diff --git a/src/cmdstan/command_helper.hpp b/src/cmdstan/command_helper.hpp index 4be80090ab..9179c383dd 100644 --- a/src/cmdstan/command_helper.hpp +++ b/src/cmdstan/command_helper.hpp @@ -204,7 +204,7 @@ context_vector get_vec_var_context(const std::string &file, size_t num_chains, = std::string("\"" + file_1 + "\" and base file \"" + file + "\""); std::stringstream msg; msg << "Searching for \"" << file_name_err << std::endl; - msg << "Can't open either of specified files," << file_name_err + msg << "Can't open either of specified files, " << file_name_err << std::endl; throw std::invalid_argument(msg.str()); } else { diff --git a/src/cmdstan/diagnose.cpp b/src/cmdstan/diagnose.cpp index 76d8fdbbf8..9a451e9d57 100644 --- a/src/cmdstan/diagnose.cpp +++ b/src/cmdstan/diagnose.cpp @@ -1,12 +1,15 @@ +#include #include -#include +#include #include #include #include #include #include -double RHAT_MAX = 1.05; +using cmdstan::return_codes; + +double RHAT_MAX = 1.01499; // round to 1.01 void diagnose_usage() { std::cout << "USAGE: diagnose [ ... ]" @@ -26,7 +29,7 @@ void diagnose_usage() { int main(int argc, const char *argv[]) { if (argc == 1) { diagnose_usage(); - return 0; + return return_codes::OK; } // Parse any arguments specifying filenames @@ -45,49 +48,47 @@ int main(int argc, const char *argv[]) { if (!filenames.size()) { std::cout << "No valid input files, exiting." << std::endl; - return 0; + return return_codes::NOT_OK; } std::cout << std::fixed << std::setprecision(2); - // Parse specified files - std::cout << "Processing csv files: " << filenames[0]; - ifstream.open(filenames[0].c_str()); - - stan::io::stan_csv stan_csv - = stan::io::stan_csv_reader::parse(ifstream, &std::cout); - stan::mcmc::chains<> chains(stan_csv); - ifstream.close(); - - if (filenames.size() > 1) - std::cout << ", "; - else - std::cout << std::endl << std::endl; - - for (std::vector::size_type chain = 1; chain < filenames.size(); - ++chain) { - std::cout << filenames[chain]; - ifstream.open(filenames[chain].c_str()); - stan_csv = stan::io::stan_csv_reader::parse(ifstream, &std::cout); - chains.add(stan_csv); - ifstream.close(); - if (chain < filenames.size() - 1) - std::cout << ", "; - else - std::cout << std::endl << std::endl; + std::vector csv_parsed; + for (int i = 0; i < filenames.size(); ++i) { + std::ifstream infile; + std::stringstream out; + stan::io::stan_csv sample; + infile.open(filenames[i].c_str()); + try { + sample = stan::io::stan_csv_reader::parse(infile, &out); + // csv_reader warnings are errors - fail fast. + if (!out.str().empty()) { + throw std::invalid_argument(out.str()); + } + csv_parsed.push_back(sample); + } catch (const std::invalid_argument &e) { + std::cout << "Cannot parse input csv file: " << filenames[i] << e.what() + << "." << std::endl; + return return_codes::NOT_OK; + } } - + stan::mcmc::chainset chains(csv_parsed); + stan::io::stan_csv_metadata metadata = csv_parsed[0].metadata; + std::vector param_names = csv_parsed[0].header; + size_t num_params = param_names.size(); int num_samples = chains.num_samples(); std::vector bad_n_eff_names; std::vector bad_rhat_names; bool has_errors = false; - for (int i = 0; i < chains.num_params(); ++i) { - if (chains.param_name(i) == std::string("treedepth__")) { + for (int i = 0; i < num_params; ++i) { + if (param_names[i] == std::string("treedepth__")) { std::cout << "Checking sampler transitions treedepth." << std::endl; - int max_limit = stan_csv.metadata.max_depth; + int max_limit = metadata.max_depth; long n_max = 0; - Eigen::VectorXd t_samples = chains.samples(i); + Eigen::MatrixXd draws = chains.samples(i); + Eigen::VectorXd t_samples + = Eigen::Map(draws.data(), draws.size()); for (long n = 0; n < t_samples.size(); ++n) { if (t_samples(n) >= max_limit) { ++n_max; @@ -109,7 +110,7 @@ int main(int argc, const char *argv[]) { std::cout << "Treedepth satisfactory for all transitions." << std::endl << std::endl; } - } else if (chains.param_name(i) == std::string("divergent__")) { + } else if (param_names[i] == std::string("divergent__")) { std::cout << "Checking sampler transitions for divergences." << std::endl; int n_divergent = chains.samples(i).sum(); if (n_divergent > 0) { @@ -129,26 +130,22 @@ int main(int argc, const char *argv[]) { std::cout << "No divergent transitions found." << std::endl << std::endl; } - } else if (chains.param_name(i) == std::string("energy__")) { + } else if (param_names[i] == std::string("energy__")) { std::cout << "Checking E-BFMI - sampler transitions HMC potential energy." << std::endl; - Eigen::VectorXd e_samples = chains.samples(i); + Eigen::MatrixXd draws = chains.samples(i); + Eigen::VectorXd e_samples + = Eigen::Map(draws.data(), draws.size()); double delta_e_sq_mean = 0; - double e_mean = 0; - double e_var = 0; - e_mean += e_samples(0); - e_var += e_samples(0) * (e_samples(0) - e_mean); + double e_mean = chains.mean(i); + double e_var = chains.variance(i); for (long n = 1; n < e_samples.size(); ++n) { double e = e_samples(n); double delta_e_sq = (e - e_samples(n - 1)) * (e - e_samples(n - 1)); double d = delta_e_sq - delta_e_sq_mean; delta_e_sq_mean += d / n; d = e - e_mean; - e_mean += d / (n + 1); - e_var += d * (e - e_mean); } - - e_var /= static_cast(e_samples.size() - 1); double e_bfmi = delta_e_sq_mean / e_var; double e_bfmi_threshold = 0.3; if (e_bfmi < e_bfmi_threshold) { @@ -163,14 +160,16 @@ int main(int argc, const char *argv[]) { } else { std::cout << "E-BFMI satisfactory." << std::endl << std::endl; } - } else if (chains.param_name(i).find("__") == std::string::npos) { - double n_eff = chains.effective_sample_size(i); + } else if (param_names[i].find("__") == std::string::npos) { + auto [ess_bulk, ess_tail] = chains.split_rank_normalized_ess(i); + double n_eff = ess_bulk < ess_tail ? ess_bulk : ess_tail; if (n_eff / num_samples < 0.001) - bad_n_eff_names.push_back(chains.param_name(i)); + bad_n_eff_names.push_back(param_names[i]); - double split_rhat = chains.split_potential_scale_reduction(i); + auto [rhat_bulk, rhat_tail] = chains.split_rank_normalized_rhat(i); + double split_rhat = rhat_bulk > rhat_tail ? rhat_bulk : rhat_tail; if (split_rhat > RHAT_MAX) - bad_rhat_names.push_back(chains.param_name(i)); + bad_rhat_names.push_back(param_names[i]); } } if (bad_n_eff_names.size() > 0) { @@ -187,13 +186,15 @@ int main(int argc, const char *argv[]) { << " may be substantially lower than quoted." << std::endl << std::endl; } else { - std::cout << "Effective sample size satisfactory." << std::endl + std::cout << "Rank-normalized split effective sample size satisfactory " + << "for all parameters." << std::endl << std::endl; } if (bad_rhat_names.size() > 0) { has_errors = true; - std::cout << "The following parameters had split R-hat greater than " + std::cout << "The following parameters had rank-normalized split R-hat " + "greater than " << RHAT_MAX << ":" << std::endl; std::cout << " "; for (size_t n = 0; n < bad_rhat_names.size() - 1; ++n) @@ -207,7 +208,8 @@ int main(int argc, const char *argv[]) { << " effective parameterization." << std::endl << std::endl; } else { - std::cout << "Split R-hat values satisfactory all parameters." << std::endl + std::cout << "Rank-normalized split R-hat values satisfactory " + << "for all parameters." << std::endl << std::endl; } if (!has_errors) @@ -215,5 +217,5 @@ int main(int argc, const char *argv[]) { else std::cout << "Processing complete." << std::endl; - return 0; + return return_codes::OK; } diff --git a/src/cmdstan/stansummary.cpp b/src/cmdstan/stansummary.cpp index fe4483d4b3..5f80270ab0 100644 --- a/src/cmdstan/stansummary.cpp +++ b/src/cmdstan/stansummary.cpp @@ -1,7 +1,6 @@ #include #include -#include -#include +#include #include #include #include @@ -34,7 +33,7 @@ Example: stansummary model_chain_1.csv model_chain_2.csv -c, --csv_filename [file] Write statistics to a csv file. -h, --help Produce help message, then exit. -p, --percentiles [values] Percentiles to report as ordered set of - comma-separated numbers from (0.1,99.9), inclusive. + comma-separated numbers from (0.0,100.0), inclusive. Default is 5,50,95. -s, --sig_figs [n] Significant figures reported. Default is 2. Must be an integer from (1, 18), inclusive. @@ -96,6 +95,7 @@ Example: stansummary model_chain_1.csv model_chain_2.csv << " not a valid chain id." << std::endl; return return_codes::NOT_OK; } + std::vector percentiles; Eigen::VectorXd probs; boost::algorithm::trim(percentiles_spec); @@ -119,134 +119,105 @@ Example: stansummary model_chain_1.csv model_chain_2.csv return return_codes::NOT_OK; } } + + std::vector csv_parsed; + Eigen::VectorXd warmup_times(filenames.size()); + Eigen::VectorXd sampling_times(filenames.size()); + Eigen::VectorXi thin(filenames.size()); // relevant for timing info for (int i = 0; i < filenames.size(); ++i) { std::ifstream infile; + std::stringstream out; + stan::io::stan_csv sample; infile.open(filenames[i].c_str()); - if (infile.good()) { - infile.close(); - } else { - std::cout << "Cannot read input csv file: " << filenames[i] << "." - << std::endl; + try { + sample = stan::io::stan_csv_reader::parse(infile, &out); + // csv_reader warnings are errors - fail fast. + if (!out.str().empty()) { + throw std::invalid_argument(out.str()); + } + csv_parsed.push_back(sample); + warmup_times(i) = sample.timing.warmup; + sampling_times(i) = sample.timing.sampling; + thin(i) = sample.metadata.thin; + } catch (const std::invalid_argument &e) { + std::cout << "Cannot parse input csv file: " << filenames[i] + << ", error: " << e.what() << std::endl; return return_codes::NOT_OK; } } - - try { - // Parse csv files into sample, metadata - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - - // check for stan csv file parse errors written to output stream - std::stringstream cout_ss; - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); - - // Get column headers for sampler, model params - size_t max_name_length = 0; - size_t num_sampler_params = 0; - for (int i = 0; i < chains.num_params(); ++i) { - if (chains.param_name(i).length() > max_name_length) - max_name_length = chains.param_name(i).length(); - if (stan::io::ends_with("__", chains.param_name(i))) - num_sampler_params++; - } - // don't count name 'lp__' - if (num_sampler_params > 0) { - num_sampler_params--; - } - - // Get column indices for the sampler params - std::vector sampler_params_idxes(num_sampler_params); - std::iota(sampler_params_idxes.begin(), sampler_params_idxes.end(), 1); - - size_t model_params_offset = num_sampler_params + 1; - - size_t num_model_params = 0; - std::vector model_param_idxes(0); - - bool model_params_subset = requested_params_vec.size() > 0; - if (model_params_subset) { - std::set requested_params(requested_params_vec.begin(), - requested_params_vec.end()); - - for (int i = model_params_offset; i < chains.num_params(); ++i) { - if (requested_params.erase(chains.param_name(i)) > 0) { - model_param_idxes.emplace_back(i); - num_model_params++; + stan::io::stan_csv_metadata metadata = csv_parsed[0].metadata; + std::vector param_names = csv_parsed[0].header; + + if (requested_params_vec.size() > 0) { + std::vector valid_params; + std::vector invalid_params; + + std::set pnames(param_names.begin(), param_names.end()); + for (std::string request : requested_params_vec) { + auto it = pnames.find(request); + if (it == pnames.end()) { + auto find_dups + = std::find(invalid_params.begin(), invalid_params.end(), request); + if (find_dups == invalid_params.end()) { + invalid_params.emplace_back(request); } - } - // some params were requested but not found by above loop - if (requested_params.size() > 0) { - std::cout << "--include_param: Unrecognized parameter(s): "; - for (auto param : requested_params) { - std::cout << "'" << param << "' "; + } else { + valid_params.emplace_back(request); + auto find_dups + = std::find(valid_params.begin(), valid_params.end(), request); + if (find_dups == valid_params.end()) { + valid_params.emplace_back(request); } - std::cout << std::endl; - return return_codes::NOT_OK; } - + } + if (invalid_params.empty()) { + param_names.clear(); + std::copy(valid_params.begin(), valid_params.end(), + std::back_inserter(param_names)); } else { - // if none were requested, get all of the model parameters - num_model_params = chains.num_params() - num_sampler_params - 1; - model_param_idxes.resize(num_model_params); - std::iota(model_param_idxes.begin(), model_param_idxes.end(), - model_params_offset); + std::cout << "--include_param: Unrecognized parameter(s): "; + for (size_t i = 0; i < invalid_params.size(); ++i) { + std::cout << "'" << invalid_params[i] << "' "; + } + std::cout << std::endl; + return return_codes::NOT_OK; } + } + size_t num_params = param_names.size(); + size_t max_name_length = 0; + for (size_t i = 0; i < num_params; ++i) { + max_name_length = std::max(param_names[i].size(), max_name_length); + } + try { std::vector header = get_header(percentiles); + stan::mcmc::chainset chains(csv_parsed); - // Compute statistics for sampler and model params - Eigen::MatrixXd lp_param(1, header.size()); - Eigen::MatrixXd sampler_params(num_sampler_params, header.size()); - Eigen::MatrixXd model_params(num_model_params, header.size()); + auto pnames = param_names; + if (requested_params_vec.empty()) { + pnames = order_param_names_row_major(param_names); + } - get_stats(chains, sampling_times, probs, {0}, lp_param); - get_stats(chains, sampling_times, probs, sampler_params_idxes, - sampler_params); - get_stats(chains, sampling_times, probs, model_param_idxes, model_params); + Eigen::MatrixXd param_stats(num_params, header.size()); + get_stats(chains, probs, pnames, param_stats); // Console output formatting Eigen::VectorXi column_sig_figs(header.size()); - Eigen::Matrix sampler_formats( - header.size()); - Eigen::VectorXi sampler_widths(header.size()); - sampler_widths = calculate_column_widths(sampler_params, header, sig_figs, - sampler_formats); - - Eigen::Matrix model_formats( + Eigen::Matrix column_formats( header.size()); - Eigen::VectorXi model_widths(header.size()); - model_widths = calculate_column_widths(model_params, header, sig_figs, - model_formats); Eigen::VectorXi column_widths(header.size()); - for (size_t i = 0; i < header.size(); ++i) - column_widths[i] = sampler_widths[i] > model_widths[i] ? sampler_widths[i] - : model_widths[i]; + column_widths = calculate_column_widths(param_stats, header, sig_figs, + column_formats); // Print to console write_timing(chains, metadata, warmup_times, sampling_times, thin, "", &std::cout); std::cout << std::endl; - write_header(header, column_widths, max_name_length, false, &std::cout); std::cout << std::endl; - write_params(chains, lp_param, column_widths, model_formats, - max_name_length, sig_figs, {0}, false, &std::cout); - write_params(chains, sampler_params, column_widths, sampler_formats, - max_name_length, sig_figs, sampler_params_idxes, false, - &std::cout); - std::cout << std::endl; - if (model_params_subset) - write_params(chains, model_params, column_widths, model_formats, - max_name_length, sig_figs, model_param_idxes, false, - &std::cout); - else - write_all_model_params(chains, model_params, column_widths, model_formats, - max_name_length, sig_figs, model_params_offset, - false, &std::cout); + write_stats(pnames, param_stats, column_widths, column_formats, + max_name_length, sig_figs, false, &std::cout); std::cout << std::endl; write_sampler_info(metadata, "", &std::cout); @@ -262,21 +233,8 @@ Example: stansummary model_chain_1.csv model_chain_2.csv csv_file << std::setprecision(app.count("--sig_figs") ? sig_figs : 6); write_header(header, column_widths, max_name_length, true, &csv_file); - write_params(chains, lp_param, column_widths, model_formats, - max_name_length, sig_figs, {0}, true, &csv_file); - write_params(chains, sampler_params, column_widths, sampler_formats, - max_name_length, sig_figs, sampler_params_idxes, true, - &csv_file); - - if (model_params_subset) - write_params(chains, model_params, column_widths, model_formats, - max_name_length, sig_figs, model_param_idxes, true, - &csv_file); - else - write_all_model_params(chains, model_params, column_widths, - model_formats, max_name_length, sig_figs, - model_params_offset, true, &csv_file); - + write_stats(pnames, param_stats, column_widths, column_formats, + max_name_length, sig_figs, true, &csv_file); write_timing(chains, metadata, warmup_times, sampling_times, thin, "# ", &csv_file); write_sampler_info(metadata, "# ", &csv_file); diff --git a/src/cmdstan/stansummary_helper.hpp b/src/cmdstan/stansummary_helper.hpp index 4fb482852e..c7a97ff75b 100644 --- a/src/cmdstan/stansummary_helper.hpp +++ b/src/cmdstan/stansummary_helper.hpp @@ -1,6 +1,7 @@ #ifndef CMDSTAN_STANSUMMARY_HELPER_HPP #define CMDSTAN_STANSUMMARY_HELPER_HPP +#include #include #include #include @@ -96,7 +97,7 @@ int column_width(const Eigen::VectorXd &x, const std::string &name, int padding = 2; // Fixed Precision - size_t fixed_threshold = 8; + size_t fixed_threshold = 10; size_t max_fixed_width = 0; for (int i = 0; i < x.size(); ++i) { @@ -150,14 +151,14 @@ Eigen::VectorXi calculate_column_widths( } /** - * Given a column label, determine whether or not the parameter - * is a scalar variable or a container variable. + * Given a column label, check for array dims, "[n(,n)*]" + * Return true if no array dimensions found. * - * @param in column label + * @param parameter_name column label * @return boolean */ -bool is_container(const std::string ¶meter_name) { - return (parameter_name.find("[") != std::string::npos); +bool is_scalar(const std::string ¶meter_name) { + return (parameter_name.find("[") == std::string::npos); } /** @@ -166,48 +167,37 @@ bool is_container(const std::string ¶meter_name) { * @param in column index * @return variable name */ -std::string base_param_name(const stan::mcmc::chains<> &chains, int index) { - std::string name = chains.param_name(index); - return name.substr(0, name.find("[")); -} - -/** - * Return parameter name corresponding to column label. - * - * @param in set of samples from one or more chains - * @param in column index - * @return parameter name - */ -std::string matrix_index(const stan::mcmc::chains<> &chains, int index) { - std::string name = chains.param_name(index); - return name.substr(name.find("[")); +std::string base_param_name(const std::vector ¶m_names, + int index) { + return param_names[index].substr(0, param_names[index].find("[")); } /** * Return vector of dimensions for container variable. + * Parameter name at start index contains "[" char. + * Finds index of final array element and parse its name + * into a vector dimensions. * * @param in set of samples from one or more chains * @param in column index of first container element * @return vector of dimensions */ -std::vector dimensions(const stan::mcmc::chains<> &chains, +std::vector dimensions(const std::vector ¶m_names, int start_index) { - std::vector dims; - int dim; - - std::string name = base_param_name(chains, start_index); - int last_matrix_element = start_index; - while (last_matrix_element + 1 < chains.num_params()) { - if (base_param_name(chains, last_matrix_element + 1) == name) - last_matrix_element++; + std::string name = base_param_name(param_names, start_index); + int end_index = start_index; + while (end_index + 1 < param_names.size()) { + if (base_param_name(param_names, end_index + 1) == name) + end_index++; else break; } - - std::stringstream ss(matrix_index(chains, last_matrix_element)); - ss.get(); + std::vector dims; + int dim; + std::stringstream ss( + param_names[end_index].substr(param_names[end_index].find("["))); + ss.get(); // skip open square bracket ss >> dim; - dims.push_back(dim); while (ss.get() == ',') { ss >> dim; @@ -217,29 +207,26 @@ std::vector dimensions(const stan::mcmc::chains<> &chains, } /** - * Compute index for next container element, - * for row-major order traversal. + * Given a current array coordinates and set of dimensions + * compute the next coordinate for row-major indexing. + * Update coordinate and return string of comma separted coords, + * enclosed by square brackets. + * Arg arrays must be the same size and next coordinate must not + * exceed allowed dimension. * - *

Stan program stores/output container elements in column-major order. - * Legacy code to manipulate indices accordingly. - * - * @param in out container element indices - * @param in vector of array dimensions + * @param index array of current/next element coords + * @param dims array dimensions */ void next_index(std::vector &index, const std::vector &dims) { if (dims.size() != index.size()) throw std::domain_error("next_index: size mismatch"); - if (dims.size() == 0) - return; index[index.size() - 1]++; - for (int i = index.size() - 1; i > 0; i--) { if (index[i] > dims[i]) { index[i - 1]++; index[i] = 1; } } - for (size_t n = 0; n < dims.size(); n++) { if (index[n] <= 0 || index[n] > dims[n]) { std::stringstream message_stream(""); @@ -252,42 +239,65 @@ void next_index(std::vector &index, const std::vector &dims) { } /** - * Return the flat 0-based index of a column major order matrix based on the - * 1-based index + * Given an array of indices, convert to string. * - * @param in out container element indices - * @param in vector of array dimensions - * @return offset from first container element. + * @param coords element coords + * @return coordinates as string */ -int matrix_index(std::vector &index, const std::vector &dims) { - if (dims.size() != index.size()) - throw std::domain_error("next_index: size mismatch"); - if (dims.size() == 0) - return 0; - for (size_t n = 0; n < dims.size(); n++) { - if (index[n] <= 0 || index[n] > dims[n]) { - std::stringstream message_stream(""); - message_stream << "matrix_index: index[" << n << "] out of bounds. " - << "dims[" << n << "] = " << dims[n] << "; " - << "index[" << n << "] = " << index[n]; - throw std::domain_error(message_stream.str()); - } +std::string coords_str(const std::vector &coords) { + std::stringstream ss_coords; + ss_coords << "["; + for (size_t i = 0; i < coords.size(); ++i) { + ss_coords << coords[i]; + if (i < coords.size() - 1) + ss_coords << ","; } + ss_coords << "]"; + return ss_coords.str(); +} - int offset = 0; - int prod = 1; - for (size_t i = 0; i < dims.size(); i++) { - offset += (index[i] - 1) * prod; - prod *= dims[i]; +/** + * Creates array of parameter names where all container parameters + * are listed in row major order. + * E.g, ( "x[1,1]", "x[2,1]", "x[1,2]", "x[2,2]" ) becomes + * ( "x[1,1]", "x[1,2]", "x[2,1]", "x[2,2]" ) becomes + * + * + * @param vector of strings + * @return vector of strings + */ +std::vector order_param_names_row_major( + const std::vector ¶m_names) { + std::vector param_names_row_maj(param_names.size()); + int pname_idx = 0; + while (pname_idx < param_names.size()) { + if (is_scalar(param_names[pname_idx])) { + param_names_row_maj[pname_idx] = param_names[pname_idx]; + pname_idx++; + } else { + auto basename = base_param_name(param_names, pname_idx); + auto dims = dimensions(param_names, pname_idx); + int max = 1; + for (size_t j = 0; j < dims.size(); j++) { + max *= dims[j]; + } + std::vector new_index(dims.size(), 1); + param_names_row_maj[pname_idx] = basename + coords_str(new_index); + for (int k = 1; k < max; ++k) { + next_index(new_index, dims); + param_names_row_maj[pname_idx + k] = basename + coords_str(new_index); + } + pname_idx += max; + } } - return offset; + return param_names_row_maj; } /** - * Convert percentiles - int values in range (1,99) + * Convert percentiles - string-encoded doubles in range (0,100) * to probabilities - double values in range (0, 1). * - *

Input values must be in strictly increasing order. + * Input values must be in strictly increasing order. * * @param vector of strings * @return vector of doubles @@ -300,12 +310,12 @@ Eigen::VectorXd percentiles_to_probs( for (size_t i = 0; i < percentiles.size(); ++i) { try { pct = std::stod(percentiles[i]); - if (!std::isfinite(pct) || pct < 0.1 || pct > 99.9 || pct < cur_pct) + if (!std::isfinite(pct) || pct < 0.0 || pct > 100.0 || pct < cur_pct) throw std::exception(); cur_pct = pct; } catch (const std::exception &e) { throw std::invalid_argument( - "values must be in range (0.1,99.9)" + "values must be in range (0, 100)" ", inclusive, and strictly increasing."); } probs[i] = pct / 100.0; @@ -314,120 +324,63 @@ Eigen::VectorXd percentiles_to_probs( } /** - * Assemble set of Stan csv files into a stan::mcmc::chains object - * - * @param in vector of filenames of stan csv files - * @param in out metadata - * @param in out warmup times for each chain - * @param in out sampling times for each chain - * @param in out thinning for each chain - * @param out output stream - * @return stan::mcmc::chains object - */ -stan::mcmc::chains<> parse_csv_files(const std::vector &filenames, - stan::io::stan_csv_metadata &metadata, - Eigen::VectorXd &warmup_times, - Eigen::VectorXd &sampling_times, - Eigen::VectorXi &thin, std::ostream *out) { - // instantiate stan::mcmc::chains object by parsing first file - std::ifstream ifstream; - ifstream.open(filenames[0].c_str()); - stan::io::stan_csv stan_csv = stan::io::stan_csv_reader::parse(ifstream, out); - ifstream.close(); - if (stan_csv.samples.rows() < 1) { - std::stringstream message_stream(""); - message_stream << "No sampling draws found in Stan CSV file: " - << filenames[0] << "."; - throw std::invalid_argument(message_stream.str()); - } - warmup_times(0) = stan_csv.timing.warmup; - sampling_times(0) = stan_csv.timing.sampling; - stan::mcmc::chains<> chains(stan_csv); - thin(0) = stan_csv.metadata.thin; - metadata = stan_csv.metadata; - - // parse rest of input files, add to chains - for (std::vector::size_type chain = 1; chain < filenames.size(); - chain++) { - ifstream.open(filenames[chain].c_str()); - stan_csv = stan::io::stan_csv_reader::parse(ifstream, out); - ifstream.close(); - if (stan_csv.samples.rows() < 1) { - std::stringstream message_stream(""); - message_stream << "No sampling draws found in Stan CSV file: " - << filenames[chain] << "."; - throw std::invalid_argument(message_stream.str()); - } - chains.add(stan_csv); - thin(chain) = stan_csv.metadata.thin; - warmup_times(chain) = stan_csv.timing.warmup; - sampling_times(chain) = stan_csv.timing.sampling; - } - return chains; -} - -/** - * Assemble vector of output column labels as follows: - * Mean, MCSE, StdDev, specified quantile labels, N_eff, N_eff/S, R-hat + * Assemble vector of output column labels, where each column is a statistic. + * See `get_stats`, (below). * * @param in vector of percentile values as strings * @return vector column labels */ std::vector get_header( const std::vector &percentiles) { - // Mean, MCSE, StdDev, ... percentiles ..., N_eff, N_eff/s, R_hat - std::vector header(percentiles.size() + 6); + std::vector header(percentiles.size() + 7); header.at(0) = "Mean"; header.at(1) = "MCSE"; header.at(2) = "StdDev"; + header.at(3) = "MAD"; + size_t offset = 4; for (size_t i = 0; i < percentiles.size(); ++i) { - header[i + 3] = percentiles[i] + '%'; + header[i + offset] = percentiles[i] + '%'; } - size_t offset = 3 + percentiles.size(); - header.at(offset) = "N_Eff"; - header.at(offset + 1) = "N_Eff/s"; - header.at(offset + 2) = "R_hat"; + offset += percentiles.size(); + header.at(offset++) = "ESS_bulk"; + header.at(offset++) = "ESS_tail"; + header.at(offset++) = "R_hat"; return header; } /** - * Compute statistics for span of output columns - * Mean, MCSE, StdDev, specified quantile, N_eff, N_eff/S, R-hat + * Compute per-parameters statistics, consisting of: + * Mean, MCSE, MAD, specified quantile(s), + * ESS_bulk, ESS_tail, R-hat_bulk, R-hat_tail + * Populate data structure for output, one row per parameter, + * one column per statistic. * - * @param in set of samples from one or more chains - * @param in vector of warmup times (required for N_eff/S) - * @param in vector of sampling times (required for N_eff/S) - * @param in vector of probabilities - * @param in vector of model param column incides in chains object - * @param in span length - * @param in out matrix of model param statistics + * Note: if you change this function, change get_header above + * + * @param chains vector of matrices of per-chain draws + * @param probs vector of probabilities for quantiles + * @param param_names vector of requested parameter names + * @param stats matrix of computed statistics */ -void get_stats(const stan::mcmc::chains<> &chains, - const Eigen::VectorXd &sampling_times, - const Eigen::VectorXd &probs, std::vector cols, - Eigen::MatrixXd ¶ms) { - params.setZero(); - double total_sampling_time = sampling_times.sum(); - - if (params.rows() != cols.size()) { - throw std::domain_error("get_stats: size mismatch"); - } - - // Model parameters - int i = 0; - for (int i_chains : cols) { - double sd = chains.sd(i_chains); - double n_eff = chains.effective_sample_size(i_chains); - params(i, 0) = chains.mean(i_chains); - params(i, 1) = sd / sqrt(n_eff); - params(i, 2) = sd; - Eigen::VectorXd quantiles = chains.quantiles(i_chains, probs); +void get_stats(const stan::mcmc::chainset &chains, const Eigen::VectorXd &probs, + const std::vector ¶m_names, + Eigen::MatrixXd &stats) { + stats.setZero(); + size_t i = 0; + for (std::string name : param_names) { + stats(i, 0) = chains.mean(name); + stats(i, 1) = chains.mcse_mean(name); + stats(i, 2) = chains.sd(name); + stats(i, 3) = chains.max_abs_deviation(name); + size_t offset = 4; + Eigen::VectorXd quantiles = chains.quantiles(name, probs); for (int j = 0; j < quantiles.size(); j++) - params(i, 3 + j) = quantiles(j); - params(i, quantiles.size() + 3) = n_eff; - params(i, quantiles.size() + 4) = n_eff / total_sampling_time; - params(i, quantiles.size() + 5) - = chains.split_potential_scale_reduction(i_chains); + stats(i, offset++) = quantiles(j); + auto [ess_bulk, ess_tail] = chains.split_rank_normalized_ess(name); + stats(i, offset++) = ess_bulk; + stats(i, offset++) = ess_tail; + auto [rhat_bulk, rhat_tail] = chains.split_rank_normalized_rhat(name); + stats(i, offset) = rhat_bulk > rhat_tail ? rhat_bulk : rhat_tail; i++; } } @@ -463,129 +416,51 @@ void write_header(const std::vector &header, * Output statistics for a set of parameters * either as fixed-width text columns or in csv format. * - * @param in set of samples from one or more chains - * @param in matrix of statistics - * @param in vector of output column widths - * @param in vector of output column formats - * @param in size of longest parameter name - (width of 1st output column) - * @param in significant digits required - * @param in vector of column indexes to output from chains - * @param in output format flag: true for csv; false for plain text - * @param in output stream + * @param param_names vector of requested parameter names + * @param stats matrix of computed statistics + * @param col_widths vector of output column widths + * @param col_formats vector of output column formats + * @param max_name_length longest parameter name - (width of 1st output column) + * @param sig_figs significant digits required + * @param as_csv flag - true for csv; false for plain text + * @param out output stream */ -void write_params(const stan::mcmc::chains<> &chains, - const Eigen::MatrixXd ¶ms, - const Eigen::VectorXi &col_widths, - const Eigen::Matrix &col_formats, - int max_name_length, int sig_figs, std::vector cols, - bool as_csv, std::ostream *out) { - int i = 0; - for (int i_chains : cols) { +void write_stats(const std::vector ¶m_names, + const Eigen::MatrixXd &stats, + const Eigen::VectorXi &col_widths, + const Eigen::Matrix + &col_formats, + int max_name_length, int sig_figs, bool as_csv, + std::ostream *out) { + bool in_sampler_params = true; + if (!boost::ends_with(param_names[0], "__")) { + in_sampler_params = false; + } + for (size_t i = 0; i < param_names.size(); ++i) { if (as_csv) { - *out << "\"" << chains.param_name(i_chains) << "\""; - for (int j = 0; j < params.cols(); j++) { - *out << "," << params(i, j); + *out << "\"" << param_names[i] << "\""; + for (int j = 0; j < stats.cols(); j++) { + *out << "," << stats(i, j); } } else { - *out << std::setw(max_name_length + 1) << std::left - << chains.param_name(i_chains); + if (i > 0 && in_sampler_params + && !boost::ends_with(param_names[i], "__")) { + in_sampler_params = false; + std::cout << std::endl; + } + *out << std::setw(max_name_length + 1) << std::left << param_names[i]; *out << std::right; - for (int j = 0; j < params.cols(); j++) { + for (int j = 0; j < stats.cols(); j++) { + if (boost::ends_with(param_names[i], "__") && param_names[i] != "lp__" + && j >= stats.cols() - 3) + continue; // don't report ESS or Rhat for sampler state std::cout.setf(col_formats(j), std::ios::floatfield); - *out << std::setprecision( - compute_precision(params(i, j), sig_figs, - col_formats(j) == std::ios_base::scientific)) - << std::setw(col_widths(j)) << params(i, j); + *out << std::setprecision(compute_precision( + stats(i, j), sig_figs, col_formats(j) == std::ios_base::scientific)) + << std::setw(col_widths(j)) << stats(i, j); } } *out << std::endl; - i++; - } -} - -/** - * Output statistics for a set of parameters - * either as fixed-width text columns or in csv format. - * Containers are re-ordered as first-index-major order - * - * @param in set of samples from one or more chains - * @param in matrix of statistics - * @param in vector of output column widths - * @param in vector of output column formats - * @param in size of longest parameter name - (width of 1st output column) - * @param in significant digits required - * @param in index of first column in chains object - * @param in output format flag: true for csv; false for plain text - * @param in output stream - */ -void write_all_model_params(const stan::mcmc::chains<> &chains, - const Eigen::MatrixXd ¶ms, - const Eigen::VectorXi &col_widths, - const Eigen::Matrix &col_formats, - int max_name_length, int sig_figs, - int params_start_col, bool as_csv, - std::ostream *out) { - for (int i = 0, i_chains = params_start_col; i < params.rows(); - ++i, ++i_chains) { - if (!is_container(chains.param_name(i_chains))) { - if (as_csv) { - *out << "\"" << chains.param_name(i_chains) << "\""; - for (int j = 0; j < params.cols(); j++) { - *out << "," << params(i, j); - } - } else { - *out << std::setw(max_name_length + 1) << std::left - << chains.param_name(i_chains); - *out << std::right; - for (int j = 0; j < params.cols(); j++) { - out->setf(col_formats(j), std::ios::floatfield); - *out << std::setprecision( - compute_precision(params(i, j), sig_figs, - col_formats(j) == std::ios_base::scientific)) - << std::setw(col_widths(j)) << params(i, j); - } - } - *out << std::endl; - } else { - // container object columns in csv are last-index-major order - // output as first-index-major order - std::vector dims = dimensions(chains, i_chains); - std::vector index(dims.size(), 1); - int max = 1; - for (size_t j = 0; j < dims.size(); j++) - max *= dims[j]; - for (int k = 0; k < max; k++) { - int row_maj_index = i + matrix_index(index, dims); - int row_maj_index_chains = i_chains + matrix_index(index, dims); - if (as_csv) { - *out << "\"" << chains.param_name(row_maj_index_chains) << "\""; - for (int j = 0; j < params.cols(); j++) { - *out << "," << std::fixed - << std::setprecision(compute_precision( - params(row_maj_index, j), sig_figs, false)) - << params(row_maj_index, j); - } - } else { - *out << std::setw(max_name_length + 1) << std::left - << chains.param_name(row_maj_index_chains); - *out << std::right; - for (int j = 0; j < params.cols(); j++) { - out->setf(col_formats(j), std::ios::floatfield); - *out << std::setprecision( - compute_precision(params(row_maj_index, j), sig_figs, - col_formats(j) == std::ios_base::scientific)) - << std::setw(col_widths(j)) << params(row_maj_index, j); - } - } - *out << std::endl; - if (k < max - 1) - next_index(index, dims); - } - i += max - 1; - i_chains += max - 1; - } } } @@ -600,26 +475,17 @@ void write_all_model_params(const stan::mcmc::chains<> &chains, * @param in prefix string - used to output as comments in csv file * @param out output stream */ -void write_timing(const stan::mcmc::chains<> &chains, +void write_timing(const stan::mcmc::chainset &chains, const stan::io::stan_csv_metadata &metadata, const Eigen::VectorXd &warmup_times, const Eigen::VectorXd &sampling_times, const Eigen::VectorXi &thin, const std::string &prefix, std::ostream *out) { *out << prefix << "Inference for Stan model: " << metadata.model << std::endl - << prefix << chains.num_chains() << " chains: each with iter=(" - << chains.num_kept_samples(0); - for (int chain = 1; chain < chains.num_chains(); chain++) - *out << "," << chains.num_kept_samples(chain); - *out << ")"; - *out << "; warmup=(" << chains.warmup(0); - for (int chain = 1; chain < chains.num_chains(); chain++) - *out << "," << chains.warmup(chain); - *out << ")"; - *out << "; thin=(" << thin(0); - for (int chain = 1; chain < chains.num_chains(); chain++) - *out << "," << thin(chain); - *out << ")"; + << prefix << chains.num_chains() + << " chains: each with iter=" << metadata.num_samples; + *out << "; warmup=" << metadata.num_warmup; + *out << "; thin=" << metadata.thin; *out << "; " << chains.num_samples() << " iterations saved." << std::endl << prefix << std::endl; @@ -702,14 +568,16 @@ void write_sampler_info(const stan::io::stan_csv_metadata &metadata, *out << prefix << "Samples were drawn using " << metadata.algorithm << " with " << metadata.engine << "." << std::endl; *out << prefix - << "For each parameter, N_Eff is a crude measure of effective " - "sample size," + << "For each parameter, ESS_bulk and ESS_tail measure the " + "effective sample size " + << std::endl + << "for the entire sample (bulk) and for the " + "the .05 and .95 tails (tail), " << std::endl; *out << prefix - << "and R_hat is the potential scale reduction factor on split " - "chains (at " - << std::endl; - *out << prefix << "convergence, R_hat=1)." << std::endl; + << "and R_hat measures the potential scale reduction on split chains." + << std::endl + << "At convergence R_hat will be very close to 1.00." << std::endl; } /** @@ -725,11 +593,11 @@ void write_sampler_info(const stan::io::stan_csv_metadata &metadata, * @param in size of longest sampler param name */ // autocorrelation report prints to std::out -void autocorrelation(const stan::mcmc::chains<> &chains, +void autocorrelation(const stan::mcmc::chainset &chains, const stan::io::stan_csv_metadata &metadata, int autocorr_idx, int max_name_length) { int c = autocorr_idx - 1; - Eigen::MatrixXd autocorr(chains.num_params(), chains.num_samples(c)); + Eigen::MatrixXd autocorr(chains.num_params(), chains.num_samples()); for (int i = 0; i < chains.num_params(); ++i) { autocorr.row(i) = chains.autocorrelation(c, i); } @@ -762,4 +630,105 @@ void autocorrelation(const stan::mcmc::chains<> &chains, } } +// functions used by print.cpp, to be deleted when print is deprecated. + +/** + * Given a column label, determine whether or not the parameter + * is a scalar variable or a container variable. + * + * @param in column label + * @return boolean + */ +bool is_container(const std::string ¶meter_name) { + return (parameter_name.find("[") != std::string::npos); +} + +/** + * Return parameter name corresponding to column label. + * + * @param in column index + * @return variable name + */ +std::string base_param_name(const stan::mcmc::chains<> &chains, int index) { + std::string name = chains.param_name(index); + return name.substr(0, name.find("[")); +} + +/** + * Return parameter name corresponding to column label. + * + * @param in set of samples from one or more chains + * @param in column index + * @return parameter name + */ +std::string matrix_index(const stan::mcmc::chains<> &chains, int index) { + std::string name = chains.param_name(index); + return name.substr(name.find("[")); +} + +/** + * Return vector of dimensions for container variable. + * + * @param in set of samples from one or more chains + * @param in column index of first container element + * @return vector of dimensions + */ +std::vector dimensions(const stan::mcmc::chains<> &chains, + int start_index) { + std::vector dims; + int dim; + + std::string name = base_param_name(chains, start_index); + int last_matrix_element = start_index; + while (last_matrix_element + 1 < chains.num_params()) { + if (base_param_name(chains, last_matrix_element + 1) == name) + last_matrix_element++; + else + break; + } + + std::stringstream ss(matrix_index(chains, last_matrix_element)); + ss.get(); + ss >> dim; + + dims.push_back(dim); + while (ss.get() == ',') { + ss >> dim; + dims.push_back(dim); + } + return dims; +} + +/** + * Return the flat 0-based index of a column major order matrix based on the + * 1-based index + * + * @param in out container element indices + * @param in vector of array dimensions + * @return offset from first container element. + */ +int matrix_index(std::vector &index, const std::vector &dims) { + if (dims.size() != index.size()) + throw std::domain_error("next_index: size mismatch"); + if (dims.size() == 0) + return 0; + for (size_t n = 0; n < dims.size(); n++) { + if (index[n] <= 0 || index[n] > dims[n]) { + std::stringstream message_stream(""); + message_stream << "matrix_index: index[" << n << "] out of bounds. " + << "dims[" << n << "] = " << dims[n] << "; " + << "index[" << n << "] = " << index[n]; + throw std::domain_error(message_stream.str()); + } + } + + int offset = 0; + int prod = 1; + for (size_t i = 0; i < dims.size(); i++) { + offset += (index[i] - 1) * prod; + prod *= dims[i]; + } + return offset; +} + #endif diff --git a/src/test/interface/csv_header_consistency_test.cpp b/src/test/interface/csv_header_consistency_test.cpp index 2b838c67de..997ad34b68 100644 --- a/src/test/interface/csv_header_consistency_test.cpp +++ b/src/test/interface/csv_header_consistency_test.cpp @@ -1,4 +1,5 @@ -#include +#include +#include #include #include #include @@ -28,8 +29,8 @@ TEST(interface, csv_header_consistency) { std::ifstream ifstream; ifstream.open(samples.c_str()); - stan::mcmc::chains<> chains( - stan::io::stan_csv_reader::parse(ifstream, &std::cout)); + auto stan_csv = stan::io::stan_csv_reader::parse(ifstream, &std::cout); + stan::mcmc::chainset chains(stan_csv); ifstream.close(); EXPECT_EQ(1, chains.num_samples()); diff --git a/src/test/interface/datetime_test.cpp b/src/test/interface/datetime_test.cpp index 7d8255b362..d553c39b0e 100644 --- a/src/test/interface/datetime_test.cpp +++ b/src/test/interface/datetime_test.cpp @@ -1,4 +1,3 @@ -#include #include #include #include diff --git a/src/test/interface/example_output/bern1.csv b/src/test/interface/example_output/bern1.csv new file mode 100644 index 0000000000..4daa3fc0f7 --- /dev/null +++ b/src/test/interface/example_output/bern1.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-10-17 18:13:44 UTC +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = false (Default) +# thin = 1 (Default) +# adapt +# engaged = true (Default) +# gamma = 0.05 (Default) +# delta = 0.8 (Default) +# kappa = 0.75 (Default) +# t0 = 10 (Default) +# init_buffer = 75 (Default) +# term_buffer = 50 (Default) +# window = 25 (Default) +# save_metric = false (Default) +# algorithm = hmc (Default) +# hmc +# engine = nuts (Default) +# nuts +# max_depth = 10 (Default) +# metric = diag_e (Default) +# metric_file = (Default) +# stepsize = 1 (Default) +# stepsize_jitter = 0 (Default) +# num_chains = 1 (Default) +# id = 1 (Default) +# data +# file = /Users/mitzi/.cmdstan/cmdstan-2.35.0/examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 86520 +# output +# file = /Users/mitzi/github/stan-dev/cmdstanpy/test_csv_files/bernoulli-20241017141344_1.csv +# diagnostic_file = (Default) +# refresh = 100 (Default) +# sig_figs = -1 (Default) +# profile_file = profile.csv (Default) +# save_cmdstan_config = false (Default) +# num_threads = 1 (Default) +# stanc_version = stanc3 v2.35.0 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +# Adaptation terminated +# Step size = 0.883328 +# Diagonal elements of inverse mass matrix: +# 0.512256 +-6.80778,0.991604,0.883328,2,3,0,6.81551,0.208532 +-6.80778,0.676659,0.883328,1,3,0,9.01984,0.208532 +-11.053,0.593184,0.883328,3,7,0,11.0857,0.0272877 +-10.8526,1,0.883328,1,1,0,11.3097,0.0293594 +-10.9957,0.926907,0.883328,2,7,0,11.355,0.661812 +-7.85065,1,0.883328,1,1,0,10.0946,0.457561 +-7.05998,1,0.883328,1,1,0,7.63241,0.356179 +-6.74806,0.998884,0.883328,2,3,0,7.0771,0.251099 +-6.77871,0.995524,0.883328,2,3,0,6.78513,0.281783 +-6.77684,1,0.883328,1,1,0,6.78461,0.28078 +-7.52399,0.771045,0.883328,1,3,0,8.22042,0.119146 +-8.05976,0.94003,0.883328,1,1,0,8.06699,0.0905514 +-6.75013,0.966227,0.883328,1,3,0,8.50437,0.241949 +-6.75182,0.99883,0.883328,1,3,0,6.75883,0.261 +-6.77286,0.985494,0.883328,2,3,0,6.84503,0.222854 +-6.74967,0.998274,0.883328,1,3,0,6.7864,0.257228 +-6.79941,0.964756,0.883328,2,3,0,6.97244,0.211425 +-6.91419,0.957459,0.883328,1,3,0,7.12266,0.326215 +-6.78633,0.974476,0.883328,1,3,0,7.07508,0.216511 +-6.78573,0.995433,0.883328,2,3,0,6.84195,0.216764 +-7.85073,0.799746,0.883328,1,3,0,8.22993,0.100264 +-7.98366,0.988934,0.883328,2,7,0,7.98371,0.470442 +-7.21863,1,0.883328,2,3,0,7.7957,0.382034 +-7.21863,0.213664,0.883328,2,3,0,13.1076,0.382034 +-6.80613,0.951776,0.883328,1,3,0,7.51243,0.209083 +-6.7796,0.989672,0.883328,1,3,0,6.90754,0.282255 +-6.92089,0.94385,0.883328,2,3,0,7.12942,0.181708 +-7.47031,0.931841,0.883328,2,3,0,7.67456,0.122833 +-6.85826,0.941179,0.883328,1,3,0,8.17326,0.311509 +-6.81941,1,0.883328,1,1,0,6.85828,0.299087 +-6.81618,1,0.883328,2,7,0,6.81777,0.205848 +-6.82389,0.92142,0.883328,2,3,0,7.4697,0.203538 +-6.76346,0.99761,0.883328,2,3,0,6.84805,0.228476 +-7.43915,0.862823,0.883328,1,3,0,7.66908,0.12507 +-7.08252,1,0.883328,1,1,0,7.38678,0.158088 +-8.35252,0.851521,0.883328,1,3,0,8.52579,0.0791085 +-6.90852,0.962927,0.883328,1,3,0,8.48705,0.184002 +-7.16205,0.978312,0.883328,2,7,0,7.1761,0.373355 +-8.37042,0.703747,0.883328,1,1,0,8.37741,0.50435 +-6.76884,0.912248,0.883328,2,3,0,9.00843,0.276067 +-6.76884,0.390809,0.883328,1,3,0,11.1779,0.276067 +-6.82492,0.824204,0.883328,2,3,0,7.99312,0.203239 +-7.34529,0.799054,0.883328,2,3,0,8.43553,0.132295 +-7.51934,0.992401,0.883328,2,3,0,7.56754,0.119457 +-7.57697,0.992854,0.883328,1,1,0,7.67917,0.115695 +-6.9342,0.992426,0.883328,2,7,0,7.46238,0.330897 +-7.44771,0.86805,0.883328,1,1,0,7.44955,0.413027 +-7.31585,1,0.883328,1,1,0,7.5376,0.395891 +-6.75821,0.974353,0.883328,2,3,0,7.49241,0.268124 +-6.75646,1,0.883328,1,1,0,6.75933,0.266467 +-6.92292,0.922297,0.883328,2,3,0,7.23861,0.181341 +-6.76322,0.987864,0.883328,1,3,0,7.04022,0.272201 +-7.49016,0.849339,0.883328,2,3,0,7.92696,0.418214 +-8.57333,0.725003,0.883328,1,1,0,8.64337,0.520448 +-7.28553,1,0.883328,1,1,0,8.2147,0.391696 +-7.30178,0.995365,0.883328,1,1,0,7.4428,0.393957 +-6.96664,1,0.883328,1,1,0,7.22278,0.338022 +-6.82517,1,0.883328,1,1,0,6.93219,0.3011 +-6.82517,0.974883,0.883328,1,1,0,6.90326,0.3011 +-7.05474,0.886853,0.883328,1,3,0,7.49408,0.161535 +-7.28058,0.965708,0.883328,1,1,0,7.28901,0.137772 +-6.97459,1,0.883328,1,1,0,7.23118,0.172746 +-6.78466,0.926495,0.883328,2,3,0,7.66596,0.217222 +-6.74825,0.998793,0.883328,1,3,0,6.79397,0.252695 +-7.27127,0.918733,0.883328,2,3,0,7.44735,0.389685 +-6.89769,1,0.883328,2,3,0,7.17202,0.322152 +-7.12047,0.845355,0.883328,1,3,0,7.78927,0.153669 +-6.74806,0.992648,0.883328,1,3,0,7.20501,0.248944 +-6.79147,0.989604,0.883328,1,3,0,6.80606,0.287996 +-6.74825,1,0.883328,2,3,0,6.78719,0.247359 +-6.79469,0.988558,0.883328,1,3,0,6.8127,0.289417 +-6.85851,0.984119,0.883328,1,1,0,6.86074,0.311583 +-7.12746,0.865405,0.883328,1,3,0,7.71702,0.152887 +-6.97087,1,0.883328,1,1,0,7.11022,0.173323 +-7.91476,0.881823,0.883328,1,3,0,8.02786,0.0971274 +-7.91864,0.999592,0.883328,1,1,0,8.08525,0.096942 +-7.7412,1,0.883328,1,1,0,7.98873,0.106011 +-7.51651,1,0.883328,1,1,0,7.76869,0.119648 +-7.82667,0.963745,0.883328,1,1,0,7.86329,0.101483 +-6.77096,0.985272,0.883328,1,3,0,8.02267,0.223883 +-6.76726,0.997349,0.883328,2,3,0,6.80125,0.226029 +-7.55754,0.911093,0.883328,2,3,0,7.68316,0.426169 +-8.57663,0.912817,0.883328,2,3,0,8.66704,0.520703 +-8.81274,1,0.883328,2,7,0,8.81274,0.0647881 +-6.78092,1,0.883328,2,3,0,8.48407,0.218887 +-7.15606,0.934544,0.883328,1,3,0,7.21871,0.149785 +-7.42655,0.86781,0.883328,1,3,0,8.65082,0.410385 +-7.42655,0.750894,0.883328,1,1,0,8.17282,0.410385 +-8.281,0.776792,0.883328,1,1,0,8.35432,0.496917 +-6.82007,0.878869,0.883328,2,3,0,9.20271,0.299324 +-7.02961,0.981276,0.883328,2,3,0,7.02967,0.350585 +-6.77011,0.977101,0.883328,1,3,0,7.16589,0.224361 +-6.77011,0.955901,0.883328,1,3,0,7.03591,0.224361 +-6.76865,1,0.883328,1,1,0,6.77382,0.2252 +-6.83696,0.975793,0.883328,1,3,0,6.93514,0.305013 +-7.10962,0.866713,0.883328,2,7,0,7.63015,0.154901 +-7.18839,0.995989,0.883328,2,3,0,7.22995,0.146448 +-6.83279,0.997093,0.883328,2,7,0,7.11603,0.303657 +-6.99639,0.958334,0.883328,1,1,0,6.99847,0.344141 +-6.84313,0.95531,0.883328,2,3,0,7.33997,0.306964 +-7.01764,0.955349,0.883328,1,1,0,7.02051,0.348305 +-7.96697,0.763754,0.883328,1,1,0,7.96763,0.468865 +-6.74825,1,0.883328,1,3,0,7.91599,0.252652 +-7.3525,0.801053,0.883328,2,3,0,8.06871,0.131712 +-7.65412,0.961751,0.883328,1,1,0,7.6781,0.110969 +-7.52826,0.976228,0.883328,2,3,0,8.25572,0.118861 +-6.8513,0.982697,0.883328,1,3,0,7.50387,0.196251 +-6.74854,0.998575,0.883328,1,3,0,6.86066,0.245985 +-7.85917,0.738625,0.883328,1,3,0,8.50538,0.0998419 +-6.84172,0.99464,0.883328,2,3,0,7.91764,0.198658 +-6.78391,0.995411,0.883328,2,3,0,6.89418,0.217549 +-6.91314,0.987521,0.883328,2,7,0,6.91327,0.325961 +-6.77633,0.983962,0.883328,2,3,0,7.03053,0.280501 +-6.81458,0.977061,0.883328,1,3,0,6.9275,0.206342 +-6.88091,0.987368,0.883328,1,1,0,6.88282,0.189526 +-6.88091,0.875791,0.883328,1,3,0,7.76789,0.189526 +-6.90349,0.995887,0.883328,1,1,0,6.92335,0.184964 +-7.54376,0.915602,0.883328,1,3,0,7.60054,0.117838 +-8.1242,0.936061,0.883328,1,1,0,8.12895,0.087839 +-7.54631,1,0.883328,1,1,0,8.06348,0.11767 +-6.80279,0.941505,0.883328,1,3,0,8.13051,0.292808 +-8.55981,0.740424,0.883328,2,7,0,8.56894,0.0721872 +-8.62879,0.984094,0.883328,2,7,0,8.70193,0.524679 +-7.31405,1,0.883328,1,1,0,8.26465,0.395644 +-6.80848,0.948107,0.883328,1,3,0,7.63238,0.2083 +-6.79823,0.984312,0.883328,1,3,0,6.94815,0.290933 +-7.04748,0.964179,0.883328,2,7,0,7.05005,0.162469 +-7.40661,0.982206,0.883328,2,3,0,7.40675,0.127488 +-6.86527,0.932487,0.883328,1,3,0,8.08465,0.313517 +-6.7657,1,0.883328,2,3,0,6.84315,0.227001 +-6.84544,0.987914,0.883328,1,3,0,6.84857,0.197706 +-6.79743,1,0.883328,1,1,0,6.83771,0.212143 +-8.06134,0.757439,0.883328,1,3,0,8.63408,0.477645 +-7.23449,1,0.883328,1,1,0,7.85411,0.384378 +-9.0762,0.691746,0.883328,2,7,0,9.28021,0.0580827 +-6.80287,1,0.883328,2,3,0,8.72194,0.2102 +-6.76549,0.993522,0.883328,1,3,0,6.87164,0.273832 +-7.07886,0.93898,0.883328,1,3,0,7.10173,0.359532 +-7.60795,0.860376,0.883328,1,1,0,7.63005,0.431917 +-6.94423,1,0.883328,1,1,0,7.42406,0.333157 +-7.08521,0.962527,0.883328,1,1,0,7.11114,0.360639 +-7.96556,0.776911,0.883328,1,1,0,7.97302,0.468731 +-7.64319,1,0.883328,1,1,0,8.06184,0.435839 +-7.15953,1,0.883328,1,1,0,7.54674,0.372955 +-7.15953,0.773609,0.883328,1,3,0,8.6203,0.372955 +-6.74972,0.993418,0.883328,1,3,0,7.2011,0.242759 +-6.85984,0.581283,0.883328,2,3,0,10.3547,0.194208 +-6.86192,0.999611,0.883328,1,1,0,6.88367,0.193725 +-9.70386,0.684127,0.883328,2,3,0,9.72358,0.0452421 +-9.95162,0.955007,0.883328,2,7,0,10.0664,0.609684 +-7.57986,1,0.883328,1,1,0,9.26789,0.428734 +-7.57986,0.604056,0.883328,1,1,0,8.81857,0.428734 +-7.21476,1,0.883328,1,1,0,7.54219,0.381456 +-7.00069,1,0.883328,1,1,0,7.18665,0.344996 +-7.00069,0.837076,0.883328,1,1,0,7.46084,0.344996 +-6.82705,1,0.883328,2,3,0,6.95675,0.301742 +-6.88273,0.98585,0.883328,1,1,0,6.89207,0.318289 +-6.82339,1,0.883328,1,1,0,6.87566,0.300487 +-7.29035,0.93104,0.883328,2,7,0,7.29516,0.136916 +-6.87226,0.944787,0.883328,1,3,0,7.90692,0.315464 +-6.95876,0.911321,0.883328,2,7,0,7.40155,0.175241 +-7.31644,0.968991,0.883328,2,7,0,7.33206,0.39597 +-6.94725,1,0.883328,2,7,0,7.24761,0.177127 +-6.74812,0.957573,0.883328,2,3,0,7.33361,0.251722 +-6.74806,1,0.883328,1,1,0,6.7481,0.251102 +-7.50794,0.846124,0.883328,1,3,0,7.67266,0.420345 +-6.75621,0.986797,0.883328,1,3,0,7.60841,0.234238 +-6.79506,0.993906,0.883328,1,3,0,6.79647,0.213026 +-6.81381,0.991773,0.883328,2,3,0,6.88596,0.206585 +-6.86371,0.990432,0.883328,1,1,0,6.86722,0.193312 +-7.03227,0.934877,0.883328,1,3,0,7.44147,0.351086 +-7.04528,0.996447,0.883328,1,1,0,7.11591,0.353504 +-7.04404,1,0.883328,2,7,0,7.04437,0.162916 +-6.89685,1,0.883328,1,1,0,7.02102,0.186263 +-6.84199,0.99093,0.883328,2,3,0,7.01806,0.198589 +-6.75043,1,0.883328,2,3,0,6.84022,0.241385 +-8.02501,0.75848,0.883328,1,3,0,8.34315,0.474304 +-7.18601,1,0.883328,2,7,0,7.8674,0.146688 +-6.83118,0.915341,0.883328,2,3,0,8.12086,0.201473 +-6.84778,0.996826,0.883328,1,1,0,6.86018,0.197118 +-6.87604,0.964663,0.883328,1,3,0,7.1583,0.316496 +-7.03042,0.728355,0.883328,2,3,0,8.74214,0.16472 +-8.25041,0.924231,0.883328,2,3,0,8.25642,0.494322 +-7.82631,1,0.883328,1,1,0,8.35354,0.455122 +-9.72672,0.830524,0.883328,2,3,0,9.81077,0.596991 +-6.84378,1,0.883328,2,3,0,9.71172,0.198129 +-6.92692,0.955154,0.883328,1,3,0,7.23509,0.329222 +-7.51222,0.851018,0.883328,1,1,0,7.5126,0.420855 +-7.31441,1,0.883328,1,1,0,7.57177,0.395694 +-7.12895,1,0.883328,1,1,0,7.32941,0.368023 +-7.31001,0.950133,0.883328,1,1,0,7.37804,0.39509 +-7.31001,0.678649,0.883328,1,1,0,8.26093,0.39509 +-6.77068,0.971906,0.883328,1,3,0,7.48195,0.224042 +-6.77068,0.854573,0.883328,1,3,0,7.61688,0.224042 +-6.91648,0.976334,0.883328,1,3,0,6.92784,0.182515 +-7.41555,0.936178,0.883328,2,3,0,7.61908,0.126815 +-7.46576,0.997811,0.883328,2,3,0,7.55745,0.123155 +-7.22119,1,0.883328,1,1,0,7.45273,0.14323 +-7.0943,0.899697,0.883328,2,3,0,8.44315,0.362209 +-7.25795,0.955116,0.883328,1,1,0,7.3192,0.387784 +-6.78185,1,0.883328,2,3,0,7.1813,0.218461 +-6.78983,0.982923,0.883328,2,3,0,6.94347,0.287249 +-6.8487,0.963584,0.883328,1,3,0,7.01968,0.19689 +-6.7627,0.984543,0.883328,2,3,0,6.99546,0.27181 +-6.88435,0.957199,0.883328,1,3,0,7.01695,0.188804 +-6.78164,0.984212,0.883328,1,3,0,7.03474,0.283307 +-7.43598,0.791795,0.883328,1,3,0,8.07726,0.125302 +-7.76905,0.959724,0.883328,1,1,0,7.79496,0.1045 +-7.78757,0.991173,0.883328,2,7,0,7.82379,0.451185 +-6.75997,1,0.883328,1,3,0,7.65877,0.26965 +-6.75997,0.825995,0.883328,1,3,0,7.55036,0.26965 +-6.85407,0.982826,0.883328,1,3,0,6.85759,0.310281 +-7.01438,0.903809,0.883328,1,3,0,7.47922,0.166916 +-6.9412,1,0.883328,1,1,0,7.02001,0.178144 +-7.18177,0.840641,0.883328,2,3,0,8.43079,0.147118 +-8.77675,0.824653,0.883328,1,3,0,9.03485,0.0657789 +-8.80435,0.997979,0.883328,1,1,0,9.0369,0.0650174 +-6.77074,0.986835,0.883328,2,7,0,8.39962,0.277255 +-6.76478,0.994619,0.883328,1,3,0,6.82,0.227593 +-6.75721,0.996778,0.883328,1,3,0,6.79414,0.267195 +-6.78714,0.862794,0.883328,2,3,0,7.72248,0.21617 +-7.0855,0.951445,0.883328,1,3,0,7.11989,0.157731 +-7.98268,0.93203,0.883328,2,7,0,7.9864,0.47035 +-8.0748,0.972835,0.883328,1,1,0,8.4062,0.478872 +-8.0748,0.687589,0.883328,1,1,0,9.15129,0.478872 +-8.2968,0.978552,0.883328,2,3,0,8.63219,0.498247 +-11.0037,0.453286,0.883328,1,1,0,11.1227,0.662174 +-8.32801,1,0.883328,1,1,0,10.3494,0.500852 +-7.64816,1,0.883328,1,1,0,8.2721,0.436386 +-7.4892,1,0.883328,1,1,0,7.77487,0.418098 +-8.24247,0.499772,0.883328,1,3,0,11.7292,0.0831561 +-8.29576,0.987587,0.883328,2,7,0,8.34885,0.498159 +-8.00549,1,0.883328,1,1,0,8.51207,0.472489 +-7.59126,1,0.883328,1,1,0,8.04659,0.430032 +-7.13726,1,0.883328,2,7,0,7.54419,0.151807 +-6.74979,1,0.883328,2,3,0,7.08592,0.242626 +-6.76004,0.977178,0.883328,2,3,0,6.9029,0.230965 +-6.76004,0.615718,0.883328,1,3,0,9.20853,0.230965 +-7.6303,0.821267,0.883328,1,3,0,7.93898,0.434413 +-7.14745,1,0.883328,2,3,0,7.53165,0.371028 +-7.36516,0.738407,0.883328,2,3,0,8.88104,0.402496 +-7.68164,0.911766,0.883328,1,1,0,7.79549,0.440036 +-8.25146,0.843842,0.883328,1,1,0,8.42039,0.494412 +-8.25146,0.714854,0.883328,1,1,0,9.29894,0.494412 +-7.84975,1,0.883328,1,1,0,8.37135,0.457471 +-6.98808,1,0.883328,1,1,0,7.60727,0.342467 +-7.15308,0.955704,0.883328,1,1,0,7.18674,0.371929 +-6.9192,0.904766,0.883328,1,3,0,7.75166,0.182015 +-7.03927,0.979484,0.883328,1,1,0,7.04688,0.163542 +-7.67571,0.925517,0.883328,2,3,0,7.95469,0.109705 +-8.16402,0.948646,0.883328,1,1,0,8.18383,0.0862213 +-8.2614,0.991018,0.883328,1,1,0,8.41715,0.0824398 +-9.1318,0.932261,0.883328,1,1,0,9.13675,0.0567804 +-9.14184,0.999356,0.883328,1,1,0,9.40608,0.0565489 +-9.34464,0.987563,0.883328,1,1,0,9.53317,0.0521142 +-9.74877,0.977842,0.883328,1,1,0,9.88175,0.0444607 +-8.69499,1,0.883328,2,3,0,9.68074,0.0681033 +-8.04954,1,0.883328,1,1,0,8.65544,0.090993 +-6.77672,1,0.883328,2,3,0,7.86788,0.22088 +-6.77003,1,0.883328,1,1,0,6.77839,0.224404 +-7.00884,0.95776,0.883328,1,3,0,7.04269,0.167694 +-6.83135,0.967211,0.883328,1,3,0,7.34748,0.303183 +-7.06945,0.939665,0.883328,1,1,0,7.06961,0.357872 +-7.01858,1,0.883328,1,1,0,7.11476,0.348486 +-7.0055,1,0.883328,1,1,0,7.07834,0.345945 +-6.93598,0.904147,0.883328,1,3,0,7.5769,0.179038 +-7.02727,0.984461,0.883328,1,1,0,7.04131,0.165145 +-6.89915,1,0.883328,1,1,0,7.00942,0.185809 +-7.5802,0.920793,0.883328,2,3,0,7.7605,0.115491 +-7.62024,0.995152,0.883328,1,1,0,7.73582,0.113003 +-6.78575,1,0.883328,2,3,0,7.5402,0.216754 +-6.77632,0.990923,0.883328,1,3,0,6.86721,0.280494 +-6.89664,0.950613,0.883328,2,3,0,7.08552,0.186305 +-6.88587,0.957326,0.883328,2,3,0,7.34887,0.319115 +-6.79766,0.972258,0.883328,1,3,0,7.06667,0.212058 +-6.75388,0.986588,0.883328,2,3,0,6.90894,0.263695 +-7.55182,0.784785,0.883328,1,3,0,8.11855,0.117311 +-7.64442,0.988801,0.883328,1,1,0,7.73911,0.111545 +-6.76497,0.988065,0.883328,1,3,0,7.79279,0.227472 +-6.79153,0.993566,0.883328,2,3,0,6.82506,0.214388 +-6.79732,0.976557,0.883328,2,3,0,7.01322,0.290548 +-7.59885,0.87839,0.883328,2,7,0,7.59952,0.114321 +-7.41848,1,0.883328,1,1,0,7.63071,0.126595 +-7.32774,1,0.883328,1,1,0,7.47398,0.133737 +-6.85534,0.9957,0.883328,2,7,0,7.23276,0.310655 +-7.20163,0.832438,0.883328,2,7,0,7.85873,0.14513 +-8.25184,0.917129,0.883328,2,7,0,8.2631,0.494444 +-10.1033,0.859458,0.883328,2,3,0,10.2834,0.61792 +-7.43226,1,0.883328,1,1,0,9.31404,0.411101 +-6.86822,1,0.883328,2,3,0,7.31025,0.19229 +-7.72253,0.93991,0.883328,2,3,0,7.74581,0.444409 +-8.26717,0.850063,0.883328,1,1,0,8.45073,0.495747 +-8.05643,1,0.883328,1,1,0,8.53594,0.477197 +-7.64592,1,0.883328,1,1,0,8.1144,0.43614 +-7.64592,0.82206,0.883328,1,1,0,8.25641,0.43614 +-6.75222,1,0.883328,2,3,0,7.68467,0.238665 +-6.75715,0.99851,0.883328,2,3,0,6.76589,0.233374 +-6.75512,0.974641,0.883328,2,3,0,6.93778,0.235302 +-6.7509,0.998793,0.883328,2,3,0,6.76667,0.259567 +-6.80329,0.983912,0.883328,1,3,0,6.84408,0.210054 +-7.62336,0.858186,0.883328,1,3,0,7.83234,0.112813 +-7.60274,0.995698,0.883328,2,7,0,7.65403,0.43133 +-6.76015,0.957946,0.883328,2,3,0,7.89411,0.269797 +-6.91555,0.970178,0.883328,1,3,0,6.92529,0.32654 +-7.24978,0.971029,0.883328,2,3,0,7.25512,0.386607 +-6.9996,1,0.883328,2,3,0,7.2076,0.344778 +-7.09519,0.974166,0.883328,1,1,0,7.14156,0.362361 +-7.61019,0.644729,0.883328,2,7,0,9.29957,0.113619 +-8.27343,0.932244,0.883328,2,3,0,8.83168,0.0819889 +-6.80947,0.888272,0.883328,2,7,0,9.3945,0.295429 +-6.87707,0.954038,0.883328,1,3,0,7.11436,0.190347 +-6.74857,0.957153,0.883328,2,3,0,7.23939,0.245871 +-7.40955,0.862375,0.883328,1,3,0,7.58081,0.408235 +-7.96232,0.84988,0.883328,1,1,0,8.05972,0.468424 +-7.09099,1,0.883328,1,1,0,7.72073,0.36164 +-8.44872,0.787859,0.883328,2,7,0,8.55516,0.0757898 +-8.82735,0.99021,0.883328,2,3,0,8.91847,0.0643913 +-8.0694,1,0.883328,1,1,0,8.76865,0.0901382 +-8.61089,0.788617,0.883328,1,3,0,12.4412,0.523321 +-7.55942,1,0.883328,1,1,0,8.38619,0.426386 +-7.88661,0.907786,0.883328,1,1,0,8.05375,0.461116 +-7.71808,1,0.883328,1,1,0,8.07539,0.443937 +-7.27468,1,0.883328,1,1,0,7.66356,0.390168 +-7.06313,1,0.883328,1,1,0,7.26219,0.356745 +-7.48424,0.887837,0.883328,1,1,0,7.51062,0.417499 +-7.10415,1,0.883328,1,1,0,7.41514,0.363887 +-6.75173,0.999137,0.883328,1,3,0,7.07583,0.260863 +-6.7511,0.99892,0.883328,1,3,0,6.76042,0.240281 +-6.74803,0.915972,0.883328,2,3,0,7.39471,0.249366 +-6.80864,0.991552,0.883328,2,3,0,6.81954,0.29511 +-6.7493,0.99959,0.883328,1,3,0,6.80423,0.256355 +-6.79743,0.98625,0.883328,1,3,0,6.82798,0.212143 +-6.81631,0.980791,0.883328,1,3,0,6.96095,0.297973 +-6.95261,0.941562,0.883328,2,3,0,7.22855,0.335005 +-7.30717,0.907032,0.883328,1,1,0,7.31707,0.3947 +-7.30717,0.853213,0.883328,1,1,0,7.76432,0.3947 +-7.10381,1,0.883328,1,1,0,7.30816,0.36383 +-7.09655,1,0.883328,1,1,0,7.19141,0.362594 +-6.75573,0.98623,0.883328,1,3,0,7.17821,0.2347 +-6.75199,0.999292,0.883328,2,3,0,6.76291,0.238973 +-6.99667,0.947414,0.883328,1,3,0,7.06759,0.169439 +-7.23241,0.897562,0.883328,1,3,0,8.0246,0.384073 +-6.7706,1,0.883328,1,3,0,7.15095,0.277171 +-7.78049,0.809765,0.883328,1,3,0,7.87786,0.450457 +-7.36619,1,0.883328,1,1,0,7.76091,0.402631 +-8.07198,0.454262,0.883328,1,3,0,11.02,0.090028 +-8.93796,0.927119,0.883328,1,1,0,8.93995,0.0614859 +-8.93202,0.981869,0.883328,2,7,0,9.0863,0.546676 +-10.621,0.613737,0.883328,1,1,0,10.9842,0.64426 +-10.4608,1,0.883328,2,7,0,10.5941,0.0339334 +-9.43376,1,0.883328,1,1,0,10.4237,0.0502994 +-9.24181,1,0.883328,1,1,0,9.62051,0.0543077 +-9.25622,0.999115,0.883328,1,1,0,9.52546,0.0539936 +-8.38098,1,0.883328,1,1,0,9.19618,0.0781064 +-8.25911,1,0.883328,2,3,0,8.52551,0.0825259 +-7.92556,1,0.883328,1,1,0,8.29159,0.0966131 +-7.63479,0.978721,0.883328,2,3,0,8.52785,0.112122 +-7.7735,0.984051,0.883328,1,1,0,7.86336,0.104263 +-7.60741,1,0.883328,1,1,0,7.83314,0.11379 +-6.94204,0.980812,0.883328,1,3,0,7.54683,0.178001 +-7.95995,0.871883,0.883328,1,3,0,8.11527,0.0950031 +-8.08356,0.987649,0.883328,1,1,0,8.21128,0.0895358 +-6.85681,0.895262,0.883328,1,3,0,9.23144,0.311087 +-6.85681,0.734721,0.883328,1,3,0,8.20687,0.311087 +-6.75249,0.999775,0.883328,1,3,0,6.84335,0.261943 +-7.58898,0.777811,0.883328,1,3,0,8.16994,0.114937 +-7.2321,0.864992,0.883328,2,7,0,9.17847,0.384028 +-6.95478,1,0.883328,1,1,0,7.17128,0.335477 +-6.92298,0.914186,0.883328,1,3,0,7.46651,0.18133 +-7.09691,0.970774,0.883328,1,1,0,7.09961,0.156376 +-8.50676,0.915167,0.883328,2,3,0,8.51137,0.515278 +-6.76752,0.989674,0.883328,1,3,0,8.67558,0.225874 +-6.83154,0.977165,0.883328,1,3,0,6.92421,0.303246 +-6.8509,0.968255,0.883328,2,3,0,7.07036,0.309336 +-6.9922,0.963661,0.883328,1,1,0,6.99819,0.3433 +-6.91593,1,0.883328,1,1,0,6.99959,0.32663 +-6.7522,0.999536,0.883328,1,3,0,6.89867,0.261545 +-6.86224,0.97767,0.883328,1,3,0,6.87474,0.312655 +-6.75973,1,0.883328,1,3,0,6.84193,0.269444 +-6.75973,0.701081,0.883328,1,3,0,8.41406,0.269444 +-7.88577,0.788074,0.883328,1,3,0,8.02629,0.461033 +-8.29529,0.884725,0.883328,1,1,0,8.54454,0.49812 +-6.758,1,0.883328,1,3,0,8.11268,0.267927 +-7.10679,0.929993,0.883328,1,3,0,7.14482,0.364333 +-6.75104,0.991541,0.883328,1,3,0,7.15883,0.24037 +-6.753,0.999573,0.883328,1,1,0,6.75327,0.23767 +-6.89896,0.962605,0.883328,1,3,0,6.97669,0.322474 +-6.76474,0.984858,0.883328,1,3,0,6.99144,0.227619 +-6.74802,0.872243,0.883328,2,3,0,7.82977,0.250192 +-6.92747,0.975076,0.883328,2,3,0,6.94057,0.180528 +-7.06579,0.992209,0.883328,2,3,0,7.07212,0.160141 +-7.20078,0.979177,0.883328,1,1,0,7.22386,0.145214 +-6.75774,0.993342,0.883328,1,3,0,7.24091,0.232849 +-6.98751,0.974873,0.883328,2,3,0,7.00511,0.34235 +-6.90858,0.917979,0.883328,1,3,0,7.48431,0.18399 +-7.56474,0.913811,0.883328,1,3,0,7.62335,0.116476 +-6.89243,0.929402,0.883328,1,3,0,8.42367,0.320815 +-7.08663,0.858791,0.883328,1,3,0,7.70769,0.157595 +-7.45681,0.94641,0.883328,1,1,0,7.45741,0.123793 +-7.33833,1,0.883328,1,1,0,7.50229,0.132863 +-6.88728,0.932254,0.883328,1,3,0,8.02362,0.319483 +-6.79743,0.979249,0.883328,2,3,0,7.04832,0.290593 +-6.8353,0.969117,0.883328,1,3,0,7.00892,0.200349 +-6.79128,0.985255,0.883328,1,3,0,6.97926,0.287911 +-6.77923,1,0.883328,2,3,0,6.79318,0.282061 +-7.31663,0.897447,0.883328,1,3,0,7.34944,0.395997 +-7.1136,1,0.883328,1,1,0,7.32024,0.365478 +-8.6009,0.750523,0.883328,2,7,0,8.72341,0.0709124 +-6.77999,1,0.883328,2,3,0,8.31214,0.219314 +-7.30636,0.933007,0.883328,2,3,0,7.38495,0.135536 +-6.87264,0.937158,0.883328,1,3,0,7.93468,0.315568 +-6.87264,0.738524,0.883328,1,3,0,8.1949,0.315568 +-6.74845,0.998745,0.883328,1,3,0,6.87158,0.253662 +-7.25037,0.929244,0.883328,2,3,0,7.26657,0.140492 +-7.01915,0.985515,0.883328,2,3,0,7.50366,0.166254 +-6.92591,1,0.883328,1,1,0,7.01539,0.180805 +-6.89921,1,0.883328,1,1,0,6.94311,0.185797 +-6.83935,0.922896,0.883328,2,3,0,7.75862,0.305777 +-6.7847,1,0.883328,1,1,0,6.82715,0.284829 +-6.81267,0.977398,0.883328,1,3,0,6.94042,0.206944 +-6.81917,0.982426,0.883328,1,3,0,6.99403,0.299002 +-7.19495,0.945655,0.883328,2,7,0,7.19974,0.145792 +-6.75117,1,0.883328,2,3,0,7.13752,0.240172 +-6.75185,0.998836,0.883328,1,3,0,6.76083,0.261047 +-6.75185,0.878894,0.883328,1,3,0,7.30346,0.261047 +-6.76329,0.992526,0.883328,2,3,0,6.80145,0.228594 +-7.43477,0.923089,0.883328,2,3,0,7.53874,0.411415 +-8.94908,0.638169,0.883328,1,1,0,8.98279,0.54786 +-6.76886,0.999868,0.883328,2,3,0,9.11316,0.225078 +-7.43231,0.855208,0.883328,1,3,0,7.73335,0.411108 +-6.89475,0.903821,0.883328,1,3,0,8.04879,0.18668 +-6.7482,0.95725,0.883328,2,3,0,7.26333,0.247624 +-7.10747,0.949191,0.883328,2,3,0,7.19692,0.364448 +-6.83903,1,0.883328,1,1,0,7.03702,0.305674 +-7.01646,0.904313,0.883328,1,3,0,7.45096,0.166627 +-6.90295,1,0.883328,1,1,0,7.00318,0.185068 +-6.76649,0.99784,0.883328,2,3,0,6.92417,0.226506 +-6.7598,1,0.883328,1,1,0,6.7662,0.231147 +-6.74976,0.994581,0.883328,2,3,0,6.80083,0.257415 +-6.74976,0.685855,0.883328,1,3,0,8.53649,0.257415 +-6.74883,0.999289,0.883328,2,3,0,6.75532,0.244982 +-6.75214,0.998776,0.883328,1,3,0,6.75659,0.26145 +-7.08668,0.94046,0.883328,2,3,0,7.23086,0.360894 +-6.75469,1,0.883328,2,3,0,7.05531,0.235751 +-6.75469,0.906097,0.883328,1,3,0,7.24639,0.235751 +-6.99051,0.942149,0.883328,1,3,0,7.10539,0.342958 +-6.82106,1,0.883328,1,1,0,6.94744,0.299674 +-6.79394,1,0.883328,1,1,0,6.82013,0.289092 +-9.81734,0.413762,0.883328,2,3,0,11.7895,0.602177 +-7.41934,1,0.883328,1,1,0,9.1117,0.409476 +-7.58049,0.954065,0.883328,1,1,0,7.73321,0.428806 +-7.39883,1,0.883328,1,1,0,7.67095,0.406867 +-6.8295,1,0.883328,2,3,0,7.28492,0.20194 +-7.06612,0.925871,0.883328,1,3,0,7.41717,0.35728 +-7.19524,0.785495,0.883328,2,3,0,8.6131,0.145763 +-7.05139,0.983262,0.883328,2,3,0,7.49216,0.161964 +-7.27699,0.988557,0.883328,2,3,0,7.28516,0.13809 +-7.28256,0.999207,0.883328,1,1,0,7.37069,0.137598 +-6.84454,0.996221,0.883328,2,7,0,7.19329,0.307399 +-6.76323,0.992283,0.883328,2,3,0,6.90205,0.272208 +-6.75486,0.998163,0.883328,2,3,0,6.77925,0.264801 +-7.2394,0.864096,0.883328,1,3,0,7.57957,0.141508 +-6.81164,0.948542,0.883328,2,7,0,7.66653,0.296249 +-6.78878,1,0.883328,1,1,0,6.81127,0.286767 +-6.78058,0.989157,0.883328,1,3,0,6.88281,0.219042 +-6.75406,0.991622,0.883328,2,3,0,6.85078,0.2639 +-7.79592,0.729588,0.883328,2,3,0,8.56821,0.103076 +-6.85598,1,0.883328,2,3,0,7.76224,0.19512 +-6.83084,0.974029,0.883328,1,3,0,7.09206,0.303016 +-7.18193,0.874959,0.883328,2,3,0,7.68732,0.376464 +-7.23002,0.986508,0.883328,1,1,0,7.33514,0.383721 +-7.26881,0.989031,0.883328,1,1,0,7.3894,0.389336 +-7.38498,0.98907,0.883328,2,3,0,7.50223,0.405082 +-6.88417,0.909958,0.883328,1,3,0,7.9581,0.188841 +-6.87629,0.95976,0.883328,2,3,0,7.30944,0.316565 +-7.93534,0.600939,0.883328,1,3,0,9.455,0.096151 +-6.97772,0.970378,0.883328,1,3,0,7.89757,0.172266 +-6.74839,0.996686,0.883328,1,3,0,7.01429,0.246622 +-6.74839,0.812846,0.883328,1,3,0,7.70018,0.246622 +-7.44911,0.85538,0.883328,1,3,0,7.62463,0.4132 +-7.44911,0.543267,0.883328,1,1,0,8.91053,0.4132 +-6.82864,1,0.883328,2,3,0,7.32936,0.202179 +-6.77132,0.941135,0.883328,2,3,0,7.30906,0.223686 +-8.15832,0.681746,0.883328,2,3,0,9.23943,0.08645 +-8.5702,0.964296,0.883328,1,1,0,8.63441,0.0718618 +-6.81727,0.963214,0.883328,2,3,0,9.39327,0.205513 +-7.72408,0.810361,0.883328,1,3,0,8.27386,0.444572 +-7.35857,1,0.883328,2,3,0,7.72293,0.401628 +-7.43946,0.97687,0.883328,1,1,0,7.5888,0.412001 +-7.49996,0.994178,0.883328,2,3,0,7.67663,0.419391 +-6.82178,0.93772,0.883328,1,3,0,7.89282,0.204157 +-6.86213,0.997433,0.883328,2,3,0,6.86814,0.193676 +-7.36479,0.931711,0.883328,1,3,0,7.40631,0.130729 +-7.15231,1,0.883328,1,1,0,7.35321,0.150183 +-7.66904,0.935412,0.883328,2,3,0,8.02892,0.110092 +-7.04548,0.899232,0.883328,1,3,0,8.96267,0.353542 +-7.11569,0.833349,0.883328,2,7,0,8.05978,0.154208 +-6.76859,1,0.883328,2,3,0,7.10786,0.225234 +-6.78237,0.997148,0.883328,1,1,0,6.78396,0.218229 +-6.82635,0.991216,0.883328,1,1,0,6.82687,0.20283 +-6.9316,0.885833,0.883328,2,3,0,7.7622,0.179799 +-6.76398,0.977009,0.883328,2,3,0,7.16226,0.272758 +-6.82961,0.968578,0.883328,2,3,0,6.96337,0.201908 +-7.36268,0.920793,0.883328,1,3,0,7.43059,0.130897 +-7.04344,1,0.883328,2,3,0,7.31461,0.162994 +-6.96121,1,0.883328,1,1,0,7.04885,0.174847 +-7.13297,0.971916,0.883328,1,1,0,7.13896,0.152277 +-7.13876,0.999106,0.883328,1,1,0,7.20549,0.151643 +-7.50268,0.982956,0.883328,2,3,0,7.50524,0.120585 +-10.3423,0.787054,0.883328,2,3,0,10.5017,0.0354697 +-9.74233,1,0.883328,1,1,0,10.41,0.0445717 +-7.23764,1,0.883328,2,3,0,9.57559,0.141673 +-7.04053,0.984388,0.883328,2,3,0,7.51479,0.163376 +-6.88097,1,0.883328,1,1,0,7.01327,0.189513 +-6.7482,0.958415,0.883328,2,3,0,7.2345,0.247615 +-6.76239,0.998202,0.883328,2,3,0,6.76364,0.271577 +-6.76145,0.959651,0.883328,2,3,0,7.03423,0.229896 +-7.66453,0.815532,0.883328,1,3,0,7.9887,0.438179 +-7.11647,1,0.883328,2,3,0,7.53603,0.365959 +-7.0895,1,0.883328,1,1,0,7.19246,0.361382 +-7.25129,0.813472,0.883328,1,3,0,8.452,0.140408 +-7.04708,1,0.883328,2,3,0,7.22973,0.162521 +-6.77375,0.976808,0.883328,2,3,0,7.31862,0.279044 +-6.76268,0.99365,0.883328,1,3,0,6.82015,0.229017 +-6.86777,0.982324,0.883328,1,3,0,6.87629,0.192391 +-6.86566,1,0.883328,1,1,0,6.8902,0.192869 +-6.87675,0.997941,0.883328,1,1,0,6.89695,0.190414 +-6.74818,0.963091,0.883328,2,3,0,7.19103,0.252225 +-6.75398,0.999267,0.883328,2,3,0,6.75423,0.236527 +-6.74827,0.893073,0.883328,2,3,0,7.60198,0.247227 +-6.74854,0.999836,0.883328,1,3,0,6.74943,0.254056 +-6.74893,0.99983,0.883328,2,3,0,6.75008,0.25536 +-6.83738,0.988034,0.883328,2,3,0,6.84153,0.199793 +-6.77077,0.999678,0.883328,2,7,0,6.82409,0.277274 +-7.00916,0.918231,0.883328,1,3,0,7.25896,0.167649 +-7.20884,0.899974,0.883328,1,3,0,8.01369,0.380568 +-7.16671,1,0.883328,1,1,0,7.29898,0.37409 +-7.16671,0.90378,0.883328,1,3,0,7.76544,0.37409 +-7.76823,0.840809,0.883328,1,1,0,7.80309,0.449191 +-7.69361,1,0.883328,2,7,0,7.71472,0.108674 +-7.01424,0.910153,0.883328,2,3,0,9.03986,0.166936 +-7.5478,0.933313,0.883328,2,3,0,7.81944,0.117573 +-7.5924,0.994524,0.883328,1,1,0,7.70249,0.114723 +-6.74834,1,0.883328,2,3,0,7.43609,0.253165 +-6.80312,0.991552,0.883328,2,3,0,6.81778,0.292941 +-6.93054,0.932527,0.883328,2,7,0,7.20382,0.179985 +-6.82243,0.888258,0.883328,2,3,0,8.22446,0.300154 +-8.16752,0.589157,0.883328,2,7,0,9.74452,0.0860808 +-7.50246,1,0.883328,1,1,0,8.09119,0.1206 +-6.80057,0.985086,0.883328,1,3,0,7.5258,0.211009 +-6.76486,0.99071,0.883328,2,7,0,6.86667,0.273394 +-6.76486,0.759577,0.883328,1,3,0,7.88854,0.273394 +-7.30324,0.894463,0.883328,1,3,0,7.35423,0.394159 +-9.18789,0.573461,0.883328,1,1,0,9.19332,0.56392 +-7.76284,1,0.883328,1,1,0,8.86733,0.448633 +-7.76698,1,0.883328,2,7,0,7.76856,0.104611 +-8.51291,0.927418,0.883328,1,1,0,8.51475,0.0736796 +-8.8849,0.971836,0.883328,1,1,0,8.98182,0.0628584 +-8.8849,0.946231,0.883328,1,1,0,9.73057,0.0628584 +-9.64987,0.952737,0.883328,1,1,0,9.68322,0.0462031 +-9.04106,1,0.883328,1,1,0,9.68036,0.0589251 +-9.35717,0.980282,0.883328,1,1,0,9.50167,0.0518545 +-6.84312,0.960131,0.883328,2,7,0,10.1794,0.198298 +-6.79172,0.980284,0.883328,2,7,0,6.99286,0.288108 +-6.86037,0.982957,0.883328,1,1,0,6.86187,0.312121 +-6.75512,1,0.883328,1,3,0,6.8434,0.265086 +-6.96323,0.957935,0.883328,1,3,0,6.98602,0.337297 +-7.48755,0.702696,0.883328,1,3,0,8.72326,0.121627 +-7.60343,0.985638,0.883328,1,1,0,7.68352,0.114036 +-7.2501,1,0.883328,1,1,0,7.56499,0.140516 +-6.78322,0.990645,0.883328,1,3,0,7.24851,0.217852 +-6.75001,0.985245,0.883328,2,3,0,6.89732,0.257935 +-7.16831,0.912791,0.883328,1,3,0,7.24334,0.374341 +-6.97218,1,0.883328,1,1,0,7.14082,0.339188 +-6.8968,1,0.883328,1,1,0,6.9753,0.321929 +-9.03266,0.44645,0.883328,2,3,0,11.1235,0.553591 +-8.86885,1,0.883328,2,7,0,8.92668,0.0632811 +-8.86885,0.982627,0.883328,1,1,0,9.26252,0.0632811 +-7.10851,0.944746,0.883328,1,3,0,8.99142,0.155029 +-6.77528,0.993647,0.883328,1,3,0,7.09737,0.221597 +-6.77234,0.993407,0.883328,1,3,0,6.84166,0.278219 +-7.00667,0.918466,0.883328,1,3,0,7.25987,0.168001 +-6.76249,0.995816,0.883328,1,3,0,7.00111,0.229151 +-6.74805,0.999791,0.883328,1,3,0,6.76366,0.249048 +-8.30437,0.783597,0.883328,2,3,0,8.31269,0.0808449 +-6.74848,0.943498,0.883328,1,3,0,9.00596,0.253799 +-6.8575,0.975963,0.883328,1,3,0,6.88111,0.31129 +-6.92838,0.838648,0.883328,2,3,0,7.944,0.180365 +-7.38352,0.878045,0.883328,1,3,0,8.10092,0.404892 +-9.11367,0.599123,0.883328,1,1,0,9.13131,0.55903 +-8.02761,1,0.883328,1,1,0,8.99115,0.474544 +-7.82463,1,0.883328,1,1,0,8.23147,0.454953 +-6.78771,1,0.883328,2,3,0,7.74307,0.21593 +-7.68884,0.812861,0.883328,1,3,0,8.13033,0.440813 +-6.76503,1,0.883328,1,3,0,7.55645,0.273513 +-6.77768,0.914901,0.883328,2,3,0,7.34208,0.22041 +-7.18848,0.926203,0.883328,1,3,0,7.2674,0.146439 +-6.7482,0.989424,0.883328,1,3,0,7.31159,0.252365 +-7.70437,0.81227,0.883328,1,3,0,7.8979,0.442478 +-8.35714,0.823061,0.883328,1,1,0,8.52217,0.50326 +-6.78191,1,0.883328,2,7,0,8.08515,0.283444 +-7.4061,0.907488,0.883328,2,3,0,7.40612,0.127526 +-6.74934,1,0.883328,2,3,0,7.283,0.256447 +-6.84478,0.941738,0.883328,2,3,0,7.11752,0.197874 +-6.74832,0.997235,0.883328,1,3,0,6.86843,0.253037 +-6.9254,0.960931,0.883328,1,3,0,6.96594,0.328867 +-7.50232,0.942163,0.883328,2,3,0,7.50271,0.419674 +-7.66878,0.952296,0.883328,1,1,0,7.84466,0.438641 +-7.62073,1,0.883328,2,7,0,7.63185,0.112973 +-6.84125,0.980743,0.883328,1,3,0,7.62121,0.198779 +-6.78675,0.986038,0.883328,1,3,0,6.97922,0.285813 +-6.85013,0.825924,0.883328,2,3,0,7.97549,0.196538 +-6.77307,0.990063,0.883328,1,3,0,6.96158,0.278648 +-6.76998,1,0.883328,1,1,0,6.77675,0.276787 +-7.30237,0.835671,0.883328,1,3,0,7.77677,0.135877 +-7.05561,1,0.883328,1,1,0,7.27076,0.161425 +-6.89223,0.95017,0.883328,1,3,0,7.55466,0.320765 +-6.82403,1,0.883328,1,1,0,6.88201,0.30071 +-6.79657,0.978185,0.883328,1,3,0,6.97362,0.212461 +-6.79376,0.986027,0.883328,1,3,0,6.91899,0.289011 +-7.47945,0.774651,0.883328,1,3,0,8.21182,0.12219 +-7.30909,0.865012,0.883328,2,7,0,9.10358,0.394965 +-8.52196,0.884961,0.883328,2,3,0,8.54886,0.516468 +-7.61124,1,0.883328,1,1,0,8.36372,0.432286 +-8.41767,0.786534,0.883328,1,1,0,8.54092,0.50819 +-7.28301,1,0.883328,2,7,0,8.1971,0.137558 +-7.02591,0.915334,0.883328,1,3,0,8.21908,0.349886 +-7.33562,0.972381,0.883328,2,3,0,7.36309,0.39857 +-7.33562,0.827583,0.883328,1,1,0,7.86154,0.39857 +-7.36934,0.990338,0.883328,1,1,0,7.52118,0.403045 +-6.97242,1,0.883328,1,1,0,7.27021,0.33924 +-6.75168,0.999268,0.883328,1,3,0,6.95289,0.260791 +-6.87025,0.935779,0.883328,2,3,0,7.15377,0.191838 +-6.81223,0.913376,0.883328,2,3,0,7.76805,0.296468 +-7.01846,0.970309,0.883328,2,7,0,7.02483,0.16635 +-7.01846,0.861679,0.883328,1,3,0,8.14524,0.16635 +-6.79841,0.921428,0.883328,2,3,0,7.78752,0.211784 +-6.80049,0.999586,0.883328,1,1,0,6.81039,0.211038 +-6.83615,0.976328,0.883328,1,3,0,7.00062,0.30475 +-6.77409,1,0.883328,1,1,0,6.82097,0.279237 +-6.8983,0.712346,0.883328,2,3,0,8.83802,0.185977 +-7.9506,0.855537,0.883328,1,3,0,8.1527,0.0954369 +-6.98816,0.969919,0.883328,1,3,0,7.91002,0.170691 +-7.30216,0.889251,0.883328,1,3,0,8.11258,0.39401 +-7.91257,0.83662,0.883328,1,1,0,7.97733,0.463647 +-6.78104,0.921068,0.883328,2,3,0,8.47267,0.282998 +-6.84046,0.968155,0.883328,1,3,0,6.98565,0.198984 +-6.7997,1,0.883328,2,3,0,6.83519,0.211319 +-9.03931,0.770139,0.883328,2,3,0,9.54475,0.554041 +-7.49029,1,0.883328,1,1,0,8.62047,0.41823 +-6.9314,1,0.883328,2,7,0,7.36835,0.179834 +-6.74926,0.997529,0.883328,1,3,0,6.94984,0.243814 +-8.02779,0.704089,0.883328,1,3,0,8.78731,0.0919433 +-8.82131,0.931387,0.883328,1,1,0,8.82602,0.064555 +-7.03229,0.976168,0.883328,2,7,0,8.50809,0.351089 +-7.36768,0.970126,0.883328,2,3,0,7.39432,0.402826 +-6.91422,1,0.883328,2,7,0,7.27,0.182932 +-7.29431,0.946835,0.883328,2,3,0,7.50105,0.136572 +-8.78256,0.839364,0.883328,1,3,0,8.95363,0.0656176 +-6.84716,0.961125,0.883328,1,3,0,9.22626,0.197275 +-6.97766,0.976385,0.883328,1,1,0,6.97817,0.172275 +-7.25269,0.95652,0.883328,1,1,0,7.25318,0.140279 +-7.54585,0.960795,0.883328,1,1,0,7.56264,0.1177 +-9.31276,0.881185,0.883328,2,7,0,9.33881,0.571951 +-8.38897,1,0.883328,1,1,0,9.35763,0.505865 +-8.34592,1,0.883328,1,1,0,8.82565,0.502335 +-7.02966,1,0.883328,2,3,0,8.08054,0.164822 +-6.9454,1,0.883328,1,1,0,7.03192,0.177435 +-9.17874,0.683327,0.883328,1,3,0,10.0416,0.0557088 +-6.82477,0.975445,0.883328,1,3,0,9.93356,0.203284 +-6.77811,1,0.883328,2,3,0,6.81549,0.220205 +-6.99431,0.939519,0.883328,1,3,0,7.18748,0.343724 +-7.00905,0.888649,0.883328,2,3,0,7.73919,0.34664 +-6.75738,1,0.883328,1,3,0,6.97371,0.267358 +-9.94637,0.597892,0.883328,2,7,0,9.97533,0.0412037 +-9.26157,1,0.883328,1,1,0,9.96867,0.0538776 +-8.82721,1,0.883328,2,3,0,9.33101,0.0643952 +-8.32587,1,0.883328,1,1,0,8.84179,0.0800632 +-8.71227,0.989522,0.883328,2,3,0,8.79349,0.0676033 +-6.80347,0.920603,0.883328,1,3,0,10.1693,0.293078 +-6.81728,0.971093,0.883328,2,7,0,6.98397,0.205509 +-6.86187,0.991464,0.883328,1,1,0,6.86656,0.193736 +-7.40323,0.932768,0.883328,2,3,0,7.56082,0.127744 +-7.04828,1,0.883328,1,1,0,7.34922,0.162365 +-6.76151,1,0.883328,2,3,0,7.03965,0.229856 +-6.74807,0.999809,0.883328,1,3,0,6.76236,0.248763 +-7.15344,0.901679,0.883328,1,3,0,7.34294,0.150063 +-6.93359,0.9369,0.883328,1,3,0,7.8072,0.330759 +-6.74844,0.998221,0.883328,1,3,0,6.9322,0.253638 +-6.94927,0.948207,0.883328,1,3,0,7.04972,0.176791 +-9.09873,0.773868,0.883328,2,3,0,9.18766,0.0575505 +-8.50605,1,0.883328,1,1,0,9.10143,0.073901 +-7.94109,1,0.883328,1,1,0,8.47615,0.0958813 +-8.29026,0.966477,0.883328,1,1,0,8.3532,0.0813638 +-9.10784,0.978905,0.883328,2,3,0,9.11714,0.0573371 +-6.96867,0.985606,0.883328,2,3,0,9.50159,0.173666 +-6.78482,0.996865,0.883328,1,3,0,6.94364,0.217156 +-6.79463,0.987453,0.883328,2,3,0,6.91517,0.289392 +-7.00938,0.912393,0.883328,1,3,0,7.33055,0.167618 +-6.88996,0.902994,0.883328,2,3,0,8.23883,0.32018 +-6.76774,0.98843,0.883328,2,3,0,6.9742,0.275356 +-7.29808,0.88368,0.883328,2,3,0,7.64597,0.393445 +-8.76913,0.648344,0.883328,1,1,0,8.78434,0.535088 +-8.10799,1,0.883328,2,7,0,9.01474,0.0885101 +-7.56408,1,0.883328,1,1,0,8.0547,0.116518 +-7.72957,0.993489,0.883328,2,3,0,7.80416,0.106652 +-6.84842,0.978113,0.883328,1,3,0,7.74629,0.19696 +-6.75123,0.994976,0.883328,1,3,0,6.89222,0.260098 +-6.88865,0.97146,0.883328,1,3,0,6.90772,0.31984 +-6.89691,0.935266,0.883328,2,3,0,7.364,0.186252 +-7.2904,0.945835,0.883328,2,3,0,7.48244,0.136912 +-6.94584,0.925498,0.883328,1,3,0,8.07142,0.333515 +-8.02262,0.552518,0.883328,1,3,0,9.87409,0.0921711 +-8.56237,0.98385,0.883328,2,3,0,8.5941,0.0721067 +-6.99546,0.95466,0.883328,1,3,0,8.6764,0.169616 +-6.7566,1,0.883328,2,3,0,6.98595,0.233866 +-6.74877,0.994387,0.883328,2,3,0,6.79743,0.254846 +-6.7492,0.952281,0.883328,2,3,0,7.08254,0.243965 +-6.7515,0.990236,0.883328,2,3,0,6.81859,0.260523 +-7.40277,0.795499,0.883328,2,3,0,8.08608,0.127779 +-6.78979,0.95415,0.883328,1,3,0,7.85454,0.28723 +-6.74858,0.999586,0.883328,2,3,0,6.79303,0.254207 +-6.74858,0.430207,0.883328,1,3,0,10.9656,0.254207 +-6.82318,0.980115,0.883328,1,3,0,6.86186,0.203744 +-6.75531,0.84598,0.883328,2,3,0,8.29355,0.265287 +-7.39104,0.824005,0.883328,1,3,0,7.84602,0.128677 +-7.1631,1,0.883328,1,1,0,7.37616,0.149044 +-6.80314,0.921503,0.883328,2,3,0,8.00784,0.210104 +-6.93416,0.976626,0.883328,2,3,0,7.03046,0.179352 +-8.38959,0.80499,0.883328,1,3,0,8.75278,0.0778067 +-6.76281,0.910147,0.883328,2,7,0,9.33874,0.271894 +-7.0179,0.96469,0.883328,2,3,0,7.01879,0.166427 +-6.76318,0.983929,0.883328,1,3,0,7.17587,0.272175 +-6.92409,0.928824,0.883328,2,3,0,7.20236,0.18113 +-7.29969,0.967428,0.883328,2,7,0,7.30713,0.393668 +-6.80561,0.943307,0.883328,2,3,0,7.7003,0.293932 +-6.74858,0.999459,0.883328,1,3,0,6.80379,0.254186 +-6.77885,0.829059,0.883328,2,3,0,8.03205,0.219851 +-6.78915,0.65412,0.883328,2,3,0,10.2069,0.215343 +-6.77142,0.992508,0.883328,1,3,0,6.86303,0.277669 +-7.48104,0.89495,0.883328,2,3,0,7.48179,0.12208 +-6.75196,0.989356,0.883328,1,3,0,7.63707,0.239023 +-6.77686,0.995535,0.883328,2,3,0,6.78972,0.220811 +-6.81542,0.992219,0.883328,1,1,0,6.8158,0.206082 +-6.7988,0.994091,0.883328,2,3,0,6.88829,0.211645 +-6.77741,0.929415,0.883328,2,3,0,7.41901,0.28109 +-6.85823,0.980205,0.883328,1,1,0,6.85823,0.311501 +-6.81626,1,0.883328,1,1,0,6.85632,0.297955 +-7.51926,0.745614,0.883328,1,3,0,8.3757,0.119462 +-7.30473,0.839109,0.883328,2,7,0,9.17371,0.394364 +-6.98439,1,0.883328,2,7,0,7.26046,0.171256 +-6.82551,0.967917,0.883328,1,3,0,7.29469,0.301219 +-7.0129,0.922654,0.883328,2,3,0,7.36162,0.34739 +-6.75156,0.999151,0.883328,1,3,0,6.99123,0.260609 +-6.82767,0.984713,0.883328,1,3,0,6.83572,0.301954 +-7.57631,0.722995,0.883328,1,3,0,8.53064,0.115737 +-6.94814,0.917735,0.883328,1,3,0,8.57926,0.334024 +-7.27593,0.913942,0.883328,1,1,0,7.28661,0.390345 +-6.75169,0.984504,0.883328,2,3,0,7.38751,0.26081 +-6.75169,0.926222,0.883328,1,3,0,7.07931,0.26081 +-6.91358,0.953538,0.883328,1,3,0,7.02133,0.183051 +-6.82789,1,0.883328,1,1,0,6.89909,0.20239 +-7.01351,0.864735,0.883328,2,3,0,7.9265,0.167037 +-6.98642,1,0.883328,2,3,0,7.04557,0.17095 +-6.90554,1,0.883328,1,1,0,6.9838,0.18457 +-7.07859,0.970521,0.883328,1,1,0,7.08021,0.158565 +-7.05823,1,0.883328,1,1,0,7.12558,0.161091 +-6.91684,1,0.883328,2,3,0,7.03883,0.182447 +-7.72815,0.894917,0.883328,1,3,0,7.82702,0.10673 +-6.74887,0.977947,0.883328,1,3,0,8.02686,0.24488 +-6.74887,0.703781,0.883328,1,3,0,8.46728,0.24488 +-6.75519,0.997943,0.883328,1,3,0,6.76139,0.265159 +-6.75954,0.998979,0.883328,1,1,0,6.76033,0.269284 +-6.83937,0.981419,0.883328,2,3,0,6.90345,0.305782 +-8.00831,0.611859,0.883328,1,3,0,9.4754,0.0928064 +-6.78868,0.950849,0.883328,2,3,0,8.83352,0.215535 +-6.75851,0.95754,0.883328,2,3,0,7.11259,0.232195 +-6.75598,1,0.883328,1,1,0,6.7591,0.234453 +-6.75484,0.997848,0.883328,1,3,0,6.7749,0.264786 +-6.78553,0.988074,0.883328,1,3,0,6.82759,0.216851 +-6.77868,0.951404,0.883328,2,3,0,7.19922,0.28177 +-6.75072,0.999952,0.883328,1,3,0,6.77398,0.25925 +-6.8048,0.989177,0.883328,1,3,0,6.81047,0.293609 +-7.11874,0.873317,0.883328,1,3,0,7.56331,0.153864 +-7.64236,0.882709,0.883328,2,3,0,8.8951,0.435747 +-7.28094,0.707862,0.883328,1,3,0,9.41632,0.13774 +-10.0942,0.865316,0.883328,2,3,0,10.1484,0.617432 +-7.64168,1,0.883328,1,1,0,9.39142,0.435672 +-7.64168,0.626319,0.883328,1,3,0,10.464,0.435672 +-10.0654,0.764093,0.883328,2,3,0,10.0923,0.615883 +-8.53604,1,0.883328,1,1,0,9.89817,0.517565 +-7.20197,1,0.883328,1,1,0,8.15419,0.37953 +-6.86116,0.927252,0.883328,1,3,0,7.65932,0.193902 +-6.86702,0.998905,0.883328,1,1,0,6.88788,0.192561 +-7.1997,0.828927,0.883328,2,3,0,8.32122,0.14532 +-6.80669,0.991397,0.883328,1,3,0,7.16981,0.208897 +-6.78522,0.988568,0.883328,1,3,0,6.91986,0.285082 +-9.70995,0.607633,0.883328,2,7,0,9.74963,0.0451351 +-6.7509,0.989463,0.883328,2,7,0,9.18555,0.240595 +-6.76097,0.996192,0.883328,1,3,0,6.77559,0.270468 +-6.76097,0.863811,0.883328,1,3,0,7.45885,0.270468 +-6.75524,1,0.883328,1,1,0,6.76025,0.265218 +-6.74915,1,0.883328,2,3,0,6.75387,0.244088 +-6.89401,0.967418,0.883328,1,3,0,6.93863,0.186829 +-7.92853,0.889369,0.883328,2,3,0,8.0811,0.0964726 +-7.40563,1,0.883328,1,1,0,7.86804,0.127562 +-6.80572,0.959848,0.883328,1,3,0,7.91356,0.293972 +-6.76602,1,0.883328,2,7,0,6.79792,0.226799 +-6.7482,0.999758,0.883328,1,3,0,6.7665,0.247659 +-6.8528,0.929809,0.883328,2,3,0,7.20422,0.195885 +-6.79836,1,0.883328,1,1,0,6.84339,0.211802 +-6.7889,0.950409,0.883328,2,3,0,7.23894,0.286825 +-6.75289,0.995816,0.883328,1,3,0,6.81602,0.237805 +-6.92592,0.896197,0.883328,2,3,0,7.45595,0.180802 +-6.82256,1,0.883328,1,1,0,6.90679,0.203928 +-6.83544,0.997511,0.883328,1,1,0,6.84715,0.200312 +-7.01631,0.936435,0.883328,1,3,0,7.35663,0.348049 +-6.84029,0.954233,0.883328,2,3,0,7.36561,0.306072 +-6.84029,0.931586,0.883328,1,1,0,7.03892,0.306072 +-7.45654,0.752645,0.883328,1,3,0,8.33009,0.123812 +-7.17844,1,0.883328,1,1,0,7.42956,0.147457 +-6.94439,1,0.883328,1,1,0,7.14021,0.177605 +-8.33456,0.748538,0.883328,1,3,0,9.42898,0.501395 +-6.97487,1,0.883328,2,3,0,8.07987,0.172703 +-6.95183,1,0.883328,1,1,0,7.00289,0.176368 +-6.81519,0.965486,0.883328,2,7,0,7.21901,0.297565 +-6.83322,0.995467,0.883328,1,1,0,6.84557,0.303798 +-6.92351,0.976959,0.883328,1,1,0,6.93038,0.328426 +-6.75108,0.993111,0.883328,1,3,0,6.96387,0.240309 +-6.75111,0.999047,0.883328,1,3,0,6.75928,0.259915 +-6.97217,0.961506,0.883328,2,3,0,7.06108,0.339187 +-6.75566,1,0.883328,1,3,0,6.94339,0.26566 +-6.76361,0.998131,0.883328,1,1,0,6.76407,0.27249 +-7.27498,0.8472,0.883328,1,3,0,7.69547,0.138268 +-7.52083,0.967175,0.883328,1,1,0,7.54696,0.119358 +-7.52083,0.750471,0.883328,1,3,0,10.8012,0.119358 +-7.33043,1,0.883328,2,3,0,7.5383,0.133514 +-6.97538,0.834455,0.883328,2,3,0,10.3997,0.339857 +-6.75256,0.990806,0.883328,1,3,0,7.02922,0.238222 +-6.7955,0.995741,0.883328,2,3,0,6.79612,0.289771 +-6.79538,0.983652,0.883328,1,3,0,6.92512,0.212907 +-6.74992,0.997345,0.883328,1,3,0,6.8168,0.257752 +-6.7527,0.999103,0.883328,2,3,0,6.75759,0.262216 +-6.75109,0.999,0.883328,1,3,0,6.76197,0.240299 +-6.75346,0.864319,0.883328,2,3,0,7.83847,0.237119 +-6.98394,0.951785,0.883328,1,3,0,7.04397,0.171322 +-6.74958,0.996908,0.883328,1,3,0,7.0108,0.243063 +-6.8537,0.985239,0.883328,2,3,0,6.8707,0.195668 +-6.85107,0.973666,0.883328,1,3,0,7.12528,0.309389 +-7.16633,0.841525,0.883328,1,3,0,7.77735,0.148706 +-7.18718,0.99686,0.883328,1,1,0,7.25397,0.146571 +-7.32784,0.979803,0.883328,1,1,0,7.36494,0.133728 +-7.32663,1,0.883328,1,1,0,7.42433,0.133829 +-6.75554,1,0.883328,2,3,0,7.21142,0.265528 +-6.90515,0.953667,0.883328,1,3,0,7.02616,0.184644 +-7.5137,0.958305,0.883328,2,3,0,7.51405,0.421031 +-7.109,1,0.883328,1,1,0,7.43634,0.364707 +-6.74839,0.997192,0.883328,1,3,0,7.10471,0.253406 +-6.74809,0.969611,0.883328,2,3,0,6.95879,0.248585 +-8.48339,0.730601,0.883328,2,3,0,9.20669,0.513437 +-8.63482,1,0.883328,2,7,0,8.63529,0.0698826 +-8.05614,1,0.883328,1,1,0,8.61014,0.0907078 +-6.98718,0.986556,0.883328,2,7,0,7.8645,0.342283 +-7.25227,0.778775,0.883328,1,3,0,8.25762,0.140318 +-6.85025,0.945303,0.883328,1,3,0,7.78989,0.309142 +-6.98813,0.903419,0.883328,1,3,0,7.41826,0.170696 +-6.76357,0.984989,0.883328,1,3,0,7.13468,0.272463 +-6.80524,0.846302,0.883328,2,3,0,7.83529,0.209384 +-6.81226,0.978241,0.883328,2,3,0,7.03021,0.296481 +-6.94851,0.924735,0.883328,2,7,0,7.25875,0.176916 +-6.83041,1,0.883328,1,1,0,6.92671,0.201684 +-6.86353,0.993716,0.883328,1,1,0,6.8722,0.193355 +-6.79367,1,0.883328,1,1,0,6.84996,0.213557 +-7.29181,0.937941,0.883328,2,3,0,7.38611,0.13679 +-6.84116,0.989198,0.883328,1,3,0,7.24931,0.198803 +-7.52465,0.920348,0.883328,2,3,0,7.65899,0.119102 +-8.1183,0.934139,0.883328,1,1,0,8.12169,0.0880822 +-6.90518,0.987145,0.883328,2,7,0,7.87616,0.32402 +-6.98276,0.895572,0.883328,1,3,0,7.51359,0.1715 +-6.98276,0.846078,0.883328,1,3,0,8.285,0.1715 +-6.99587,0.997779,0.883328,1,1,0,7.03603,0.169556 +-7.11282,0.981047,0.883328,1,1,0,7.13031,0.154535 +-8.20366,0.895974,0.883328,2,3,0,8.47386,0.0846527 +-8.35533,0.985176,0.883328,2,7,0,8.36378,0.503111 +-7.07909,1,0.883328,1,1,0,7.98809,0.359572 +-7.24491,0.742148,0.883328,2,3,0,8.94053,0.140996 +-6.98555,0.923056,0.883328,1,3,0,8.07196,0.341952 +-7.07287,0.976476,0.883328,1,1,0,7.11686,0.358478 +-7.07287,0.793354,0.883328,1,1,0,7.65939,0.358478 +-6.76641,1,0.883328,1,3,0,7.01836,0.274465 +-7.11563,0.872421,0.883328,2,3,0,7.55495,0.154215 +-6.81803,0.961306,0.883328,1,3,0,7.48718,0.298595 +-6.81001,0.981977,0.883328,2,3,0,6.96648,0.295632 +-6.79013,1,0.883328,1,1,0,6.81114,0.287388 +-8.48203,0.524544,0.883328,1,3,0,10.2485,0.0746845 +-8.10643,1,0.883328,2,3,0,8.51691,0.088575 +-8.46903,0.9892,0.883328,2,3,0,8.54102,0.0751132 +-8.03772,1,0.883328,1,1,0,8.48119,0.0915074 +-7.79448,1,0.883328,1,1,0,8.08855,0.103152 +-7.79448,0.972452,0.883328,1,1,0,8.10246,0.103152 +-7.77812,0.990428,0.883328,2,7,0,7.83753,0.450213 +-7.1297,0.840982,0.883328,2,3,0,9.18166,0.152639 +-6.8173,0.995371,0.883328,2,3,0,7.18732,0.205503 +-7.19321,0.94524,0.883328,1,3,0,7.22721,0.145965 +-7.3984,0.971111,0.883328,1,1,0,7.42332,0.128112 +-7.16878,0.893222,0.883328,1,3,0,8.69916,0.374415 +-6.76767,1,0.883328,1,3,0,7.09974,0.27531 +-6.9168,0.978865,0.883328,2,7,0,6.91683,0.182454 +-8.07308,0.845484,0.883328,1,3,0,8.30471,0.0899808 +-8.27506,0.993701,0.883328,2,3,0,8.38803,0.0819278 +-8.14491,1,0.883328,1,1,0,8.40552,0.0869922 +-8.03194,1,0.883328,1,1,0,8.27203,0.0917607 +-7.83854,1,0.883328,1,1,0,8.10606,0.100879 +-7.64164,1,0.883328,1,1,0,7.8902,0.111711 +-6.76932,0.9671,0.883328,1,3,0,8.1422,0.276371 +-7.82456,0.801779,0.883328,1,3,0,7.93,0.454946 +-11.3357,0.355747,0.883328,1,1,0,11.3492,0.676765 +-6.93217,1,0.883328,2,7,0,10.2888,0.330434 +-8.01263,0.620187,0.883328,2,3,0,9.55745,0.473154 +-8.25918,0.97628,0.883328,2,3,0,8.57187,0.495069 +-7.50071,1,0.883328,2,7,0,8.2192,0.12072 +-6.87079,0.983336,0.883328,1,3,0,7.46037,0.191718 +-6.91871,0.991286,0.883328,1,1,0,6.93111,0.182104 +-6.98619,0.978324,0.883328,2,3,0,7.197,0.170985 +-7.18705,0.967939,0.883328,1,1,0,7.19234,0.146583 +-6.96154,1,0.883328,1,1,0,7.1518,0.174795 +-6.77561,0.981784,0.883328,1,3,0,7.13483,0.2801 +-6.96064,0.931283,0.883328,1,3,0,7.18878,0.174938 +-6.82891,0.880024,0.883328,2,3,0,8.42621,0.302371 +-7.29768,0.816544,0.883328,1,3,0,7.97858,0.136281 +-6.76948,0.968519,0.883328,1,3,0,7.61271,0.276474 +-6.84784,0.990161,0.883328,2,7,0,6.84896,0.197103 +-8.77697,0.677248,0.883328,1,3,0,9.59205,0.0657728 +-8.77697,0.957458,0.883328,1,1,0,9.43255,0.0657728 +-8.41742,1,0.883328,1,1,0,8.84232,0.0768483 +-8.45554,0.996787,0.883328,1,1,0,8.65575,0.0755617 +-8.87393,0.96786,0.883328,1,1,0,8.95545,0.063147 +-9.14096,0.982087,0.883328,1,1,0,9.29149,0.0565693 +-9.32877,0.988444,0.883328,1,1,0,9.52269,0.0524458 +-8.38326,1,0.883328,1,1,0,9.25977,0.0780267 +-7.9349,1,0.883328,1,1,0,8.38205,0.0961719 +-6.82782,0.991299,0.883328,2,7,0,7.70083,0.302002 +-6.84658,0.995243,0.883328,1,1,0,6.86192,0.308027 +-7.61305,0.712728,0.883328,2,7,0,8.66999,0.113443 +-6.75381,0.951309,0.883328,2,3,0,8.28938,0.23671 +-6.94229,0.961331,0.883328,1,3,0,6.98588,0.177959 +-7.62896,0.953572,0.883328,2,3,0,7.62898,0.434264 +-9.27103,0.613033,0.883328,1,1,0,9.33284,0.569293 +-8.66758,1,0.883328,2,7,0,9.81464,0.0689062 +-9.02989,0.974136,0.883328,1,1,0,9.13899,0.0591959 +-7.08223,0.942759,0.883328,1,3,0,9.242,0.158125 +-7.09298,0.99829,0.883328,1,1,0,7.15013,0.156839 +-7.32978,0.988318,0.883328,2,3,0,7.34023,0.133568 +-6.83499,0.988064,0.883328,1,3,0,7.29295,0.200434 +-6.83837,0.977353,0.883328,1,3,0,7.06877,0.305465 +-7.28171,0.819443,0.883328,1,3,0,7.97409,0.137673 +-7.44906,0.977316,0.883328,1,1,0,7.49152,0.12435 +-6.74905,0.980734,0.883328,1,3,0,7.69535,0.255698 +-6.74841,1,0.883328,1,1,0,6.74891,0.253515 +-6.75156,0.998948,0.883328,1,3,0,6.7547,0.239578 +-8.35519,0.709782,0.883328,1,3,0,8.74806,0.503099 +-7.66148,1,0.883328,2,7,0,8.39908,0.110536 +-6.87975,0.978826,0.883328,1,3,0,7.63737,0.189772 +-6.75028,0.761635,0.883328,2,3,0,9.45003,0.258467 +-7.34892,0.8781,0.883328,1,3,0,7.45367,0.400348 +-7.06117,1,0.883328,1,1,0,7.30577,0.356394 +-7.14776,0.807554,0.883328,1,3,0,8.16124,0.15067 +-7.45676,0.956366,0.883328,1,1,0,7.46381,0.123797 +-7.20175,1,0.883328,1,1,0,7.43854,0.145118 +-6.8169,0.949945,0.883328,2,7,0,7.62132,0.298186 +-6.8169,0.833629,0.883328,1,3,0,7.66412,0.298186 +-6.8169,0.816584,0.883328,1,3,0,7.78989,0.298186 +-6.76321,0.989973,0.883328,1,3,0,6.88251,0.228646 +-6.77817,0.991232,0.883328,1,3,0,6.82991,0.281496 +-6.77993,0.948705,0.883328,2,3,0,7.12394,0.219345 +-7.14606,0.935948,0.883328,1,3,0,7.20698,0.150852 +-7.08661,1,0.883328,1,1,0,7.18006,0.157598 +-6.92591,0.933736,0.883328,2,7,0,7.67535,0.328987 +-7.45112,0.734971,0.883328,2,7,0,8.55356,0.124202 +-7.24296,1,0.883328,2,3,0,7.45187,0.141177 +-7.52162,0.962427,0.883328,1,1,0,7.53962,0.119304 +-9.19003,0.88069,0.883328,2,3,0,9.53068,0.0554546 +-8.83823,1,0.883328,1,1,0,9.28837,0.0640979 +-8.01622,1,0.883328,1,1,0,8.76737,0.0924545 +-8.53555,0.984369,0.883328,2,3,0,8.5702,0.072954 +-8.57375,0.796894,0.883328,3,7,0,13.108,0.520481 +-7.2325,1,0.883328,1,1,0,8.19195,0.384087 +-7.85904,0.589424,0.883328,2,3,0,10.0746,0.458395 +-6.89129,1,0.883328,2,3,0,7.67519,0.187377 +-6.86247,0.956656,0.883328,2,7,0,7.21294,0.312722 +-6.78704,0.977921,0.883328,1,3,0,7.00711,0.21621 +-6.80841,0.992106,0.883328,2,3,0,6.87083,0.208322 +-6.765,0.891456,0.883328,2,3,0,7.79308,0.273494 +-6.82537,0.811419,0.883328,2,3,0,8.09284,0.203111 +-7.40079,0.930023,0.883328,2,3,0,7.52511,0.12793 +-7.30099,1,0.883328,1,1,0,7.44888,0.135996 +-7.2148,1,0.883328,1,1,0,7.34275,0.143844 +-7.03391,1,0.883328,1,1,0,7.19824,0.164253 +-7.20134,0.973883,0.883328,1,1,0,7.2152,0.145158 +-6.75167,0.944383,0.883328,2,3,0,7.80575,0.239427 +# +# Elapsed Time: 0.003 seconds (Warm-up) +# 0.009 seconds (Sampling) +# 0.012 seconds (Total) +# diff --git a/src/test/interface/example_output/bern2.csv b/src/test/interface/example_output/bern2.csv new file mode 100644 index 0000000000..a92c9624ac --- /dev/null +++ b/src/test/interface/example_output/bern2.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-10-17 18:13:44 UTC +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = false (Default) +# thin = 1 (Default) +# adapt +# engaged = true (Default) +# gamma = 0.05 (Default) +# delta = 0.8 (Default) +# kappa = 0.75 (Default) +# t0 = 10 (Default) +# init_buffer = 75 (Default) +# term_buffer = 50 (Default) +# window = 25 (Default) +# save_metric = false (Default) +# algorithm = hmc (Default) +# hmc +# engine = nuts (Default) +# nuts +# max_depth = 10 (Default) +# metric = diag_e (Default) +# metric_file = (Default) +# stepsize = 1 (Default) +# stepsize_jitter = 0 (Default) +# num_chains = 1 (Default) +# id = 2 +# data +# file = /Users/mitzi/.cmdstan/cmdstan-2.35.0/examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 86520 +# output +# file = /Users/mitzi/github/stan-dev/cmdstanpy/test_csv_files/bernoulli-20241017141344_2.csv +# diagnostic_file = (Default) +# refresh = 100 (Default) +# sig_figs = -1 (Default) +# profile_file = profile.csv (Default) +# save_cmdstan_config = false (Default) +# num_threads = 1 (Default) +# stanc_version = stanc3 v2.35.0 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +# Adaptation terminated +# Step size = 0.911571 +# Diagonal elements of inverse mass matrix: +# 0.568283 +-9.4699,1,0.911571,2,3,0,9.88038,0.0495852 +-8.60156,1,0.911571,1,1,0,9.43576,0.0708923 +-6.90138,0.862296,0.911571,2,7,0,9.70197,0.323078 +-7.07893,0.945255,0.911571,1,1,0,7.10214,0.359544 +-8.54466,0.605769,0.911571,1,1,0,8.5574,0.518234 +-6.76418,0.871155,0.911571,2,3,0,9.48349,0.22799 +-6.74884,0.966719,0.911571,2,3,0,6.98528,0.244954 +-7.20361,0.927301,0.911571,2,3,0,7.27293,0.144935 +-7.1124,0.971088,0.911571,2,3,0,7.66262,0.154583 +-6.7508,0.893501,0.911571,2,3,0,8.57743,0.240753 +-6.82289,0.980223,0.911571,1,3,0,6.85006,0.300313 +-7.64253,0.825605,0.911571,1,3,0,7.64649,0.435767 +-6.78465,0.988398,0.911571,1,3,0,7.70179,0.217225 +-6.74918,1,0.911571,1,3,0,6.77909,0.244013 +-7.07853,0.772008,0.911571,2,3,0,8.122,0.158572 +-6.87654,0.983311,0.911571,2,3,0,7.28121,0.19046 +-6.85124,1,0.911571,1,1,0,6.88925,0.196265 +-7.95745,0.817925,0.911571,1,3,0,8.13031,0.0951186 +-6.80063,1,0.911571,1,3,0,7.95519,0.210988 +-6.76707,0.994599,0.911571,2,3,0,6.84876,0.226148 +-6.76707,0.648581,0.911571,1,3,0,8.44205,0.226148 +-7.11187,0.911776,0.911571,1,3,0,7.24225,0.365189 +-7.15161,0.818467,0.911571,1,3,0,8.00367,0.150258 +-6.90301,1,0.911571,1,1,0,7.10256,0.185058 +-6.84735,1,0.911571,1,1,0,6.90252,0.197227 +-7.27531,0.926306,0.911571,2,3,0,7.50796,0.138239 +-6.80162,1,0.911571,2,3,0,7.15584,0.292333 +-7.19797,0.938222,0.911571,2,3,0,7.20151,0.145492 +-7.54096,0.945166,0.911571,1,1,0,7.5597,0.118021 +-6.75849,1,0.911571,2,3,0,7.4662,0.232212 +-7.42107,0.846394,0.911571,1,3,0,7.5725,0.409695 +-6.81479,0.750948,0.911571,2,3,0,8.64886,0.29742 +-6.83588,0.993737,0.911571,1,1,0,6.85124,0.304665 +-6.96315,0.987222,0.911571,2,3,0,6.97322,0.33728 +-6.96315,0.8806,0.911571,1,1,0,7.24984,0.33728 +-6.75125,0.998745,0.911571,1,3,0,6.96451,0.240043 +-7.16498,0.900016,0.911571,1,3,0,7.25144,0.373818 +-6.8815,1,0.911571,2,3,0,7.08634,0.317963 +-6.7911,1,0.911571,2,3,0,6.85759,0.214561 +-7.09071,0.966894,0.911571,2,3,0,7.1255,0.361591 +-7.23478,0.953433,0.911571,1,1,0,7.31971,0.384421 +-6.76291,0.993755,0.911571,1,3,0,7.25836,0.228855 +-6.88048,0.965814,0.911571,1,3,0,6.95128,0.31769 +-7.68466,0.770409,0.911571,1,1,0,7.68489,0.440362 +-6.7562,0.814153,0.911571,2,3,0,8.64365,0.266206 +-6.78893,0.935422,0.911571,2,3,0,7.10016,0.215433 +-7.18334,0.927384,0.911571,1,3,0,7.21548,0.146958 +-6.96422,1,0.911571,1,1,0,7.14919,0.174368 +-6.74925,0.993298,0.911571,1,3,0,6.98482,0.256232 +-6.90187,0.975135,0.911571,2,3,0,6.92278,0.185277 +-6.92577,0.962345,0.911571,1,3,0,7.23954,0.328953 +-7.21255,0.911765,0.911571,1,1,0,7.23432,0.381125 +-6.79161,1,0.911571,1,3,0,7.08667,0.288056 +-6.79161,0.876521,0.911571,1,3,0,7.19021,0.288056 +-8.12624,0.726792,0.911571,1,3,0,8.1595,0.483501 +-7.14986,1,0.911571,2,3,0,7.83454,0.371414 +-6.85938,1,0.911571,1,1,0,7.06493,0.311833 +-7.7989,0.837983,0.911571,2,3,0,7.79974,0.10292 +-6.77537,0.940972,0.911571,2,3,0,8.54056,0.279963 +-6.87804,0.928233,0.911571,2,3,0,7.18277,0.190138 +-6.74817,0.997585,0.911571,1,3,0,6.88222,0.252139 +-6.77208,0.993575,0.911571,1,3,0,6.77951,0.22327 +-6.74871,0.96095,0.911571,2,3,0,7.03976,0.245369 +-6.7482,0.99409,0.911571,2,3,0,6.78349,0.247664 +-6.7481,0.997474,0.911571,2,3,0,6.76281,0.248448 +-6.7481,0.678608,0.911571,2,3,0,8.44882,0.248448 +-6.77899,0.994133,0.911571,2,3,0,6.78979,0.281935 +-6.77899,0.760263,0.911571,1,3,0,7.89436,0.281935 +-6.90277,0.923299,0.911571,2,3,0,7.1912,0.323425 +-7.71949,0.765743,0.911571,1,1,0,7.72089,0.444086 +-7.26658,1,0.911571,1,1,0,7.67455,0.389018 +-7.69586,0.954361,0.911571,2,3,0,7.80848,0.441567 +-6.8834,1,0.911571,2,3,0,7.43231,0.318465 +-6.74848,1,0.911571,1,3,0,6.87621,0.246221 +-7.00917,0.936826,0.911571,1,3,0,7.07544,0.167648 +-8.04738,0.869256,0.911571,1,3,0,8.1124,0.0910866 +-7.51361,1,0.911571,2,3,0,7.99647,0.119843 +-9.67109,0.830305,0.911571,2,3,0,10.1099,0.0458225 +-7.10949,0.983591,0.911571,1,3,0,9.8504,0.154916 +-7.10949,0.915775,0.911571,1,1,0,7.54038,0.154916 +-9.75739,0.67738,0.911571,1,3,0,10.4213,0.0443125 +-8.97305,1,0.911571,1,1,0,9.76866,0.0605989 +-6.75414,0.973541,0.911571,2,3,0,9.48797,0.23635 +-6.75414,0.863431,0.911571,1,3,0,7.30781,0.23635 +-8.91792,0.539108,0.911571,1,3,0,10.0005,0.0619997 +-9.14687,0.982061,0.911571,1,1,0,9.35981,0.0564336 +-6.7604,0.960408,0.911571,2,3,0,10.0284,0.230685 +-6.75288,1,0.911571,1,1,0,6.75872,0.237816 +-6.93329,0.952854,0.911571,1,3,0,6.98979,0.330688 +-6.8455,1,0.911571,1,1,0,6.92229,0.307695 +-8.44123,0.491978,0.911571,1,3,0,9.9497,0.0760411 +-9.30957,0.926629,0.911571,1,1,0,9.34016,0.0528502 +-6.7493,1,0.911571,2,3,0,8.79108,0.243709 +-6.83111,0.984516,0.911571,2,3,0,6.85998,0.201493 +-7.20758,0.940839,0.911571,1,3,0,7.21865,0.144546 +-7.37852,0.971643,0.911571,1,1,0,7.42744,0.129648 +-6.75898,0.964629,0.911571,1,3,0,7.52417,0.268805 +-6.96465,0.919144,0.911571,2,3,0,7.22444,0.337601 +-6.75257,1,0.911571,1,3,0,6.91818,0.262045 +-7.42818,0.838934,0.911571,2,3,0,7.7495,0.125875 +-7.86126,0.939551,0.911571,1,1,0,7.88958,0.0997374 +-7.71688,1,0.911571,1,1,0,7.96726,0.107359 +-6.75383,0.908863,0.911571,2,3,0,8.79529,0.236693 +-7.50815,0.865424,0.911571,2,3,0,7.72427,0.120213 +-7.16431,1,0.911571,1,1,0,7.4659,0.148917 +-6.75029,0.984058,0.911571,1,3,0,7.21887,0.25849 +-7.04135,0.93165,0.911571,1,3,0,7.06704,0.352779 +-6.83282,1,0.911571,1,1,0,6.9818,0.303667 +-7.30796,0.676985,0.911571,2,3,0,8.60583,0.394809 +-7.08588,1,0.911571,2,3,0,7.30871,0.360755 +-6.95488,0.728792,0.911571,2,3,0,8.47421,0.335498 +-6.95488,0.954839,0.911571,1,1,0,7.09451,0.335498 +-7.62891,0.913954,0.911571,2,3,0,7.64017,0.434258 +-7.04645,0.863494,0.911571,1,3,0,8.39097,0.162602 +-6.81759,0.96495,0.911571,1,3,0,7.26082,0.298436 +-6.7669,1,0.911571,1,1,0,6.8035,0.274798 +-6.82063,0.924078,0.911571,2,3,0,7.16576,0.204497 +-6.75429,1,0.911571,2,3,0,6.80644,0.264164 +-6.94947,0.942979,0.911571,1,3,0,7.04894,0.176758 +-6.75251,0.890441,0.911571,2,3,0,7.80423,0.238287 +-6.77799,0.997096,0.911571,2,3,0,6.77931,0.281402 +-6.77799,0.766043,0.911571,1,3,0,7.58436,0.281402 +-6.86978,0.989574,0.911571,2,3,0,6.86982,0.191941 +-6.76993,0.943807,0.911571,2,3,0,7.27452,0.276753 +-6.7484,0.998703,0.911571,2,3,0,6.77783,0.253448 +-6.74817,0.99836,0.911571,2,3,0,6.75767,0.247878 +-7.03228,0.930163,0.911571,1,3,0,7.11122,0.16447 +-6.92163,1,0.911571,1,1,0,7.02569,0.181573 +-6.76696,0.9335,0.911571,2,3,0,7.42091,0.274837 +-6.76467,0.995459,0.911571,1,3,0,6.80212,0.227664 +-7.86576,0.764661,0.911571,1,3,0,8.09479,0.459062 +-7.15669,1,0.911571,1,1,0,7.68215,0.372505 +-6.95669,1,0.911571,2,3,0,7.12911,0.335893 +-7.00171,0.895922,0.911571,1,3,0,7.49539,0.16871 +-7.00916,0.944835,0.911571,1,3,0,7.50916,0.346662 +-6.83131,1,0.911571,1,1,0,6.96039,0.30317 +-6.79994,0.952928,0.911571,2,3,0,7.07534,0.291644 +-7.06347,0.825739,0.911571,2,3,0,7.72301,0.356807 +-6.97201,0.902071,0.911571,1,3,0,7.57796,0.173145 +-7.85046,0.884899,0.911571,1,3,0,7.89558,0.100278 +-6.79584,1,0.911571,1,3,0,7.83612,0.212733 +-6.74814,0.923373,0.911571,2,3,0,7.29532,0.24805 +-7.52194,0.878385,0.911571,2,3,0,7.59464,0.119283 +-7.77567,0.964779,0.911571,1,1,0,7.84752,0.104147 +-6.78885,0.922843,0.911571,1,3,0,8.157,0.286798 +-7.11953,0.928313,0.911571,1,3,0,7.12073,0.366467 +-7.11953,0.365331,0.911571,1,1,0,9.02732,0.366467 +-6.79703,1,0.911571,2,3,0,7.07362,0.212291 +-6.95849,0.973945,0.911571,1,3,0,6.95919,0.175285 +-6.99387,0.992865,0.911571,1,1,0,7.0317,0.169849 +-7.59498,0.952346,0.911571,2,3,0,7.60302,0.430453 +-7.55044,1,0.911571,1,1,0,7.83419,0.425346 +-7.75545,0.931077,0.911571,1,1,0,7.98841,0.447865 +-6.77833,0.996468,0.911571,1,3,0,7.77679,0.220096 +-6.94382,0.970465,0.911571,1,3,0,6.94789,0.177701 +-7.04864,0.979181,0.911571,1,1,0,7.0692,0.162318 +-7.44809,0.977061,0.911571,2,3,0,7.4503,0.12442 +-7.80239,0.764176,0.911571,2,3,0,10.3674,0.102738 +-7.61358,1,0.911571,2,3,0,7.87596,0.113411 +-6.85891,1,0.911571,2,3,0,7.41543,0.311697 +-6.96981,0.96622,0.911571,1,1,0,6.98722,0.338691 +-6.76117,0.992299,0.911571,1,3,0,7.00738,0.230105 +-6.75308,1,0.911571,1,1,0,6.75934,0.237569 +-8.7352,0.479187,0.911571,2,3,0,10.4686,0.532608 +-7.53585,1,0.911571,1,1,0,8.4525,0.423643 +-6.99839,0.883541,0.911571,1,3,0,8.17595,0.16919 +-6.97053,0.952178,0.911571,1,3,0,7.44754,0.338843 +-6.81653,1,0.911571,1,1,0,6.92787,0.298054 +-9.317,0.55041,0.911571,1,3,0,9.37524,0.572219 +-7.49237,1,0.911571,1,1,0,8.76723,0.41848 +-7.06343,1,0.911571,1,1,0,7.39888,0.356799 +-7.29399,0.975496,0.911571,2,3,0,7.36058,0.392877 +-6.84649,0.949708,0.911571,1,3,0,7.55535,0.197441 +-6.96318,0.975056,0.911571,1,1,0,6.9673,0.174532 +-8.30456,0.845669,0.911571,2,3,0,8.60262,0.0808379 +-6.90649,0.979841,0.911571,2,7,0,7.93982,0.324343 +-8.06387,0.556805,0.911571,1,3,0,9.39897,0.090375 +-7.64494,1,0.911571,1,1,0,8.05997,0.111514 +-6.94509,0.98442,0.911571,1,3,0,7.53648,0.177487 +-7.07279,0.935053,0.911571,1,3,0,7.51208,0.358464 +-6.82291,1,0.911571,2,3,0,7.01514,0.203823 +-6.82244,1,0.911571,1,1,0,6.8407,0.203961 +-8.94779,0.615452,0.911571,1,3,0,9.68299,0.0612357 +-8.7825,1,0.911571,1,1,0,9.1589,0.0656191 +-9.75057,0.929194,0.911571,1,1,0,9.78119,0.0444296 +-8.6628,1,0.911571,1,1,0,9.67905,0.0690477 +-8.32149,1,0.911571,1,1,0,8.75941,0.0802215 +-7.00316,0.980554,0.911571,1,3,0,8.22442,0.168502 +-7.0881,0.983687,0.911571,1,1,0,7.1228,0.157419 +-6.80472,0.943132,0.911571,2,3,0,7.59595,0.293579 +-7.65702,0.856035,0.911571,2,3,0,7.66589,0.110798 +-7.99099,0.957205,0.911571,1,1,0,8.05993,0.0935843 +-8.61835,0.934125,0.911571,1,1,0,8.66015,0.07038 +-7.12207,0.994311,0.911571,2,3,0,8.73637,0.153489 +-6.90703,0.981567,0.911571,2,3,0,7.3584,0.184284 +-6.79306,0.953063,0.911571,2,3,0,7.27327,0.288704 +-7.50561,0.780696,0.911571,1,3,0,8.05429,0.120386 +-7.89811,0.946757,0.911571,1,1,0,7.94012,0.0979284 +-7.30096,1,0.911571,2,3,0,7.81171,0.135999 +-7.7554,0.977575,0.911571,2,3,0,7.77033,0.105236 +-6.76085,0.986008,0.911571,1,3,0,7.79792,0.230346 +-6.75246,0.928466,0.911571,2,3,0,7.20184,0.238344 +-7.30612,0.913673,0.911571,2,3,0,7.3966,0.135557 +-6.75081,0.895953,0.911571,2,3,0,8.31545,0.24074 +-6.76491,0.99611,0.911571,2,3,0,6.77925,0.22751 +-6.76647,0.995715,0.911571,2,3,0,6.80428,0.226519 +-6.74864,1,0.911571,1,3,0,6.76348,0.24562 +-7.05742,0.924766,0.911571,1,3,0,7.11274,0.355718 +-6.75939,1,0.911571,1,3,0,6.98265,0.269153 +-7.24024,0.891419,0.911571,1,3,0,7.26355,0.385221 +-6.81156,1,0.911571,1,3,0,7.10772,0.296219 +-6.76169,1,0.911571,1,1,0,6.79738,0.271037 +-6.74833,1,0.911571,1,3,0,6.75924,0.253133 +-7.19693,0.886249,0.911571,1,3,0,7.35945,0.145595 +-6.95716,1,0.911571,1,1,0,7.15615,0.175499 +-7.22046,0.912026,0.911571,1,3,0,7.72823,0.382306 +-7.22046,0.541798,0.911571,1,1,0,8.40318,0.382306 +-6.91759,1,0.911571,1,1,0,7.14177,0.327028 +-6.78997,0.981173,0.911571,1,3,0,7.02805,0.215012 +-6.89158,0.97679,0.911571,1,1,0,6.8916,0.187319 +-6.76006,1,0.911571,2,3,0,6.8623,0.269721 +-6.86116,0.886064,0.911571,2,3,0,7.36654,0.193901 +-6.92957,0.985325,0.911571,1,1,0,6.94179,0.180156 +-6.79793,0.952387,0.911571,2,3,0,7.31092,0.290804 +-7.87971,0.686208,0.911571,1,3,0,8.71942,0.0988252 +-8.78151,0.904731,0.911571,1,1,0,8.78781,0.0656467 +-7.74063,0.885345,0.911571,2,3,0,11.378,0.106042 +-8.50016,0.913085,0.911571,1,1,0,8.51178,0.0740922 +-6.77777,1,0.911571,2,3,0,8.09599,0.281284 +-8.12005,0.725079,0.911571,1,3,0,8.16667,0.482948 +-8.10387,1,0.911571,1,1,0,8.5675,0.481498 +-8.11924,0.994576,0.911571,1,1,0,8.57253,0.482876 +-7.01413,1,0.911571,2,3,0,7.95634,0.166951 +-7.01413,0.721154,0.911571,1,3,0,9.18254,0.166951 +-6.76988,0.928448,0.911571,2,3,0,7.59275,0.276724 +-6.76132,0.991859,0.911571,2,3,0,6.81986,0.270748 +-6.74931,1,0.911571,2,3,0,6.7592,0.243696 +-6.86323,0.970397,0.911571,1,3,0,6.89304,0.312938 +-6.77954,1,0.911571,2,3,0,6.84175,0.219523 +-6.75372,1,0.911571,2,3,0,6.77307,0.263498 +-6.84857,0.9668,0.911571,2,3,0,6.95189,0.308634 +-6.75348,1,0.911571,1,3,0,6.82521,0.263204 +-7.12114,0.872849,0.911571,2,3,0,7.51305,0.366735 +-6.88706,1,0.911571,1,1,0,7.06234,0.319428 +-8.23689,0.726401,0.911571,1,3,0,8.23859,0.493167 +-6.78347,0.660335,0.911571,2,3,0,10.0101,0.284223 +-7.143,0.881174,0.911571,1,3,0,7.43125,0.151183 +-7.143,0.839971,0.911571,1,3,0,8.39901,0.151183 +-6.80117,0.997371,0.911571,1,3,0,7.08341,0.210796 +-8.60226,0.661978,0.911571,1,3,0,9.19108,0.0708708 +-8.7184,0.996486,0.911571,2,3,0,8.94614,0.067427 +-8.26183,0.866905,0.911571,2,3,0,11.8456,0.0824235 +-7.74757,1,0.911571,1,1,0,8.24148,0.105662 +-6.89835,0.991905,0.911571,2,3,0,7.84883,0.185967 +-6.91334,0.964849,0.911571,1,3,0,7.21616,0.326009 +-6.84255,1,0.911571,1,1,0,6.90862,0.306782 +-7.11166,0.761573,0.911571,2,3,0,8.09191,0.365154 +-7.00657,1,0.911571,1,1,0,7.14028,0.346155 +-7.05139,0.985654,0.911571,1,1,0,7.12254,0.354624 +-6.82373,1,0.911571,2,3,0,6.98397,0.300606 +-6.89577,0.978423,0.911571,1,1,0,6.90739,0.321668 +-6.79369,1,0.911571,2,3,0,6.86896,0.213551 +-6.8561,0.985628,0.911571,1,1,0,6.85797,0.195091 +-6.75136,0.99509,0.911571,1,3,0,6.87642,0.260301 +-6.84156,0.986099,0.911571,2,3,0,6.85024,0.1987 +-6.75373,1,0.911571,2,3,0,6.82418,0.263511 +-8.54708,0.652237,0.911571,1,3,0,8.67019,0.518422 +-7.03134,1,0.911571,2,3,0,8.0372,0.350911 +-7.03134,0.74832,0.911571,1,3,0,8.05627,0.350911 +-7.03134,0.899152,0.911571,1,3,0,7.51067,0.350911 +-6.76849,1,0.911571,1,3,0,6.95827,0.27584 +-6.96083,0.908198,0.911571,2,3,0,7.27706,0.336783 +-6.90576,1,0.911571,2,3,0,6.98134,0.324164 +-6.74861,1,0.911571,1,3,0,6.89725,0.245744 +-6.87091,0.968773,0.911571,1,3,0,6.89822,0.315092 +-7.4284,0.926477,0.911571,2,3,0,7.4301,0.410618 +-7.07219,1,0.911571,1,1,0,7.36749,0.358358 +-6.92638,1,0.911571,1,1,0,7.05898,0.329096 +-7.37481,0.946621,0.911571,2,3,0,7.38837,0.403759 +-7.37481,0.655456,0.911571,1,3,0,8.78069,0.403759 +-7.37481,0.542465,0.911571,1,1,0,8.57602,0.403759 +-6.75716,1,0.911571,1,3,0,7.2295,0.267144 +-8.98406,0.590307,0.911571,1,3,0,9.12141,0.550274 +-8.98406,0.302628,0.911571,1,1,0,11.7869,0.550274 +-7.76472,1,0.911571,1,1,0,8.76205,0.448827 +-7.93822,0.940831,0.911571,1,1,0,8.25001,0.466122 +-11.4391,0.298491,0.911571,1,1,0,11.5522,0.681145 +-9.13087,1,0.911571,1,1,0,11.1943,0.560172 +-8.81407,1,0.911571,1,1,0,9.68159,0.538336 +-8.26243,1,0.911571,1,1,0,9.05908,0.495345 +-10.7818,0.418404,0.911571,1,1,0,11.0387,0.651937 +-8.18937,1,0.911571,2,3,0,10.1153,0.489063 +-7.07546,0.504952,0.911571,2,3,0,11.3124,0.358934 +-7.21956,0.953551,0.911571,1,1,0,7.29953,0.382171 +-7.21956,0.409704,0.911571,1,1,0,8.90624,0.382171 +-6.9357,1,0.911571,2,3,0,7.15243,0.331239 +-7.08901,0.952152,0.911571,1,1,0,7.12427,0.361298 +-7.25502,0.946475,0.911571,1,1,0,7.33678,0.387363 +-6.82935,0.957763,0.911571,1,3,0,7.47271,0.201981 +-6.78134,0.987982,0.911571,1,3,0,6.91189,0.283151 +-6.82894,0.936248,0.911571,2,3,0,7.11653,0.202096 +-6.86409,0.992121,0.911571,1,1,0,6.87575,0.193225 +-7.38399,0.915695,0.911571,2,3,0,7.63773,0.129222 +-7.19733,1,0.911571,1,1,0,7.39666,0.145556 +-6.75193,0.980541,0.911571,1,3,0,7.26829,0.261164 +-7.08593,0.922425,0.911571,1,3,0,7.11106,0.360765 +-6.90341,1,0.911571,2,3,0,7.05135,0.323584 +-6.74987,0.985688,0.911571,2,3,0,6.98753,0.257643 +-6.74987,0.968159,0.911571,1,3,0,6.8584,0.257643 +-6.75414,0.994285,0.911571,2,3,0,6.78282,0.236347 +-6.90671,0.966904,0.911571,1,3,0,6.92416,0.184345 +-7.71076,0.816328,0.911571,1,3,0,8.24685,0.443159 +-9.97929,0.451066,0.911571,1,1,0,10.1036,0.611204 +-7.65563,1,0.911571,1,1,0,9.27137,0.437206 +-6.87115,1,0.911571,2,3,0,7.58427,0.191637 +-6.75032,0.995269,0.911571,1,3,0,6.88877,0.25853 +-6.85169,0.901871,0.911571,2,3,0,7.33134,0.196154 +-8.04128,0.803457,0.911571,1,3,0,8.24369,0.0913521 +-9.05588,0.967084,0.911571,2,3,0,9.06,0.058568 +-9.49067,0.968908,0.911571,1,1,0,9.6471,0.0491801 +-6.90395,0.953681,0.911571,2,7,0,8.84414,0.323716 +-6.92972,0.997334,0.911571,2,3,0,6.97136,0.329869 +-6.85508,0.959003,0.911571,1,3,0,7.17776,0.195336 +-6.7483,0.9978,0.911571,1,3,0,6.8597,0.252933 +-6.75273,0.998785,0.911571,2,3,0,6.75627,0.26226 +-6.77385,0.991014,0.911571,2,3,0,6.80726,0.279103 +-6.84821,0.947521,0.911571,2,3,0,7.07267,0.197011 +-7.48433,0.846077,0.911571,1,3,0,7.86229,0.41751 +-6.74805,1,0.911571,1,3,0,7.37269,0.249018 +-7.39301,0.843498,0.911571,1,3,0,7.62298,0.128525 +-7.22145,1,0.911571,2,3,0,7.41517,0.143204 +-6.96757,1,0.911571,1,1,0,7.17824,0.173838 +-6.96757,0.750731,0.911571,1,3,0,8.7644,0.173838 +-6.7684,0.876628,0.911571,2,3,0,7.96681,0.225351 +-6.83858,0.988085,0.911571,1,3,0,6.83872,0.199477 +-6.76224,1,0.911571,2,3,0,6.81953,0.271459 +-6.76408,0.999481,0.911571,1,1,0,6.76762,0.272838 +-6.75861,1,0.911571,2,3,0,6.76448,0.268477 +-6.89781,0.955985,0.911571,1,3,0,6.98823,0.186074 +-7.90446,0.851086,0.911571,1,3,0,8.0105,0.0976217 +-8.06848,0.980394,0.911571,1,1,0,8.20977,0.0901775 +-7.27682,0.963294,0.911571,1,3,0,7.95005,0.138105 +-7.86172,0.914346,0.911571,1,1,0,7.8651,0.0997146 +-6.93456,0.879233,0.911571,2,7,0,8.63482,0.33098 +-6.78359,1,0.911571,1,1,0,6.88978,0.284282 +-8.2201,0.758947,0.911571,2,3,0,8.23513,0.084014 +-8.24258,0.997564,0.911571,1,1,0,8.46807,0.0831521 +-7.96129,1,0.911571,2,3,0,8.32348,0.0949412 +-7.90959,1,0.911571,1,1,0,8.13407,0.097375 +-7.77321,0.965029,0.911571,2,3,0,8.79958,0.104278 +-6.82209,1,0.911571,1,3,0,7.71758,0.204065 +-6.7563,0.969509,0.911571,2,3,0,7.06575,0.266306 +-6.80312,0.956334,0.911571,2,3,0,7.00408,0.210113 +-6.76943,0.98792,0.911571,2,3,0,6.89314,0.276437 +-6.909,0.970242,0.911571,1,3,0,6.90937,0.324958 +-7.43785,0.842363,0.911571,1,1,0,7.4453,0.4118 +-6.85625,1,0.911571,1,1,0,7.25269,0.310922 +-8.10291,0.782139,0.911571,2,3,0,8.10392,0.0887221 +-8.38167,0.970148,0.911571,1,1,0,8.50971,0.0780821 +-7.69384,1,0.911571,2,3,0,8.31295,0.108661 +-7.16456,1,0.911571,1,1,0,7.60867,0.148891 +-7.14014,1,0.911571,1,1,0,7.23511,0.151493 +-7.14014,0.872211,0.911571,1,3,0,8.00607,0.151493 +-8.36841,0.916125,0.911571,2,3,0,8.42361,0.504185 +-7.07397,1,0.911571,1,1,0,7.94266,0.358673 +-6.78669,0.979079,0.911571,1,3,0,7.18142,0.216357 +-6.74911,0.949795,0.911571,2,3,0,7.14916,0.244199 +-6.8733,0.9769,0.911571,2,3,0,6.91878,0.31575 +-6.86215,1,0.911571,1,1,0,6.90115,0.312631 +-6.92499,0.980819,0.911571,1,1,0,6.94852,0.328771 +-6.90231,0.939095,0.911571,1,3,0,7.26366,0.185192 +-6.81617,1,0.911571,1,1,0,6.88585,0.205848 +-6.7483,0.941448,0.911571,2,3,0,7.27178,0.247047 +-6.74872,0.999891,0.911571,1,1,0,6.74873,0.245362 +-6.75144,0.999491,0.911571,1,3,0,6.75144,0.239768 +-8.28308,0.661923,0.911571,1,3,0,8.9429,0.0816296 +-6.93947,0.857729,0.911571,1,3,0,9.28725,0.332092 +-6.9906,0.983941,0.911571,1,1,0,7.03943,0.342977 +-7.22216,0.927223,0.911571,1,1,0,7.26632,0.382559 +-6.97539,1,0.911571,1,1,0,7.18021,0.339859 +-6.859,1,0.911571,1,1,0,6.95623,0.311723 +-7.26767,0.835857,0.911571,1,3,0,7.81273,0.138921 +-6.94945,1,0.911571,1,1,0,7.20715,0.176761 +-6.89905,1,0.911571,1,1,0,6.96153,0.185829 +-6.84955,1,0.911571,1,1,0,6.90138,0.196679 +-8.41471,0.696221,0.911571,1,3,0,8.94565,0.507952 +-7.59254,1,0.911571,1,1,0,8.31048,0.430177 +-7.15455,1,0.911571,2,3,0,7.52056,0.372164 +-6.91066,1,0.911571,1,1,0,7.09728,0.325362 +-6.75379,1,0.911571,2,3,0,6.91067,0.236733 +-6.83708,0.982455,0.911571,1,3,0,6.84294,0.199873 +-7.05545,0.965228,0.911571,1,3,0,7.05554,0.161445 +-7.05545,0.850366,0.911571,1,3,0,8.18917,0.161445 +-6.9868,1,0.911571,1,1,0,7.07729,0.170894 +-7.00338,0.996696,0.911571,1,1,0,7.05178,0.168471 +-7.14801,0.921503,0.911571,1,3,0,7.70596,0.371119 +-7.65888,0.840835,0.911571,1,1,0,7.72777,0.437562 +-7.37647,1,0.911571,1,1,0,7.72548,0.403976 +-6.78728,1,0.911571,1,3,0,7.20464,0.286064 +-6.97275,0.882999,0.911571,2,3,0,7.40925,0.339309 +-6.97275,0.796264,0.911571,1,3,0,7.81543,0.339309 +-7.07888,0.96644,0.911571,1,1,0,7.13076,0.359535 +-7.07888,0.882313,0.911571,1,1,0,7.38663,0.359535 +-6.7613,1,0.911571,2,3,0,7.09293,0.230009 +-6.91742,0.968536,0.911571,1,3,0,6.92814,0.18234 +-7.75089,0.885097,0.911571,2,3,0,8.04991,0.105481 +-6.77912,0.928815,0.911571,1,3,0,8.08963,0.282001 +-6.74813,0.99987,0.911571,1,3,0,6.77824,0.248178 +-7.93053,0.751284,0.911571,1,3,0,8.06731,0.465384 +-7.10992,1,0.911571,1,1,0,7.69143,0.364862 +-7.7062,0.934242,0.911571,2,3,0,7.75834,0.442673 +-7.7062,0.335419,0.911571,1,3,0,10.8293,0.442673 +-7.17858,0.791799,0.911571,1,3,0,8.79066,0.147442 +-6.83047,0.988602,0.911571,2,3,0,7.30359,0.201669 +-6.80381,0.980532,0.911571,2,3,0,6.99763,0.293215 +-6.75912,0.995242,0.911571,1,3,0,6.83466,0.23169 +-6.91561,0.957026,0.911571,1,3,0,6.98613,0.326554 +-6.83375,1,0.911571,1,1,0,6.90399,0.303973 +-8.76261,0.630095,0.911571,1,3,0,8.78996,0.534613 +-6.85225,0.992884,0.911571,1,3,0,8.91895,0.196018 +-6.87957,0.99399,0.911571,1,1,0,6.89764,0.189812 +-6.98464,0.951787,0.911571,1,3,0,7.28861,0.341766 +-7.65589,0.800147,0.911571,1,1,0,7.67309,0.437235 +-7.74702,0.968662,0.911571,1,1,0,8.03178,0.446985 +-7.21427,0.773007,0.911571,1,3,0,8.92154,0.143896 +-7.34405,0.978295,0.911571,1,1,0,7.40331,0.132396 +-7.0791,0.975289,0.911571,2,3,0,7.74048,0.158503 +-6.90061,1,0.911571,1,1,0,7.04771,0.185524 +-6.89758,1,0.911571,1,1,0,6.93379,0.186119 +-7.92526,0.904837,0.911571,2,3,0,8.10766,0.464876 +-6.75847,1,0.911571,1,3,0,7.64353,0.268349 +-7.1361,0.891025,0.911571,1,3,0,7.33982,0.151934 +-6.99479,1,0.911571,1,1,0,7.1315,0.169713 +-6.97702,1,0.911571,1,1,0,7.03735,0.172372 +-6.98591,0.998211,0.911571,1,1,0,7.03454,0.171027 +-8.17185,0.761652,0.911571,1,3,0,8.94674,0.487532 +-8.41046,0.918979,0.911571,1,1,0,8.85722,0.507608 +-6.75095,1,0.911571,1,3,0,8.15961,0.24051 +-7.05117,0.925508,0.911571,1,3,0,7.11981,0.354584 +-7.6514,0.817582,0.911571,1,1,0,7.68746,0.436742 +-7.58397,1,0.911571,1,1,0,7.89096,0.429203 +-6.76729,0.998338,0.911571,1,3,0,7.58331,0.226015 +-6.82211,0.981057,0.911571,1,3,0,6.88416,0.300043 +-8.64007,0.46261,0.911571,1,3,0,10.2499,0.0697249 +-9.10392,0.961338,0.911571,1,1,0,9.22523,0.0574288 +-6.93578,1,0.911571,1,3,0,9.2437,0.179072 +-6.7784,0.954593,0.911571,2,3,0,7.30794,0.28162 +-8.18228,0.714484,0.911571,1,3,0,8.23105,0.488445 +-7.32164,1,0.911571,1,1,0,7.98025,0.396679 +-6.7689,0.995578,0.911571,2,3,0,7.39404,0.225055 +-6.76011,0.910565,0.911571,2,3,0,7.34243,0.230908 +-7.66375,0.805968,0.911571,2,3,0,8.21439,0.438094 +-6.87361,0.937317,0.911571,1,3,0,7.9906,0.191097 +-7.7391,0.916895,0.911571,2,3,0,7.88355,0.446155 +-7.07308,0.851892,0.911571,1,3,0,8.5738,0.159239 +-7.06667,1,0.911571,1,1,0,7.1387,0.160032 +-6.80384,0.943675,0.911571,2,3,0,7.56251,0.293228 +-7.02064,0.970594,0.911571,2,3,0,7.02086,0.166049 +-6.90282,0.965961,0.911571,1,3,0,7.375,0.323436 +-6.7575,1,0.911571,1,3,0,6.86523,0.26747 +-7.28002,0.915158,0.911571,2,3,0,7.31072,0.137822 +-7.65975,0.94232,0.911571,1,1,0,7.68174,0.110637 +-7.00533,0.98048,0.911571,1,3,0,7.55049,0.168192 +-6.89157,0.968624,0.911571,1,3,0,7.3354,0.320595 +-7.39618,0.849912,0.911571,1,1,0,7.40149,0.406526 +-6.91944,1,0.911571,1,1,0,7.25245,0.327467 +-7.24958,0.642935,0.911571,2,3,0,8.87782,0.386577 +-7.01825,0.642375,0.911571,2,3,0,9.21024,0.348423 +-6.75282,0.965424,0.911571,2,3,0,7.22147,0.262377 +-7.17552,0.902835,0.911571,1,3,0,7.20588,0.375468 +-7.09828,1,0.911571,1,1,0,7.24628,0.36289 +-6.75419,1,0.911571,1,3,0,7.021,0.264057 +-7.35018,0.865789,0.911571,1,3,0,7.39052,0.400516 +-6.76248,1,0.911571,1,3,0,7.20202,0.271648 +-7.02509,0.890161,0.911571,2,3,0,7.38605,0.349731 +-7.76975,0.778997,0.911571,1,1,0,7.79291,0.449349 +-7.00393,1,0.911571,2,3,0,7.60424,0.168391 +-7.25928,0.953313,0.911571,1,1,0,7.26818,0.139678 +-7.11362,1,0.911571,2,3,0,7.27346,0.154444 +-6.87216,0.984097,0.911571,2,3,0,7.30601,0.191416 +-7.09531,0.95468,0.911571,1,1,0,7.0958,0.156564 +-7.31643,0.961456,0.911571,1,1,0,7.34043,0.134683 +-7.37846,0.989966,0.911571,1,1,0,7.47193,0.129653 +-7.09267,0.921152,0.911571,1,3,0,8.19405,0.361928 +-7.24923,0.949442,0.911571,1,1,0,7.33329,0.386527 +-7.16268,1,0.911571,1,1,0,7.3366,0.373455 +-7.95811,0.761696,0.911571,1,1,0,8.01334,0.468023 +-7.78553,0.512756,0.911571,1,3,0,10.5464,0.103623 +-7.23544,1,0.911571,2,3,0,7.70251,0.141878 +-7.06677,1,0.911571,1,1,0,7.23334,0.16002 +-6.83361,0.960291,0.911571,1,3,0,7.31835,0.303926 +-7.04652,0.936247,0.911571,1,1,0,7.05141,0.353734 +-7.5483,0.845603,0.911571,1,1,0,7.5887,0.425098 +-6.74825,0.903077,0.911571,2,3,0,8.13388,0.252663 +-7.01146,0.782501,0.911571,2,3,0,8.13273,0.167324 +-6.94294,0.957481,0.911571,1,3,0,7.4249,0.332869 +-6.75317,1,0.911571,1,3,0,6.90003,0.26283 +-7.12192,0.914938,0.911571,1,3,0,7.1472,0.366864 +-7.02237,1,0.911571,1,1,0,7.15801,0.349213 +-6.9714,0.743849,0.911571,2,3,0,8.33486,0.339025 +-6.91562,1,0.911571,1,1,0,6.99457,0.326556 +-6.92822,0.996071,0.911571,1,1,0,6.97575,0.329524 +-6.76981,1,0.911571,1,3,0,6.88251,0.27668 +-6.75596,1,0.911571,2,3,0,6.76643,0.265965 +-8.47268,0.663752,0.911571,1,3,0,8.58216,0.512589 +-6.76834,1,0.911571,1,3,0,8.33185,0.225387 +-6.75858,0.995975,0.911571,2,3,0,6.7984,0.268454 +-7.423,0.741805,0.911571,2,3,0,8.28621,0.409939 +-6.78346,0.983232,0.911571,1,3,0,7.50106,0.217746 +-6.74819,1,0.911571,1,3,0,6.7804,0.247688 +-6.8733,0.851193,0.911571,2,3,0,7.60864,0.191164 +-8.3544,0.761909,0.911571,1,3,0,8.65025,0.0790417 +-6.82803,0.870749,0.911571,1,3,0,9.11746,0.302074 +-6.77577,1,0.911571,1,1,0,6.81465,0.280188 +-6.77577,0.830753,0.911571,1,3,0,7.34028,0.280188 +-7.89255,0.692597,0.911571,1,3,0,8.64638,0.0981981 +-7.40181,1,0.911571,1,1,0,7.84014,0.127852 +-6.76087,0.999487,0.911571,1,3,0,7.3876,0.230325 +-6.76021,1,0.911571,1,1,0,6.76367,0.230827 +-6.88163,0.97576,0.911571,1,3,0,6.88818,0.189375 +-8.34959,0.826146,0.911571,2,3,0,8.57773,0.0792128 +-8.19545,1,0.911571,1,1,0,8.50886,0.0849741 +-7.42985,1,0.911571,1,1,0,8.08998,0.125752 +-6.90858,0.957116,0.911571,1,3,0,7.95771,0.324855 +-7.12816,0.707468,0.911571,2,3,0,8.45396,0.367893 +-7.62087,0.846474,0.911571,1,1,0,7.68516,0.433364 +-7.25016,1,0.911571,2,3,0,7.60688,0.386661 +-8.09391,0.747206,0.911571,1,1,0,8.17089,0.480602 +-7.17688,1,0.911571,1,1,0,7.83167,0.37568 +-6.99898,1,0.911571,1,1,0,7.17084,0.344657 +-6.75827,0.959892,0.911571,2,3,0,7.23723,0.268175 +-7.09552,0.923122,0.911571,1,3,0,7.1109,0.362418 +-6.77836,0.982991,0.911571,1,3,0,7.17953,0.220083 +-6.77518,1,0.911571,1,1,0,6.78365,0.221647 +-6.77954,0.998939,0.911571,1,1,0,6.78534,0.219525 +-6.79094,0.991058,0.911571,2,3,0,6.86143,0.214622 +-8.58009,0.659588,0.911571,1,3,0,8.97856,0.520968 +-7.26702,1,0.911571,2,3,0,8.2917,0.13898 +-6.78509,0.932475,0.911571,2,3,0,7.91702,0.285016 +-6.84568,0.945931,0.911571,2,3,0,7.07255,0.307751 +-6.86764,0.993359,0.911571,1,1,0,6.89205,0.314183 +-7.09669,0.930483,0.911571,1,1,0,7.1078,0.362617 +-8.53534,0.610846,0.911571,1,1,0,8.55158,0.51751 +-6.97778,1,0.911571,1,1,0,8.0109,0.340354 +-6.97727,1,0.911571,1,1,0,7.04676,0.340249 +-6.80313,0.901689,0.911571,2,3,0,7.46009,0.292943 +-7.04293,0.929595,0.911571,1,1,0,7.04321,0.353071 +-7.3923,0.730904,0.911571,1,3,0,8.37624,0.128579 +-7.03566,1,0.911571,1,1,0,7.33148,0.164019 +-6.91924,1,0.911571,1,1,0,7.02662,0.182008 +-6.87551,1,0.911571,1,1,0,6.92925,0.190682 +-6.83801,1,0.911571,1,1,0,6.88023,0.199626 +-6.88831,0.970504,0.911571,1,3,0,7.08967,0.319752 +-6.75133,0.984921,0.911571,2,3,0,6.97731,0.260257 +-6.85332,0.976366,0.911571,1,3,0,6.85922,0.310059 +-8.35645,0.698831,0.911571,1,3,0,8.36606,0.503203 +-6.97003,1,0.911571,2,3,0,7.89204,0.338738 +-6.7582,0.964684,0.911571,2,3,0,7.17989,0.268114 +-6.87783,0.982534,0.911571,2,3,0,6.88355,0.190183 +-6.8497,1,0.911571,1,1,0,6.88897,0.196643 +-7.0043,0.960664,0.911571,2,3,0,7.21624,0.168339 +-6.92493,1,0.911571,1,1,0,7.00989,0.18098 +-7.79883,0.879916,0.911571,1,3,0,7.85917,0.102924 +-6.84874,0.99786,0.911571,1,3,0,7.72508,0.196881 +-7.06773,0.779006,0.911571,2,3,0,8.53143,0.1599 +-7.60832,0.861385,0.911571,1,3,0,8.40892,0.431958 +-6.98124,0.889316,0.911571,1,3,0,8.21118,0.17173 +-6.87019,1,0.911571,1,1,0,6.96557,0.19185 +-6.81594,1,0.911571,1,1,0,6.86408,0.205919 +-6.99316,0.95986,0.911571,2,3,0,7.16362,0.169952 +-7.1104,0.977575,0.911571,1,1,0,7.13694,0.154811 +-7.07683,1,0.911571,1,1,0,7.16494,0.15878 +-7.09731,0.927798,0.911571,1,3,0,7.74876,0.362723 +-7.15797,0.980221,0.911571,1,1,0,7.25629,0.372708 +-6.74954,1,0.911571,1,3,0,7.12499,0.243147 +-6.74856,0.998702,0.911571,2,3,0,6.75769,0.254109 +-8.5141,0.72587,0.911571,2,3,0,8.55984,0.0736409 +-6.74969,1,0.911571,2,3,0,8.18223,0.242836 +-9.71784,0.372151,0.911571,1,3,0,11.6108,0.0449971 +-9.50641,1,0.911571,1,1,0,9.9629,0.0488758 +-9.51502,0.999811,0.911571,2,3,0,9.85513,0.0487104 +-7.49574,0.936909,0.911571,1,3,0,9.43929,0.121061 +-6.78754,0.942536,0.911571,1,3,0,7.77541,0.286187 +-6.86428,0.935389,0.911571,2,3,0,7.12901,0.313238 +-6.96948,0.96788,0.911571,1,1,0,6.98892,0.338622 +-6.81458,0.970632,0.911571,1,3,0,7.13952,0.206343 +-6.836,0.998365,0.911571,2,3,0,6.84724,0.200163 +-7.66154,0.861885,0.911571,1,3,0,7.75997,0.110532 +-7.13471,1,0.911571,2,3,0,7.57441,0.152087 +-6.80244,0.940733,0.911571,2,3,0,7.67648,0.292664 +-6.90541,0.989854,0.911571,2,3,0,6.90955,0.324078 +-6.89717,1,0.911571,1,1,0,6.94541,0.322021 +-7.69564,0.71448,0.911571,1,3,0,8.67207,0.108558 +-7.29338,1,0.911571,1,1,0,7.65367,0.136653 +-7.55631,0.959283,0.911571,1,1,0,7.59832,0.11702 +-6.80497,0.996697,0.911571,2,3,0,7.57052,0.209477 +-6.7737,1,0.911571,1,1,0,6.799,0.222412 +-6.77219,0.990915,0.911571,2,3,0,6.84534,0.278126 +-7.08609,0.9304,0.911571,1,3,0,7.09097,0.360791 +-7.08609,0.469141,0.911571,1,1,0,8.53276,0.360791 +-7.0506,0.864981,0.911571,1,3,0,7.76579,0.162065 +-7.53401,0.918087,0.911571,1,1,0,7.53409,0.118479 +-8.63559,0.923245,0.911571,2,7,0,8.64192,0.525193 +-7.04734,1,0.911571,1,1,0,8.10026,0.353883 +-7.22028,0.944697,0.911571,1,1,0,7.28788,0.38228 +-6.75363,1,0.911571,1,3,0,7.11782,0.263388 +-6.97959,0.923054,0.911571,2,3,0,7.2125,0.34073 +-7.91023,0.60214,0.911571,2,7,0,9.27308,0.0973443 +-8.02288,0.986394,0.911571,1,1,0,8.18126,0.0921596 +-6.76462,0.976303,0.911571,1,3,0,8.11517,0.227702 +-6.77994,0.996232,0.911571,1,1,0,6.78152,0.21934 +-7.5093,0.831355,0.911571,1,3,0,7.73896,0.420508 +-7.5093,0.632502,0.911571,1,1,0,8.47928,0.420508 +-6.74814,1,0.911571,1,3,0,7.39679,0.248101 +-6.88293,0.966224,0.911571,1,3,0,6.90795,0.31834 +-11.7182,0.308183,0.911571,2,7,0,11.8329,0.0214733 +-7.80444,0.949211,0.911571,1,3,0,12.3346,0.102631 +-6.82741,0.855662,0.911571,2,3,0,9.67823,0.301864 +-7.6556,0.82411,0.911571,1,3,0,7.65887,0.437204 +-6.798,1,0.911571,1,3,0,7.40078,0.290835 +-8.0593,0.785489,0.911571,2,3,0,8.07019,0.0905716 +-8.23784,0.980087,0.911571,1,1,0,8.39153,0.0833328 +-8.04516,1,0.911571,1,1,0,8.36384,0.0911832 +-6.89691,0.99324,0.911571,1,3,0,7.96707,0.18625 +-7.05312,0.968378,0.911571,1,1,0,7.05978,0.161742 +-7.25092,0.988141,0.911571,2,3,0,7.27291,0.140442 +-7.06246,0.929607,0.911571,1,3,0,7.95764,0.356626 +-6.74849,1,0.911571,1,3,0,7.01225,0.253827 +-6.79013,0.989669,0.911571,2,3,0,6.816,0.287388 +-6.9275,0.944041,0.911571,1,3,0,7.10363,0.180522 +-6.74811,0.906125,0.911571,2,3,0,7.6341,0.251697 +-6.76143,0.974326,0.911571,2,3,0,6.89709,0.229914 +-6.74812,1,0.911571,2,3,0,6.76064,0.25179 +-6.75279,0.998883,0.911571,2,3,0,6.75558,0.26234 +-7.41569,0.851543,0.911571,1,3,0,7.46475,0.409015 +-7.02493,1,0.911571,1,1,0,7.32777,0.3497 +-7.06247,0.995975,0.911571,2,3,0,7.14069,0.356628 +-7.06247,0.8664,0.911571,1,1,0,7.39776,0.356628 +-6.75011,1,0.911571,1,3,0,7.00297,0.258144 +-6.81725,0.984401,0.911571,1,3,0,6.8215,0.298313 +-7.57864,0.837213,0.911571,1,3,0,7.58267,0.428594 +-7.63224,0.981544,0.911571,1,1,0,7.89538,0.434628 +-7.31074,1,0.911571,1,1,0,7.6595,0.39519 +-7.10987,0.827686,0.911571,1,3,0,8.17252,0.154873 +-6.98069,1,0.911571,2,3,0,7.10714,0.171813 +-7.6372,0.908372,0.911571,1,3,0,7.64928,0.111977 +-7.59771,1,0.911571,1,1,0,7.77421,0.114391 +-6.79147,1,0.911571,1,3,0,7.55459,0.214412 +-7.12309,0.940409,0.911571,1,3,0,7.14269,0.153375 +-6.7589,0.978797,0.911571,1,3,0,7.21211,0.268734 +-6.94983,0.956887,0.911571,1,3,0,6.95556,0.334395 +-6.88838,1,0.911571,1,1,0,6.96225,0.31977 +-6.74813,1,0.911571,1,3,0,6.87669,0.248147 +-8.25897,0.696642,0.911571,1,3,0,8.42368,0.495051 +-7.70827,1,0.911571,1,1,0,8.31369,0.442894 +-7.83121,0.957827,0.911571,1,1,0,8.12993,0.455615 +-8.54493,0.301947,0.911571,1,3,0,12.2321,0.0726562 +-7.9856,1,0.911571,1,1,0,8.5365,0.0938286 +-7.47924,0.973893,0.911571,2,3,0,8.60163,0.122206 +-6.86216,0.924146,0.911571,1,3,0,7.9346,0.312633 +-6.83126,1,0.911571,2,3,0,6.87156,0.303155 +-7.10507,0.774575,0.911571,2,3,0,8.01371,0.364043 +-6.80261,0.971541,0.911571,1,3,0,7.25384,0.210289 +-6.81825,0.986963,0.911571,2,3,0,6.92962,0.205214 +-6.80627,0.989209,0.911571,2,3,0,6.93095,0.209036 +-6.76224,0.98235,0.911571,2,3,0,6.94823,0.271466 +-6.74824,0.999756,0.911571,1,3,0,6.76295,0.247423 +-6.74824,0.817853,0.911571,1,3,0,7.58297,0.247423 +-6.94627,0.951359,0.911571,1,3,0,6.99586,0.177289 +-7.25252,0.942411,0.911571,1,1,0,7.25366,0.140295 +-6.79216,0.993849,0.911571,2,3,0,7.30482,0.214144 +-7.71472,0.795408,0.911571,1,3,0,8.00656,0.44358 +-6.76612,0.954207,0.911571,2,3,0,8.04232,0.226736 +-6.99769,0.937718,0.911571,1,3,0,7.10317,0.3444 +-6.7498,0.992705,0.911571,2,3,0,7.04772,0.242605 +-6.75333,0.999695,0.911571,2,3,0,6.75338,0.237266 +-7.11451,0.941333,0.911571,2,3,0,7.19636,0.154342 +-6.75071,0.998278,0.911571,1,3,0,7.10566,0.240906 +-6.78766,0.994813,0.911571,2,3,0,6.7927,0.286244 +-6.84913,0.927656,0.911571,2,3,0,7.16633,0.196784 +-7.66805,0.867391,0.911571,1,3,0,7.75492,0.110151 +-6.84776,0.913448,0.911571,1,3,0,8.16672,0.308387 +-6.75644,0.995391,0.911571,1,3,0,6.87371,0.234021 +-7.19524,0.930469,0.911571,2,3,0,7.29159,0.145763 +-7.93801,0.946084,0.911571,2,7,0,7.93804,0.466103 +-7.29002,1,0.911571,1,1,0,7.81629,0.392323 +-9.30351,0.748601,0.911571,2,3,0,9.33996,0.571364 +-6.74998,1,0.911571,1,3,0,8.72786,0.257886 +-6.85571,0.897615,0.911571,2,3,0,7.35881,0.195185 +-7.71733,0.862086,0.911571,1,3,0,7.81098,0.107333 +-8.36507,0.923807,0.911571,1,1,0,8.38675,0.0786643 +-8.18507,1,0.911571,1,1,0,8.51203,0.0853831 +-6.74981,0.944711,0.911571,1,3,0,8.41425,0.242575 +-7.00448,0.936499,0.911571,1,3,0,7.06026,0.345744 +-7.14468,0.955432,0.911571,1,1,0,7.20245,0.370583 +-6.83178,1,0.911571,2,3,0,7.07742,0.201307 +-7.49318,0.841855,0.911571,1,3,0,7.83948,0.418577 +-7.36474,1,0.911571,1,1,0,7.62797,0.402442 +-6.90019,0.925864,0.911571,1,3,0,7.75988,0.185605 +-6.77537,1,0.911571,2,3,0,6.86792,0.279966 +-7.83988,0.775072,0.911571,1,3,0,7.87616,0.456485 +-7.51844,1,0.911571,2,3,0,7.93591,0.421592 +-7.74381,0.924602,0.911571,1,1,0,7.96316,0.446648 +-6.8236,1,0.911571,1,3,0,7.45737,0.300561 +-6.81887,0.976193,0.911571,1,3,0,6.97428,0.205025 +-6.90163,0.993873,0.911571,2,3,0,6.90516,0.185324 +-6.98229,0.983335,0.911571,1,1,0,6.99973,0.171572 +-7.36331,0.931193,0.911571,1,1,0,7.36368,0.130847 +-6.85765,0.933522,0.911571,1,3,0,7.76522,0.311333 +-7.31263,0.865481,0.911571,1,1,0,7.31456,0.39545 +-6.75588,1,0.911571,1,3,0,7.18436,0.265889 +-8.67664,0.633233,0.911571,1,3,0,8.7993,0.528275 +-7.13467,1,0.911571,2,3,0,8.16605,0.36896 +-7.06883,1,0.911571,1,1,0,7.20132,0.357762 +-7.06883,0.498621,0.911571,1,1,0,8.4049,0.357762 +-7.29783,0.926907,0.911571,1,1,0,7.36627,0.39341 +-7.68629,0.875044,0.911571,1,1,0,7.81293,0.440538 +-7.23282,1,0.911571,1,1,0,7.63083,0.384133 +-6.80473,1,0.911571,1,3,0,7.10158,0.293584 +-7.06341,0.90135,0.911571,1,3,0,7.35322,0.160439 +-6.85674,0.956532,0.911571,1,3,0,7.35619,0.311066 +-7.23811,0.952265,0.911571,2,3,0,7.24142,0.384909 +-6.75937,1,0.911571,1,3,0,7.12106,0.269135 +-6.76849,0.969273,0.911571,2,3,0,6.92485,0.225295 +-6.77691,0.997933,0.911571,1,1,0,6.78032,0.220784 +-7.5922,0.815368,0.911571,1,3,0,7.82552,0.430138 +-7.98212,0.957445,0.911571,2,3,0,8.20796,0.470297 +-8.70995,0.773012,0.911571,1,1,0,9.03416,0.530749 +-8.05253,1,0.911571,1,1,0,8.83304,0.47684 +-6.75297,1,0.911571,1,3,0,7.89323,0.23771 +-6.89861,0.97695,0.911571,2,3,0,6.93646,0.322384 +-8.78229,0.465132,0.911571,1,3,0,10.8301,0.0656251 +-6.80443,1,0.911571,2,3,0,8.50784,0.209661 +-6.75065,0.965384,0.911571,2,3,0,7.06432,0.259133 +-6.92847,0.946405,0.911571,2,3,0,7.08115,0.32958 +-8.07262,0.684304,0.911571,1,1,0,8.07319,0.478673 +-6.7933,0.996324,0.911571,1,3,0,8.10863,0.213698 +-7.03171,0.976018,0.911571,2,3,0,7.04956,0.350981 +-6.78925,1,0.911571,1,3,0,6.95878,0.286983 +-6.96573,0.976403,0.911571,2,3,0,6.96633,0.174129 +-6.87312,0.973044,0.911571,1,3,0,7.25035,0.315701 +-7.1331,0.876414,0.911571,1,3,0,7.60337,0.152263 +-7.60323,0.924022,0.911571,1,1,0,7.60611,0.114049 +-6.74818,0.972678,0.911571,1,3,0,7.69525,0.247746 +-7.078,0.919217,0.911571,1,3,0,7.17258,0.158637 +-7.752,0.946673,0.911571,2,3,0,7.7546,0.447505 +-7.64341,1,0.911571,1,1,0,7.99205,0.435864 +-7.57338,0.605941,0.911571,1,3,0,9.63024,0.115923 +-8.04346,0.979715,0.911571,2,3,0,8.07892,0.0912572 +-7.31423,1,0.911571,1,1,0,7.93551,0.134868 +-7.56511,0.961447,0.911571,1,1,0,7.61203,0.116452 +-7.07771,1,0.911571,1,1,0,7.4809,0.158672 +-6.74913,0.908632,0.911571,2,3,0,8.15194,0.255923 +-7.41413,0.789353,0.911571,2,3,0,8.06742,0.408817 +-7.35062,1,0.911571,1,1,0,7.57549,0.400575 +-7.35062,0.807654,0.911571,1,1,0,7.87666,0.400575 +-6.8101,1,0.911571,1,3,0,7.18411,0.295667 +-8.63304,0.513246,0.911571,1,3,0,10.1819,0.0699361 +-9.95608,0.901545,0.911571,1,1,0,9.95695,0.0410509 +-8.50253,0.987068,0.911571,2,3,0,10.6765,0.0740151 +-9.12979,0.982122,0.911571,2,3,0,9.20396,0.0568269 +-9.38385,0.981723,0.911571,1,1,0,9.60299,0.0513063 +-9.12514,1,0.911571,1,1,0,9.58226,0.0569345 +-10.4106,0.920196,0.911571,1,1,0,10.4189,0.0345739 +-8.9372,1,0.911571,1,1,0,10.3093,0.0615052 +-8.31267,1,0.911571,2,3,0,8.9409,0.0805418 +-9.12498,0.927232,0.911571,1,1,0,9.15735,0.0569381 +-9.2687,0.989407,0.911571,1,1,0,9.52772,0.0537234 +-8.43432,1,0.911571,1,1,0,9.22991,0.0762742 +-7.90462,1,0.911571,1,1,0,8.42614,0.0976139 +-7.19639,0.969272,0.911571,1,3,0,7.79283,0.145649 +-7.04886,1,0.911571,1,1,0,7.19885,0.16229 +-6.85906,1,0.911571,1,1,0,7.00964,0.194392 +-6.79737,0.989773,0.911571,2,3,0,6.9617,0.212167 +-7.71833,0.828476,0.911571,1,3,0,7.88992,0.107277 +-7.14961,0.979259,0.911571,2,3,0,8.10114,0.150471 +-6.85771,0.993799,0.911571,1,3,0,7.08949,0.194709 +-6.82937,1,0.911571,1,1,0,6.86435,0.201976 +-6.77458,1,0.911571,1,1,0,6.81657,0.221953 +-7.14859,0.904225,0.911571,1,3,0,7.30461,0.371211 +-8.46022,0.636771,0.911571,1,1,0,8.49002,0.5116 +-7.7663,1,0.911571,1,1,0,8.46954,0.448992 +-7.05532,1,0.911571,1,1,0,7.55851,0.355339 +-7.0665,0.996376,0.911571,1,1,0,7.15889,0.357347 +-6.86245,1,0.911571,2,3,0,7.01224,0.193603 +-6.86245,0.73739,0.911571,1,3,0,8.413,0.193603 +-7.29402,0.884767,0.911571,1,3,0,7.65851,0.392881 +-7.05449,1,0.911571,1,1,0,7.27769,0.355187 +-6.89994,0.936683,0.911571,1,3,0,7.41857,0.185654 +-6.89994,0.736937,0.911571,1,3,0,8.57931,0.185654 +-7.20259,0.756472,0.911571,2,3,0,8.87621,0.145035 +-7.88832,0.904204,0.911571,1,3,0,7.88846,0.0984038 +-8.46465,0.936272,0.911571,1,1,0,8.50768,0.0752586 +-9.64549,0.904829,0.911571,1,1,0,9.64932,0.046282 +-7.5658,0.931532,0.911571,1,3,0,9.57414,0.116408 +-7.92408,0.952398,0.911571,1,1,0,7.97848,0.0966833 +-7.22675,0.98022,0.911571,2,3,0,8.32835,0.142698 +-7.05225,0.974489,0.911571,2,3,0,7.6165,0.161854 +-6.75338,1,0.911571,2,3,0,6.99945,0.263091 +-6.82492,0.989643,0.911571,2,3,0,6.82947,0.203239 +-7.04161,0.953716,0.911571,2,3,0,7.22987,0.163234 +-6.85271,0.984892,0.911571,2,3,0,7.21637,0.195907 +-6.93307,0.967098,0.911571,2,3,0,7.1753,0.330639 +-6.9184,1,0.911571,1,1,0,6.97651,0.327219 +-6.7766,1,0.911571,2,3,0,6.88967,0.220936 +-6.78661,0.991709,0.911571,1,3,0,6.84903,0.285747 +-6.91105,0.963683,0.911571,1,1,0,6.9118,0.325457 +-6.99134,0.904809,0.911571,1,3,0,7.41054,0.170221 +-7.52295,0.922862,0.911571,1,3,0,7.52512,0.119216 +-8.18406,0.915269,0.911571,1,1,0,8.19368,0.0854231 +-6.83908,1,0.911571,2,3,0,8.10432,0.199345 +-7.15721,0.973687,0.911571,2,3,0,7.16893,0.372588 +-7.50346,0.889599,0.911571,1,1,0,7.58859,0.419811 +-6.89992,1,0.911571,1,1,0,7.31194,0.322713 +-6.79333,1,0.911571,2,3,0,6.87212,0.213687 +-6.862,0.984218,0.911571,1,1,0,6.86339,0.193707 +-6.82275,1,0.911571,1,1,0,6.86282,0.203871 +-6.8288,0.998614,0.911571,1,1,0,6.84531,0.202136 +-6.8288,0.637251,0.911571,1,3,0,8.87836,0.202136 +-7.00498,0.962301,0.911571,1,1,0,7.00503,0.168241 +-7.05158,0.990936,0.911571,1,1,0,7.09555,0.16194 +-7.75318,0.945254,0.911571,2,3,0,7.76047,0.447628 +-7.32472,1,0.911571,1,1,0,7.73712,0.397098 +-7.02072,0.8736,0.911571,1,3,0,7.9935,0.166038 +-6.7547,0.99793,0.911571,2,3,0,7.02929,0.235742 +-6.75796,0.956234,0.911571,2,3,0,7.04087,0.232657 +-7.07213,0.949449,0.911571,2,3,0,7.17487,0.358348 +-7.13247,0.980424,0.911571,1,1,0,7.22257,0.368599 +-8.13915,0.87347,0.911571,2,3,0,8.17658,0.484648 +-7.38823,1,0.911571,1,1,0,8.00264,0.405502 +-6.78108,1,0.911571,1,3,0,7.21545,0.283021 +-6.97291,0.8738,0.911571,2,3,0,7.50649,0.173006 +-6.90642,1,0.911571,1,1,0,6.97995,0.184401 +-6.90193,1,0.911571,1,1,0,6.93981,0.185267 +-7.16711,0.916297,0.911571,1,3,0,7.5674,0.374152 +-6.98364,1,0.911571,1,1,0,7.15417,0.341561 +-6.94657,1,0.911571,1,1,0,7.0251,0.333676 +-7.77884,0.759333,0.911571,1,1,0,7.78485,0.450287 +-7.1881,1,0.911571,1,1,0,7.65217,0.377414 +-6.80116,1,0.911571,1,3,0,7.06997,0.292144 +-6.78619,1,0.911571,1,1,0,6.80487,0.285547 +-7.17942,0.777373,0.911571,2,3,0,7.97527,0.147357 +-7.07095,1,0.911571,1,1,0,7.20062,0.159501 +-7.21731,0.991192,0.911571,2,3,0,7.25075,0.143602 +-7.70396,0.925179,0.911571,1,1,0,7.7103,0.108085 +-8.08934,0.952161,0.911571,1,1,0,8.15211,0.0892914 +-6.7508,0.981616,0.911571,2,3,0,8.27543,0.240756 +-6.74802,0.999988,0.911571,2,3,0,6.75086,0.250236 +-6.74821,0.999954,0.911571,1,3,0,6.74824,0.252459 +-6.87378,0.855668,0.911571,2,3,0,7.56602,0.19106 +-7.27281,0.940274,0.911571,1,3,0,7.27785,0.138461 +-7.14018,1,0.911571,1,1,0,7.29653,0.151488 +-6.98774,1,0.911571,1,1,0,7.13051,0.170755 +-6.9036,1,0.911571,1,1,0,6.98745,0.184943 +-9.31887,0.680763,0.911571,2,3,0,10.371,0.572338 +-6.77939,0.849869,0.911571,2,3,0,10.4922,0.219597 +-6.77939,0.959326,0.911571,1,3,0,6.99719,0.219597 +-7.14204,0.930824,0.911571,1,3,0,7.17515,0.151287 +-6.94336,1,0.911571,1,1,0,7.11083,0.177779 +-6.82846,1,0.911571,1,1,0,6.92023,0.20223 +-6.93929,0.975852,0.911571,1,1,0,6.94176,0.17847 +-6.79067,0.998213,0.911571,1,3,0,6.906,0.214729 +-6.7752,0.978021,0.911571,2,3,0,6.94612,0.27987 +-6.89352,0.965852,0.911571,1,1,0,6.89355,0.321096 +-8.76388,0.399036,0.911571,2,7,0,10.7742,0.0661379 +-6.93397,0.999909,0.911571,1,3,0,8.7989,0.179386 +-6.9837,0.989852,0.911571,1,1,0,7.01334,0.171359 +-7.04993,0.987029,0.911571,1,1,0,7.08525,0.162152 +-7.26469,0.961469,0.911571,1,1,0,7.28376,0.139189 +-7.68632,0.978665,0.911571,2,3,0,7.70188,0.109092 +-7.1617,0.978198,0.911571,2,3,0,8.08926,0.14919 +-6.9788,0.947531,0.911571,1,3,0,7.697,0.340566 +-6.78811,1,0.911571,2,3,0,6.94055,0.215765 +-7.538,0.827012,0.911571,1,3,0,7.79328,0.423896 +-6.94694,1,0.911571,1,1,0,7.35625,0.333757 +-6.78257,1,0.911571,2,3,0,6.89806,0.283774 +-6.86901,0.943403,0.911571,2,3,0,7.10636,0.192114 +-7.06289,0.960239,0.911571,1,1,0,7.06422,0.160504 +-7.09441,0.998019,0.911571,2,3,0,7.15323,0.15667 +-6.77506,0.973076,0.911571,1,3,0,7.22698,0.279792 +-6.9862,0.857826,0.911571,2,3,0,7.59959,0.170984 +-6.74803,0.901887,0.911571,2,3,0,7.76131,0.250448 +-6.80073,0.898611,0.911571,2,3,0,7.32043,0.210952 +-6.75775,1,0.911571,2,3,0,6.78981,0.267696 +-7.12995,0.893028,0.911571,1,3,0,7.32754,0.152611 +-6.9749,1,0.911571,1,1,0,7.11725,0.172698 +-6.9749,0.750406,0.911571,1,3,0,8.79436,0.172698 +-7.31603,0.937593,0.911571,1,1,0,7.31721,0.134716 +-7.1075,1,0.911571,1,1,0,7.30678,0.155145 +-7.42202,0.946768,0.911571,1,1,0,7.43516,0.126332 +-6.74975,1,0.911571,2,3,0,7.30507,0.257398 +-6.74975,0.608739,0.911571,2,3,0,8.79472,0.257398 +-6.75052,0.99979,0.911571,1,1,0,6.75084,0.258912 +-6.74878,0.999719,0.911571,1,3,0,6.75249,0.245161 +-6.74924,0.998502,0.911571,2,3,0,6.75793,0.256197 +-6.7488,0.998897,0.911571,2,3,0,6.756,0.245097 +-7.52334,0.818169,0.911571,1,3,0,7.79291,0.119189 +-7.33464,1,0.911571,1,1,0,7.55666,0.133167 +-8.23941,0.880707,0.911571,1,3,0,8.24238,0.0832729 +-6.77826,1,0.911571,2,3,0,7.89703,0.281544 +-8.31282,0.744429,0.911571,2,3,0,8.32924,0.0805364 +-6.76417,0.958807,0.911571,1,3,0,8.49289,0.227996 +-6.84873,0.850103,0.911571,2,3,0,7.71882,0.196883 +-6.75454,0.993824,0.911571,1,3,0,6.87837,0.264449 +-6.80808,0.982284,0.911571,1,3,0,6.84779,0.208432 +-6.75203,0.938288,0.911571,2,3,0,7.21385,0.2613 +-6.81036,0.940346,0.911571,2,3,0,7.0954,0.207686 +-7.84573,0.813097,0.911571,1,3,0,8.04064,0.100515 +-6.7493,0.918806,0.911571,2,3,0,8.85803,0.243725 +-6.76458,0.995457,0.911571,1,3,0,6.77281,0.273194 +-7.06668,0.952508,0.911571,2,3,0,7.08036,0.16003 +-6.75301,1,0.911571,2,3,0,7.01185,0.262622 +-6.88343,0.961469,0.911571,1,3,0,6.9503,0.188997 +-7.15587,0.945796,0.911571,1,1,0,7.15589,0.149805 +-8.01537,0.885758,0.911571,1,3,0,8.02621,0.0924921 +-7.2835,0.881722,0.911571,1,3,0,9.48375,0.391412 +-7.2835,0.79669,0.911571,1,1,0,7.8138,0.391412 +-7.45781,0.942365,0.911571,1,1,0,7.60306,0.414274 +-7.38367,1,0.911571,1,1,0,7.62522,0.404912 +-6.83893,1,0.911571,2,3,0,7.2115,0.305641 +-6.80732,1,0.911571,2,3,0,6.84123,0.294601 +-7.52124,0.846427,0.911571,1,3,0,7.5266,0.421924 +-6.83793,1,0.911571,1,3,0,7.30468,0.305322 +-6.74858,0.998737,0.911571,2,3,0,6.84736,0.245821 +-6.74805,0.998145,0.911571,2,3,0,6.75942,0.250924 +-6.74802,0.999573,0.911571,2,3,0,6.75045,0.249953 +-6.74804,0.999995,0.911571,1,3,0,6.74804,0.249231 +-6.74802,0.999898,0.911571,2,3,0,6.74862,0.250181 +-6.80725,0.985148,0.911571,1,3,0,6.81744,0.294574 +-6.75493,0.990765,0.911571,2,3,0,6.86502,0.264876 +-6.80689,0.982594,0.911571,1,3,0,6.84697,0.208829 +-6.85275,0.981057,0.911571,2,3,0,6.98136,0.195897 +-6.75016,0.998352,0.911571,2,3,0,6.8625,0.241889 +-6.87922,0.9776,0.911571,2,3,0,6.92059,0.317353 +-6.9761,0.970234,0.911571,1,1,0,7.00066,0.340006 +-6.81815,1,0.911571,2,3,0,6.93229,0.298638 +-6.79499,1,0.911571,1,1,0,6.82071,0.289549 +-6.80417,0.97974,0.911571,2,3,0,6.92122,0.209751 +-6.8201,0.996297,0.911571,1,1,0,6.83016,0.204656 +-7.4536,0.891401,0.911571,1,3,0,7.51484,0.124023 +-8.87674,0.863545,0.911571,2,3,0,9.4201,0.0630729 +-9.7307,0.938815,0.911571,1,1,0,9.78169,0.0447731 +-7.70719,0.920092,0.911571,1,3,0,9.63864,0.107903 +-7.61497,1,0.911571,1,1,0,7.82217,0.113326 +-6.88196,0.958804,0.911571,1,3,0,8.16713,0.318083 +-6.77224,1,0.911571,2,3,0,6.85826,0.223184 +-6.95332,0.948593,0.911571,1,3,0,7.06241,0.335159 +-6.8241,0.968203,0.911571,1,3,0,7.142,0.203478 +-8.0677,0.839982,0.911571,2,3,0,8.25986,0.0902107 +-7.58664,0.972791,0.911571,2,3,0,8.75146,0.115084 +-8.79267,0.903145,0.911571,2,7,0,8.79833,0.536794 +-7.51414,1,0.911571,2,3,0,8.47075,0.421083 +-10.3245,0.669795,0.911571,2,3,0,10.379,0.629494 +-7.26207,0.86988,0.911571,1,3,0,11.6547,0.139426 +-6.75815,0.999956,0.911571,2,3,0,7.24198,0.232499 +-6.86133,0.979208,0.911571,1,3,0,6.86679,0.193861 +-7.92461,0.829258,0.911571,1,3,0,8.07377,0.0966584 +-8.16783,0.971707,0.911571,1,1,0,8.28792,0.0860684 +-7.68403,1,0.911571,1,1,0,8.14915,0.109223 +-7.81118,0.994364,0.911571,2,3,0,7.93728,0.102281 +-8.4857,0.924158,0.911571,1,1,0,8.50972,0.0745641 +-7.32815,0.986464,0.911571,2,3,0,8.8252,0.133703 +-7.29985,0.891992,0.911571,1,3,0,8.4224,0.39369 +-6.9146,1,0.911571,1,1,0,7.18925,0.326313 +-6.83505,1,0.911571,1,1,0,6.90426,0.304395 +-7.2159,0.950743,0.911571,2,3,0,7.2168,0.381626 +-6.79348,0.975099,0.911571,1,3,0,7.33855,0.213629 +-7.08016,0.921104,0.911571,1,3,0,7.26322,0.35976 +-6.93806,0.742126,0.911571,2,3,0,8.38579,0.331773 +-6.93806,0.716378,0.911571,2,7,0,8.1643,0.331773 +-7.19196,0.660098,0.911571,2,3,0,8.78223,0.378006 +-6.87896,1,0.911571,2,3,0,7.11262,0.189941 +-6.87896,0.577499,0.911571,2,3,0,9.93617,0.189941 +-7.7474,0.804986,0.911571,1,3,0,8.23622,0.447024 +-7.43398,1,0.911571,1,1,0,7.81884,0.411318 +-6.74829,1,0.911571,1,3,0,7.33963,0.24713 +-7.27579,0.877026,0.911571,1,3,0,7.35324,0.390325 +-7.06817,1,0.911571,1,1,0,7.27752,0.357645 +-6.80871,0.864117,0.911571,2,3,0,7.72603,0.295134 +-6.7891,1,0.911571,1,1,0,6.81119,0.286917 +-7.28689,0.919573,0.911571,2,3,0,7.29591,0.137218 +-6.83291,1,0.911571,2,3,0,7.16739,0.303697 +-6.74931,0.999033,0.911571,1,3,0,6.83527,0.243689 +-6.74812,0.996906,0.911571,2,3,0,6.76767,0.251714 +-7.02032,0.930671,0.911571,1,3,0,7.10714,0.166093 +-6.76526,1,0.911571,1,3,0,6.98371,0.227283 +-6.76388,1,0.911571,2,3,0,6.76862,0.228194 +-6.82176,0.989944,0.911571,1,3,0,6.82191,0.204162 +-6.74917,0.997584,0.911571,1,3,0,6.83023,0.25603 +-6.77844,0.991443,0.911571,1,3,0,6.79215,0.220048 +-6.77844,0.893036,0.911571,1,3,0,7.27763,0.220048 +-7.38153,0.908581,0.911571,2,3,0,7.52865,0.129413 +-7.83207,0.935892,0.911571,1,1,0,7.85398,0.101208 +-7.75478,1,0.911571,1,1,0,7.97297,0.10527 +-7.59019,1,0.911571,1,1,0,7.83502,0.114861 +-6.90968,0.987573,0.911571,1,3,0,7.48746,0.183783 +-7.59165,0.90612,0.911571,1,3,0,7.62183,0.11477 +-6.79619,0.932801,0.911571,1,3,0,7.92896,0.290065 +-6.90297,0.951659,0.911571,1,3,0,7.07523,0.185064 +-6.75997,1,0.911571,1,3,0,6.87781,0.231018 +# +# Elapsed Time: 0.003 seconds (Warm-up) +# 0.01 seconds (Sampling) +# 0.013 seconds (Total) +# diff --git a/src/test/interface/example_output/bern3.csv b/src/test/interface/example_output/bern3.csv new file mode 100644 index 0000000000..0f79beab7b --- /dev/null +++ b/src/test/interface/example_output/bern3.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-10-17 18:13:44 UTC +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = false (Default) +# thin = 1 (Default) +# adapt +# engaged = true (Default) +# gamma = 0.05 (Default) +# delta = 0.8 (Default) +# kappa = 0.75 (Default) +# t0 = 10 (Default) +# init_buffer = 75 (Default) +# term_buffer = 50 (Default) +# window = 25 (Default) +# save_metric = false (Default) +# algorithm = hmc (Default) +# hmc +# engine = nuts (Default) +# nuts +# max_depth = 10 (Default) +# metric = diag_e (Default) +# metric_file = (Default) +# stepsize = 1 (Default) +# stepsize_jitter = 0 (Default) +# num_chains = 1 (Default) +# id = 3 +# data +# file = /Users/mitzi/.cmdstan/cmdstan-2.35.0/examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 86520 +# output +# file = /Users/mitzi/github/stan-dev/cmdstanpy/test_csv_files/bernoulli-20241017141344_3.csv +# diagnostic_file = (Default) +# refresh = 100 (Default) +# sig_figs = -1 (Default) +# profile_file = profile.csv (Default) +# save_cmdstan_config = false (Default) +# num_threads = 1 (Default) +# stanc_version = stanc3 v2.35.0 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +# Adaptation terminated +# Step size = 0.889047 +# Diagonal elements of inverse mass matrix: +# 0.568698 +-8.55171,0.835828,0.889047,2,3,0,8.79251,0.0724419 +-9.14968,0.951918,0.889047,1,1,0,9.22155,0.0563692 +-6.74914,0.962544,0.889047,1,3,0,9.97683,0.244117 +-7.2825,0.895266,0.889047,2,3,0,7.54537,0.39127 +-6.89863,1,0.889047,1,1,0,7.17236,0.322391 +-6.89863,0.686169,0.889047,1,3,0,8.52937,0.322391 +-7.04084,0.883091,0.889047,1,3,0,7.5211,0.163334 +-7.15265,0.980207,0.889047,1,1,0,7.1846,0.150147 +-7.11115,0.917446,0.889047,1,3,0,7.95245,0.365068 +-6.95374,0.902479,0.889047,1,3,0,7.64873,0.176055 +-6.9966,0.991767,0.889047,1,1,0,7.02914,0.169449 +-7.09041,0.982818,0.889047,1,1,0,7.11901,0.157144 +-7.89108,0.894695,0.889047,1,3,0,7.90923,0.0982697 +-7.04712,0.87415,0.889047,2,7,0,9.02762,0.353843 +-6.74847,0.999533,0.889047,1,3,0,7.03366,0.246273 +-6.74813,0.990485,0.889047,2,3,0,6.8073,0.24819 +-6.75364,0.969935,0.889047,2,3,0,6.93634,0.236906 +-7.19564,0.895245,0.889047,1,3,0,7.31483,0.378568 +-6.77654,0.923282,0.889047,2,3,0,7.65468,0.280615 +-6.88386,0.957168,0.889047,1,3,0,7.02087,0.188905 +-6.78458,0.998684,0.889047,1,3,0,6.86194,0.217257 +-6.79505,0.997618,0.889047,1,1,0,6.80125,0.213032 +-6.94811,0.976011,0.889047,1,3,0,6.94934,0.176982 +-6.88023,1,0.889047,1,1,0,6.94836,0.18967 +-8.02025,0.896408,0.889047,2,3,0,8.19292,0.473863 +-8.02025,0.327512,0.889047,1,1,0,10.4019,0.473863 +-7.55376,1,0.889047,1,1,0,8.051,0.425732 +-6.97531,1,0.889047,1,1,0,7.38517,0.339842 +-6.99206,0.994932,0.889047,1,1,0,7.05418,0.343272 +-7.37361,0.887374,0.889047,1,1,0,7.40068,0.403603 +-6.95409,1,0.889047,1,1,0,7.25932,0.335327 +-7.69156,0.793089,0.889047,1,1,0,7.69669,0.441105 +-7.16328,1,0.889047,1,1,0,7.58202,0.373549 +-6.79823,0.96771,0.889047,1,3,0,7.33381,0.211851 +-6.76131,0.887538,0.889047,2,3,0,7.7219,0.230002 +-7.48126,0.886547,0.889047,2,3,0,7.74983,0.417139 +-7.79599,0.901063,0.889047,1,1,0,7.97646,0.452046 +-6.97638,1,0.889047,2,3,0,7.62226,0.172472 +-6.99519,0.996408,0.889047,1,1,0,7.03828,0.169655 +-9.12987,0.833642,0.889047,2,3,0,9.52748,0.560105 +-6.85073,0.634125,0.889047,2,3,0,11.2918,0.309286 +-6.85073,0.766963,0.889047,1,3,0,8.00503,0.309286 +-7.00321,0.905334,0.889047,1,3,0,7.36848,0.168495 +-7.75019,0.899911,0.889047,1,3,0,7.77567,0.105519 +-6.78796,0.928187,0.889047,1,3,0,8.1988,0.286385 +-7.63171,0.745873,0.889047,1,3,0,8.31372,0.112307 +-7.0445,0.979879,0.889047,1,3,0,7.53683,0.162855 +-6.74904,0.880038,0.889047,2,3,0,8.5391,0.255667 +-7.53766,0.830286,0.889047,1,3,0,7.63299,0.423855 +-7.33571,1,0.889047,1,1,0,7.61954,0.398581 +-6.84735,0.941819,0.889047,1,3,0,7.65104,0.197226 +-6.76632,0.995395,0.889047,2,3,0,6.88892,0.226612 +-6.74802,0.956979,0.889047,2,3,0,7.0688,0.249853 +-7.01679,0.932999,0.889047,1,3,0,7.10757,0.166581 +-9.54977,0.655582,0.889047,1,3,0,10.319,0.0480492 +-11.0548,0.924944,0.889047,1,1,0,11.0549,0.0272698 +-16.5473,0.844684,0.889047,2,3,0,18.3184,0.00407243 +-7.73562,0.888719,0.889047,2,5,0,15.8691,0.445789 +-7.583,1,0.889047,1,1,0,7.92055,0.429093 +-6.9035,1,0.889047,1,1,0,7.37377,0.323605 +-6.82117,0.968823,0.889047,1,3,0,7.09814,0.204337 +-7.19839,0.967601,0.889047,2,3,0,7.2163,0.378986 +-7.0288,1,0.889047,1,1,0,7.20161,0.350433 +-6.7721,0.982911,0.889047,1,3,0,7.11783,0.223262 +-6.81806,0.996512,0.889047,2,3,0,6.81827,0.205272 +-7.43725,0.851948,0.889047,1,3,0,7.78689,0.411725 +-10.0784,0.414871,0.889047,1,1,0,10.1057,0.616584 +-6.89043,0.977409,0.889047,2,3,0,10.5838,0.187551 +-7.18629,0.955869,0.889047,1,3,0,7.18658,0.14666 +-6.77454,0.99817,0.889047,1,3,0,7.15187,0.221974 +-6.77454,0.694718,0.889047,1,3,0,8.35626,0.221974 +-6.77667,0.999505,0.889047,1,1,0,6.78248,0.220904 +-7.24464,0.941843,0.889047,2,3,0,7.33243,0.385861 +-8.22809,0.891035,0.889047,2,3,0,8.28163,0.492413 +-8.58544,0.88655,0.889047,1,1,0,9.00751,0.521378 +-6.99261,1,0.889047,2,3,0,8.43706,0.170034 +-8.9012,0.674491,0.889047,1,3,0,9.94697,0.544521 +-8.03361,0.405275,0.889047,1,3,0,12.6845,0.0916875 +-6.74814,0.947784,0.889047,1,3,0,8.34921,0.251962 +-6.75109,0.999349,0.889047,1,3,0,6.75134,0.259878 +-7.87211,0.716743,0.889047,1,3,0,8.50254,0.0991995 +-7.50427,1,0.889047,2,3,0,7.86257,0.120477 +-7.87852,0.951362,0.889047,1,1,0,7.91692,0.0988837 +-6.77209,0.989559,0.889047,2,3,0,7.96379,0.223266 +-7.26858,0.927308,0.889047,2,3,0,7.37932,0.138839 +-7.2404,1,0.889047,1,1,0,7.35023,0.141414 +-6.78559,0.996822,0.889047,1,3,0,7.19786,0.216824 +-6.82546,0.991082,0.889047,1,1,0,6.82758,0.203085 +-6.76911,0.90591,0.889047,2,3,0,7.51889,0.224931 +-6.75774,0.93329,0.889047,2,3,0,7.21156,0.232845 +-7.00786,0.965393,0.889047,2,3,0,7.0581,0.346409 +-6.75893,1,0.889047,2,3,0,6.99387,0.231847 +-6.74873,0.975238,0.889047,2,3,0,6.91405,0.254727 +-6.74873,0.911899,0.889047,1,3,0,7.13771,0.254727 +-7.87236,0.768927,0.889047,1,3,0,8.00588,0.459714 +-6.74913,1,0.889047,1,3,0,7.69425,0.255912 +-6.9749,0.939894,0.889047,1,3,0,7.06898,0.172698 +-6.77054,0.981912,0.889047,1,3,0,7.08858,0.27713 +-6.79892,0.992266,0.889047,1,1,0,6.80088,0.291222 +-6.83128,0.959282,0.889047,2,3,0,7.03693,0.30316 +-9.41432,0.637367,0.889047,2,7,0,9.49107,0.578311 +-9.58744,0.944845,0.889047,1,1,0,10.4304,0.588821 +-8.55706,1,0.889047,1,1,0,9.68794,0.519195 +-7.99767,1,0.889047,1,1,0,8.68835,0.471757 +-7.6031,1,0.889047,1,1,0,8.07644,0.431371 +-7.6031,0.37392,0.889047,1,1,0,9.61871,0.431371 +-7.6031,0.930651,0.889047,1,1,0,7.98057,0.431371 +-7.6031,0.45139,0.889047,1,1,0,9.25619,0.431371 +-6.98153,1,0.889047,1,1,0,7.41992,0.341129 +-6.80962,0.927162,0.889047,2,3,0,7.38746,0.295485 +-7.48132,0.742577,0.889047,2,3,0,8.25316,0.12206 +-7.78912,0.835676,0.889047,1,3,0,9.48513,0.451343 +-7.68854,1,0.889047,1,1,0,8.034,0.44078 +-8.39563,0.788827,0.889047,1,1,0,8.59931,0.506407 +-7.45672,1,0.889047,2,7,0,8.18238,0.1238 +-6.8091,0.994267,0.889047,1,3,0,7.40758,0.208096 +-7.02647,0.958661,0.889047,2,3,0,7.17343,0.165253 +-7.2174,0.966655,0.889047,1,1,0,7.23366,0.143593 +-7.60995,0.94134,0.889047,1,1,0,7.62094,0.113634 +-7.25549,1,0.889047,1,1,0,7.57465,0.140023 +-7.13961,1,0.889047,1,1,0,7.28227,0.15155 +-7.92289,0.932257,0.889047,2,7,0,7.92296,0.464647 +-8.40383,0.850536,0.889047,1,1,0,8.70854,0.507072 +-7.83998,1,0.889047,1,1,0,8.48191,0.456495 +-7.82626,1,0.889047,1,1,0,8.17354,0.455117 +-8.37261,0.338652,0.889047,1,3,0,12.0631,0.0783993 +-7.08584,0.964512,0.889047,1,3,0,8.28372,0.157689 +-6.74842,0.996169,0.889047,1,3,0,7.10667,0.246469 +-7.55948,0.824226,0.889047,1,3,0,7.69205,0.426393 +-6.92094,0.90603,0.889047,1,3,0,8.08752,0.181698 +-7.91121,0.92607,0.889047,2,3,0,7.99407,0.463516 +-7.91121,0.53139,0.889047,1,1,0,9.33857,0.463516 +-7.86366,1,0.889047,2,3,0,8.24049,0.458853 +-6.96961,1,0.889047,1,1,0,7.58442,0.338649 +-6.83183,0.960896,0.889047,1,3,0,7.20287,0.201293 +-6.98555,0.968549,0.889047,1,1,0,6.98574,0.17108 +-6.98555,0.933314,0.889047,1,1,0,7.30441,0.17108 +-6.98555,0.953935,0.889047,1,1,0,7.20419,0.17108 +-6.75951,0.83169,0.889047,2,3,0,8.88746,0.231381 +-6.75951,0.887391,0.889047,1,3,0,7.2903,0.231381 +-6.76121,0.999593,0.889047,1,1,0,6.7636,0.230077 +-6.75182,0.983053,0.889047,2,3,0,6.87021,0.261005 +-6.75182,0.991459,0.889047,1,3,0,6.78308,0.261005 +-6.7527,0.99861,0.889047,2,3,0,6.76254,0.238046 +-7.29995,0.877353,0.889047,1,3,0,7.4585,0.136085 +-6.95247,1,0.889047,1,1,0,7.23636,0.176263 +-6.77948,0.891048,0.889047,2,3,0,7.86619,0.219553 +-7.06365,0.923693,0.889047,1,3,0,7.23372,0.356839 +-7.02079,1,0.889047,1,1,0,7.12189,0.348909 +-6.77292,1,0.889047,2,3,0,6.98514,0.222823 +-7.88119,0.776786,0.889047,1,3,0,8.22253,0.0987528 +-6.89797,0.890691,0.889047,2,7,0,8.69998,0.322223 +-7.15592,0.924757,0.889047,1,1,0,7.16901,0.372382 +-7.0734,1,0.889047,2,3,0,7.21151,0.358571 +-7.57233,0.683187,0.889047,2,7,0,8.88897,0.11599 +-6.85025,0.989346,0.889047,1,3,0,7.50457,0.196507 +-7.00055,0.969769,0.889047,1,1,0,7.0018,0.168877 +-7.00082,0.999983,0.889047,2,3,0,7.05398,0.168839 +-7.0846,0.984645,0.889047,1,1,0,7.11601,0.157838 +-6.83264,0.925497,0.889047,2,3,0,7.77881,0.303608 +-6.92182,0.991479,0.889047,2,3,0,6.93237,0.32803 +-7.40794,0.860471,0.889047,1,1,0,7.41527,0.40803 +-9.64832,0.473935,0.889047,1,1,0,9.68333,0.592422 +-7.25137,1,0.889047,1,1,0,8.86295,0.386836 +-6.93019,1,0.889047,1,1,0,7.16901,0.329979 +-7.2742,0.966256,0.889047,2,3,0,7.28929,0.390101 +-6.90535,1,0.889047,1,1,0,7.17027,0.324063 +-6.79109,1,0.889047,2,3,0,6.87388,0.287823 +-6.90289,0.93334,0.889047,2,3,0,7.17757,0.323454 +-7.50472,0.926858,0.889047,2,3,0,7.50681,0.419961 +-7.41717,1,0.889047,1,1,0,7.66677,0.409202 +-7.41717,0.7654,0.889047,1,1,0,8.06665,0.409202 +-6.78256,1,0.889047,1,3,0,7.25202,0.283771 +-6.8223,0.976732,0.889047,1,3,0,6.93028,0.204004 +-7.71897,0.802947,0.889047,1,3,0,8.13741,0.444032 +-8.03509,0.899591,0.889047,1,1,0,8.29329,0.475236 +-8.1142,0.973729,0.889047,1,1,0,8.51204,0.482425 +-8.1142,0.57467,0.889047,1,1,0,9.46251,0.482425 +-6.95337,1,0.889047,2,3,0,7.74624,0.33517 +-6.95337,0.635815,0.889047,1,3,0,8.57478,0.33517 +-7.49523,0.844273,0.889047,1,1,0,7.50592,0.418825 +-7.49523,0.664132,0.889047,1,1,0,8.41433,0.418825 +-7.16234,1,0.889047,1,1,0,7.46645,0.373401 +-9.01259,0.544073,0.889047,1,1,0,9.02116,0.552226 +-9.01259,0.259633,0.889047,1,3,0,13.1968,0.552226 +-6.76347,1,0.889047,1,3,0,8.50872,0.272387 +-6.79719,0.984793,0.889047,1,3,0,6.85456,0.212233 +-7.26525,0.917326,0.889047,1,3,0,7.31522,0.139138 +-7.03729,1,0.889047,1,1,0,7.23796,0.163803 +-8.41328,0.837768,0.889047,1,3,0,8.58001,0.0769898 +-7.05803,0.966496,0.889047,1,3,0,8.34048,0.161117 +-6.78778,0.996909,0.889047,1,3,0,7.01523,0.215901 +-6.78778,0.900884,0.889047,1,3,0,7.28331,0.215901 +-7.25118,0.884736,0.889047,1,3,0,7.48655,0.386809 +-6.9204,1,0.889047,1,1,0,7.16344,0.327694 +-6.79663,1,0.889047,1,1,0,6.8864,0.290252 +-6.76218,1,0.889047,1,1,0,6.78756,0.271415 +-6.81435,0.994176,0.889047,2,3,0,6.81436,0.206415 +-6.78465,0.988317,0.889047,1,3,0,6.90729,0.284804 +-7.06366,0.902094,0.889047,1,3,0,7.33381,0.160408 +-7.52702,0.925306,0.889047,1,1,0,7.52706,0.118944 +-8.07717,0.931528,0.889047,1,1,0,8.09279,0.0898068 +-7.04927,0.868443,0.889047,2,7,0,9.33791,0.354236 +-7.06168,0.748623,0.889047,2,3,0,8.4497,0.356485 +-7.56907,0.72735,0.889047,2,3,0,8.92568,0.116199 +-6.74808,0.985335,0.889047,2,3,0,7.70335,0.248636 +-6.84043,0.977154,0.889047,1,3,0,6.86107,0.306117 +-7.83239,0.649105,0.889047,2,7,0,8.8669,0.101192 +-6.74968,0.970627,0.889047,1,3,0,8.01426,0.242857 +-7.56351,0.878362,0.889047,2,3,0,7.62817,0.116555 +-7.38904,1,0.889047,1,1,0,7.6053,0.12883 +-7.80517,0.93271,0.889047,2,3,0,8.41556,0.102593 +-7.28557,1,0.889047,1,1,0,7.73408,0.137334 +-6.94935,1,0.889047,1,1,0,7.22384,0.176778 +-6.8633,0.97077,0.889047,1,3,0,7.24034,0.312957 +-6.81394,0.974136,0.889047,1,3,0,7.03161,0.206543 +-6.95417,0.990219,0.889047,2,3,0,6.95417,0.175985 +-7.13476,0.966819,0.889047,1,1,0,7.14367,0.15208 +-6.82052,0.99464,0.889047,1,3,0,7.07979,0.204529 +-7.11468,0.976518,0.889047,2,3,0,7.12184,0.365659 +-8.64524,0.606409,0.889047,1,1,0,8.65415,0.52592 +-9.35848,0.78825,0.889047,1,1,0,9.87019,0.574832 +-7.66133,0.577509,0.889047,1,3,0,12.1583,0.110544 +-7.48539,0.860281,0.889047,1,3,0,9.36696,0.417638 +-7.53141,0.984993,0.889047,1,1,0,7.75109,0.423122 +-8.32781,0.922148,0.889047,2,3,0,8.47454,0.500836 +-6.78317,1,0.889047,1,3,0,7.93949,0.284076 +-7.57464,0.872142,0.889047,2,3,0,7.58258,0.115843 +-10.9057,0.853817,0.889047,2,3,0,11.083,0.657704 +-10.8986,1,0.889047,1,1,0,12.2449,0.657377 +-7.65435,1,0.889047,1,1,0,9.86336,0.437066 +-6.9003,0.914745,0.889047,1,3,0,8.13168,0.185585 +-6.7481,1,0.889047,2,3,0,6.8886,0.248441 +-6.7563,0.997825,0.889047,1,3,0,6.75903,0.266314 +-6.81471,0.924313,0.889047,2,3,0,7.21398,0.206304 +-7.13832,0.949023,0.889047,1,3,0,7.15152,0.151691 +-8.26543,0.861744,0.889047,1,3,0,8.3284,0.0822883 +-6.77032,1,0.889047,2,3,0,8.04347,0.224243 +-6.87922,0.966162,0.889047,1,3,0,6.97504,0.317354 +-7.242,0.895855,0.889047,1,1,0,7.24682,0.385477 +-6.81976,0.956123,0.889047,1,3,0,7.47659,0.204758 +-7.03827,0.982243,0.889047,2,3,0,7.03968,0.352208 +-7.5045,0.954184,0.889047,2,3,0,7.53741,0.419934 +-7.08111,0.831494,0.889047,1,3,0,8.42893,0.158259 +-6.77797,0.906022,0.889047,2,3,0,8.14682,0.281392 +-6.77085,0.992667,0.889047,1,3,0,6.83226,0.223947 +-6.81615,0.98966,0.889047,1,1,0,6.8163,0.205857 +-6.77709,0.979194,0.889047,2,3,0,6.99519,0.280913 +-7.78615,0.793414,0.889047,1,3,0,7.8312,0.451038 +-6.82096,1,0.889047,2,3,0,7.7697,0.204401 +-6.75488,0.948702,0.889047,2,3,0,7.24063,0.264822 +-6.87549,0.964684,0.889047,2,3,0,6.98393,0.316346 +-6.77167,1,0.889047,1,3,0,6.8467,0.27782 +-6.7659,0.994388,0.889047,1,3,0,6.8142,0.226873 +-6.91488,0.743987,0.889047,2,3,0,8.71568,0.182809 +-6.85339,0.973642,0.889047,1,3,0,7.17254,0.310079 +-7.12132,0.923184,0.889047,1,1,0,7.1255,0.366764 +-7.12132,0.45497,0.889047,1,3,0,10.5144,0.366764 +-6.92123,1,0.889047,1,1,0,7.08329,0.327891 +-6.78421,1,0.889047,2,3,0,6.88257,0.284589 +-6.80354,0.994664,0.889047,1,1,0,6.80976,0.29311 +-6.803,1,0.889047,2,3,0,6.81816,0.292891 +-6.8803,0.978235,0.889047,1,1,0,6.8851,0.317643 +-6.91989,0.996135,0.889047,2,3,0,6.94973,0.327574 +-10.253,0.170346,0.889047,1,3,0,14.5859,0.0366793 +-8.87059,1,0.889047,1,1,0,10.1592,0.0632353 +-6.9151,1,0.889047,2,3,0,8.69437,0.182768 +-7.30123,0.935036,0.889047,2,3,0,7.57348,0.135975 +-7.6135,0.954592,0.889047,1,1,0,7.6424,0.113415 +-6.78569,1,0.889047,1,3,0,7.61103,0.216782 +-8.74472,0.738529,0.889047,2,3,0,8.82591,0.0666771 +-9.4063,0.951103,0.889047,1,1,0,9.47544,0.0508505 +-7.39802,0.998095,0.889047,2,3,0,9.50144,0.128141 +-6.79384,0.996291,0.889047,1,3,0,7.35766,0.213491 +-6.76401,0.978235,0.889047,2,3,0,6.96801,0.272787 +-7.06157,0.899175,0.889047,2,3,0,7.38881,0.356465 +-6.78194,0.977394,0.889047,1,3,0,7.18102,0.218422 +-7.48463,0.903539,0.889047,2,3,0,7.61274,0.121829 +-7.13752,0.903759,0.889047,1,3,0,8.52896,0.369422 +-6.77726,0.978969,0.889047,1,3,0,7.24453,0.220616 +-6.86916,0.9853,0.889047,1,3,0,6.86953,0.19208 +-6.7866,1,0.889047,1,1,0,6.85088,0.216397 +-6.78979,0.999273,0.889047,1,1,0,6.79809,0.215085 +-6.7482,1,0.889047,1,3,0,6.78823,0.247658 +-7.53338,0.829353,0.889047,1,3,0,7.6579,0.423354 +-7.53338,0.516159,0.889047,1,1,0,8.92076,0.423354 +-7.21595,1,0.889047,1,1,0,7.52677,0.381633 +-7.32339,0.966152,0.889047,1,1,0,7.44596,0.396918 +-6.98478,1,0.889047,1,1,0,7.24595,0.341796 +-8.12671,0.694595,0.889047,1,1,0,8.12853,0.483543 +-7.91911,1,0.889047,2,3,0,8.3966,0.464281 +-8.75151,0.918554,0.889047,2,3,0,9.01519,0.533803 +-7.58906,1,0.889047,2,3,0,8.49614,0.429782 +-6.7509,0.961425,0.889047,2,3,0,7.85432,0.24059 +-6.905,0.974468,0.889047,2,3,0,6.94528,0.184673 +-9.76779,0.671285,0.889047,2,3,0,9.85478,0.0441344 +-10.0217,0.986267,0.889047,1,1,0,10.2617,0.0400358 +-11.5872,0.978137,0.889047,2,3,0,11.5876,0.022503 +-7.16358,0.889808,0.889047,2,7,0,10.7207,0.373596 +-6.86275,1,0.889047,1,1,0,7.07772,0.312803 +-6.75369,0.989425,0.889047,2,3,0,6.92919,0.263462 +-7.48159,0.805972,0.889047,1,3,0,7.88215,0.122041 +-8.19632,0.806547,0.889047,1,3,0,10.0345,0.489667 +-7.14224,1,0.889047,1,1,0,7.87967,0.370188 +-7.22715,0.99116,0.889047,2,3,0,7.32973,0.383298 +-7.22715,0.758909,0.889047,1,3,0,8.28868,0.383298 +-6.85383,0.941329,0.889047,1,3,0,7.55087,0.195635 +-6.86589,0.984239,0.889047,2,3,0,7.03689,0.192816 +-6.97804,0.977512,0.889047,1,1,0,6.98374,0.172217 +-6.74834,0.994964,0.889047,1,3,0,7.00424,0.253158 +-6.79884,0.992192,0.889047,2,3,0,6.80586,0.211628 +-6.78868,0.992876,0.889047,2,3,0,6.87411,0.215533 +-6.76885,1,0.889047,1,1,0,6.78563,0.225081 +-6.83112,0.989928,0.889047,1,3,0,6.83123,0.201488 +-7.42675,0.944268,0.889047,2,3,0,7.48349,0.41041 +-6.93083,1,0.889047,1,1,0,7.28147,0.330125 +-6.84222,1,0.889047,1,1,0,6.91795,0.306677 +-7.04462,0.941976,0.889047,1,1,0,7.04966,0.353383 +-8.04987,0.723645,0.889047,1,1,0,8.06113,0.476595 +-8.00486,1,0.889047,1,1,0,8.42777,0.47243 +-11.8648,0.282986,0.889047,1,1,0,11.9396,0.698401 +-7.45549,1,0.889047,1,1,0,10.409,0.413988 +-7.35212,1,0.889047,1,1,0,7.5889,0.400774 +-7.31703,1,0.889047,1,1,0,7.50732,0.396051 +-7.31703,0.849487,0.889047,1,3,0,8.07544,0.396051 +-6.85339,1,0.889047,1,1,0,7.17755,0.310079 +-6.84684,1,0.889047,1,1,0,6.87747,0.308107 +-8.47745,0.747755,0.889047,2,7,0,8.47799,0.0748353 +-7.10727,0.962154,0.889047,1,3,0,8.39471,0.155171 +-7.13641,0.994905,0.889047,1,1,0,7.20017,0.1519 +-7.15054,0.911867,0.889047,1,3,0,7.98541,0.371524 +-6.83258,1,0.889047,2,3,0,7.07796,0.201087 +-6.81516,0.989703,0.889047,2,3,0,6.94827,0.206164 +-6.74955,1,0.889047,2,3,0,6.8046,0.256955 +-6.75406,0.984149,0.889047,2,3,0,6.84051,0.236433 +-7.09349,0.925473,0.889047,1,3,0,7.16791,0.156778 +-7.19848,0.906216,0.889047,1,3,0,7.98463,0.379 +-8.17036,0.727242,0.889047,1,1,0,8.21347,0.487401 +-6.78865,0.991739,0.889047,1,3,0,8.25584,0.215547 +-6.8057,0.998719,0.889047,2,3,0,6.8115,0.209228 +-8.23724,0.736388,0.889047,1,3,0,8.66287,0.0833554 +-8.23399,1,0.889047,1,1,0,8.45997,0.08348 +-6.97846,0.974544,0.889047,1,3,0,8.17114,0.172153 +-7.43078,0.935483,0.889047,1,3,0,7.43206,0.125683 +-7.7828,0.952405,0.889047,1,1,0,7.81806,0.103768 +-7.10546,0.975051,0.889047,1,3,0,7.67926,0.15538 +-6.9456,1,0.889047,2,3,0,7.08559,0.177402 +-8.71227,0.851807,0.889047,2,3,0,9.03572,0.53092 +-6.97368,0.901427,0.889047,1,3,0,9.414,0.172887 +-7.25399,0.950378,0.889047,1,1,0,7.25651,0.14016 +-6.82644,0.992276,0.889047,2,3,0,7.34018,0.202805 +-6.79601,0.988281,0.889047,1,3,0,6.94466,0.289989 +-6.77948,1,0.889047,1,1,0,6.79686,0.282194 +-6.8543,0.928152,0.889047,2,3,0,7.20816,0.195523 +-6.78349,0.985619,0.889047,1,3,0,6.96024,0.284232 +-6.7947,0.996912,0.889047,1,1,0,6.80199,0.289423 +-7.91614,0.774248,0.889047,1,3,0,7.9509,0.463994 +-6.86244,0.936795,0.889047,1,3,0,8.28374,0.193606 +-9.00227,0.741211,0.889047,2,3,0,9.12515,0.0598725 +-6.74976,1,0.889047,2,3,0,8.53127,0.257412 +-6.84265,0.875198,0.889047,2,3,0,7.54179,0.198417 +-7.24965,0.968249,0.889047,2,3,0,7.26299,0.386588 +-10.348,0.358429,0.889047,1,1,0,10.349,0.630698 +-8.67531,1,0.889047,1,1,0,10.2049,0.528175 +-7.12221,1,0.889047,2,3,0,8.17665,0.366912 +-6.75884,0.956974,0.889047,2,3,0,7.38778,0.268683 +-6.75884,0.440885,0.889047,1,3,0,10.1241,0.268683 +-7.1871,0.906383,0.889047,1,3,0,7.21449,0.377261 +-6.77296,0.981382,0.889047,1,3,0,7.27959,0.222798 +-6.7672,0.995344,0.889047,2,3,0,6.81759,0.274993 +-6.79905,0.991354,0.889047,1,1,0,6.80012,0.291273 +-6.81167,0.996476,0.889047,1,1,0,6.82295,0.296259 +-6.81167,0.577691,0.889047,2,7,0,9.05608,0.296259 +-6.81169,0.977256,0.889047,1,3,0,6.95671,0.207259 +-7.06069,0.926739,0.889047,1,3,0,7.29954,0.356308 +-7.71416,0.8112,0.889047,1,1,0,7.74171,0.44352 +-7.71416,0.455261,0.889047,1,1,0,9.3754,0.44352 +-6.90035,1,0.889047,1,1,0,7.46163,0.322822 +-7.00447,0.969302,0.889047,1,1,0,7.03126,0.345742 +-6.77794,1,0.889047,1,3,0,6.94236,0.281372 +-6.84686,0.981002,0.889047,1,1,0,6.84774,0.308114 +-6.85265,0.998335,0.889047,1,1,0,6.87878,0.30986 +-6.75343,0.99551,0.889047,1,3,0,6.87671,0.237157 +-6.77261,0.996756,0.889047,1,3,0,6.77267,0.222985 +-9.63247,0.426019,0.889047,1,3,0,11.2966,0.0465179 +-9.91814,0.983857,0.889047,1,1,0,10.1397,0.0416516 +-6.78432,0.961178,0.889047,1,3,0,10.9829,0.217372 +-7.24814,0.945764,0.889047,2,3,0,7.3208,0.386368 +-7.04522,0.853018,0.889047,1,3,0,8.02794,0.162762 +-7.25864,0.963374,0.889047,1,1,0,7.27405,0.139736 +-7.3909,0.979437,0.889047,1,1,0,7.4508,0.128687 +-7.70923,0.955802,0.889047,1,1,0,7.74633,0.107788 +-6.85922,0.910062,0.889047,2,7,0,8.34343,0.311788 +-7.12833,0.818652,0.889047,2,3,0,7.97415,0.15279 +-7.03344,1,0.889047,1,1,0,7.14558,0.164316 +-6.80209,0.969383,0.889047,1,3,0,7.24163,0.292523 +-6.79007,0.985354,0.889047,1,3,0,6.90226,0.21497 +-9.22836,0.587919,0.889047,2,3,0,10.4799,0.566549 +-7.21646,1,0.889047,1,1,0,8.57541,0.38171 +-6.83667,1,0.889047,1,1,0,7.10353,0.304921 +-6.78838,0.98354,0.889047,1,3,0,6.94444,0.215655 +-8.03323,0.746508,0.889047,1,3,0,8.41304,0.475064 +-7.34321,1,0.889047,1,1,0,7.9052,0.399587 +-7.34321,0.409234,0.889047,1,3,0,10.1997,0.399587 +-8.35703,0.891541,0.889047,2,3,0,8.43387,0.503251 +-7.29888,1,0.889047,1,1,0,8.06992,0.393556 +-6.78351,1,0.889047,1,3,0,7.1622,0.284245 +-7.34171,0.578231,0.889047,2,3,0,9.64862,0.132587 +-6.92558,0.98854,0.889047,1,3,0,7.26726,0.180863 +-6.77294,0.983857,0.889047,1,3,0,7.03126,0.278574 +-6.85138,0.96749,0.889047,1,3,0,6.96068,0.19623 +-7.96097,0.768995,0.889047,1,3,0,8.49717,0.468296 +-7.13593,1,0.889047,1,1,0,7.72902,0.369164 +-6.80792,0.894396,0.889047,2,3,0,7.71295,0.294833 +-6.80792,0.899043,0.889047,1,3,0,7.29473,0.294833 +-6.75579,1,0.889047,2,3,0,6.79701,0.234643 +-6.7582,0.933799,0.889047,2,3,0,7.22128,0.232458 +-6.74908,0.979536,0.889047,2,3,0,6.89518,0.255778 +-7.11979,0.915573,0.889047,1,3,0,7.16726,0.366511 +-6.82349,1,0.889047,2,3,0,7.03287,0.300521 +-7.12253,0.964913,0.889047,2,3,0,7.12281,0.366964 +-7.12253,0.54725,0.889047,1,1,0,8.36367,0.366964 +-7.2644,0.95606,0.889047,1,1,0,7.3526,0.388708 +-6.89937,1,0.889047,1,1,0,7.16097,0.322576 +-8.0571,0.463719,0.889047,2,3,0,10.3381,0.477258 +-7.00915,1,0.889047,1,1,0,7.72714,0.34666 +-7.89798,0.568935,0.889047,1,3,0,9.43765,0.0979348 +-6.79084,0.966557,0.889047,2,3,0,8.4252,0.287709 +-6.86899,0.961303,0.889047,1,3,0,7.02431,0.192117 +-6.75619,0.911123,0.889047,2,3,0,7.54363,0.234253 +-7.22842,0.926483,0.889047,2,3,0,7.38429,0.383486 +-6.81688,0.864037,0.889047,2,3,0,7.95871,0.298182 +-6.78377,0.986296,0.889047,1,3,0,6.90958,0.217612 +-7.34162,0.866461,0.889047,1,3,0,7.58599,0.399375 +-7.37202,0.996733,0.889047,2,3,0,7.54732,0.403396 +-7.37202,0.481076,0.889047,1,3,0,9.75355,0.403396 +-6.7548,1,0.889047,1,3,0,7.25399,0.264735 +-6.74888,1,0.889047,1,3,0,6.75338,0.255196 +-6.93956,0.957254,0.889047,2,3,0,7.04722,0.332111 +-6.92522,0.923946,0.889047,1,3,0,7.35992,0.180927 +-6.76476,0.998915,0.889047,1,3,0,6.89993,0.227607 +-6.99001,0.955801,0.889047,1,3,0,7.01378,0.170417 +-7.29651,0.942157,0.889047,2,3,0,7.63652,0.136382 +-7.10633,1,0.889047,2,3,0,7.29091,0.155279 +-7.92485,0.939732,0.889047,2,3,0,7.92576,0.464836 +-6.76137,1,0.889047,1,3,0,7.67405,0.270782 +-7.42171,0.78799,0.889047,2,3,0,8.10717,0.409776 +-7.24831,1,0.889047,1,1,0,7.48931,0.386394 +-7.24831,0.646362,0.889047,1,1,0,8.17173,0.386394 +-6.90119,1,0.889047,1,1,0,7.15147,0.32303 +-6.90119,0.938978,0.889047,1,1,0,7.06358,0.32303 +-6.77878,0.983224,0.889047,1,3,0,6.99929,0.219884 +-6.75638,1,0.889047,1,1,0,6.77344,0.234076 +-6.88052,0.984196,0.889047,2,3,0,6.8956,0.3177 +-6.88052,0.857559,0.889047,1,1,0,7.2319,0.3177 +-6.75435,0.987396,0.889047,2,3,0,6.95934,0.264231 +-6.97351,0.966915,0.889047,2,3,0,6.98548,0.172912 +-7.68321,0.835022,0.889047,1,3,0,8.41629,0.440206 +-7.13058,1,0.889047,1,1,0,7.55577,0.36829 +-6.74802,0.982359,0.889047,2,3,0,7.24403,0.250042 +-7.14045,0.902644,0.889047,1,3,0,7.28385,0.151459 +-7.19482,0.990759,0.889047,1,1,0,7.25695,0.145804 +-7.19482,0.981041,0.889047,1,1,0,7.34727,0.145804 +-7.44453,0.961043,0.889047,1,1,0,7.47196,0.124679 +-7.37846,0.874323,0.889047,1,3,0,8.83683,0.404235 +-7.37846,0.354147,0.889047,1,1,0,9.47415,0.404235 +-6.79334,1,0.889047,1,3,0,7.2181,0.288828 +-6.78105,0.988806,0.889047,1,3,0,6.87291,0.218824 +-8.17293,0.615406,0.889047,2,3,0,9.64936,0.085865 +-7.32349,0.984317,0.889047,2,3,0,8.55218,0.134091 +-12.2294,0.588365,0.889047,2,3,0,12.2559,0.0179125 +-6.9431,0.975079,0.889047,3,7,0,11.4377,0.177822 +-6.92721,0.980916,0.889047,2,3,0,7.19955,0.180573 +-6.84373,0.97578,0.889047,1,3,0,7.17395,0.307149 +-7.13759,0.872801,0.889047,1,3,0,7.5966,0.15177 +-7.33616,0.796833,0.889047,2,3,0,9.27642,0.133042 +-6.75091,1,0.889047,2,3,0,7.26716,0.240577 +-7.03372,0.812564,0.889047,2,3,0,7.92123,0.164277 +-7.17113,0.959384,0.889047,2,3,0,7.54769,0.148208 +-6.94905,1,0.889047,1,1,0,7.13429,0.176827 +-6.99444,0.991261,0.889047,1,1,0,7.0255,0.169765 +-7.21844,0.960395,0.889047,1,1,0,7.22704,0.143494 +-7.24831,0.9951,0.889047,1,1,0,7.33047,0.140681 +-6.97806,1,0.889047,2,3,0,7.20273,0.172213 +-7.42818,0.935768,0.889047,1,3,0,7.4294,0.125876 +-6.80379,1,0.889047,2,3,0,7.27587,0.293208 +-6.84444,0.996189,0.889047,2,3,0,6.85292,0.30737 +-7.40989,0.791866,0.889047,1,3,0,8.09021,0.12724 +-7.69253,0.96081,0.889047,1,1,0,7.7383,0.108736 +-8.04589,0.940301,0.889047,2,3,0,8.82333,0.0911513 +-8.92549,0.916868,0.889047,1,1,0,8.93396,0.061805 +-8.52083,1,0.889047,1,1,0,9.00678,0.0734246 +-7.90188,1,0.889047,1,1,0,8.48389,0.0977459 +-7.93686,0.995881,0.889047,1,1,0,8.11137,0.0960798 +-7.62548,1,0.889047,1,1,0,7.95988,0.112685 +-6.8188,1,0.889047,2,3,0,7.42759,0.298871 +-6.87494,0.984042,0.889047,1,1,0,6.88544,0.316197 +-6.75225,0.996003,0.889047,1,3,0,6.89499,0.238631 +-6.74825,0.999809,0.889047,1,3,0,6.75347,0.252654 +-6.76903,0.995131,0.889047,1,3,0,6.77186,0.276186 +-6.83871,0.967273,0.889047,2,3,0,6.96946,0.305571 +-6.84724,0.997556,0.889047,1,1,0,6.87048,0.308229 +-6.84724,0.860478,0.889047,1,3,0,7.48007,0.308229 +-7.32186,0.941311,0.889047,2,3,0,7.3219,0.396709 +-7.0362,1,0.889047,1,1,0,7.27823,0.351823 +-6.97018,0.897886,0.889047,1,3,0,7.58584,0.17343 +-6.79775,0.964142,0.889047,2,3,0,7.2987,0.290728 +-7.98583,0.653295,0.889047,1,3,0,8.99989,0.0938183 +-7.09108,0.89865,0.889047,1,3,0,9.26678,0.361655 +-6.93542,1,0.889047,1,1,0,7.07451,0.331175 +-6.79201,0.976807,0.889047,1,3,0,7.07049,0.214202 +-6.77372,1,0.889047,1,1,0,6.79041,0.222402 +-7.87059,0.831775,0.889047,2,3,0,8.30801,0.459539 +-6.75284,0.88659,0.889047,2,3,0,8.63085,0.262407 +-6.81471,0.914816,0.889047,2,3,0,7.27512,0.206304 +-6.92821,0.976101,0.889047,1,1,0,6.92872,0.180396 +-6.94636,0.99641,0.889047,1,1,0,6.98038,0.177274 +-6.76105,0.944006,0.889047,2,3,0,7.39997,0.270529 +-7.21732,0.867188,0.889047,1,3,0,7.50302,0.143601 +-7.5419,0.861341,0.889047,1,3,0,8.67781,0.424351 +-6.78276,1,0.889047,1,3,0,7.34627,0.283872 +-6.78276,0.709458,0.889047,2,3,0,8.1765,0.283872 +-7.04599,0.945896,0.889047,1,3,0,7.04803,0.353636 +-6.83256,1,0.889047,1,1,0,6.98626,0.303584 +-6.9689,0.921857,0.889047,2,7,0,7.27416,0.17363 +-6.74806,1,0.889047,2,3,0,6.9469,0.248849 +-6.74806,0.663605,0.889047,1,3,0,8.53768,0.248849 +-6.81421,0.983656,0.889047,1,3,0,6.83137,0.20646 +-6.82061,0.982613,0.889047,1,3,0,6.96738,0.299515 +-6.93541,0.929413,0.889047,2,3,0,7.21574,0.179137 +-6.83668,0.977436,0.889047,1,3,0,7.17331,0.304923 +-7.12345,0.877731,0.889047,1,3,0,7.55659,0.153334 +-6.78621,1,0.889047,2,3,0,7.04129,0.285557 +-6.98354,0.878697,0.889047,2,3,0,7.44702,0.171382 +-7.18588,0.953406,0.889047,2,3,0,7.51885,0.146701 +-7.08897,1,0.889047,1,1,0,7.21183,0.157315 +-7.99293,0.883552,0.889047,1,3,0,8.02554,0.093497 +-6.77122,0.921041,0.889047,1,3,0,8.4835,0.277545 +-6.77122,0.875424,0.889047,1,3,0,7.34275,0.277545 +-6.88647,0.950182,0.889047,2,3,0,7.07249,0.319273 +-6.79294,0.960021,0.889047,2,3,0,7.12452,0.288652 +-6.79294,0.394216,0.889047,2,7,0,10.136,0.288652 +-6.9248,0.94328,0.889047,1,3,0,7.12245,0.181003 +-7.61176,0.906176,0.889047,1,3,0,7.64684,0.113523 +-9.59492,0.881224,0.889047,2,3,0,9.59721,0.589266 +-8.39451,1,0.889047,2,3,0,9.56763,0.506315 +-10.1613,0.556913,0.889047,1,1,0,10.4762,0.621003 +-8.08833,1,0.889047,1,1,0,9.67422,0.480098 +-6.99405,0.874322,0.889047,1,3,0,8.84798,0.169821 +-6.98842,1,0.889047,1,1,0,7.0422,0.170653 +-7.07426,0.994716,0.889047,2,3,0,7.10316,0.159094 +-7.29406,0.963001,0.889047,1,1,0,7.31199,0.136594 +-6.9135,0.989803,0.889047,1,3,0,7.2244,0.183067 +-6.78458,0.963652,0.889047,2,3,0,7.22052,0.284771 +-7.80713,0.833289,0.889047,2,3,0,7.81473,0.102491 +-7.06112,0.974808,0.889047,1,3,0,7.69988,0.160726 +-7.9123,0.894468,0.889047,2,3,0,8.27591,0.0972452 +-7.13739,0.879469,0.889047,2,3,0,9.77302,0.151793 +-6.77675,0.997704,0.889047,1,3,0,7.09937,0.220862 +-7.18264,0.898055,0.889047,1,3,0,7.37435,0.376572 +-7.12822,0.816588,0.889047,1,3,0,8.12477,0.152802 +-7.72985,0.952714,0.889047,2,7,0,7.73444,0.445182 +-7.43453,1,0.889047,1,1,0,7.80018,0.411386 +-8.53383,0.693243,0.889047,1,1,0,8.62954,0.517393 +-7.09277,1,0.889047,1,1,0,8.07239,0.361945 +-6.94667,0.906497,0.889047,1,3,0,7.60971,0.177224 +-9.86211,0.54892,0.889047,1,3,0,11.0164,0.0425574 +-9.91467,0.997143,0.889047,1,1,0,10.2399,0.041707 +-11.1547,0.944478,0.889047,1,1,0,11.1724,0.0262976 +-11.8491,0.978594,0.889047,1,1,0,11.9963,0.0204947 +-11.169,1,0.889047,1,1,0,11.9795,0.0261616 +-10.9225,0.945886,0.889047,2,7,0,11.5269,0.658474 +-9.26374,1,0.889047,1,1,0,10.9722,0.568826 +-9.5577,0.907835,0.889047,1,1,0,10.332,0.587044 +-7.54849,1,0.889047,1,1,0,8.95843,0.425119 +-6.75314,0.918391,0.889047,2,3,0,8.07306,0.262787 +-6.82368,0.990244,0.889047,2,3,0,6.82656,0.203598 +-6.93136,0.972433,0.889047,2,3,0,7.08301,0.179842 +-6.89674,1,0.889047,1,1,0,6.94812,0.186284 +-8.39689,0.828004,0.889047,2,3,0,8.59364,0.0775536 +-8.42314,0.999161,0.889047,2,3,0,8.65329,0.0766534 +-6.74813,1,0.889047,2,3,0,8.08982,0.251856 +-6.8904,0.963415,0.889047,1,3,0,6.9389,0.187558 +-6.7666,0.941901,0.889047,2,3,0,7.447,0.274596 +-6.7666,0.793683,0.889047,1,3,0,7.74698,0.274596 +-7.01429,0.947222,0.889047,1,3,0,7.02118,0.347658 +-6.85994,1,0.889047,1,1,0,6.98009,0.311996 +-6.75404,0.989373,0.889047,2,3,0,6.92687,0.263883 +-6.81745,0.979422,0.889047,1,3,0,6.86489,0.205456 +-6.87674,0.970364,0.889047,1,3,0,7.05797,0.316686 +-6.77822,1,0.889047,1,1,0,6.84936,0.281526 +-6.92152,0.869921,0.889047,2,3,0,7.56338,0.181594 +-7.5088,0.955519,0.889047,2,3,0,7.51973,0.420448 +-7.20296,1,0.889047,1,1,0,7.50342,0.379681 +-7.54298,0.895893,0.889047,1,1,0,7.63275,0.424477 +-7.70756,0.946966,0.889047,1,1,0,7.92817,0.442818 +-6.82665,0.953329,0.889047,1,3,0,7.96596,0.202744 +-7.05124,0.956627,0.889047,2,3,0,7.22127,0.161983 +-7.05124,0.584224,0.889047,1,3,0,10.6736,0.161983 +-6.99971,1,0.889047,1,1,0,7.08036,0.168998 +-7.84303,0.889223,0.889047,1,3,0,7.88509,0.100652 +-6.84756,0.903765,0.889047,1,3,0,8.51607,0.308328 +-7.25635,0.884621,0.889047,1,1,0,7.25682,0.387553 +-6.83597,0.837658,0.889047,2,3,0,8.11776,0.304695 +-7.29497,0.826157,0.889047,1,3,0,7.86113,0.136515 +-6.76241,0.982003,0.889047,2,3,0,7.47384,0.271589 +-6.79663,0.984981,0.889047,1,3,0,6.85166,0.212439 +-6.76359,0.975924,0.889047,2,3,0,6.98914,0.272475 +-7.12054,0.891927,0.889047,1,3,0,7.36028,0.15366 +-7.65322,0.917985,0.889047,1,1,0,7.65322,0.111022 +-7.31177,1,0.889047,1,1,0,7.62836,0.135076 +-6.75385,0.93176,0.889047,2,3,0,8.0096,0.263655 +-6.7722,0.968926,0.889047,2,3,0,6.93969,0.223207 +-7.00314,0.956899,0.889047,1,3,0,7.02176,0.168505 +-6.82408,0.966691,0.889047,1,3,0,7.24562,0.300724 +-7.45538,0.898684,0.889047,2,3,0,7.45574,0.123895 +-8.2128,0.910215,0.889047,2,3,0,8.80863,0.0842968 +-6.90311,0.969236,0.889047,2,7,0,7.89057,0.323508 +-6.79386,1,0.889047,1,1,0,6.87352,0.289055 +-6.89092,0.954097,0.889047,1,3,0,7.06709,0.187453 +-6.90282,0.997569,0.889047,1,1,0,6.93112,0.185093 +-6.94239,0.955285,0.889047,1,3,0,7.2953,0.332747 +-7.28543,0.794728,0.889047,2,7,0,8.06636,0.137346 +-7.66606,0.934677,0.889047,2,3,0,8.21861,0.110267 +-6.87843,0.986229,0.889047,1,3,0,7.59039,0.190054 +-6.87814,1,0.889047,1,1,0,6.9073,0.190117 +-7.13932,0.917108,0.889047,1,3,0,7.53039,0.369715 +-6.85069,1,0.889047,2,3,0,7.06851,0.1964 +-6.76555,0.999256,0.889047,1,3,0,6.83283,0.227094 +-6.88302,0.774202,0.889047,2,3,0,8.4803,0.189082 +-6.81643,0.973234,0.889047,2,7,0,7.06186,0.298018 +-6.9007,0.976065,0.889047,1,1,0,6.90788,0.322909 +-7.08345,0.946336,0.889047,1,1,0,7.10255,0.360333 +-7.02916,1,0.889047,1,1,0,7.13881,0.3505 +-7.59296,0.687091,0.889047,2,3,0,9.16593,0.114688 +-6.99661,0.981373,0.889047,1,3,0,7.49807,0.169449 +-6.84486,0.987434,0.889047,2,3,0,7.14617,0.197853 +-7.62814,0.87467,0.889047,1,3,0,7.72473,0.112523 +-9.3574,0.8172,0.889047,1,3,0,9.46192,0.0518496 +-6.88568,0.909093,0.889047,1,3,0,11.1668,0.319066 +-6.77773,0.98426,0.889047,1,3,0,6.97911,0.220386 +-6.81333,0.99731,0.889047,2,3,0,6.81473,0.206735 +-6.82944,0.980708,0.889047,1,3,0,6.97991,0.302547 +-6.87395,0.92915,0.889047,2,3,0,7.22574,0.315928 +-6.91134,0.892859,0.889047,2,3,0,7.45671,0.325527 +-7.36506,0.869675,0.889047,1,1,0,7.37181,0.402482 +-6.74925,0.973703,0.889047,2,3,0,7.54295,0.243837 +-6.75043,0.970901,0.889047,2,3,0,6.92474,0.241384 +-6.81336,0.982774,0.889047,1,3,0,6.84061,0.296892 +-7.20185,0.819261,0.889047,2,3,0,7.79755,0.145109 +-7.99928,0.932455,0.889047,2,7,0,8.00142,0.471908 +-7.05387,0.848097,0.889047,1,3,0,8.92004,0.161646 +-9.35351,0.842703,0.889047,2,3,0,9.72668,0.574521 +-8.32978,1,0.889047,1,1,0,9.38346,0.501 +-8.32978,0.45634,0.889047,1,1,0,10.1698,0.501 +-8.32978,0.461378,0.889047,1,1,0,10.1492,0.501 +-8.20569,1,0.889047,2,7,0,8.21007,0.0845735 +-6.7818,1,0.889047,2,3,0,7.87793,0.283389 +-8.32482,0.581052,0.889047,1,3,0,9.56298,0.0801012 +-8.03149,1,0.889047,1,1,0,8.40004,0.0917803 +-7.37575,1,0.889047,1,1,0,7.94272,0.129864 +-7.05566,1,0.889047,1,1,0,7.3264,0.161419 +-6.89524,1,0.889047,1,1,0,7.0287,0.186582 +-7.24451,0.948514,0.889047,1,3,0,7.24634,0.141032 +-7.47828,0.964351,0.889047,1,1,0,7.51438,0.122273 +-6.9855,0.890548,0.889047,2,3,0,8.52309,0.341941 +-8.31903,0.832534,0.889047,2,3,0,8.31945,0.500105 +-6.85567,1,0.889047,2,7,0,7.88267,0.310753 +-6.85567,0.878674,0.889047,1,1,0,7.15637,0.310753 +-6.77764,1,0.889047,1,1,0,6.83447,0.281211 +-6.86099,0.991812,0.889047,2,3,0,6.86139,0.312299 +-6.81246,1,0.889047,1,1,0,6.85692,0.296556 +-7.65416,0.731894,0.889047,1,3,0,8.4431,0.110967 +-7.57485,1,0.889047,1,1,0,7.76205,0.11583 +-6.7962,0.99733,0.889047,1,3,0,7.55158,0.212599 +-6.77213,1,0.889047,1,1,0,6.79229,0.223247 +-6.78271,0.997547,0.889047,1,1,0,6.7862,0.218079 +-6.74804,0.940762,0.889047,2,3,0,7.22553,0.249339 +-7.66946,0.804247,0.889047,1,3,0,7.80323,0.438715 +-7.0072,1,0.889047,1,1,0,7.47532,0.346278 +-6.91039,1,0.889047,1,1,0,7.00862,0.325296 +-6.75772,0.99231,0.889047,1,3,0,6.95063,0.232867 +-7.38241,0.857134,0.889047,1,3,0,7.55083,0.404748 +-8.90946,0.601361,0.889047,1,1,0,8.96793,0.5451 +-7.32977,1,0.889047,2,3,0,8.56665,0.133569 +-7.0824,1,0.889047,1,1,0,7.30287,0.158103 +-7.51422,0.930816,0.889047,1,1,0,7.51517,0.119802 +-6.84115,0.990427,0.889047,1,3,0,7.44797,0.198806 +-6.96077,0.975526,0.889047,1,1,0,6.96304,0.174917 +-6.80204,0.997473,0.889047,1,3,0,6.92743,0.210489 +-8.39711,0.702155,0.889047,1,3,0,8.92528,0.077546 +-7.72791,1,0.889047,1,1,0,8.33388,0.106744 +-6.89672,0.99006,0.889047,2,7,0,7.52119,0.321908 +-6.86108,1,0.889047,1,1,0,6.91124,0.312325 +-6.86108,0.787965,0.889047,1,3,0,7.91285,0.312325 +-6.75348,0.995364,0.889047,1,3,0,6.88559,0.237088 +-6.75299,0.998646,0.889047,2,3,0,6.7655,0.262598 +-6.76731,0.998709,0.889047,2,3,0,6.76733,0.275071 +-6.79487,0.992523,0.889047,1,1,0,6.79626,0.289497 +-6.75935,1,0.889047,2,3,0,6.78599,0.231507 +-8.59013,0.741953,0.889047,2,3,0,8.64905,0.0712435 +-6.75249,0.889191,0.889047,2,7,0,9.25398,0.261935 +-6.80304,0.985341,0.889047,2,3,0,6.84969,0.292908 +-6.76433,1,0.889047,1,1,0,6.79286,0.273013 +-7.30649,0.841794,0.889047,1,3,0,7.66136,0.135526 +-6.75386,0.974765,0.889047,1,3,0,7.44648,0.263663 +-8.07344,0.736459,0.889047,1,3,0,8.19095,0.478749 +-7.90896,1,0.889047,2,3,0,8.36071,0.463297 +-8.6616,0.776202,0.889047,1,1,0,8.93053,0.52715 +-6.76692,0.917174,0.889047,2,3,0,9.29644,0.226237 +-7.54729,0.826172,0.889047,1,3,0,7.77798,0.42498 +-6.99643,0.875408,0.889047,1,3,0,8.26952,0.169474 +-6.81656,0.968693,0.889047,1,3,0,7.22128,0.298063 +-6.93502,0.926274,0.889047,2,3,0,7.22659,0.179203 +-7.76962,0.814274,0.889047,1,3,0,8.44774,0.449335 +-7.23208,0.751787,0.889047,1,3,0,9.12083,0.142195 +-9.66739,0.763635,0.889047,1,3,0,10.1922,0.0458886 +-10.0702,0.962578,0.889047,2,7,0,10.0706,0.616145 +-7.35887,1,0.889047,2,3,0,9.74553,0.131201 +-7.89415,0.927566,0.889047,1,1,0,7.90158,0.0981204 +-7.12231,0.986162,0.889047,2,3,0,8.16656,0.153462 +-7.12231,0.37233,0.889047,1,3,0,14.5152,0.153462 +-6.77408,0.972491,0.889047,1,3,0,7.28933,0.279235 +-6.77254,1,0.889047,1,1,0,6.77982,0.278338 +-6.77254,0.615402,0.889047,2,3,0,8.72588,0.278338 +-7.56714,0.769656,0.889047,1,3,0,8.13497,0.116322 +-6.82919,0.926697,0.889047,1,3,0,8.05706,0.302465 +-6.82919,0.703022,0.889047,1,3,0,7.93111,0.302465 +-7.31817,0.924221,0.889047,2,3,0,7.31817,0.134536 +-7.85712,0.9256,0.889047,1,1,0,7.8623,0.0999442 +-6.91901,0.994647,0.889047,2,3,0,7.92966,0.18205 +-6.78131,0.981941,0.889047,1,3,0,7.04211,0.28314 +-6.77546,0.986952,0.889047,2,3,0,6.86638,0.280015 +-7.16657,0.849606,0.889047,2,3,0,7.68146,0.374068 +-7.16657,0.451293,0.889047,1,1,0,8.7863,0.374068 +-6.97869,1,0.889047,1,1,0,7.14811,0.340544 +-7.00038,0.993436,0.889047,1,1,0,7.06262,0.344933 +-6.78409,1,0.889047,2,3,0,6.95765,0.217472 +-6.77171,0.992172,0.889047,2,3,0,6.84875,0.27784 +-6.77171,0.875742,0.889047,1,3,0,7.34199,0.27784 +-6.8906,0.884723,0.889047,2,3,0,7.46657,0.187517 +-6.78834,0.982102,0.889047,1,3,0,7.01912,0.286565 +-6.74916,0.998843,0.889047,1,3,0,6.7947,0.244079 +-6.80302,0.985624,0.889047,1,3,0,6.82281,0.292899 +-6.86847,0.981577,0.889047,1,1,0,6.87423,0.314415 +-7.22988,0.959325,0.889047,2,3,0,7.23324,0.383701 +-6.74964,0.985236,0.889047,2,3,0,7.33528,0.242924 +-6.74947,0.998701,0.889047,2,3,0,6.75853,0.256772 +-6.76162,0.996021,0.889047,1,3,0,6.77109,0.229771 +-6.8054,0.85812,0.889047,2,3,0,7.81339,0.209332 +-6.82503,0.99567,0.889047,1,1,0,6.8338,0.203207 +-6.78111,1,0.889047,1,1,0,6.81629,0.218797 +-6.749,0.999336,0.889047,2,3,0,6.78556,0.244505 +-6.83994,0.849333,0.889047,2,3,0,7.77035,0.199121 +-6.93666,0.98005,0.889047,1,1,0,6.94064,0.17892 +-8.46576,0.783522,0.889047,1,3,0,8.75969,0.0752218 +-8.72121,0.954583,0.889047,2,3,0,9.82104,0.0673464 +-9.73449,0.927894,0.889047,1,1,0,9.7505,0.0447074 +-7.78894,0.913039,0.889047,1,3,0,9.66188,0.103443 +-6.82864,0.908783,0.889047,2,7,0,8.38292,0.30228 +-6.91272,0.911107,0.889047,2,3,0,7.3232,0.32586 +-6.94592,0.990157,0.889047,1,1,0,6.98631,0.333532 +-6.92927,0.855788,0.889047,2,3,0,7.72,0.329766 +-6.88347,1,0.889047,1,1,0,6.94553,0.318484 +-6.91527,0.990677,0.889047,1,1,0,6.9473,0.326474 +-7.03193,0.965452,0.889047,1,1,0,7.06142,0.351022 +-7.53224,0.949762,0.889047,2,3,0,7.5615,0.42322 +-7.0277,1,0.889047,1,1,0,7.40033,0.350225 +-7.49173,0.758522,0.889047,1,3,0,8.63718,0.121337 +-7.05945,1,0.889047,1,1,0,7.41928,0.160937 +-6.96173,1,0.889047,1,1,0,7.06315,0.174764 +-6.94957,0.952087,0.889047,1,3,0,7.39972,0.334339 +-8.16387,0.846114,0.889047,2,3,0,8.16388,0.486831 +-8.79533,0.808467,0.889047,1,1,0,9.16068,0.536986 +-6.75675,0.890346,0.889047,2,3,0,9.61162,0.233731 +-6.76092,0.926709,0.889047,2,3,0,7.27701,0.230287 +-6.75796,0.997767,0.889047,2,3,0,6.7821,0.23266 +-6.74994,0.952325,0.889047,2,3,0,7.08723,0.242308 +-6.75465,0.998136,0.889047,1,3,0,6.76149,0.264572 +-8.37367,0.592681,0.889047,2,3,0,9.44101,0.0783621 +-8.51935,0.995433,0.889047,2,3,0,8.70304,0.0734719 +-6.76252,0.892856,0.889047,1,3,0,9.23187,0.271679 +-6.80275,0.981342,0.889047,2,3,0,6.88048,0.292791 +-6.80267,1,0.889047,1,1,0,6.8175,0.292759 +-6.9228,0.943477,0.889047,1,3,0,7.13815,0.181363 +-7.01806,0.981641,0.889047,1,1,0,7.03442,0.166405 +-6.93641,1,0.889047,1,1,0,7.02332,0.178963 +-6.84826,0.974558,0.889047,1,3,0,7.19529,0.308539 +-6.90801,0.982742,0.889047,1,1,0,6.92588,0.324717 +-6.79203,1,0.889047,1,1,0,6.87608,0.288247 +-6.85513,0.950483,0.889047,2,3,0,7.07212,0.195323 +-6.77494,0.999087,0.889047,1,3,0,6.83718,0.221771 +-6.77494,0.46528,0.889047,1,3,0,10.2318,0.221771 +-6.75737,0.99744,0.889047,2,3,0,6.79771,0.233174 +-6.74855,1,0.889047,2,3,0,6.75575,0.254059 +-7.1858,0.888159,0.889047,1,3,0,7.36825,0.146709 +-6.75186,0.92823,0.889047,2,3,0,7.86529,0.261058 +-6.95186,0.954851,0.889047,1,3,0,6.96932,0.33484 +-7.16764,0.978616,0.889047,2,3,0,7.19711,0.374235 +-6.79323,1,0.889047,1,3,0,7.06229,0.288781 +-7.15596,0.925306,0.889047,1,3,0,7.15865,0.372388 +-6.89854,1,0.889047,2,3,0,7.09113,0.322367 +-7.0041,0.968896,0.889047,1,1,0,7.03022,0.34567 +-6.74989,0.997746,0.889047,2,3,0,7.02776,0.242412 +-6.85634,0.972304,0.889047,1,3,0,6.89215,0.310948 +-6.772,1,0.889047,1,1,0,6.83301,0.278014 +-6.86984,0.902869,0.889047,2,3,0,7.35406,0.191928 +-7.8091,0.882733,0.889047,2,3,0,8.02408,0.102389 +-7.36831,1,0.889047,1,1,0,7.76396,0.13045 +-6.81188,1,0.889047,2,3,0,7.23067,0.296338 +-6.93463,0.965249,0.889047,1,1,0,6.93828,0.330994 +-6.83627,0.96179,0.889047,1,3,0,7.16962,0.20009 +-7.16912,0.950385,0.889047,1,3,0,7.17761,0.148416 +-8.12444,0.878979,0.889047,1,3,0,8.15151,0.0878288 +-8.22145,0.960118,0.889047,2,3,0,9.23926,0.0839621 +-8.3207,0.968164,0.889047,2,7,0,8.34122,0.500244 +-7.72804,1,0.889047,1,1,0,8.35007,0.444991 +-7.22618,1,0.889047,1,1,0,7.64603,0.383154 +-7.61217,0.619104,0.889047,1,3,0,9.24391,0.113497 +-6.95593,0.988908,0.889047,2,3,0,7.78312,0.175698 +-6.78294,0.997916,0.889047,1,3,0,6.92284,0.217974 +-6.75544,0.997654,0.889047,2,3,0,6.80285,0.234989 +-6.74889,0.999478,0.889047,1,3,0,6.75901,0.255244 +-7.08535,0.806095,0.889047,2,3,0,7.90082,0.157749 +-6.76062,0.999853,0.889047,1,3,0,7.06397,0.230515 +-6.78455,0.994377,0.889047,1,1,0,6.78472,0.217268 +-6.76104,1,0.889047,1,1,0,6.77923,0.230199 +-6.99294,0.961363,0.889047,2,3,0,7.06714,0.169984 +-7.05502,0.931963,0.889047,1,3,0,7.60929,0.355284 +-6.78275,0.97712,0.889047,1,3,0,7.1765,0.218061 +-6.81363,0.993035,0.889047,1,1,0,6.81627,0.20664 +-6.76967,1,0.889047,1,1,0,6.80365,0.224611 +-6.76967,0.933006,0.889047,1,3,0,7.10139,0.224611 +-6.74803,1,0.889047,2,3,0,6.76933,0.249486 +-9.88488,0.497667,0.889047,1,3,0,10.2485,0.605978 +-7.91942,1,0.889047,1,1,0,9.39417,0.464312 +-7.16839,1,0.889047,1,1,0,7.72277,0.374353 +-7.07256,0.843078,0.889047,1,3,0,7.98404,0.159303 +-8.57083,0.827871,0.889047,1,3,0,8.76223,0.0718422 +-6.74833,0.970563,0.889047,2,3,0,9.14638,0.253123 +-6.77315,0.948924,0.889047,2,3,0,7.04301,0.222702 +-6.75392,0.976543,0.889047,2,3,0,6.92869,0.263743 +-6.773,0.994958,0.889047,1,1,0,6.77301,0.278607 +-6.76568,1,0.889047,2,3,0,6.77426,0.273963 +-6.86805,0.962983,0.889047,1,3,0,6.97139,0.192329 +-6.75753,0.949812,0.889047,2,3,0,7.24472,0.267493 +-6.83037,0.9905,0.889047,2,3,0,6.83157,0.201697 +-6.77485,1,0.889047,2,3,0,6.81786,0.221815 +-6.81209,0.991531,0.889047,1,1,0,6.81299,0.207131 +-6.8005,0.8914,0.889047,2,3,0,7.62614,0.211033 +-8.05627,0.767016,0.889047,1,3,0,8.40107,0.090702 +-6.98707,0.974489,0.889047,1,3,0,7.96777,0.170853 +-7.46577,0.872608,0.889047,1,3,0,8.16282,0.415251 +-6.91952,1,0.889047,2,3,0,7.30184,0.327486 +-6.90293,1,0.889047,1,1,0,6.95504,0.323464 +-7.02304,0.988193,0.889047,2,3,0,7.04872,0.349339 +-7.98139,0.735637,0.889047,1,1,0,7.99065,0.470228 +-6.76668,0.997824,0.889047,1,3,0,7.98349,0.226389 +-7.92659,0.837318,0.889047,2,3,0,8.02314,0.0965644 +-8.54574,0.978715,0.889047,2,3,0,8.57691,0.0726304 +-6.74829,0.913991,0.889047,1,3,0,9.10627,0.252909 +-6.74882,0.999768,0.889047,1,3,0,6.74974,0.24503 +-6.78439,0.911591,0.889047,2,3,0,7.33284,0.21734 +-6.77176,0.995172,0.889047,2,3,0,6.83229,0.223444 +-6.74852,0.95074,0.889047,2,3,0,7.09236,0.246076 +-8.75006,0.707305,0.889047,2,3,0,8.78037,0.0665261 +-8.55064,1,0.889047,1,1,0,8.9131,0.0724757 +-8.01838,1,0.889047,2,3,0,8.54683,0.0923586 +-8.22745,0.977562,0.889047,1,1,0,8.35672,0.0837308 +-7.79567,0.974396,0.889047,2,3,0,8.97608,0.10309 +-8.45978,0.928073,0.889047,1,1,0,8.47799,0.0754204 +-7.85675,1,0.889047,1,1,0,8.42267,0.0999623 +-7.39138,1,0.889047,1,1,0,7.80797,0.128651 +-6.75225,1,0.889047,2,3,0,7.26878,0.261617 +-7.01972,0.738523,0.889047,2,3,0,8.47668,0.166176 +-6.85404,0.959992,0.889047,1,3,0,7.32628,0.310271 +-6.90265,0.905286,0.889047,2,3,0,7.37366,0.323396 +-6.76273,0.989878,0.889047,1,3,0,6.95819,0.228978 +-6.90748,0.959087,0.889047,1,3,0,6.99479,0.324587 +-6.89547,1,0.889047,1,1,0,6.94303,0.321592 +-7.07517,0.888852,0.889047,2,3,0,7.59494,0.158982 +-7.13568,0.989333,0.889047,1,1,0,7.18522,0.15198 +-6.941,1,0.889047,2,3,0,7.10512,0.178179 +-6.7806,0.993666,0.889047,2,3,0,7.00191,0.219034 +-6.90379,0.980301,0.889047,1,3,0,6.90528,0.184905 +-6.97885,0.971819,0.889047,2,3,0,7.22161,0.172093 +-6.78251,0.955732,0.889047,2,3,0,7.36525,0.283746 +-7.51771,0.846548,0.889047,1,3,0,7.54169,0.421507 +-6.79078,1,0.889047,1,3,0,7.32298,0.287683 +-7.20613,0.936276,0.889047,2,3,0,7.20859,0.144688 +-7.25538,0.997307,0.889047,2,3,0,7.32968,0.140034 +-7.32397,0.996371,0.889047,2,3,0,7.4004,0.134051 +-7.44946,0.981106,0.889047,1,1,0,7.52034,0.124321 +-9.604,0.878832,0.889047,2,3,0,9.6451,0.589806 +-7.36784,1,0.889047,1,1,0,8.88794,0.402848 +-6.79234,1,0.889047,1,3,0,7.21053,0.288386 +-6.74847,0.999371,0.889047,1,3,0,6.79535,0.246278 +-6.76067,0.950412,0.889047,2,3,0,7.06692,0.230476 +-6.7482,0.969331,0.889047,2,3,0,6.95362,0.252338 +-6.91529,0.965448,0.889047,2,3,0,6.99596,0.326478 +-7.24308,0.967606,0.889047,2,3,0,7.2559,0.385634 +-7.24308,0.543068,0.889047,1,1,0,8.49721,0.385634 +-7.04325,1,0.889047,1,1,0,7.23737,0.353131 +-6.74871,0.999337,0.889047,1,3,0,7.0331,0.245381 +-6.96356,0.741603,0.889047,2,3,0,8.54417,0.174472 +-6.77261,0.894238,0.889047,2,3,0,7.85216,0.222988 +-7.37024,0.860048,0.889047,1,3,0,7.58849,0.403162 +-7.37024,0.669804,0.889047,1,1,0,8.24731,0.403162 +-7.57938,0.933826,0.889047,1,1,0,7.73734,0.42868 +-7.84687,0.914893,0.889047,1,1,0,8.06539,0.457184 +-6.75653,0.955338,0.889047,2,3,0,8.17304,0.233936 +-8.17586,0.718936,0.889047,1,3,0,8.4497,0.487883 +-6.77564,1,0.889047,1,3,0,7.83661,0.280116 +-6.79628,0.994352,0.889047,1,1,0,6.80017,0.290103 +-7.07719,0.849944,0.889047,2,3,0,7.61314,0.158735 +-6.75493,1,0.889047,2,3,0,7.01439,0.264884 +-6.78126,0.995142,0.889047,1,3,0,6.78126,0.283112 +-7.11316,0.86209,0.889047,2,3,0,7.59943,0.365404 +-6.75966,0.990289,0.889047,1,3,0,7.15833,0.231264 +-6.74918,0.977891,0.889047,2,3,0,6.90881,0.256054 +-6.82871,0.981658,0.889047,1,3,0,6.83756,0.302304 +-6.90047,0.944755,0.889047,1,3,0,7.14516,0.18555 +-6.99042,0.982339,0.889047,1,1,0,7.00409,0.170357 +-7.21328,0.960479,0.889047,1,1,0,7.2216,0.143991 +-6.88948,0.958685,0.889047,1,3,0,7.67448,0.320055 +-6.87882,1,0.889047,1,1,0,6.92081,0.317245 +-7.2791,0.720117,0.889047,2,3,0,8.4684,0.390792 +-8.52269,0.662783,0.889047,1,1,0,8.57114,0.516524 +-8.19429,1,0.889047,1,1,0,8.82679,0.489491 +-8.99184,0.764756,0.889047,1,1,0,9.34731,0.550807 +-8.99756,0.998091,0.889047,1,1,0,9.72873,0.551199 +-7.09141,0.853805,0.889047,1,3,0,10.066,0.157025 +-7.33298,0.959963,0.889047,1,1,0,7.34986,0.133303 +-7.6634,0.952906,0.889047,1,1,0,7.69262,0.110423 +-7.6634,0.742538,0.889047,1,3,0,11.2034,0.110423 +-12.4665,0.648403,0.889047,2,3,0,12.5292,0.0164793 +-7.73643,1,0.889047,2,3,0,12.0879,0.106273 +-7.93798,0.975521,0.889047,1,1,0,8.03976,0.0960269 +-7.4774,1,0.889047,2,3,0,7.89946,0.122334 +-7.63403,0.978324,0.889047,1,1,0,7.71722,0.112168 +-6.79805,0.997593,0.889047,1,3,0,7.61709,0.211917 +-6.84362,0.989992,0.889047,1,1,0,6.84704,0.19817 +-6.79236,0.982036,0.889047,2,3,0,7.00633,0.288392 +-6.79236,0.789278,0.889047,1,3,0,7.80137,0.288392 +-6.79966,0.982541,0.889047,1,3,0,6.90616,0.211332 +-7.26587,0.882829,0.889047,1,3,0,7.53337,0.388917 +-7.14225,1,0.889047,1,1,0,7.32352,0.37019 +-7.75251,0.685201,0.889047,2,3,0,9.40926,0.105393 +-8.03156,0.96694,0.889047,1,1,0,8.11464,0.0917774 +-7.53282,1,0.889047,1,1,0,7.9891,0.118559 +-8.37802,0.899536,0.889047,1,1,0,8.37803,0.0782097 +-6.88114,1,0.889047,2,3,0,8.28275,0.189478 +-6.74982,0.995549,0.889047,1,3,0,6.90564,0.257541 +-7.67665,0.804631,0.889047,1,3,0,7.77979,0.439496 +-9.11172,0.617879,0.889047,1,1,0,9.25048,0.558901 +-7.13335,1,0.889047,2,3,0,8.87791,0.152236 +-6.99627,1,0.889047,1,1,0,7.12874,0.169498 +-6.75301,0.989129,0.889047,1,3,0,7.05697,0.262616 +-6.89773,0.978557,0.889047,2,3,0,6.90626,0.186088 +-7.02546,0.991722,0.889047,2,3,0,7.03353,0.165391 +-7.06702,0.99239,0.889047,1,1,0,7.1129,0.159988 +-6.90067,0.959668,0.889047,1,3,0,7.47928,0.322901 +-6.74803,0.996386,0.889047,2,3,0,6.92529,0.249458 +-6.75321,0.972378,0.889047,2,3,0,6.90963,0.237413 +-7.1075,0.914119,0.889047,1,3,0,7.20904,0.364453 +-7.10655,1,0.889047,1,1,0,7.21271,0.364293 +-7.13047,0.992541,0.889047,1,1,0,7.23181,0.368272 +-6.99557,1,0.889047,1,1,0,7.13928,0.343975 +-7.08617,0.972526,0.889047,1,1,0,7.14252,0.360805 +-6.74822,0.999895,0.889047,1,3,0,7.06467,0.247502 +-6.75678,0.962071,0.889047,2,3,0,6.97216,0.233708 +-6.89117,0.982807,0.889047,2,3,0,6.90819,0.320491 +-6.85682,1,0.889047,1,1,0,6.90507,0.31109 +-7.49671,0.765665,0.889047,1,3,0,8.28175,0.120994 +-7.07583,1,0.889047,1,1,0,7.42756,0.158902 +-6.77678,0.947593,0.889047,2,3,0,7.55689,0.280746 +-7.73406,0.803031,0.889047,1,3,0,7.77627,0.445625 +-6.76664,1,0.889047,1,3,0,7.51338,0.274621 +-6.77092,0.993024,0.889047,1,3,0,6.81603,0.223905 +-6.77023,1,0.889047,1,1,0,6.77593,0.224293 +-6.79501,0.994288,0.889047,1,1,0,6.79628,0.213047 +-6.76444,0.993621,0.889047,1,3,0,6.84279,0.273095 +-6.76444,0.885822,0.889047,1,3,0,7.17381,0.273095 +-6.89864,0.972294,0.889047,1,3,0,6.9005,0.322392 +-7.11602,0.936368,0.889047,1,1,0,7.13195,0.365883 +-6.77496,1,0.889047,2,3,0,7.08095,0.221762 +-6.79212,0.998685,0.889047,2,3,0,6.79514,0.214157 +-7.26341,0.753671,0.889047,2,3,0,8.54681,0.139305 +-7.1403,1,0.889047,1,1,0,7.28746,0.151475 +-6.93784,1,0.889047,1,1,0,7.10726,0.178717 +-7.08305,0.972746,0.889047,1,1,0,7.0942,0.158025 +-6.893,0.947559,0.889047,2,7,0,7.48944,0.320963 +-7.83951,0.629828,0.889047,2,7,0,9.03424,0.10083 +-7.43628,1,0.889047,1,1,0,7.81183,0.12528 +-6.80391,0.994936,0.889047,1,3,0,7.38984,0.20984 +-7.33026,0.741967,0.889047,2,3,0,8.68524,0.133528 +-7.19429,1,0.889047,2,3,0,7.35791,0.145857 +-7.31923,0.993284,0.889047,2,3,0,7.37157,0.134448 +-7.6679,0.95015,0.889047,1,1,0,7.69301,0.110159 +-7.2773,1,0.889047,2,3,0,7.62555,0.138063 +# +# Elapsed Time: 0.004 seconds (Warm-up) +# 0.01 seconds (Sampling) +# 0.014 seconds (Total) +# diff --git a/src/test/interface/example_output/bern4.csv b/src/test/interface/example_output/bern4.csv new file mode 100644 index 0000000000..0067fcc7e5 --- /dev/null +++ b/src/test/interface/example_output/bern4.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-10-17 18:13:44 UTC +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = false (Default) +# thin = 1 (Default) +# adapt +# engaged = true (Default) +# gamma = 0.05 (Default) +# delta = 0.8 (Default) +# kappa = 0.75 (Default) +# t0 = 10 (Default) +# init_buffer = 75 (Default) +# term_buffer = 50 (Default) +# window = 25 (Default) +# save_metric = false (Default) +# algorithm = hmc (Default) +# hmc +# engine = nuts (Default) +# nuts +# max_depth = 10 (Default) +# metric = diag_e (Default) +# metric_file = (Default) +# stepsize = 1 (Default) +# stepsize_jitter = 0 (Default) +# num_chains = 1 (Default) +# id = 4 +# data +# file = /Users/mitzi/.cmdstan/cmdstan-2.35.0/examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 86520 +# output +# file = /Users/mitzi/github/stan-dev/cmdstanpy/test_csv_files/bernoulli-20241017141344_4.csv +# diagnostic_file = (Default) +# refresh = 100 (Default) +# sig_figs = -1 (Default) +# profile_file = profile.csv (Default) +# save_cmdstan_config = false (Default) +# num_threads = 1 (Default) +# stanc_version = stanc3 v2.35.0 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +# Adaptation terminated +# Step size = 0.933117 +# Diagonal elements of inverse mass matrix: +# 0.524582 +-7.19125,0.977404,0.933117,1,1,0,7.22452,0.146161 +-9.45173,0.793941,0.933117,2,3,0,9.72516,0.0499428 +-8.92419,1,0.933117,1,1,0,9.52673,0.0618385 +-8.93603,0.999061,0.933117,1,1,0,9.22216,0.0615352 +-8.55245,1,0.933117,1,1,0,9.03101,0.0724187 +-7.16094,0.95946,0.933117,1,3,0,8.4516,0.149269 +-7.1408,1,0.933117,1,1,0,7.23097,0.151421 +-6.87906,0.985653,0.933117,2,3,0,7.32273,0.18992 +-6.81664,1,0.933117,1,1,0,6.87006,0.205706 +-6.93808,0.97414,0.933117,1,1,0,6.93857,0.178676 +-6.75356,0.921107,0.933117,2,3,0,7.74736,0.263303 +-7.82022,0.725402,0.933117,1,3,0,8.42332,0.101814 +-8.60618,0.91604,0.933117,1,1,0,8.6157,0.0707507 +-7.71085,1,0.933117,2,3,0,8.50309,0.107697 +-8.63147,0.898649,0.933117,1,1,0,8.63194,0.0699834 +-7.11515,0.963221,0.933117,1,3,0,8.55732,0.154269 +-6.75893,1,0.933117,1,3,0,7.0941,0.231848 +-6.75358,1,0.933117,1,1,0,6.7581,0.236981 +-6.77939,0.916345,0.933117,2,3,0,7.27015,0.219598 +-6.83251,0.978841,0.933117,1,3,0,6.92511,0.303567 +-6.8253,1,0.933117,1,1,0,6.85047,0.301144 +-6.74878,0.999235,0.933117,1,3,0,6.82827,0.24516 +-6.85892,0.971935,0.933117,1,3,0,6.88812,0.311702 +-6.74803,1,0.933117,1,3,0,6.85026,0.25032 +-6.75691,0.997795,0.933117,1,3,0,6.75868,0.266905 +-6.78541,0.992278,0.933117,1,1,0,6.78543,0.285171 +-6.74808,1,0.933117,1,3,0,6.78207,0.251337 +-7.5709,0.684017,0.933117,2,3,0,8.73765,0.116081 +-7.57445,0.999502,0.933117,1,1,0,7.72063,0.115856 +-7.57445,0.767103,0.933117,1,3,0,10.2913,0.115856 +-8.05272,0.940127,0.933117,1,1,0,8.08259,0.0908553 +-8.04874,1,0.933117,1,1,0,8.25851,0.0910278 +-8.14426,0.996478,0.933117,2,3,0,8.31698,0.0870183 +-6.80614,0.95643,0.933117,1,3,0,8.81381,0.294139 +-6.7998,1,0.933117,1,1,0,6.81726,0.291585 +-6.75334,0.99681,0.933117,1,3,0,6.81912,0.237262 +-6.84991,0.97333,0.933117,1,3,0,6.89428,0.309039 +-6.89173,0.995909,0.933117,2,3,0,6.91313,0.320635 +-7.7034,0.774606,0.933117,1,1,0,7.70347,0.442374 +-6.97824,1,0.933117,1,1,0,7.48091,0.34045 +-7.0315,0.983634,0.933117,1,1,0,7.08953,0.350941 +-6.74849,1,0.933117,1,3,0,6.99432,0.253826 +-6.81195,0.984939,0.933117,1,3,0,6.82015,0.296364 +-6.88843,0.948475,0.933117,2,3,0,7.12896,0.18796 +-6.82169,0.9883,0.933117,2,3,0,7.01835,0.204182 +-6.89473,0.984293,0.933117,1,1,0,6.89896,0.186685 +-6.84981,0.985752,0.933117,2,3,0,7.06269,0.196617 +-7.28699,0.935469,0.933117,1,3,0,7.30327,0.13721 +-7.14954,1,0.933117,1,1,0,7.30807,0.150478 +-6.77607,0.969897,0.933117,1,3,0,7.32008,0.280352 +-7.58257,0.69529,0.933117,2,3,0,8.54576,0.115341 +-6.93176,0.984094,0.933117,1,3,0,7.48651,0.179771 +-7.35437,0.938206,0.933117,1,3,0,7.35656,0.131562 +-6.7821,0.943412,0.933117,2,3,0,7.95872,0.283539 +-7.88749,0.686465,0.933117,1,3,0,8.72044,0.0984446 +-7.11785,0.971651,0.933117,1,3,0,7.7736,0.153964 +-7.41504,0.940215,0.933117,2,3,0,7.8714,0.126853 +-7.04176,1,0.933117,1,1,0,7.35206,0.163215 +-6.75311,0.999616,0.933117,2,3,0,7.03597,0.237539 +-6.76609,0.996817,0.933117,1,1,0,6.76611,0.226752 +-6.78364,0.991039,0.933117,1,3,0,6.83171,0.28431 +-6.82066,0.960819,0.933117,2,3,0,7.00448,0.204488 +-6.77137,0.96968,0.933117,2,3,0,7.04366,0.27764 +-6.90766,0.972238,0.933117,1,3,0,6.90806,0.32463 +-7.19302,0.853927,0.933117,1,3,0,7.80684,0.145984 +-7.10234,1,0.933117,1,1,0,7.22483,0.155742 +-7.13668,0.993893,0.933117,1,1,0,7.1993,0.15187 +-7.05292,1,0.933117,1,1,0,7.1627,0.161768 +-6.8125,0.965572,0.933117,1,3,0,7.28046,0.296572 +-6.80571,1,0.933117,1,1,0,6.82507,0.293969 +-6.80571,0.779303,0.933117,1,3,0,7.85824,0.293969 +-6.93783,0.90796,0.933117,2,3,0,7.30027,0.178719 +-6.89291,1,0.933117,1,1,0,6.94995,0.18705 +-6.96458,0.995175,0.933117,2,3,0,6.9807,0.17431 +-7.18668,0.959288,0.933117,1,1,0,7.19323,0.14662 +-6.88368,0.935101,0.933117,2,7,0,7.60728,0.31854 +-6.74888,1,0.933117,1,3,0,6.86436,0.255213 +-6.93035,0.957327,0.933117,1,3,0,6.95293,0.330015 +-7.06914,0.958101,0.933117,1,1,0,7.1016,0.357817 +-7.06914,0.398363,0.933117,1,3,0,10.0727,0.357817 +-6.82683,1,0.933117,2,3,0,6.99859,0.301669 +-6.8658,0.988703,0.933117,1,1,0,6.88108,0.313666 +-7.49139,0.626586,0.933117,2,3,0,9.33363,0.121361 +-7.03581,0.98207,0.933117,2,3,0,7.78635,0.163999 +-6.80124,0.996731,0.933117,1,3,0,6.99067,0.21077 +-7.98529,0.780883,0.933117,1,3,0,8.28054,0.0938428 +-8.27429,0.968605,0.933117,1,1,0,8.3809,0.0819565 +-7.99174,1,0.933117,1,1,0,8.35213,0.0935507 +-7.58639,1,0.933117,1,1,0,7.98186,0.1151 +-7.83178,0.967934,0.933117,1,1,0,7.90789,0.101223 +-6.91683,0.98356,0.933117,1,3,0,7.74348,0.182449 +-7.13303,0.958913,0.933117,1,1,0,7.13585,0.152271 +-6.7501,0.986391,0.933117,1,3,0,7.19692,0.258121 +-6.79659,0.989619,0.933117,1,3,0,6.79946,0.290237 +-6.87598,0.992465,0.933117,2,3,0,6.87965,0.316479 +-6.75771,1,0.933117,1,3,0,6.84657,0.267664 +-6.75354,1,0.933117,1,1,0,6.75733,0.263278 +-7.1939,0.771995,0.933117,2,3,0,8.07772,0.145897 +-8.59743,0.837543,0.933117,1,3,0,8.70501,0.0710188 +-7.77913,1,0.933117,2,3,0,8.51056,0.103962 +-7.48771,1,0.933117,2,3,0,7.79356,0.121615 +-7.02069,0.925109,0.933117,1,3,0,8.30293,0.348891 +-6.92401,1,0.933117,1,1,0,7.02659,0.328544 +-6.80706,1,0.933117,1,1,0,6.89338,0.294497 +-7.80667,0.794859,0.933117,1,3,0,7.82487,0.453135 +-7.73062,1,0.933117,1,1,0,8.08247,0.445263 +-8.30943,0.820875,0.933117,1,1,0,8.54733,0.499304 +-7.2406,1,0.933117,1,1,0,8.00413,0.385272 +-7.2406,0.586377,0.933117,1,3,0,9.0162,0.385272 +-7.70184,0.858345,0.933117,1,1,0,7.79501,0.442207 +-7.32262,0.709535,0.933117,1,3,0,9.21549,0.134163 +-7.27355,1,0.933117,1,1,0,7.40145,0.138395 +-6.98534,1,0.933117,1,1,0,7.22419,0.171113 +-6.828,1,0.933117,1,1,0,6.95211,0.202361 +-6.85723,0.975218,0.933117,1,3,0,7.04068,0.311209 +-6.74813,1,0.933117,1,3,0,6.84625,0.251841 +-7.29817,0.914403,0.933117,2,3,0,7.34676,0.136239 +-7.40368,0.957216,0.933117,2,3,0,8.00146,0.12771 +-7.35058,0.967974,0.933117,2,3,0,8.03124,0.131867 +-7.65489,0.95609,0.933117,1,1,0,7.6921,0.110923 +-6.83239,1,0.933117,2,3,0,7.4486,0.303528 +-7.30087,0.812872,0.933117,2,3,0,7.84635,0.136006 +-6.74976,0.979754,0.933117,1,3,0,7.39728,0.257417 +-6.91659,0.859144,0.933117,2,3,0,7.55486,0.182493 +-6.91659,0.951617,0.933117,1,1,0,7.12481,0.182493 +-6.86416,1,0.933117,1,1,0,6.92002,0.193209 +-7.03841,0.937571,0.933117,1,3,0,7.35748,0.352235 +-6.75984,0.991068,0.933117,1,3,0,7.08025,0.231121 +-6.75984,0.645056,0.933117,1,3,0,8.73903,0.231121 +-6.7499,0.956089,0.933117,2,3,0,7.05974,0.242387 +-6.7503,0.999899,0.933117,1,1,0,6.75069,0.24162 +-6.7503,0.70192,0.933117,1,3,0,8.08078,0.24162 +-7.60414,0.677245,0.933117,2,3,0,8.85518,0.113992 +-7.54851,1,0.933117,1,1,0,7.72155,0.117527 +-6.84863,0.963272,0.933117,1,3,0,8.05296,0.308651 +-6.78143,1,0.933117,2,3,0,6.83119,0.283199 +-8.49587,0.670917,0.933117,1,3,0,8.57084,0.514422 +-7.09706,1,0.933117,1,1,0,8.04437,0.36268 +-7.09706,0.720654,0.933117,1,1,0,7.78724,0.36268 +-6.76347,0.949218,0.933117,2,3,0,7.40942,0.27239 +-6.88438,0.886922,0.933117,2,3,0,7.43877,0.188798 +-6.92464,0.960388,0.933117,1,3,0,7.2299,0.328691 +-6.97795,0.98388,0.933117,1,1,0,7.01964,0.340389 +-7.19254,0.934778,0.933117,1,1,0,7.23088,0.378096 +-6.74881,0.980864,0.933117,2,3,0,7.31831,0.245067 +-6.76623,0.995059,0.933117,1,3,0,6.77427,0.274345 +-6.93115,0.965115,0.933117,1,3,0,6.93343,0.330199 +-6.93115,0.783772,0.933117,1,3,0,8.03727,0.330199 +-6.82259,1,0.933117,1,1,0,6.90635,0.300209 +-6.82259,0.629836,0.933117,1,3,0,8.23658,0.300209 +-6.82259,0.630547,0.933117,1,3,0,8.23311,0.300209 +-9.24563,0.60648,0.933117,2,7,0,9.2472,0.0542242 +-8.21573,1,0.933117,1,1,0,9.15537,0.0841833 +-8.70424,0.953583,0.933117,1,1,0,8.78147,0.067835 +-7.44964,0.943444,0.933117,1,3,0,8.57218,0.124309 +-7.83827,0.94752,0.933117,1,1,0,7.87124,0.100893 +-6.86008,0.988185,0.933117,2,7,0,7.59135,0.312037 +-6.88468,0.992751,0.933117,1,1,0,6.91174,0.318802 +-7.679,0.779402,0.933117,1,1,0,7.679,0.43975 +-6.90976,1,0.933117,1,1,0,7.43698,0.325142 +-6.94589,0.989128,0.933117,1,1,0,6.9858,0.333525 +-6.90556,1,0.933117,1,1,0,6.97167,0.324114 +-6.83344,0.965944,0.933117,1,3,0,7.11969,0.200851 +-6.87479,0.971529,0.933117,1,3,0,7.07549,0.316157 +-9.64396,0.555939,0.933117,2,7,0,9.66064,0.0463097 +-7.61387,0.996005,0.933117,2,3,0,9.84169,0.113393 +-7.12985,1,0.933117,1,1,0,7.53615,0.152622 +-6.96589,1,0.933117,1,1,0,7.11202,0.174103 +-6.77913,0.998219,0.933117,1,3,0,6.93102,0.219716 +-6.86985,0.985295,0.933117,1,3,0,6.86999,0.191925 +-6.98324,0.96753,0.933117,2,3,0,7.19922,0.171428 +-6.92692,1,0.933117,1,1,0,6.99729,0.180625 +-6.75033,0.993617,0.933117,1,3,0,6.95762,0.25855 +-6.92511,0.822003,0.933117,2,3,0,7.88114,0.180947 +-7.92728,0.923474,0.933117,2,3,0,8.02545,0.46507 +-7.75073,1,0.933117,1,1,0,8.16107,0.447372 +-7.75219,0.999506,0.933117,1,1,0,8.07223,0.447524 +-6.78014,0.989084,0.933117,1,3,0,7.82099,0.219246 +-6.77123,0.909161,0.933117,2,3,0,7.40196,0.223735 +-6.99906,0.956868,0.933117,1,3,0,7.01652,0.169092 +-6.79783,0.991442,0.933117,2,3,0,7.08638,0.211999 +-6.97664,0.985187,0.933117,2,3,0,6.97985,0.340118 +-6.96079,0.907698,0.933117,1,3,0,7.47091,0.174915 +-7.82798,0.886127,0.933117,1,3,0,7.88252,0.101416 +-7.04294,0.911733,0.933117,1,3,0,8.87464,0.353074 +-8.05048,0.719327,0.933117,1,1,0,8.0635,0.476651 +-7.1318,1,0.933117,2,3,0,7.78077,0.368491 +-7.1318,0.689805,0.933117,1,1,0,7.90671,0.368491 +-6.79734,0.893289,0.933117,2,3,0,7.69778,0.290556 +-6.79814,0.971585,0.933117,2,3,0,6.96237,0.290893 +-7.7692,0.708843,0.933117,1,3,0,8.57591,0.104493 +-7.25711,1,0.933117,1,1,0,7.69677,0.139875 +-7.03349,1,0.933117,1,1,0,7.23089,0.164308 +-8.07192,0.927692,0.933117,2,3,0,8.11306,0.47861 +-6.84405,0.955864,0.933117,1,3,0,8.34385,0.19806 +-6.83499,1,0.933117,1,1,0,6.85985,0.200434 +-6.77887,1,0.933117,2,3,0,6.8225,0.21984 +-7.82781,0.64836,0.933117,2,3,0,9.30466,0.101425 +-8.038,0.991714,0.933117,2,3,0,8.15035,0.0914954 +-6.77826,1,0.933117,2,3,0,7.74737,0.281545 +-6.75154,0.998024,0.933117,1,3,0,6.79086,0.23961 +-6.7898,0.904615,0.933117,2,3,0,7.39236,0.215079 +-7.2452,0.885748,0.933117,1,3,0,7.47444,0.385942 +-6.83395,1,0.933117,2,3,0,7.12073,0.304038 +-9.15221,0.651739,0.933117,2,7,0,9.15411,0.0563112 +-8.8737,1,0.933117,1,1,0,9.31372,0.0631531 +-9.40821,0.961029,0.933117,1,1,0,9.51708,0.0508118 +-7.51917,0.930382,0.933117,1,3,0,9.33442,0.119469 +-7.26798,1,0.933117,1,1,0,7.51752,0.138893 +-7.00258,0.849218,0.933117,2,3,0,8.95661,0.168585 +-6.75051,1,0.933117,2,3,0,6.9614,0.258879 +-6.75051,0.834623,0.933117,1,3,0,7.37684,0.258879 +-6.83648,0.895579,0.933117,2,3,0,7.39252,0.200034 +-6.78838,0.977454,0.933117,2,3,0,7.02247,0.286582 +-6.98348,0.925967,0.933117,1,3,0,7.20349,0.171392 +-6.74899,1,0.933117,2,3,0,6.95006,0.255536 +-7.38122,0.901171,0.933117,2,3,0,7.42517,0.129437 +-6.97718,0.912586,0.933117,2,3,0,8.09347,0.340231 +-6.96615,1,0.933117,2,3,0,7.03526,0.337918 +-6.85542,1,0.933117,2,3,0,6.9479,0.310681 +-7.69182,0.829598,0.933117,1,3,0,7.69329,0.441133 +-7.61863,1,0.933117,1,1,0,7.93129,0.433114 +-8.24327,0.808646,0.933117,1,1,0,8.43998,0.493714 +-6.85132,1,0.933117,1,3,0,7.81949,0.309463 +-7.13925,0.916371,0.933117,1,1,0,7.14305,0.369704 +-7.54563,0.875671,0.933117,1,1,0,7.61333,0.424787 +-8.89796,0.631265,0.933117,1,1,0,9.0141,0.544293 +-9.42176,0.838032,0.933117,1,1,0,10.0556,0.578771 +-9.28879,1,0.933117,2,7,0,9.28889,0.0532919 +-7.1176,0.966271,0.933117,1,3,0,9.3771,0.153992 +-7.47237,0.934777,0.933117,2,3,0,7.92606,0.122688 +-7.17198,1,0.933117,1,1,0,7.44238,0.148121 +-7.57292,0.937744,0.933117,1,1,0,7.58091,0.115953 +-7.42685,1,0.933117,1,1,0,7.63322,0.125974 +-6.80639,0.996046,0.933117,1,3,0,7.37138,0.208996 +-6.82245,0.9964,0.933117,1,1,0,6.83242,0.20396 +-7.66093,0.811821,0.933117,1,3,0,8.05099,0.437786 +-7.7015,0.986394,0.933117,1,1,0,7.98495,0.442171 +-7.7015,0.35367,0.933117,1,1,0,9.80577,0.442171 +-6.82624,1,0.933117,2,3,0,7.67656,0.20286 +-7.12495,0.954712,0.933117,1,3,0,7.13129,0.153166 +-6.83011,0.989492,0.933117,2,3,0,7.24395,0.201769 +-6.75342,0.94673,0.933117,2,3,0,7.20386,0.263139 +-6.81703,0.986338,0.933117,1,3,0,6.81894,0.298234 +-6.81703,0.838409,0.933117,1,3,0,7.36702,0.298234 +-7.39894,0.625409,0.933117,2,3,0,9.27824,0.128071 +-6.92436,0.947628,0.933117,1,3,0,7.99343,0.328625 +-6.87926,1,0.933117,1,1,0,6.94029,0.317365 +-6.87926,0.413668,0.933117,1,3,0,9.98927,0.317365 +-6.7579,0.983085,0.933117,2,3,0,6.98457,0.267841 +-6.76694,0.994486,0.933117,1,3,0,6.79461,0.226225 +-6.81834,0.991527,0.933117,1,3,0,6.81835,0.205185 +-7.23789,0.931586,0.933117,1,3,0,7.2627,0.141649 +-7.70753,0.930549,0.933117,1,1,0,7.71429,0.107884 +-6.79065,1,0.933117,1,3,0,7.7023,0.21474 +-6.76812,0.988145,0.933117,2,3,0,6.88791,0.275602 +-6.75874,1,0.933117,1,1,0,6.7669,0.268588 +-6.83669,0.989754,0.933117,2,3,0,6.83813,0.199979 +-6.83669,0.767729,0.933117,1,3,0,8.19836,0.199979 +-6.80699,0.986261,0.933117,1,3,0,6.97416,0.294471 +-6.80554,1,0.933117,1,1,0,6.82211,0.293902 +-6.90578,0.949554,0.933117,1,3,0,7.10823,0.184523 +-7.1507,0.953362,0.933117,1,1,0,7.15152,0.150355 +-6.79835,0.993109,0.933117,2,3,0,7.21842,0.211807 +-6.74965,1,0.933117,1,3,0,6.79201,0.242918 +-7.03017,0.934467,0.933117,1,3,0,7.10018,0.164754 +-7.25992,0.959743,0.933117,1,1,0,7.27253,0.13962 +-7.13248,1,0.933117,2,3,0,7.28208,0.152331 +-7.5683,0.931253,0.933117,1,1,0,7.57155,0.116248 +-6.86519,0.917946,0.933117,1,3,0,8.1199,0.313493 +-6.79937,1,0.933117,1,1,0,6.85149,0.291406 +-6.75876,1,0.933117,1,1,0,6.78825,0.268609 +-6.77822,0.998239,0.933117,2,3,0,6.77873,0.281522 +-6.78894,0.98522,0.933117,2,3,0,6.87315,0.215426 +-7.09168,0.918098,0.933117,1,3,0,7.28341,0.361758 +-6.84117,1,0.933117,1,1,0,7.01978,0.306351 +-7.53055,0.7338,0.933117,2,3,0,8.29671,0.118709 +-7.38713,1,0.933117,1,1,0,7.58612,0.128978 +-7.02111,1,0.933117,1,1,0,7.32388,0.165985 +-8.37483,0.74534,0.933117,1,3,0,9.33213,0.504711 +-6.90697,1,0.933117,2,7,0,7.90796,0.324462 +-7.96279,0.822144,0.933117,2,7,0,7.96493,0.0948721 +-7.60593,1,0.933117,2,3,0,7.97024,0.113882 +-7.53768,1,0.933117,1,1,0,7.71596,0.118237 +-6.99923,0.89125,0.933117,2,3,0,8.50305,0.344706 +-6.90297,1,0.933117,1,1,0,6.99941,0.323475 +-6.90297,0.812913,0.933117,1,1,0,7.35659,0.323475 +-7.74615,0.766074,0.933117,1,1,0,7.74639,0.446893 +-7.70636,1,0.933117,1,1,0,8.03162,0.44269 +-7.27951,1,0.933117,1,1,0,7.67293,0.390851 +-6.97352,0.892677,0.933117,1,3,0,7.88028,0.172911 +-6.89467,1,0.933117,1,1,0,6.97271,0.186697 +-6.89336,1,0.933117,1,1,0,6.92669,0.18696 +-6.80381,0.990138,0.933117,2,3,0,6.99744,0.209875 +-6.7497,0.997745,0.933117,1,3,0,6.81572,0.257285 +-6.87709,0.970401,0.933117,1,3,0,6.88998,0.31678 +-7.4139,0.759722,0.933117,1,3,0,8.15433,0.126939 +-7.61233,0.971541,0.933117,1,1,0,7.67901,0.113488 +-7.90565,0.962533,0.933117,1,1,0,7.9734,0.0975643 +-8.26174,0.960547,0.933117,1,1,0,8.34393,0.0824269 +-6.85132,0.997803,0.933117,1,3,0,8.29201,0.196246 +-6.77983,1,0.933117,1,1,0,6.83505,0.219388 +-6.97609,0.943547,0.933117,1,3,0,7.1174,0.340004 +-6.77811,1,0.933117,1,3,0,6.92011,0.281466 +-7.46272,0.794911,0.933117,1,3,0,7.96392,0.123371 +-7.93938,0.979037,0.933117,2,3,0,7.96087,0.0959612 +-6.76637,1,0.933117,2,3,0,7.78706,0.226578 +-7.98277,0.749097,0.933117,1,3,0,8.26209,0.470358 +-6.76423,0.7994,0.933117,2,3,0,9.10142,0.272939 +-6.86244,0.908202,0.933117,2,3,0,7.26328,0.193605 +-6.86244,0.78127,0.933117,1,3,0,8.22704,0.193605 +-8.08977,0.873699,0.933117,2,3,0,8.35961,0.480228 +-7.72655,1,0.933117,1,1,0,8.22737,0.444833 +-7.1295,1,0.933117,1,1,0,7.58131,0.368113 +-6.92629,1,0.933117,2,3,0,7.09173,0.329076 +-7.05372,0.961551,0.933117,1,1,0,7.08627,0.355048 +-8.36575,0.649479,0.933117,1,1,0,8.37333,0.503967 +-7.09335,1,0.933117,2,3,0,8.13009,0.156795 +-7.18227,0.984398,0.933117,1,1,0,7.22898,0.147067 +-6.7848,0.997695,0.933117,1,3,0,7.13487,0.217163 +-6.76209,0.994798,0.933117,1,3,0,6.82304,0.271347 +-6.89784,0.949098,0.933117,2,3,0,7.06988,0.322192 +-7.50744,0.826107,0.933117,1,1,0,7.50961,0.420286 +-9.58786,0.493466,0.933117,1,1,0,9.65509,0.588846 +-7.39143,1,0.933117,2,3,0,8.88319,0.405915 +-7.39143,0.264695,0.933117,1,1,0,10.0164,0.405915 +-7.25434,1,0.933117,1,1,0,7.4801,0.387265 +-7.10926,1,0.933117,1,1,0,7.29369,0.364751 +-6.74936,0.999758,0.933117,1,3,0,7.09361,0.243569 +-6.92651,0.788119,0.933117,2,3,0,8.19055,0.180698 +-7.01911,0.941788,0.933117,1,3,0,7.43474,0.348587 +-7.5074,0.854747,0.933117,1,1,0,7.5365,0.420281 +-7.15382,1,0.933117,1,1,0,7.46866,0.372047 +-7.43994,0.910992,0.933117,1,1,0,7.52341,0.412061 +-7.37982,1,0.933117,1,1,0,7.60628,0.404412 +-7.18361,1,0.933117,2,3,0,7.41894,0.376722 +-6.87111,1,0.933117,2,3,0,7.09398,0.315146 +-9.03942,0.641181,0.933117,2,7,0,9.04428,0.0589647 +-6.80386,1,0.933117,2,3,0,8.51455,0.293235 +-6.89043,0.937942,0.933117,2,3,0,7.17612,0.187551 +-7.2502,0.94643,0.933117,1,3,0,7.25242,0.140508 +-6.78554,0.960287,0.933117,1,3,0,7.47892,0.285234 +-8.31692,0.562352,0.933117,1,3,0,9.53213,0.0803872 +-8.31063,1,0.933117,1,1,0,8.54967,0.0806161 +-6.80621,0.8775,0.933117,2,7,0,9.06898,0.294167 +-6.97497,0.951728,0.933117,1,1,0,6.97632,0.339771 +-6.74817,0.992776,0.933117,2,3,0,7.02275,0.247843 +-6.84054,0.9831,0.933117,2,3,0,6.87325,0.30615 +-6.96558,0.921468,0.933117,1,3,0,7.27357,0.174153 +-6.91115,1,0.933117,2,3,0,6.97736,0.183506 +-6.75956,0.996545,0.933117,2,3,0,6.93805,0.231343 +-6.767,0.9982,0.933117,1,1,0,6.76842,0.22619 +-6.76386,0.994668,0.933117,2,3,0,6.81183,0.272677 +-7.64911,0.812998,0.933117,1,3,0,7.69952,0.436491 +-6.75742,0.964716,0.933117,2,3,0,7.90596,0.233125 +-6.88305,0.803959,0.933117,2,3,0,8.15976,0.189075 +-7.01944,0.972815,0.933117,1,1,0,7.02527,0.166214 +-6.89346,1,0.933117,1,1,0,7.00242,0.186938 +-6.75241,0.927583,0.933117,2,3,0,7.57454,0.261829 +-6.74852,1,0.933117,2,3,0,6.7516,0.246086 +-6.79397,0.911626,0.933117,2,3,0,7.31823,0.213443 +-6.76556,0.993477,0.933117,1,3,0,6.84175,0.273882 +-6.96212,0.971321,0.933117,2,3,0,6.96685,0.174702 +-6.77515,0.998456,0.933117,1,3,0,6.92853,0.221665 +-6.75151,0.999944,0.933117,1,3,0,6.76995,0.239655 +-6.9465,0.950302,0.933117,1,3,0,7.00625,0.333661 +-7.12179,0.735312,0.933117,2,3,0,8.38741,0.366842 +-6.90188,0.929147,0.933117,1,3,0,7.53057,0.185275 +-7.3009,0.96806,0.933117,2,3,0,7.3032,0.393836 +-6.93969,1,0.933117,1,1,0,7.20512,0.332141 +-7.69035,0.787341,0.933117,1,1,0,7.69457,0.440975 +-6.96651,1,0.933117,2,3,0,7.46703,0.337995 +-6.89036,0.858661,0.933117,2,3,0,7.69761,0.320282 +-6.89036,0.787713,0.933117,1,1,0,7.41172,0.320282 +-7.26562,0.890332,0.933117,1,1,0,7.27265,0.388881 +-7.24589,1,0.933117,1,1,0,7.40797,0.386042 +-7.22115,1,0.933117,2,3,0,7.37776,0.382409 +-6.7501,0.983298,0.933117,2,3,0,7.33661,0.242002 +-7.68736,0.785264,0.933117,1,3,0,8.04628,0.109032 +-7.65286,1,0.933117,1,1,0,7.8292,0.111044 +-7.2146,1,0.933117,2,3,0,7.59234,0.143864 +-7.21563,0.999826,0.933117,1,1,0,7.3079,0.143764 +-6.94775,0.982156,0.933117,2,3,0,7.46871,0.177042 +-6.88363,1,0.933117,2,3,0,6.95041,0.188953 +-7.19186,0.953461,0.933117,1,3,0,7.19249,0.1461 +-7.38536,0.968853,0.933117,1,1,0,7.42405,0.129116 +-7.79747,0.942856,0.933117,1,1,0,7.82122,0.102995 +-7.40149,1,0.933117,1,1,0,7.76872,0.127877 +-7.01121,1,0.933117,1,1,0,7.33266,0.16736 +-7.38633,0.935518,0.933117,1,1,0,7.3871,0.12904 +-7.63455,0.964354,0.933117,1,1,0,7.68666,0.112137 +-6.74803,0.971494,0.933117,1,3,0,7.77623,0.249489 +-7.11078,0.920048,0.933117,2,3,0,7.31466,0.365006 +-7.32659,0.932744,0.933117,1,1,0,7.40442,0.397352 +-7.0553,1,0.933117,1,1,0,7.29489,0.355334 +-8.53369,0.614276,0.933117,1,1,0,8.53869,0.517382 +-6.88857,1,0.933117,2,3,0,8.61495,0.187932 +-7.24968,0.946245,0.933117,1,3,0,7.25212,0.140556 +-7.1099,1,0.933117,2,3,0,7.26341,0.154869 +-6.75729,1,0.933117,2,3,0,7.03911,0.267267 +-6.77856,0.998079,0.933117,2,3,0,6.77878,0.281704 +-7.15156,0.726112,0.933117,2,3,0,8.50828,0.150263 +-6.74856,0.994489,0.933117,1,3,0,7.17373,0.245916 +-6.76827,0.997044,0.933117,2,3,0,6.77162,0.275701 +-6.88509,0.948813,0.933117,2,3,0,7.07087,0.318912 +-6.74846,1,0.933117,1,3,0,6.86789,0.253714 +-6.97042,0.776578,0.933117,2,3,0,8.21451,0.173392 +-6.76742,1,0.933117,2,3,0,6.92296,0.275142 +-6.76325,0.995509,0.933117,1,3,0,6.80228,0.228621 +-6.7603,1,0.933117,1,1,0,6.7649,0.230761 +-7.03432,0.929504,0.933117,1,3,0,7.14181,0.351471 +-6.95157,1,0.933117,1,1,0,7.05435,0.334778 +-7.75212,0.774095,0.933117,1,1,0,7.75679,0.447517 +-7.30757,1,0.933117,1,1,0,7.71941,0.394755 +-6.92101,0.733373,0.933117,2,3,0,8.71687,0.327839 +-6.79034,1,0.933117,2,3,0,6.88873,0.21486 +-6.78805,0.895316,0.933117,2,3,0,7.5342,0.215791 +-8.64894,0.654735,0.933117,1,3,0,9.09496,0.526199 +-7.22805,1,0.933117,1,1,0,8.20682,0.383431 +-7.15044,1,0.933117,1,1,0,7.31164,0.371507 +-6.75625,0.994685,0.933117,1,3,0,7.17122,0.234197 +-7.11967,0.617879,0.933117,2,3,0,9.56071,0.153758 +-6.75471,0.982403,0.933117,1,3,0,7.20772,0.264636 +-6.92048,0.962973,0.933117,1,3,0,6.92944,0.327712 +-6.92683,0.926216,0.933117,1,3,0,7.32536,0.180641 +-7.07415,0.960325,0.933117,2,3,0,7.35751,0.159108 +-8.97221,0.602037,0.933117,2,3,0,10.9979,0.06062 +-7.52341,0.990301,0.933117,2,3,0,9.29703,0.119185 +-7.02006,0.982892,0.933117,1,3,0,7.4364,0.166129 +-6.93235,1,0.933117,1,1,0,7.02281,0.179667 +-6.92607,1,0.933117,1,1,0,6.96865,0.180776 +-7.32952,0.967601,0.933117,2,3,0,7.33012,0.397748 +-7.14425,1,0.933117,1,1,0,7.36144,0.370512 +-6.76846,0.985631,0.933117,1,3,0,7.21305,0.225313 +-6.98817,0.960904,0.933117,2,3,0,7.07955,0.17069 +-6.79216,0.997496,0.933117,1,3,0,6.9493,0.21414 +-6.76363,0.974228,0.933117,2,3,0,6.97163,0.272505 +-6.75563,0.997443,0.933117,1,3,0,6.78289,0.234799 +-9.25635,0.490256,0.933117,1,3,0,10.6911,0.0539909 +-8.85294,1,0.933117,1,1,0,9.36855,0.0637039 +-7.4657,0.939569,0.933117,1,3,0,8.72474,0.123159 +-7.33696,1,0.933117,1,1,0,7.51977,0.132976 +-6.992,1,0.933117,1,1,0,7.27566,0.170122 +-6.86361,0.971624,0.933117,1,3,0,7.29267,0.313046 +-6.98377,0.964523,0.933117,1,1,0,6.99988,0.341588 +-6.90437,1,0.933117,1,1,0,6.99164,0.323822 +-6.74921,1,0.933117,1,3,0,6.88081,0.256125 +-6.77043,0.960443,0.933117,2,3,0,6.98603,0.224181 +-7.12863,0.953545,0.933117,2,3,0,7.19718,0.367971 +-7.03911,1,0.933117,2,3,0,7.17188,0.352364 +-8.68667,0.581159,0.933117,1,1,0,8.6884,0.529022 +-7.74368,1,0.933117,2,3,0,8.57106,0.446635 +-6.76978,1,0.933117,1,3,0,7.50562,0.276657 +-6.7582,1,0.933117,1,1,0,6.76762,0.268115 +-6.76318,0.995304,0.933117,2,3,0,6.79137,0.228671 +-6.88175,0.976375,0.933117,2,3,0,6.94796,0.189349 +-7.82106,0.858923,0.933117,1,3,0,7.93122,0.101771 +-9.93414,0.854688,0.933117,2,3,0,10.4277,0.0413971 +-10.2934,0.981759,0.933117,1,1,0,10.5097,0.0361251 +-9.38945,1,0.933117,1,1,0,10.2943,0.051192 +-9.34983,1,0.933117,1,1,0,9.69221,0.0520064 +-8.2176,1,0.933117,1,1,0,9.24725,0.0841108 +-7.72762,1,0.933117,1,1,0,8.19876,0.106759 +-6.79433,1,0.933117,2,3,0,7.67433,0.213305 +-7.59651,0.850963,0.933117,1,3,0,7.74584,0.114466 +-7.13852,0.903011,0.933117,1,3,0,8.67356,0.369585 +-7.49244,0.891018,0.933117,1,1,0,7.5646,0.418489 +-6.75172,0.91877,0.933117,2,3,0,8.00706,0.26085 +-7.52017,0.771641,0.933117,2,3,0,8.23371,0.421797 +-8.52051,0.711932,0.933117,1,1,0,8.65393,0.516354 +-11.0048,0.438871,0.933117,1,1,0,11.303,0.662224 +-8.42944,1,0.933117,2,3,0,10.4152,0.509138 +-7.34044,1,0.933117,2,7,0,8.16063,0.132691 +-7.20191,1,0.933117,1,1,0,7.36953,0.145103 +-6.90291,0.984818,0.933117,2,3,0,7.4038,0.185075 +-6.92074,0.978957,0.933117,2,3,0,7.15969,0.181734 +-6.82582,1,0.933117,1,1,0,6.90312,0.202982 +-6.75194,1,0.933117,2,3,0,6.8115,0.261174 +-6.75194,0.636302,0.933117,1,3,0,8.30538,0.261174 +-6.95945,0.845489,0.933117,2,3,0,7.62877,0.17513 +-6.95945,0.971654,0.933117,1,1,0,7.09592,0.17513 +-6.83228,0.96132,0.933117,2,3,0,7.26178,0.303489 +-6.82708,1,0.933117,1,1,0,6.85173,0.301754 +-8.07831,0.587949,0.933117,2,7,0,9.25884,0.0897585 +-6.91801,0.874948,0.933117,1,3,0,9.01485,0.327128 +-7.20267,0.915354,0.933117,1,1,0,7.21982,0.379636 +-6.87915,1,0.933117,1,1,0,7.11027,0.317336 +-6.76186,1,0.933117,1,3,0,6.84809,0.271168 +-6.80005,0.98108,0.933117,2,3,0,6.87795,0.29169 +-7.07448,0.848305,0.933117,2,3,0,7.6489,0.358761 +-6.95927,1,0.933117,1,1,0,7.08237,0.336449 +-7.51156,0.936036,0.933117,2,3,0,7.52443,0.420776 +-7.32531,1,0.933117,1,1,0,7.60007,0.397178 +-7.75663,0.955341,0.933117,2,3,0,7.87886,0.447987 +-10.3563,0.414734,0.933117,1,1,0,10.4539,0.631116 +-10.4225,1,0.933117,2,7,0,10.4226,0.0344214 +-9.53461,1,0.933117,1,1,0,10.4345,0.0483362 +-8.79482,1,0.933117,1,1,0,9.53932,0.0652789 +-6.75853,1,0.933117,2,3,0,8.34711,0.268406 +-7.95428,0.612194,0.933117,2,3,0,9.26685,0.467659 +-7.16041,1,0.933117,2,3,0,7.7386,0.373096 +-6.86247,0.941917,0.933117,1,3,0,7.48361,0.193597 +-6.83012,0.98755,0.933117,2,3,0,7.00386,0.201768 +-7.1053,0.957993,0.933117,1,3,0,7.10903,0.155398 +-6.81743,0.960804,0.933117,1,3,0,7.36191,0.29838 +-6.78288,1,0.933117,1,1,0,6.81197,0.283928 +-6.76796,0.993257,0.933117,1,3,0,6.83173,0.22561 +-6.75518,0.997315,0.933117,1,3,0,6.7877,0.265147 +-6.75518,0.584656,0.933117,1,3,0,8.57683,0.265147 +-6.97276,0.951219,0.933117,1,3,0,6.98559,0.339311 +-7.29308,0.967918,0.933117,2,3,0,7.32132,0.392751 +-7.17829,1,0.933117,1,1,0,7.36797,0.375899 +-6.85931,0.815707,0.933117,2,3,0,8.12326,0.311814 +-6.75293,1,0.933117,2,3,0,6.85036,0.237757 +-7.6329,0.808358,0.933117,1,3,0,7.80468,0.434701 +-7.66709,0.98854,0.933117,1,1,0,7.94208,0.438458 +-7.22299,1,0.933117,1,1,0,7.60973,0.382682 +-7.96124,0.782269,0.933117,1,1,0,8.02804,0.468321 +-6.97339,0.885942,0.933117,1,3,0,8.62116,0.172932 +-6.77191,0.944594,0.933117,2,3,0,7.43032,0.277963 +-6.80759,0.990095,0.933117,1,1,0,6.80939,0.294705 +-6.97758,0.951334,0.933117,1,1,0,6.97906,0.340315 +-7.13203,0.952832,0.933117,1,1,0,7.17646,0.368527 +-7.50353,0.885951,0.933117,1,1,0,7.57215,0.419819 +-7.83933,0.893016,0.933117,1,1,0,8.02962,0.45643 +-7.14421,1,0.933117,2,7,0,7.66423,0.151052 +-6.89047,1,0.933117,1,1,0,7.09428,0.187544 +-7.51605,0.912811,0.933117,1,3,0,7.54854,0.119678 +-7.37248,1,0.933117,2,3,0,7.56939,0.130121 +-8.051,0.909529,0.933117,1,1,0,8.05223,0.0909298 +-8.50055,0.953982,0.933117,1,1,0,8.57387,0.0740796 +-8.21109,1,0.933117,1,1,0,8.59875,0.0843633 +-8.03435,1,0.933117,1,1,0,8.33589,0.0916551 +-8.3077,0.970813,0.933117,1,1,0,8.42328,0.0807231 +-7.06272,0.993765,0.933117,2,3,0,8.42713,0.160525 +-6.75329,0.986018,0.933117,1,3,0,7.13201,0.262971 +-6.76108,0.997917,0.933117,1,1,0,6.76142,0.270555 +-6.74849,1,0.933117,2,3,0,6.75966,0.2462 +-6.76001,0.95776,0.933117,2,3,0,7.0137,0.230988 +-7.19902,0.907267,0.933117,1,3,0,7.28596,0.145387 +-6.82937,0.951539,0.933117,1,3,0,7.51601,0.302524 +-8.38077,0.514854,0.933117,1,3,0,9.85856,0.0781135 +-7.89393,1,0.933117,1,1,0,8.37991,0.098131 +-6.8559,0.897637,0.933117,1,3,0,8.58058,0.310821 +-7.00928,0.90344,0.933117,1,3,0,7.37814,0.167632 +-6.7481,0.994845,0.933117,1,3,0,7.0304,0.251524 +-8.13821,0.721454,0.933117,1,3,0,8.30123,0.484566 +-6.97965,0.885646,0.933117,1,3,0,8.81863,0.171971 +-6.9693,1,0.933117,1,1,0,7.02259,0.173567 +-6.74804,0.893397,0.933117,2,3,0,8.1253,0.250673 +-7.62235,0.811414,0.933117,1,3,0,7.73768,0.433528 +-7.00881,0.871851,0.933117,1,3,0,8.35513,0.167699 +-6.84347,1,0.933117,1,1,0,6.97485,0.198207 +-6.78757,1,0.933117,1,1,0,6.83204,0.215989 +-6.74858,0.953985,0.933117,2,3,0,7.12746,0.254203 +-7.31694,0.872322,0.933117,1,3,0,7.38762,0.39604 +-6.91942,1,0.933117,2,3,0,7.21704,0.181976 +-7.00445,0.983251,0.933117,1,1,0,7.02275,0.168317 +-6.75377,1,0.933117,2,3,0,6.95759,0.263563 +-9.26771,0.42041,0.933117,1,3,0,11.1259,0.0537449 +-8.28875,1,0.933117,1,1,0,9.18939,0.0814198 +-6.77569,0.891997,0.933117,2,7,0,8.91161,0.280143 +-6.76018,1,0.933117,2,3,0,6.7725,0.269822 +-7.19014,0.853899,0.933117,2,3,0,7.65688,0.377727 +-6.75014,0.960211,0.933117,2,3,0,7.43241,0.258195 +-6.75504,0.998708,0.933117,1,1,0,6.75508,0.264998 +-6.74913,0.999472,0.933117,1,3,0,6.75877,0.244153 +-7.24372,0.883419,0.933117,1,3,0,7.39985,0.141106 +-8.19281,0.879015,0.933117,1,3,0,8.20784,0.0850778 +-7.40787,1,0.933117,1,1,0,8.086,0.127393 +-8.21544,0.903715,0.933117,2,3,0,8.79787,0.0841945 +-8.99456,0.929313,0.933117,1,1,0,9.02147,0.0600631 +-6.84648,0.946975,0.933117,2,7,0,8.47729,0.307996 +-7.17431,0.905322,0.933117,1,1,0,7.17638,0.37528 +-6.82724,0.955897,0.933117,1,3,0,7.41167,0.202575 +-6.89122,0.986272,0.933117,1,1,0,6.89735,0.187391 +-6.77727,0.984672,0.933117,1,3,0,6.99173,0.281014 +-6.77727,0.75751,0.933117,1,3,0,7.66549,0.281014 +-6.90919,0.889969,0.933117,2,3,0,7.42731,0.183874 +-7.1086,0.961724,0.933117,1,1,0,7.1119,0.155018 +-7.1086,0.76929,0.933117,1,3,0,9.40761,0.155018 +-6.83417,0.96473,0.933117,2,3,0,7.48688,0.304111 +-6.83417,0.356607,0.933117,2,7,0,11.4253,0.304111 +-7.75996,0.672417,0.933117,2,7,0,8.682,0.10499 +-7.53379,1,0.933117,1,1,0,7.80375,0.118494 +-7.91475,0.950481,0.933117,1,1,0,7.95688,0.0971276 +-8.35158,0.952546,0.933117,1,1,0,8.41661,0.079142 +-6.83251,0.873029,0.933117,1,3,0,9.22022,0.303567 +-7.20757,0.892878,0.933117,1,1,0,7.20781,0.380377 +-6.92865,1,0.933117,2,3,0,7.14073,0.329623 +-6.97145,0.987037,0.933117,1,1,0,7.01599,0.339037 +-6.88069,1,0.933117,1,1,0,6.96788,0.317747 +-6.86552,1,0.933117,1,1,0,6.90651,0.313587 +-7.11212,0.927705,0.933117,1,1,0,7.12005,0.365231 +-7.69624,0.825983,0.933117,1,1,0,7.74316,0.441608 +-7.60423,1,0.933117,1,1,0,7.92168,0.431498 +-7.45338,1,0.933117,2,3,0,7.75113,0.413728 +-7.6113,0.982857,0.933117,2,3,0,7.80764,0.432293 +-8.14073,0.835421,0.933117,1,1,0,8.34485,0.484789 +-8.18245,0.985823,0.933117,1,1,0,8.62917,0.488459 +-7.15731,1,0.933117,1,1,0,7.87711,0.372604 +-9.56571,0.446499,0.933117,1,1,0,9.56847,0.587524 +-8.60166,1,0.933117,1,1,0,9.71906,0.522618 +-7.22267,0.791384,0.933117,1,3,0,9.98112,0.143087 +-6.96951,1,0.933117,2,3,0,7.18015,0.173534 +-6.91047,1,0.933117,1,1,0,6.9793,0.183632 +-6.75331,1,0.933117,1,3,0,6.89454,0.237296 +-6.79723,0.986699,0.933117,1,3,0,6.82654,0.29051 +-6.83918,0.961295,0.933117,2,3,0,7.02021,0.199318 +-7.22773,0.941758,0.933117,1,3,0,7.24072,0.142606 +-6.95779,1,0.933117,1,1,0,7.17987,0.175397 +-6.74912,0.999822,0.933117,1,3,0,6.95518,0.244166 +-6.94516,0.968212,0.933117,2,3,0,6.98623,0.177475 +-7.86011,0.880919,0.933117,1,3,0,7.93091,0.0997947 +-8.11178,0.990309,0.933117,2,3,0,8.21602,0.0883526 +-8.23503,0.986816,0.933117,1,1,0,8.40486,0.0834401 +-7.17205,0.96235,0.933117,1,3,0,8.11121,0.148113 +-8.00692,0.890498,0.933117,1,3,0,8.01764,0.0928688 +-7.73598,1,0.933117,1,1,0,8.05968,0.106298 +-8.29914,0.935406,0.933117,1,1,0,8.32852,0.0810367 +-6.75653,0.969419,0.933117,2,3,0,8.81336,0.266533 +-6.74848,0.999453,0.933117,2,3,0,6.76012,0.253805 +-7.11113,0.916035,0.933117,1,3,0,7.15924,0.365064 +-6.75303,0.996198,0.933117,2,3,0,7.15208,0.237634 +-6.75534,0.999429,0.933117,1,1,0,6.75612,0.235088 +-6.75257,0.947703,0.933117,2,3,0,7.08057,0.238206 +-6.74956,0.994328,0.933117,2,3,0,6.78935,0.256979 +-6.74966,0.999975,0.933117,1,1,0,6.75004,0.257195 +-7.70469,0.760285,0.933117,1,3,0,8.18332,0.108044 +-8.47534,0.91314,0.933117,2,3,0,9.19947,0.0749048 +-8.44341,1,0.933117,1,1,0,8.70859,0.075968 +-8.32308,1,0.933117,1,1,0,8.62337,0.0801641 +-8.52633,0.980431,0.933117,1,1,0,8.69001,0.0732482 +-9.57192,0.918925,0.933117,1,1,0,9.58222,0.0476332 +-9.78695,0.987209,0.933117,1,1,0,10.0364,0.0438086 +-10.4083,0.968104,0.933117,1,1,0,10.5385,0.0346038 +-9.32684,1,0.933117,1,1,0,10.3708,0.0524863 +-8.26965,1,0.933117,1,1,0,9.23607,0.0821299 +-7.99347,1,0.933117,1,1,0,8.35009,0.0934723 +-6.7544,0.969631,0.933117,1,3,0,8.16645,0.236058 +-7.10413,0.923128,0.933117,1,3,0,7.1773,0.155534 +-6.75969,0.837219,0.933117,2,3,0,9.2628,0.231236 +-7.8591,0.765576,0.933117,1,3,0,8.23512,0.0998454 +-6.93525,0.981681,0.933117,1,3,0,7.76581,0.179164 +-7.55956,0.913152,0.933117,1,3,0,7.57979,0.11681 +-7.09094,1,0.933117,1,1,0,7.48179,0.157082 +-6.76342,0.933698,0.933117,2,3,0,7.67727,0.272349 +-6.81105,0.950351,0.933117,2,3,0,7.05474,0.207462 +-6.76563,1,0.933117,1,1,0,6.80036,0.227048 +-6.82114,0.990873,0.933117,1,3,0,6.82124,0.204345 +-6.76248,0.96736,0.933117,2,3,0,7.09071,0.27165 +-6.8185,0.941547,0.933117,2,3,0,7.10567,0.205137 +-7.97063,0.75998,0.933117,1,3,0,8.40569,0.469212 +-8.86033,0.737673,0.933117,1,1,0,9.14394,0.541637 +-8.57257,1,0.933117,1,1,0,9.32007,0.52039 +-7.29926,0.748291,0.933117,1,3,0,10.1624,0.136145 +-7.24852,1,0.933117,1,1,0,7.37323,0.140662 +-6.77455,0.964697,0.933117,1,3,0,7.44398,0.2795 +-6.8065,0.991108,0.933117,1,1,0,6.80914,0.29428 +-6.7645,1,0.933117,2,3,0,6.79574,0.22778 +-8.015,0.822302,0.933117,2,3,0,8.11355,0.0925087 +-7.54188,1,0.933117,1,1,0,7.981,0.11796 +-8.33942,0.903647,0.933117,1,1,0,8.34046,0.0795757 +-8.33942,0.911505,0.933117,1,1,0,9.31461,0.0795757 +-8.57927,0.977241,0.933117,1,1,0,8.73273,0.0715798 +-6.99534,0.999861,0.933117,2,3,0,8.56335,0.169633 +-6.7936,0.973944,0.933117,1,3,0,7.16308,0.28894 +-6.7936,0.800716,0.933117,1,3,0,7.49212,0.28894 +-7.35573,0.881231,0.933117,1,3,0,7.36378,0.401252 +-7.91411,0.829306,0.933117,1,1,0,8.03385,0.463797 +-8.3854,0.851139,0.933117,1,1,0,8.69644,0.505574 +-6.81382,0.989411,0.933117,1,3,0,8.52142,0.206581 +-7.17546,0.941196,0.933117,1,3,0,7.19295,0.147763 +-6.8216,0.974432,0.933117,2,3,0,7.46669,0.299864 +-9.213,0.376719,0.933117,1,3,0,11.5543,0.0549422 +-8.32935,1,0.933117,2,3,0,9.15379,0.0799376 +-7.50647,1,0.933117,2,3,0,8.22332,0.120327 +-6.79354,1,0.933117,2,3,0,7.33497,0.288918 +-8.2369,0.714977,0.933117,1,3,0,8.28377,0.493168 +-8.2369,0.409717,0.933117,1,3,0,13.7778,0.493168 +-7.79434,1,0.933117,2,3,0,8.36026,0.451877 +-7.34785,1,0.933117,1,1,0,7.77295,0.400206 +-6.88176,1,0.933117,2,3,0,7.20651,0.318031 +-7.98764,0.812,0.933117,2,7,0,7.98819,0.0937359 +-7.88635,1,0.933117,1,1,0,8.1282,0.0985004 +-7.72274,1,0.933117,1,1,0,7.97958,0.107031 +-7.07476,0.97677,0.933117,1,3,0,7.61929,0.159032 +-7.23724,0.971804,0.933117,1,1,0,7.26563,0.14171 +-6.80702,0.896592,0.933117,2,3,0,8.33675,0.294483 +-7.23261,0.71461,0.933117,2,3,0,8.60474,0.142145 +-7.2052,1,0.933117,2,3,0,7.31026,0.144779 +-6.91461,0.95529,0.933117,1,3,0,7.69088,0.326314 +-6.88554,0.881469,0.933117,2,3,0,7.53323,0.319029 +-6.91012,0.992675,0.933117,1,1,0,6.94471,0.325229 +-6.75076,1,0.933117,1,3,0,6.8812,0.259326 +-6.81429,0.985786,0.933117,1,3,0,6.81817,0.297233 +-6.81429,0.394667,0.933117,1,3,0,10.4492,0.297233 +-7.00783,0.913105,0.933117,2,3,0,7.29857,0.167837 +-6.93012,1,0.933117,1,1,0,7.01397,0.180059 +-8.5623,0.818317,0.933117,2,3,0,8.78234,0.0721089 +-6.84447,0.931698,0.933117,2,3,0,9.80163,0.197954 +-6.75578,0.946819,0.933117,2,3,0,7.22513,0.265785 +-6.7801,0.997623,0.933117,2,3,0,6.78013,0.282516 +-6.8497,0.955345,0.933117,2,3,0,7.0373,0.308975 +-7.48668,0.746729,0.933117,1,3,0,8.22271,0.121687 +-7.5002,0.96422,0.933117,2,3,0,8.23061,0.120755 +-7.09427,1,0.933117,1,1,0,7.43504,0.156687 +-7.01746,0.837941,0.933117,2,3,0,8.76309,0.166488 +-7.6648,0.910713,0.933117,1,3,0,7.67443,0.11034 +-7.84011,0.977521,0.933117,1,1,0,7.94381,0.100799 +-6.81874,1,0.933117,2,3,0,7.58873,0.298848 +-6.76164,1,0.933117,1,3,0,6.80298,0.270999 +-6.89813,0.980735,0.933117,2,3,0,6.90157,0.186011 +-7.48253,0.917843,0.933117,1,3,0,7.50613,0.121976 +-8.01339,0.931288,0.933117,1,1,0,8.02988,0.0925801 +-7.89009,1,0.933117,1,1,0,8.14459,0.0983176 +-8.42699,0.980707,0.933117,2,3,0,8.47118,0.0765224 +-7.34579,0.952876,0.933117,1,3,0,8.29681,0.132254 +-6.77402,1,0.933117,1,3,0,7.31748,0.222243 +-6.85445,0.812038,0.933117,2,3,0,8.2188,0.195487 +-6.77078,0.964223,0.933117,2,3,0,7.17605,0.277275 +-6.77078,0.917895,0.933117,1,3,0,7.05176,0.277275 +-6.84025,0.971328,0.933117,1,3,0,6.93527,0.19904 +-8.10526,0.743323,0.933117,1,3,0,8.6174,0.481624 +-6.88356,0.933725,0.933117,1,3,0,8.50201,0.188969 +-6.95946,0.971876,0.933117,2,3,0,7.18598,0.175127 +-6.8925,0.965433,0.933117,1,3,0,7.29404,0.320833 +-7.22331,0.830436,0.933117,2,7,0,7.83458,0.143027 +-7.12877,1,0.933117,1,1,0,7.25805,0.152742 +-7.01395,1,0.933117,1,1,0,7.13576,0.166976 +-6.77058,0.941184,0.933117,2,3,0,7.51233,0.277154 +-6.74904,1,0.933117,1,3,0,6.76629,0.25567 +-7.01231,0.930437,0.933117,1,3,0,7.11756,0.167205 +-6.91772,1,0.933117,1,1,0,7.00991,0.182285 +-7.27632,0.946673,0.933117,1,3,0,7.27692,0.138149 +-6.84949,0.965408,0.933117,2,3,0,7.70176,0.308911 +-8.25197,0.57805,0.933117,1,3,0,9.67837,0.0827956 +-8.48891,0.976691,0.933117,1,1,0,8.63547,0.0744591 +-8.04229,1,0.933117,1,1,0,8.51518,0.0913083 +-7.70254,1,0.933117,1,1,0,8.0668,0.108166 +-10.5243,0.859641,0.933117,2,3,0,10.5842,0.639538 +-10.2684,1,0.933117,1,1,0,11.5637,0.626608 +-8.09661,1,0.933117,1,1,0,9.74464,0.480845 +-7.27029,1,0.933117,2,7,0,7.89098,0.138686 +-6.82786,0.946888,0.933117,1,3,0,7.61129,0.302017 +-6.75778,1,0.933117,2,3,0,6.81418,0.232817 +-9.11975,0.586106,0.933117,1,3,0,9.49222,0.559434 +-7.75729,1,0.933117,1,1,0,8.83056,0.448057 +-6.76197,0.998721,0.933117,1,3,0,7.74238,0.22952 +-7.22801,0.902647,0.933117,1,3,0,7.3192,0.142579 +-8.34302,0.862828,0.933117,1,3,0,8.38189,0.079447 +-8.2513,1,0.933117,2,3,0,8.52873,0.0828207 +-6.86039,0.869363,0.933117,2,7,0,9.14344,0.312124 +-6.75883,0.993141,0.933117,1,3,0,6.89892,0.231926 +-6.9282,0.977634,0.933117,2,3,0,6.95417,0.329518 +-6.9282,0.814935,0.933117,1,3,0,7.87855,0.329518 +-6.79102,0.978416,0.933117,1,3,0,7.05391,0.214592 +-6.74944,1,0.933117,1,3,0,6.78546,0.243393 +-6.82477,0.980074,0.933117,1,3,0,6.84998,0.300962 +-7.04233,0.904888,0.933117,1,3,0,7.37864,0.16314 +-7.0521,0.998178,0.933117,1,1,0,7.11113,0.161873 +-6.96118,1,0.933117,2,3,0,7.05884,0.174852 +-6.76149,0.99958,0.933117,1,3,0,6.93467,0.229872 +-6.98645,0.970104,0.933117,2,3,0,7.02515,0.342135 +-6.98022,1,0.933117,1,1,0,7.05122,0.340859 +-7.07022,0.972378,0.933117,1,1,0,7.12347,0.358009 +-7.0783,0.713883,0.933117,2,3,0,8.66137,0.359433 +-8.09883,0.71498,0.933117,1,1,0,8.11768,0.481045 +-6.84528,1,0.933117,2,3,0,8.14522,0.197747 +-6.88982,0.990532,0.933117,1,1,0,6.90213,0.187676 +-7.07611,0.96357,0.933117,1,1,0,7.07866,0.158868 +-6.8654,1,0.933117,1,1,0,7.0336,0.192927 +-6.83433,1,0.933117,2,3,0,6.87138,0.200612 +-6.93777,0.978257,0.933117,1,1,0,6.94082,0.17873 +-6.83907,1,0.933117,1,1,0,6.9209,0.199349 +-6.83907,0.941169,0.933117,1,3,0,7.1638,0.199349 +-6.94422,0.970698,0.933117,2,3,0,7.12095,0.177634 +-7.23296,0.907857,0.933117,1,3,0,7.75846,0.384154 +-7.11151,1,0.933117,2,3,0,7.28381,0.365128 +-6.84739,1,0.933117,1,1,0,7.03567,0.308276 +-6.81113,0.976742,0.933117,1,3,0,7.00021,0.207438 +-6.7641,0.973806,0.933117,2,3,0,7.02569,0.272846 +-6.75874,1,0.933117,1,1,0,6.76449,0.268593 +-7.16378,0.784942,0.933117,2,3,0,7.98339,0.148973 +-7.33828,0.971328,0.933117,1,1,0,7.3769,0.132868 +-6.98976,1,0.933117,1,1,0,7.27608,0.170454 +-6.76852,0.981724,0.933117,1,3,0,7.09539,0.275857 +-6.84775,0.978052,0.933117,1,1,0,6.84775,0.308383 +-6.99752,0.918718,0.933117,1,3,0,7.34288,0.169315 +-6.97727,0.947287,0.933117,1,3,0,7.4849,0.34025 +-6.98354,0.796823,0.933117,2,3,0,8.0548,0.341542 +-8.07874,0.526531,0.933117,1,3,0,9.71122,0.0897399 +-6.82709,1,0.933117,1,3,0,8.09603,0.20262 +-7.57729,0.873841,0.933117,1,3,0,7.67315,0.115675 +-6.80851,1,0.933117,2,3,0,7.38829,0.295061 +-6.75853,1,0.933117,2,3,0,6.79705,0.232179 +-6.97793,0.942434,0.933117,1,3,0,7.06795,0.340387 +-6.75007,0.998788,0.933117,1,3,0,6.9798,0.242055 +-6.75942,0.951444,0.933117,2,3,0,7.06447,0.231449 +-6.75942,0.791718,0.933117,1,3,0,7.80804,0.231449 +-7.00028,0.95009,0.933117,1,3,0,7.03228,0.168916 +-6.81983,0.870165,0.933117,2,3,0,8.15038,0.204735 +-7.67603,0.903784,0.933117,2,3,0,7.85584,0.439429 +-8.06384,0.876492,0.933117,1,1,0,8.30523,0.477874 +-7.51125,0.618565,0.933117,1,3,0,10.133,0.120003 +-7.91998,0.946609,0.933117,1,1,0,7.9553,0.0968786 +-10.5697,0.85742,0.933117,2,3,0,10.5738,0.641763 +-8.33886,1,0.933117,2,7,0,10.0769,0.0795958 +-7.86384,1,0.933117,1,1,0,8.33841,0.0996094 +-7.10373,0.972541,0.933117,1,3,0,7.75082,0.15558 +-6.86514,0.951695,0.933117,1,3,0,7.45428,0.31348 +-6.78691,1,0.933117,2,3,0,6.84476,0.285889 +-6.99295,0.958219,0.933117,1,3,0,6.99309,0.34345 +-6.8217,1,0.933117,2,3,0,6.94925,0.20418 +-7.2583,0.886453,0.933117,1,3,0,7.56141,0.387835 +-7.03105,1,0.933117,1,1,0,7.23843,0.350858 +-6.75443,1,0.933117,2,3,0,7.04184,0.23603 +-7.18514,0.934186,0.933117,2,3,0,7.26365,0.146776 +-7.69417,0.923066,0.933117,1,1,0,7.69618,0.108642 +-8.09969,0.951232,0.933117,1,1,0,8.15201,0.0888567 +-7.03394,0.972074,0.933117,1,3,0,7.99243,0.164248 +-7.21111,0.968604,0.933117,1,1,0,7.23138,0.144201 +-6.8119,0.995003,0.933117,1,3,0,7.15055,0.20719 +-6.85846,0.989778,0.933117,1,1,0,6.86432,0.194532 +-6.75125,0.995164,0.933117,1,3,0,6.88364,0.260127 +-7.07677,0.715752,0.933117,2,3,0,8.62162,0.158787 +-7.30998,0.960323,0.933117,1,1,0,7.32744,0.135229 +-8.62758,0.845382,0.933117,1,3,0,8.68888,0.0701005 +-6.84336,0.934389,0.933117,2,3,0,9.84996,0.198235 +-6.83536,1,0.933117,1,1,0,6.85975,0.200333 +-6.83536,0.604774,0.933117,1,3,0,9.27077,0.200333 +-6.88638,0.97901,0.933117,2,3,0,7.04745,0.188382 +-6.76264,0.999353,0.933117,1,3,0,6.86398,0.229045 +-6.74898,0.949903,0.933117,2,3,0,7.07755,0.244558 +-8.16714,0.71677,0.933117,1,3,0,8.36625,0.487119 +-6.8461,1,0.933117,2,3,0,8.23542,0.19754 +-6.77482,0.964868,0.933117,2,3,0,7.11193,0.279654 +-6.82429,0.955934,0.933117,2,3,0,7.03593,0.203422 +-6.76043,0.887906,0.933117,2,3,0,7.77959,0.230665 +-6.84238,0.99107,0.933117,2,3,0,6.84687,0.306728 +-6.77075,0.979573,0.933117,2,3,0,6.97373,0.277261 +-6.77137,0.999831,0.933117,1,1,0,6.77734,0.277636 +-6.80351,0.991086,0.933117,1,1,0,6.80547,0.293098 +-6.82027,0.975453,0.933117,1,3,0,6.95664,0.204606 +-6.75559,0.994663,0.933117,1,3,0,6.85274,0.265585 +-7.24508,0.615768,0.933117,2,3,0,9.35308,0.14098 +-7.08365,0.97546,0.933117,2,3,0,7.64276,0.157952 +-7.07642,1,0.933117,1,1,0,7.1484,0.15883 +-7.03061,1,0.933117,1,1,0,7.11463,0.164694 +-8.07554,0.876409,0.933117,2,3,0,8.41543,0.089876 +-7.20161,0.849203,0.933117,2,3,0,9.71604,0.379476 +-7.80215,0.81974,0.933117,1,1,0,7.87252,0.452674 +-7.80215,0.509666,0.933117,1,1,0,9.255,0.452674 +-9.13226,0.635091,0.933117,1,1,0,9.3237,0.560264 +-7.60266,1,0.933117,1,1,0,8.73178,0.431321 +-7.06494,1,0.933117,2,3,0,7.46571,0.35707 +-6.77818,0.93347,0.933117,2,3,0,7.44426,0.281503 +-9.31899,0.605433,0.933117,2,3,0,9.31919,0.0526513 +-7.58059,0.927506,0.933117,1,3,0,9.21682,0.115466 +-7.08797,1,0.933117,2,3,0,7.49841,0.157435 +-6.7676,0.976813,0.933117,1,3,0,7.21614,0.275261 +-7.06737,0.905478,0.933117,1,3,0,7.28292,0.159945 +-7.06737,0.857115,0.933117,1,3,0,8.12823,0.159945 +-6.88816,1,0.933117,1,1,0,7.03444,0.188015 +-6.79253,0.981414,0.933117,1,3,0,7.01886,0.288469 +-7.24587,0.848851,0.933117,1,3,0,7.64783,0.140907 +-7.84716,0.913393,0.933117,1,1,0,7.84786,0.100443 +-8.10843,0.969713,0.933117,1,1,0,8.20875,0.0884919 +-6.89332,0.983988,0.933117,2,7,0,7.80234,0.321044 +-8.77514,0.701502,0.933117,2,7,0,8.77987,0.0658235 +-8.72853,1,0.933117,1,1,0,9.02717,0.0671371 +-8.56912,1,0.933117,1,1,0,8.91449,0.0718957 +-8.66414,0.991506,0.933117,1,1,0,8.88771,0.0690079 +-7.98717,1,0.933117,1,1,0,8.62216,0.0937571 +-8.69212,0.929007,0.933117,1,1,0,8.71741,0.0681868 +-8.69755,0.999528,0.933117,1,1,0,8.96709,0.068029 +-9.41326,0.981917,0.933117,2,3,0,9.47317,0.0507101 +-6.92691,0.957586,0.933117,2,7,0,8.8168,0.32922 +-6.92691,0.859569,0.933117,1,1,0,7.26617,0.32922 +-8.11072,0.601108,0.933117,1,3,0,9.63177,0.0883966 +-7.82381,1,0.933117,2,3,0,8.16801,0.10163 +-6.76198,0.936931,0.933117,1,3,0,8.16658,0.271264 +-7.23761,0.924903,0.933117,2,3,0,7.25527,0.141675 +-7.53652,0.954239,0.933117,1,1,0,7.56243,0.118313 +-7.19742,1,0.933117,2,3,0,7.4989,0.145546 +-6.75901,0.999956,0.933117,2,3,0,7.18285,0.231785 +-6.83079,0.986565,0.933117,1,3,0,6.83306,0.201579 +-7.16604,0.941427,0.933117,2,3,0,7.35647,0.148736 +-7.06997,1,0.933117,1,1,0,7.19004,0.159622 +-7.6457,0.948648,0.933117,2,7,0,7.64612,0.436116 +-7.1896,1,0.933117,1,1,0,7.57381,0.377645 +-6.7532,0.952433,0.933117,2,3,0,7.47943,0.26286 +-7.00624,0.928128,0.933117,1,3,0,7.13556,0.168063 +-7.07043,0.988008,0.933117,1,1,0,7.10822,0.159565 +-6.97512,1,0.933117,2,3,0,7.07799,0.172665 +-8.89757,0.667965,0.933117,1,3,0,9.86057,0.544266 +-7.22867,1,0.933117,2,3,0,8.5972,0.142516 +-6.88,0.939688,0.933117,1,3,0,7.6605,0.317562 +-6.89847,0.940856,0.933117,1,3,0,7.21302,0.185943 +-7.48587,0.917483,0.933117,1,3,0,7.50983,0.121743 +-6.81051,0.955201,0.933117,2,3,0,8.03483,0.295822 +-6.92126,0.908516,0.933117,2,3,0,7.31131,0.327896 +-6.81807,1,0.933117,1,1,0,6.89754,0.298611 +-6.93191,0.922902,0.933117,2,3,0,7.28041,0.179744 +-6.87799,0.96908,0.933117,1,3,0,7.22981,0.317023 +-6.75897,1,0.933117,2,3,0,6.86052,0.231816 +-7.86059,0.783034,0.933117,2,3,0,8.47185,0.458549 +-6.98852,1,0.933117,1,1,0,7.58698,0.342556 +-6.91761,1,0.933117,1,1,0,7.00394,0.327033 +-6.99244,0.977434,0.933117,1,1,0,7.02894,0.343347 +-6.79696,1,0.933117,1,1,0,6.93551,0.290395 +-8.40777,0.520849,0.933117,2,7,0,9.76679,0.0771788 +-8.63826,0.992893,0.933117,2,3,0,8.80062,0.0697792 +-9.48645,0.935444,0.933117,1,1,0,9.52197,0.0492622 +-8.75046,1,0.933117,1,1,0,9.48909,0.0665149 +-8.60584,1,0.933117,1,1,0,8.94626,0.0707612 +-9.75047,0.91488,0.933117,1,1,0,9.75585,0.0444312 +-9.45161,1,0.933117,1,1,0,9.94452,0.0499452 +-9.79435,0.963408,0.933117,2,7,0,9.79513,0.60087 +-8.16888,1,0.933117,2,7,0,9.45458,0.0860266 +-7.56289,1,0.933117,1,1,0,8.10492,0.116595 +-7.69908,0.981513,0.933117,1,1,0,7.80135,0.108363 +-7.24226,1,0.933117,1,1,0,7.63715,0.141241 +-6.85242,0.943646,0.933117,1,3,0,7.62494,0.309792 +-6.88501,0.94844,0.933117,1,3,0,7.14732,0.188666 +-6.81858,1,0.933117,1,1,0,6.87503,0.205114 +-6.76475,0.883611,0.933117,2,3,0,7.80614,0.227616 +-6.84914,0.991632,0.933117,2,3,0,6.85204,0.308806 +-7.51701,0.763008,0.933117,1,3,0,8.27668,0.119614 +-6.76761,0.90412,0.933117,2,3,0,8.5988,0.225818 +-6.78041,0.996967,0.933117,1,1,0,6.78272,0.219121 +-6.78041,0.747946,0.933117,1,3,0,8.15598,0.219121 +-6.76517,0.983521,0.933117,2,3,0,6.89815,0.273612 +-7.16731,0.878915,0.933117,1,3,0,7.43158,0.148604 +-7.27032,0.982755,0.933117,1,1,0,7.32544,0.138683 +-7.27032,0.920183,0.933117,1,1,0,7.74757,0.138683 +-6.75154,1,0.933117,2,3,0,7.21971,0.239613 +-6.82245,0.888446,0.933117,2,3,0,7.43196,0.203958 +-6.76453,0.999512,0.933117,1,3,0,6.80906,0.227757 +-6.76453,0.714532,0.933117,1,3,0,8.3038,0.227757 +-7.60373,0.814369,0.933117,1,3,0,7.82324,0.431442 +-6.75037,0.949438,0.933117,2,3,0,7.93797,0.241497 +-6.77988,0.993874,0.933117,1,3,0,6.78171,0.219367 +-6.8034,0.994568,0.933117,1,1,0,6.80661,0.210015 +-6.81117,0.989403,0.933117,2,3,0,6.91379,0.207425 +-6.8538,0.990618,0.933117,1,1,0,6.86008,0.195644 +-6.83511,1,0.933117,2,3,0,6.86524,0.2004 +-6.80345,0.83411,0.933117,2,3,0,8.3546,0.209997 +-6.78035,1,0.933117,1,1,0,6.80146,0.219146 +-8.01724,0.756505,0.933117,1,3,0,8.38808,0.0924092 +-6.94623,0.98036,0.933117,1,3,0,7.93218,0.177297 +-6.85075,0.975231,0.933117,1,3,0,7.20496,0.309291 +-6.7745,0.97555,0.933117,2,3,0,7.00287,0.279475 +-6.9289,0.968507,0.933117,1,3,0,6.9293,0.32968 +-7.19901,0.919324,0.933117,1,1,0,7.21973,0.379081 +-6.94004,1,0.933117,1,1,0,7.14248,0.332219 +-6.76595,0.988338,0.933117,1,3,0,7.00223,0.226843 +-7.23783,0.8856,0.933117,1,3,0,7.40236,0.384869 +-6.76687,1,0.933117,1,3,0,7.12189,0.274774 +-6.82158,0.984886,0.933117,1,1,0,6.8218,0.299856 +-7.37609,0.885258,0.933117,1,3,0,7.37759,0.403927 +-8.98535,0.580092,0.933117,1,1,0,9.04422,0.550362 +-6.83412,1,0.933117,2,7,0,8.35385,0.304093 +-8.90448,0.68737,0.933117,2,7,0,8.90499,0.0623476 +-6.75358,0.910195,0.933117,1,3,0,9.47606,0.236981 +-6.82047,0.986371,0.933117,1,3,0,6.82499,0.204546 +-7.39061,0.724513,0.933117,2,3,0,8.86995,0.128709 +-7.14655,0.975365,0.933117,2,3,0,7.82271,0.1508 +-6.91308,1,0.933117,1,1,0,7.10286,0.183144 +-7.66687,0.897663,0.933117,1,3,0,7.71526,0.110219 +-7.14537,1,0.933117,1,1,0,7.58353,0.150927 +-7.14619,0.914067,0.933117,1,3,0,7.97007,0.370825 +-7.15179,0.810884,0.933117,1,3,0,8.0999,0.150238 +-7.05621,1,0.933117,1,1,0,7.17359,0.161348 +-7.00444,1,0.933117,1,1,0,7.08692,0.168318 +-9.45746,0.611648,0.933117,1,3,0,10.5904,0.580969 +-8.53314,1,0.933117,1,1,0,9.60608,0.517339 +-7.03412,1,0.933117,2,3,0,8.356,0.164225 +-6.85584,0.958689,0.933117,2,7,0,7.33865,0.310802 +-6.79446,0.981094,0.933117,1,3,0,6.97699,0.213254 +-6.79756,0.98851,0.933117,1,3,0,6.89726,0.29065 +-6.92037,0.944995,0.933117,1,3,0,7.11814,0.181803 +-7.58146,0.908818,0.933117,1,3,0,7.61075,0.115411 +-6.88438,0.987375,0.933117,1,3,0,7.49441,0.188796 +-6.89473,0.997839,0.933117,1,1,0,6.92264,0.186684 +-6.85119,1,0.933117,1,1,0,6.8991,0.196278 +-7.00353,0.989641,0.933117,2,3,0,7.005,0.168448 +-7.04386,0.992385,0.933117,1,1,0,7.0871,0.162939 +-7.61613,0.919816,0.933117,1,3,0,7.61852,0.113254 +-6.74817,1,0.933117,2,3,0,7.47342,0.247859 +-7.47698,0.838765,0.933117,1,3,0,7.58682,0.416618 +-9.18756,0.559437,0.933117,1,1,0,9.26535,0.563898 +-7.87144,1,0.933117,2,7,0,8.89897,0.0992328 +-6.77539,0.925126,0.933117,1,3,0,8.29713,0.279974 +-7.8816,0.819045,0.933117,2,3,0,7.8955,0.0987325 +-6.78475,1,0.933117,2,3,0,7.77764,0.217185 +-6.80888,0.98569,0.933117,1,3,0,6.89968,0.2952 +-7.14637,0.931089,0.933117,1,3,0,7.14649,0.370854 +-6.74851,0.983012,0.933117,2,3,0,7.25722,0.246125 +-6.76365,0.996602,0.933117,1,3,0,6.76531,0.228345 +# +# Elapsed Time: 0.003 seconds (Warm-up) +# 0.009 seconds (Sampling) +# 0.012 seconds (Total) +# diff --git a/src/test/interface/example_output/bernoulli_chain_1.csv b/src/test/interface/example_output/bernoulli_chain_1.csv deleted file mode 100644 index 5a2ac2efe4..0000000000 --- a/src/test/interface/example_output/bernoulli_chain_1.csv +++ /dev/null @@ -1,1048 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 23 -# stan_version_patch = 0 -# model = bernoulli_model -# method = sample (Default) -# sample -# num_samples = 1000 (Default) -# num_warmup = 1000 (Default) -# save_warmup = 0 (Default) -# thin = 1 (Default) -# adapt -# engaged = 1 (Default) -# gamma = 0.050000000000000003 (Default) -# delta = 0.80000000000000004 (Default) -# kappa = 0.75 (Default) -# t0 = 10 (Default) -# init_buffer = 75 (Default) -# term_buffer = 50 (Default) -# window = 25 (Default) -# algorithm = hmc (Default) -# hmc -# engine = nuts (Default) -# nuts -# max_depth = 10 (Default) -# metric = diag_e (Default) -# metric_file = (Default) -# stepsize = 1 (Default) -# stepsize_jitter = 0 (Default) -# id = 0 (Default) -# data -# file = bernoulli.data.json -# init = 2 (Default) -# random -# seed = 1116358692 (Default) -# output -# file = b_out_1.csv -# diagnostic_file = (Default) -# refresh = 100 (Default) -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta -# Adaptation terminated -# Step size = 1.02703 -# Diagonal elements of inverse mass matrix: -# 0.526879 --6.91744,1,1.02703,1,3,0,7.6246,0.182337 --6.91089,0.924042,1.02703,2,3,0,7.44931,0.325417 --6.78354,1,1.02703,1,1,0,6.86927,0.28426 --7.02032,0.919598,1.02703,1,1,0,7.02114,0.348819 --11.1853,0.186256,1.02703,1,1,0,11.1894,0.670257 --8.71464,1,1.02703,2,3,0,10.4167,0.067535 --7.76321,1,1.02703,1,1,0,8.60009,0.104815 --7.76321,0.813185,1.02703,1,3,0,9.5347,0.104815 --7.76321,0.929309,1.02703,1,1,0,8.27816,0.104815 --7.65238,1,1.02703,1,1,0,7.90344,0.111072 --7.66199,0.998423,1.02703,1,1,0,7.85186,0.110505 --8.15727,0.976159,1.02703,2,3,0,8.2246,0.0864922 --6.85949,1,1.02703,2,3,0,7.7925,0.311865 --7.22109,0.942866,1.02703,2,3,0,7.23616,0.382399 --6.822,1,1.02703,1,1,0,7.07917,0.300001 --6.9462,0.956383,1.02703,1,1,0,6.9599,0.333594 --7.61837,0.770096,1.02703,1,1,0,7.6501,0.433085 --7.05996,0.899071,1.02703,1,3,0,8.11965,0.160872 --7.66397,0.884719,1.02703,1,1,0,7.66481,0.110389 --6.74993,0.945971,1.02703,1,3,0,7.65554,0.257775 --9.16973,0.507017,1.02703,1,3,0,10.3017,0.0559126 --7.02677,1,1.02703,1,3,0,9.02205,0.165212 --6.7661,0.979457,1.02703,1,3,0,7.05426,0.274257 --7.05007,0.927119,1.02703,1,3,0,7.05064,0.354383 --6.83946,1,1.02703,2,3,0,6.9878,0.305811 --6.92007,0.971396,1.02703,1,1,0,6.94253,0.327616 --6.7481,0.932102,1.02703,2,3,0,7.18333,0.251606 --7.07452,0.766523,1.02703,2,3,0,7.8573,0.358769 --7.75166,0.763863,1.02703,1,1,0,7.82662,0.447469 --7.36022,1,1.02703,1,1,0,7.79256,0.401846 --7.88396,0.807646,1.02703,1,1,0,8.07617,0.460856 --12.0299,0.188575,1.02703,1,1,0,12.2454,0.70478 --7.3739,1,1.02703,1,1,0,10.2014,0.403641 --7.28969,1,1.02703,1,1,0,7.5347,0.392277 --6.81326,0.493725,1.02703,2,3,0,9.98096,0.296853 --6.77341,0.950133,1.02703,2,3,0,7.04157,0.222563 --6.81714,0.964624,1.02703,2,3,0,6.98394,0.298273 --6.81714,0.22518,1.02703,2,3,0,11.8552,0.298273 --6.75028,0.970297,1.02703,2,3,0,6.93558,0.258466 --6.75028,0.88314,1.02703,1,3,0,7.06925,0.258466 --7.29731,0.862251,1.02703,1,3,0,7.31563,0.393338 --6.75576,1,1.02703,1,3,0,7.1191,0.265763 --6.75097,1,1.02703,1,1,0,6.75462,0.259673 --6.9705,0.939169,1.02703,1,3,0,7.03072,0.17338 --7.4458,0.967143,1.02703,2,3,0,7.44663,0.124586 --6.96494,0.917215,1.02703,2,3,0,7.83548,0.337662 --7.75274,0.734513,1.02703,1,1,0,7.78714,0.447582 --7.62895,1,1.02703,1,1,0,8.03096,0.434263 --8.02005,0.850871,1.02703,1,1,0,8.32968,0.473844 --6.9236,0.879228,1.02703,2,3,0,8.79047,0.181219 --6.9236,0.86846,1.02703,1,3,0,7.66614,0.181219 --6.75019,0.992716,1.02703,1,3,0,6.91314,0.258283 --6.81499,0.955735,1.02703,2,3,0,6.94469,0.297491 --7.69266,0.853907,1.02703,2,3,0,7.69285,0.441223 --6.77508,0.45798,1.02703,2,3,0,10.6775,0.2798 --7.17769,0.853243,1.02703,2,3,0,7.50713,0.147534 --6.90015,1,1.02703,1,1,0,7.11617,0.185612 --6.75089,0.993208,1.02703,2,3,0,6.94001,0.240614 --6.96434,0.889181,1.02703,2,3,0,7.35358,0.174348 --6.84157,1,1.02703,1,1,0,6.94057,0.198697 --7.75015,0.719723,1.02703,2,3,0,8.74399,0.447312 --6.92875,0.987696,1.02703,2,3,0,8.03316,0.1803 --7.02782,0.866751,1.02703,2,3,0,8.21342,0.16507 --7.11095,0.981527,1.02703,1,1,0,7.1631,0.154748 --6.9948,1,1.02703,1,1,0,7.12327,0.169713 --6.89058,0.969844,1.02703,2,3,0,7.31227,0.187522 --6.75573,0.980402,1.02703,2,3,0,6.9761,0.265732 --7.1317,0.89467,1.02703,1,3,0,7.25755,0.152417 --7.43203,0.941247,1.02703,1,1,0,7.46454,0.125591 --7.61302,0.96867,1.02703,1,1,0,7.71692,0.113445 --6.86913,1,1.02703,2,3,0,7.40047,0.314599 --8.09401,0.762853,1.02703,2,3,0,8.12754,0.0890949 --7.66685,1,1.02703,1,1,0,8.11065,0.11022 --6.75433,0.998808,1.02703,2,3,0,7.60754,0.236142 --6.92858,0.952989,1.02703,1,3,0,6.96404,0.329606 --7.4962,0.903827,1.02703,2,3,0,7.50256,0.121029 --7.4962,0.936839,1.02703,1,1,0,7.89434,0.121029 --7.49404,1,1.02703,2,3,0,7.66113,0.121178 --8.9804,0.904706,1.02703,2,3,0,9.18206,0.550022 --8.9804,0.317395,1.02703,1,3,0,11.6024,0.550022 --7.58408,1,1.02703,2,3,0,8.71171,0.115245 --7.41467,1,1.02703,1,1,0,7.65791,0.12688 --6.79603,0.929924,1.02703,2,3,0,7.62579,0.289996 --6.76235,0.986644,1.02703,2,3,0,6.86662,0.229245 --6.84676,0.985909,1.02703,2,3,0,6.8716,0.308083 --8.13057,0.622132,1.02703,2,3,0,9.18078,0.0875771 --6.80088,0.973482,1.02703,1,3,0,7.99994,0.210897 --6.80088,0.723416,1.02703,1,3,0,7.88703,0.210897 --9.20784,0.577912,1.02703,1,3,0,9.89383,0.0550569 --12.3647,0.745928,1.02703,1,3,0,12.5336,0.0170791 --9.538,0.799909,1.02703,1,3,0,12.2741,0.0482719 --8.7213,1,1.02703,1,1,0,9.55438,0.0673438 --6.79773,0.923828,1.02703,1,3,0,8.66881,0.212034 --7.67986,0.834535,1.02703,1,3,0,7.76908,0.109464 --7.23956,1,1.02703,1,1,0,7.62566,0.141493 --7.18063,1,1.02703,1,1,0,7.31688,0.147234 --7.05815,0.897636,1.02703,2,3,0,8.94344,0.161102 --6.98931,0.928022,1.02703,2,3,0,7.65279,0.342716 --6.86016,0.972943,1.02703,1,3,0,7.16897,0.194135 --6.88755,0.99296,1.02703,1,1,0,6.91279,0.18814 --6.74926,0.827439,1.02703,2,3,0,8.00453,0.256255 --6.94459,0.948954,1.02703,1,3,0,6.95261,0.333238 --7.5412,0.89823,1.02703,2,3,0,7.54649,0.118005 --7.56614,0.886812,1.02703,1,3,0,8.70942,0.427162 --6.74916,1,1.02703,1,3,0,7.31553,0.256008 --6.8166,0.982425,1.02703,1,3,0,6.81885,0.298079 --6.97076,0.94611,1.02703,1,1,0,6.98129,0.338892 --7.99818,0.6668,1.02703,1,1,0,8.02873,0.471806 --7.99818,0.198309,1.02703,1,3,0,11.4065,0.471806 --6.76479,1,1.02703,1,3,0,7.56427,0.273345 --6.74802,1,1.02703,1,3,0,6.76131,0.249682 --6.74802,0.756943,1.02703,1,3,0,7.77187,0.249682 --6.75566,0.936165,1.02703,2,3,0,7.05114,0.265662 --6.75566,0.851084,1.02703,1,3,0,7.30776,0.265662 --6.80682,0.983132,1.02703,1,1,0,6.80684,0.294403 --6.77833,1,1.02703,1,1,0,6.80367,0.281583 --6.92651,0.949597,1.02703,1,1,0,6.9279,0.329126 --6.92651,0.687339,1.02703,2,3,0,8.03985,0.329126 --7.15156,0.918464,1.02703,1,1,0,7.19456,0.371688 --6.76052,1,1.02703,1,3,0,7.10111,0.230593 --7.40299,0.861622,1.02703,1,3,0,7.48852,0.127762 --7.11646,1,1.02703,1,1,0,7.37683,0.154121 --7.58697,0.88408,1.02703,1,3,0,8.19228,0.429545 --6.79169,1,1.02703,1,3,0,7.51459,0.214327 --6.80965,0.978121,1.02703,2,3,0,6.94462,0.207916 --6.92642,0.969659,1.02703,1,1,0,6.92935,0.180713 --6.95956,0.944508,1.02703,2,3,0,7.36991,0.33651 --6.96978,0.998732,1.02703,2,3,0,7.04337,0.338685 --6.8923,1,1.02703,1,1,0,6.98274,0.320783 --10.6282,0.377214,1.02703,2,3,0,10.6285,0.031889 --10.9868,0.994251,1.02703,2,3,0,11.3157,0.0279531 --11.7817,0.96853,1.02703,1,1,0,11.9806,0.0209925 --11.6333,0.980897,1.02703,2,3,0,13.9016,0.0221348 --6.87546,0.823607,1.02703,2,7,0,10.3135,0.31634 --6.76361,1,1.02703,2,3,0,6.83739,0.272494 --6.79118,0.9908,1.02703,1,1,0,6.79344,0.287866 --7.30457,0.839029,1.02703,1,3,0,7.5914,0.135689 --7.34917,0.991416,1.02703,1,1,0,7.46677,0.131981 --7.71666,0.936884,1.02703,1,1,0,7.76903,0.107371 --6.87656,0.98248,1.02703,2,3,0,7.90347,0.190456 --6.87656,0.722942,1.02703,1,3,0,8.48574,0.190456 --7.26909,0.940369,1.02703,1,3,0,7.26914,0.138794 --6.79441,0.922268,1.02703,2,3,0,8.13039,0.213275 --7.21707,0.90649,1.02703,2,3,0,7.48003,0.143625 --7.2816,0.987074,1.02703,1,1,0,7.37683,0.137683 --6.75297,0.989762,1.02703,1,3,0,7.20696,0.237699 --6.76723,0.925742,1.02703,2,3,0,7.12364,0.275016 --6.76723,0.913261,1.02703,1,3,0,6.988,0.275016 --7.61451,0.788334,1.02703,2,3,0,7.97383,0.113354 --6.75189,0.897533,1.02703,2,3,0,8.16553,0.261098 --6.97089,0.905402,1.02703,2,3,0,7.22095,0.173319 --7.64303,0.943009,1.02703,2,3,0,7.82489,0.435822 --6.82876,1,1.02703,2,3,0,7.33835,0.302319 --6.92026,0.96771,1.02703,1,1,0,6.93827,0.327661 --6.92026,0.593995,1.02703,1,1,0,7.73892,0.327661 --6.90152,1,1.02703,1,1,0,6.96447,0.323113 --6.87269,0.896033,1.02703,2,3,0,7.36078,0.191299 --6.78514,1,1.02703,1,1,0,6.84997,0.217015 --7.0082,0.963046,1.02703,2,3,0,7.09531,0.346475 --7.18872,0.754241,1.02703,2,3,0,8.0641,0.146416 --6.78705,0.953794,1.02703,2,3,0,7.32508,0.285955 --6.78705,0.44414,1.02703,1,3,0,8.68526,0.285955 --7.47265,0.8715,1.02703,2,3,0,7.53362,0.122668 --6.87616,0.89263,1.02703,2,3,0,8.41681,0.316528 --7.1728,0.895008,1.02703,1,1,0,7.1952,0.375043 --6.99006,1,1.02703,1,1,0,7.1719,0.342868 --6.76571,1,1.02703,1,3,0,6.9125,0.273984 --6.91213,0.800645,1.02703,2,3,0,7.60212,0.325717 --6.86946,1,1.02703,1,1,0,6.93329,0.31469 --6.86946,0.369858,1.02703,1,1,0,8.40312,0.31469 --6.92802,0.588536,1.02703,2,3,0,8.85664,0.329476 --7.05136,0.954849,1.02703,1,1,0,7.10193,0.354618 --7.17779,0.952344,1.02703,1,1,0,7.27463,0.375821 --6.95805,1,1.02703,1,1,0,7.14875,0.336185 --7.53301,0.799901,1.02703,1,1,0,7.57147,0.423311 --6.84012,0.984975,1.02703,1,3,0,7.59022,0.199073 --6.76662,1,1.02703,2,3,0,6.82256,0.274611 --6.76662,0.761864,1.02703,1,3,0,7.72033,0.274611 --6.75849,1,1.02703,1,1,0,6.76624,0.268369 --6.75849,0.716562,1.02703,1,3,0,7.56504,0.268369 --6.75834,0.985524,1.02703,2,3,0,6.81622,0.268235 --6.89718,0.964457,1.02703,1,3,0,6.8975,0.322025 --7.37417,0.833994,1.02703,1,1,0,7.39666,0.403676 --8.08677,0.746855,1.02703,1,1,0,8.27453,0.479957 --8.08677,0.445221,1.02703,1,1,0,9.64554,0.479957 --7.064,0.908201,1.02703,1,3,0,8.52981,0.160365 --7.12893,0.94875,1.02703,1,3,0,7.59696,0.368019 --7.14305,0.994533,1.02703,1,1,0,7.28082,0.370319 --6.76034,1,1.02703,1,3,0,7.01358,0.269954 --6.75954,0.876249,1.02703,2,3,0,7.32655,0.231358 --7.35212,0.871264,1.02703,1,3,0,7.42813,0.131742 --6.75936,0.992646,1.02703,2,3,0,7.37785,0.2315 --6.78235,0.992435,1.02703,1,3,0,6.80575,0.283667 --6.89988,0.959818,1.02703,1,1,0,6.90285,0.322704 --7.11503,0.922575,1.02703,1,1,0,7.14928,0.365717 --7.11503,0.451878,1.02703,1,1,0,8.3297,0.365717 --8.51096,0.568365,1.02703,1,1,0,8.5778,0.515607 --10.6514,0.420214,1.02703,1,1,0,11.2011,0.645732 --6.90744,1,1.02703,1,3,0,10.0504,0.184207 --6.98378,0.993842,1.02703,2,3,0,7.0111,0.171346 --6.75411,1,1.02703,1,3,0,6.93541,0.236376 --6.79242,0.963541,1.02703,2,3,0,6.95059,0.214039 --6.83605,0.932777,1.02703,2,3,0,7.24735,0.200148 --7.69596,0.619087,1.02703,2,3,0,9.6938,0.10854 --7.16889,1,1.02703,2,3,0,7.6066,0.148441 --6.91114,1,1.02703,1,1,0,7.11485,0.183507 --6.7487,0.998345,1.02703,2,3,0,6.91333,0.254639 --6.76194,0.996124,1.02703,1,3,0,6.76618,0.229541 --6.79777,0.970176,1.02703,2,3,0,6.92735,0.290739 --6.82829,0.996485,1.02703,2,3,0,6.84106,0.302161 --8.36607,0.707739,1.02703,2,3,0,8.4171,0.0786292 --6.75019,0.906579,1.02703,1,3,0,8.37944,0.241832 --7.18447,0.80951,1.02703,2,3,0,7.8359,0.146844 --7.20208,0.998782,1.02703,2,3,0,7.30349,0.145085 --7.9556,0.870875,1.02703,1,1,0,7.95691,0.0952044 --7.20728,1,1.02703,1,1,0,7.82026,0.144575 --7.31657,0.978319,1.02703,1,1,0,7.39867,0.134671 --6.85019,1,1.02703,1,3,0,7.20776,0.196522 --7.01551,0.95938,1.02703,1,1,0,7.02084,0.166759 --6.77151,1,1.02703,2,3,0,6.96759,0.277719 --6.75395,0.924651,1.02703,2,3,0,7.10468,0.236558 --6.98268,0.913915,1.02703,2,3,0,7.21958,0.341364 --6.78442,1,1.02703,1,1,0,6.91418,0.284693 --6.80968,0.991375,1.02703,1,1,0,6.81854,0.295506 --6.74881,0.999614,1.02703,1,3,0,6.8006,0.245044 --6.80695,0.984116,1.02703,1,3,0,6.81652,0.294454 --6.86814,0.978679,1.02703,1,1,0,6.88123,0.314323 --6.80723,0.971869,1.02703,2,3,0,7.02827,0.208715 --6.84365,0.928893,1.02703,2,3,0,7.31995,0.198162 --7.06079,0.947123,1.02703,1,1,0,7.06244,0.160768 --6.75451,0.982583,1.02703,1,3,0,7.05854,0.264414 --6.82787,0.986095,1.02703,2,3,0,6.84193,0.202397 --7.14507,0.959426,1.02703,2,3,0,7.23796,0.370645 --7.14507,0.67099,1.02703,1,1,0,7.82309,0.370645 --6.95219,1,1.02703,2,3,0,7.12616,0.334912 --6.74888,1,1.02703,1,3,0,6.9099,0.244847 --6.75193,0.999065,1.02703,1,1,0,6.75195,0.239056 --6.9628,0.950369,1.02703,1,3,0,6.98148,0.174594 --6.9628,0.731456,1.02703,1,3,0,8.72838,0.174594 --6.79592,1,1.02703,2,3,0,6.91847,0.212704 --6.79592,0.826745,1.02703,1,3,0,7.58,0.212704 --8.204,0.792808,1.02703,2,3,0,8.4983,0.0846393 --6.74819,1,1.02703,2,3,0,7.94836,0.252315 --6.74938,0.999631,1.02703,1,3,0,6.74997,0.243516 --6.75996,0.828665,1.02703,2,3,0,7.6538,0.231024 --7.0949,0.926276,1.02703,1,3,0,7.12081,0.156613 --7.69584,0.862088,1.02703,1,3,0,8.28623,0.441565 --6.80731,1,1.02703,1,1,0,7.36463,0.294595 --7.67655,0.72339,1.02703,1,1,0,7.67655,0.439485 --6.77923,1,1.02703,1,3,0,7.35204,0.28206 --6.77923,0.909026,1.02703,1,1,0,6.9538,0.28206 --7.90497,0.638391,1.02703,2,3,0,8.97991,0.0975969 --8.70615,0.799152,1.02703,1,3,0,10.4974,0.530467 --8.09385,0.43394,1.02703,1,3,0,11.3766,0.0891014 --7.02219,0.951751,1.02703,2,3,0,8.71402,0.349178 --6.74804,0.867734,1.02703,2,3,0,7.52078,0.24917 --6.76262,0.99557,1.02703,2,3,0,6.77248,0.22906 --7.13826,0.85478,1.02703,2,3,0,7.5743,0.369543 --6.76887,0.612064,1.02703,2,3,0,8.84079,0.276082 --7.70514,0.77424,1.02703,1,3,0,7.71261,0.44256 --6.86659,1,1.02703,1,1,0,7.39209,0.31389 --6.83751,0.899761,1.02703,2,3,0,7.30542,0.199759 --6.81997,1,1.02703,2,3,0,6.84966,0.204694 --6.75917,1,1.02703,1,3,0,6.80247,0.231648 --7.94803,0.753073,1.02703,1,3,0,8.20419,0.0955564 --6.80174,0.895085,1.02703,1,3,0,8.1462,0.292381 --6.79057,1,1.02703,2,3,0,6.81044,0.28759 --6.86145,0.975589,1.02703,1,1,0,6.86871,0.31243 --6.80166,0.979116,1.02703,2,3,0,6.98859,0.210622 --6.86974,0.981818,1.02703,1,1,0,6.87513,0.19195 --7.19081,0.925606,1.02703,1,1,0,7.19112,0.146206 --8.62141,0.903003,1.02703,2,3,0,9.21877,0.52412 --7.53761,1,1.02703,1,1,0,8.4074,0.423849 --6.80371,0.825018,1.02703,2,3,0,8.31434,0.209907 --7.14328,0.937179,1.02703,1,3,0,7.14775,0.151152 --6.89372,1,1.02703,2,3,0,7.08882,0.186888 --7.36686,0.895744,1.02703,2,3,0,7.78238,0.130565 --6.96632,1,1.02703,1,1,0,7.28161,0.174035 --8.04477,0.821681,1.02703,2,3,0,8.76184,0.476128 --6.77061,1,1.02703,1,3,0,7.5887,0.277174 --6.78072,0.99661,1.02703,1,1,0,6.78668,0.282834 --6.74914,1,1.02703,1,3,0,6.77118,0.255956 --6.75287,0.99948,1.02703,2,3,0,6.75323,0.237822 --7.17165,0.912744,1.02703,2,3,0,7.33015,0.148155 --9.21569,0.662107,1.02703,2,3,0,10.7048,0.565728 --6.9587,1,1.02703,1,1,0,8.32429,0.336327 --6.9587,0.89038,1.02703,1,1,0,7.19563,0.336327 --6.90703,0.922255,1.02703,2,3,0,7.33324,0.184284 --7.08024,0.981864,1.02703,2,3,0,7.08146,0.359774 --6.77963,1,1.02703,1,1,0,6.97373,0.282267 --6.91621,0.750045,1.02703,2,3,0,7.83662,0.326697 --6.87676,1,1.02703,1,1,0,6.9415,0.316692 --6.87676,0.581101,1.02703,1,1,0,7.73473,0.316692 --6.85074,1,1.02703,1,1,0,6.89922,0.309289 --6.77913,1,1.02703,2,3,0,6.83538,0.219717 --7.25089,0.900489,1.02703,2,3,0,7.49032,0.140444 --8.53661,0.766398,1.02703,1,3,0,9.41793,0.517609 --6.76106,1,1.02703,1,3,0,7.9116,0.270535 --7.63259,0.697994,1.02703,2,3,0,8.51048,0.112255 --7.10848,1,1.02703,1,1,0,7.53548,0.155032 --6.97226,1,1.02703,1,1,0,7.10791,0.173106 --6.75554,1,1.02703,1,3,0,6.92441,0.234881 --7.4361,0.873346,1.02703,2,3,0,7.63474,0.125293 --9.14185,0.833809,1.02703,1,3,0,9.18786,0.0565488 --6.74808,0.928958,1.02703,2,3,0,10.308,0.251364 --8.3842,0.647801,1.02703,1,3,0,8.44567,0.505476 --6.95207,1,1.02703,1,1,0,7.83586,0.334887 --7.22931,0.899519,1.02703,1,1,0,7.2784,0.383616 --7.22931,0.268875,1.02703,1,1,0,9.18872,0.383616 --6.8087,1,1.02703,1,1,0,7.07775,0.295132 --6.83364,0.991318,1.02703,1,1,0,6.85075,0.303937 --6.77608,1,1.02703,2,3,0,6.81992,0.221197 --7.21127,0.906248,1.02703,2,3,0,7.43904,0.144186 --6.75872,0.941568,1.02703,2,3,0,7.46457,0.268574 --6.82896,0.976673,1.02703,1,1,0,6.82903,0.302388 --7.44771,0.793762,1.02703,1,1,0,7.45086,0.413027 --6.74872,1,1.02703,1,3,0,7.23865,0.254682 --6.78924,0.977732,1.02703,2,3,0,6.8512,0.28698 --6.78924,0.697306,1.02703,1,3,0,7.61494,0.28698 --7.52147,0.818237,1.02703,1,3,0,7.52191,0.421952 --7.40438,1,1.02703,2,3,0,7.71192,0.407576 --7.00648,1,1.02703,2,3,0,7.31189,0.346137 --6.88896,1,1.02703,1,1,0,6.99994,0.319921 --6.79725,0.986662,1.02703,1,3,0,6.96477,0.212212 --7.09977,0.919547,1.02703,1,3,0,7.22469,0.363143 --6.82316,1,1.02703,2,3,0,7.00672,0.300409 --6.97419,0.746652,1.02703,2,3,0,7.96051,0.172808 --6.77809,0.979617,1.02703,1,3,0,7.02487,0.281457 --7.51378,0.862055,1.02703,2,3,0,7.58622,0.119832 --7.72029,0.965857,1.02703,1,1,0,7.83069,0.107168 --6.95659,1,1.02703,1,3,0,7.56392,0.17559 --6.76116,0.985566,1.02703,1,3,0,6.9739,0.270618 --7.38995,0.827173,1.02703,1,3,0,7.62969,0.12876 --7.09004,1,1.02703,1,1,0,7.35448,0.157188 --7.29921,0.985678,1.02703,2,3,0,7.33937,0.136149 --6.95779,1,1.02703,1,1,0,7.22852,0.175397 --6.7799,0.952689,1.02703,2,3,0,7.45045,0.219356 --6.89102,0.962075,1.02703,2,3,0,7.04827,0.187432 --7.20677,0.976014,1.02703,2,3,0,7.20826,0.144625 --6.76475,1,1.02703,1,3,0,7.12207,0.227611 --6.88843,0.973904,1.02703,1,3,0,6.88951,0.18796 --6.83485,1,1.02703,1,1,0,6.88891,0.20047 --6.80963,0.980733,1.02703,2,3,0,7.00433,0.207925 --6.87606,0.914236,1.02703,2,3,0,7.42388,0.190563 --6.9097,0.991498,1.02703,1,1,0,6.93764,0.183778 --6.84539,1,1.02703,1,1,0,6.90841,0.197721 --7.04312,0.937887,1.02703,2,3,0,7.34878,0.163036 --6.95131,1,1.02703,2,3,0,7.05562,0.176453 --7.47124,0.871937,1.02703,1,3,0,7.84875,0.41592 --7.24322,1,1.02703,1,1,0,7.54421,0.385654 --6.80265,0.988134,1.02703,1,3,0,7.27579,0.210277 --6.82916,0.992784,1.02703,1,1,0,6.83996,0.202035 --6.90976,0.960784,1.02703,2,3,0,7.15109,0.183767 --8.34489,0.704333,1.02703,1,3,0,8.7355,0.50225 --9.55506,0.606727,1.02703,1,1,0,10.1042,0.586886 --7.0553,1,1.02703,1,1,0,8.57114,0.355335 --6.74833,1,1.02703,1,3,0,6.98164,0.246885 --6.74864,0.999579,1.02703,2,3,0,6.75035,0.245618 --6.74864,0.867715,1.02703,1,3,0,7.24431,0.245618 --6.74864,0.947081,1.02703,1,3,0,6.9269,0.245618 --7.51117,0.821861,1.02703,1,3,0,7.68281,0.120008 --7.40249,1,1.02703,1,1,0,7.60915,0.127801 --7.88802,0.920866,1.02703,1,1,0,7.9281,0.0984186 --9.44187,0.816799,1.02703,1,3,0,9.44513,0.0501382 --7.09605,1,1.02703,1,3,0,9.31005,0.156477 --6.88548,0.927332,1.02703,2,3,0,8.16911,0.188569 --7.49278,0.90706,1.02703,1,3,0,7.50038,0.121265 --7.79445,0.950854,1.02703,1,1,0,7.87952,0.103153 --7.45006,1,1.02703,2,3,0,7.80642,0.124279 --7.11958,0.962028,1.02703,2,3,0,8.01147,0.153769 --6.81049,0.980033,1.02703,2,3,0,7.29941,0.207643 --6.9854,0.955409,1.02703,1,1,0,6.98594,0.171103 --7.99616,0.870078,1.02703,1,3,0,8.02315,0.0933514 --9.34879,0.851674,1.02703,1,1,0,9.34966,0.052028 --6.89468,0.928004,1.02703,1,3,0,9.32041,0.186695 --6.74973,0.994312,1.02703,1,3,0,6.88469,0.257343 --6.75182,0.957252,1.02703,2,3,0,6.94606,0.261002 --6.82992,0.979948,1.02703,1,3,0,6.83076,0.302708 --6.82992,0.630292,1.02703,1,1,0,7.58122,0.302708 --6.7866,0.859537,1.02703,2,3,0,7.34939,0.285742 --6.90938,0.957875,1.02703,1,1,0,6.91315,0.32505 --7.11802,0.92465,1.02703,1,1,0,7.15596,0.366216 --6.8834,1,1.02703,1,1,0,7.05809,0.318467 --6.75044,1,1.02703,1,3,0,6.84304,0.25875 --6.75236,0.999383,1.02703,1,1,0,6.75286,0.26176 --6.90645,0.968478,1.02703,2,3,0,6.94469,0.184396 --7.16459,0.941034,1.02703,1,1,0,7.17044,0.148888 --6.75915,0.947159,1.02703,2,3,0,7.39017,0.268951 --6.79255,0.988925,1.02703,1,1,0,6.79342,0.288478 --7.23877,0.850836,1.02703,1,1,0,7.23899,0.385005 --6.76124,1,1.02703,1,3,0,7.1689,0.230054 --6.74821,0.855148,1.02703,2,3,0,7.54319,0.25243 --6.75008,0.995747,1.02703,2,3,0,6.76796,0.258076 --6.75037,0.997521,1.02703,2,3,0,6.76071,0.258637 --7.01059,0.887366,1.02703,2,3,0,7.3202,0.167447 --7.14036,0.99044,1.02703,2,3,0,7.17976,0.151469 --7.56313,0.956737,1.02703,2,3,0,7.56576,0.426815 --7.32334,1,1.02703,1,1,0,7.66182,0.396911 --6.90821,1,1.02703,1,1,0,7.19329,0.324765 --6.79306,0.737184,1.02703,2,3,0,7.9444,0.288702 --6.81076,0.843562,1.02703,2,3,0,7.4841,0.207558 --6.74836,1,1.02703,1,3,0,6.79785,0.246747 --6.79892,0.982233,1.02703,2,3,0,6.84163,0.29122 --7.4595,0.78442,1.02703,1,1,0,7.45952,0.414482 --6.84706,1,1.02703,1,1,0,7.23562,0.308174 --7.37964,0.819017,1.02703,1,1,0,7.38748,0.404389 --6.97885,1,1.02703,1,1,0,7.27687,0.340576 --7.89025,0.827529,1.02703,2,3,0,7.89722,0.0983101 --9.21838,0.847431,1.02703,1,1,0,9.21873,0.054823 --6.74817,0.974513,1.02703,2,3,0,9.4856,0.247846 --7.27531,0.783783,1.02703,2,3,0,7.97546,0.138239 --6.74802,0.979892,1.02703,1,3,0,7.22918,0.24996 --6.74802,0.976762,1.02703,1,3,0,6.81485,0.24996 --7.12005,0.906528,1.02703,1,3,0,7.19357,0.153716 --7.2834,0.966562,1.02703,1,1,0,7.33731,0.137524 --7.95717,0.845574,1.02703,1,3,0,8.82277,0.467933 --7.8377,1,1.02703,1,1,0,8.32338,0.456267 --6.76881,1,1.02703,1,3,0,7.62894,0.225106 --6.79428,0.992739,1.02703,1,1,0,6.79685,0.213325 --6.9907,0.97272,1.02703,2,3,0,7.04351,0.342997 --8.46091,0.706803,1.02703,2,3,0,8.4695,0.0753827 --8.31696,0.953934,1.02703,2,3,0,9.83696,0.080386 --6.78134,1,1.02703,2,3,0,7.94576,0.283151 --8.66385,0.564035,1.02703,1,3,0,9.693,0.0690166 --7.02403,1,1.02703,1,3,0,8.46631,0.165585 --8.39405,0.831657,1.02703,1,3,0,8.46598,0.0776519 --6.89478,1,1.02703,2,3,0,7.95599,0.321416 --6.78355,1,1.02703,1,1,0,6.85942,0.284265 --6.78355,0.797611,1.02703,1,3,0,7.56348,0.284265 --6.75246,1,1.02703,2,3,0,6.78302,0.238351 --7.1561,0.896226,1.02703,1,3,0,7.20439,0.37241 --7.53214,0.688265,1.02703,1,3,0,8.51594,0.118603 --7.53214,0.843846,1.02703,1,3,0,8.62949,0.118603 --6.96963,0.913999,1.02703,2,3,0,8.35393,0.338653 --6.75197,0.837971,1.02703,2,3,0,7.56824,0.261219 --6.74916,0.894844,1.02703,2,3,0,7.24367,0.244058 --7.36303,0.855636,1.02703,1,3,0,7.48322,0.130869 --9.40215,0.828128,1.02703,1,3,0,9.5239,0.0509343 --7.05263,0.784541,1.02703,2,3,0,10.5923,0.354849 --6.86266,1,1.02703,1,1,0,7.00568,0.312776 --7.29927,0.927812,1.02703,2,3,0,7.31114,0.136144 --6.98521,1,1.02703,1,1,0,7.24085,0.171132 --7.66146,0.908152,1.02703,1,3,0,7.6631,0.110536 --7.8052,0.860877,1.02703,1,3,0,9.14388,0.452985 --7.8052,0.842601,1.02703,1,1,0,8.42725,0.452985 --7.34548,1,1.02703,1,1,0,7.80815,0.399891 --7.34548,0.62426,1.02703,1,3,0,8.57819,0.399891 --7.34282,1,1.02703,1,1,0,7.56784,0.399536 --6.88531,1,1.02703,2,3,0,7.1891,0.318968 --6.88531,0.333434,1.02703,1,1,0,8.5634,0.318968 --6.88531,0.7311,1.02703,1,1,0,7.39907,0.318968 --7.71449,0.727062,1.02703,1,1,0,7.7261,0.443555 --8.38267,0.757822,1.02703,1,1,0,8.71015,0.505351 --7.41923,1,1.02703,1,1,0,8.1796,0.409462 --7.00943,0.918256,1.02703,1,3,0,7.8416,0.167611 --7.43816,0.912505,1.02703,1,1,0,7.44314,0.125142 --7.58169,0.974962,1.02703,1,1,0,7.69614,0.115397 --6.7485,0.963591,1.02703,1,3,0,7.52725,0.246156 --9.14161,0.538655,1.02703,1,3,0,9.23802,0.560882 --6.77413,1,1.02703,1,3,0,8.27233,0.279263 --6.8582,0.971471,1.02703,1,1,0,6.86046,0.311493 --7.21312,0.945225,1.02703,2,3,0,7.22156,0.144007 --7.9997,0.866742,1.02703,1,1,0,8.00051,0.0931919 --6.77881,0.967758,1.02703,1,3,0,7.88595,0.21987 --6.98457,0.943716,1.02703,1,3,0,7.06825,0.341752 --6.75056,1,1.02703,1,3,0,6.94205,0.241164 --6.80094,0.985884,1.02703,1,3,0,6.81404,0.292056 --8.07397,0.760418,1.02703,2,3,0,8.1416,0.0899431 --7.22279,1,1.02703,1,1,0,7.92093,0.143076 --9.91877,0.746398,1.02703,2,3,0,10.3848,0.0416415 --8.51997,1,1.02703,1,1,0,9.794,0.0734521 --8.44577,1,1.02703,1,1,0,8.78698,0.0758885 --6.7561,0.975981,1.02703,2,3,0,8.59946,0.266105 --6.78066,0.996638,1.02703,2,3,0,6.78236,0.219005 --7.26527,0.877181,1.02703,1,3,0,7.37949,0.388831 --7.03021,1,1.02703,1,1,0,7.2547,0.350698 --7.03021,0.589194,1.02703,1,1,0,7.86448,0.350698 --7.41089,0.861798,1.02703,1,1,0,7.48284,0.408406 --6.75403,0.679982,1.02703,2,3,0,8.73206,0.236472 --6.81723,0.986941,1.02703,2,3,0,6.84326,0.298309 --6.87486,0.719771,1.02703,2,3,0,7.98925,0.316176 --6.78862,1,1.02703,2,3,0,6.85547,0.215556 --7.28633,0.903027,1.02703,1,3,0,7.31249,0.137267 --6.75504,0.967733,1.02703,1,3,0,7.28574,0.265005 --6.76337,0.983942,1.02703,2,3,0,6.82075,0.272312 --6.79432,0.989669,1.02703,1,1,0,6.7963,0.289258 --7.34876,0.826775,1.02703,1,3,0,7.66285,0.132014 --7.07786,1,1.02703,2,3,0,7.32074,0.158654 --7.55073,0.885599,1.02703,1,3,0,8.10197,0.425379 --6.80767,1,1.02703,1,1,0,7.27528,0.294734 --7.0565,0.914126,1.02703,1,1,0,7.06145,0.355551 --7.89,0.717466,1.02703,1,1,0,7.95312,0.461449 --7.18215,1,1.02703,2,3,0,7.73035,0.14708 --6.96204,1,1.02703,2,3,0,7.14924,0.174715 --7.47659,0.873317,1.02703,1,3,0,7.86884,0.416572 --6.8509,0.97063,1.02703,2,3,0,7.7478,0.196349 --6.83654,1,1.02703,1,1,0,6.86894,0.200016 --6.8402,0.999676,1.02703,2,3,0,6.86435,0.199052 --6.96229,0.987421,1.02703,2,3,0,6.96491,0.337097 --6.86911,0.570616,1.02703,2,3,0,9.05585,0.314594 --7.03599,0.940308,1.02703,1,1,0,7.06257,0.351783 --6.91423,1,1.02703,1,1,0,7.03625,0.326223 --7.06481,0.945233,1.02703,1,1,0,7.10829,0.357046 --7.06481,0.532767,1.02703,1,1,0,8.044,0.357046 --7.41454,0.871736,1.02703,1,1,0,7.5011,0.40887 --7.32048,1,1.02703,1,1,0,7.58274,0.396521 --7.65874,0.872051,1.02703,1,1,0,7.84624,0.437547 --7.40366,1,1.02703,1,1,0,7.78189,0.407484 --7.01165,1,1.02703,1,1,0,7.31552,0.347147 --7.01165,0.486891,1.02703,1,1,0,8.1132,0.347147 --6.86154,0.972189,1.02703,1,3,0,7.19244,0.193814 --6.75149,0.982142,1.02703,2,3,0,6.95046,0.260509 --7.21166,0.877496,1.02703,1,3,0,7.34499,0.144149 --7.26241,0.989754,1.02703,1,1,0,7.36023,0.139395 --6.76246,0.964819,1.02703,1,3,0,7.28464,0.271633 --6.85461,0.984205,1.02703,2,3,0,6.86592,0.195448 --6.82617,0.935886,1.02703,2,3,0,7.39998,0.202882 --6.76256,0.96659,1.02703,2,3,0,7.0709,0.229099 --6.97814,0.953229,1.02703,1,3,0,6.98666,0.172201 --6.79529,1,1.02703,2,3,0,6.9298,0.289677 --7.00486,0.966995,1.02703,2,3,0,7.01771,0.168259 --7.20024,0.957559,1.02703,1,1,0,7.22781,0.145267 --8.12558,0.855509,1.02703,2,3,0,8.81479,0.087782 --8.69756,0.93306,1.02703,1,1,0,8.79579,0.0680286 --6.82109,0.941713,1.02703,1,3,0,8.61052,0.20436 --6.74805,0.828165,1.02703,2,3,0,7.86645,0.250992 --6.77022,0.990782,1.02703,2,3,0,6.79364,0.276935 --6.89719,0.979537,1.02703,2,3,0,6.89775,0.322027 --8.05122,0.638321,1.02703,1,1,0,8.06108,0.476719 --7.22577,0.839428,1.02703,1,3,0,8.84515,0.142793 --7.16456,1,1.02703,1,1,0,7.29868,0.148891 --7.10382,0.949753,1.02703,2,3,0,7.71539,0.363831 --7.55551,0.686708,1.02703,2,3,0,8.48868,0.117072 --6.93255,0.910091,1.02703,2,3,0,7.91716,0.33052 --6.77451,1,1.02703,1,1,0,6.87822,0.279479 --6.77643,0.949453,1.02703,2,3,0,6.9657,0.280552 --6.74811,0.997018,1.02703,2,3,0,6.79171,0.248376 --6.74802,0.999987,1.02703,2,3,0,6.74818,0.249706 --6.98432,0.855385,1.02703,2,3,0,7.42803,0.341701 --6.74954,0.851205,1.02703,2,3,0,7.53555,0.25692 --7.1027,0.909013,1.02703,1,3,0,7.11642,0.363641 --7.1027,0.453298,1.02703,1,1,0,8.31143,0.363641 --8.09296,0.671586,1.02703,1,1,0,8.16708,0.480516 --6.78981,1,1.02703,1,3,0,7.61039,0.287243 --6.78981,0.854808,1.02703,1,3,0,7.15633,0.287243 --6.96858,0.938697,1.02703,1,1,0,6.97144,0.338432 --6.99134,0.997171,1.02703,2,3,0,7.06681,0.343125 --6.99134,0.646639,1.02703,1,1,0,7.68995,0.343125 --6.7808,1,1.02703,1,1,0,6.91797,0.282878 --6.77571,1,1.02703,1,1,0,6.78741,0.280157 --7.00246,0.666062,1.02703,2,3,0,8.306,0.345345 --6.80605,0.984142,1.02703,1,3,0,7.08257,0.209109 --6.75096,1,1.02703,1,3,0,6.79141,0.2405 --7.12966,0.791293,1.02703,2,3,0,7.80348,0.36814 --7.00687,1,1.02703,2,3,0,7.16282,0.346213 --6.74899,1,1.02703,1,3,0,6.95117,0.244523 --6.76334,0.98432,1.02703,2,3,0,6.82508,0.272293 --6.74806,0.999965,1.02703,1,3,0,6.76056,0.248881 --7.95292,0.724496,1.02703,1,3,0,8.00878,0.467529 --7.17731,1,1.02703,2,3,0,7.80895,0.147573 --6.90248,0.895615,1.02703,2,3,0,7.99041,0.323352 --6.90248,0.799886,1.02703,1,1,0,7.28326,0.323352 --6.82986,1,1.02703,2,3,0,6.87886,0.201839 --8.01971,0.557018,1.02703,2,3,0,9.68589,0.473813 --7.14663,1,1.02703,2,3,0,7.93874,0.150791 --8.11952,0.932929,1.02703,2,3,0,8.32356,0.482901 --7.69572,1,1.02703,1,1,0,8.27899,0.441552 --6.78049,0.665365,1.02703,2,3,0,9.13003,0.219085 --6.866,0.966668,1.02703,2,3,0,7.01354,0.192791 --7.65026,0.81591,1.02703,1,3,0,7.92719,0.436617 --7.65026,0.701222,1.02703,1,1,0,8.44201,0.436617 --6.84084,0.988511,1.02703,1,3,0,7.68376,0.198885 --6.7577,0.968916,1.02703,2,3,0,7.07626,0.232882 --6.78724,0.979906,1.02703,2,3,0,6.86706,0.286048 --9.36895,0.549563,1.02703,2,3,0,9.42165,0.0516115 --10.8985,0.902076,1.02703,1,1,0,10.9144,0.02887 --10.6798,1,1.02703,2,3,0,11.2732,0.0312866 --10.2986,1,1.02703,2,3,0,10.9643,0.0360552 --8.58401,0.856675,1.02703,1,3,0,10.1434,0.0714326 --9.66852,0.902263,1.02703,1,1,0,9.7084,0.0458684 --7.40957,0.991813,1.02703,2,3,0,9.90275,0.127264 --7.75545,0.866198,1.02703,1,3,0,8.75928,0.447865 --6.88076,1,1.02703,1,1,0,7.42915,0.317766 --7.25843,0.94102,1.02703,2,3,0,7.2792,0.387853 --7.37453,0.95478,1.02703,1,1,0,7.55366,0.403723 --7.85203,0.545724,1.02703,1,3,0,9.38548,0.100199 --9.17748,0.845242,1.02703,1,1,0,9.17763,0.0557372 --6.75619,1,1.02703,2,3,0,8.72956,0.234251 --6.78788,0.990752,1.02703,1,1,0,6.78795,0.21586 --6.78286,1,1.02703,1,1,0,6.79567,0.218011 --8.25957,0.720621,1.02703,1,3,0,8.55492,0.0825084 --6.8105,0.850239,1.02703,2,3,0,8.90646,0.295817 --6.86511,0.980931,1.02703,1,1,0,6.87992,0.313472 --7.6064,0.862257,1.02703,2,3,0,7.63108,0.113853 --6.84523,1,1.02703,1,3,0,7.4588,0.19776 --6.87755,0.935065,1.02703,2,3,0,7.2703,0.316905 --6.87755,0.457682,1.02703,1,1,0,8.09025,0.316905 --6.94395,0.976029,1.02703,1,1,0,6.98112,0.333095 --8.12454,0.628364,1.02703,1,1,0,8.14492,0.483349 --8.12454,0.67119,1.02703,1,1,0,9.1622,0.483349 --6.86546,1,1.02703,1,3,0,8.10592,0.192914 --7.21811,0.945308,1.02703,1,3,0,7.21811,0.143525 --8.03078,0.863273,1.02703,1,1,0,8.03122,0.0918116 --6.76348,0.864958,1.02703,2,3,0,8.74563,0.272395 --6.80952,0.927427,1.02703,2,3,0,7.05117,0.295447 --6.7661,1,1.02703,1,1,0,6.79687,0.274255 --6.81557,0.983391,1.02703,1,1,0,6.81733,0.297706 --6.83623,0.99278,1.02703,1,1,0,6.85622,0.304777 --7.26475,0.926956,1.02703,2,3,0,7.28277,0.139184 --7.25065,1,1.02703,1,1,0,7.37778,0.140466 --7.18353,0.954126,1.02703,2,3,0,7.92096,0.146939 --7.23015,0.934151,1.02703,1,3,0,7.8637,0.383741 --6.75605,0.812267,1.02703,2,3,0,7.96921,0.234389 --7.39772,0.858349,1.02703,1,3,0,7.49413,0.128164 --8.02065,0.901016,1.02703,1,1,0,8.0428,0.0922581 --10.3469,0.820536,1.02703,2,3,0,11.1511,0.035408 --7.58518,1,1.02703,1,3,0,10.2326,0.115176 --8.67883,0.904438,1.02703,2,3,0,8.70037,0.528438 --7.94409,1,1.02703,1,1,0,8.79037,0.466685 --6.93609,0.940514,1.02703,2,3,0,8.50053,0.179018 --7.71709,0.819753,1.02703,1,3,0,8.09846,0.443832 --6.9259,1,1.02703,1,1,0,7.43269,0.328984 --6.97039,0.983642,1.02703,1,1,0,7.0275,0.338813 --9.2422,0.675099,1.02703,2,3,0,9.25483,0.567442 --7.97964,1,1.02703,1,1,0,9.11853,0.470063 --6.7481,1,1.02703,1,3,0,7.6045,0.251548 --7.25618,0.901945,1.02703,2,3,0,7.38209,0.139961 --7.58784,0.939787,1.02703,1,1,0,7.63346,0.115008 --7.32251,1,1.02703,1,1,0,7.60691,0.134173 --6.8406,1,1.02703,1,3,0,7.21131,0.198948 --8.47062,0.726481,1.02703,1,3,0,8.72834,0.0750608 --8.7593,0.968807,1.02703,1,1,0,8.96536,0.0662663 --10.4299,0.868231,1.02703,1,1,0,10.4306,0.0343265 --6.92224,1,1.02703,2,3,0,9.40346,0.328128 --6.95129,0.989328,1.02703,1,1,0,7.00876,0.334716 --6.91214,1,1.02703,1,1,0,6.98947,0.325721 --7.07984,0.939143,1.02703,1,1,0,7.12137,0.359703 --6.81993,1,1.02703,1,1,0,6.99285,0.299275 --6.96755,0.609577,1.02703,2,3,0,8.66569,0.338216 --6.89884,0.544642,1.02703,2,3,0,9.30435,0.322443 --6.75113,0.999292,1.02703,1,3,0,6.87851,0.240232 --8.4265,0.653122,1.02703,1,3,0,8.94687,0.0765391 --6.85814,0.985454,1.02703,1,3,0,8.27448,0.194609 --6.9371,0.980138,1.02703,1,1,0,6.95311,0.178845 --6.90173,1,1.02703,1,1,0,6.96213,0.185306 --6.75543,0.978666,1.02703,2,3,0,6.99601,0.265413 --6.74804,0.93878,1.02703,2,3,0,7.03193,0.250723 --6.82119,0.980544,1.02703,1,3,0,6.82699,0.299717 --7.11546,0.952926,1.02703,2,3,0,7.12239,0.365789 --6.95028,1,1.02703,2,3,0,7.10849,0.334495 --7.16716,0.920863,1.02703,1,1,0,7.2192,0.37416 --7.03911,1,1.02703,2,3,0,7.20981,0.352365 --6.80525,1,1.02703,2,3,0,7.03854,0.209381 --7.40295,0.85242,1.02703,1,3,0,7.5686,0.407394 --6.77685,0.807694,1.02703,2,3,0,8.20095,0.220816 --8.0319,0.429161,1.02703,2,3,0,10.3411,0.474941 --7.13567,1,1.02703,1,1,0,7.75977,0.369122 --6.78843,0.571782,1.02703,2,3,0,9.13265,0.286605 --6.76787,0.910467,1.02703,2,3,0,7.1803,0.225662 --7.09787,0.930275,1.02703,1,3,0,7.1157,0.156264 --7.20073,0.937639,1.02703,1,3,0,7.72404,0.379342 --7.28745,0.988777,1.02703,2,3,0,7.44623,0.391965 --7.71634,0.840691,1.02703,1,1,0,7.88498,0.443752 --6.81758,0.766899,1.02703,2,3,0,8.74307,0.205418 --6.81758,0.641635,1.02703,1,3,0,8.32007,0.205418 --7.75174,0.841435,1.02703,2,3,0,8.08592,0.105435 --6.75986,0.969136,1.02703,1,3,0,7.65803,0.231101 --6.8446,0.97582,1.02703,1,3,0,6.88002,0.307418 --8.18471,0.597709,1.02703,1,1,0,8.18546,0.488656 --7.40473,1,1.02703,1,1,0,8.0609,0.407621 --7.13416,1,1.02703,1,1,0,7.41592,0.368876 --6.98697,1,1.02703,1,1,0,7.14861,0.342241 --7.0033,0.920718,1.02703,2,3,0,7.40872,0.168482 --6.85559,1,1.02703,1,1,0,6.9739,0.195212 --7.13044,0.924827,1.02703,2,3,0,7.46839,0.152557 --6.92325,0.921696,1.02703,2,3,0,8.37791,0.181281 --6.91524,1,1.02703,1,1,0,6.96454,0.182744 --6.91225,1,1.02703,1,1,0,6.95825,0.1833 --9.3049,0.572166,1.02703,1,3,0,9.75851,0.571452 --9.18469,1,1.02703,1,1,0,10.2294,0.56371 --9.18469,0.464681,1.02703,1,1,0,11.1769,0.56371 --6.88063,1,1.02703,1,1,0,8.27809,0.317731 --7.99993,0.602157,1.02703,2,3,0,8.87862,0.0931819 --8.8306,0.89007,1.02703,2,3,0,9.95536,0.0643036 --6.78002,0.831749,1.02703,1,3,0,9.19148,0.282473 --6.78002,0.569273,1.02703,1,3,0,8.09031,0.282473 --7.78184,0.728246,1.02703,1,3,0,8.26897,0.103819 --8.15192,0.947887,1.02703,1,1,0,8.25931,0.086708 --9.24519,0.883622,1.02703,1,1,0,9.26506,0.0542337 --9.05757,1,1.02703,1,1,0,9.52294,0.0585274 --9.06086,0.999699,1.02703,1,1,0,9.42626,0.0584487 --6.82197,0.90443,1.02703,2,3,0,10.7334,0.204102 --7.04241,0.945191,1.02703,1,1,0,7.04262,0.16313 --9.39646,0.417166,1.02703,2,3,0,11.6929,0.577203 --7.38174,1,1.02703,1,1,0,8.70573,0.404662 --6.89901,0.959813,1.02703,1,3,0,7.59142,0.185836 --7.04591,0.965129,1.02703,1,1,0,7.06111,0.162673 --6.76312,1,1.02703,1,3,0,6.98254,0.228706 --7.17665,0.8937,1.02703,1,3,0,7.25158,0.375643 --6.82299,1,1.02703,2,3,0,7.2183,0.203799 --6.88942,0.98265,1.02703,1,1,0,6.89945,0.187758 --7.12592,0.823141,1.02703,2,3,0,8.36922,0.153058 --6.98619,1,1.02703,1,1,0,7.12701,0.170985 --7.16852,0.959754,1.02703,1,1,0,7.1947,0.148479 --7.32825,0.968146,1.02703,1,1,0,7.39177,0.133695 --6.75544,0.964484,1.02703,1,3,0,7.33022,0.265428 --7.59072,0.703948,1.02703,2,3,0,8.47516,0.114828 --7.59357,0.883279,1.02703,1,3,0,8.80526,0.430294 --9.43121,0.467445,1.02703,1,1,0,9.65384,0.579355 --7.95397,1,1.02703,1,1,0,9.1971,0.467629 --7.30401,0.785283,1.02703,1,3,0,8.92066,0.135737 --7.61126,0.945228,1.02703,1,1,0,7.66803,0.113553 --9.31341,0.897141,1.02703,2,3,0,9.53787,0.571992 --9.49854,0.927466,1.02703,1,1,0,10.5188,0.583475 --7.1275,1,1.02703,1,1,0,8.58213,0.367785 --6.74925,0.729643,1.02703,2,3,0,8.18634,0.256222 --6.75177,0.982459,1.02703,2,3,0,6.82962,0.260926 --6.76457,0.995573,1.02703,1,3,0,6.77463,0.227732 --6.76457,0.659863,1.02703,1,3,0,7.98354,0.227732 --6.75492,0.876046,1.02703,2,3,0,7.42192,0.264873 --7.1504,0.890307,1.02703,1,3,0,7.27937,0.150387 --7.00707,1,1.02703,1,1,0,7.15458,0.167945 --6.75441,1,1.02703,2,3,0,6.98039,0.264307 --6.78118,0.990871,1.02703,1,3,0,6.8001,0.218766 --7.23064,0.859547,1.02703,2,3,0,7.65564,0.383813 --9.13078,0.459281,1.02703,1,1,0,9.22234,0.560165 --7.06332,1,1.02703,2,3,0,8.33151,0.35678 --7.06332,0.754073,1.02703,1,1,0,7.56086,0.35678 --6.83798,1,1.02703,1,1,0,6.99455,0.305339 --6.96256,0.955895,1.02703,1,1,0,6.98138,0.337154 --6.75602,1,1.02703,1,3,0,6.89449,0.266028 --6.75786,0.9994,1.02703,1,1,0,6.76014,0.267801 --6.97281,0.766791,1.02703,2,3,0,7.78383,0.339321 --7.4827,0.920493,1.02703,2,3,0,7.48421,0.121964 --7.2497,0.956728,1.02703,2,3,0,8.18363,0.140553 --6.79693,0.954346,1.02703,1,3,0,7.34784,0.29038 --7.35218,0.810609,1.02703,2,3,0,7.76375,0.131738 --7.94726,0.846994,1.02703,1,3,0,8.90156,0.466989 --7.92528,1,1.02703,1,1,0,8.39816,0.464878 --10.1502,0.400102,1.02703,1,1,0,10.4775,0.620416 --7.08882,1,1.02703,2,3,0,8.93427,0.361265 --6.75916,0.999224,1.02703,1,3,0,7.04936,0.231657 --6.8143,0.991366,1.02703,2,3,0,6.82715,0.297237 --6.98876,0.976477,1.02703,2,3,0,6.9935,0.170603 --7.16034,0.962062,1.02703,1,1,0,7.18859,0.149333 --7.78603,0.887794,1.02703,1,1,0,7.79046,0.103597 --7.37637,1,1.02703,1,1,0,7.76359,0.129816 --7.09622,1,1.02703,1,1,0,7.34864,0.156457 --7.00127,1,1.02703,2,3,0,7.11874,0.168773 --6.75422,1,1.02703,1,3,0,6.95031,0.236253 --6.74924,0.999474,1.02703,1,3,0,6.75602,0.256196 --7.29946,0.895353,1.02703,2,3,0,7.41674,0.136127 --9.11666,0.799543,1.02703,2,3,0,9.75289,0.0571315 --9.23011,0.990073,1.02703,1,1,0,9.55722,0.0545644 --7.6751,0.943397,1.02703,1,3,0,9.02864,0.10974 --8.47521,0.891463,1.02703,1,1,0,8.49929,0.0749092 --7.74052,1,1.02703,1,1,0,8.40881,0.106048 --6.9658,1,1.02703,1,3,0,7.58271,0.174117 --6.7616,0.972845,1.02703,2,3,0,7.0719,0.270968 --7.06108,0.942814,1.02703,2,3,0,7.11077,0.160731 --7.6725,0.961182,1.02703,2,3,0,7.67321,0.109891 --7.83233,0.975123,1.02703,1,1,0,7.97919,0.101195 --7.19476,1,1.02703,1,1,0,7.71935,0.145811 --6.86858,1,1.02703,2,3,0,7.09677,0.314446 --7.325,0.924026,1.02703,2,3,0,7.33664,0.133965 --6.99606,1,1.02703,2,3,0,7.26398,0.169528 --6.89673,1,1.02703,1,1,0,6.993,0.186286 --7.0853,0.985247,1.02703,2,3,0,7.09558,0.157754 --6.7495,0.99415,1.02703,1,3,0,7.03427,0.243254 --6.76857,0.968447,1.02703,2,3,0,6.90417,0.275891 --6.87428,0.982716,1.02703,2,3,0,6.88447,0.190951 --8.12708,0.812423,1.02703,2,3,0,8.52443,0.0877206 --6.79027,0.997889,1.02703,2,3,0,8.05944,0.214891 --6.75881,0.808174,1.02703,2,3,0,7.96124,0.231946 --6.78828,0.982446,1.02703,2,3,0,6.85634,0.286534 --6.97413,0.936378,1.02703,1,1,0,6.97652,0.339596 --6.97413,0.652973,1.02703,1,1,0,7.65707,0.339596 --7.71391,0.748358,1.02703,1,1,0,7.75249,0.443494 --6.79308,1,1.02703,1,3,0,7.61279,0.213783 --6.86152,0.981539,1.02703,1,1,0,6.86523,0.193818 --7.83243,0.721751,1.02703,2,3,0,8.83189,0.455738 --7.98176,0.979994,1.02703,2,3,0,8.39294,0.470263 --6.88428,1,1.02703,1,1,0,7.56485,0.318697 --7.38126,0.828155,1.02703,1,1,0,7.39942,0.404599 --6.9617,1,1.02703,2,3,0,7.26487,0.33697 --6.9617,0.193037,1.02703,1,1,0,9.41317,0.33697 --7.04733,0.968258,1.02703,1,1,0,7.11369,0.353881 --7.63882,0.906106,1.02703,2,3,0,7.63888,0.11188 --6.93921,0.911132,1.02703,2,3,0,8.50466,0.332032 --8.59314,0.745723,1.02703,2,3,0,8.60608,0.521967 --10.2773,0.503936,1.02703,1,1,0,10.8906,0.627067 --8.2257,1,1.02703,1,1,0,9.88601,0.492207 --6.86888,1,1.02703,1,1,0,7.70327,0.31453 --7.33275,0.924861,1.02703,2,3,0,7.34752,0.398184 --8.61848,0.796013,1.02703,2,3,0,8.76576,0.523898 --7.11308,0.912827,1.02703,1,3,0,9.0756,0.154506 --7.22212,0.977195,1.02703,1,1,0,7.28605,0.143141 --6.76674,0.988969,1.02703,2,3,0,7.29225,0.226349 --7.07884,0.837769,1.02703,2,3,0,7.75187,0.158535 --7.07884,0.437717,1.02703,2,3,0,11.8225,0.158535 --7.04719,1,1.02703,1,1,0,7.14002,0.162506 --9.06821,0.749087,1.02703,1,3,0,9.29635,0.058273 --8.45517,1,1.02703,2,3,0,9.12079,0.0755738 --9.98553,0.86269,1.02703,1,1,0,9.98693,0.0405916 --7.71049,0.978443,1.02703,1,3,0,9.79713,0.107717 --7.21093,1,1.02703,1,1,0,7.63471,0.14422 --6.84697,0.879209,1.02703,2,3,0,8.14354,0.308147 --7.10281,0.965301,1.02703,2,3,0,7.10765,0.155687 --7.68854,0.947369,1.02703,2,3,0,7.72714,0.44078 --7.0843,1,1.02703,2,3,0,7.52979,0.360481 --7.0843,0.473484,1.02703,1,3,0,8.98043,0.360481 --6.93505,0.947682,1.02703,1,3,0,7.39169,0.179198 --7.08722,0.939519,1.02703,2,3,0,7.50999,0.157525 --7.60225,0.890882,1.02703,2,3,0,8.22142,0.114109 --6.92578,1,1.02703,1,3,0,7.45829,0.180828 --6.75008,0.965064,1.02703,2,3,0,7.18105,0.242042 --6.75823,0.995933,1.02703,2,3,0,6.77134,0.268134 --6.79917,0.985732,1.02703,2,3,0,6.82957,0.211509 --6.74911,0.998129,1.02703,1,3,0,6.79616,0.25585 --7.72543,0.654024,1.02703,2,3,0,8.89157,0.106881 --6.74808,0.947646,1.02703,1,3,0,7.69701,0.251314 --6.8103,0.970749,1.02703,2,3,0,6.88823,0.295744 --6.77354,1,1.02703,1,1,0,6.80224,0.278922 --6.87939,0.983757,1.02703,2,3,0,6.88088,0.317398 --6.75353,1,1.02703,1,3,0,6.83862,0.263275 --6.75353,0.214761,1.02703,1,3,0,11.9467,0.263275 --7.38308,0.842953,1.02703,1,3,0,7.39768,0.404836 --7.06401,1,1.02703,1,1,0,7.34609,0.356903 --7.02632,1,1.02703,2,3,0,7.14532,0.349963 --6.77366,0.673725,1.02703,2,3,0,8.37127,0.278988 --6.8516,0.973566,1.02703,1,1,0,6.85396,0.309545 --7.0106,0.943486,1.02703,1,1,0,7.03181,0.346943 --7.0106,0.402998,1.02703,1,1,0,8.38067,0.346943 --7.0106,0.353789,1.02703,1,3,0,9.65945,0.346943 --6.76343,0.995903,1.02703,1,3,0,6.99986,0.228494 --6.80609,0.995598,1.02703,2,3,0,6.80656,0.209096 --6.80609,0.718836,1.02703,1,3,0,8.26204,0.209096 --6.78243,0.986316,1.02703,2,3,0,6.91633,0.218202 --7.06898,0.943129,1.02703,1,3,0,7.07518,0.159745 --6.93626,1,1.02703,1,1,0,7.06191,0.178989 --7.14794,0.952084,1.02703,1,1,0,7.16199,0.150651 --6.94574,0.966815,1.02703,2,3,0,7.53669,0.177379 --7.17232,0.935464,1.02703,1,3,0,7.50332,0.374969 --7.17232,0.579784,1.02703,1,3,0,8.58284,0.374969 --7.00221,0.918077,1.02703,1,3,0,7.59695,0.168639 --6.74877,0.813585,1.02703,2,3,0,8.3533,0.245175 --6.85833,0.97051,1.02703,1,3,0,6.8727,0.31153 --9.12537,0.577407,1.02703,2,3,0,9.15373,0.0569291 --6.8844,0.799249,1.02703,1,3,0,9.85978,0.318731 --6.8844,0.898115,1.02703,1,1,0,7.08916,0.318731 --6.8485,1,1.02703,1,1,0,6.90138,0.308613 --7.77585,0.702564,1.02703,1,1,0,7.77919,0.449979 --7.96464,0.924823,1.02703,1,1,0,8.34932,0.468643 --7.57367,1,1.02703,1,1,0,8.09052,0.428027 --7.65891,0.96572,1.02703,1,1,0,7.96846,0.437565 --6.88537,1,1.02703,1,1,0,7.37461,0.318984 --6.77357,0.991941,1.02703,1,3,0,6.91828,0.222481 --6.86025,0.988905,1.02703,2,3,0,6.87491,0.312086 --6.84382,0.974,1.02703,2,3,0,7.01384,0.198118 --6.77879,0.955678,1.02703,2,3,0,7.19243,0.219877 --7.36592,0.88214,1.02703,1,3,0,7.4139,0.130639 --6.749,0.979211,1.02703,1,3,0,7.3041,0.244494 --6.79692,0.988187,1.02703,1,3,0,6.79986,0.212331 --6.88845,0.991883,1.02703,2,3,0,6.89112,0.187956 --6.99128,0.975004,1.02703,1,1,0,7.01028,0.170229 --6.99128,0.823392,1.02703,1,3,0,8.15113,0.170229 --6.77068,1,1.02703,2,3,0,6.94798,0.277218 --6.99001,0.929382,1.02703,1,3,0,7.10597,0.170417 --6.83994,1,1.02703,1,1,0,6.95688,0.199121 --6.93775,0.975178,1.02703,1,1,0,6.94757,0.178734 --7.01155,0.964535,1.02703,1,3,0,7.30324,0.347128 --6.94126,0.942748,1.02703,1,3,0,7.33046,0.178134 --6.74834,0.995433,1.02703,2,3,0,6.96168,0.246879 --6.79913,0.987112,1.02703,1,3,0,6.80382,0.211523 --7.66159,0.656208,1.02703,2,3,0,8.89531,0.437858 --6.78677,1,1.02703,1,3,0,7.55667,0.216326 --6.84011,0.995133,1.02703,2,3,0,6.8439,0.199077 --6.84011,0.821734,1.02703,1,3,0,7.72951,0.199077 --6.76332,1,1.02703,2,3,0,6.82351,0.272281 --7.76808,0.66199,1.02703,2,3,0,8.78824,0.104553 --8.50935,0.902434,1.02703,1,1,0,8.54729,0.0737945 --8.09085,1,1.02703,1,1,0,8.58726,0.0892278 --7.54172,1,1.02703,1,1,0,8.04991,0.117971 --7.32063,1,1.02703,1,1,0,7.57745,0.13433 --6.75817,1,1.02703,2,3,0,7.23224,0.268083 --6.75817,0.677431,1.02703,1,3,0,7.7012,0.268083 --6.88631,0.967258,1.02703,1,3,0,6.88654,0.31923 --7.27379,0.863938,1.02703,1,1,0,7.29591,0.390042 --8.93605,0.505658,1.02703,1,1,0,9.04922,0.546955 --7.24991,1,1.02703,1,1,0,8.34939,0.386625 --7.25583,0.99766,1.02703,1,1,0,7.44194,0.387479 --8.93379,0.502732,1.02703,1,1,0,9.04025,0.546798 --7.65186,1,1.02703,2,3,0,8.59712,0.111103 --7.89408,0.962761,1.02703,1,1,0,8.01573,0.0981237 --6.96881,1,1.02703,1,3,0,7.7185,0.173644 --6.75865,0.956095,1.02703,2,3,0,7.34623,0.232075 --6.75204,1,1.02703,1,1,0,6.7571,0.238901 --6.78037,0.991656,1.02703,1,3,0,6.79301,0.282656 --6.76785,0.894791,1.02703,2,3,0,7.24379,0.225674 --6.83863,0.9802,1.02703,1,1,0,6.83875,0.199464 --7.11297,0.970962,1.02703,2,3,0,7.16663,0.365374 --7.59778,0.824699,1.02703,1,1,0,7.69539,0.430771 --6.88326,0.976375,1.02703,2,3,0,7.88016,0.18903 --6.74958,1,1.02703,1,3,0,6.85573,0.243063 --6.74958,0.562815,1.02703,1,3,0,9.09094,0.243063 --6.76181,0.996371,1.02703,1,3,0,6.76708,0.271127 --6.76181,0.970291,1.02703,1,1,0,6.82075,0.271127 --6.82203,0.990555,1.02703,2,3,0,6.82771,0.204081 --6.9272,0.967437,1.02703,1,3,0,7.06068,0.329286 --7.79608,0.713034,1.02703,1,1,0,7.81761,0.452055 --6.92785,1,1.02703,2,3,0,7.47978,0.329436 --7.34883,0.935244,1.02703,2,3,0,7.38291,0.400337 --7.34883,0.378562,1.02703,1,3,0,9.61424,0.400337 --6.74885,1,1.02703,1,3,0,7.19582,0.244943 --6.75145,0.999655,1.02703,2,3,0,6.75172,0.260439 --7.61153,0.784816,1.02703,1,3,0,7.89005,0.113537 --8.29383,0.90284,1.02703,1,1,0,8.32705,0.0812321 --7.58683,1,1.02703,2,3,0,8.21516,0.115072 --8.28726,0.899481,1.02703,1,1,0,8.31622,0.0814749 --6.94054,1,1.02703,1,3,0,8.09648,0.178256 --6.80699,1,1.02703,1,1,0,6.907,0.208794 --6.80699,0.901604,1.02703,1,3,0,7.23823,0.208794 --6.81944,0.998867,1.02703,2,3,0,6.83384,0.204853 --6.74888,1,1.02703,1,3,0,6.80383,0.244857 --6.91486,0.955772,1.02703,1,3,0,6.93429,0.326376 --6.91486,0.4496,1.02703,1,1,0,8.1409,0.326376 --6.91486,0.461793,1.02703,1,1,0,8.10181,0.326376 --6.85065,1,1.02703,1,1,0,6.91947,0.309263 --6.89499,0.642015,1.02703,2,3,0,8.46344,0.32147 --6.83369,1,1.02703,1,1,0,6.89518,0.303954 --6.84052,0.997588,1.02703,1,1,0,6.86867,0.306146 --7.26412,0.637298,1.02703,2,3,0,8.551,0.139241 --6.76043,0.99665,1.02703,1,3,0,7.17831,0.230663 --6.77335,0.998742,1.02703,2,3,0,6.7752,0.222594 --6.87717,0.971563,1.02703,1,1,0,6.87717,0.190324 --6.87717,0.796484,1.02703,1,3,0,7.857,0.190324 --6.90549,0.935795,1.02703,2,3,0,7.32451,0.324097 --7.01764,0.779341,1.02703,2,3,0,7.85482,0.166463 --7.03458,0.95034,1.02703,2,3,0,7.49384,0.35152 --6.80082,1,1.02703,1,1,0,6.95455,0.292006 --6.7802,0.91197,1.02703,2,3,0,7.12559,0.282568 --6.99871,0.92608,1.02703,1,3,0,7.13579,0.169143 --7.45743,0.968779,1.02703,2,3,0,7.46018,0.123749 --7.24908,1,1.02703,1,1,0,7.48487,0.14061 --7.32662,0.940873,1.02703,2,3,0,8.07714,0.13383 --9.41782,0.827849,1.02703,1,3,0,9.56116,0.0506184 --10.9614,0.903037,1.02703,1,1,0,10.977,0.0282139 --9.60406,1,1.02703,1,1,0,10.9158,0.0470373 --6.80139,1,1.02703,2,3,0,8.85286,0.292241 --6.76177,0.948402,1.02703,2,3,0,6.99347,0.271101 --6.78244,0.836928,1.02703,2,3,0,7.51908,0.218199 --6.75119,0.994901,1.02703,2,3,0,6.80631,0.260031 --6.82878,0.964113,1.02703,2,3,0,6.9228,0.202142 --6.82878,0.798615,1.02703,1,3,0,7.83459,0.202142 --6.83774,0.916597,1.02703,2,3,0,7.33011,0.305264 --7.79358,0.695889,1.02703,1,1,0,7.79531,0.451799 --8.15025,0.420489,1.02703,1,3,0,10.4997,0.0867757 --7.31784,1,1.02703,1,1,0,8.01042,0.134564 --6.80517,0.946945,1.02703,1,3,0,7.43709,0.293756 --6.77562,0.915711,1.02703,2,3,0,7.11523,0.280106 --6.75593,1,1.02703,1,1,0,6.76988,0.265935 --6.75593,0.796863,1.02703,1,3,0,7.54915,0.265935 --6.99451,0.953116,1.02703,2,3,0,7.04312,0.169754 --6.77787,0.95001,1.02703,2,3,0,7.51466,0.22032 --6.75107,0.984215,1.02703,2,3,0,6.87437,0.240331 --7.42183,0.834702,1.02703,1,3,0,7.47952,0.409791 --6.75305,0.549513,1.02703,2,3,0,9.53612,0.262676 --6.74835,0.997717,1.02703,2,3,0,6.76425,0.246816 --6.76286,0.972826,1.02703,2,3,0,6.87831,0.271937 --7.10533,0.868102,1.02703,2,3,0,7.42037,0.155395 --7.93335,0.938091,1.02703,2,3,0,8.08021,0.465655 --7.05132,0.908393,1.02703,1,3,0,8.374,0.161973 --6.82821,0.939243,1.02703,2,3,0,7.85724,0.202301 --6.8664,0.938635,1.02703,2,3,0,7.22149,0.313836 --8.05854,0.651318,1.02703,1,3,0,8.94484,0.0906042 --8.05854,0.904804,1.02703,1,1,0,8.83316,0.0906042 --6.74802,0.864746,1.02703,2,3,0,9.05919,0.249882 --6.75914,0.969188,1.02703,2,3,0,6.89314,0.268941 --6.75914,0.844258,1.02703,1,3,0,7.17186,0.268941 --6.82247,0.978955,1.02703,1,1,0,6.82264,0.300167 --6.74951,0.999287,1.02703,1,3,0,6.81315,0.243229 --6.80157,0.98374,1.02703,2,3,0,6.84297,0.210654 --7.1021,0.944246,1.02703,1,3,0,7.10481,0.155769 --6.99223,1,1.02703,1,1,0,7.11641,0.170089 --7.06335,0.983756,1.02703,1,1,0,7.1104,0.160447 --8.18366,0.769431,1.02703,1,3,0,8.77931,0.488565 --8.1601,1,1.02703,1,1,0,8.7314,0.4865 --7.35193,1,1.02703,2,3,0,7.932,0.131758 --8.0326,0.890592,1.02703,1,1,0,8.04568,0.0917319 --7.39888,1,1.02703,1,1,0,7.94786,0.128075 --7.41286,0.907256,1.02703,1,3,0,8.34804,0.408656 --6.8634,1,1.02703,1,1,0,7.21675,0.312987 --6.80795,0.954281,1.02703,2,3,0,7.09013,0.208476 --6.82956,0.994136,1.02703,1,1,0,6.84255,0.201921 --6.76159,0.991837,1.02703,2,3,0,6.85683,0.270957 --6.90315,0.827106,1.02703,2,3,0,7.48513,0.323518 --8.5705,0.519242,1.02703,1,1,0,8.57661,0.52023 --7.38041,1,1.02703,1,1,0,8.2496,0.404489 --8.2946,0.686951,1.02703,1,1,0,8.47526,0.498062 --7.02163,1,1.02703,1,1,0,7.82631,0.34907 -# -# Elapsed Time: 0.009 seconds (Warm-up) -# 0.023 seconds (Sampling) -# 0.032 seconds (Total) -# diff --git a/src/test/interface/example_output/corr_gauss.nom b/src/test/interface/example_output/corr_gauss.nom index a6cd709481..64d07f8279 100644 --- a/src/test/interface/example_output/corr_gauss.nom +++ b/src/test/interface/example_output/corr_gauss.nom @@ -9,8 +9,8 @@ No divergent transitions found. Checking E-BFMI - sampler transitions HMC potential energy. E-BFMI satisfactory. -Effective sample size satisfactory. +Rank-normalized split effective sample size satisfactory for all parameters. -Split R-hat values satisfactory all parameters. +Rank-normalized split R-hat values satisfactory for all parameters. Processing complete. diff --git a/src/test/interface/example_output/corr_gauss_depth15.nom b/src/test/interface/example_output/corr_gauss_depth15.nom index f348c9e339..aa9095d6c7 100644 --- a/src/test/interface/example_output/corr_gauss_depth15.nom +++ b/src/test/interface/example_output/corr_gauss_depth15.nom @@ -7,8 +7,8 @@ No divergent transitions found. Checking E-BFMI - sampler transitions HMC potential energy. E-BFMI satisfactory. -Effective sample size satisfactory. +Rank-normalized split effective sample size satisfactory for all parameters. -Split R-hat values satisfactory all parameters. +Rank-normalized split R-hat values satisfactory for all parameters. Processing complete, no problems detected. diff --git a/src/test/interface/example_output/corr_gauss_depth8.nom b/src/test/interface/example_output/corr_gauss_depth8.nom index 32c345dc92..5a476ee328 100644 --- a/src/test/interface/example_output/corr_gauss_depth8.nom +++ b/src/test/interface/example_output/corr_gauss_depth8.nom @@ -9,8 +9,8 @@ No divergent transitions found. Checking E-BFMI - sampler transitions HMC potential energy. E-BFMI satisfactory. -Effective sample size satisfactory. +Rank-normalized split effective sample size satisfactory for all parameters. -Split R-hat values satisfactory all parameters. +Rank-normalized split R-hat values satisfactory for all parameters. Processing complete. diff --git a/src/test/interface/example_output/eight_schools.nom b/src/test/interface/example_output/eight_schools.nom index b306a5bb6b..ae4fc866dc 100644 --- a/src/test/interface/example_output/eight_schools.nom +++ b/src/test/interface/example_output/eight_schools.nom @@ -11,8 +11,8 @@ Checking E-BFMI - sampler transitions HMC potential energy. The E-BFMI, 0.26, is below the nominal threshold of 0.30 which suggests that HMC may have trouble exploring the target distribution. If possible, try to reparameterize the model. -Effective sample size satisfactory. +Rank-normalized split effective sample size satisfactory for all parameters. -Split R-hat values satisfactory all parameters. +Rank-normalized split R-hat values satisfactory for all parameters. Processing complete. diff --git a/src/test/interface/example_output/epil.1.csv b/src/test/interface/example_output/epil.1.csv new file mode 100644 index 0000000000..5f8f69ca07 --- /dev/null +++ b/src/test/interface/example_output/epil.1.csv @@ -0,0 +1,1046 @@ +# stan_version_major = 1 +# stan_version_minor = 3 +# stan_version_patch = 0 +# model = epil_model +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = 0 (Default) +# thin = 1 (Default) +# adapt +# engaged = 1 (Default) +# gamma = 0.050000000000000003 (Default) +# delta = 0.65000000000000002 (Default) +# kappa = 0.75 (Default) +# t0 = 10 (Default) +# algorithm = hmc (Default) +# hmc +# engine = nuts (Default) +# nuts +# max_depth = 10 (Default) +# metric = diag_e (Default) +# stepsize = 1 (Default) +# stepsize_jitter = 0 (Default) +# id = 1 +# data = src/models/bugs_examples/vol1/epil/epil.data.R +# init = 2 (Default) +# random +# seed = 1434802924 +# output +# sample = samples.csv (Default) +# append_sample = 0 (Default) +# diagnostic = (Default) +# append_diagnostic = 0 (Default) +# refresh = 100 (Default) +# save_warmup = 0 (Default) +lp__,accept_stat__,stepsize__,treedepth__,a0,alpha_Base,alpha_Trt,alpha_BT,alpha_Age,alpha_V4,b1.1,b1.2,b1.3,b1.4,b1.5,b1.6,b1.7,b1.8,b1.9,b1.10,b1.11,b1.12,b1.13,b1.14,b1.15,b1.16,b1.17,b1.18,b1.19,b1.20,b1.21,b1.22,b1.23,b1.24,b1.25,b1.26,b1.27,b1.28,b1.29,b1.30,b1.31,b1.32,b1.33,b1.34,b1.35,b1.36,b1.37,b1.38,b1.39,b1.40,b1.41,b1.42,b1.43,b1.44,b1.45,b1.46,b1.47,b1.48,b1.49,b1.50,b1.51,b1.52,b1.53,b1.54,b1.55,b1.56,b1.57,b1.58,b1.59,b.1.1,b.2.1,b.3.1,b.4.1,b.5.1,b.6.1,b.7.1,b.8.1,b.9.1,b.10.1,b.11.1,b.12.1,b.13.1,b.14.1,b.15.1,b.16.1,b.17.1,b.18.1,b.19.1,b.20.1,b.21.1,b.22.1,b.23.1,b.24.1,b.25.1,b.26.1,b.27.1,b.28.1,b.29.1,b.30.1,b.31.1,b.32.1,b.33.1,b.34.1,b.35.1,b.36.1,b.37.1,b.38.1,b.39.1,b.40.1,b.41.1,b.42.1,b.43.1,b.44.1,b.45.1,b.46.1,b.47.1,b.48.1,b.49.1,b.50.1,b.51.1,b.52.1,b.53.1,b.54.1,b.55.1,b.56.1,b.57.1,b.58.1,b.59.1,b.1.2,b.2.2,b.3.2,b.4.2,b.5.2,b.6.2,b.7.2,b.8.2,b.9.2,b.10.2,b.11.2,b.12.2,b.13.2,b.14.2,b.15.2,b.16.2,b.17.2,b.18.2,b.19.2,b.20.2,b.21.2,b.22.2,b.23.2,b.24.2,b.25.2,b.26.2,b.27.2,b.28.2,b.29.2,b.30.2,b.31.2,b.32.2,b.33.2,b.34.2,b.35.2,b.36.2,b.37.2,b.38.2,b.39.2,b.40.2,b.41.2,b.42.2,b.43.2,b.44.2,b.45.2,b.46.2,b.47.2,b.48.2,b.49.2,b.50.2,b.51.2,b.52.2,b.53.2,b.54.2,b.55.2,b.56.2,b.57.2,b.58.2,b.59.2,b.1.3,b.2.3,b.3.3,b.4.3,b.5.3,b.6.3,b.7.3,b.8.3,b.9.3,b.10.3,b.11.3,b.12.3,b.13.3,b.14.3,b.15.3,b.16.3,b.17.3,b.18.3,b.19.3,b.20.3,b.21.3,b.22.3,b.23.3,b.24.3,b.25.3,b.26.3,b.27.3,b.28.3,b.29.3,b.30.3,b.31.3,b.32.3,b.33.3,b.34.3,b.35.3,b.36.3,b.37.3,b.38.3,b.39.3,b.40.3,b.41.3,b.42.3,b.43.3,b.44.3,b.45.3,b.46.3,b.47.3,b.48.3,b.49.3,b.50.3,b.51.3,b.52.3,b.53.3,b.54.3,b.55.3,b.56.3,b.57.3,b.58.3,b.59.3,b.1.4,b.2.4,b.3.4,b.4.4,b.5.4,b.6.4,b.7.4,b.8.4,b.9.4,b.10.4,b.11.4,b.12.4,b.13.4,b.14.4,b.15.4,b.16.4,b.17.4,b.18.4,b.19.4,b.20.4,b.21.4,b.22.4,b.23.4,b.24.4,b.25.4,b.26.4,b.27.4,b.28.4,b.29.4,b.30.4,b.31.4,b.32.4,b.33.4,b.34.4,b.35.4,b.36.4,b.37.4,b.38.4,b.39.4,b.40.4,b.41.4,b.42.4,b.43.4,b.44.4,b.45.4,b.46.4,b.47.4,b.48.4,b.49.4,b.50.4,b.51.4,b.52.4,b.53.4,b.54.4,b.55.4,b.56.4,b.57.4,b.58.4,b.59.4,sigmasq_b,sigmasq_b1,sigma_b,sigma_b1,alpha0 +# Adaptation terminated +# Step size = 0.0912059 +# Diagonal elements of inverse mass matrix: +# 0.00514964, 0.0164189, 0.136691, 0.0373078, 0.129678, 0.0063384, 0.084918, 0.0914396, 0.0984498, 0.0933355, 0.0607823, 0.0581269, 0.0814062, 0.0698373, 0.0595323, 0.0716688, 0.0581346, 0.0627179, 0.0790696, 0.0619455, 0.0675787, 0.0759281, 0.125448, 0.062572, 0.0801937, 0.0696032, 0.0800921, 0.0866751, 0.0831688, 0.0574813, 0.0496204, 0.110307, 0.11476, 0.0572242, 0.0742208, 0.0582014, 0.109405, 0.0955795, 0.0757185, 0.0761355, 0.0518875, 0.0737803, 0.106076, 0.0996074, 0.0648819, 0.128578, 0.102644, 0.080497, 0.0626866, 0.0538236, 0.0656591, 0.127835, 0.0539588, 0.13398, 0.107848, 0.071894, 0.0576675, 0.0864753, 0.0704093, 0.0978736, 0.0895867, 0.049038, 0.106836, 0.174931, 0.0927091, 0.107491, 0.0896856, 0.101119, 0.096376, 0.101808, 0.0810368, 0.104484, 0.105905, 0.0865275, 0.105769, 0.0893455, 0.105213, 0.105671, 0.0780459, 0.10179, 0.0990919, 0.0729661, 0.0652669, 0.0652717, 0.059714, 0.0716705, 0.0874516, 0.0879786, 0.0873065, 0.0814566, 0.0943656, 0.103015, 0.100216, 0.04741, 0.0532874, 0.0512453, 0.0646567, 0.0764098, 0.0821246, 0.0787039, 0.0824585, 0.0715345, 0.0684867, 0.0873532, 0.0866062, 0.0617753, 0.0638205, 0.0712298, 0.0613013, 0.0673363, 0.076498, 0.0760931, 0.0693152, 0.0853495, 0.0909551, 0.0884303, 0.101635, 0.071048, 0.0660399, 0.060565, 0.0619235, 0.0583748, 0.0558994, 0.0615101, 0.0685286, 0.0764358, 0.0814483, 0.0777531, 0.0784756, 0.101902, 0.0993178, 0.0878353, 0.0953601, 0.0442957, 0.047076, 0.0457411, 0.0414397, 0.0778984, 0.0971785, 0.0873413, 0.0975895, 0.0802793, 0.0764537, 0.0801133, 0.0915831, 0.0954758, 0.0989211, 0.100024, 0.111702, 0.101252, 0.106511, 0.0950901, 0.102923, 0.0958734, 0.0818964, 0.0995881, 0.0850026, 0.075327, 0.0675716, 0.0816818, 0.0734626, 0.0581286, 0.0520929, 0.0394527, 0.0497244, 0.087697, 0.117403, 0.0961834, 0.116798, 0.0939963, 0.102207, 0.115359, 0.0967084, 0.0587699, 0.0720321, 0.0545346, 0.0670846, 0.0731495, 0.0612049, 0.0702849, 0.072175, 0.0859132, 0.0773837, 0.0918899, 0.0798993, 0.112132, 0.0980613, 0.1019, 0.109705, 0.106375, 0.107193, 0.0984473, 0.100389, 0.0939813, 0.104179, 0.0816827, 0.0937976, 0.0834273, 0.0966134, 0.10076, 0.0822539, 0.0462975, 0.0526743, 0.0588672, 0.0626639, 0.0895119, 0.0969911, 0.0872799, 0.0922495, 0.0906939, 0.0986754, 0.108761, 0.0777629, 0.0910151, 0.0773072, 0.082477, 0.0760273, 0.0796818, 0.0655312, 0.0883391, 0.0871082, 0.102049, 0.107778, 0.107976, 0.106621, 0.108046, 0.090303, 0.108297, 0.0933515, 0.0897567, 0.0956962, 0.119541, 0.122026, 0.0696641, 0.0510513, 0.0574657, 0.065707, 0.0666601, 0.0748296, 0.0741633, 0.0786604, 0.0582098, 0.0716939, 0.0833883, 0.0901544, 0.104989, 0.12936, 0.0931097, 0.112262, 0.0723296, 0.06618, 0.0853071, 0.0777806, 0.112181, 0.104432, 0.0958621, 0.107401, 0.0394697, 0.0427412, 0.0425151, 0.0492268, 0.0872379, 0.0815048, 0.0877116, 0.0984519, 0.0753151, 0.0689038, 0.0905306, 0.0787085, 0.101135, 0.0886025, 0.0931491, 0.0953315, 0.0625519, 0.0589986, 0.052681, 0.0538377, 0.107233, 0.0861134, 0.0964864, 0.0990043, 0.0829435, 0.0986394, 0.0856391, 0.0954638, 0.0864772, 0.0568565, 0.065292, 0.0715314, 0.095215, 0.0904198, 0.0950905, 0.107694, 0.124136, 0.099056, 0.10865, 0.106357, 0.0961571, 0.101178, 0.0955816, 0.10238, 0.0397262, 0.0752223 +3405.39,0.725089,0.0912059,5,1.59421,0.874397,-1.46391,0.49877,-0.108302,-0.0536995,0.136065,0.0586859,0.224502,0.365848,-0.291491,0.0369414,-0.477141,0.0173397,-0.286078,0.904883,0.404072,-0.191664,-0.354202,-0.281719,-0.098408,-1.20696,-0.632029,0.186985,-0.464426,-0.186654,-0.284883,0.195765,-0.441891,-0.0574328,0.683481,-0.725214,-0.703495,0.0847444,-0.809537,-0.0643052,-0.446951,0.678668,0.223414,-0.48005,0.710714,0.41677,0.766636,-1.27316,-0.0955865,0.332249,-0.574799,0.0979022,0.605075,-0.0114607,0.0760947,0.221377,0.393695,-0.567562,0.522971,-0.383271,-0.691532,-1.53359,0.323732,0.00809296,0.358533,1.06018,-1.16776,-1.21067,0.732088,0.610749,0.338741,-0.784631,-0.0585826,0.0308145,-0.363969,0.846516,0.99557,0.0922163,0.467997,0.262396,0.306681,0.260623,0.162635,0.0335022,0.369873,0.0507242,0.0448565,-0.173655,0.116943,0.235661,-0.0341032,-0.0056678,0.352444,-0.213976,-0.10887,0.326941,-0.0575329,0.2411,0.199074,0.158067,0.357371,-0.153447,0.102991,0.660115,0.260914,0.186147,0.152823,-0.275299,0.0776317,-0.258538,-0.118156,-0.317383,-0.259014,0.796129,-0.453324,-0.366719,-0.0587478,0.200813,-0.113872,0.525102,-0.022486,-0.560186,0.399093,-0.0295143,-0.549802,0.101841,0.2425,0.329843,0.234777,0.107845,-0.228621,0.102416,0.345624,-0.0743608,0.109284,0.195713,0.104896,-0.318338,-0.43558,-0.0141311,-0.223253,0.293303,0.1702,-0.610469,-1.01884,0.215795,0.282075,-0.229298,0.264733,-0.551282,0.204428,0.414704,0.174021,0.329105,0.0598403,-0.0968964,0.195222,0.0571276,-0.0594738,0.51097,0.244432,0.196738,0.227069,-0.649995,0.197322,0.291074,0.594753,0.551649,-0.185501,0.376389,-0.37264,-0.191162,0.17803,0.254751,0.315807,0.0790396,-0.160658,0.285491,-0.294972,0.521087,-0.766483,0.0188933,0.380812,0.591926,0.59335,0.620253,0.312975,0.162119,-0.661738,-0.108216,-0.540599,-0.177954,-0.249986,-0.216055,0.319133,0.417078,0.0569965,-0.589498,0.0662654,-0.108489,0.539145,-0.688209,-1.03544,0.44358,-0.0867892,-0.800683,0.02266,-0.404678,-0.000604482,0.626858,-0.620676,0.88813,0.688776,0.434195,-0.234698,0.0230446,-0.0662964,-0.047818,0.0832872,0.137407,0.081681,0.265517,0.426888,-0.953289,0.441949,-0.891106,-0.157004,-0.375436,-0.141302,0.187846,-0.235181,-0.355427,-0.973325,-0.533614,0.0265201,-0.129817,-0.263668,0.25783,0.34574,0.467248,0.136537,0.606798,0.499258,-0.372698,-0.192866,-0.158012,0.000658903,0.169444,0.899354,0.445412,0.221387,-0.306471,0.00997802,-0.0197922,-0.0808428,-0.203235,0.1335,0.128575,-0.110761,0.243281,-0.44844,0.356156,0.228589,0.153027,0.376612,-0.175723,0.486836,-0.138117,-0.139153,0.0737574,-0.163588,-0.733199,-0.864655,-0.15666,-0.0945315,-0.344584,-0.430999,-0.173148,-0.106821,0.0480643,0.597945,0.254613,0.995247,0.31356,-0.177458,0.0776411,0.235507,-0.0950454,0.10747,0.0119089,0.47701,-0.22947,0.271711,0.478501,-0.309558,-0.156245,0.0653024,0.395175,0.230714,-1.04758,0.0210212,-0.48178,0.271373,-0.616392,0.0506982,0.152093,0.253549,0.389991,0.503537,0.717431 +3401.35,0.920203,0.0912059,4,1.58112,0.812114,-1.16122,0.442649,-0.236518,-0.138078,-0.541805,0.498535,-0.06282,0.141883,-0.231764,-0.369009,-0.502015,0.210537,-0.145682,1.02797,0.389326,-0.505778,0.012942,-0.215137,-0.153858,-0.743397,-0.92683,0.113434,-0.0456523,-0.0686684,-0.356455,0.123858,-0.205612,0.146588,0.641167,-0.877396,-0.756991,0.438116,-0.552242,0.166376,-0.525711,0.620913,0.287095,-0.173893,0.914862,0.59815,0.416618,-0.94644,-0.235771,-0.280136,-0.935147,0.296558,0.757818,-0.258431,0.0356307,0.336708,0.178169,-0.360138,0.520353,-0.10326,-0.315962,-0.823177,0.254654,0.0634841,0.540415,0.881777,-0.657562,-0.753298,0.424375,0.788266,0.00372179,-0.322751,-0.0184961,-0.151577,-0.455704,0.856326,1.31982,0.0429627,0.552152,0.410295,0.212209,0.382148,-0.165836,-0.0844095,0.829891,-0.497864,0.100343,0.22425,-0.128235,0.0696011,-0.0874932,-0.0680744,-0.0786583,-0.534141,0.250945,0.46494,-0.190739,0.124659,-0.16311,0.40081,0.228702,-0.192298,-0.191905,0.687465,0.25968,0.282413,-0.1009,-0.312944,0.419654,0.085953,-0.0474519,-0.35921,0.131839,0.309198,-0.58173,-0.534115,-0.209461,0.32434,0.0814852,0.533226,-0.27846,-0.480367,0.110142,-0.187344,-0.715503,0.20157,0.369717,0.262147,0.271195,-0.17522,-0.613426,0.0428136,0.315714,0.448158,0.301071,0.267362,0.0547558,-0.109545,-0.0827297,0.363179,-0.479318,0.534931,0.273448,-0.320072,-0.706422,0.0956312,-0.0496505,-0.164937,0.538542,-0.328862,-0.102679,0.262972,0.408487,0.601712,-0.491349,-0.349291,0.220927,0.263794,-0.195714,0.187869,0.12644,0.445943,0.240387,-0.555809,0.223795,0.359147,0.567079,0.781876,-0.356278,0.335664,-0.152754,0.233835,0.352785,0.101248,0.241224,0.125254,-0.161485,0.227641,-0.0206848,0.357035,-0.448448,-0.393188,-0.0628473,0.335177,0.3457,0.425892,0.140578,0.0654846,-0.806806,0.0541955,-0.441286,-0.116692,-0.132739,-0.0943411,0.300916,0.137095,-0.190174,-0.484618,0.380688,0.141736,0.133378,-0.588611,-0.808216,0.605593,-0.0451989,-0.756922,0.135304,-0.465323,0.0254262,0.106201,-0.437614,0.942874,0.976343,0.546096,-0.31214,0.00593878,-0.0436117,0.287634,-0.00127085,0.4014,-0.0123691,0.118357,0.166183,-0.647439,0.200293,-0.675033,-0.196612,-0.592037,-0.251713,0.151746,-0.483014,0.0341262,-1.10011,-0.443188,-0.123528,-0.23723,-0.465978,0.199877,0.560272,0.342385,-0.398247,0.519228,0.167487,0.0965134,0.417419,-0.673781,0.0558792,-0.134703,0.329114,0.0449324,0.663287,0.307099,0.123397,-0.303976,-0.231364,-0.00158301,-0.0619371,-0.0236342,-0.246641,0.630141,-0.44631,0.522573,0.111331,0.258347,0.242131,0.102625,0.205522,0.208303,0.361134,0.229651,-0.0298081,-0.660305,-0.885435,-0.0682854,0.0626501,-0.606319,0.131982,-0.0351921,-0.0515505,-0.12585,0.379796,0.175874,0.321136,0.249443,-0.0190652,-0.363281,0.0969218,-0.0707027,-0.121838,-0.237907,0.222207,-0.105112,0.0834309,0.513526,-0.0187703,0.156601,-0.233518,0.155533,0.0409897,-1.0378,-0.0408542,-0.23686,-0.288022,-0.272916,-0.296149,0.161439,0.279778,0.401794,0.52894,1.15538 +3435.86,0.946448,0.0912059,4,1.5164,0.870986,-1.53056,0.469672,-0.2703,-0.111936,-0.206152,0.258662,-0.0885106,0.270341,-0.351981,-0.113641,-0.381722,-0.00868111,0.0968654,0.639354,0.470915,-0.476119,-0.191529,-0.247143,-0.513087,-1.07199,-0.809396,0.127871,-0.265467,-0.139613,-0.0600052,0.144353,-0.376876,-0.0519462,0.606978,-0.719317,-0.159636,0.230921,-0.482987,0.23321,-0.635917,0.539055,0.128368,-0.124042,0.937795,0.553128,0.411167,-1.12552,-0.0534861,0.214352,-0.843932,0.482935,0.636226,-0.103576,0.208122,0.264697,0.37992,-0.598622,0.473783,-0.0607053,-0.0796308,-0.628773,0.614516,0.25786,0.691171,1.28945,-0.679491,-0.584528,0.994092,0.99322,0.0243464,-0.129282,-0.195986,-0.210244,-0.594515,0.530261,1.0206,0.211005,0.404046,0.228523,0.258441,0.208312,-0.0648136,0.163135,0.54873,-0.453374,0.358341,-0.136146,-0.380401,0.0884323,0.337382,-0.0878498,0.192696,-0.582407,-0.116989,0.219568,-0.288157,-0.204475,-0.185381,0.428889,0.294982,-0.335354,-0.305181,0.801976,0.100041,0.532209,0.174212,-0.264772,0.0766637,0.035432,-0.187076,-0.113712,-0.197851,0.713659,-0.366204,-0.627872,0.103534,0.352706,0.13599,0.23151,-0.05671,-0.384334,-0.191464,-0.247025,-0.727969,0.220358,0.339985,0.310802,0.699891,0.0191462,-0.3095,-0.167331,0.158719,-0.00846623,0.284376,0.484309,0.060312,0.375763,-0.257479,0.302486,0.0964735,0.232374,0.243424,-0.235536,-0.940482,0.155933,-0.224838,-0.455614,0.141177,-0.322592,-0.312108,0.299849,0.0805415,0.0437563,-0.316163,-0.324592,0.197054,0.256094,-0.126263,0.688826,-0.0413431,0.437023,0.240046,-0.0449207,0.118208,0.0102841,0.481208,0.809272,0.0593644,0.108703,-0.577571,-0.120161,0.311394,0.1549,-0.059198,0.152519,-0.212163,0.187445,-0.101444,0.246826,-0.313034,-0.608705,0.302712,0.523554,0.259862,0.467841,0.170402,0.0785413,-0.59831,-0.116454,-0.657245,-0.160575,0.0621643,-0.237755,0.544037,0.185127,-0.355043,-0.709444,-0.0202241,0.39756,0.165137,-0.424423,-0.744391,0.300986,-0.115984,-0.859283,-0.0226037,-0.668355,0.243013,-0.0446501,-0.736378,1.09986,0.751509,0.530827,-0.213465,0.0817894,0.320027,0.596817,-0.0292347,0.154632,0.116138,0.277354,0.132634,-0.247539,-0.137714,-0.371703,-0.186824,-0.679671,-0.11736,0.191171,-0.439887,-0.0477124,-0.491578,-0.218646,-0.0165045,0.120008,-0.239044,-0.0659745,0.200988,0.3587,0.124264,0.06181,0.438701,0.00892043,0.369146,-0.343213,-0.0984713,0.312132,0.464879,0.173793,0.444953,0.053078,0.35398,-0.352166,-0.133361,0.112072,0.0387206,-0.332926,-0.354349,0.676426,-0.182493,0.483157,-0.0296003,0.194649,0.292713,0.336775,0.0149366,0.331788,0.0651995,0.0279562,0.0969963,-0.58356,-0.460236,-0.104245,-0.275664,-0.15946,-0.176224,0.244292,0.104303,0.0724971,0.262826,-0.0421069,0.60246,0.155045,0.273399,-0.12898,0.189033,0.0347013,0.255051,-0.0841633,0.167757,0.423596,0.0930499,0.431581,-0.0595702,-0.36331,-0.141067,0.557004,-0.0910737,-0.780842,-0.0338324,-0.0846147,0.215523,0.0220207,-0.0910078,0.141914,0.231262,0.376715,0.480897,1.26063 +3445.27,0.979842,0.0912059,4,1.51428,0.776677,-0.804196,0.296033,-0.36562,-0.0682187,0.0925377,0.0676815,0.579094,0.111359,-0.200934,-0.475467,0.00409408,0.811848,0.297466,0.342339,0.82039,0.0222041,0.0904493,-0.101559,-0.395953,-0.887555,-0.814513,0.420791,-0.162291,-0.0992438,0.0802568,-0.0401226,0.379847,-0.0103084,0.90518,-0.0461214,-0.314245,0.152892,-0.764445,-0.163717,-0.609299,0.344781,0.265762,-0.266772,1.00714,0.891144,-0.144062,-0.294532,-0.40916,-0.185858,-0.210932,0.773429,0.773308,0.471443,0.0035849,0.852664,0.23965,-0.822703,0.77848,0.0835853,-0.134215,-0.350776,0.471924,0.160361,0.0534983,0.635957,-1.11142,-1.13242,-0.10688,-0.315331,-0.446072,-0.0503017,0.559536,-0.290364,-0.151988,0.36556,0.526213,-0.631342,0.879702,0.273012,0.547508,-0.388153,0.128882,0.00879851,0.545663,-0.23083,0.306928,0.39607,-0.0328154,0.131133,-0.00739144,-0.431245,0.0733223,0.191163,-0.075421,-0.378399,0.191184,0.202579,0.0779802,-0.660299,0.312108,-0.472469,0.284542,0.231956,0.126782,-0.440449,-0.748397,-0.0625566,0.0996642,-0.235633,0.112489,-0.292401,0.337836,0.812206,-0.236068,0.0247004,0.030883,0.300774,-0.130106,0.272595,-0.534569,0.140123,0.121197,0.262188,-0.095971,0.10723,-0.297408,-0.632267,-0.47958,0.153549,0.476164,0.0360095,0.321636,-0.439608,-0.271529,-0.0562981,-0.257047,0.828834,-0.277866,-0.0914591,-0.0638737,-0.176095,0.6551,-0.203101,0.463981,0.0793642,0.445882,-0.390802,-0.409681,0.0250781,-0.330007,0.483784,-0.0817426,0.140222,0.0614705,0.532961,0.0839701,0.0802577,0.562596,0.274714,0.445275,-0.25989,0.187571,0.00817206,0.342363,-0.13867,0.903745,-0.506897,-0.0935059,0.0672162,-0.0861877,-0.712331,-0.00540376,-0.165581,-0.23264,0.297967,-0.0365167,-0.177383,-0.103196,-0.293331,-0.551156,0.151862,0.190473,0.810665,0.0553661,-0.206953,0.171581,-0.204277,0.132792,-0.625487,-0.0467419,-0.322408,0.449252,-0.431235,-0.00629443,-0.597236,0.236362,-0.409711,-7.49983e-05,-0.424181,0.397184,-0.0227036,-0.344901,0.0163378,0.275494,0.229725,0.100086,0.134733,-0.367164,-0.228393,-0.166414,0.990438,-0.389102,-0.210086,0.321872,-0.346622,-0.0317754,-0.0996711,-0.144106,-0.00964303,-0.536459,0.38145,0.0485,-0.114182,-0.0688543,-0.433817,0.746189,0.488016,-0.434625,0.384093,-0.72136,-0.502797,-0.0621066,0.164864,-0.361061,-0.0301283,-0.0682768,-0.355263,-0.45439,0.154528,-0.443671,-0.0446729,0.41302,-0.702478,-0.223866,0.0492734,-0.220106,-0.211732,0.178011,-0.0633788,0.315119,0.746945,-0.155731,0.213159,0.035861,-0.614769,0.0129296,-0.209701,-0.720236,0.642297,-0.0324893,-0.0226119,0.479914,0.151581,-0.0524329,-0.266289,0.33717,-0.376179,-0.0628794,0.136542,0.0558215,0.437882,0.301987,0.137242,-0.0462071,0.0292496,-0.379309,0.139259,0.303743,-0.504867,0.246168,0.19896,0.258848,-0.272094,-0.407428,0.491089,-0.312781,-0.0592863,-0.317873,0.0380087,0.0702506,-0.361296,-0.242522,-0.077384,-0.0695961,0.350516,-0.180886,-0.0255697,-0.422196,-0.138788,-0.283437,0.118514,-0.12499,-0.266291,0.104238,0.121188,0.300883,0.348121,0.548528,1.51378 +3451.86,0.723113,0.0912059,5,1.6093,0.732162,-1.38623,0.592336,0.79472,-0.0557122,-0.62818,-0.402433,-0.0696743,-0.178102,0.089062,0.144394,-0.225025,0.39358,-0.304049,0.786311,0.120173,0.209862,-0.541343,-0.0255589,-0.1445,-0.426025,-0.275072,0.390145,-0.0568728,-0.292719,-0.0650016,-0.129936,-0.485457,-0.367643,0.859645,-0.368878,-0.0746027,0.788979,-0.568367,-0.00823192,-0.0548629,0.865162,0.68226,-0.0675827,1.05376,0.279707,0.386525,-0.413145,-0.0245129,0.399736,-0.427543,-0.376739,0.0250815,-0.0438695,0.00626076,0.218217,-0.0939653,0.101017,0.517698,-0.314363,-0.453259,-0.758018,0.274569,-0.472262,-0.0211671,1.00336,-0.19701,-0.56865,-0.323041,0.444115,0.354546,0.0036034,-0.438825,-0.441806,0.0294977,0.142853,0.626442,0.279022,0.178492,0.265876,0.230831,0.41873,-0.553399,0.0941995,0.313633,-0.229995,0.108847,-0.465768,-0.0926099,-0.323343,-0.124907,0.0427538,0.311726,-0.468339,0.0338532,0.357142,-0.139599,-0.128891,-0.236103,0.211977,-0.0741557,0.306388,-0.326154,0.395541,0.0686435,0.50482,0.053604,-0.204766,0.0832902,-0.20692,0.148616,0.183257,0.101879,0.158039,0.224426,-0.350872,0.0148477,0.446484,0.222197,-0.134276,0.171975,-0.0908116,0.253468,-0.42023,-1.02931,-0.378898,-0.020515,0.303902,0.101158,0.281119,-0.0806896,0.134809,0.317414,-0.32378,0.401914,-0.0665838,0.180774,0.102637,-0.318261,0.0626102,0.146254,0.00538566,0.183573,-0.593611,-0.964794,0.0202056,-0.137431,-0.261553,0.531046,-0.150207,0.0664738,0.430384,-0.177658,-0.399925,-0.43047,-0.123009,0.33071,-0.362586,-0.372676,0.594837,0.105016,0.103382,0.104729,0.0534809,0.0980885,-0.131742,0.442997,0.467376,0.0250154,0.029417,0.130554,0.481449,-0.298536,0.244586,0.572047,-0.517831,0.0484769,0.107421,0.107475,0.302796,-0.0352957,-0.456136,0.070772,0.655176,-0.134643,0.0169568,0.00201154,-0.0429049,-0.178726,0.0921791,-0.339963,-0.157697,-0.00306425,-0.150739,0.241723,0.49482,-0.373298,-0.665957,0.0121888,0.829804,-0.199976,-0.454141,-0.559493,0.148022,-0.0957427,-0.515992,0.342843,-0.271816,0.371953,0.107667,-0.312426,0.914335,0.329859,0.477482,-0.234296,0.0644317,-0.239895,0.219834,-0.0501681,0.72348,0.040442,-0.0970036,0.516813,-0.271619,-0.014755,-0.171161,-0.797427,-0.19136,-0.271463,0.527797,0.129599,-0.46728,0.297772,-0.040632,-0.0582722,0.155314,-0.207624,0.234514,0.0870984,0.770204,0.444019,-0.0188998,0.347272,0.0355459,-0.0104573,-0.0154904,-0.0107469,0.333132,0.333202,0.163772,0.50081,-0.446799,-0.00180907,-0.545614,-0.203333,-0.30179,0.560422,-0.0751853,0.276971,-0.12019,-0.326112,0.0727139,-0.307171,0.084549,0.40312,0.816574,-0.375269,0.536115,0.251697,0.389095,-0.110526,-0.646504,-0.466708,0.0547206,-0.200348,-0.616168,-0.147006,0.0927683,-0.0729013,0.337543,0.0790745,-0.122207,0.272134,0.111117,0.256244,-0.745326,-0.11339,0.179565,0.407947,0.30359,-0.0926026,0.899538,0.219351,-0.309415,-0.0374008,-0.203928,0.372067,0.364273,0.0738868,-0.674686,0.201569,-0.107399,-0.379538,0.0559593,-0.325812,0.104567,0.177028,0.323368,0.420747,-2.1429 +3414.86,0.877882,0.0912059,5,1.6447,0.864198,-0.980598,0.420256,0.0867724,-0.0539094,0.221132,0.149027,0.201513,0.622459,0.0728748,-0.118009,-0.312722,0.666586,-0.541189,1.05102,-0.085615,-0.231066,0.0333353,-0.3882,-0.395939,-0.79201,-0.825083,0.0468703,-0.247255,-0.457282,-0.169291,0.801493,-0.293948,0.194739,0.660958,-0.890419,0.0516583,0.175121,-0.34881,-0.0504286,-0.445202,-0.056589,-0.00872368,-0.433893,0.724454,0.683373,-0.00744022,-0.686834,-0.208772,-0.0782615,-0.49974,0.679104,0.304899,-0.197994,-0.0937678,0.159667,-0.0876509,-0.702224,0.384759,0.32556,-0.0477782,-1.10134,-0.0773892,-0.270306,0.184062,0.394792,-0.600044,-0.930747,0.616499,-0.270698,-0.136306,0.0557585,0.471182,-0.275041,-0.460005,0.2755,0.484758,0.193727,0.544123,0.763329,0.650491,-0.00737926,-0.0854652,-0.120456,0.311077,-0.235382,0.294729,0.0909687,0.776265,0.221329,0.0578226,-0.649342,0.457107,-0.132051,0.186916,-0.280817,0.104753,-0.148058,0.0706823,-1.00559,0.254972,-0.48196,-0.0142019,0.358511,-0.122138,-0.109292,-0.607103,-0.339588,0.200777,-0.52252,0.313277,-0.379277,0.650304,0.707837,-0.0675715,0.00784626,0.0813533,0.340695,-0.658874,0.668849,-0.848541,0.696479,0.0211614,0.597019,0.123834,-0.330958,0.111352,-0.53322,-0.13246,0.298618,0.79665,-0.183938,0.0366789,-0.812341,-0.39865,-0.0101545,-0.175048,0.467109,0.0720037,-0.154055,-0.0358563,-0.220172,0.421245,-0.459001,0.328476,0.0301818,-0.0585111,-0.761344,-0.498962,0.322727,-0.0620417,0.420235,-0.000122034,0.369871,0.231174,0.379416,-0.253016,-0.0147339,0.554583,0.226874,0.135662,0.106321,0.152879,-0.77379,0.440484,0.208775,0.950757,-0.478241,0.0298219,-0.0416825,-0.17711,-0.752729,-0.23475,0.067544,-0.413449,0.657733,-0.0967817,-0.484918,-0.0978125,0.2334,-0.220975,0.0118065,0.427448,1.01731,0.091045,-0.366958,0.265125,-0.465231,0.0907947,-0.631906,-0.274953,-0.372822,-0.0640121,-0.66994,-0.280856,0.119438,-0.00396796,-0.0684976,0.202423,-0.502449,0.282806,-0.0696903,-0.361704,-0.189535,0.094676,-0.352031,0.301658,0.34597,-0.453541,-0.167732,-0.132345,1.02798,0.0887483,-0.0444835,0.243708,-0.583681,0.356438,0.211064,-0.723207,-0.0400252,-0.718425,0.617828,0.0692316,-0.345836,0.116815,-0.494464,0.305445,0.703716,-0.300604,0.492818,-0.150563,-0.0728826,0.632272,-0.0117813,-0.0648192,0.0238053,-0.444454,-0.703592,-0.52604,0.588033,-0.494056,0.350612,1.08223,-0.406305,-0.267301,-0.579022,0.0265538,-0.000249862,0.0387994,-0.566464,0.214524,0.226145,-0.202195,-0.239643,0.629068,-1.10996,0.286944,-0.0216907,-0.188211,0.563355,-0.456671,-0.176555,0.0305945,0.111687,-0.546747,0.330123,0.439565,-0.704695,0.0894791,0.379341,0.13051,0.583102,0.35235,-0.186633,-0.323417,-0.237903,-0.11977,0.40024,0.159545,-0.0229747,0.311995,0.142629,0.339393,0.13554,-0.299151,-0.109198,-0.592114,-0.407119,-0.0283793,0.24649,-0.250054,-0.466609,-0.163819,0.234129,0.0541466,0.220807,0.0245296,0.410457,0.290763,0.0812516,-0.0238734,0.364529,0.10888,0.0340249,0.143525,0.154773,0.255816,0.393412,0.505782,-0.0410813 +3415.14,0.972968,0.0912059,4,1.65613,0.853044,-0.961821,0.38818,0.112889,-0.0473497,0.178615,0.190715,0.192084,0.573372,0.119353,-0.103837,-0.301768,0.667459,-0.536236,1.04539,-0.104498,-0.222266,0.0833198,-0.391875,-0.370035,-0.812527,-0.848532,0.0759277,-0.237599,-0.446996,-0.190076,0.785012,-0.268269,0.234892,0.656097,-0.877978,0.0540546,0.180598,-0.308683,-0.100706,-0.438326,-0.0775628,0.0380943,-0.452755,0.708726,0.696718,0.0532882,-0.73755,-0.24446,-0.104937,-0.486774,0.695823,0.296051,-0.160094,-0.124862,0.104449,-0.107345,-0.679534,0.35932,0.354685,-0.0467611,-1.13701,-0.0604651,-0.278459,0.199433,0.397948,-0.625581,-0.953691,0.642083,-0.258381,-0.153884,0.0816133,0.442939,-0.236732,-0.453451,0.324136,0.504424,0.228111,0.564322,0.765939,0.671621,-0.0174924,-0.0641648,-0.109084,0.320596,-0.254402,0.280409,0.0469046,0.766007,0.213781,0.0929887,-0.634311,0.476945,-0.110077,0.141201,-0.30541,0.132585,-0.13948,0.0960194,-1.02296,0.26103,-0.529232,0.0181079,0.358972,-0.160136,-0.0583036,-0.654734,-0.341929,0.235373,-0.518791,0.337902,-0.385996,0.643986,0.677361,-0.0903641,-0.00159388,0.130049,0.341208,-0.660251,0.624113,-0.833992,0.676814,0.0160848,0.551452,0.155622,-0.293349,0.146965,-0.452117,-0.102319,0.297003,0.800118,-0.167166,0.0727622,-0.796015,-0.376538,0.0226038,-0.166065,0.470459,0.0569322,-0.158903,0.000465247,-0.187375,0.393183,-0.446584,0.311238,0.058612,-0.0704296,-0.75611,-0.506706,0.316553,-0.056189,0.41073,-0.0181115,0.403785,0.27089,0.360791,-0.267662,-0.0380083,0.476145,0.186081,0.129536,0.113789,0.137267,-0.786987,0.458304,0.167122,0.957594,-0.451773,0.0324677,-0.0373252,-0.184514,-0.787947,-0.228625,0.0103687,-0.374912,0.653542,-0.106158,-0.464515,-0.126616,0.202262,-0.249101,0.0166087,0.466041,1.00415,0.0979414,-0.384127,0.264145,-0.441395,0.0722281,-0.590474,-0.280734,-0.371191,-0.0857941,-0.681823,-0.284252,0.0791547,-0.00771668,-0.0297323,0.234275,-0.548648,0.263585,-0.0819063,-0.388257,-0.195313,0.097869,-0.352966,0.314127,0.31386,-0.427903,-0.170312,-0.132604,1.02335,0.0394634,-0.0212126,0.264832,-0.553102,0.355159,0.22096,-0.75792,0.000674389,-0.714201,0.621411,0.0540957,-0.374841,0.111852,-0.4734,0.342657,0.687928,-0.301354,0.519611,-0.0812089,-0.118009,0.637223,-0.00139695,-0.0879587,0.0428964,-0.482041,-0.711476,-0.517262,0.594901,-0.448501,0.364762,1.0938,-0.40135,-0.278095,-0.57526,0.0392746,-0.0162363,0.069376,-0.589056,0.210219,0.245849,-0.186256,-0.284479,0.647736,-1.18296,0.259646,0.0096875,-0.162539,0.557854,-0.489553,-0.14259,0.000627655,0.132659,-0.574641,0.342661,0.400885,-0.671835,0.0857744,0.383356,0.12134,0.578521,0.35959,-0.18271,-0.319212,-0.229242,-0.138076,0.398982,0.157356,-0.00830284,0.298024,0.118545,0.33044,0.16813,-0.279189,-0.0694314,-0.626792,-0.385898,-0.0223242,0.239034,-0.270552,-0.445318,-0.165326,0.243694,0.0627754,0.180711,0.05039,0.415162,0.286316,0.0944134,-0.0468926,0.376265,0.11004,0.0503275,0.144987,0.152997,0.256517,0.391149,0.506475,-0.0777226 +3426.12,0.956788,0.0912059,4,1.55427,0.835114,-0.925448,0.345961,0.607715,-0.207135,0.162959,0.0644365,0.440703,-0.132893,0.0121443,-0.0416495,0.290234,0.466772,-0.0727758,0.727946,-0.0030176,-0.00970151,0.0668935,-0.0835402,-0.266051,-0.708907,-0.670173,0.417184,-0.339967,0.03366,0.025984,0.337282,0.0588206,-0.223569,0.674438,-0.279484,-0.0375115,0.418805,-0.423686,-0.233868,0.0400453,0.881245,0.536151,0.203466,0.610944,0.451286,0.0400808,-0.434742,-0.236368,0.0761477,-0.478048,-0.144325,0.743386,-0.173707,0.246012,0.235578,0.491529,-0.0229855,0.555217,-0.696503,-0.289648,-0.38794,0.549039,-0.563101,0.173389,0.925778,-0.286116,-0.937217,-0.56478,0.409836,0.0961639,-0.0131966,-0.41233,-0.282603,0.0668741,0.084852,0.579796,0.0176888,0.44029,0.466176,0.397529,-0.366075,-0.444537,0.0947663,0.33086,0.219114,-0.0443054,0.146429,-0.540612,-0.201827,-0.439033,0.0612501,-0.440055,-0.392999,0.190044,0.245553,0.166741,0.102534,0.0534173,-0.119838,0.154186,0.169577,-0.160458,0.847325,0.00403617,-0.15854,-0.0512178,0.0408117,0.123951,-0.120237,-0.0817733,-0.474366,0.21013,-0.0419,0.544322,-0.381696,-0.309434,0.567554,0.712404,-0.637105,0.0391727,-0.313625,0.667974,-0.45844,-1.13746,-0.11942,-0.422846,0.190797,-0.372129,0.0779542,-0.788936,0.356771,0.390023,0.0944389,0.264777,-0.160836,0.335978,0.378566,0.0869808,0.0431456,-0.0748606,0.107623,0.0879496,-0.379827,-0.214989,-0.218357,0.47936,0.181065,0.144578,-0.333132,-0.457373,0.132317,-0.0441008,-0.432679,-0.453436,-0.059733,0.459707,0.00851471,-0.0118816,0.4948,0.239313,-0.362838,0.594304,0.482798,0.325715,-0.301548,0.609286,0.187341,-0.0407574,0.103305,-0.464655,0.356625,-0.28843,0.084814,0.245416,-0.624791,-0.00943353,0.409633,0.0583246,-0.00144018,-0.108657,0.134865,-0.652612,0.708891,-0.33168,0.23948,0.0577568,-0.0367067,-0.381695,0.253621,-0.211434,-0.150293,0.182112,-0.206851,0.267821,-0.0547475,0.297977,-1.02346,0.0169849,0.605685,-0.17394,-0.732299,-0.379146,0.141573,-0.317328,-0.0427676,0.228707,0.0855491,0.00668536,-0.142025,-0.720835,1.07949,0.288036,0.357582,-0.113932,0.175671,0.0097259,-0.19447,0.370399,0.661209,-0.167254,0.212012,0.294054,0.086447,-0.104784,-0.162272,-0.300316,-0.185371,-0.436712,-0.278036,-0.0188967,-0.525625,-0.228079,-0.163243,0.3387,0.294578,0.150291,0.2802,-0.0995633,0.474157,0.357855,-0.263178,0.274369,-0.424309,0.749131,0.223213,-0.0851743,0.0973485,0.249955,0.634858,0.661275,-0.0734257,-0.113612,-0.312694,-0.513778,0.313751,0.840506,0.243076,-0.393021,-0.0552071,-0.158513,0.290043,0.133203,-0.0901698,0.833195,0.148428,-0.280593,0.488657,-0.0828869,0.163717,0.0687073,-0.518222,-0.157719,0.270248,0.199191,-0.393534,-0.520672,-0.220644,0.113635,0.0102907,0.467356,-0.169544,0.745858,0.0478987,0.181664,0.207416,-0.207021,0.186297,-0.273176,0.54939,-0.135584,0.694405,0.163905,-0.187009,0.167742,-0.0121302,0.094762,-0.297168,-0.227136,-0.276258,0.452112,-0.00616415,-0.103419,-0.0265298,0.10885,0.11751,0.151933,0.342798,0.389785,-1.72973 +3415.51,0.628673,0.0912059,4,1.51588,1.08383,-0.85502,0.300855,0.843444,-0.0608842,0.309741,0.474574,0.124348,0.145736,-0.0883681,-0.192064,-0.192547,0.215832,-0.461704,0.523208,-0.113845,0.113669,0.155415,-0.0943787,-0.532707,-0.850365,-0.685902,0.0724309,-0.241363,0.103619,0.0276554,0.324301,-0.213609,0.444196,0.234105,-0.265126,0.397946,0.206056,0.125337,-0.406887,-0.525609,0.395342,0.299386,-0.503944,1.01429,0.221809,0.736895,-0.580049,-0.373832,-0.435343,-0.213938,0.556476,0.467504,0.236013,-0.221322,0.437455,-0.00751108,-0.312855,0.312512,-0.097041,-0.0992085,-0.614784,0.346798,-0.513328,0.444202,0.827174,-0.517238,-0.34763,0.226842,-0.00876967,-0.362851,0.0936948,0.588071,-0.368161,0.143151,0.325103,0.662103,0.00819942,1.20616,0.705889,0.185803,0.284433,-0.285111,-0.0737356,0.710414,-0.695435,0.0804343,-0.213377,-0.705267,0.413331,0.781634,-0.57265,0.533046,0.172544,0.0386133,-0.0724697,-0.120614,-0.103851,0.150604,-0.0907554,-0.352568,-0.648732,0.364397,0.170904,0.696679,0.304233,-0.53747,-0.0834958,0.377322,0.188579,-0.0701641,-0.372987,0.44657,0.677971,0.188577,0.157764,0.153628,0.558112,0.162901,0.375039,-0.932793,0.543559,0.129825,-0.050128,-0.246585,0.000839922,-0.000965215,-0.122031,-0.00387885,0.0935916,1.00448,0.49599,0.354877,-0.807424,-0.218427,0.100835,0.0864618,1.23454,-0.233133,-0.474671,-0.196917,-0.526177,0.480524,-0.893388,-0.44208,-0.201215,-0.0140771,-1.12433,0.297777,0.810102,0.240215,0.66745,0.278017,-0.0682394,0.428332,0.361548,0.138744,0.452307,0.492205,0.119468,0.566841,0.0420761,0.201974,0.175992,-0.103154,-0.441242,1.09351,-0.344925,-0.369375,-0.163561,-0.0170294,-0.298465,0.037956,0.0029748,-0.0551055,0.3427,0.100465,0.27432,0.0597559,0.0805244,-0.330491,-0.0502809,0.755418,0.882088,0.429725,0.0771343,0.368739,-0.0109744,-0.0687561,-0.680674,0.0104702,-0.499992,-0.00503535,-0.606072,-0.256582,0.141401,0.446166,-0.165218,-0.0489165,-0.165147,-0.329242,0.295188,-0.755303,0.643996,-0.19004,-0.234251,0.408289,0.241134,0.141491,-0.468914,-0.122331,1.25404,-0.146454,-0.178971,0.0124763,-0.60016,0.196531,0.316167,-1.21802,0.215289,0.0891299,0.43898,0.292382,-0.853996,-0.103738,-0.518662,-0.113722,0.413224,-0.104545,0.464124,-0.679459,-0.329152,-0.0574107,-0.269594,-0.12855,0.0701383,-1.08961,-0.362288,-0.941812,0.207096,0.414717,-0.165084,0.830959,0.00217133,-1.01875,0.760382,-0.697856,-0.02614,0.64132,0.426351,0.532416,0.116489,-0.0540927,-0.259217,0.511695,-0.809675,0.256901,-0.58765,0.00387396,0.186433,-0.136167,-0.0187354,0.558212,-0.101367,-0.176937,0.492211,0.199377,0.252076,0.0567098,-0.15061,0.384838,0.272731,0.3858,-0.130174,-0.542896,0.235041,0.647527,0.125301,-0.0785828,-0.032656,0.326043,0.107143,-0.167216,0.0129728,-0.0326804,-0.539084,-0.0851436,-0.0124394,-0.12527,-0.0614008,-0.355924,0.180779,-0.410324,0.298698,0.211501,0.617686,0.300069,0.0464598,0.240122,-0.390319,-0.162832,0.180438,0.0757847,-0.545769,-0.212187,0.206772,0.180517,0.454722,0.424872,-3.0212 +3394.19,0.585064,0.0912059,4,1.56938,1.13807,-0.511192,0.184071,0.966284,0.0135629,0.133935,0.0739557,0.462373,0.0288055,0.206113,-0.283737,0.42034,0.0707615,-0.31915,0.339125,-0.309333,0.0810204,0.09886,-0.335134,-0.456409,-0.510354,-1.03299,-0.11488,0.113463,0.269253,0.12928,0.252579,-0.164052,-0.443235,0.234412,-0.294156,0.205612,0.212676,-0.264917,-0.384552,-0.528835,0.644656,0.615325,-0.580914,0.918754,0.395283,0.709508,-0.226387,-0.158226,0.152214,-0.862512,0.0633204,0.254023,0.0191566,0.030204,0.0909218,0.229197,-0.481648,0.253097,0.033168,-0.201889,-0.432701,0.0905575,-0.537166,0.225832,0.925774,-0.133574,-0.895896,-0.442461,0.265212,-0.314178,0.358259,-0.284297,-0.618502,-0.120687,0.554763,0.68488,0.47791,1.27449,0.719574,0.207858,0.534315,0.0646101,-0.00714948,0.385846,-0.547506,0.248874,-0.733296,-0.163236,-0.256414,-0.347705,-0.477757,0.293419,0.069539,-0.0038287,0.312578,0.24799,0.0198208,-0.102965,-0.0826894,0.125099,-0.16242,0.784067,0.117812,0.693971,-0.17696,-0.780431,0.219052,-0.0787676,0.205138,-0.12178,-0.113444,0.500176,0.746506,-0.413474,-0.292929,0.404724,0.603512,0.126766,-0.281305,-0.53383,0.0725227,-0.41273,-0.070599,-0.295177,-0.207232,-0.346341,0.246894,0.47512,0.391459,0.98197,0.604275,-0.0913615,-0.842855,-0.211882,-0.384102,0.209286,1.02931,-0.0420039,-0.281209,0.389644,0.60124,0.607587,-0.851607,0.478008,0.116507,-0.317537,-1.04633,-0.145301,0.369609,0.337524,0.312011,0.125512,-0.38607,-0.0985865,0.0478818,-0.0554704,0.234763,0.137255,0.704305,-0.30777,0.223245,-0.127271,-0.201692,-0.0611654,0.179776,0.791248,-0.200244,-0.0811605,0.514262,-0.00606017,0.0938007,0.254054,-0.457967,0.206622,0.903923,0.140812,0.106992,-0.078456,-0.478687,0.338039,0.163321,-0.0487996,0.419995,0.306845,-0.550734,-0.342141,0.330793,0.515004,-0.633501,0.201394,-0.44586,0.20288,-0.375011,0.178527,0.720083,0.365569,-0.375914,0.728706,-0.348347,-0.245461,0.0863435,-1.21422,0.404725,-0.256893,-0.473325,0.0184336,0.129849,0.0248405,-0.676059,-0.142389,1.34625,-0.207894,-0.230597,0.296608,-0.329715,0.209482,0.286046,0.0354369,0.130575,-0.198058,-0.236284,0.285719,-0.561255,-0.532901,-0.57198,-0.419676,0.76551,-0.935027,0.129383,-0.256912,-0.734462,-0.291345,0.548608,-0.00586053,0.444713,-0.157128,0.133236,-0.398781,1.15311,-0.137083,-0.259611,0.367542,-0.229672,-0.576867,1.02215,-0.416151,-0.0322114,0.312883,0.611999,0.0915147,0.775813,0.0596009,-0.0671994,0.0404755,-0.609669,0.585494,-0.492882,-0.188457,-0.042601,-0.361397,-0.342452,0.772781,-0.247972,-0.204851,-0.172016,-0.0241001,0.0639242,-0.0499962,-0.131921,0.301554,0.0457872,0.305986,-0.11331,-0.0359454,-0.438169,0.105874,-0.511788,-0.122746,0.33935,-0.362301,0.137046,-0.0767661,0.145617,0.177737,0.0120782,0.203379,-0.494592,-0.0869423,-0.0606472,0.24526,0.476136,0.125398,0.238705,0.0622372,-0.0646815,0.109426,-0.262482,0.0323777,-0.0370369,-0.416245,-0.252323,0.241719,-0.234252,-0.672509,0.168396,0.171679,0.410361,0.414341,-3.55989 +3402.42,1,0.0912059,4,1.62049,1.00572,-0.771469,0.172945,0.870959,0.0177981,-0.151787,-0.314521,0.222138,-0.0883098,0.339451,-0.330858,-0.00366781,-0.232978,-0.507522,0.659455,-0.258604,0.1375,0.0329644,-0.521681,-0.495929,-0.653654,-0.939624,-0.143821,0.244793,0.144841,0.323681,0.294853,0.0805832,-0.121876,0.140025,-0.0655464,0.0746933,0.0659423,-0.154046,-0.592218,0.038216,0.453735,0.680568,-0.648152,1.0602,0.356931,0.715445,-0.23194,-0.0207607,0.407658,-0.308344,0.249403,0.327309,-0.309033,-0.30758,0.198597,-0.0717213,-0.816357,0.575988,-0.372433,-0.268912,-0.129104,-0.0136557,-0.245075,0.230598,1.16044,-0.344643,-0.54646,-0.247823,0.419945,-0.22118,0.363632,-0.469937,-0.72588,-0.315989,0.370962,0.926825,0.140479,0.850623,0.655814,0.263187,0.450618,-0.192556,-0.274924,0.543509,-0.792407,0.34112,-0.403559,0.412193,-0.226793,-0.323216,-0.476916,0.247075,0.083372,-0.0153184,0.521024,0.0698167,0.0899249,0.309815,0.339422,-0.23647,0.188335,0.640289,0.309588,0.437477,-0.423771,-0.598133,-0.32429,-0.257854,0.0778935,0.148802,-0.439084,0.276078,0.588278,0.193894,0.0703646,0.295461,0.525509,-0.0330397,-0.29522,-0.852038,0.48604,0.0931365,0.0964753,-0.742441,0.215781,-0.21346,0.0644293,-0.146552,0.363334,0.960951,0.413031,0.0122927,-0.909866,-0.314787,0.0975907,-0.0367622,0.866606,-0.337018,-0.182321,0.314629,0.358929,0.137745,-0.621403,0.284185,0.0305588,-0.559799,-0.773786,-0.0668045,0.0216477,0.136275,0.354415,-0.100104,-0.303413,-0.156409,0.155414,0.285055,0.0675215,0.469448,0.39304,-0.0539856,0.0690057,-0.230703,0.0443726,-0.0610572,-0.291452,0.85195,-0.0898167,-0.360438,0.577776,-0.0154223,0.267525,-0.0276731,-0.383809,0.194239,0.974903,0.338474,-0.127356,0.0709109,-0.416961,0.303705,0.241858,-0.161149,0.457464,0.310448,-0.82599,-0.225407,0.412429,0.388187,-0.801484,-0.00432129,-0.582245,0.657696,-0.770737,0.148033,0.662912,0.0613337,-0.367883,0.306766,-0.206218,-0.110735,0.213029,-0.893394,0.0176227,-0.180346,-0.630105,0.0166232,-0.692286,0.220889,-0.584679,-0.730895,1.40411,0.412004,-0.0322142,0.154311,-0.211311,0.244318,-0.0377585,-0.190341,0.0203143,-0.533836,-0.115714,-0.12412,-0.639666,-0.548911,-0.731736,-0.176813,0.0495402,-0.564695,0.312057,-0.19502,-0.972057,0.0913405,0.539269,-0.208525,0.359978,0.49365,0.00352373,-0.144684,0.936205,0.104338,-0.404535,0.736385,-0.388,-0.208643,0.895829,-0.222569,-0.170562,0.593811,0.358781,0.0265533,0.220782,-0.208162,-0.421449,-0.0589874,-0.814053,0.23558,-0.387511,-0.36208,-0.020549,-0.16938,0.0688259,0.482975,-0.085543,0.0635047,-0.409462,-0.454541,0.467137,-0.113514,-0.112262,0.428036,0.334345,-0.331164,-0.0834737,0.257693,-0.0289017,-0.352031,-0.459534,0.0636188,0.306414,-0.100191,-0.136709,0.0684964,0.26689,0.0137937,-0.316318,0.0274656,0.0743313,0.0748202,0.0487703,-0.288004,0.816731,0.428768,0.440474,0.212219,-0.0739133,0.434921,-0.409915,0.254725,0.231768,-0.339387,-0.542496,0.326389,-0.471967,-1.13222,0.203104,0.221096,0.450671,0.470208,-2.81209 +3381.83,0.98368,0.0912059,4,1.59015,0.931455,-1.05729,0.295672,0.711921,0.0533621,0.00861892,-0.0677004,-0.220496,-0.472169,0.0708153,-0.0967614,0.216848,-0.0422211,-0.627311,0.642854,-0.197898,-0.295382,-0.0687019,-0.156635,-0.11753,-0.417994,-0.981211,-0.251978,-0.0259867,-0.0460462,0.374928,0.152101,-0.0401779,-0.119955,0.121626,-0.714515,-0.630602,0.0652969,-0.105159,-0.547091,-0.425005,0.276402,0.492322,-0.803903,1.02905,0.577012,0.0683703,-0.272548,0.0224218,0.365348,-0.232156,0.0901602,0.256856,0.355631,-0.0691177,0.757724,-0.373834,-1.19499,0.363349,-0.461,0.136378,-0.578459,0.0952442,-0.738827,0.308927,1.02718,-0.395281,-0.0377593,0.135254,0.377083,0.221523,0.6298,-0.0430385,-0.952437,-0.499745,0.185004,0.790087,0.0314756,0.195583,0.581547,0.00279732,0.0782737,-0.340403,-0.163761,0.510788,-0.133435,0.640449,-0.251761,0.20121,0.183993,-0.228332,-0.309707,0.361994,-0.0790628,0.11628,0.381094,0.314873,-0.178611,-0.100706,0.160814,0.0626121,0.144616,1.07964,-0.14544,0.681221,-0.108475,-0.562747,-0.21232,-0.0387052,0.140524,-0.314859,-0.13495,0.597066,0.795972,0.19021,-0.254072,-0.0881198,0.990552,-0.249129,-0.0437914,-0.331318,0.373706,0.298797,0.571309,-0.691439,-0.128084,-1.02423,-0.123594,-0.328957,0.0565481,0.693757,0.127245,-0.423335,-0.394744,-0.636841,-0.0507182,0.524084,0.710794,0.00785417,-0.21135,0.26085,-0.0140911,0.461292,-0.55184,0.198075,0.23496,-0.517688,-0.908349,-0.277606,0.353159,-0.18199,0.673808,0.154528,-0.262016,0.550961,0.326235,0.208368,0.283553,0.671359,0.610512,-0.0754074,0.641998,-0.293025,-0.0552283,-0.204778,0.0945799,0.774847,0.340345,0.139525,-0.0493342,0.223982,0.261604,-0.115788,-0.15553,0.70111,-0.417945,0.269721,-0.495188,0.210099,-0.344388,0.548511,0.191542,0.115129,0.424868,-0.356026,-0.865561,0.195845,-0.225645,0.624389,-0.320591,-0.0292978,-0.545564,0.198319,-0.415784,-0.107041,0.830441,0.0393151,-0.407534,0.224996,0.223622,0.279056,-0.290954,-0.858608,-0.254773,0.0305137,-0.451059,-0.555056,-0.762028,0.000334172,-0.465169,-0.357993,1.29402,0.932107,0.296186,0.179526,-0.0678086,0.422571,0.534311,-0.368689,0.0965832,-0.399096,0.165111,0.188409,-0.172529,-0.106073,-0.445656,-0.302155,-0.0362379,-0.356123,0.469848,-0.536465,-0.777029,-0.0401986,0.232309,-0.171963,0.414498,0.842709,-0.143261,-0.144379,1.07278,-0.123456,-0.722701,0.263279,-0.243683,-0.736559,0.469623,0.524806,-0.295773,0.0592462,0.637195,0.246913,-0.00505311,-0.34061,0.0278075,0.138773,-0.745977,0.00798614,-0.298008,-1.05398,-0.0673064,-0.557519,-0.324678,0.366039,0.102505,-0.272628,0.362937,-0.342242,-0.177202,-0.011506,0.0524981,0.181026,0.0780232,-0.0940039,0.0741356,-0.0142854,0.506988,-0.082884,-0.19614,0.0624907,0.327609,0.0938848,-0.357247,-0.0932201,-0.211992,0.0763932,-0.951479,0.0964328,0.17003,0.0967426,-0.306679,0.587963,0.738428,0.599688,-0.505648,0.0377068,0.393942,0.113705,-0.596077,0.242706,-0.127556,-0.332053,-0.260987,0.613618,-0.103561,-0.483825,0.164044,0.167652,0.405023,0.409454,-2.15827 +3387.94,0.972822,0.0912059,4,1.66086,0.933604,-0.56017,0.144626,0.569346,-0.0814948,-0.298262,-0.572201,-0.0261141,0.154907,0.126255,-0.312983,-0.0488833,0.138379,-0.551954,0.354811,-0.0290024,0.0860354,-0.0365936,-0.0792072,-0.0991286,-0.973235,-0.84231,0.0467655,0.0609907,-0.267905,-0.319124,0.472309,-0.680059,-0.348436,0.0854843,-0.453666,0.356424,-0.476956,-0.0546811,0.159557,-0.207151,0.424861,0.178986,-0.472356,0.983808,-0.0651301,0.626595,-0.285579,0.157667,0.0076409,-0.677529,0.149359,-0.0137733,-0.319103,-0.0140245,-0.581681,-0.102454,0.0911997,0.344052,-0.281658,-0.00497822,-0.449617,-0.15195,-0.57149,-0.23725,1.22542,-0.596686,-1.50315,-0.294647,0.165877,0.670053,0.244095,0.879849,-0.501381,0.100598,-0.091477,0.730758,0.382425,0.900674,0.459314,0.483908,-0.0340271,-0.501844,-0.00421507,0.160758,-0.117999,0.211149,-0.519003,-0.200357,-0.135176,0.0837642,-0.159369,0.0486778,-0.191605,0.0296079,-0.0763789,0.721518,0.125229,-0.0133546,-0.729227,0.0759498,-0.17384,-0.177022,0.308308,0.229486,-0.435166,-0.526898,-0.661224,-0.0712093,-0.467667,0.231001,0.13847,0.327789,0.365443,-0.173331,0.36131,0.518464,0.721939,-0.0163112,0.0155228,-0.372686,0.87197,0.45601,0.376087,-0.714827,0.09513,0.254579,0.0179098,0.718671,0.618802,0.799662,0.200551,0.324748,0.26173,-0.0817015,0.319262,0.300587,0.898476,-0.121385,0.00233767,-0.613495,-0.304024,0.3349,-0.938997,-0.173094,0.0745474,-0.022598,0.1169,-0.082352,-0.207298,0.0226664,0.575768,0.440165,-0.299839,-0.616142,0.616999,0.0719477,-0.302401,-0.405171,0.356558,0.953323,-0.0185452,0.164434,0.245937,0.59152,-0.847555,0.450498,-0.403318,0.00369814,-0.402897,-0.0313752,-0.553908,0.241673,-0.277114,0.625281,-0.0761733,0.484347,0.0707174,-0.617154,0.0452479,-0.314871,0.300077,0.0304857,0.409288,0.0501537,-0.0384951,0.197307,-0.385655,-0.517416,0.434929,-0.57797,0.0156253,-0.500187,-0.671979,0.302722,-0.121439,-0.10203,-0.580121,-0.0863218,0.139068,0.0359043,-0.591876,-0.777913,0.49398,0.25869,-0.625905,0.541455,-0.470257,-0.0788093,-0.115323,-0.132758,1.38027,-0.344413,0.385615,0.41513,-0.52924,0.039553,0.498867,-0.320032,-0.293597,-0.126381,0.10486,0.106634,-0.541348,-0.217906,-0.521113,-0.273706,-0.196364,-0.0173132,0.756511,-0.105126,-0.0680435,0.122959,-0.019855,0.0932293,0.531857,-0.584558,-0.695098,-0.62974,1.04791,0.786894,0.645582,0.300926,-0.654556,0.491051,0.323171,-0.335399,0.436649,0.82066,-0.272872,-0.0765716,-0.0942856,-0.414664,-0.357256,-0.364818,0.312024,0.661707,-0.648071,0.0884767,0.16369,-0.319209,-0.333626,0.396806,0.0596618,-0.5577,0.31346,0.545753,-0.877055,0.625624,0.263549,0.536563,0.146373,0.201678,0.554437,-0.887018,-0.43366,-0.389788,-0.378324,0.168064,-0.124567,-0.138328,0.60423,0.0627109,-0.136502,-0.503853,0.0616946,-0.478549,0.141956,0.549588,0.067852,-0.617431,-0.108875,0.382772,-0.307511,0.649817,0.293611,-0.525864,0.528535,0.462853,-0.443423,-0.239005,-0.685845,-0.377576,-0.215377,-0.142348,0.191648,0.202773,0.437776,0.450303,-1.70228 +3372.48,0.958659,0.0912059,5,1.67332,0.900627,-0.526902,0.131814,0.251132,-0.11772,-0.3006,-0.575539,-0.120739,0.0476045,0.195935,-0.197351,-0.0932535,0.13683,-0.53383,0.284104,-0.159023,-0.0466965,-0.0619013,-0.0860042,-0.122103,-0.852488,-0.633029,0.180137,0.134736,-0.149809,-0.239422,0.486128,-0.573926,-0.272713,0.10477,-0.491439,0.3865,-0.428151,0.102531,0.241458,-0.0657162,0.499577,0.072673,-0.287755,0.984648,-0.204217,0.547037,-0.394211,0.0400895,-0.128074,-0.463337,0.13296,-0.104273,-0.330522,0.0921811,-0.656328,-0.171874,0.0182452,0.326429,-0.446004,-0.0735572,-0.6505,-0.134022,-0.520719,0.0913664,1.26052,-0.749574,-1.54699,-0.327817,0.348436,0.964364,0.103118,1.0142,-0.343906,0.330787,-0.0823072,0.802527,0.374923,1.08059,0.508112,0.628289,-0.089362,-0.575581,-0.0560227,0.278989,-0.210542,-0.0977622,-0.6291,-0.195039,-0.184428,0.0224395,-0.232115,-0.00100761,-0.026281,0.340075,-0.223224,0.703098,0.157618,-0.0880012,-0.681723,0.0795238,-0.147269,-0.290965,0.225632,0.36264,-0.437328,-0.590151,-0.57996,-0.00391743,-0.676591,0.150429,0.321095,0.542824,0.432691,-0.18068,0.511316,0.530651,0.685061,-0.161012,0.0729666,-0.574876,0.872512,0.417755,0.176722,-0.762094,-0.0226668,0.140306,0.174144,0.603095,0.438698,0.66878,0.163554,0.241217,0.325387,0.121076,0.382492,0.521021,1.07006,-0.113463,0.0156107,-0.68231,-0.253297,0.236,-0.840362,-0.126156,0.00351642,0.0468758,0.105715,0.0171722,-0.261679,-0.112263,0.662656,0.380875,-0.0958881,-0.613037,0.515692,-0.0345652,-0.430478,-0.377297,0.486514,0.90095,0.0693082,0.113403,0.342195,0.382734,-1.02464,0.437517,-0.55896,0.0622425,-0.293509,-0.140702,-0.623934,0.371777,-0.308653,0.624842,-0.212879,0.436129,0.239892,-0.447791,-0.0252855,0.0616829,0.279704,0.208611,0.295004,0.148401,-0.260163,0.249906,-0.0633012,-0.267747,0.538336,-0.774175,-0.005519,-0.489968,-0.675044,0.365577,-0.225501,-0.150812,-0.646162,-0.297878,0.331509,0.0528221,-0.418111,-0.757074,0.783395,0.222418,-0.86659,0.350468,-0.484838,-0.153984,0.0616852,-0.166853,1.42399,-0.515677,0.0891496,0.540849,-0.327989,-0.101139,0.322531,-0.448501,-0.406778,-0.122745,0.188919,0.162993,-0.549843,-0.170071,-0.428648,-0.0556272,-0.117628,-0.15252,0.829991,-0.190996,-0.0392802,0.0635216,-0.0449333,0.00445126,0.401358,-0.750892,-0.715284,-0.511477,0.993768,1.07848,0.598435,0.51988,-0.535904,0.501223,0.151222,-0.405498,0.352125,0.815489,-0.330913,-0.0973051,-0.291308,-0.39113,-0.31219,-0.251498,0.357999,0.678789,-0.539979,0.122075,0.146276,-0.279852,-0.395474,0.36395,-0.0334275,-0.312418,0.319542,0.486855,-0.809021,0.716241,0.390319,0.524728,0.0721654,0.177318,0.436931,-1.04241,-0.452687,-0.717733,-0.367512,0.0197505,-0.17507,-0.226261,0.857616,0.00624429,-0.0148187,-0.455177,0.103254,-0.292109,0.210935,0.612657,0.227338,-0.544837,0.0910612,0.387726,-0.315878,0.513793,0.34165,-0.571245,0.522395,0.277619,-0.363769,-0.294176,-0.689109,-0.44867,0.0134818,-0.110724,0.199302,0.213204,0.446433,0.46174,-0.571379 +3390.48,0.979048,0.0912059,5,1.58679,0.834251,-0.794567,0.370187,0.549969,0.00916653,-0.0972631,0.289274,-0.197145,0.0246724,-0.0361679,-0.00262207,0.160509,0.235461,-0.0457479,0.374883,0.272653,0.144037,0.245817,0.323537,-0.179505,-0.448871,-0.950487,0.439608,-0.0615571,-0.14015,-0.0598014,0.660341,-0.0268169,-0.0333497,0.507584,-0.375637,0.0458805,0.0225874,-0.0248565,-0.32953,-0.497459,0.301289,0.217772,-0.00388964,0.829373,-0.0802359,0.259428,-0.142091,-0.199786,-0.322479,-0.850109,-0.286102,0.177387,-0.434264,-0.0448208,0.229007,-0.509852,-0.508895,0.394282,-0.308662,0.00457169,-0.723598,0.0580241,-0.635365,-0.0240201,0.5669,-0.588693,-0.48616,0.189081,0.246205,0.623525,0.445514,-0.231001,-0.0354434,0.209892,-0.17553,0.46622,0.502204,1.06138,0.347868,0.624127,-0.057754,-0.148309,0.160215,0.796928,-0.218697,0.19345,0.0772856,0.0291668,-0.318371,-0.277621,-0.686992,0.516243,0.104997,0.120408,0.266383,0.646833,-0.524437,-0.0614803,0.251219,0.409435,-0.0823175,-0.134479,0.117014,0.825811,-0.0310284,-0.735937,-0.719527,0.185261,-1.0365,0.153054,-0.109294,0.44792,0.565461,0.238109,0.290178,0.606222,0.620516,0.0622324,-0.105269,-0.840346,0.375452,0.450875,-0.620732,-0.875081,0.774635,-0.0509672,-0.0279149,0.106077,0.349271,0.223235,0.0289141,0.210853,-0.270911,-0.297353,0.168045,-0.116221,0.719852,0.0217425,-0.618921,-0.187718,0.0904401,0.562703,-0.900083,-0.539791,0.0918453,-0.133847,0.0132124,0.416701,-1.00468,-0.283528,0.824279,0.469371,0.16437,-0.0953167,0.181471,-0.315881,-0.343478,0.830814,0.163917,0.252035,0.113568,0.24672,0.201801,-0.104421,-0.878336,0.973027,0.0811874,-0.424942,0.398924,-0.0837553,-0.433764,-0.342145,0.118939,0.623167,-1.01557,0.0688283,-0.292857,0.0468502,-0.0845557,-0.0999106,0.753935,0.0705051,0.488033,0.451165,-0.572299,-0.0874501,0.59906,-0.0835023,0.0775789,-0.643908,-0.141524,-0.587169,-0.696009,0.197674,-0.00485896,0.173804,-0.452264,-0.0105014,-0.260542,-0.0357123,-0.409514,-1.22125,0.285451,-0.159534,-0.294148,-0.224241,-0.418233,0.573107,-0.265638,-0.220968,1.39305,0.183709,0.283062,0.599166,-0.214847,0.190103,0.418898,-0.774081,0.350718,-0.528982,0.0746434,0.512928,-0.304663,0.137153,-0.260086,0.204155,0.22739,-0.179135,0.701223,-0.325783,0.0481548,-0.0334223,0.334941,-0.423194,0.309493,0.162595,0.0625836,0.212411,0.553304,-0.677391,0.301981,0.692683,-0.280228,-0.841183,0.388325,-0.268176,-0.0728238,1.0896,-0.0529247,0.247516,0.487022,-0.398593,-0.0668252,0.315873,0.189939,0.40679,-0.602786,0.0933397,-0.247444,-0.0642653,-0.240847,0.357565,0.209302,-0.159107,0.885346,0.209014,0.040568,0.690773,0.184715,0.529797,0.0209009,0.366061,0.367188,-0.577934,-0.458707,-0.488524,-0.676895,0.0895977,0.489612,-0.360112,0.272006,0.321456,-0.44444,-0.276535,0.399673,-0.206262,0.1355,0.111336,0.866924,-0.389334,0.21248,0.707285,-0.663491,-0.00237481,0.787218,-0.326962,0.199112,0.821623,-0.966412,-0.609011,0.146367,0.146649,0.231101,0.217778,0.204273,0.12643,0.451966,0.355569,-1.64979 +3392.36,0.918546,0.0912059,5,1.57779,1.00468,-0.494842,0.0535199,0.171368,-0.145744,0.203243,0.00695427,0.535562,0.0420281,-0.382952,-0.473631,-0.386923,0.25702,0.0635059,0.646894,-0.271955,-0.244324,-0.23951,-0.177634,-0.232344,-0.523367,-0.806291,0.234788,-0.192487,-0.361178,-0.35392,-0.344178,-0.282972,0.52227,0.607261,-0.260476,0.397426,0.232605,0.034778,-0.419289,0.063581,0.103273,0.532959,-0.387551,0.740079,0.658353,0.379857,-0.594963,0.16683,0.532368,-0.562206,0.202251,0.220239,0.283922,0.257059,0.441402,0.552244,-0.477329,0.690705,0.263877,0.0386054,-0.245587,0.415467,-0.384088,-0.025555,0.832027,-0.0367337,-0.633641,0.37834,0.183341,-0.658346,-0.437029,0.368969,-0.850934,-0.106702,0.619079,0.670962,-0.629223,0.324791,0.718024,-0.0457185,-0.149959,-0.306525,-0.0290557,-0.0306853,-0.638498,-0.0195095,-0.414311,-0.189712,0.225077,0.114549,0.210513,-0.720116,-0.751734,-0.163587,-0.101722,-0.562922,0.213661,0.208766,-0.834585,-0.327688,-0.297001,0.647444,0.657808,-0.668415,-0.10196,-0.219911,-0.24657,0.105662,0.11736,0.448073,0.165824,0.0362055,0.427274,-0.358341,-0.476228,-0.477072,0.479473,0.0348265,0.549968,0.085696,0.00711027,0.111725,0.415447,-0.496474,-0.784649,-0.313915,-0.584763,0.0209853,0.144462,0.236409,0.157272,0.199611,-0.295174,0.29997,-0.193064,0.268124,0.578382,0.256078,0.166851,0.0358208,-0.329968,0.25645,-0.465897,-0.37102,-0.632338,0.197248,-0.860526,-0.113727,1.38139,0.0893872,-0.215623,0.252313,-0.419088,-0.296607,0.119517,0.297929,0.0591252,-0.326258,0.624242,0.161637,0.113916,0.0409697,-0.141875,0.555371,0.661917,0.532769,-0.02373,0.138719,0.108151,0.227187,0.177206,-0.0206735,-0.163887,-0.0776146,0.764303,-0.119826,0.0531842,-0.0272722,-0.322438,-0.0724015,-1.04629,-0.123823,0.654409,-0.208674,0.174008,0.402198,-0.40652,-0.012654,-0.620909,0.0189454,-0.383715,1.01847,-0.263249,0.34308,0.226118,0.135215,-0.30138,0.0322192,0.196509,0.325829,-0.162363,-0.31668,-0.44419,-0.222721,-0.229684,0.587506,0.148523,-0.757595,0.143179,-0.932836,0.717355,-0.194501,0.0247724,-0.338649,-0.418581,0.410709,-0.154566,0.0799007,0.320532,0.178456,0.459593,0.138574,-0.333963,-0.152395,-0.672557,-0.259262,-0.0827361,-0.484358,0.340643,-0.303513,-0.494437,0.132426,-0.299839,-0.010061,0.0547214,-0.59823,-0.104835,-0.981449,0.466892,0.504089,-0.281694,0.727767,-0.335363,0.392537,-0.442025,0.361483,0.220179,-0.273778,0.382691,0.551493,0.0395887,0.0631457,0.103657,-0.1373,-1.1875,0.696571,-0.0101975,-0.552378,0.707072,-0.327612,0.192091,-0.335262,-0.0558996,0.321312,-0.118062,0.0929329,0.314251,-0.292927,-0.0970508,0.325561,-0.315489,-0.392099,0.130819,0.116748,0.187799,-0.145912,0.591801,0.122288,-0.324966,0.608226,-0.0123108,0.306984,0.437027,0.0400201,-0.687374,-0.492782,0.0409132,0.344997,-0.566065,0.294133,0.316873,-0.329201,0.204137,-0.0462345,-0.559016,0.316516,0.0888684,-0.78153,0.0329754,0.545279,-0.168089,-0.324447,-0.572152,-0.379668,0.176577,0.125871,0.42021,0.354782,-0.521669 +3397,1,0.0912059,5,1.57308,0.998576,-0.5818,0.110621,0.134778,-0.1659,0.214399,-0.0207406,0.517917,0.0236333,-0.282651,-0.516892,-0.333975,0.218965,0.04799,0.623995,-0.23804,-0.252326,-0.243017,-0.195891,-0.240976,-0.482146,-0.71597,0.234425,-0.23148,-0.371811,-0.294317,-0.286565,-0.281658,0.471717,0.670809,-0.322249,0.386206,0.21772,-0.0589282,-0.391346,0.0672207,0.271669,0.480247,-0.321953,0.738629,0.631546,0.289173,-0.54577,0.155109,0.596747,-0.613491,0.245827,0.261774,0.284142,0.286946,0.253726,0.511602,-0.531019,0.702905,0.249184,0.0115094,-0.274196,0.315118,-0.30845,0.107008,0.837228,-0.0184271,-0.682994,0.363859,0.165276,-0.629115,-0.529883,0.306744,-0.782002,-0.0573861,0.592396,0.744769,-0.5586,0.272746,0.691284,-0.105622,-0.220647,-0.331558,-0.0243206,-0.0276624,-0.653192,-0.0133634,-0.267499,-0.182689,0.205384,0.125621,0.235783,-0.743782,-0.799637,-0.133474,-0.109857,-0.573561,0.168944,0.233107,-0.792499,-0.293783,-0.306222,0.675396,0.668923,-0.691142,-0.122198,-0.328936,-0.190672,0.0229661,0.00558878,0.495371,0.164479,0.115946,0.410118,-0.328403,-0.535072,-0.531854,0.483287,0.0733713,0.623254,0.0763849,0.025092,0.0933834,0.441332,-0.386274,-0.893114,-0.319217,-0.574979,0.106282,0.169122,0.280349,0.102501,0.216835,-0.343386,0.286135,-0.256726,0.293973,0.570646,0.22492,0.154935,0.0476398,-0.255757,0.183447,-0.522258,-0.420084,-0.661792,0.268855,-0.738441,-0.0276553,1.26136,0.0821489,-0.252692,0.257826,-0.360997,-0.229139,0.0863703,0.29984,0.0239266,-0.38228,0.664651,0.146235,0.199395,-0.019387,-0.218873,0.602892,0.716439,0.572672,-0.0461362,0.134757,0.0529231,0.204988,0.122068,-0.0393067,-0.214049,-0.0541687,0.783975,-0.14165,0.0188996,-0.017207,-0.281366,-0.0888352,-0.989744,-0.139412,0.688489,-0.236718,0.245306,0.365919,-0.405301,-0.0156655,-0.693512,-0.0298876,-0.425374,1.07703,-0.292882,0.346081,0.250174,0.0281694,-0.352976,-0.0272398,0.19991,0.346281,-0.156346,-0.414053,-0.436712,-0.219799,-0.208897,0.525586,0.229667,-0.705483,0.156976,-0.860367,0.7306,-0.235298,0.026017,-0.3252,-0.382561,0.324775,-0.194359,0.111029,0.26541,0.185147,0.584986,0.173099,-0.18916,-0.0805402,-0.729439,-0.222196,-0.0607775,-0.568785,0.362021,-0.277446,-0.498321,0.186965,-0.338871,-0.032237,0.0418694,-0.591038,-0.0189853,-0.882991,0.456425,0.559349,-0.387368,0.774466,-0.264129,0.305458,-0.387305,0.340845,0.272521,-0.287934,0.355826,0.601033,-0.0342313,0.00794365,0.0685724,-0.156037,-1.09607,0.637998,-0.00355677,-0.531048,0.649393,-0.417304,0.179577,-0.283862,-0.0545199,0.294912,-0.137644,0.110125,0.296548,-0.253372,-0.00683491,0.343932,-0.387184,-0.430972,0.121316,0.143889,0.227541,-0.211638,0.703501,0.0424695,-0.379946,0.691473,-0.012054,0.361189,0.421924,0.100126,-0.635583,-0.41,-0.0291818,0.371604,-0.546502,0.286069,0.282876,-0.40751,0.166372,0.0124509,-0.535771,0.318045,0.0846445,-0.762945,0.0380201,0.546423,-0.136597,-0.319359,-0.587239,-0.332824,0.165965,0.1324,0.407388,0.363868,-0.397531 +3398.28,0.984104,0.0912059,4,1.62323,1.01375,-0.426779,0.0549371,0.592227,-0.0792634,-0.181183,0.112123,1.07083,-0.0557398,-0.123287,-0.290852,-0.267227,-0.142536,-0.284104,0.509243,-0.0954947,0.513208,-0.202641,-0.268812,-0.561438,-1.02519,-0.403027,0.0346749,-0.34672,0.0659091,0.322098,-0.0165492,-0.224868,0.355937,0.520149,-0.185239,0.277001,0.461921,-0.357714,0.271655,0.0737492,0.5056,0.227403,-0.586444,0.77038,0.636763,0.0330026,-0.557722,0.0825518,-0.465106,-0.39197,-0.154264,0.00744422,0.227944,0.275737,0.421115,0.417679,-0.40613,0.603334,-0.498813,-0.409348,-0.469118,0.614221,-0.649385,-0.123104,0.609767,-0.710989,-0.850543,-0.253737,0.141303,-0.0281398,-0.241051,0.219549,0.0467598,0.182601,0.661724,0.770111,-0.00995671,0.773016,0.486758,0.0577525,-0.0723186,-0.197534,0.252828,0.683128,-1.03974,-0.0548376,-0.188769,-0.22149,-0.236484,0.0279806,-0.326471,-0.164988,0.137558,0.342604,-0.336787,0.0129097,-0.0492543,-0.0232354,-0.29126,0.594955,-0.315796,-0.00654231,0.136977,0.583438,-0.224736,-0.172572,-0.297043,0.0720082,-0.516396,0.176231,-0.101906,0.202732,0.376262,-0.418637,-0.402839,-0.331868,0.625323,0.0973773,0.0341854,-0.433738,-0.191998,0.614858,-0.348265,-0.916655,-0.308296,-0.33341,-0.211273,0.199268,0.427159,-0.5645,0.292712,0.178555,-0.0263587,0.280084,0.595353,-0.181609,0.690158,-0.214175,-0.479051,0.323051,0.547122,0.685605,-1.06935,-0.467034,0.198124,-0.0176361,-0.764805,-0.0545817,0.151607,-0.54731,0.0122393,-0.506993,-0.543935,-0.886768,-0.0100367,0.0890532,0.00422921,0.0963649,-0.472829,0.268008,-0.252703,0.552147,-0.616232,0.153541,-0.535989,0.555364,-0.303065,0.354633,-0.262449,-0.118482,-0.617951,-0.195459,-0.225879,0.0864435,-0.527016,0.309061,-0.355211,-0.0640937,-0.294323,-0.321967,0.0345953,0.80463,1.03041,0.124895,0.376962,0.457631,-0.272735,-0.623783,-0.752525,0.0276201,-0.467673,-0.375538,-0.490952,0.182387,-0.307865,0.265386,-0.505033,-0.830513,0.311995,0.0915286,-0.367176,-1.53736,0.539585,-0.245039,-0.03276,-0.412425,-0.322738,0.621715,-0.336435,-0.491305,1.18157,-0.0413363,-0.15858,-0.140166,0.66777,-0.13871,-0.301616,-0.644111,0.505256,0.274404,0.409017,-0.455926,-0.173846,0.250199,-0.123947,0.0879866,0.369676,0.23815,0.761782,-0.810357,-0.363928,0.0542901,-0.148301,0.0460294,0.0578596,-0.441779,-0.482107,-0.443504,0.337307,0.0142346,0.239671,0.646088,-0.382674,-0.826663,0.057233,-0.117055,-0.226908,-0.545642,-0.0519848,0.41502,0.325224,-0.532362,-0.0758055,-0.449356,-0.643937,0.496918,-0.63401,0.69505,0.0527903,-0.0499113,-0.0507064,0.456766,-0.104123,-0.0476302,0.595962,0.238023,0.88364,0.0793406,-0.619005,-0.210907,-0.230035,-0.26946,-0.369773,-0.0036216,-0.500948,-0.605157,-0.488875,-0.232706,0.0989577,0.0854705,0.0799838,-0.234591,0.333387,-0.620046,-0.204477,0.0141588,0.0376281,0.326045,0.520138,-0.734947,0.0449701,0.0397399,-0.115055,0.371526,0.915416,0.253237,-0.412208,-0.273679,0.0350033,-0.101495,0.263385,-0.145735,-0.892062,0.161405,0.187667,0.290473,0.433206,0.538956,-1.94314 +3389.37,0.736319,0.0912059,4,1.63782,0.972792,-0.831519,0.144088,0.806103,-0.0681493,0.0458453,-0.28431,0.869751,0.366077,-0.244029,-0.288988,0.0617152,-0.283982,-0.132386,0.437072,-0.311939,0.280183,-0.0874005,-0.527297,-0.612214,-0.944802,-1.11624,-0.14678,-0.297888,-0.266414,0.263248,-0.0658937,-0.482989,-0.00699468,0.325119,-0.469824,0.217618,0.318247,-0.390881,-0.105395,-0.328036,0.801522,0.585896,-0.621022,0.909918,0.59687,0.0307274,-0.328278,-0.16385,-0.266017,-0.884038,-0.265385,0.142172,0.367487,-0.0583384,0.200236,0.595515,-0.6754,0.825588,-0.422368,-0.236403,-0.484307,0.798524,-0.516086,-0.458262,0.811698,-0.32899,-0.73276,-0.0609105,0.114653,0.132768,-0.165477,0.424169,-0.0757333,0.121885,0.508172,1.02556,0.117955,0.866209,0.50621,0.147621,0.0134395,-0.120484,0.231277,0.727696,-0.576319,0.0516596,-0.334898,0.205635,-0.0422267,0.168803,-0.0219805,-0.0260445,-0.32842,0.177859,-0.175267,-0.213299,0.647249,0.0601686,-0.189962,0.312392,0.151172,-0.0469348,0.255196,0.466505,-0.534238,-0.856889,-0.0487765,-0.0278076,-0.770606,-0.0633847,-0.024639,0.265031,0.636805,0.0321881,-0.795898,0.267262,0.522382,0.196516,0.00791792,-0.343608,-0.129029,0.464112,0.0187654,-1.02685,-0.142691,-0.140194,-0.578807,0.0692906,0.348708,-0.503033,-0.343848,0.0973845,-0.199211,0.0182645,-0.0889877,0.09776,0.749549,-0.20468,-0.310495,-0.0364869,0.263886,0.718049,-0.829378,-0.219044,-0.0310755,-0.213022,-0.773811,-0.189736,-0.147582,-0.928024,0.129205,-0.499593,-0.193909,-0.833216,-0.0786726,0.0954285,-0.513778,-0.405383,-0.558081,0.254265,0.413382,0.379397,-0.587998,0.134447,-0.210935,0.504273,-0.443011,0.625705,0.387478,0.434112,-0.804376,-0.35197,0.176547,0.063401,-0.996193,0.105146,-0.136345,-0.435741,0.190696,-0.522827,0.170615,1.13062,1.0973,-0.3639,-0.0727598,0.484469,0.0298897,-0.242233,-0.339767,0.155361,-0.120723,0.115193,-0.162481,0.197577,-0.149955,0.0909313,-0.22352,-0.571455,0.233052,0.310374,-0.756204,-1.45429,0.30281,0.0726254,0.16836,-0.207244,-0.928817,0.374876,-0.359625,-0.295387,1.09688,0.20639,0.479024,-0.15657,0.652056,-6.48287e-05,-0.114782,-0.282811,0.767018,0.215237,0.15096,-0.105856,-0.03256,0.472484,-0.3534,0.441472,0.212313,-0.0808707,0.683692,-1.17948,-0.126624,-0.38245,-0.434943,0.15486,0.23715,-0.0891803,-0.195101,-0.108196,0.321181,0.0127618,0.187692,0.532443,-0.359501,-0.323116,0.535684,-0.479957,-0.35162,-0.26793,-0.343398,0.337063,0.338113,-0.238442,-0.339505,-0.698677,-0.943579,0.338649,-0.575557,0.557859,0.035148,-0.0587916,-0.310868,0.552075,-0.132595,-0.0740714,0.0149668,-0.244631,0.724365,0.249911,-0.544695,0.076475,0.357567,-0.437027,-0.334508,-0.139685,-0.357577,-0.28987,-0.00415118,-0.792656,0.512882,0.0330244,0.338699,0.370508,0.0774569,-0.862624,-0.162849,-0.0661594,-0.680246,0.53425,0.31749,-0.299254,0.426359,0.0034929,-0.332568,-0.0866201,0.887175,0.293985,-0.373431,-0.124883,-0.304772,0.673269,0.572575,-0.283438,-0.964221,0.324427,0.196936,0.208099,0.443775,0.456179,-2.44084 +3395.97,0.867949,0.0912059,4,1.42739,1.03187,-0.504413,0.0538222,-0.567171,-0.136482,0.104684,0.588548,0.249642,0.445427,-0.0955937,-0.315452,-0.535991,0.768694,-0.218839,0.974327,0.436322,-0.162216,-0.605182,0.137604,-0.601157,-0.454584,-0.518218,0.166165,-0.255541,-0.517997,0.187713,0.52029,0.361353,0.340842,0.826403,-0.481012,-0.000326414,0.385393,-0.537658,0.626944,0.020907,0.492079,-0.0733786,-0.433168,1.37088,0.614375,0.284296,-1.37173,0.520003,0.405567,-0.46266,0.285031,0.75245,-0.0407786,0.527546,0.557678,0.450385,0.0762213,0.579686,0.337512,-0.0595065,-0.450982,0.814882,0.047029,0.414608,0.647937,-0.761417,-1.50304,0.260423,0.286479,-0.165544,-0.0531563,-0.438285,-0.793982,-0.0662189,0.293305,0.210874,-0.120033,0.445544,0.440655,-0.0784624,0.119336,-0.241105,0.359051,-0.199408,0.137546,0.333166,0.539836,-0.227995,0.20559,0.197517,-0.440977,-0.171322,-0.433079,0.255764,0.270008,-0.223705,-0.249376,-0.18722,-0.538149,-0.0441901,-0.463323,0.430644,0.360119,-0.10329,0.52602,0.709354,-0.885987,0.460771,0.333285,0.389694,0.110966,0.0780497,0.46461,-0.215587,-0.439245,0.160744,0.692309,0.0749997,0.461311,-0.405502,0.0185774,0.103771,0.365927,-0.214163,-0.270521,0.0895285,0.457813,0.474116,0.203566,0.313292,-0.0271592,0.293319,-0.259745,0.683849,0.16312,0.292376,0.530945,-0.0660072,-0.220143,0.0308024,-0.12482,0.545624,-0.31109,-0.186433,0.0175709,0.398812,0.157108,0.189715,-0.0571973,0.624654,-0.00835893,0.264479,0.298956,-0.412492,-0.0840179,0.750361,0.0750472,0.221238,0.715991,0.149363,0.196394,-0.246807,0.102151,0.235232,0.801278,0.619029,0.00644973,-0.34894,0.442244,-0.0178149,0.344864,-0.0624714,-0.532885,-0.16424,0.278869,0.0123424,-0.194394,0.0237355,-0.302728,-0.373243,0.345227,-0.191204,0.549733,0.487113,0.258148,0.0499309,-0.110861,-0.0319843,-0.0499189,-0.407285,-0.586077,0.276796,-0.435175,-0.106388,0.575063,0.381015,-0.80689,0.312792,0.805119,-0.0470374,0.571452,-0.415598,0.307538,-0.129035,-0.356372,0.530726,-0.231088,-0.140511,0.0787431,-1.135,0.820153,0.0122768,0.0565774,-0.3765,-0.344061,0.0830423,-0.215526,-0.394755,-0.165114,-0.15885,0.113227,0.813832,-0.0606328,0.0681639,-0.730219,-0.144062,0.500774,-0.126105,0.459293,0.0604931,-0.176726,-0.00987414,-0.011854,-0.728292,0.403642,-0.375815,-0.129492,-0.416195,0.183197,0.165319,0.338547,0.881247,0.0450775,0.165318,-0.188646,0.180737,0.310131,0.603771,0.731937,0.302081,0.00915532,-0.0302465,-0.241728,0.633791,-0.48831,0.389755,-0.341999,-0.423111,0.440081,-0.107177,-0.553417,-0.0278225,0.140232,0.650542,1.07699,-0.0662838,-0.158927,-0.712702,-0.0794572,-0.136039,0.106304,-0.557443,-0.0841663,0.329043,-0.224185,-0.217782,-0.175236,0.750244,0.14817,-0.0127631,-0.328437,0.434701,0.478565,0.0267409,0.0298463,0.132962,1.19993,0.0550867,-0.170686,0.0784069,0.269589,-0.340164,0.373615,0.139683,-0.57345,0.24511,0.797776,-0.750782,-0.552743,0.0541183,-0.10869,-0.0544092,0.218343,-0.0499682,0.133683,0.386408,0.365627,0.621617,1.73409 +3412.32,0.693343,0.0912059,4,1.40958,1.06208,-0.129796,-0.0598492,-0.629493,-0.0390111,0.254831,-0.017475,0.401609,0.80665,0.227363,-0.190136,0.333542,0.857765,0.143665,0.9012,0.26508,0.238334,-0.232632,0.232527,-0.560846,-0.579176,-0.84173,0.349357,0.0797709,-0.201592,0.254198,-0.0458133,0.00690634,0.776001,0.702355,-0.10485,-0.378733,0.239006,-0.464762,0.209935,-0.403113,0.222132,-0.170139,-0.48942,1.12689,0.777326,-0.295249,-0.581287,0.0870061,-0.16635,-0.961628,0.150297,0.873897,0.152328,0.165131,0.657443,0.351138,-0.563481,0.662334,0.0147205,-0.147514,-0.794803,0.702583,0.16522,0.447517,1.1054,-0.39269,-0.494101,-0.204817,0.363951,-0.16003,-0.411572,-0.239091,-0.184404,0.255494,0.600422,0.344492,0.291631,0.841641,0.299756,0.348444,-0.661996,0.0553243,0.0931837,-0.321454,-0.113704,0.209974,-0.0444156,0.205024,0.562856,-0.330703,-0.528731,0.00521154,-0.651599,0.597845,-0.536331,-0.162442,-0.05924,0.29353,-0.520754,0.46711,-0.249923,0.352384,0.242652,0.216422,0.0485384,-0.178189,-0.347171,0.889111,-0.187493,0.0876072,-0.320056,-0.345955,0.814382,-0.308557,0.133955,-0.629896,0.507974,0.00517196,0.296238,-0.0555319,-0.0485779,0.832882,0.101097,-0.631572,-0.132426,-0.702833,-0.319476,0.179402,0.284511,0.182872,0.657103,-0.460686,0.0147733,0.259569,-0.183355,-0.112201,0.455085,0.20262,-0.20289,0.573876,-0.102996,0.801198,-0.435296,-0.0457801,-0.147342,0.0723749,-0.225952,-0.0215672,-0.388747,0.0612961,-0.351997,-0.0128068,0.0597181,0.140635,-0.0480686,0.642753,-0.210671,0.0731628,0.18463,0.105556,0.269196,-0.000201765,-0.231974,0.406021,0.131914,0.495634,-0.279542,0.388695,0.0870147,0.0325562,0.0140249,0.0654318,0.293102,0.207199,-0.200424,0.218659,-0.183087,0.449634,-0.322927,-0.464822,-0.0244394,0.226728,1.00124,-0.100625,-0.0617421,0.114422,-0.0173111,0.00230788,-0.370588,-0.0640717,-0.29511,0.0423735,-0.448695,0.0841501,-0.315266,0.298985,-0.565599,0.132843,0.546416,-0.104224,-0.258831,-0.486352,0.970933,0.0176754,-0.0728236,0.165394,0.219385,-0.385475,-0.365203,-0.642612,1.07125,-0.281148,1.0277,-0.247202,-0.145858,-0.155262,-0.644401,-0.329652,-0.0616678,0.0328932,0.314478,0.424389,-0.603051,-0.176235,-0.457128,-0.229267,0.689511,-0.27334,0.443566,-0.0186715,-0.0433334,0.51219,0.07285,-0.108585,0.257404,-0.313648,0.26879,-0.291191,0.216358,-0.116218,0.179949,0.50981,-0.396919,-0.0493359,0.542249,-0.116339,0.417368,0.424202,-0.216737,-0.27517,0.471862,0.0376383,-0.276571,0.352765,-0.442961,0.319159,-0.0290088,-0.589657,0.259201,-0.0176767,-0.355871,0.103793,-0.164912,-0.324067,0.0119615,0.281315,-0.140129,-0.326786,-0.399836,0.426817,0.0952935,0.395555,-0.362047,0.0722564,-0.314594,-0.143277,0.0991378,0.58713,0.450029,0.327809,-0.426755,0.971518,0.343986,-0.355441,-0.196083,0.0643716,0.167417,0.0608712,0.49753,0.0709502,-0.0447322,-0.0502915,-0.086959,0.302506,0.479317,0.507431,-0.150415,-0.070387,-0.367626,0.340766,0.0572058,-0.0146724,0.569536,-0.0612933,0.13931,0.198904,0.373243,0.445986,1.75636 +3423.39,1,0.0912059,4,1.40455,1.05493,-0.3913,0.073541,-0.108922,-0.133497,0.0225973,0.195333,0.765437,0.0465895,-0.0825456,0.0723273,0.276995,0.632937,0.491627,0.926452,0.112446,-0.179894,0.0769651,0.0354825,-0.514701,-0.297698,-0.580856,0.100328,0.156255,-0.232459,0.189733,0.924702,0.203593,0.117713,0.528865,0.163791,-0.167154,0.378617,-0.207211,0.0950067,-0.251241,0.278369,0.411647,-0.677201,1.13914,0.399061,0.587963,-0.652846,0.169413,0.163897,-0.261526,0.484032,0.493931,0.215072,0.512461,-0.308703,0.0499132,0.54463,0.508495,0.154072,-0.58182,-0.17175,0.743992,-0.467775,0.578672,0.822604,-0.672929,-0.870927,0.391764,0.544478,0.105845,0.536626,0.20422,-0.805945,-0.1911,0.212639,0.416806,-0.588469,1.10109,0.90315,-0.13032,0.109624,-0.214889,0.0726022,0.198852,-0.338852,0.329328,0.024527,0.111232,-0.64874,-0.292392,0.0423466,-0.17515,0.210288,0.0527743,0.483976,0.139675,0.0548921,0.233202,-0.0445475,0.30546,0.468675,0.364814,0.093651,0.181117,-0.193511,-0.666864,-0.358683,-0.294246,-0.463558,0.378085,0.187055,0.198255,0.422055,0.288153,0.021901,0.180758,0.644607,0.0011333,-0.0923689,0.0371429,0.125138,0.433069,-0.168879,-0.601078,0.0834386,-0.467628,-0.416782,0.333113,-0.0138832,0.28376,0.410064,0.275795,-0.348004,0.0657773,-0.00539232,-0.138625,0.508199,-0.0436952,0.291444,0.433919,-0.00993074,0.52052,-0.45416,-0.456546,0.102693,0.141336,0.0763907,0.528889,0.682992,-0.0272042,0.0996624,0.24182,-0.0984975,0.291492,-0.0667814,0.523219,0.277783,-0.144287,0.344722,0.32095,-0.073565,0.17228,0.294954,0.199253,0.329061,0.714986,0.0163281,-0.117708,0.217464,-0.04171,-0.404626,0.0685181,0.240099,0.274684,-0.480989,0.101635,0.229027,0.136313,-0.117426,-0.123058,0.331214,-0.511269,0.46802,0.67884,0.457204,0.460236,0.179777,0.145036,-0.246539,0.0773838,-0.708731,0.495798,-0.603822,-0.0810387,0.360949,-0.341654,0.0568575,0.0640175,0.190395,0.109488,0.312165,-0.490154,0.575991,-0.0390326,-0.541417,0.104971,0.215755,-0.107891,0.356014,-0.362269,1.14795,0.291266,0.0178511,-0.128541,-0.124369,-0.0873367,0.00629844,-0.346503,0.288763,0.140235,0.115341,0.459196,-0.323392,0.220689,-0.19794,-0.333511,0.141207,-0.262509,0.496646,-0.375923,-0.231963,0.478655,0.323897,-0.168788,0.250154,-0.201442,0.384529,0.0341868,0.415666,0.175453,-0.0462789,0.490221,-0.611501,0.261058,-0.0393139,0.12283,0.612723,0.0570506,0.523926,0.650139,-0.317359,0.0439085,-0.281999,-0.204839,-0.991382,0.67623,-0.729004,0.400791,0.549727,-0.0665594,-0.105117,0.646108,0.201389,0.00263629,0.955804,-0.192535,0.25356,0.141854,-0.0726515,0.0260831,-0.108283,0.953011,0.215338,-0.0642469,0.167861,-0.167556,0.661485,-0.0871601,-0.0792278,0.120918,0.678871,0.485889,0.366,-0.453759,0.00970034,-0.686859,0.027017,0.0662486,-0.341219,-0.287518,0.127951,-0.0052471,0.164965,0.0660305,-0.344634,0.0917997,0.0813821,-0.486094,-0.570727,-0.201377,-0.178356,-0.00453679,0.126047,0.324028,0.120763,0.241037,0.34751,0.490955,0.0703035 +3400.53,0.986183,0.0912059,5,1.56803,0.986471,-0.865296,0.364062,0.476532,-0.130151,0.315192,0.0980219,0.227166,0.151708,0.614853,0.155983,-0.136357,0.264386,-0.343197,1.055,-0.144213,0.226899,-0.0931997,-0.433354,-0.480717,-0.850801,-0.302563,-0.0170058,-0.177874,0.0299661,0.275617,0.118352,-0.61953,0.327269,0.551931,-0.45939,0.155271,0.437942,-0.537894,-0.279052,-0.149949,0.471189,0.340963,-0.154603,1.12597,0.175464,-0.340409,-0.551926,-0.164402,0.169047,-0.771033,-0.0365282,0.327728,0.0796681,-0.0328366,0.608645,0.0210005,-1.20564,0.405663,-0.641352,0.122409,-1.15172,0.572844,0.11216,-0.215855,0.744055,-0.780169,-0.772929,-0.0754181,-0.132875,0.080061,0.0233159,0.550507,-0.450453,0.0605043,0.258096,0.750815,0.357611,0.032861,0.257211,0.478932,-0.224927,0.0666978,0.484484,0.537085,-0.294203,0.362875,0.195361,-0.00768654,0.53595,-0.0614636,0.0832388,0.0958721,-0.518501,-0.250491,-0.139347,-0.372427,0.316083,-0.135651,-0.261379,-0.146354,-0.893131,0.148051,0.0811709,0.297281,-0.260722,-0.315387,0.110179,-0.342394,0.067557,0.520035,-0.386754,0.14156,0.134593,-0.0703779,0.18372,0.0325673,0.318934,0.527189,0.256948,-0.277547,-0.0723572,0.0188201,0.277889,-0.686037,-0.298519,0.461235,0.475243,-0.15808,0.692515,0.0232123,0.0976105,-0.562268,-0.70055,-0.154935,-0.13297,0.0648912,0.5083,0.463869,-0.20534,-0.0753533,0.372757,0.799255,-0.796426,-0.705395,0.208449,0.125624,0.107789,-0.336509,-0.215674,0.307655,0.623165,0.0484564,-0.683436,-0.0548104,-0.0166687,-0.173067,-0.0148307,0.56363,0.576806,-0.400543,0.270257,-0.494921,-0.0671736,0.385753,0.044266,0.296159,-0.626291,-0.0587538,-0.0520454,0.063486,-0.103878,-0.397317,0.13905,0.31006,0.139641,-0.187216,-0.022651,0.0209039,-0.0115298,-0.756493,-0.726183,1.0913,1.08565,-0.176949,0.239686,-0.132734,-0.794896,-0.250682,0.0035443,-0.739646,-0.386779,-0.25935,-0.15212,0.207003,-0.0972635,0.291489,-0.623575,0.145481,0.367882,0.663314,-0.124684,-0.619666,-0.527626,0.248704,-0.680604,0.304856,0.200893,0.0500417,-0.633923,-0.187774,1.14175,-0.212109,0.459872,-0.11058,0.171484,-0.0262281,0.263608,-0.505885,0.462665,-0.079488,-0.220036,0.603168,0.0602922,0.0296404,-0.539311,0.333383,-0.0591791,-0.0771043,0.401304,-0.141273,-0.529529,-0.269798,-0.159039,0.0769634,-0.0317891,0.270428,-0.341303,0.347473,0.159601,-0.362159,0.31756,0.909466,0.207953,-0.665272,-0.522688,0.20996,-0.0919808,0.616243,0.908845,-0.149296,0.255472,0.407961,-0.311234,-0.0392453,-0.480398,0.557355,0.560779,-0.395005,0.554488,0.0888801,-0.164736,-0.0103143,0.188091,0.146602,-0.301985,0.0602398,0.0324456,-0.372006,-0.25322,0.420477,0.334014,-0.151254,-0.397769,-0.00966179,-0.236458,-0.311016,-0.0718515,-0.124944,0.232191,-0.136724,0.134361,0.627522,-0.170735,0.0535993,0.327155,0.706885,-0.354875,0.232592,0.404113,-0.285115,0.412871,0.0633987,0.132856,-0.0586439,0.589691,0.082646,-0.218729,0.187696,-0.0611957,0.189785,0.35492,0.12681,0.182822,-0.130286,0.143338,0.171176,0.3786,0.413734,-1.61608 +3416.55,0.712458,0.0912059,4,1.54334,0.915363,-0.895638,0.334338,0.707929,-0.170141,0.287993,0.0710556,0.272567,0.246151,0.519385,0.186698,-0.100749,0.238493,-0.0214406,0.784809,0.0520144,0.203289,-0.184744,-0.450481,-0.668851,-0.591931,-0.13576,-0.0906802,-0.0831711,0.315626,0.387194,0.342803,-0.919034,0.164337,0.631046,0.130017,0.167671,0.677067,-0.491322,-0.033467,-0.238031,0.325731,0.402777,-0.302351,1.16027,0.340042,-0.340838,-0.513371,-0.000813963,0.14742,-0.520688,0.171461,0.151647,-0.13174,0.165423,0.380654,-0.0119319,-0.540025,0.867552,-0.753251,-0.111951,-0.824475,0.573682,-0.00379356,-0.429187,0.613825,-0.986529,-0.680787,-0.238182,-0.146359,0.183817,0.151458,0.601479,-0.410677,0.0744494,0.436181,0.725032,0.169833,0.325305,0.708263,-0.252492,-0.0532063,-0.0358541,0.335829,0.360382,-0.246316,0.208001,0.0552105,0.186545,0.494145,-0.105584,0.0551644,-0.28996,-0.0304333,-0.0268878,-0.211801,-0.534485,-0.0219031,0.0110366,-0.217679,0.426459,-0.771343,0.199642,0.210437,0.460581,0.0610789,-0.438626,-0.175011,0.328436,0.057216,0.37188,-0.20535,0.0909405,0.448971,-0.348039,-0.0345444,0.441434,0.178214,0.508186,0.25114,-0.652478,-0.158836,0.255973,0.39193,-0.697772,-0.366393,0.153719,0.292848,-0.4967,1.0164,0.369029,0.00699705,-0.604876,-0.637442,0.178619,0.0897889,-0.238197,0.407356,0.0552638,-0.540604,-0.0491437,0.425931,0.557413,-0.545043,-0.321976,0.333794,-0.0519585,-0.174923,-0.281579,0.031663,-0.0257292,0.532519,-0.0571846,-0.080541,-0.434777,0.114912,0.10376,-0.371178,0.421817,0.554934,0.681541,0.0970337,-0.313375,0.0804569,0.68296,-0.142706,0.693566,-0.474537,-0.197777,-0.000685051,0.185287,-0.185449,-0.0246446,-0.0958029,0.218291,-0.0134888,-0.135352,-0.325921,0.373313,-0.256163,-0.562635,-0.614765,0.64411,1.12787,0.459933,0.54204,0.273303,-0.705477,-0.0328047,-0.370967,-0.87667,-0.512405,-0.163516,-0.199566,0.00184985,0.0582738,0.183292,0.0270229,0.451421,0.264068,0.620941,0.0857938,-0.810048,0.109653,0.119057,-0.627674,-0.281698,0.00494463,0.196085,-0.379862,-0.359158,0.912586,0.231442,0.614121,-0.00979786,-0.302121,-0.00609315,0.19018,-0.609711,0.153904,0.146075,-0.0560163,0.296531,0.0806995,0.0447594,-0.220339,0.175074,0.0172039,-0.221601,0.188469,-0.372176,-0.639301,-0.405856,-0.250229,-0.186211,-0.172032,0.428404,-0.416691,0.22642,0.345899,-0.212426,0.727049,0.52784,-0.148129,-0.782749,-0.40606,0.221001,-0.243624,0.187526,0.470274,-0.108098,0.209978,0.0473751,-0.225676,0.261674,-0.676444,0.147492,-0.0358624,-0.0684985,0.358921,0.15478,0.0170159,-0.141716,0.378486,0.283454,-0.158123,-0.0388965,-0.0369972,-0.38372,-0.431195,0.617799,-0.0385724,-0.36762,-0.16521,0.24181,-0.341845,-0.464545,-0.196277,-0.189549,-0.0798873,-0.127494,0.0668279,0.24793,-0.0727412,-0.186184,-0.047021,0.587831,-0.714904,0.387553,0.523205,-0.521725,0.273646,0.355614,-0.30163,-0.0596056,0.141191,-0.403138,-0.0228517,-0.345065,-0.180225,-0.118277,-0.115584,-0.204827,0.0586606,-0.373534,0.137695,0.185923,0.371072,0.431187,-2.2291 +3430.4,0.998683,0.0912059,4,1.48061,1.01813,-0.45986,0.0753705,0.458065,-0.247669,0.0349696,0.0148229,0.482389,0.425705,0.189546,-0.200143,-0.255876,0.303492,-0.0911816,1.02562,-0.0151426,-0.18713,0.0610619,-0.270177,-0.377002,-0.768781,-0.496537,-0.288525,-0.073545,-0.173916,0.457804,0.553152,-0.773972,0.26377,0.385098,0.0492325,0.553235,0.381261,-0.00940421,0.154499,-0.233187,0.486832,0.557273,-0.389805,1.14671,0.67653,0.249778,-0.216769,-0.338642,0.166889,-0.572592,0.315561,0.527041,-0.0349635,0.319898,0.106553,0.490191,-0.151982,1.01748,-0.494649,-0.283417,-0.487578,0.802399,-0.309795,-0.0807849,0.887656,-0.951304,-0.783601,0.170066,-0.439027,0.0709821,0.373125,0.131775,-0.721342,0.427641,0.4265,0.468836,0.125391,0.386617,0.272135,0.0252701,0.177872,0.188504,0.270302,0.289454,-0.290168,0.449866,-0.332739,0.186895,-0.208015,0.372763,-0.293214,-0.441561,-0.0224686,0.053674,-0.333353,-0.0248549,0.0972017,-0.044497,0.318267,-0.148138,-0.343725,-0.0829258,0.313414,-0.00929492,0.0142343,-0.402708,0.309596,0.0523905,-0.11184,0.367012,0.261892,0.479252,0.401092,0.326393,0.0801663,0.873965,0.232394,0.226565,0.0475139,-0.74484,-0.480158,-0.334928,-0.0956411,-0.0834407,-0.0454328,-0.0574324,-0.21679,-0.512851,0.736716,0.10084,-0.0616315,-0.0391914,-0.22176,0.604669,-0.0315124,0.167951,0.273534,-0.249981,0.074406,0.0294522,0.197703,0.531071,-0.226021,-0.657594,0.405751,-0.0696799,-1.04765,0.000984779,0.0284448,-0.134523,0.260068,0.12653,-0.353972,0.361087,-0.469157,0.0489471,-0.207779,0.0273721,0.253441,0.513383,-0.0906113,-0.400649,-0.250158,0.0509756,-0.401263,0.485342,-0.541387,-1.03112,0.147315,-0.170033,-0.314572,-0.192581,0.191049,0.109954,0.255334,-0.107834,0.0311876,0.342958,-0.365953,-0.335616,0.0556167,0.16836,0.907699,0.389634,0.20002,0.15621,-0.268,-0.382386,-0.296407,-0.278989,-0.539212,0.308475,0.0304386,0.410432,-0.299592,0.223404,-0.0989326,0.156148,0.033521,0.590342,-0.239282,-0.338885,-0.133148,0.143427,-0.616431,0.273988,-0.317061,0.525376,0.14396,-0.42705,1.13617,0.0713092,0.161286,-0.306894,-0.0642409,-0.0904853,-0.205669,-0.00813169,0.363484,0.0596194,-0.18005,0.345849,0.317904,-0.0961736,-0.52595,0.165118,0.157373,-0.139774,0.253956,-0.144044,-0.49195,-0.0610027,-0.317071,-0.259316,-0.104623,-0.0778965,-0.669258,-0.564614,0.124539,0.109291,0.338315,0.571605,-0.0135465,-0.505513,-0.285775,-0.196774,-0.181581,0.384381,0.366935,0.240849,-0.191705,0.101145,-0.231043,0.247753,-0.971627,0.57011,-0.045332,-0.494424,-0.0405285,-0.129844,-0.00947627,-0.0681793,0.484045,0.311902,0.220373,-0.17674,0.371792,-0.664498,-0.721372,0.471783,0.0819918,0.160243,0.114548,0.264639,-0.0379718,-0.611495,-0.373788,0.109962,-0.149244,-0.101506,0.178825,0.424423,0.24084,-0.209011,-0.156315,0.645764,-0.19675,0.23645,0.4934,0.327975,0.222302,0.1305,-0.0394399,-0.0700974,0.373527,-0.116178,0.423844,-0.326798,0.204294,0.675024,0.15463,0.660957,-0.0532832,0.250544,0.114652,0.237551,0.338602,0.487392,-1.60801 +3440.16,0.706548,0.0912059,4,1.53519,0.941871,-0.815454,0.146926,0.0746418,-0.0270529,0.330445,0.220382,0.406253,0.116058,-0.0195302,-0.651058,-0.439355,-0.189741,-0.218485,0.693196,0.0700475,0.0854705,-0.0989991,-0.392034,-0.459704,-0.739537,-0.423762,-0.232737,0.193155,-0.272657,0.371196,0.557728,-0.32675,0.14231,0.431401,-0.00483322,-0.286491,0.234578,-0.429502,0.362323,-0.554378,0.310594,-0.107725,0.366561,1.09191,0.747579,0.175531,-0.49845,0.202144,0.560936,-0.594036,0.323138,0.568093,-0.206292,0.365728,-0.315931,0.0802341,-0.645584,0.706477,-0.0450867,0.297137,-0.178357,0.838128,-0.126189,0.303121,0.854011,-0.567504,-1.35422,0.550028,0.0328193,-0.764212,-0.427867,-0.456314,-0.41077,-0.053385,0.752227,1.24033,0.0923484,0.540628,0.295196,0.51575,0.359661,-0.0840069,-0.232177,0.139635,-0.0275685,0.397438,0.0677278,0.295196,-0.0342463,0.110549,0.0631485,0.0994896,-0.0572648,0.182164,0.0416609,0.0478639,0.125164,-0.399688,-0.0115085,-0.195024,0.148979,-0.124686,0.468922,-0.126384,0.273806,-0.294566,-0.131976,0.269297,0.00962473,0.141029,-0.665191,0.293781,0.527817,0.0610484,-0.31178,0.210914,0.542031,0.582828,0.0772554,-0.182243,-0.0213628,0.459891,-0.237183,-0.563683,-0.0617704,-0.030716,0.201438,0.0256891,-0.00518573,0.455592,-0.0723987,-0.307509,-0.243977,-0.0433731,0.241968,0.0767335,0.453114,0.261192,0.187121,0.030128,-0.0874772,0.451549,-0.323326,-0.673148,0.157374,0.0918405,-0.9636,-0.442714,-0.389273,0.408051,-0.0648462,0.11381,-0.421205,-0.293429,-0.175668,0.545841,-0.486929,0.325624,0.41094,0.358769,0.346435,0.288641,0.119831,-0.161198,-0.0154899,0.695963,0.249059,-0.376616,-0.285741,-0.121185,-0.254553,-0.224133,0.546831,0.102129,-0.0499446,0.103452,-0.201623,-0.194636,-0.13535,-0.220065,0.570824,0.310537,0.746952,-0.05546,0.102837,0.122393,0.0187952,-0.185337,-0.216165,-0.0722597,-0.415819,0.366008,0.468407,0.339299,-0.41991,-0.0487159,-0.546703,-0.168159,-0.13801,0.262219,-0.271555,-0.47335,-0.590135,0.296874,-0.382694,0.222833,-0.356814,-0.222052,-0.276045,-0.374251,1.075,-0.172292,-0.240079,-0.345611,0.0204731,-0.213205,0.320426,-0.197456,0.248582,-0.63554,0.299498,0.296038,-0.515995,-0.121144,-0.186783,0.135763,-0.174485,-0.217084,0.614472,-0.253673,0.156815,0.230491,0.272321,0.317902,0.243029,-0.67104,0.12371,-0.591749,0.227476,-0.0908552,0.24551,0.556917,-0.296956,0.094671,0.011281,0.281035,-0.457453,0.165438,-0.1126,0.361175,0.180302,0.744211,-0.0721343,0.040839,-0.794756,0.159824,-0.642007,-0.231383,0.663264,-0.282577,-0.323776,-0.340372,0.42082,-0.430181,0.0620443,-0.192196,-0.326008,-0.0731657,-0.16521,0.00509357,-0.0546201,-0.0361319,0.0157259,-0.0334114,0.186967,-0.0542418,0.411782,0.689767,-0.62623,0.141369,0.164336,0.476584,0.298098,0.230673,-0.611551,-0.0559764,-0.0265981,0.00283913,0.534455,-0.51234,0.640038,0.30118,-0.251219,0.15893,0.0238428,0.41009,-0.0663681,-0.179026,-0.493551,0.256044,-0.192632,-0.0745991,0.103716,0.36032,0.123986,0.206363,0.352116,0.454272,-0.0819091 +3443.45,0.573907,0.0912059,4,1.52583,1.03724,-0.920355,0.154947,0.240331,-0.0497918,0.0181613,-0.0981135,0.309042,0.124919,-0.0623358,-0.506551,-0.417388,-0.0915881,-0.0996002,0.821971,0.0548755,-0.11834,0.0266989,-0.531945,-0.406936,-0.757566,-0.0865148,-0.338134,0.220466,-0.383675,0.226947,0.355575,-0.238646,0.191324,0.436366,-0.0368813,0.213649,0.0973271,-0.449101,0.32222,-0.48705,0.206033,-0.0414586,-0.0900921,1.08549,0.50514,0.0185501,-0.378426,0.116417,0.0881199,-0.725546,0.470822,0.421143,-0.192467,0.208548,0.164398,0.185778,-0.689682,0.735493,-0.112069,0.256892,-0.198665,0.6654,-0.345615,0.376787,0.948545,-0.58097,-1.20319,0.215924,0.164706,-0.834065,-0.459725,0.137393,-0.660181,-0.111205,0.579856,1.18953,0.293983,0.221798,0.219049,0.471252,0.42774,0.239236,-0.350094,-0.0534046,-0.0361478,0.443523,0.0279115,0.153861,-0.065368,-0.236322,0.112685,0.173129,-0.315176,0.0783373,0.0132234,-0.0895004,0.301877,-0.358342,-0.00483566,-0.332826,0.123822,-0.0385687,0.526213,0.0763083,0.296207,-0.168567,-0.325866,0.401703,0.187426,0.27985,-0.737957,0.154705,0.466191,0.0819158,-0.384105,0.187185,0.495066,0.397648,-0.120043,-0.0538272,-0.272156,0.444537,-0.209164,-0.448838,0.217252,-0.169335,-0.0167632,-0.0083954,-0.121311,0.604874,-0.216613,-0.153331,-0.406792,0.0159,0.229968,-0.0266803,0.485593,0.191761,0.187816,0.355014,0.222581,0.632494,-0.256223,-0.556995,0.182762,-0.0865568,-0.868376,-0.424828,-0.150813,0.526779,-0.0840359,0.00314647,-0.277172,-0.562312,-0.448299,0.450962,-0.373867,0.302414,0.310274,0.578862,0.260024,0.266281,0.0999653,-0.201569,-0.0882532,0.695381,0.288095,-0.419925,-0.344186,-0.103944,-0.263355,-0.137982,0.541744,0.188585,0.121479,0.057449,-0.238431,0.0154648,-0.255474,-0.140013,0.591066,0.359044,0.851025,0.100955,0.0494904,0.143619,0.0802386,-0.0557906,-0.0012412,-0.369301,-0.510405,0.294456,0.419213,0.231226,-0.225344,-0.223026,-0.472604,-0.290172,0.11643,0.207533,-0.372973,-0.40084,-0.35923,0.0362756,-0.222825,0.140771,-0.59228,-0.135381,-0.38702,-0.557798,1.07581,0.0926428,-0.0498177,-0.369355,0.0203126,-0.106736,0.191276,-0.295841,0.293565,-0.52249,0.1627,0.260444,-0.543596,-0.149276,-0.173015,0.0230698,-0.0430184,-0.0900626,0.679519,-0.144634,0.157508,0.342813,0.37258,0.176414,0.214572,-0.492664,0.284922,-0.463786,0.207996,-0.16904,0.320141,0.641635,-0.329847,-0.110962,0.131066,0.124785,-0.464547,0.184914,-0.111285,0.229264,0.131658,0.665189,-0.152006,0.0931977,-0.75403,0.246729,-0.747274,-0.0608502,0.785542,-0.249016,-0.293938,-0.206013,0.189335,-0.422637,-0.067829,-0.464173,-0.236679,0.0341363,-0.0109321,0.0439353,-0.00945228,0.0392456,0.181378,-0.0333248,0.0180613,-0.0633577,0.177397,0.534897,-0.439211,0.208368,0.145403,0.493438,0.296085,-0.155029,-0.275107,-0.214254,0.255694,0.109113,0.281005,-0.0454994,0.954963,0.52169,-0.313347,0.0727858,0.175928,0.500129,-0.0152977,-0.263602,-0.53793,0.310721,-0.18385,-0.277471,0.0260564,0.0724444,0.112414,0.197149,0.335281,0.444015,-0.756734 +3428.66,0.459137,0.0912059,4,1.61889,0.951668,-0.826288,0.196793,0.40928,-0.110741,0.0356763,0.286114,0.208471,0.440195,0.0919617,-0.261948,-0.695873,-0.169097,-0.341717,0.875658,0.0130949,-0.54358,-0.440695,-0.467852,-0.38598,-0.471712,-0.56609,-0.122047,-0.539184,-0.22621,-0.257743,0.544216,-0.296189,0.243761,0.570566,-0.21492,0.195796,0.142509,-0.246789,0.193422,-0.341773,0.0362615,0.293,0.0698249,0.709413,0.830772,-0.0761085,-0.65538,-0.0437012,-0.0158667,-0.283808,0.266861,0.64882,0.286989,-0.0108646,-0.226391,0.335427,-0.0299319,0.690718,-0.0151054,-0.225796,-0.62836,0.522287,0.0268475,0.372291,0.805934,-0.328854,-0.707099,0.380756,0.164751,-0.393105,-0.629205,0.0185023,-0.377295,-0.203807,0.438816,0.63498,-0.0211,0.517013,0.385117,0.574754,-0.15644,-0.083694,0.257338,0.283337,-0.466653,0.487758,0.0281431,-0.245889,0.198242,-0.00155725,0.392224,-0.262021,-0.4129,0.332829,0.0702616,0.127783,0.36888,-0.527058,-0.273643,-0.243613,-0.17655,-0.457305,0.224751,0.39824,0.13224,-0.0909225,-0.652279,0.285132,-0.287994,-0.161481,-0.227406,0.284993,0.364255,0.135866,-0.104194,-0.208546,0.366098,0.473901,0.326192,-0.118323,0.204999,-0.442191,0.333623,-0.315601,0.446045,-0.161384,-0.162591,0.503917,0.00195026,0.342689,-0.386662,-0.136238,-0.113217,0.527303,0.367675,0.159867,0.246918,-0.278045,0.605802,0.12834,-0.203706,0.348946,-0.550171,-0.186404,0.0340938,0.262747,-0.639686,0.0645344,-0.105922,0.185016,0.386004,-0.0607197,-0.00041712,-0.692337,-0.185748,0.254977,-0.605609,0.377494,0.603615,0.878053,-0.0353112,0.528494,-0.442914,-0.173534,-0.304098,0.20364,0.215238,-0.430607,0.141656,-0.202706,-0.263982,-0.0634392,0.316926,-0.0105634,-0.0265757,0.0771227,-0.241657,-0.170497,0.0571906,-0.378727,0.279524,-0.066236,0.794466,-0.0825833,-0.083715,0.151847,-0.186543,0.335362,-0.0518886,-0.435885,0.0348257,0.00475083,0.0501779,0.307947,0.0312526,0.0422815,-0.980048,-0.226413,-0.180737,0.125556,-0.621364,-0.572168,0.187844,0.00150323,-0.147408,0.455613,-0.00640418,0.141204,-0.234352,-0.0569488,0.952816,0.367153,0.302181,-0.17449,-0.0625982,0.0309264,0.100955,-0.090739,-0.0559073,-0.591167,0.110388,0.380584,0.458157,-0.121675,-0.585102,0.035267,0.129481,0.368156,0.239772,0.19382,0.182932,0.308086,0.242449,-0.348487,0.148509,-0.803026,-0.0571112,-0.185008,0.549944,-0.269213,0.152828,0.551906,-0.203758,0.306286,0.254992,0.498986,0.269968,-0.208902,0.197402,0.100335,0.466552,-0.0736128,-0.0177929,-0.094416,-0.155454,-0.17812,-1.18567,0.0452467,0.206883,-0.192982,-0.187471,-0.404817,0.0506965,-0.820741,0.165947,-0.417416,0.456618,0.0720069,-0.191141,-0.0689381,0.369952,-0.339793,0.283399,0.0421846,-0.0271325,-0.455618,0.391347,0.0986193,-0.140056,0.0279409,-0.0274515,0.133748,0.421503,0.111616,-0.550892,0.222708,0.535974,-0.127441,0.0856791,-0.266864,0.169666,-0.25472,0.0857926,-0.00518128,-0.0270528,-0.421534,0.181883,0.107226,-0.677181,-0.0860735,-0.430273,-0.428236,-0.20713,0.196342,0.114423,0.148413,0.338265,0.385244,-1.14714 +3434.73,0.832735,0.0912059,4,1.57995,0.994487,-0.833145,0.279611,0.887658,0.00998001,-0.0429925,-0.00775877,0.180081,0.306154,-0.194636,-0.191127,-0.131979,-0.0455823,-0.282293,0.566476,0.00586901,0.0956489,0.0843538,-0.221201,-0.362014,-0.595587,-0.483104,-0.235038,-0.346305,-0.11485,0.2814,0.121589,-0.0984154,0.0966436,0.546917,-0.784286,-0.0683401,0.142147,-0.0742328,0.0600909,-0.318442,0.461151,0.0965852,-0.0990931,0.750907,0.541517,-0.220584,-0.569368,0.304443,0.140474,-0.0941052,-0.178436,0.374404,0.143702,0.0611619,-0.142762,0.426135,0.128719,0.579038,-0.397948,0.0440292,-0.719391,0.0822998,-0.279531,0.0704133,0.752929,-1.02348,-0.03258,-0.0253761,-0.0233026,-0.722065,-0.543291,-0.638627,-0.393056,-0.0565164,0.148246,0.739352,0.345414,0.563631,0.60996,0.314128,-0.243615,-0.105864,0.325672,-0.0935704,-0.315633,0.48256,-0.0844549,-0.0237028,0.152487,0.341632,0.318928,-0.233552,-0.111263,0.143275,0.565901,0.191284,0.139863,-0.171947,0.0698163,0.118118,0.276502,-0.208547,0.219888,0.234507,0.0199907,-0.18305,-0.140635,0.204401,-0.14103,0.183985,-0.121939,0.778034,0.496579,0.268709,-0.0214561,-0.392621,0.501171,-0.0761293,0.0761663,-0.358299,0.433331,-0.202211,0.497741,-0.52612,0.413755,-0.0275099,-0.142087,0.0464403,0.480256,-0.247631,0.0301979,0.195818,-0.401706,0.0469649,0.3856,-0.125157,0.436951,-0.187989,-0.0305208,0.442243,-0.0917372,0.383321,-0.793065,0.513166,0.400276,0.385586,-0.30084,0.0869374,0.103883,0.237007,0.43941,-0.219112,-0.581147,-0.281099,0.31842,0.25383,-0.242678,0.989198,0.216071,-0.0234539,-0.0187523,0.0172612,-0.499438,0.53429,-0.550761,0.159738,-0.157155,-0.239709,-0.0298016,-0.544592,-0.0565088,-0.226939,-0.197309,0.149412,-0.114313,0.0198306,0.339198,-0.0701397,-0.110363,-0.592546,-0.308004,-0.0693476,0.681323,0.123597,0.178575,0.261931,-0.0861987,-0.161994,-0.271058,-0.521202,0.0456365,-0.395973,-0.0436841,0.0601473,-0.417976,0.0383298,-0.764355,0.0316245,-0.11536,0.389823,-0.320138,-0.511854,0.0580654,0.0405966,0.0363999,0.64972,0.130665,0.0853478,-0.04511,-0.375728,0.981156,0.392376,0.22754,0.248397,-0.431185,-0.289511,-0.248358,0.365795,0.783015,0.0233335,0.571707,-0.0966655,0.356966,0.522676,-0.488218,-0.0605521,-0.429981,0.0760749,0.0144052,-0.0637271,-0.13907,0.342297,-0.306874,-0.832807,0.131073,-0.596264,0.0675176,-0.404258,0.850153,-0.252672,0.364855,0.602322,-0.428741,-0.215131,0.440396,0.313752,-0.20466,-0.166444,0.0128998,0.41956,0.006537,-0.0527713,0.0384377,-0.469131,-0.7403,0.465455,-0.41529,-0.218547,0.37823,-0.462108,-0.0278043,0.161092,-0.146829,0.220134,0.25478,-0.291869,0.0976112,0.218541,-0.467974,0.172151,-0.0279731,-0.101314,0.10866,-0.197862,-0.368675,0.328112,-0.0647054,-0.294051,-0.0683125,0.525123,-0.375683,0.372251,-0.229248,-0.0150384,-0.554683,-0.0209844,0.0363538,0.093521,0.491716,0.534557,0.545151,-0.351549,0.219862,0.0849357,0.254808,0.418662,0.0102186,0.161995,-0.160414,-0.444992,-0.251741,-0.229075,-0.517354,0.00196061,0.118638,0.148986,0.344438,0.385987,-2.95501 +3418.89,0.561844,0.0912059,5,1.64124,0.904818,-0.970926,0.355545,0.419852,0.0235489,0.00141736,-0.179672,0.0661189,-0.253114,-0.0686733,-0.349049,0.0354679,0.363582,-0.404251,0.675801,-0.000366785,-0.0662682,0.09347,-0.0530395,-0.336258,-0.894957,-0.606566,-0.0136961,-0.142668,-0.190841,-0.309359,0.278726,-0.558939,0.290124,0.767172,-0.068681,-0.353587,0.387912,-0.407741,-0.512017,-0.278966,-0.304736,0.0448557,-0.586631,0.954621,0.410954,0.524336,-0.467368,-0.565913,-0.434265,-0.974654,0.144533,-0.0296528,-0.258893,0.0357875,0.2874,-0.129888,-0.731938,0.311582,-0.514908,-0.432772,-0.574541,0.228917,-0.211936,-0.152342,0.769065,-0.384123,-1.0074,-0.170129,0.133954,0.211238,0.218045,0.718744,-0.317568,0.163171,0.21135,0.506398,-0.673715,0.505768,0.494101,0.107894,-0.137906,-0.26771,-0.100673,0.671512,-0.345187,0.0904666,-0.454272,-0.128792,-0.075999,-0.331971,-0.351775,0.145519,-0.442725,-0.166385,-0.0660973,-0.139531,-0.00727622,0.308602,-0.417703,0.240364,0.106944,0.589254,0.544655,-0.463649,-0.0466341,-0.220277,-0.352096,-0.0504674,-0.388307,0.0203135,-0.297786,-0.222465,0.697006,-0.221507,-0.487354,0.549753,0.678441,0.401112,0.131819,-0.248257,-0.024476,0.490624,-0.365108,-0.367737,-0.41995,-0.444586,-0.0755955,-0.194331,-0.0802584,0.780253,0.284208,0.311497,-0.0883879,-0.0223209,-0.257424,0.0743984,0.520063,0.109804,-0.393567,-0.738721,-0.240347,0.470482,-0.167423,-0.953869,-0.237698,-0.0957948,-0.331682,-0.0393599,0.415524,-0.558206,-0.0585906,0.173718,0.355305,0.101426,0.089092,0.236131,0.0630044,-0.68086,0.512088,0.835754,0.201852,0.410935,0.0776782,-0.15597,0.511724,1.06227,-0.0296854,0.170144,0.20439,0.413299,-0.126483,0.122115,0.123925,0.0132645,-0.0819727,0.143404,0.0938001,-0.164115,-0.416713,0.373186,0.194488,0.354934,0.867424,0.131841,-0.312001,0.0915082,-0.0659497,0.331716,-0.130264,-0.0228279,-0.356089,0.618024,-0.430355,0.148259,0.235067,0.125072,0.107131,-0.125632,0.263396,-0.27524,-0.0148891,-0.412186,-0.0418602,-0.000654889,-0.0276739,-0.381933,-0.38697,-0.145616,0.218125,-0.321028,1.12424,-0.430903,0.60139,0.0248026,0.350205,0.52625,0.540474,-0.616544,0.0953861,-0.849506,-0.00843024,0.0321281,-0.83452,-0.332284,-0.188572,0.297948,0.873924,-0.519636,0.630352,-0.537377,-0.277689,-0.252307,0.280302,0.457534,0.287221,0.595778,-0.0220442,-0.14425,0.275829,0.394334,-0.446434,0.619285,-0.285836,-0.125527,-0.000876456,-0.442789,0.23802,0.863868,0.242272,0.281453,0.264422,-0.351353,-0.66149,0.0827311,-0.243432,0.298431,-0.551507,-0.477535,0.0630283,-0.0146934,-0.220726,-0.551963,0.255356,-0.0684279,0.136429,0.221945,0.207833,0.134275,0.333334,-0.267442,-0.467371,0.365486,-0.113181,-0.0896161,-0.0730166,-0.531492,0.207924,0.467841,0.322819,-0.347293,-0.147747,-0.0675807,0.282108,-0.318555,0.633483,-0.684339,-0.0116897,-0.157442,-0.149763,-0.913701,0.146214,0.249912,-0.171837,0.182444,0.142747,-0.0835537,-0.130285,-0.313216,-0.374622,0.566365,0.186857,0.0802094,-0.0905296,0.135804,0.140967,0.223933,0.375456,0.473215,-1.18518 +3413.93,0.969617,0.0912059,4,1.68211,0.909775,-1.0065,0.327114,0.68831,0.0789693,-0.420643,-0.188045,-0.0219863,-0.299831,-0.131525,-0.136522,0.067017,0.138792,-0.260596,0.58977,-0.160926,0.358459,0.166578,0.134993,-0.50678,-0.787235,-0.40767,-0.0221715,-0.0251883,0.444362,0.171676,0.529968,-0.162879,-0.353057,0.375299,-0.624265,0.197486,0.244188,-0.579858,-0.416663,0.00867194,0.20545,0.02634,-0.378137,0.509935,0.547097,0.438427,-1.10118,-0.309062,0.0294918,-0.305281,-0.0439406,-0.059541,0.458209,-0.256428,-0.320857,0.279232,-0.757259,0.286652,-0.212555,-0.221071,-0.381531,0.212413,-0.646285,0.0916784,0.434549,-0.285722,-1.12899,-0.0226646,0.287678,0.617135,0.185745,0.146729,-0.45305,-0.131201,0.030392,0.300608,-0.442973,0.255842,0.374024,0.278847,-0.0762193,-0.522039,0.20685,0.152384,-0.685603,0.280598,-0.509129,-0.253965,0.152015,-0.159285,-0.330748,0.571482,0.103793,-0.41806,-0.790419,-0.508995,0.53341,0.330732,-0.263943,0.1786,0.0793455,0.503088,0.332827,0.194273,-0.192142,-0.416828,-0.390173,-0.072137,0.0895914,0.152406,0.139561,0.170987,0.635739,0.299802,-0.493552,0.400023,0.6685,0.282148,-0.0777602,-0.394376,0.34132,-0.253479,-0.28681,-0.345052,-0.29357,-0.449757,0.192849,-0.522702,0.602965,0.231709,0.122807,0.16272,-0.46502,0.240077,-0.60912,-0.081632,0.427479,-0.0215013,-0.0860579,-0.110184,-0.689176,0.405458,-0.153982,-0.657691,0.004361,0.12777,-0.0972818,0.0332896,-0.0414099,-0.324848,0.471841,-0.103703,-0.00271409,0.363644,-0.598946,0.351497,0.24181,-0.273107,-0.225331,0.738941,-0.190862,0.355163,-0.0948433,-0.177263,-0.100913,1.22247,-0.205925,0.000309548,0.338587,0.318354,-0.660735,0.0137231,-0.385154,0.151601,-0.411091,0.255184,-0.375636,0.0893242,-0.267705,-0.0740863,0.159406,0.146111,1.28157,-0.235941,0.0159855,0.334393,-0.210975,0.267301,-0.518597,0.0508875,-0.0980299,-0.0417173,-0.545666,-0.080099,-0.143173,0.190217,-1.08317,0.0538671,0.215336,-0.253156,-0.112701,-0.580944,-0.102385,-0.0259865,-0.383797,-0.566547,-0.259284,0.170983,-0.377516,-0.540189,0.836536,0.211196,0.947462,0.306972,0.168681,-0.08064,0.106411,-0.164285,-0.557323,0.0220574,0.357419,-0.0532113,-0.533793,0.410552,-0.251803,0.275396,0.306515,0.262954,0.976947,0.270648,0.0751359,0.442414,-0.162334,-0.0597714,0.334173,0.0384553,0.351057,-0.173535,0.668787,0.330807,0.0543689,0.963154,-0.30735,-0.00413173,0.35951,-0.387683,0.147349,0.746033,0.41311,0.411162,-0.137722,-0.0181113,-0.11707,0.375756,-0.208034,0.147228,-0.414347,-0.592804,-0.353854,-0.200205,0.312299,-0.563516,-0.0100458,-0.0785943,-0.095913,0.283632,0.0648197,0.32003,0.166682,-0.0647786,-0.314936,-0.367752,-0.0095696,-0.105456,-0.119336,-0.374609,0.519591,0.22873,0.505456,-0.142652,-0.0761753,-0.128744,0.225424,-0.691128,-0.163856,0.10936,0.0463959,-0.0428993,-0.134411,0.218083,-0.0808958,-0.159726,0.0534988,0.058608,0.303858,-0.0464892,0.28899,0.0376581,-0.708737,0.606681,0.213759,-0.228061,0.0287364,0.0110403,0.141422,0.133678,0.376062,0.36562,-2.0125 +3410.4,0.974486,0.0912059,4,1.72399,0.874709,-0.95657,0.383752,0.433262,-0.0876529,0.247487,-0.409001,-0.0103731,0.0875827,-0.0598573,-0.36369,-0.56426,-0.0148268,-0.735018,0.595501,0.309673,-0.0968702,0.0671814,0.179379,-0.219221,-0.71295,-0.851489,-0.120146,-0.127295,-0.245891,-0.355072,0.0617284,-0.330271,-0.107744,0.402195,-0.663647,0.0262047,0.225617,-0.18446,-0.382052,-0.164635,0.467346,0.551898,-0.805647,0.640935,0.437118,-0.159378,-0.442632,-0.115079,0.179189,-0.92444,-0.0127832,-0.124575,-0.375311,-0.269941,0.200143,-0.0965365,-0.696437,0.266224,-0.617331,-0.628828,-1.01989,0.0253505,-0.287173,0.228371,0.419691,-0.305863,-0.0963533,-0.578525,0.0940845,0.0175976,0.415619,-0.133844,-0.538734,0.0812398,0.803157,0.920869,-0.0343845,0.970082,0.0895098,-0.192749,-0.0911333,-0.164057,-0.405631,-0.0295847,0.375079,-0.0283617,-0.499037,0.122325,0.386903,-0.48608,0.151559,0.0766899,-0.256251,0.499372,-0.387759,0.00996083,-0.428173,0.312038,-0.198911,0.208621,-0.469255,0.0608771,0.700868,-0.0469969,-0.151859,-0.186048,0.172398,-0.00967823,-0.0220585,0.172884,-0.175372,0.318129,0.638142,0.15964,0.163179,-0.0446847,0.427895,0.298579,-0.470434,-0.329699,0.0709363,0.738659,-0.429034,-0.314362,-0.308801,-0.147423,-0.438923,-0.157287,0.101471,-0.251297,-0.198914,0.414483,-0.358763,0.451249,0.325012,0.158919,0.780796,-0.384112,-0.19516,0.0120624,-0.65636,0.313761,-0.692542,0.175172,-0.0267532,0.256071,-0.0380561,0.203313,0.459286,-0.369176,0.58178,0.0495409,0.220821,-0.452845,0.255645,-0.0982135,0.0571684,0.312622,0.240519,0.331705,0.466048,-0.0873274,-0.465826,0.883485,-0.377915,0.308938,0.121886,0.198549,0.398548,0.195568,-0.320114,0.0136548,0.232864,0.2439,0.475404,0.0406626,0.0344238,0.100408,0.166441,0.153063,-0.175131,-0.0817424,0.68557,0.0804964,-0.262433,0.498775,0.0588736,0.546519,-1.11464,-0.474695,0.119276,0.137398,-0.227214,-0.188998,0.615029,-0.0241005,-0.656753,-0.466476,-0.15208,-0.373213,-0.0364331,-1.06316,0.13633,0.195715,-0.119956,0.500983,-0.0992049,-0.194252,-0.330158,0.388202,1.15002,-0.930315,-0.140348,-0.283102,-0.079043,0.418889,-0.397497,-0.438665,0.230984,0.602007,0.249986,-0.318398,-0.497667,0.134121,-0.90523,-0.684133,-0.208824,-0.285488,0.334693,-0.271973,-0.204923,0.582654,0.0973595,0.0563411,0.0336249,0.04944,-0.338477,0.205552,0.63725,-0.3238,0.270979,0.932026,-0.547394,-0.151835,0.280047,0.157967,0.326173,0.195357,0.147809,-0.0605668,-0.400399,0.244552,-0.102457,-0.0240195,-0.528115,0.336924,-1.01822,-0.132156,-0.278806,-0.57032,0.206692,0.287829,0.0517361,-0.187781,0.135411,-0.146738,-0.258216,0.0197677,-0.0199642,0.0627735,-0.574952,-0.249608,0.282734,-0.303525,-0.333049,-0.965889,-0.196851,0.164381,0.0666909,0.221164,0.0691696,0.202263,0.178509,0.218147,-0.619113,-0.336797,0.0586687,0.0506475,-0.114437,-0.221138,0.37184,-0.471749,-0.0554943,0.133048,0.61579,-0.179005,0.0388251,0.121116,-0.70181,-0.267208,-0.0584562,-0.36139,-0.166495,0.227602,0.13256,0.191972,0.364087,0.438146,-1.10022 +3426.47,0.807414,0.0912059,4,1.61653,0.898148,-1.07678,0.334372,0.345217,0.0163379,-0.312531,-0.232041,0.0905245,0.174434,0.0110049,-0.00959644,-0.622871,0.158667,-0.208313,0.773151,-0.0722086,0.0392078,-0.370291,-0.185709,-0.170734,-0.313486,-0.922519,0.0796197,0.00322079,-0.373083,-0.0687849,0.296991,-0.516225,-0.145814,0.491368,-0.204872,0.419928,0.0586358,-0.206687,0.0640474,-0.64188,0.4355,0.363886,-0.760851,0.648056,0.556977,0.431594,-0.777724,0.000474924,-0.100669,-0.408148,-0.355778,0.283048,0.0521331,0.0295308,0.61818,0.0545065,-0.927415,0.510027,-0.158667,-0.250072,-1.2663,0.387322,-0.291844,0.419832,0.610408,-0.363787,-1.11966,0.306359,-0.139241,0.433554,0.380251,-0.0876168,-0.260995,0.0748651,0.416006,0.543838,-0.969706,0.196782,0.375915,0.457461,-0.241099,-0.215659,-0.270605,0.0375895,-0.334236,0.296681,-0.199177,-0.0891786,0.256336,0.401533,-0.0309785,-0.147373,-0.0566632,0.0630057,-0.00361813,0.223498,-0.223321,-0.117349,-0.417646,0.349328,-0.375253,0.006438,0.244083,0.523779,-0.175635,-0.174561,-0.773528,0.215642,-0.626816,0.313448,-0.111126,0.0226413,0.515195,-0.203729,-0.129712,0.118782,0.49498,0.371579,0.4642,-0.358594,0.346996,-0.293142,-0.514983,-0.0384991,0.120174,0.578442,-0.49232,-0.196913,0.0477695,0.328796,0.329479,-0.0237194,-0.322494,0.650312,0.147251,0.195547,0.53712,-0.41523,-0.363601,0.279374,0.0314308,0.00225366,-0.859503,-0.432428,-0.00257671,-0.342774,0.126794,-0.461848,0.209196,0.276466,0.378505,-0.0522219,-0.258173,-0.587395,-0.0600787,0.268,-0.308196,0.0934206,0.475749,0.298369,0.0287146,0.14388,-0.281955,0.275661,-0.250413,0.618884,0.308908,-0.00495635,0.44023,0.0262345,0.0359641,-0.394601,-0.0502529,0.488012,0.512392,-0.00687101,0.0802563,-0.136769,-0.304804,-0.175924,-0.134918,-0.125143,1.16036,0.466218,-0.173573,-0.103786,0.0948066,-0.322747,-0.567658,0.295953,-0.269274,0.545111,-0.258245,-0.308631,0.000550086,-0.185969,-0.416696,0.17857,0.634728,-0.0290298,0.0257819,-0.666027,0.0838709,-0.317065,-0.526581,0.0505712,0.329908,-0.833224,-0.514279,-0.189417,0.877057,-0.623939,0.0329794,0.124675,-0.227024,-0.212956,0.458502,-0.46658,0.241774,0.0871151,0.226735,-0.3085,-0.0784549,-0.266911,-0.469009,0.646908,0.153017,-0.0184131,0.801806,-0.321815,0.493283,0.10519,0.262266,-0.664365,0.269092,0.058501,0.0314415,0.386232,0.401164,-0.34947,-0.30039,0.837629,-0.0495184,-0.398988,-0.107777,-0.278612,0.38288,0.425063,0.549075,0.123142,0.0724249,0.6332,-0.230628,0.00115287,-0.672653,0.0161091,-0.641768,-0.0682765,0.347549,-0.502135,-0.9135,0.709686,0.029879,-0.0297855,-0.0373088,-0.162274,0.179762,0.548401,0.147121,0.303549,-0.611904,-0.111762,-0.110605,-0.447577,-0.165489,0.050594,0.482457,0.163879,0.528712,0.284862,-0.270627,0.81501,-0.36947,-0.175708,-0.636097,-0.282314,0.0664298,0.244189,0.533099,-0.422457,-0.020569,-0.734174,-0.0162214,-0.0496033,0.0279995,0.282863,0.605372,-0.0947314,-0.691638,0.119399,0.044358,-0.445407,-0.249718,0.116898,0.149425,0.222779,0.386555,0.471995,-0.87283 +3428.52,0.865054,0.0912059,5,1.59931,0.934543,-1.00596,0.327985,0.46858,-0.0285799,0.289379,0.31274,-0.0668224,-0.0408427,0.125443,-0.353239,-0.361108,0.244768,-0.199758,1.00877,0.193011,-0.160893,-0.393987,-0.135933,0.177207,-0.284445,-1.10582,0.0176141,-0.264567,-0.175074,-0.0102412,-0.10705,-0.432878,-0.164622,0.44188,-0.234569,0.384848,0.0242578,0.0949987,-0.0223058,-0.747621,0.19718,0.0149607,0.119207,1.00475,0.478565,0.550211,-0.441347,-0.268938,-0.142345,-0.394066,-0.264048,-0.0233649,-0.0854753,0.182566,0.17012,-0.139985,0.27395,0.781645,-0.6055,-0.492305,-0.762523,-0.0265931,0.232357,0.359808,0.72829,-1.0272,-0.134372,0.394121,-0.0200528,0.534828,0.255343,0.112428,-0.228268,0.353094,0.0379755,0.485735,-0.147246,0.285107,0.491718,0.60187,-0.416202,-0.186598,-0.399307,-0.0533446,-0.656299,0.184028,-0.760634,-0.389515,0.161771,0.201884,-0.254906,0.265617,-0.0926017,0.185621,0.0900222,0.115433,-0.22278,-0.012174,-0.82693,-0.195796,-0.172929,-0.0476515,0.449408,0.133842,0.0758347,-0.41065,-0.377556,0.457617,-0.251952,0.349259,-0.138417,-0.137697,0.254488,0.334074,-0.43645,0.0818228,0.19738,0.310538,0.183915,-0.423583,0.231677,-0.177831,-0.0824234,-0.557194,0.12895,0.327609,-0.287153,-0.219309,0.434366,0.640995,0.548485,-0.0332414,-0.440465,0.508795,0.0616512,-0.469408,0.806939,0.103064,-0.367706,0.159271,-0.245711,0.0420005,-0.522007,-0.566368,0.0122832,-0.0668683,-0.105343,-0.525117,-0.204455,-0.0381434,0.0321881,-0.0245699,-0.270776,-0.114233,-0.0153378,-0.00335678,-0.208354,-0.145759,0.620572,0.106446,-0.105201,0.009609,0.25734,0.62418,0.292895,0.661185,-0.253338,-0.169739,0.362314,0.230849,-0.314503,-0.222494,-0.000979257,0.313921,0.294234,-0.278468,0.574959,-0.0302088,-0.391516,0.217862,0.0270093,0.109639,0.869616,0.184963,-0.226108,0.0471058,-0.0659361,-0.118045,-0.389967,0.306274,-0.295774,0.235935,0.0241964,0.108696,0.140408,-0.0929216,-0.475989,-0.0316273,0.265987,-0.302726,-1.09721,-0.46843,-0.0625104,-0.264291,-0.125958,-0.355451,0.319013,-0.0828324,-0.622603,-0.320795,1.24139,-0.44947,0.0603303,0.226616,-0.178917,-0.117982,-0.156425,-0.35587,0.503276,0.00536578,-0.0543753,0.458951,-0.209879,-0.134392,-0.216815,0.214189,0.533774,-0.279136,0.565925,-0.0882098,0.0788334,0.454446,0.252667,-0.870195,-0.328659,0.386208,-0.190211,-0.196357,0.862229,-0.186663,0.417855,0.606962,-0.0438615,-0.384327,0.0270341,-0.00337318,0.0656727,0.779023,0.193286,0.38537,-0.0820105,0.274779,-0.386693,-0.367911,-0.471969,-0.167535,-0.627667,-0.155907,0.194171,-0.916394,-0.669415,0.497602,-0.0497038,-0.150555,0.321827,0.100765,-0.0880333,0.698894,0.180986,-0.000991174,-0.432988,-0.367358,-0.26408,-0.255797,0.123028,0.216659,0.209112,-0.0383971,0.368533,0.424586,-0.138562,0.432338,0.0403489,-0.249106,-0.210316,-0.193653,0.439514,0.359502,0.323242,-0.277445,0.0718421,-0.750837,0.0904,-0.163275,-0.25258,0.0403968,0.32173,0.0624359,-0.221119,0.178115,-0.0119725,-0.743141,0.341233,0.19048,0.125526,0.159097,0.354297,0.398869,-1.38386 +3412.59,0.9366,0.0912059,4,1.65044,0.839759,-1.01144,0.473796,0.413665,-0.0943469,0.162442,-0.127327,0.0347372,-0.16758,-0.380902,-0.0549607,0.146212,0.377282,-0.271432,0.421438,-0.110219,0.13032,0.260554,0.0773668,0.144882,-0.603541,-0.133183,0.151003,-0.0452106,-0.0954263,0.111758,0.353412,-0.487936,0.284257,0.571316,-0.13629,-0.0352009,0.385933,-0.919609,-0.404744,-0.298434,0.590447,0.440977,-0.679603,0.54739,0.225115,-0.0933936,-0.67183,0.0227507,0.312651,-0.158652,0.40827,0.111319,0.00300568,-0.187873,0.066782,0.505376,-0.645858,0.094069,-0.524666,-0.119564,-0.472205,0.0773803,-0.716233,0.00459054,0.721386,-0.39447,-0.961393,0.185503,0.0581319,-0.619618,0.480043,0.263312,-0.321535,-0.346797,0.302646,0.710314,0.181888,0.749756,0.46796,0.259352,-0.470527,0.0317514,-0.221595,0.51789,-0.0796805,0.109617,-0.165436,-0.0855691,-0.578416,0.11729,0.0956934,-0.380086,-0.223695,-0.436217,0.00287915,0.223889,-0.0244442,0.238197,0.786871,0.309961,0.0148534,-0.304719,0.236794,0.0459612,-0.505359,-0.466765,-0.0498636,0.0993431,-0.000128544,0.42208,0.119215,0.215611,0.789765,0.00996259,-0.810479,-0.326362,0.540504,0.470457,0.221352,-0.802781,0.376722,0.162495,-0.358724,-0.272375,0.614704,0.0784406,-0.131309,-0.664712,-0.0140312,0.798553,0.427793,0.755274,-0.160936,-0.111402,0.225822,0.2028,0.558607,-0.19405,0.169326,-0.245054,-0.128484,-0.187596,-0.635203,-0.897356,-0.0112445,0.389683,-0.249361,0.232062,0.692928,0.400425,0.619276,0.08735,-0.160883,-0.477515,0.138404,-0.104914,-0.251293,-0.0599619,0.621818,0.23051,-0.308882,0.320015,-0.339111,-0.194714,-0.436886,0.600675,0.186165,-0.0558904,-0.122494,0.167294,0.298921,-0.646616,0.66486,-0.265244,-0.0995483,0.123426,0.490457,-0.1183,-0.160829,-0.128756,-0.134056,0.21607,0.857511,0.0993507,-0.554285,-0.455345,-0.0713434,0.136955,-0.637515,0.159679,0.183569,0.603885,-0.360289,-0.335566,0.360263,-0.15342,-0.314339,-0.257853,-0.144684,0.198474,-0.350841,-0.679058,0.301908,0.208853,-0.668868,-0.0912164,0.0457114,0.387038,0.186277,-0.12536,1.11611,0.566799,0.127409,0.00304562,0.0767212,0.186241,0.342757,0.203777,0.574588,-0.225446,0.339876,0.496726,0.076231,-0.576645,-0.480694,-0.212146,-0.888294,-0.704577,0.427967,-0.270491,-0.356783,0.322026,-0.509481,-0.812218,0.439602,0.312507,-0.0286895,-0.601526,0.565253,0.234871,-0.0620316,0.303658,0.0155407,-0.371683,0.0597539,0.135025,0.149167,0.64938,-0.0173645,0.583843,0.180639,0.482627,-0.178825,0.439792,-0.470735,0.638439,-0.565238,-0.0999503,0.251229,-0.508953,-0.495479,0.202544,-0.0591507,0.584993,0.365309,-0.0815183,-0.111981,0.633759,0.168434,0.245408,0.800036,-0.0631684,-0.0339382,0.114893,-0.41715,-0.526062,0.0209644,-0.203659,0.100473,-0.0074711,0.743699,0.347807,0.00183347,-0.555221,0.0160592,-0.716668,-0.0405198,-0.0781526,0.239717,0.189508,-0.000252251,0.383633,-0.385743,0.154689,-0.0869954,-0.0712171,0.103928,0.234562,-0.639066,0.0142695,-0.14635,-0.552528,-0.451689,-0.226038,0.170291,0.121604,0.412664,0.348717,-1.10182 +3401.58,0.985522,0.0912059,4,1.56691,0.780266,-1.16815,0.556169,0.50468,-0.0986406,0.436154,0.22369,0.263826,-0.0954052,0.0134559,-0.104462,-0.263019,0.361629,-0.278857,0.69751,0.146703,-0.159376,0.201792,-0.214187,0.214666,-0.252675,-0.853771,0.462215,0.0111851,0.027029,-0.0153847,0.225111,-0.896119,-0.267189,0.7616,-0.769457,-0.212422,0.153161,-0.446392,-0.552793,-0.453971,0.501875,0.19249,-0.297185,0.795712,0.0356709,0.195827,-0.295558,-0.27924,0.31156,0.0836194,-0.146336,-0.187077,-0.390888,-0.00854276,0.141724,-0.149193,0.248133,0.12038,-0.227874,-0.332688,-0.396014,-0.144116,-0.230527,0.221193,0.555528,-0.836012,-0.434215,-0.126336,-0.359888,0.454992,0.163491,0.726694,0.427629,-0.686826,0.278671,0.61602,-0.494,0.719783,0.533728,0.275818,-0.275181,-0.558486,-0.124426,0.411728,0.316312,0.312282,-0.230901,-0.780756,0.469696,-0.542089,0.171654,0.195549,0.040999,0.026506,-0.108957,-0.241445,0.587149,0.130993,-0.113156,0.246519,-0.716307,0.0150022,0.479185,-0.0738611,0.0664214,-0.218462,-0.0141059,0.23167,-0.495466,-0.00389787,-0.335335,0.377465,0.364171,0.0919433,-0.597032,0.00248715,0.661087,-0.343183,-0.1465,-0.450291,0.103622,0.502696,0.0845952,-0.413515,-0.191429,-0.372364,-0.608681,-0.781451,0.632686,-0.267684,1.10193,0.428707,-0.366795,0.235225,0.166693,0.111268,0.33559,0.0122703,0.143519,-0.17663,0.356171,0.379444,-0.513962,-1.02404,0.206694,-0.0155821,-0.722746,-0.0941151,0.207611,-0.383621,0.459239,0.151794,-0.263242,-0.542514,0.640018,0.310199,-0.405595,-0.0553057,0.197856,0.0999838,-0.261485,0.104598,0.555,0.150985,-0.473312,0.580782,-0.649381,-0.359631,-0.280255,0.225672,0.126522,0.22257,0.320997,0.252762,-0.628112,0.227535,0.499977,-0.227584,-0.263443,0.213793,-0.284502,-0.152465,0.591261,0.179057,-0.492287,0.134292,0.0880221,0.0335181,0.133703,-0.395006,-0.0750318,0.14895,-0.451826,0.0600079,0.314397,0.40204,-0.13378,-0.282004,-0.214823,0.542662,-0.642975,-0.851233,0.467505,-0.539607,-0.646198,0.183379,0.163024,-0.149063,0.753121,-0.19642,1.10564,0.17713,-0.119051,-0.209048,0.148701,0.019867,0.0802859,-0.242879,0.373969,-0.1494,0.189486,0.703228,0.278071,-0.389046,-0.420907,-0.401682,-0.0120944,-0.00204448,0.782604,-0.0225561,-0.166697,0.00903908,-0.400323,-0.300419,0.134812,-0.442405,0.181839,-0.935505,0.731962,-0.0362658,0.211752,1.10303,-0.364119,-0.388679,0.0679434,-0.217187,-0.214953,-0.229119,0.152182,0.732644,0.0390148,-0.215313,0.0508851,0.17367,-0.0519426,0.484761,-0.414317,-0.490544,-0.273297,-0.439951,0.052534,0.0385124,-0.110999,-0.362561,0.245734,0.259507,0.132284,0.566317,0.0437433,0.0838818,-0.445953,0.041132,0.100244,0.504655,-0.268257,-0.471616,-0.124034,-0.0493418,0.0113268,-0.0720353,0.2106,0.251006,-0.239663,-0.722205,0.332951,-0.94841,0.345089,0.557027,0.550914,-0.45608,-0.2652,-0.119876,-0.267197,0.387785,-0.137381,-0.24443,0.389652,0.0792526,-0.259561,0.319515,0.281638,-0.258231,-0.515506,0.163467,0.132839,0.157383,0.364471,0.396715,-1.37702 +3382.3,0.760457,0.0912059,4,1.63304,0.894772,-0.57137,0.250384,0.39252,-0.0344106,0.170241,0.230025,-0.289303,-0.258536,-0.123556,0.064239,0.0265865,0.413835,-0.0959796,0.488252,0.116277,0.122553,-0.0329807,0.0523275,0.0170137,-0.869982,-0.436103,0.367302,-0.0778884,0.0390452,-0.0583475,0.206848,-0.507021,0.168826,0.63606,-0.289463,0.526454,0.355058,-1.01267,-0.317805,0.186694,0.388801,0.28682,-0.102631,0.629261,0.142055,0.0545056,-0.778913,0.0250799,-0.314215,-0.644913,0.39004,0.142948,-0.452207,-0.33391,-0.112589,0.410843,-0.589671,0.198317,-0.260072,-0.282389,-0.367404,0.163476,-0.634798,-0.162958,0.322778,-0.458305,-0.84987,-0.0412458,-0.0438262,-0.742728,-0.395606,-0.44631,-0.710565,-0.380339,-0.218991,0.510033,-0.0499233,0.42126,0.321075,0.401343,-0.152883,-0.26418,0.0504337,0.441954,-0.111786,-0.311598,-0.208081,-0.976767,0.178421,-0.205335,-0.139135,-0.891676,-0.478401,0.103974,0.194234,0.446689,0.378938,0.390189,-0.107849,-0.153276,-0.637383,-0.260158,-0.0348453,0.509139,-0.406116,-0.540862,0.0428614,0.637495,-0.237525,-0.134364,0.099275,0.854845,1.00582,-0.152233,0.0359358,0.23968,0.771744,0.295799,0.350221,-0.32134,0.214174,-0.440226,0.0763792,-0.198606,0.0291355,0.373486,-0.318598,-0.289362,-0.401398,-0.135747,0.175864,-0.0366574,-1.04256,0.519139,0.0145655,-0.0926963,0.446405,0.103918,0.161756,0.194798,0.193172,-0.0710069,-0.690948,-0.678576,-0.27204,-0.170239,-0.80559,0.618025,-0.0995631,0.267235,0.812863,-0.169376,-0.0791458,-0.3145,-0.263539,0.751969,0.23517,-0.460908,-0.139465,0.299323,-0.145557,0.206663,0.314847,0.660929,0.00254988,0.635414,0.26554,-0.199016,0.759079,-0.532537,0.795547,-0.0536486,0.247689,-0.45553,-0.228557,0.377396,-0.282875,0.265497,-0.71956,-0.16419,0.203097,0.827808,1.51577,0.0976569,0.0299778,0.489977,-0.0615505,-0.901533,0.0508506,-0.0148099,0.345858,0.286587,-0.737573,-0.0137758,0.178999,0.201656,-0.443209,0.326591,0.0658804,0.0979426,-0.0497341,-0.467556,0.357631,0.0754409,-0.00757943,-0.313006,-0.260194,-0.173856,-0.165917,0.174701,1.13986,0.0601245,-0.227141,0.280318,0.160929,0.864582,0.0571771,-0.226136,0.21253,-0.0387629,0.30233,0.618338,-0.107033,-0.182006,-0.559635,-0.141142,-0.177801,-0.894365,0.471862,-0.646938,-0.0864183,-0.0319705,-0.00590923,-0.569967,0.659581,-0.327753,-0.0981979,-0.0528888,0.53739,0.257314,-0.408311,0.610572,-0.777756,-0.618647,0.407956,-0.100931,0.0183466,0.370878,0.469386,0.110912,0.080367,0.191158,-0.316939,0.25553,-1.02085,0.440388,-0.418102,0.103478,-0.0489025,-0.484832,-0.12472,0.184734,0.0763668,0.471528,0.674142,-0.363447,0.274079,0.837071,0.278954,-0.213098,0.22335,-0.0816948,0.0701131,0.148066,-0.108853,0.069051,-0.120397,0.147205,-0.362791,0.213649,0.190271,0.0680815,0.118416,-0.490946,0.240019,-0.101191,-0.0294559,0.242683,0.493075,0.260578,0.403445,0.0491854,-0.689026,0.392431,-0.818122,0.118787,-0.312126,0.317267,-0.203495,-0.0564567,-0.382742,-0.725522,-0.633635,0.193504,0.216636,0.143322,0.465442,0.378579,-1.1806 +3369.54,0.870398,0.0912059,4,1.62467,0.859154,-0.669429,0.249622,0.348071,-0.033466,0.143068,0.233087,-0.331511,-0.381549,-0.116787,0.122616,0.0802927,0.383176,-0.128399,0.508329,0.091498,0.18766,-0.0544092,0.0261935,0.0348089,-1.01951,-0.611456,0.392232,-0.127769,-0.228532,-0.102668,0.196765,-0.534264,0.246945,0.646606,-0.455965,0.417251,0.257281,-0.939654,-0.166775,0.157484,0.31365,0.199819,-0.113135,0.605532,0.102329,0.152914,-0.892242,0.0871757,-0.38775,-0.745452,0.468475,0.191538,-0.430569,-0.275081,-0.192767,0.473053,-0.66654,0.292918,-0.192318,-0.239207,-0.236185,0.196394,-0.612429,-0.12005,0.394709,-0.307444,-0.788998,-0.17092,-0.0785324,-0.780018,-0.267165,-0.443182,-0.700988,-0.359399,-0.261724,0.600232,0.0400954,0.360596,0.334009,0.498224,-0.295648,-0.364577,0.176228,0.496418,-0.146809,-0.300421,-0.0580546,-0.940424,0.125281,-0.226853,-0.105872,-1.02875,-0.486632,0.231398,0.1907,0.473494,0.365327,0.384874,-0.213087,-0.281421,-0.674954,-0.25839,0.0729807,0.472144,-0.465595,-0.592171,0.0132125,0.551374,-0.130607,0.0283918,0.121023,0.886997,1.00334,-0.177535,0.0334916,0.245076,0.881079,0.31757,0.360688,-0.220567,0.266708,-0.402924,0.0571351,-0.304181,0.118072,0.399012,-0.248046,-0.205475,-0.330227,-0.226455,0.274025,-0.0157806,-1.05692,0.446167,-0.0569574,-0.184458,0.323699,0.0429583,0.260936,0.213751,0.0922188,-0.110104,-0.755343,-0.719067,-0.242805,-0.113691,-0.741349,0.561603,-0.188576,0.3368,0.779305,-0.154404,-0.123078,-0.340014,-0.301344,0.68848,0.238168,-0.365641,-0.207218,0.215687,-0.150763,0.2767,0.336549,0.629591,0.0129886,0.614114,0.244416,-0.396196,0.691813,-0.532147,0.845734,-0.0596837,0.241391,-0.471967,-0.25324,0.403325,-0.264257,0.194526,-0.675681,-0.116467,0.265044,0.782234,1.65093,-0.0561529,0.0359529,0.529451,-0.0496224,-1.07427,0.0396835,-0.11382,0.327647,0.417946,-0.823951,-0.0439598,0.151892,0.03205,-0.454669,0.478371,0.157732,0.0901715,-0.0612669,-0.403027,0.320301,0.136298,-0.0834464,-0.276671,-0.366714,-0.173134,-0.318567,-0.0188616,1.16854,0.183606,-0.336854,0.277124,0.215987,0.842828,0.124774,-0.406265,0.218143,0.0420119,0.329486,0.648435,-0.130215,-0.101519,-0.490301,-0.378371,-0.103591,-0.861358,0.397396,-0.662886,-0.299013,0.0801486,-0.0635723,-0.622101,0.632672,-0.245999,-0.00698624,0.0355673,0.47701,0.356464,-0.334209,0.585003,-0.801699,-0.513418,0.392708,0.0601078,0.152694,0.35106,0.396651,0.0866669,0.126959,0.143998,-0.280831,0.315253,-1.11322,0.383058,-0.354906,0.0572656,-0.0291015,-0.637907,0.0605251,0.0797269,0.101847,0.516497,0.643416,-0.320329,0.253583,0.912835,0.28221,-0.0985212,0.240372,-0.0232354,0.04695,0.200288,-0.164272,-0.0657351,-0.230847,0.22536,-0.440678,0.145028,0.261093,0.0755354,0.195139,-0.476874,0.135313,-0.160698,-0.11209,0.150492,0.549372,0.257408,0.407701,0.0363622,-0.61184,0.392945,-0.835265,-0.0710185,-0.388263,0.341147,-0.184747,0.0732447,-0.342558,-0.700637,-0.714884,0.171412,0.216762,0.150992,0.465577,0.388577,-0.926434 +3392.35,0.959925,0.0912059,4,1.55461,0.892944,-1.20136,0.356762,0.371226,-0.226296,-0.187889,0.422561,0.641027,0.460835,0.220052,-0.371913,-0.643676,0.160431,-0.278016,0.664122,0.188095,-0.717522,-0.20938,0.214379,-0.364685,-1.00541,-0.318938,0.219703,-0.601013,0.0237744,0.589647,0.201948,-0.640381,-0.338672,0.496404,-0.400452,-0.499412,0.137087,-0.519364,-0.199834,-0.641563,0.761437,0.345588,-0.0868025,1.07547,0.486547,0.32792,-0.41724,-0.121644,0.373055,-0.412183,-0.297068,0.428763,-0.218893,0.26719,0.695337,0.0902636,-0.286224,0.344759,-0.0613706,-0.0742865,-0.357271,0.306733,0.114553,0.41668,0.509779,-0.458578,-0.504537,0.449968,0.497896,0.192963,-0.362477,0.446204,-0.610334,-0.0465285,0.599874,0.626073,-0.323112,0.675088,0.400529,0.436287,0.278443,-0.228762,-0.159592,0.822297,-0.763401,0.453311,0.243776,-0.682363,-0.814487,-0.495669,-0.137059,0.209725,-0.16406,0.0162704,-0.265597,-0.13715,0.336011,0.104318,-0.17079,0.094939,-0.0291934,-0.00498028,0.405408,-0.156951,0.135789,0.00321832,-0.589085,0.279201,0.0985017,-0.168033,-0.0566207,0.202002,0.271204,-0.584158,-0.799935,0.0449201,0.640083,0.456897,-0.429524,-1.23763,0.382277,0.227406,0.380686,-0.192609,0.309772,-0.508149,-0.21015,0.0236422,-0.13998,0.034163,0.230247,-0.128028,-0.583812,0.137873,0.10652,0.182716,0.507529,-0.697254,0.0900939,0.0775601,-0.522242,0.610478,-0.929054,-0.577632,-0.153123,0.458186,0.00523973,-0.824277,0.458517,0.10368,0.0458878,0.217805,-0.425759,-0.28746,0.685757,0.292571,0.0971428,0.428022,0.839115,0.152782,0.217154,-0.00979589,0.0335665,-0.531337,0.115126,0.723675,0.187515,0.745644,-0.118515,0.256211,-0.277509,-0.225124,-0.0907083,0.213173,0.502222,0.294022,-0.0553895,-0.0820347,-0.0331871,-0.0755822,0.173789,-0.653596,0.832066,-0.51485,-0.488443,0.145156,0.0854168,-0.101683,-0.670164,-0.159672,-1.21937,-0.129434,-0.0409294,0.175229,-0.0891984,0.0760032,-0.997198,-0.0508897,-0.0394349,-0.292261,-0.72104,0.050693,-0.505174,-0.548857,-0.0154341,0.0249637,-0.436538,-0.139159,0.0891516,-0.446921,0.962394,0.441162,0.32711,0.19151,0.156314,-0.378009,-0.17669,-0.409821,0.205628,-0.753555,-0.134665,0.534079,-0.157101,-0.000288074,-0.35297,-0.452481,0.162975,0.0222525,0.429135,0.061471,-0.0229716,-0.440914,-0.0865534,-0.681022,0.303991,-0.924409,-0.141013,-0.682226,0.703358,-0.328592,0.33243,1.35477,-0.277626,0.0644056,-0.709382,-0.241326,-0.730869,0.542225,-0.773906,0.30539,0.0558875,-0.500389,-0.471039,0.0112644,-0.370253,0.294544,-0.182555,-0.826056,0.0801465,-0.232192,0.447132,-0.43723,-0.0033129,-0.160501,0.209352,-0.115845,0.140979,0.582857,-0.0560016,0.298596,-0.635008,0.296613,-0.236673,-0.0673517,-0.908864,-0.133723,0.438222,0.390686,0.180384,-0.0481473,0.0297453,0.698398,-0.0126303,-0.518537,-0.314902,-0.158896,0.265831,0.228166,0.432864,-0.30666,0.409661,0.0514232,0.615597,0.249363,0.630071,0.244584,0.126586,-0.0614068,-0.635969,-0.0908616,0.285085,-0.570891,0.25658,0.0405824,0.184621,0.202428,0.429675,0.44992,-0.907014 +3397.48,0.895026,0.0912059,4,1.56282,0.89527,-1.5499,0.499371,0.49482,-0.0748707,-0.16074,0.237577,0.201953,0.0497391,0.0966309,-0.310604,-0.299625,0.275057,-0.252769,0.616552,0.190254,-0.477148,-0.55859,-0.183489,-0.445027,-1.12425,-0.235353,-0.0124336,-0.552202,-0.384036,0.438884,0.0443546,-0.531359,-0.336463,0.624381,-0.628502,-0.388237,0.106187,-0.202196,-0.190849,-0.27487,0.794127,0.528755,-0.302244,1.03672,0.809559,0.0709295,-0.794685,-0.0513782,0.49253,-0.485672,0.0564382,0.342212,0.342238,0.511728,0.424099,0.130625,0.0409669,0.122424,0.254159,-0.140465,-0.615402,0.106741,-0.0724035,0.158687,0.581917,-0.347336,-0.556573,0.238275,0.520923,-0.132949,-0.515225,0.290465,-0.562468,-0.026532,0.665941,0.689676,-0.779081,0.404363,0.0787359,0.483188,0.0434786,-0.148379,0.0199021,0.905975,-1.32086,0.43197,0.30332,-0.499999,-0.450344,-0.517834,-0.0936323,-0.0131981,-0.175372,0.0503027,-0.450365,0.021681,0.398948,0.197187,0.066079,-0.157314,0.393359,-0.146473,0.311984,-0.0703657,-0.404982,-0.494494,-0.289854,0.134706,0.0280003,-0.152516,-0.29305,-0.00272428,0.376621,-0.161522,-0.636817,0.364078,0.910914,0.566563,-0.130918,-0.768114,0.302379,0.129993,0.414017,-0.113482,0.573883,-0.828917,-0.580453,0.13676,0.035993,-0.0592328,0.100828,0.00844529,-0.347659,0.0819632,0.158317,0.0552976,0.685993,-0.431247,0.338658,0.385021,-0.483051,0.422947,-1.21313,-0.617912,-0.163628,0.410063,-0.225271,-0.52402,0.522044,0.251654,0.267848,-0.0980854,-0.295148,0.00166798,0.446114,0.0635921,-0.0260772,1.03573,0.851109,0.374192,0.157984,0.0244864,0.130496,0.0382418,0.040933,1.22495,0.00674669,0.451654,-0.121102,0.230908,-0.21729,-0.391521,-0.33636,-0.0273587,-0.163208,0.163113,-0.185379,-0.359568,-0.269983,-0.00607387,0.0253725,-0.618889,0.952917,-0.584529,-0.289173,0.156426,-0.00487005,0.217961,-0.392567,0.177273,-1.03961,0.464736,-0.540305,-0.0556544,-0.0491846,-0.277468,-0.860698,-0.0270833,0.685934,-0.0224761,-0.629594,-0.0225297,-0.566096,-0.235958,0.0856922,-0.0484673,-0.480292,0.315748,0.163102,-0.681594,0.831492,0.345634,0.408771,0.00867436,0.107985,-0.438858,0.387645,-0.818499,0.409646,-0.293227,0.102152,0.253751,-0.363596,0.188557,-0.577015,-0.244973,0.442619,-0.450793,0.142068,-0.0582361,-0.672009,-0.576423,-0.0170387,-0.875296,0.283146,-0.931413,0.0795628,-0.755737,0.875631,-0.328406,0.0487773,1.51784,-0.343559,0.106485,-0.347303,0.012441,-0.651038,0.452936,-0.500008,0.376341,0.336116,-0.41367,-0.513204,-0.294452,-0.481385,0.281072,-0.129163,-0.829525,0.152202,-0.498743,0.541512,-0.653944,-0.136626,-0.137818,0.0869642,0.026209,0.293868,0.992149,0.0811845,0.0552733,-0.839907,0.775705,-0.0498448,-0.03448,-0.793414,-0.362437,0.4548,0.32903,0.35767,0.0599657,-0.152879,0.915138,0.0247667,-0.515505,-0.543721,-0.211605,0.311107,0.152223,0.448561,-0.0308266,0.135388,0.209175,0.466257,0.201794,0.334036,-0.264724,0.471153,-0.223967,-0.375473,0.174373,0.298095,-0.308192,0.457785,0.115995,0.193293,0.220914,0.439651,0.470015,-1.3032 +3386.29,0.950799,0.0912059,4,1.64852,0.930284,-0.971272,0.30082,0.884615,-0.102372,0.0806319,-0.208759,0.00973035,0.0241048,0.0479309,-0.379314,-0.278959,-0.0165734,-0.054376,0.564785,0.183343,-0.109076,0.29085,-0.439341,-0.320287,-1.35802,-0.590541,-0.0743188,-0.394364,0.294963,-0.114473,0.181983,-1.02739,0.292625,0.381504,-0.215506,0.187698,0.17716,-0.638339,0.0641674,-0.221141,-0.205934,0.151192,-0.190613,0.895598,0.545368,0.222743,-0.845997,-0.0757507,0.283143,-0.569494,0.322951,0.296368,-0.0912928,-0.106803,0.604563,0.514292,0.158049,0.427597,-0.444651,-0.0240465,-0.364715,0.302098,-0.396432,0.286405,0.419394,-0.769638,-0.619805,0.437314,0.00746669,-0.259522,-0.014472,-0.0752915,-0.513958,-0.759614,0.134157,0.523458,-0.0647347,0.212457,0.409474,0.520609,0.148267,-0.727112,-0.210963,0.930043,-1.11946,-0.057408,0.110076,-0.691483,0.00532346,0.305523,0.146844,0.076999,-0.234078,-0.612744,0.37799,-0.175501,0.0299974,-0.0311658,-0.39827,0.00797471,-0.257008,-0.0151445,0.108796,-0.48574,-0.703857,0.250293,-0.216365,-0.0746888,-0.497371,-0.444,0.0971926,0.0852257,0.11932,0.678046,-0.0363444,0.400335,0.379771,-0.0957041,0.292001,-0.358441,-0.037063,0.462371,0.0197891,-0.712962,-0.15283,-0.700534,-0.48513,-0.130911,-0.315879,-0.333651,0.139972,-0.054274,-0.836523,-0.1403,-0.196443,-0.186737,0.875905,-0.593963,0.330727,-0.469362,-0.462409,0.151258,-0.623676,-0.143762,-0.0937383,0.155152,-0.606777,-0.31477,0.402847,0.208096,0.51758,-0.0385863,0.377091,-0.474518,-0.195111,0.967801,0.111962,0.371913,0.396213,0.864425,-0.0046603,0.240204,0.311425,1.13462,0.444861,0.43352,-0.116669,0.0201598,-0.824889,-0.161196,0.105634,0.0652627,-0.560597,-0.121766,-0.646526,0.262331,0.287661,-0.120179,-0.206424,0.278352,-0.285698,-0.492096,1.31178,0.238937,-0.438796,0.33944,-0.157304,-0.247817,0.0174847,-0.913136,-0.25015,0.399905,-0.516204,0.318098,-0.0229481,0.069756,-0.842537,-0.276808,0.00561022,0.348695,0.00388282,-0.324522,-0.0544829,-0.0817707,-0.235424,-0.00436702,0.356737,0.147061,-0.409086,-0.975224,1.19523,-0.234334,0.0852075,-0.109761,0.168911,0.406502,0.165851,-0.806683,0.284543,-0.937464,0.01909,0.294069,-0.296662,0.697527,-0.683274,-0.395262,0.511608,0.317158,0.405945,-0.31852,-0.318663,-0.463491,-0.30552,-0.762848,0.35748,-0.0807888,-0.401548,-0.719427,0.574658,-0.558824,0.454062,0.860201,0.525992,0.490457,-0.368567,-0.241483,-0.479472,0.329585,0.180002,0.407314,-0.0984547,-0.424083,-0.356495,-0.23002,-0.328047,-0.206888,-0.246328,-0.580199,0.431281,-0.00521386,-0.0923217,-0.121896,0.0494061,0.570096,0.709197,-0.514346,-0.218739,0.731637,-0.0477292,-0.0696077,-0.506582,0.109677,0.255644,-0.240886,-0.677119,-0.616665,0.807048,0.290071,0.396485,-0.0390868,-0.516581,0.402245,0.367591,0.395164,-0.0464737,0.11822,0.101357,-0.133222,-0.355425,-0.221959,0.63957,0.0110315,-0.086057,0.291581,-0.524195,0.697005,-0.30136,0.0428299,-0.328579,0.146939,0.457013,0.162116,0.138264,-0.0280921,0.186973,0.156632,0.432404,0.395767,-2.68228 +3406.46,0.77368,0.0912059,5,1.61635,0.907044,-0.877428,0.335872,0.553612,-0.140677,0.0786213,-0.201373,0.322122,0.216558,0.0746492,-0.441846,0.139076,0.271447,-0.074819,0.400625,0.161015,-0.0825449,0.290222,-0.0995315,0.026208,-0.968662,-0.639857,0.123654,-0.517596,-0.242613,0.227705,0.242925,-0.429543,0.00820934,0.276254,-0.342353,0.269573,0.270856,-0.301245,-0.182251,0.204334,0.48276,0.145291,-0.205761,0.788796,0.620513,-0.199243,-0.819052,-0.205585,-0.201477,-0.110993,-0.0516417,0.239966,0.463939,0.263211,0.0347162,0.241513,-0.0265398,0.49277,0.103245,-0.345218,-0.532364,0.122381,-0.373639,0.005045,0.380782,-0.717279,-0.825879,-0.446009,-0.0428015,0.135718,0.0125893,0.566233,-0.612182,-0.105517,0.00915331,0.742836,-0.616049,0.312598,0.29047,0.246356,-0.204505,-0.124419,-0.25654,0.793995,-0.858478,0.105737,0.106888,-0.195625,0.315681,0.158264,0.195987,0.310027,0.210067,-0.6538,0.200506,-0.192027,-0.0640547,-0.175091,-0.971898,0.553482,-0.327778,-0.126212,0.368271,0.392578,0.333124,-0.442954,0.0861682,0.135209,-0.886534,-0.307246,0.139746,0.236215,0.576706,-0.0683856,-0.305871,0.293874,0.572165,0.0549143,-0.013183,-0.621524,0.30161,0.0168192,-0.0103148,-0.386433,-0.154131,-0.372007,-0.15786,0.336775,0.162328,0.162523,0.112761,-0.157799,-0.0993366,-0.194207,-0.406193,-0.572496,1.04539,-0.556005,0.0510787,-0.633812,0.397271,0.235288,-0.296652,-0.0185038,-0.0857771,0.335788,-1.1999,-0.334562,0.121645,0.00180332,0.0814391,-0.0206306,-0.222362,-0.619632,0.439511,0.442499,-0.330457,0.0339474,1.12819,0.333491,0.526066,0.311178,-0.458675,0.117074,0.580277,0.929808,-0.397983,-0.0719605,-0.529744,0.0193916,0.107295,-0.243115,-0.0398853,-0.0323142,-0.708209,-0.0399086,0.154975,0.203289,0.104048,-0.177339,-0.0523632,-0.283387,0.990796,0.157584,-0.165407,0.298843,0.50503,-0.234575,-0.287926,-0.312152,-0.3173,0.556742,-0.203453,-0.167154,0.296062,0.222784,-0.483733,0.314682,-0.319979,-0.0844506,-0.743,-0.756786,-0.286574,0.19607,-0.216535,0.219648,-0.138919,0.211168,-0.552408,-0.8338,1.25686,-0.0905299,0.301149,-0.334251,-0.0600896,-0.155221,-0.0489809,0.166177,0.467358,-0.553431,-0.0402171,-0.103387,-0.0458355,0.130452,-0.479483,-0.786566,0.375494,-0.351892,-0.0398302,-0.896031,-0.239924,-0.599865,-0.294208,-0.566274,-0.0462288,0.00132772,-0.247079,-0.116955,0.874955,-0.598944,0.262161,0.755075,0.557996,0.388476,-0.185107,-0.437952,-0.490141,0.561581,0.565833,0.446797,0.530506,-0.387252,-0.607829,-0.438773,-0.0365322,-0.0518246,-0.190619,-0.139143,0.507734,-0.684726,0.0301231,0.172332,0.0940179,0.293851,0.600402,0.138958,0.222068,0.571696,0.0111279,0.303471,-0.515593,-0.408613,0.191476,0.316852,-1.30163,0.0830955,0.451801,0.377013,0.530017,0.047575,-0.271371,0.568128,-0.0269216,-1.7496e-05,0.43432,-0.302485,0.573807,0.120934,-0.577126,-0.271076,0.376899,0.131418,0.101477,0.0904716,-0.572982,-0.269483,-0.404145,0.287574,-0.470772,-0.115261,0.725719,-0.145014,0.487039,0.770205,0.18043,0.143835,0.424771,0.379256,-1.64747 +3405.39,0.969081,0.0912059,4,1.51659,0.887713,-1.09638,0.479,0.849216,-0.143989,0.291438,-0.0305054,0.382111,0.120132,0.306631,-0.153579,0.198376,0.2247,0.091307,0.656719,0.175392,-0.176281,0.107584,-0.238085,0.0768878,-1.04576,-0.458788,-0.0335163,-0.304935,-0.067947,0.324289,0.03134,-0.209497,0.463432,0.40424,-0.161914,0.0987003,0.00384722,-0.443513,-0.198714,0.0984072,0.0884394,0.172045,-0.216781,1.0645,0.543678,-0.066892,-0.733117,-0.126829,0.130588,-0.238704,0.221084,0.237257,0.346111,0.264586,0.197921,0.195106,-0.0896336,0.369886,-0.165329,-0.294218,-0.482461,0.280346,-0.245793,0.114249,0.485494,-0.804514,-0.546485,-0.0302187,-0.506252,0.477916,-0.0605917,0.206655,-0.639215,-0.107825,0.0882014,0.755332,-0.428073,0.625142,0.357641,0.704489,-0.264704,0.0530745,0.0736678,0.759132,-1.28798,0.210589,0.0746677,-0.109156,0.0382936,-0.0241898,0.132761,0.14783,0.194452,-0.38384,0.099671,-0.146306,-0.240513,0.0701599,-0.785821,0.482742,-0.729245,-0.115579,0.153543,0.114846,0.206553,-0.359359,0.456119,-0.00615635,-0.447621,-0.0965793,-0.103184,-0.220306,0.672818,-0.112943,-0.134114,0.503438,0.550504,-0.27627,-0.225338,-0.322944,0.147834,-0.0744123,-0.0425532,-0.239791,-0.157176,-0.215468,0.17207,0.265117,0.194864,0.589638,0.41675,-0.161852,0.144736,-0.4955,-0.342391,-0.646092,0.675157,-0.661865,-0.218885,-0.578917,0.333252,0.216596,-0.14999,0.322109,0.045603,0.459886,-0.990947,-0.311368,0.344724,-0.291761,0.135648,-0.129012,-0.483778,-0.346163,0.123875,0.627434,-0.101022,0.106475,1.20958,0.351649,0.585545,0.270865,-0.749273,-0.0506731,0.533223,0.705241,-0.549672,-0.257501,-0.293616,-0.129529,0.241982,-0.421234,0.337652,-0.2025,-0.771103,0.0442591,0.377322,0.151335,0.253773,-0.680784,-0.0937247,-0.106505,0.977239,0.16199,-0.329718,0.355186,0.392092,-0.373231,-0.53616,-0.173101,-0.129555,0.656767,-0.417994,-0.119437,0.122115,-0.267748,-0.422229,0.521532,-0.423361,-0.110226,-0.374309,-0.814003,-0.275387,0.074491,-0.332528,0.258292,-0.25266,-0.0242713,-0.27214,-0.997264,1.32271,-0.548333,-0.0773457,0.0295997,-0.0698199,0.0360657,-0.150884,0.0376873,0.511143,-0.893235,0.00938457,0.213731,-0.151208,0.210817,-0.763225,-0.5387,0.28638,-0.841496,-0.062632,-0.722562,-0.231956,-0.479093,-0.200444,-0.634272,-0.0663717,-0.226906,-0.00794458,0.0404609,0.656485,-0.496637,0.422464,0.797579,0.28718,0.36087,0.0459945,-0.221406,-0.674667,0.707788,0.54023,0.308608,0.466245,-0.427712,-0.583672,-0.356777,-0.498491,0.228581,0.0424395,-0.361338,0.553777,-0.611427,-0.172123,0.204696,0.237637,0.448335,0.179066,-0.14516,0.412198,0.493972,-0.121257,0.316439,-0.524764,-0.467664,0.248728,0.163289,-1.0215,-0.433191,0.229951,0.582216,0.450286,-0.235964,-0.521502,0.755099,-0.114944,0.0297972,0.0482819,-0.0939484,0.175993,0.105103,-0.619481,-0.356102,0.693321,0.289192,-0.0108908,0.222278,-0.305121,-0.0492287,-0.262757,0.170223,-0.353191,0.0172498,0.537325,0.145654,0.49386,0.545942,0.189482,0.156827,0.435295,0.396014,-2.71428 +3398.81,0.992768,0.0912059,4,1.50241,0.986931,-0.964186,0.324329,0.856576,-0.0746395,0.0519045,-0.262737,0.3466,0.00619338,0.426823,-0.244535,0.269102,0.305227,0.264792,0.652268,0.266587,-0.24119,-0.0519915,-0.357589,0.0113941,-0.889406,-0.485217,-0.0355812,-0.389401,0.0950339,0.390087,0.314519,-0.246294,0.32276,0.472418,-0.138102,-0.160218,0.117314,-0.297206,-0.30087,-0.0215226,0.0765958,0.189154,-0.303494,1.05933,0.610736,-0.0616453,-0.691836,0.0465316,-0.173981,-0.189407,0.484216,0.12625,0.370118,0.300866,0.206941,0.124425,-0.191438,0.409927,-0.255991,-0.0820297,-0.324064,0.414858,-0.103343,0.270374,0.662993,-0.884205,-0.382615,0.217214,-0.305949,0.115745,-0.229295,0.208196,-0.536484,-0.083473,-0.0364975,0.616159,-0.367624,0.773583,0.407843,0.868146,-0.120926,-0.0531627,0.0447729,0.832013,-1.07162,0.23857,-0.00701619,-0.159514,0.0126051,0.163402,0.187705,0.15073,0.135622,-0.420731,0.209384,-0.105744,-0.0647767,0.0462581,-0.64654,0.765584,-0.507287,0.0243753,0.102811,0.417983,0.409386,-0.160256,-0.0110702,-0.335306,-0.562838,-0.227589,-0.293368,-0.0538573,0.523051,0.134668,0.0515435,0.516198,0.625418,-0.436295,-0.303679,-0.327025,-0.000488159,0.0209992,0.0869087,-0.369369,-0.154261,-0.460507,0.0977323,0.145885,0.371987,0.346765,0.462486,-0.108984,-0.213562,-0.462508,-0.255096,-0.798847,0.458804,-0.745907,-0.502045,-0.640776,0.438179,0.305377,-0.116233,0.373315,0.160841,0.541344,-0.946482,-0.383448,0.268408,-0.0507388,0.120853,-0.160991,-0.596453,-0.287993,0.171808,0.652686,-0.101323,0.180625,1.05795,0.10381,0.482145,0.324439,-0.779613,-0.0143166,0.427082,0.518689,-0.620938,-0.200932,0.0651175,-0.210064,0.214375,-0.59771,0.360812,-0.142993,-0.915274,0.212067,0.761816,0.194209,0.195435,-0.595201,-0.0337602,0.0866527,1.07889,0.396959,-0.40647,0.167973,0.235451,-0.18252,-0.6005,-0.0628139,-0.0813187,0.646026,-0.565646,-0.103922,0.0969205,-0.295632,-0.140569,0.696107,-0.315539,0.163378,-0.595783,-0.671893,-0.297419,0.136965,-0.288757,0.123504,-0.189954,0.258615,-0.182411,-1.02692,1.17775,-0.646025,0.147202,0.224715,-0.017887,-0.325736,0.0467428,0.0927389,0.584222,-0.988194,0.0437393,-0.111277,-0.263121,0.236421,-0.736871,-0.507369,0.345429,-0.877131,0.1613,-0.898487,-0.397202,-0.275533,-0.245532,-0.742215,0.110405,-0.174862,-0.198963,0.117976,0.730716,-0.683311,0.419654,0.760054,0.155657,0.273759,-0.129635,-0.313185,-0.617862,0.680151,0.50927,0.234733,0.605965,-0.398224,-0.686552,-0.267847,-0.390776,0.334942,0.023471,-0.298377,0.470127,-0.400677,-0.0296788,0.0448286,0.222085,0.593426,0.422955,-0.0322934,0.263939,0.627905,-0.311802,0.24955,-0.417786,-0.350968,0.503509,0.31491,-0.742622,-0.104214,0.0842468,0.670744,0.447011,-0.051261,-0.406515,0.635415,-0.0995821,0.107945,0.195341,-0.252107,0.159176,-0.24072,-0.487117,-0.53834,0.594879,0.416034,0.0178601,0.329478,-0.196311,-0.0706934,-0.52185,0.0496428,-0.618228,-0.135189,0.645166,0.210837,0.428852,0.172925,0.161709,0.140254,0.402131,0.374505,-2.86841 +3401.98,0.697019,0.0912059,4,1.55305,0.863317,-1.05109,0.42194,0.750063,-0.096147,-0.0389064,-0.0744452,0.255238,-0.337825,0.342094,-0.259269,0.202991,0.522437,0.137138,0.794694,0.334986,-0.232718,0.438253,-0.58355,0.107832,-0.581225,-0.559888,0.102043,-0.28513,0.106776,0.521366,0.688952,-0.0828162,0.495768,0.569796,-0.503848,-0.0699265,0.332575,-0.370628,-0.47285,0.18501,0.277077,0.14089,-0.154195,0.871909,0.770832,0.198933,-0.833265,0.151798,0.277053,-0.234453,0.0977562,0.153885,0.131635,0.259784,0.0880485,0.202513,-0.011522,0.326214,-0.208995,0.0213544,-0.601547,0.361332,-0.123452,-0.0173775,0.83238,-0.875799,-0.38186,0.441321,-0.163697,0.156728,-0.100616,0.154829,-0.647777,-0.0308709,-0.0456864,0.684643,-0.0151716,0.928531,0.356974,0.425473,-0.0829084,-0.0597157,-0.0193119,0.788016,-1.1009,0.243898,-0.0683933,-0.177801,0.203883,0.108072,0.191471,0.0338831,0.184752,-0.199459,0.626692,-0.219613,-0.0321717,0.142044,-0.504072,0.455927,-0.230076,0.0357681,0.175074,-0.0349403,0.0854397,-0.34093,0.0144075,-0.383127,-0.718119,-0.178409,0.165675,0.170334,0.390861,0.144676,0.139919,0.270116,0.582369,-0.443012,-0.204161,-0.426478,0.0937824,0.01981,0.116225,-0.307466,-0.035886,-0.417234,0.0845468,-0.113569,0.699941,0.390784,0.227598,0.110891,-0.308718,-0.624013,-0.172362,-0.535079,0.616893,-0.675106,-0.708702,-0.356326,0.271717,0.274552,-0.377189,0.321391,0.0191281,0.307344,-0.959695,-0.460723,0.0988339,0.0126672,0.236067,0.126867,-0.654319,-0.262395,-0.0767592,0.736637,-0.316247,0.556397,0.919405,0.42762,0.10491,0.0173627,-0.425213,0.358184,0.24777,0.57775,-0.476786,-0.237709,-0.00474491,-0.425327,-0.0572905,-0.392534,0.425529,0.0328571,-0.923772,0.272976,0.778798,0.111016,0.159568,-0.628914,-0.0112461,0.356664,0.76352,0.287194,-0.234438,0.322478,0.230937,-0.204401,-0.424136,-0.0136785,0.0526914,0.600471,-0.808934,-0.306834,-0.130291,-0.0958761,-0.240346,0.559945,-0.396711,0.162923,-0.509298,-0.844448,-0.386058,0.468271,-0.378661,0.0185585,-0.300971,0.040408,-0.900584,-0.636537,1.28008,-0.683161,0.411945,0.0748568,-0.21758,-0.479676,-0.046449,0.255847,0.758855,-0.976338,0.17476,-0.274042,-0.301473,0.0167255,-0.836339,-0.0507509,0.0866458,-0.77992,0.316345,-0.454613,-0.420114,-0.291957,-0.284527,-0.407049,0.149462,-0.32808,0.294552,0.000858158,0.695323,-0.562467,0.55709,0.717173,0.174173,-0.0210924,-0.175131,0.318869,-0.54608,0.410758,0.927932,0.187815,0.792004,-0.31974,-0.652396,-0.391406,-0.235419,0.322369,-0.0200806,-0.0759917,0.492336,-0.166593,-0.103864,-0.240461,0.0205085,0.0560667,0.450724,0.066892,0.337964,0.681179,0.0145702,0.407848,0.13627,0.145207,0.363596,0.0925955,-0.642269,-0.139151,-0.0236897,0.625188,-0.0106349,0.126937,-0.381204,0.498392,-0.141683,0.151666,-0.337922,-0.122194,0.268542,-0.327773,-0.657355,-0.605379,0.280882,0.3449,-0.121083,0.527773,-0.245738,0.0313475,-0.125287,-0.0249153,-0.769133,0.234747,0.318222,0.400687,0.274194,0.247629,0.169089,0.133336,0.411205,0.365153,-2.28716 +3395.65,0.827285,0.0912059,4,1.57905,0.783234,-0.917047,0.395422,0.915729,-0.0970325,0.0203804,0.0997297,0.428364,0.0582112,0.23202,-0.295836,0.227789,0.364884,0.17236,0.75887,0.319821,-0.290719,0.699425,-0.373299,-0.0845796,-0.901817,-0.739231,0.188255,-0.218589,0.218821,0.528131,0.350838,-0.136882,0.479171,0.489741,-0.551524,-0.0644232,0.305487,-0.353175,-0.487034,0.22409,0.412314,0.203321,-0.206398,0.87601,0.771815,0.188399,-0.749135,0.135127,0.162905,-0.176678,0.144535,0.164379,0.239236,0.189682,0.036371,0.185792,0.0416035,0.387204,-0.363376,-0.0868815,-0.465292,0.338035,-0.0402833,-0.0983592,0.687992,-0.790006,-0.314405,0.296374,-0.00128656,0.122683,-0.221724,0.281643,-0.647703,-0.0744634,-0.0705043,0.731866,-0.105201,0.986191,0.294697,0.403952,-0.18099,0.0283512,0.000862418,0.865255,-1.37629,0.215561,-0.00207608,-0.161547,0.0562062,-0.0142924,-0.0540808,0.106998,0.22715,-0.471783,0.653088,0.0493174,-0.169525,0.0088005,-0.151272,0.523048,-0.166834,0.00659699,0.364847,0.165116,0.159383,-0.350403,-0.0626718,-0.216995,-0.789586,-0.200628,0.00888716,0.0813379,0.298654,0.325929,-0.0602975,0.3941,0.629643,-0.405521,-0.213771,-0.198977,0.23354,0.123031,-0.00372468,-0.218112,-0.332897,-0.191652,-0.087835,-0.0771963,0.732378,0.270733,0.449571,0.288115,-0.369043,-0.713931,-0.258932,-0.501228,0.605901,-0.462933,-0.550426,-0.383816,0.348339,0.250699,-0.527246,0.0250927,0.0690577,0.296407,-0.956293,-0.616132,0.247902,-0.164777,0.170901,0.309129,-0.432149,-0.149785,-0.068875,0.712051,-0.239958,0.651713,0.936547,0.277291,-0.0358584,0.128413,-0.346788,0.563531,0.247404,0.691675,-0.690686,-0.0906957,-0.21412,-0.469967,-0.247008,-0.244147,0.167899,0.070167,-0.958458,0.264072,0.432086,-0.0757173,0.0488391,-0.654727,0.0199079,0.314005,0.776802,0.185518,-0.0318459,0.329976,0.0783009,-0.130173,-0.499251,0.134859,0.000170315,0.713189,-0.860029,-0.328193,-0.398815,-0.419823,-0.278384,0.713395,-0.41388,0.250265,-0.652025,-0.939116,-0.405849,0.49165,-0.365282,0.124623,-0.271908,-0.0303729,-0.903368,-0.686328,1.12564,-0.710172,0.175577,0.138146,-0.183141,-0.484701,-0.231072,0.148326,0.651158,-1.02399,0.413535,-0.0564054,-0.355836,0.129869,-0.861192,0.129352,0.0896607,-0.794133,0.439952,-0.356641,-0.396963,-0.235308,-0.135703,-0.388245,0.208729,-0.163811,0.411503,-0.0962491,0.651159,-0.786712,0.688699,0.67725,0.209087,-0.0362104,-0.137634,0.335718,-0.458308,0.54792,0.904233,-0.0124323,0.660658,-0.354251,-0.842415,-0.344475,-0.154025,0.359089,-0.132436,-0.398046,0.507197,-0.250484,-0.192531,-0.365692,0.157335,0.0570186,0.393645,0.25093,0.287276,0.797274,0.137637,0.269766,-0.0135381,0.147361,0.387091,0.0886394,-0.706317,-0.264183,-0.00266969,0.365815,-0.0756576,0.0974381,-0.18062,0.468326,0.0217595,-0.0546289,-0.337269,0.0592185,0.3415,-0.185197,-0.707794,-0.529147,0.370937,0.201898,-0.129247,0.35399,-0.381248,0.118334,-0.0827084,0.00485932,-0.744702,0.390593,0.19724,0.0849379,0.294363,0.0719876,0.14439,0.125084,0.379986,0.353672,-2.7146 +3386,0.804174,0.0912059,4,1.51842,0.993865,-1.03278,0.264015,0.934467,-0.109894,-0.382671,-0.113434,0.186544,-0.714339,0.369878,-0.605146,0.315432,0.409351,0.13607,-0.0781799,-0.159616,0.117583,0.127594,-0.528404,-0.0200888,-1.01703,-0.558822,-0.378269,-0.112021,0.113664,-0.0203285,0.624908,-0.114568,0.0813527,0.423744,-0.157694,0.0758988,0.290372,-0.320998,0.276343,-0.0590229,-0.163795,0.487045,0.086932,0.870003,0.498506,0.234694,-0.386492,-0.338574,-0.0180616,-0.475512,0.675247,0.589543,0.146513,0.130813,0.398823,0.0803339,-0.227545,0.593927,-0.0057203,-0.00256505,-0.658782,0.455443,-0.414131,-0.489411,0.90766,0.105023,-1.06888,0.129912,0.257505,-0.158803,0.268836,0.602479,-0.372393,-0.178683,0.107332,0.330663,-0.468551,0.86333,0.283304,0.203268,-0.412937,0.188149,-0.236051,0.962235,-0.0667785,0.29128,-0.251919,-0.691319,-0.076732,0.103571,-0.341442,0.150698,-0.305674,0.155541,-0.282975,-0.43133,0.369961,0.457534,0.0155848,-0.245535,-0.235979,0.0214072,0.195639,0.160532,-0.0984354,0.307597,0.0894145,0.779023,-0.4236,-0.390684,-0.19418,0.602083,0.31976,0.274145,-0.069349,-0.256903,0.538189,0.500731,-0.281397,0.637242,0.317154,-0.49983,0.136465,-0.561976,0.064005,0.0766827,0.190731,0.31686,-0.0885182,-0.364995,0.625869,-0.188643,-0.116589,0.0166446,-0.0785579,-0.73765,1.26881,-0.390326,-0.4856,-0.622823,0.443108,-0.0195108,-0.251375,-0.340434,0.198086,-0.446105,-0.961017,0.452359,-0.287409,-0.0688659,0.341078,-0.11686,-0.0641383,-0.416655,0.0799787,0.0140868,-0.0998901,0.197641,0.206298,-0.100268,-0.124222,-0.181105,-0.00610749,0.333763,-0.217099,0.918002,0.0495783,-0.645373,-0.395696,0.255391,0.0217005,0.0298,-0.301221,-0.211727,-0.619862,0.0882987,-0.0689091,0.23674,-0.325571,-0.465871,0.295981,0.47822,0.869915,-0.243919,-1.18637,-0.0164039,0.257443,0.464672,-0.599544,-0.131174,-0.608414,0.376954,-0.278874,-0.21313,-0.0873953,0.26056,-0.398443,0.246044,0.107522,0.405459,-0.206783,-0.466409,0.162014,0.334043,-0.233634,-0.139873,0.164308,-0.0185246,0.00287279,-0.923046,1.06162,-0.504827,0.164785,0.098756,-0.467214,-0.0305428,-0.38946,0.737231,0.449942,-0.0640203,0.314717,-0.0367425,-0.690304,0.0576345,-0.816281,0.234719,0.191409,-0.763455,0.30943,-0.72585,-0.362532,0.824809,0.225117,-1.00076,0.325058,-0.435974,-0.495299,-0.180456,0.55997,-0.156649,0.246014,0.86292,0.330318,-0.101621,0.326267,0.458623,-0.0425447,0.454342,0.220167,-0.117856,0.397804,-0.692278,-0.307396,-0.236734,0.113453,0.489668,0.199921,0.166744,0.452271,-0.209647,0.318344,0.095313,0.221621,0.111148,-0.0835711,-0.0836919,-0.149808,0.114655,0.0862675,0.332693,0.0274146,0.56977,0.145998,0.872571,0.0908594,0.245455,0.532976,-0.195873,-0.0555372,-0.000534539,-0.56685,0.440053,0.330245,0.365606,-1.01673,-0.155106,-0.272673,-0.157868,-0.152775,0.0491807,0.273832,0.283908,-0.398099,-0.0106505,0.00944006,-0.0558332,0.275876,-0.0768005,0.28012,-0.12882,-0.216559,0.143457,-0.243865,0.221621,0.189986,0.197839,0.435874,0.444791,-3.02118 +3419.57,1,0.0912059,5,1.51278,0.928508,-1.34149,0.488306,0.408383,-0.233809,0.220206,0.440494,0.568231,0.258511,-0.0618245,0.314717,-0.260868,0.343596,-0.407012,0.717688,0.101152,-0.568594,0.184204,-0.142221,-0.168894,-0.890258,-0.925037,0.22348,-0.0819964,0.487069,0.120066,-0.0625225,-0.149951,0.25277,0.953664,-0.947733,-0.0675655,0.558105,-0.245131,-0.57375,-0.185118,0.547247,0.427656,-0.489106,1.38829,0.428826,0.558383,-0.44869,0.35118,0.514248,-0.493583,0.345218,-0.00145708,0.0116454,0.0345883,0.516566,0.0690443,0.519533,0.784205,-0.0516771,0.17733,-1.06835,0.317182,-0.36079,0.857709,1.01239,-0.605887,-0.718926,0.0134375,-0.243228,-0.398719,-0.141594,0.390989,-0.780509,-0.2038,0.166748,0.67868,-0.361722,0.737004,0.612162,0.550126,-0.285528,-0.211951,0.219985,0.0853426,-0.712364,0.120197,-0.669464,0.083768,-0.434247,-0.015578,-0.419191,-0.182048,-0.470097,0.149536,0.0258543,0.0376676,-0.0363156,-0.212369,-0.523287,0.178303,-0.601701,0.208441,-0.104337,-0.183802,-0.151131,-1.01266,-0.734575,-0.834588,-0.50853,0.120219,0.0491531,0.203026,0.651978,-0.342661,-0.0768364,-0.244071,0.0405585,-0.503061,0.135996,-1.02992,-0.124267,0.147915,-0.163941,-0.726531,-0.400469,-0.162816,-0.850779,-0.337766,0.0741293,0.102484,-0.279066,0.296897,-0.846516,-0.340556,-0.0941333,0.40977,0.381837,-0.0307541,0.0407696,0.16641,-0.264575,0.695706,-0.219242,-0.301456,-0.193671,-0.0287575,-0.831452,-0.410773,0.687577,-0.608293,0.137698,-0.254877,-0.153603,-0.0991341,-0.164871,0.393061,0.141558,0.182486,1.17794,0.724258,0.193337,-0.352741,-0.128443,-0.249552,0.0677768,0.413688,0.0717156,0.34782,0.198413,-0.234633,0.0362349,-0.162814,-0.0390555,0.277077,-0.0785876,-0.649971,-0.184042,-0.933227,0.388809,-0.268918,-0.183931,0.0788065,0.515161,-0.439588,0.497852,0.312088,0.0965743,-0.605711,-0.499324,-0.176054,-0.289243,-0.0488967,-0.49472,0.215477,-0.139712,-0.0181359,-0.44926,0.3557,-0.152973,0.253638,-0.645511,-0.296369,0.40672,-0.339645,-0.42549,-0.134972,-0.5474,-0.409362,-0.363137,-0.319628,0.592222,0.133757,0.362301,-0.25248,0.064903,0.219909,0.122389,-0.265745,0.438282,-0.25831,-0.620572,0.16902,-0.315083,-0.0841754,-0.523605,-0.504182,0.296125,-0.764566,0.601277,-0.184809,-0.127923,-0.0186611,-0.0816943,-0.346173,-0.56107,-0.199045,0.0196318,0.103491,0.432848,0.2915,-0.391219,0.207031,-0.818528,0.0423753,-0.468293,-0.267896,-0.182703,0.324004,0.292008,0.613832,-0.259425,-0.093407,-0.324,0.137844,-0.528695,0.416206,-0.255795,-0.528366,0.527579,-0.318626,0.0229545,-0.168579,-0.0601284,0.156099,-0.00305525,0.401,0.593141,-0.195151,-0.381525,-0.383975,-0.0602917,-0.248543,-0.260754,-0.560784,-0.327962,-0.431535,-0.133972,0.314157,0.119584,-0.281404,0.421654,0.401164,-0.0707717,-0.436699,0.474511,-0.320927,-0.12503,0.416166,0.563059,-0.124904,-0.072014,0.210131,0.0228538,-0.414088,-0.0229228,0.072148,0.346281,0.107146,-0.658742,-0.134792,-0.162777,-0.954931,0.139427,-0.211426,0.153356,0.338478,0.391606,0.581789,-1.18432 +3405,0.995703,0.0912059,4,1.56984,0.857401,-1.09313,0.408464,0.730223,-0.118964,0.544032,0.505554,0.680133,0.226135,-0.023896,0.230717,0.215476,0.278354,-0.554331,0.432835,0.0371261,-0.458188,0.22503,-0.165543,-0.274003,-0.7979,-1.023,0.387236,-0.016607,0.252592,0.152459,-0.286666,0.123162,0.413588,1.08664,-0.561366,-0.0289265,0.380723,-0.0785017,-0.484236,-0.0887775,0.477392,0.402038,-0.158476,1.30137,0.420041,0.49783,-0.412996,0.186529,0.327475,-0.538315,0.218856,0.0794462,0.0685296,0.0049024,0.11373,0.126773,0.106198,1.11767,-0.268472,-0.00894646,-1.32634,0.432259,-0.285291,0.676827,1.47831,-0.350834,-0.886478,0.0523877,-0.155448,-0.303304,0.0313608,0.788856,-0.506142,-0.538014,0.335297,0.402545,-0.120832,0.950883,0.453565,0.647383,-0.595949,-0.494077,-0.0207667,0.409684,-0.606408,0.0139292,-0.811863,-0.452482,-0.494872,0.131703,-0.946243,-0.0969162,-0.39834,0.178098,-0.17995,-0.11228,-0.328191,-0.437985,-0.51166,0.212442,-0.365084,0.369241,-0.0874711,-0.267316,-0.0512968,-0.744227,-0.516928,-0.477056,-0.626907,0.443297,0.100792,-0.0344301,0.550268,-0.0383038,0.1084,-0.361056,-0.128927,-0.192893,-0.336185,-0.81529,-0.0454679,0.191002,-0.139253,-1.20187,-0.294826,-0.799013,-0.662508,-0.198457,-0.196983,0.364745,-0.326502,0.244553,-0.8441,-0.537794,0.279032,0.269005,0.340766,0.0708546,-0.146559,0.146065,-0.211005,0.649861,-0.435595,-0.172552,-0.121765,-0.317297,-0.40988,-0.442039,0.536888,-0.68061,0.183355,-0.235475,-0.418697,0.312033,-0.0251517,0.273755,-0.233747,0.320528,0.836008,0.486178,0.225678,-0.33669,-0.0691571,-0.307542,0.322212,0.458789,0.219888,0.0799737,0.441787,-0.332436,-0.0776596,-0.0788923,0.0630109,0.660417,0.120641,-0.706769,-0.0181438,-0.821669,0.600177,-0.165741,-0.427496,0.347762,0.570252,-0.0510236,0.447704,0.140763,0.340736,-0.589421,-0.749321,0.349966,-0.308389,-0.61008,-0.252619,0.0857371,-0.453333,0.0520508,-0.285694,0.314698,-0.00480937,0.182235,-0.720895,-0.359515,0.199273,0.00709606,-0.363402,-0.245016,-0.386753,-0.0487897,-0.0171473,-0.471342,0.696944,0.328669,0.233594,-0.392068,-0.310203,0.0508195,0.0722193,0.186688,0.316851,-0.41953,-0.30364,0.142175,-0.282454,-0.14836,-0.525059,-0.418112,-0.0101491,-0.50989,0.63742,-0.184167,-0.00575407,0.21393,-0.110746,-0.766276,-0.791885,-0.096339,0.00640811,0.308773,0.104652,0.361224,-0.511145,0.29796,-0.777424,-0.259443,-0.384701,-0.0506973,-0.412927,0.410081,0.268934,0.787642,-0.217997,-0.0899231,-0.308748,0.121474,-0.626902,0.484267,-0.17739,-0.526733,0.217899,-0.382552,0.0734365,-0.264416,-0.105626,0.120906,-0.100111,0.282106,0.440761,-0.239653,-0.360919,-0.451227,-0.142846,-0.225888,-0.24069,-0.363917,-0.347623,-0.353496,-0.306826,0.419133,-0.00339731,-0.376274,0.526359,0.171159,-0.0312077,-0.30139,0.366143,-0.596689,-0.105102,0.382514,0.437935,-0.0555425,-0.18103,0.328696,-0.155064,-0.315605,0.286856,0.174335,0.181719,-0.0613617,-0.630204,-0.395546,0.120827,-0.773373,0.266734,-0.398563,0.171098,0.230019,0.41364,0.479603,-2.15346 +3400.68,0.93214,0.0912059,4,1.48043,0.901541,-1.13256,0.538521,0.902604,-0.115845,-0.170706,0.0201868,0.267934,0.164659,0.166048,0.455642,-0.0487218,0.0989684,-0.0845655,1.23921,-0.00908163,-0.0257352,0.292192,-0.081251,-0.371225,-0.962781,-0.615208,0.37007,-0.205827,0.187542,0.296459,0.687268,0.409842,0.448743,0.760798,-0.874569,-0.243447,0.696426,-0.163255,0.347476,-0.223829,0.788264,0.326596,-0.613614,1.05322,0.37325,-0.11143,-0.475981,0.0141583,0.0102057,0.437579,-0.326885,0.215063,-0.187024,0.266439,0.740871,-0.214987,-0.299178,0.844629,-0.224322,-0.116511,-1.07691,0.401938,-0.270802,0.478811,0.684019,0.0679227,-0.679232,0.126456,-0.0800371,-0.275861,0.177904,-0.542997,-0.272546,-0.0817973,0.0917024,0.821502,0.257693,0.192253,0.421769,0.50755,-0.343259,-0.0332814,0.875924,0.642061,0.221978,0.0975516,-0.171887,0.278184,-0.123402,0.168272,-0.612166,-0.250096,-0.514912,0.00481081,0.514794,-0.337567,-0.178046,0.101815,-0.825094,0.37432,-0.0777254,0.147609,-0.0246039,0.0043648,0.811759,-0.270259,-0.15765,0.383784,-0.766087,0.11021,-0.322656,0.515247,0.110301,0.0733608,-0.620349,0.0531281,-0.260023,0.0983346,-0.274258,-0.36829,0.0120395,0.290398,-0.0649471,-0.947005,0.211875,-0.90288,0.396796,0.260494,0.210366,-0.404719,-0.0853531,0.320818,-0.44729,0.302034,-0.174935,0.383078,0.737826,-0.0781209,0.68174,-0.303015,0.0259431,0.504296,0.0290918,0.443333,-0.172631,0.00431635,-0.0349108,-0.399131,0.289222,-0.36546,0.124119,-0.121952,-0.328394,-0.0245915,0.362316,-0.0234738,-0.116849,0.738821,0.116153,-0.0564249,0.416652,0.176367,-0.0696478,-0.4657,-0.557545,0.585276,0.201803,-0.426956,0.164213,0.343111,0.503987,-0.23017,-0.0629307,-0.263266,0.858617,-0.549315,0.0632874,0.189247,0.206463,-0.318411,-0.0835038,-0.274836,0.697118,0.320755,0.120715,0.551371,-0.340698,0.201731,-0.922231,0.0698816,-0.378392,-0.153909,-0.241628,0.0822814,0.561429,0.0409077,-0.437827,0.059326,0.484552,0.490762,0.0322337,-0.586122,0.000517015,0.112336,-0.468566,-0.109103,-0.00112767,-0.181465,-0.691307,-0.0359889,0.996088,0.226348,0.381871,-0.192734,-0.205737,0.19467,0.0657971,-0.0644028,0.400309,-0.170138,-0.0381609,0.481173,-0.28974,-0.223114,-0.417925,-0.108611,-0.0602633,-0.0482895,0.562937,-0.126332,-0.651984,0.374137,-0.0161047,-0.281785,-0.294095,0.0945383,-0.649591,0.365483,0.379343,-0.0997676,0.19025,0.206159,-0.465903,-0.338111,0.160521,0.378255,-0.109091,-0.481501,-0.279232,0.121896,-0.0224835,-0.156339,-0.149427,0.0439229,-0.57914,0.590971,-0.0415671,-0.65482,0.26885,-0.132353,0.0379193,0.803853,-0.0985037,-0.291468,0.353486,0.30895,0.138356,-0.0941393,-0.192401,-0.0596465,-0.278894,0.439701,-0.242366,-0.407057,-0.48421,-0.0426297,-0.261797,0.0475135,0.438596,0.0795374,0.339633,0.238968,-0.344477,-0.221916,-0.0946742,-0.236737,0.443221,-0.0245374,0.00229676,-0.43049,0.464936,-0.0325509,-0.100396,-0.703816,0.651899,0.549933,-0.227845,-0.00932978,0.207865,-0.202276,-0.0802084,-0.348679,-0.0960634,0.146125,0.118504,0.261147,0.344244,0.511026,-2.99659 +3385.84,0.982365,0.0912059,4,1.57473,1.07863,0.160595,-0.157032,0.619661,-0.0941102,0.256486,0.496427,0.963407,0.675169,-0.405315,-0.4701,0.0957744,0.135198,-0.301048,1.23665,0.304847,-0.459035,0.155471,0.267556,-0.240632,-0.507228,-0.698318,-0.00287643,0.144141,-0.294037,0.0733535,1.01324,-0.594835,0.524339,0.804536,-0.464862,0.583416,0.534104,-0.0470485,-0.972348,-0.248393,0.0128661,0.470889,-0.0701621,0.94624,0.334565,0.0923106,-1.10979,-0.279636,-0.185278,-1.1026,-0.0800801,0.5184,-0.197622,-0.243926,-0.28777,0.212906,-0.533645,1.33063,-0.456336,-0.337095,-0.500006,0.697946,-0.68486,-0.194786,0.377074,-1.5176,-1.0233,-0.0949206,0.474021,0.100487,0.01931,0.606714,-0.302684,0.104914,0.43446,0.43552,-0.365272,0.302612,0.213278,0.800495,0.162739,-0.312583,-0.839166,-0.021859,-0.28508,0.170339,-0.33648,-0.262843,-0.339315,-0.73738,0.124344,0.0488158,-0.324958,0.203532,-0.193672,-0.0449943,0.105102,0.171957,-0.184385,-0.219177,-0.53792,0.117818,0.43932,0.112022,-0.482647,-0.36262,-0.162218,0.511194,0.193701,0.731077,0.150477,0.437176,0.890576,-0.366432,0.439874,-0.210805,0.232099,0.0611187,0.233654,-0.293823,-0.0303853,-0.259211,-0.0775827,0.222242,-0.156762,0.275229,-0.596966,-0.0512035,0.185062,0.551897,0.339136,0.172048,-0.163171,-0.19221,0.199782,-0.124721,-0.29687,-0.237018,-0.171623,-0.127426,-0.286044,0.323616,-0.61109,-1.55771,0.0134632,-0.0340976,-0.364527,0.286802,-0.58044,0.445209,-0.143602,-0.290426,0.82294,-0.0304426,-0.455283,0.297907,0.389698,-0.1901,0.262878,0.317511,-0.363257,-0.349072,0.176529,0.89584,0.766688,1.02378,-0.462458,0.197034,-0.095375,-0.215822,-0.103413,-0.132591,0.264813,0.508796,-0.540593,-0.439332,-0.186949,-0.0736733,-0.104437,-0.396299,0.394104,0.66916,0.841027,0.208456,-0.359296,-0.44173,0.305802,-0.385537,-0.0286539,-0.61526,-0.00678476,0.0777101,-0.0911271,0.165724,-0.546334,-0.641626,-0.833074,0.595147,-0.189095,-0.486952,-0.349424,-0.374134,-0.0555233,-0.305079,-0.446,0.453539,-0.125654,-0.313898,0.521725,-1.08325,0.578079,0.579239,-0.0624872,-0.14037,-0.162453,0.154077,-0.22919,-0.0450829,0.269531,-0.365862,0.0625526,-0.160645,-0.103748,0.440412,-0.320747,0.190397,-0.1269,-0.369686,0.291103,-0.253729,-0.0985708,-0.0181244,0.060257,0.171766,-0.389293,-0.0535104,0.488706,-0.554166,0.395273,0.421426,-0.795806,0.95281,-0.202603,0.167661,-0.0707352,0.336239,0.231337,0.861195,0.212109,0.803232,0.248312,0.173017,-0.20633,0.339269,-0.843875,-0.051185,-0.127276,0.274747,-0.312618,-0.16323,-0.166812,-0.285496,0.12339,0.152497,0.511668,0.245965,-0.0686412,0.233264,0.0744604,-0.102705,-0.206497,-0.145683,-0.120844,-0.19388,-0.0777962,-0.804729,0.508307,-0.0123622,-0.112787,-0.107601,-0.0625584,0.444672,0.701956,0.195476,-0.726757,-0.353626,0.127723,0.302868,0.535656,0.343268,-0.33653,0.154701,-0.442246,-0.0483375,-0.355855,-0.36605,0.408985,-0.153291,-1.15039,0.211674,0.137335,0.474937,-0.66109,-0.192708,0.170077,0.348187,0.412403,0.590074,-2.30131 +3382.05,0.88816,0.0912059,5,1.47158,1.25034,0.579212,-0.242143,0.665274,-0.0734169,0.334687,0.153287,0.666012,0.661304,-0.217357,-0.205022,0.13006,0.136313,0.0544415,1.95757,0.324357,0.288287,0.569659,0.390945,-0.169832,-0.887707,0.204284,-0.00997509,-0.332448,0.161285,0.447624,0.590235,-0.150199,0.209896,0.81787,-0.417794,0.44192,0.0690819,-0.111194,0.032755,-0.466904,0.455185,-0.220709,-0.121347,1.02766,0.169858,-0.400991,-0.30095,-0.225363,-0.223392,-0.646221,0.0205369,0.205343,0.0364603,0.0286251,0.246571,0.031264,-0.295384,1.14783,-0.281958,-0.237537,-1.03963,0.539574,-0.842408,-0.245064,0.596095,-1.42195,-0.697875,-0.476907,0.38323,0.127593,0.389019,-0.0350165,-0.102973,-0.176893,0.199272,1.01673,0.62549,0.488509,0.123757,0.166399,-0.263385,-0.778352,-0.157642,0.290013,-0.459687,0.116051,0.00298957,-0.0103481,0.116659,-0.352903,0.319497,0.164392,-0.822234,0.303,0.264646,0.441574,0.027,-0.105941,-0.569798,-0.128768,-0.375858,0.0953751,0.111774,-0.120307,-0.451312,-1.01818,-0.523193,-0.0301261,-0.242739,0.599034,-0.234941,0.212722,0.374837,-1.00585,-0.352626,0.284531,0.0475499,-0.123257,0.330899,-0.442996,-0.184531,0.701935,-0.140417,-0.782779,0.459838,0.536742,-0.950921,0.103997,1.38832,0.22386,-0.0014845,0.38133,-0.373866,0.230131,-0.309797,0.135742,0.0393833,-0.177267,-0.00243626,0.127292,-0.387563,0.311004,0.120313,-1.05389,-0.168114,0.0288335,-0.381244,-0.448699,0.0672657,0.553586,0.362415,-0.0857885,-0.543614,-0.264839,0.450869,0.18376,0.473596,-0.216635,1.06918,0.760795,0.428018,0.0809889,0.237158,-0.112612,-0.627621,1.19033,-0.214014,0.340238,-0.508944,0.224676,0.211001,-0.106807,0.809926,0.0597174,-0.0159539,-0.0924254,-0.291137,0.00571522,0.0461812,-0.622131,0.0380658,0.592103,0.977172,0.674534,-0.71081,0.212382,0.277519,0.39607,0.326765,-0.439503,0.279665,0.337454,-0.674195,-0.0854985,-0.224437,-0.572313,-1.27119,0.0529129,0.315649,-0.586356,-0.48003,-0.0369316,-0.100362,0.0214312,-0.81762,0.143742,0.214725,-0.53296,0.360384,-0.764719,0.933889,0.359234,-0.256413,-0.18262,0.205561,0.434152,0.762463,-0.522475,0.278424,-0.723965,-0.109246,-0.158081,-0.0803627,0.155078,-0.418704,0.0506433,0.332277,-0.860273,0.368927,0.0674348,-0.292735,-0.0338477,-0.0710695,-0.776383,0.00162538,0.0981054,0.0944569,-0.273045,0.394865,0.241382,-0.0222917,0.696125,-0.371806,-0.142836,0.241059,0.0176457,0.332635,0.576457,0.258385,0.73801,-0.306601,-0.460942,-0.239843,0.0672595,-0.954418,-0.0990814,-0.230463,-0.036372,0.0961369,-0.705296,-0.301228,0.138865,-0.292686,0.347218,0.634399,0.440845,0.625472,0.321084,0.044594,-0.331078,0.340855,-0.16749,0.271417,-0.266357,-0.369326,-0.492363,0.368861,0.166112,-0.66429,-0.011513,-0.256262,0.313326,0.019839,-0.146877,-0.158637,-0.364503,0.033696,-0.188945,0.741379,0.0679123,0.860677,-0.298667,-0.205153,-0.439078,-0.0349749,0.00936397,0.1953,-0.179575,-0.913551,0.0335659,0.402009,0.926346,-0.574676,-0.162581,0.190179,0.323705,0.436095,0.568951,-3.00386 +3367.42,0.876777,0.0912059,4,1.49747,1.24524,0.458073,-0.276047,-0.199463,0.0596465,0.284588,0.155424,0.915585,0.903944,-0.84753,0.18654,0.389286,0.191178,-0.0167885,0.977216,0.736944,0.226355,-0.193112,0.113839,-0.385278,-0.835056,-0.728864,0.351224,0.229366,-0.311696,0.33718,0.481399,-0.580894,0.493347,0.536255,-0.246194,0.248234,0.122883,-0.668892,-0.581524,-1.14357,-0.398029,0.0914638,-0.504317,0.940953,0.23817,0.59233,-0.456816,0.144911,-0.241326,-0.213952,-0.231925,0.496155,-0.26284,0.298632,-0.386725,0.0807485,-0.593835,0.977778,-0.226081,-0.5689,-0.553466,0.0128695,-0.295028,0.0833061,0.659024,-0.952209,-1.43663,0.229037,0.704513,0.0672005,0.161964,0.0630129,0.585945,-0.217763,0.46638,0.596376,-0.195429,0.392072,0.211417,0.202873,0.221817,-0.329687,0.412957,0.775495,-1.10555,-0.0676606,0.0448111,-0.0698164,-0.533301,-0.350537,0.562165,-0.480352,0.171776,0.410278,0.113653,-0.0664612,0.151307,0.372454,0.200691,0.377723,-0.487544,0.345026,0.24919,0.322035,0.169051,-0.194697,-0.494856,0.149761,-0.199525,0.50275,-0.156941,0.618271,0.700849,0.483484,-0.155636,0.619715,0.407921,0.166081,0.427781,-0.644801,0.0393707,0.45758,0.244029,-0.488784,0.00570132,-0.470691,-0.323934,0.453523,0.252678,0.242873,-0.167744,0.971791,-0.265058,0.0436311,0.58842,0.280952,0.757361,-0.516093,-0.382859,-0.330679,0.0500582,0.562213,-1.2143,-0.61652,-0.346241,0.533895,0.0208561,0.582384,-0.0242144,0.724058,0.247833,0.0416351,-0.389731,0.797416,0.0512616,0.62296,0.0812329,1.05183,0.351814,0.206325,-0.484777,0.12389,0.320397,0.289406,-0.482274,0.272509,-0.495539,-0.694905,0.148079,-0.317613,-0.137027,-0.0829296,-0.02263,0.169091,-0.92619,-0.196751,0.590472,-0.109705,0.418595,0.299113,0.643958,0.353428,0.94167,0.432746,-0.127848,0.623933,0.267323,0.029545,-0.456305,-0.222327,0.207366,0.520244,-1.38398,0.618923,0.657811,0.0780922,-0.687308,-0.643002,0.278849,0.743522,-0.286517,-0.468141,0.258539,-0.52399,-0.460042,0.617522,0.0284788,0.341881,0.283823,-0.464254,1.20278,-0.529918,0.143364,0.452287,-0.062109,0.282798,0.427657,-0.185358,0.384519,-0.320368,0.339835,0.85806,-0.500767,-0.00956501,-1.48329,-0.252655,-0.497643,-0.263108,0.464526,-0.718569,-0.302179,0.0227069,0.388997,-0.58185,-0.194394,-0.816154,-0.154846,0.0638679,0.493927,-0.121582,0.639103,0.501323,-0.395374,0.575238,0.340393,-0.359288,-0.114092,0.258454,0.512336,0.963633,0.335699,0.192855,0.148462,-0.189304,-0.48863,0.0950486,-0.2556,-0.0817959,0.0731172,-0.345591,-0.00213246,-0.0782402,-0.290296,0.312053,0.201666,0.262412,0.889536,0.427938,-0.120024,0.284961,0.791147,0.0812529,-0.177318,0.103771,0.165189,-0.185326,0.316579,0.231251,-0.11162,-0.0462253,0.358028,0.183072,-0.700115,-0.0991464,0.242875,-0.0578198,0.526181,-0.0900578,-0.64984,-0.140573,-0.0412673,0.224029,-0.866008,0.00821041,-0.12092,0.483775,-0.0493106,0.124023,-0.205773,-0.592575,-0.0684998,-0.0507565,0.119524,-0.385678,0.147282,0.299584,0.383774,0.547343,-0.0356744 +3355.04,0.9667,0.0912059,5,1.60544,1.05488,-0.676458,0.153997,0.115207,-0.234875,-0.376235,0.43404,0.153029,-0.281363,-0.349991,-0.272676,-0.0264942,-0.296542,-0.00617522,0.684672,0.455526,-0.010624,-0.0373491,0.0946406,-0.404164,-1.32949,-0.645103,0.0615051,-0.0155847,-0.532993,0.361698,-0.0143381,0.157907,0.449197,0.587057,-0.681507,-0.264089,0.139194,-0.291207,0.00343433,-0.584641,0.325015,-0.201057,-0.184113,1.10251,0.210633,-0.496501,-0.777491,0.0447775,-0.207708,-1.33348,0.431981,0.348513,0.125056,-0.16587,0.284889,-0.556104,-0.498074,0.432277,-0.500092,-0.260532,-0.60125,-0.121477,-0.423916,0.205153,1.14208,-0.472964,-0.409469,0.194803,0.844817,0.0237296,0.409019,0.871604,-0.674414,-0.497734,0.280372,1.31734,0.301991,0.705446,0.255011,0.232996,-0.017773,-0.212838,-0.0357817,1.08149,-0.345146,0.0685981,-0.732821,0.0752129,0.223059,0.714741,-0.336984,-0.012658,-0.647888,0.167196,-0.244452,-0.235275,0.108619,0.193986,-0.282177,0.514837,0.453014,0.113237,0.222916,0.657787,0.16235,-0.929278,-0.716859,0.200471,-0.597474,0.367034,-0.387071,-0.43723,0.618093,0.00561473,0.233127,0.355925,0.45673,-0.144668,-0.333334,-0.87704,0.38085,0.479501,-0.170872,-0.976497,-0.00911348,-0.146329,-0.339055,0.0683967,-0.46151,0.0262543,0.485012,0.254793,-0.926686,0.194778,0.213521,0.0786574,0.402335,-0.256157,-0.137329,0.434726,-0.504175,0.613261,-0.971942,0.229565,-0.0933933,-0.291995,-0.306216,-0.501271,0.340297,-0.633565,-0.555844,-0.0256058,0.200123,-0.730717,-0.0137869,-0.206693,-0.245886,0.381289,0.83623,0.4704,0.467054,0.0346074,-0.0302288,-0.166042,0.416141,0.511834,0.130889,-0.319859,0.0710034,0.161556,0.0529067,-0.0103852,-0.272602,0.791031,0.42105,0.242517,0.124087,0.0681336,-0.180575,-0.606275,-0.245471,-0.187039,0.42991,-1.16221,0.261223,-0.315147,0.229771,0.223361,-0.742709,-0.392516,0.200944,0.185552,0.0600672,0.140093,-0.281941,-0.0984454,-1.23535,0.540048,0.377807,-0.458196,0.0890125,-0.527228,0.167695,-0.0347941,-0.699329,0.697506,-0.667944,-0.12706,-0.452271,-1.35642,1.06698,-0.477411,0.47524,-0.93041,-0.349127,0.313266,0.498434,0.737583,0.514629,-0.98502,-0.0279252,0.213018,-0.282468,0.176391,-0.292328,0.32899,1.20639,-0.324415,0.287823,0.000461302,-0.443616,1.23907,0.370523,-0.00834063,0.200685,-0.130442,0.299279,-0.944232,0.911002,-0.0654945,-0.403385,0.264297,-0.640886,-0.969291,-0.223515,-0.259768,0.134674,0.617043,0.0012114,0.741847,-0.23408,-0.529365,-0.114417,0.113514,-0.822912,0.170213,-0.307246,-0.222512,0.492381,0.0504655,-0.110526,0.449158,0.101805,-0.471679,0.599352,-0.00334883,0.0468876,0.372279,-0.252152,0.0293976,-0.929636,-0.172599,0.0885672,-0.40316,0.10864,-0.488142,1.00061,-0.491779,-0.228565,0.299119,0.0556547,-0.0626987,0.174706,-0.424062,-0.524945,-0.437496,-0.159825,0.225522,0.641392,0.300683,0.534329,0.277355,0.447586,0.200845,0.987037,0.0986428,0.553176,0.401902,-0.21817,0.55955,0.0801778,0.100009,0.0734038,-0.439195,0.17717,0.310865,0.420916,0.557553,-0.373893 +3391.25,0.904102,0.0912059,5,1.68139,0.93002,-0.686605,0.199048,0.135722,-0.222298,-0.340609,0.276,0.464056,-0.12775,-0.429892,-0.0717956,-0.277626,-0.155956,-0.282431,0.706103,0.282136,-0.281086,-0.165028,0.17213,-0.581685,-1.15135,-0.557075,0.134605,0.312911,-0.676853,0.546719,0.392906,0.414512,0.370409,0.711216,-0.432604,0.0270865,0.115323,-0.0785599,-0.0223854,-0.46041,0.530375,-0.0371039,-0.235119,0.879221,0.00486602,-0.13854,-0.97771,-0.36837,-0.508483,-1.34899,0.279257,0.501004,0.0641211,0.0285434,0.182699,-0.56958,-0.371754,0.415825,-0.463017,-0.0309541,-0.839632,0.0124927,-1.04034,0.177956,1.03252,-0.313447,-1.02506,0.28269,0.601145,0.069802,0.185451,0.72708,-0.588358,-0.333725,0.38303,1.28033,0.0102809,0.801727,0.348798,0.0802416,-0.0500773,-0.256498,0.0575261,0.926543,-0.25911,-0.130242,-0.826544,-0.26661,0.111139,0.251483,-0.415296,-0.0498428,-0.582772,0.172348,-0.357913,-0.222394,-0.222737,0.00543953,-0.5111,0.0210192,0.00820511,0.204955,0.0102102,0.780265,0.147928,-1.11023,-0.48899,0.311503,-0.424128,0.326625,-0.514869,-0.265128,0.803398,0.161598,0.442684,0.449054,0.506793,0.0943814,-0.437516,-0.841529,0.243118,0.497798,0.0138981,-1.10285,-0.512906,0.130028,-0.548546,0.00553113,-0.159656,0.305317,0.428143,0.188744,-0.373252,0.0470623,0.588199,0.252477,0.313422,-0.349734,-0.261484,0.36791,-0.460283,0.71859,-0.742881,-0.0323139,0.0103311,-0.0213567,-0.45062,-0.381928,-0.0835749,-0.937301,-0.274867,-0.165597,-0.150881,-0.341626,0.150545,-0.26927,-0.216983,0.446836,0.561994,0.349271,0.192125,0.00186631,-0.241832,-0.215336,0.427549,0.374856,0.321623,-0.218298,-0.0794955,-0.0828208,0.0580925,-0.174737,0.181208,0.771908,0.465707,0.074379,0.0267297,0.0673877,-0.127468,-0.496409,0.0482784,0.45829,0.459225,-1.09535,0.345039,0.0479564,-0.210236,0.154405,-0.623761,0.0593689,0.119798,0.0904428,-0.193592,0.210151,-0.00428364,0.232347,-0.963863,0.787661,0.156354,-0.1697,0.106713,-0.685458,0.0619844,0.0789435,-0.648956,0.702664,-0.398466,0.0216989,-0.634647,-1.12562,0.887141,-0.367952,0.378823,-0.733429,-0.254704,-0.0418938,0.149199,0.663906,0.557866,-1.26674,0.0607709,0.158358,-0.0503585,0.110155,-0.236432,0.0557285,0.900084,-0.111831,0.473539,0.143051,0.00451354,1.095,0.463398,-0.269947,0.322194,-0.271331,0.014148,-1.06358,0.838215,0.0986618,-0.113693,0.560373,-0.443027,-0.985727,-0.155747,-0.0343403,-0.0112348,0.537342,0.224386,0.688733,0.271333,-0.464129,0.106323,0.053739,-0.657208,0.270482,-0.324996,-0.133945,0.25575,0.291939,-0.0779932,0.369692,-0.00169804,-0.234407,0.760552,0.2204,0.0612445,0.280942,-0.4191,-0.218173,-0.680007,0.222046,0.186481,-0.297016,-0.123549,-0.143098,0.545639,-0.574841,-0.13067,-0.123538,0.126324,-0.328034,0.167088,-0.0822083,-0.1632,-0.429299,-0.0675151,0.263754,0.544088,0.151318,0.186508,0.402093,0.336387,0.325483,0.266954,0.133887,0.367449,0.610682,0.42504,0.319697,-0.0652068,-0.013141,0.28803,-0.722372,0.244875,0.32539,0.494848,0.57043,-0.185851 +3392.15,0.840718,0.0912059,4,1.65524,0.952804,-0.699645,0.211212,0.204332,-0.216397,-0.310087,0.27081,0.531588,-0.158719,-0.480209,-0.134093,-0.313467,-0.309682,-0.30899,0.69846,0.256045,-0.303784,-0.147952,0.179319,-0.477986,-1.10779,-0.491839,0.123059,0.221686,-0.662761,0.526494,0.361171,0.411635,0.339255,0.708177,-0.430935,-0.00350179,0.124717,-0.143388,-0.0357183,-0.346924,0.447278,0.0253024,-0.257568,0.942186,-0.0145739,-0.0754733,-0.937045,-0.305337,-0.613667,-1.29101,0.239679,0.527384,0.0128465,-0.0518194,0.24493,-0.509686,-0.462309,0.42223,-0.441797,-0.113869,-0.711521,0.0415403,-1.06855,0.155913,1.05335,-0.283377,-0.974606,0.259236,0.58594,0.08293,0.144295,0.699542,-0.545604,-0.239825,0.337586,1.28198,-0.0885183,0.818347,0.306721,0.0332374,-0.029538,-0.32347,0.0148611,0.91573,-0.291433,-0.164388,-0.811398,-0.323669,0.175444,0.165612,-0.382029,-0.0541217,-0.578577,0.293484,-0.458279,-0.276639,-0.227682,-0.051881,-0.55703,0.0153671,0.0577912,0.277298,-0.0329972,0.672107,0.160951,-1.17923,-0.473794,0.318534,-0.397358,0.267682,-0.49317,-0.31743,0.752533,0.0773557,0.502511,0.386772,0.52379,0.287282,-0.423009,-0.741917,0.244302,0.47294,-0.0155648,-1.13173,-0.589566,0.305251,-0.517685,0.0228436,-0.192384,0.245166,0.422456,0.229474,-0.313683,-0.00729916,0.598244,0.219842,0.335576,-0.341537,-0.293475,0.371358,-0.463859,0.738707,-0.680846,-0.0185471,-0.0175188,-0.0125903,-0.368956,-0.354426,-0.128184,-0.939224,-0.268316,-0.102263,-0.157283,-0.395745,0.187357,-0.365523,-0.189307,0.415035,0.426474,0.305719,0.167618,0.0847895,-0.243413,-0.0968088,0.399798,0.449542,0.286036,-0.216469,-0.050292,-0.0758194,-0.0371998,-0.120513,0.121701,0.884308,0.49012,0.0232175,0.0200388,0.0810028,-0.129519,-0.486255,0.025194,0.326123,0.437045,-1.08729,0.442545,0.0473929,-0.173553,0.205565,-0.645517,0.187292,0.139143,-0.0469078,-0.234136,0.173293,0.0106946,0.300632,-0.970925,0.711581,0.121649,-0.0949201,0.0756283,-0.784467,0.127154,0.091549,-0.66676,0.791126,-0.389087,0.0532517,-0.689864,-1.08713,0.965375,-0.483561,0.318175,-0.726826,-0.318336,-0.064718,0.100849,0.679426,0.509899,-1.22541,0.0519813,0.115793,-0.0427968,0.163593,-0.175294,0.0700514,0.805356,-0.173602,0.387517,0.196108,-0.0158163,1.2485,0.517023,-0.223213,0.331169,-0.248131,-0.0185323,-1.09021,0.731524,0.0652184,-0.0750955,0.570498,-0.615667,-0.874936,-0.0982597,0.103368,-0.136764,0.525878,0.268709,0.533925,0.283433,-0.440464,0.0814278,0.0195763,-0.590035,0.223304,-0.32,-0.152906,0.288588,0.27118,-0.134128,0.358999,0.0541571,-0.239487,0.721696,0.308505,0.0245303,0.202149,-0.45566,-0.177008,-0.575536,0.153557,0.160045,-0.264902,-0.168614,-0.154267,0.448306,-0.582616,-0.132135,-0.143327,0.1549,-0.363412,0.155619,-0.0814986,-0.156583,-0.452342,-0.0477384,0.213578,0.540372,0.234712,0.0932558,0.466776,0.328057,0.314898,0.226631,0.143145,0.2627,0.563773,0.451375,0.266885,-0.0463079,0.00762015,0.288552,-0.801941,0.234439,0.336354,0.484189,0.579961,-0.486214 +3390.62,0.830929,0.0912059,4,1.61367,1.02252,-0.80647,0.275995,0.285307,-0.21402,-0.402279,0.353629,0.536588,-0.120356,-0.355758,-0.447998,0.113252,-0.0240575,-0.408282,0.799399,0.249723,-0.330527,-0.161934,-0.0107429,-0.456817,-0.836793,-0.555528,-0.0284951,0.148961,-0.557513,0.258949,0.138749,-0.0836028,0.513224,0.637597,-0.498659,0.0632381,-0.079509,-0.290002,-0.164345,-0.67682,0.244615,0.283326,-0.451023,0.909801,0.189305,-0.373992,-0.723225,-0.213495,-0.568307,-0.904047,0.3519,0.0295936,-0.0428017,-0.00251399,0.189049,-0.678836,-0.644088,0.266885,-0.145913,-0.222013,-0.720469,-0.0472862,-0.80903,0.279307,0.914104,-0.0801921,-1.15792,0.327038,0.365709,-0.165458,0.610338,0.706061,-0.236593,-0.436789,0.817862,1.12172,-0.27971,1.00382,0.251271,0.348103,-0.0542258,-0.267466,0.17239,0.650201,-0.223156,0.147089,-0.716814,0.0496998,0.183324,0.220321,-0.839184,-0.264222,-0.276988,0.378143,-0.913256,-0.119718,-0.0593496,-0.06641,-0.326032,0.560009,-0.0637736,0.502007,0.272552,0.672677,0.464494,-1.1376,-0.505945,0.22401,-0.678987,0.733083,-0.152179,-0.326667,0.944904,0.285745,0.400353,0.347061,0.389416,0.347958,-0.327128,-0.55985,0.0867423,0.997227,-0.689744,-1.01298,-0.593625,0.372943,-0.339181,-0.181014,0.0846877,0.257861,0.638644,0.715396,-0.386115,0.135906,0.310826,0.274376,0.540092,-0.271694,-0.431809,0.0941694,-0.190827,0.458541,-0.879105,-0.261469,-0.171983,0.237071,-0.331957,-0.126209,-0.253912,-1.03548,-0.384032,-0.179383,0.429219,-0.187195,0.153902,-0.343905,-0.179442,0.645606,0.306175,0.354608,0.108167,0.0265343,-0.154626,-0.270125,0.432221,0.457297,0.223816,-0.0800827,0.156937,-0.0420485,-0.37637,-0.308627,0.188344,0.573424,0.269998,0.0466346,-0.191812,-0.0644587,-0.425061,-0.343575,0.0566508,0.706801,0.515701,-0.991892,0.205646,-0.0927826,0.432571,0.138658,-0.769531,0.157699,-0.0150412,-0.0915338,-0.674073,0.282725,-0.135567,0.17237,-1.26197,0.401972,0.223494,-0.0792108,-0.319257,-0.69045,0.488493,0.195474,-0.802749,0.746557,0.0017809,-0.0724637,-0.626665,-0.957839,1.02001,-0.184562,0.358264,-0.237109,-0.191283,-0.235628,0.229247,0.648589,0.577762,-1.29152,-0.0229598,0.404868,0.130487,0.134066,-0.625704,0.32303,0.58084,-0.202219,0.527528,0.140694,-0.112858,0.643795,0.849962,-0.141568,0.234216,-0.441064,-0.0881295,-0.8947,0.699505,0.14334,-0.07956,0.261767,-0.708714,-1.07448,-0.134057,0.40681,-0.460216,0.345782,0.318211,0.816741,0.198697,-0.36517,-0.460818,-0.500407,-0.748116,0.299084,-0.72246,-0.185942,0.31296,0.148144,-0.553437,0.663263,0.0369847,0.312952,0.451108,-0.0749448,0.106545,-0.117201,-0.205722,0.101508,-0.522978,-0.0692833,0.344758,0.0996382,0.095918,-0.316069,0.618348,-0.753384,-0.0960412,0.0412127,0.474017,0.0133668,0.469708,0.096023,-0.264952,-0.0210851,-0.474598,0.408595,0.141684,-0.102735,-0.235887,0.712769,-0.103288,0.10921,0.255489,0.0282642,0.545584,0.63863,0.269805,0.387079,0.233802,-0.0378883,-0.153088,-0.247378,0.198445,0.297904,0.445472,0.545806,-0.925761 +3380.23,0.981344,0.0912059,4,1.65185,1.14379,-0.670727,0.180324,0.422405,-0.0515013,0.66583,-0.272104,0.37699,-0.104373,-0.848894,-0.168418,-0.191012,0.0184117,-0.0134448,0.780111,0.0482431,-0.10884,-0.209562,-0.114003,-0.463973,-0.90403,-0.982358,-0.37943,0.1466,-0.777803,-0.0889285,1.02066,0.36107,0.526256,0.887643,-0.546937,0.554339,0.0715389,-0.451661,0.159919,-0.366002,0.173965,0.275195,0.03369,0.974115,0.244892,0.405551,-1.38209,0.38301,0.0338369,-0.756197,-0.231868,0.113986,-0.102901,-0.266342,-0.117753,-0.520172,-0.556691,0.194554,-0.532535,-0.192028,-0.78851,0.279332,-0.818996,0.185125,1.23387,-0.283512,-1.05256,0.161391,0.456153,0.216846,0.129947,0.509387,0.134764,-0.386023,0.323013,0.628573,0.358195,0.209122,0.108436,0.273766,0.0103083,-0.62045,-0.137982,0.4297,-0.769588,0.396741,-0.00370256,0.469376,0.142383,-0.0606525,-0.503577,-0.14931,-0.565559,-0.136913,-0.172352,-0.481224,0.0330968,-0.641632,-0.533729,0.198249,0.00973136,0.246384,0.464497,0.316525,0.268785,0.0318349,-0.875922,-1.00734,0.146455,0.310093,-0.487614,0.0158834,0.644849,-0.322679,0.142375,0.55438,0.577281,0.138176,-0.483677,-0.454971,0.154137,0.420294,-0.0926368,-1.03337,-0.522028,-0.276511,-0.147106,-0.155159,0.740348,0.840867,0.81638,0.675241,0.0376194,-0.356838,-0.0149296,0.1906,0.635685,-0.694365,0.081966,0.638371,-0.460716,0.128493,-0.653052,-0.370887,0.0652628,-0.459012,0.424019,-0.504769,0.16945,-0.299238,-0.537052,-0.289738,0.397632,-0.501792,0.665134,0.0662478,-0.407307,0.791441,0.578699,0.112693,0.30405,-0.256207,0.0779092,-0.251235,0.121941,0.230429,0.499002,-0.0709487,-0.273572,0.112027,0.161371,-0.0836116,0.835073,0.7755,-0.382773,0.0329814,0.0681667,0.312978,-0.852181,-0.301514,-0.010473,-0.0291976,0.174481,-0.916204,0.523257,0.244611,0.00624876,-0.0526181,-0.629411,-0.207117,-0.0771139,0.146,-0.246471,0.17281,0.0599165,0.157335,-0.516788,0.218623,-0.12556,-0.0780534,-0.451067,-0.85904,0.213483,-0.0295066,-0.0730435,0.683826,0.0683661,0.247588,-0.0134456,-1.23102,0.614496,-0.247758,-0.10845,-0.301254,-0.0909223,0.0543238,-0.159461,0.0732825,0.811932,-0.316896,0.0194274,0.80506,-0.0171616,0.223887,-0.927648,0.762364,0.685294,-0.689752,0.778122,-0.216295,-0.0976382,0.907955,0.572184,-0.225289,0.0806123,-0.438427,-0.187835,0.0827857,0.568147,0.123656,-0.051078,0.466224,-0.517031,-0.410946,-0.0557852,-0.161498,-0.0275088,-0.135601,-0.131115,0.672426,-0.0642748,0.0719584,0.0545783,-0.36444,-0.604723,-0.0839183,-0.705806,-0.589754,0.273015,-0.460453,-0.870194,-0.234664,0.130563,-0.35002,0.311114,0.255965,-0.186482,-0.133304,-0.0885062,-0.480198,-0.0906013,-0.425467,0.0705489,-0.445942,-0.212698,-0.484614,0.673369,-0.517747,-0.687384,-0.246972,0.264243,0.520676,0.592635,-0.365785,-0.514951,-0.411676,-0.273248,0.15465,0.383637,-0.411587,0.92894,0.835615,0.285265,0.192048,0.363669,-0.0821057,0.806796,-0.00302976,-0.0138226,0.207603,-0.156668,0.600827,-0.132464,0.470222,0.204376,0.266512,0.45208,0.516248,-1.57835 +3414.08,0.921756,0.0912059,4,1.63349,0.982486,-0.580402,0.233632,1.25448,-0.0865955,-0.328458,0.359935,0.7436,0.389773,0.198612,-0.005369,0.292115,0.0143399,-0.446497,0.949002,-0.197971,-0.290531,0.604224,-0.186887,-0.420524,-0.730625,-0.341068,0.0489182,-0.498049,0.353169,0.282682,0.111392,-0.970359,0.248924,0.78619,-0.193028,0.435073,0.214686,-0.0975027,-0.49425,-0.326142,0.489419,0.68338,-0.531364,0.68077,0.401474,-0.14845,-0.662888,-0.458113,-0.033926,-0.412116,0.219541,0.675136,0.152296,-0.219098,0.763302,0.0904113,-0.0165584,0.83395,-0.155841,-0.034146,-1.05281,0.282642,-0.279816,0.0843887,0.672132,-0.487151,-0.726934,-0.23253,-0.166021,-0.515249,-0.0353449,0.0936308,-0.62799,0.255466,0.0627578,0.746909,-0.447851,0.753117,0.220442,0.444699,-0.432789,-0.137017,0.190947,0.436013,-0.0706055,-0.0160895,-0.0752377,-0.216219,0.00568093,0.106363,0.293405,-0.105556,-0.392606,-0.288942,0.0262125,0.491541,0.00372587,0.377675,0.22232,0.131405,-0.169552,0.12291,-0.00201028,0.0209799,-0.00627967,-0.628284,0.139902,0.835328,-0.339289,-0.00772558,-0.335463,0.447585,0.290146,0.0371963,0.0732415,-0.329149,0.197436,-0.102442,0.409934,0.0195433,0.381509,-0.171313,-0.527357,-0.301638,-0.00545014,-0.286647,-0.257914,-0.117973,-0.157415,-0.180194,-0.293133,-0.0503319,-0.870434,0.291487,0.180031,-0.23346,0.400772,-0.0608329,0.0595747,-0.650644,-0.00948156,0.516967,-0.308139,-0.0457657,-0.053133,0.543255,-0.662689,0.571862,-0.0781605,-0.044047,0.74603,-0.25651,-0.652056,-0.151235,-0.648627,0.279948,-0.00915409,-0.0701022,0.266421,0.311147,-0.453453,0.272876,-0.1238,0.692464,-0.0887733,0.552819,-0.467105,-0.282751,0.20233,-0.765963,-0.482586,-0.202412,-0.900519,-0.232359,0.215188,-0.174058,-0.483853,-0.566778,0.381977,0.107947,-0.127719,0.120405,1.12813,0.927121,-0.278025,0.0426808,0.104582,-0.163367,-0.321104,-0.409101,-0.184567,0.0765494,-0.534173,0.0720874,-0.0068382,-0.159932,-0.821573,0.140964,0.384985,0.049802,-0.0624872,-0.431285,-0.0735714,-0.0794729,-0.311529,-0.225259,-0.0656474,-0.381874,0.0120289,0.0306181,0.769806,0.551041,0.265098,0.358227,-0.0143405,-0.160168,0.130133,-0.0924715,0.0625099,-0.155731,0.219613,-0.172145,-0.363229,-0.282965,-0.174589,-0.74761,-0.126514,-0.243781,-0.399594,-0.219954,-0.397792,-0.363091,-0.137813,-0.323034,-0.180345,-0.00919832,-0.269095,-0.440738,0.755251,-0.1756,0.190524,0.637286,-0.959858,-0.179578,0.299754,-0.271396,-0.0527341,0.708448,0.591104,0.318233,0.274056,-0.102286,-0.461438,-0.00616626,-0.275483,0.361922,0.362424,0.190354,0.0246387,-0.222001,0.720317,0.683516,-0.00706323,0.564085,0.697354,0.0848379,0.373518,0.635207,0.0225423,0.124609,0.0305127,-0.271835,-0.0597248,0.194098,-0.461512,0.274081,-0.380788,0.377417,0.0840758,0.366965,0.0950033,0.0630023,-0.432633,-0.394793,0.206736,0.00527924,0.105806,-0.397146,-0.0692879,0.0570235,-0.247657,-0.296765,-0.485477,-0.192221,-0.141449,0.0150744,-0.263886,0.199388,-0.769284,-0.179317,0.254153,-1.07189,0.0702936,-0.512441,0.134668,0.217555,0.366971,0.466428,-4.16306 +3435.28,0.827,0.0912059,4,1.58419,0.978954,-0.997838,0.401176,0.602568,-0.182866,-0.136756,0.29018,0.293089,0.244853,0.221369,-0.316428,0.0926188,-0.179255,-0.110895,0.639323,0.142658,-0.291393,-0.218883,-0.111233,-0.313074,-0.736576,-0.345793,0.0698697,-0.492205,0.135296,-0.00813253,0.227521,-1.00017,-0.0604877,0.668121,-0.0968853,0.164658,0.00325862,-0.548394,-0.195788,-0.653716,0.545819,0.265615,-0.399743,0.703038,0.270926,-0.308441,-0.0571892,-0.263026,0.109507,-0.368252,0.145091,0.412497,0.0615946,-0.0666364,0.205088,0.264899,0.294418,0.310555,-0.372466,-0.402186,-0.70292,-0.00324081,-0.399888,0.282288,0.501951,-0.824439,-0.896778,0.0605329,0.239621,-0.33124,0.105826,-0.690535,-0.264379,-0.148769,0.330557,0.677742,-0.264346,0.327853,0.442914,0.434243,-0.377472,-0.190215,-0.00528115,0.694595,-0.655111,0.312872,0.537495,-0.00997362,0.238724,-0.00164433,0.0916865,0.419632,-0.420373,-0.53163,-0.0162257,0.524414,0.00554486,0.0719523,0.155919,0.105184,-0.648988,-0.0919694,0.160186,0.337921,-0.294272,-0.273498,0.204343,0.116504,-0.183548,0.410163,-0.650583,0.0822523,0.588171,0.365951,0.0450989,0.0953052,0.255975,0.253718,0.280439,0.0865654,0.0922401,-0.0707025,-0.272885,-0.309628,-0.678709,-0.115392,-0.293726,0.00881635,0.452437,0.517973,-0.412395,0.0692203,-0.635778,-0.4413,0.327287,0.110613,0.993881,-0.181341,0.279562,-0.404665,-0.160652,0.482913,-0.220898,0.0107546,0.0504155,0.121567,-0.101177,0.504133,0.119469,0.264543,0.658693,-0.127443,-0.882197,-0.24896,-0.376352,0.100008,-0.0403884,0.766284,0.203318,0.271209,-0.511822,0.382934,0.111044,0.75453,-0.266645,0.814401,-0.341611,-0.286153,0.419698,-0.592023,-0.550247,-0.264273,-0.314462,-0.0759371,0.147856,-0.171744,-0.288588,-0.211933,0.112841,0.301812,-0.172899,0.0986347,0.758855,0.109341,0.0194933,0.338638,-0.318495,0.27198,-0.707162,-0.209262,-0.541331,0.140115,-0.465119,0.41181,0.191692,0.400905,-0.64622,0.308541,0.410591,-0.119404,-0.0915404,-0.106741,-0.269398,-0.124892,0.273655,0.144078,-0.178151,-0.401758,0.368053,0.169253,0.917232,0.282045,0.174489,0.185597,0.159738,0.125448,0.139098,-0.229637,0.378328,-0.386786,-0.0350397,0.113951,-0.349489,-0.501339,-0.187481,0.371473,-0.0545872,-0.671971,0.224251,-0.0280618,-0.0606921,-0.102168,0.0688089,0.100895,0.0256283,0.106212,-0.0416338,-0.30657,0.446002,-0.783958,0.458512,0.581548,-0.334977,-0.126122,0.377683,0.033863,0.217501,0.630867,0.178591,0.393012,-0.00262366,-0.360416,-0.135343,0.0434807,0.00299009,0.519257,0.0871804,-0.44604,-0.0909281,-0.0605301,-0.0391864,0.188135,-0.142711,0.00263032,0.197624,0.313868,-0.267355,0.670853,-0.383807,0.023246,-0.381959,0.0047036,0.430141,0.0869752,-0.752685,-0.230028,-0.205323,-0.383819,0.468173,0.178664,-0.00494671,-0.123693,-0.00589644,-0.51613,-0.130674,0.0634592,-0.230706,0.14717,0.178558,-0.651309,0.284514,-0.190887,-0.144918,-0.114588,-0.115349,0.0395318,-0.12455,-0.0142296,-0.54707,0.550191,0.0456706,-0.313782,-0.236034,0.0877609,0.127081,0.180716,0.356484,0.425107,-1.95742 +3437.02,0.952406,0.0912059,4,1.68761,0.964251,-0.749953,0.263764,0.702493,0.0131774,-0.102871,-0.375761,0.0789036,-0.0709448,0.101492,0.129406,-0.323878,-0.0426091,-0.351287,0.584178,-0.290052,-0.134285,0.493479,-0.20099,-0.460038,-1.03659,-0.901221,0.0930433,0.0984963,0.432153,-0.0263737,0.219885,-0.644273,-0.160568,0.675649,-0.225377,0.648897,0.128912,-0.12701,0.279923,-0.0972174,0.60767,0.675904,-0.686575,0.900079,0.452215,0.0559155,-0.769861,-0.100131,-0.0838169,-0.191898,-0.268322,0.445457,0.207171,-0.202755,0.661199,0.0764797,-0.632948,0.597612,0.0281325,-0.427855,-0.570066,0.633833,-0.102898,0.276512,0.883285,-0.599867,-0.481159,-0.0680394,0.399032,-0.479597,0.258396,-0.0482711,-0.396693,-0.23026,0.507718,0.871441,-0.242913,0.603881,0.524491,0.184433,-0.666472,-0.203006,-0.37175,0.525961,-0.675011,-0.119272,0.124649,-0.16204,0.144693,0.205516,0.029336,0.296063,-0.677758,-0.0609188,-0.165918,-0.0583663,-0.0249528,-0.269675,-0.011979,-0.318239,-0.372853,0.00183507,0.15605,-0.10334,0.0272483,-0.199245,-0.389831,0.0211769,-0.560065,-0.261851,-0.235262,0.554306,0.534689,-0.250931,-0.0452938,0.026276,0.26692,0.107335,0.101082,-0.394841,0.218562,0.0192841,-0.252095,-0.400843,0.0283749,-0.544811,0.219552,-0.469297,-0.0204094,0.0133104,0.282482,-0.426628,0.23006,0.280582,0.0947728,0.0884944,0.499134,0.101836,0.249636,-0.0341208,-0.129389,0.542024,-0.483405,-0.40219,-0.0572632,0.0819076,-0.566356,-0.33909,0.23442,0.797934,0.24362,-0.316629,-0.571739,-0.036205,-0.036627,-0.0345399,0.0348646,0.488329,0.458215,0.068207,-0.316788,0.0344994,-0.104705,0.0693347,-0.621673,0.579106,-0.217584,0.422705,0.691306,-0.341919,-0.399319,0.163709,-0.253527,-0.234747,-0.0555131,-0.111449,-0.294741,0.369607,-0.0179448,-0.27898,-0.157535,0.0424061,0.514367,0.353272,-0.221434,0.406871,0.0561967,0.532611,0.33878,0.0846257,0.0950712,0.213412,-0.357914,0.266541,0.200999,0.214464,-0.563867,-0.000179751,-0.146644,-0.193535,0.308368,-0.295703,-0.456902,-0.045742,-0.196217,-0.653871,-0.419551,-0.717159,-0.317999,0.0465179,0.91871,-0.228452,-0.377148,0.287112,-0.0551858,-0.431472,0.253394,0.23587,-0.0192661,0.249655,0.0273874,-0.293872,-0.186488,0.206106,-0.13882,0.173132,0.059063,-0.605355,-0.00719383,-0.448272,-0.152089,-0.0434698,0.0827324,0.230197,-0.0355623,-0.173728,-0.11904,0.00852425,0.354347,-0.444955,0.31449,0.642792,-0.0308116,-0.190242,0.331472,0.0691178,-0.180692,0.276887,0.36432,-0.0693273,-0.541,-0.15676,0.000974353,0.136229,0.0596652,0.197842,-0.0929755,-0.270864,0.462467,-0.40238,0.0791546,0.239792,-0.214092,0.124098,0.0847147,0.205464,-0.232039,0.605134,0.169086,-0.0908474,-0.283321,-0.499414,0.338017,0.0170337,-0.390299,-0.182679,-0.0624631,-0.379626,-0.228099,0.145746,-0.156611,-0.42896,-0.644418,-0.210074,0.0115362,-0.520937,0.195405,0.00875851,-0.0697733,-0.49663,0.0969999,-0.0357946,0.021938,-0.0084472,0.157611,0.269433,0.239994,-0.292107,-0.173686,-0.362297,0.363882,0.294492,-0.283998,-0.0512755,0.107571,0.14576,0.327981,0.381785,-2.20866 +3426.31,0.950168,0.0912059,4,1.56857,0.96968,-0.737331,0.325332,0.62417,0.0178931,0.076706,0.129498,0.571323,0.310305,0.356775,-0.0176364,-0.199186,0.212013,-0.0465079,0.752275,0.163586,-0.0187401,-0.289583,-0.26299,-0.394984,-0.448213,-0.0671203,-0.0842278,-0.482287,-0.192648,0.389644,0.590373,-0.491344,0.0412937,0.889997,-0.440535,-0.226213,0.299445,-0.26262,-0.427597,-0.265917,0.224213,0.575761,0.0803359,0.763706,0.356835,0.378065,-0.266027,-0.294226,0.105605,-0.88103,0.120997,0.55253,-0.126305,-0.0265405,-0.123594,0.334165,0.322356,0.389597,-0.490501,-0.35888,-0.754075,0.160009,-0.150073,-0.407302,0.898448,-0.387612,-0.88389,-0.174859,0.138865,0.72169,-0.055773,-0.1101,-0.567721,-0.196358,0.143769,0.451827,0.181028,0.651518,0.501901,0.463073,-0.00207443,-0.0070441,0.425228,0.375388,-0.0198009,0.595485,0.0076476,0.142273,-0.715151,-0.23545,0.397788,0.184043,0.00577867,0.159294,0.0476955,-0.0276272,0.0105264,0.436865,-0.756008,-0.12242,0.000116121,0.500056,0.225523,0.195544,0.385147,-0.491564,0.119593,-0.0284736,0.575088,0.610911,-0.51159,0.0714238,0.468423,-0.281447,-0.559705,-0.153272,0.420676,0.150529,0.32726,0.199758,0.0824493,0.071604,0.360188,-0.649856,0.165013,0.284532,0.311542,0.0803909,0.636563,0.480438,-0.0890661,0.320648,-0.984785,0.1438,0.412451,0.123706,0.574112,-0.293632,-0.28103,0.150897,0.222657,0.599265,-0.311035,-0.126922,0.198172,-0.0445877,-0.482189,0.0204178,0.123971,-0.159759,0.778452,0.0345046,0.396017,0.19076,0.21487,0.164922,-0.557561,-0.309356,-0.0573325,0.16746,-0.317056,0.235605,0.192618,-0.0329,-0.227111,0.743727,0.274454,-0.479727,-0.102724,-0.161459,0.204033,-0.128047,-0.171261,0.274596,0.128221,0.063986,-0.412255,0.0955238,-0.135664,-0.388972,-0.572081,0.769786,0.71179,-0.168522,-0.208857,0.216294,0.318262,-0.387672,0.16695,0.0967714,-0.62729,-0.212633,0.242756,0.227149,-0.0194071,-0.208488,-0.393686,0.196628,0.387443,0.356488,-0.274601,-0.184713,0.333579,-0.0350057,-0.47865,0.000771752,0.286832,-0.275429,0.466627,-0.313625,0.69965,0.0679972,0.542262,0.227135,-0.0796231,0.160093,0.0379389,0.304968,-0.205586,-0.297748,0.295969,0.568028,0.431681,-0.571852,-0.294016,-0.333778,0.408247,-0.359072,0.402999,-0.448628,0.0488169,0.63754,-0.515379,-0.250874,0.053869,-0.292986,0.375145,-0.50762,0.47047,-0.231773,0.139164,0.236454,-0.420746,0.193447,-0.24337,0.160299,0.795214,0.0937714,0.0406034,0.148597,0.193241,0.740306,-0.7019,-0.309812,-0.010324,0.426601,0.0613625,0.044129,-0.102944,0.085731,-0.811579,-0.0469023,0.0889033,0.0833045,-0.0349034,0.16715,0.59163,0.0762753,-0.0705753,-0.308634,-0.125242,-0.105659,0.121815,-0.794072,-0.27906,-0.199745,0.314276,-0.0495817,-0.187405,-0.174554,0.106039,0.487,-0.359403,0.114388,-0.0298759,0.0645765,-0.403751,-0.260222,0.100212,0.245781,0.360565,0.00752253,0.0591853,-0.156323,0.0718835,-0.441994,-0.259767,0.295851,-1.08564,0.584459,-0.282637,-0.385856,-0.0475812,0.182167,0.141371,0.158895,0.375993,0.398617,-2.14349 +3431.2,0.964287,0.0912059,4,1.56914,0.967486,-0.967261,0.393521,0.692164,0.0854327,0.177534,0.0515438,0.643151,0.240912,0.14603,-0.0112081,0.00884536,0.108343,-0.0718345,0.794553,0.079318,-0.0232967,-0.0464637,-0.00277766,-0.370545,-0.4522,-0.279653,-0.140839,-0.430327,-0.0579101,0.279804,0.570463,-0.422327,-0.18673,0.814815,-0.358863,-0.0625795,0.241127,-0.432212,-0.196723,-0.19135,0.377003,0.516143,0.0144294,0.671765,0.514385,0.589077,-0.256654,-0.480659,0.256364,-0.827744,0.210138,0.356176,0.0658669,-0.0668629,0.324857,0.370217,0.555047,0.37791,-0.171094,-0.397678,-0.502539,0.293556,-0.354543,-0.460116,0.949413,-0.36715,-0.762139,-0.146027,0.124828,0.680171,0.0238863,-0.247563,-0.409685,-0.0887854,0.0514593,0.354352,0.0112407,0.644042,0.417608,0.48799,-0.114501,-0.210541,0.394287,0.286244,-0.031913,0.579222,0.0535283,0.139705,-0.876762,-0.301011,0.43394,0.167585,-0.105364,0.113568,0.132859,-0.0310268,-0.0736036,0.373324,-0.612615,-0.352056,-0.233814,0.709566,0.163959,-0.0866504,0.258173,-0.405282,0.00491178,-0.0518178,0.464371,0.517869,-0.481862,0.0419486,0.549814,0.00109542,-0.610439,-0.164696,0.550615,0.130511,0.221756,0.149169,0.0805907,-0.0873051,0.348386,-0.558045,0.458437,0.202218,0.0952444,0.194231,0.555269,0.51287,-0.0115262,0.274517,-0.756263,0.134274,0.298308,0.277983,0.586025,-0.28388,-0.227798,0.148022,0.0541497,0.580896,-0.566164,-0.28942,0.232843,0.0200651,-0.783907,0.192731,0.17508,-0.125102,0.766243,-0.132711,0.284016,-0.0585472,0.231247,0.275289,-0.222341,-0.391132,0.109648,0.240139,-0.199783,0.356211,0.0961192,0.041465,-0.220037,0.910473,0.110151,-0.207081,-0.0360664,-0.182303,0.119234,-0.271568,-0.281284,0.109879,-0.0100744,-0.0343492,-0.445323,0.254238,-0.090148,-0.406476,-0.645169,0.775756,0.701006,0.0208167,-0.100762,-0.00291355,0.437872,-0.177564,0.14279,0.0846992,-0.543182,-0.209162,0.0758048,0.137679,-0.068137,-0.189143,-0.611351,0.17285,0.281484,0.468697,-0.172764,-0.142205,0.540158,-0.0452496,-0.441123,0.232959,0.0545629,-0.334034,0.58009,-0.0844759,0.645127,0.221095,0.505187,0.160556,-0.0811363,-0.0247711,-0.16811,0.423781,0.0827072,-0.329135,0.318129,0.428797,0.541,-0.578531,-0.285785,-0.114452,0.253065,-0.417103,0.332751,-0.437143,-0.297171,0.45928,-0.634838,-0.225679,0.164105,-0.373775,0.417541,-0.464977,0.271353,-0.329469,-0.154922,0.163904,-0.377753,0.0680028,-0.430785,0.228933,0.548067,0.401348,0.416707,0.174055,0.00191916,0.672943,-0.669552,-0.314864,-0.364346,0.377223,0.127013,0.0240776,0.046337,0.0426792,-0.801777,-0.0440163,0.107384,0.00439445,-0.075021,0.292375,0.425586,0.110731,-0.173017,-0.421178,-0.275235,0.120938,0.0814445,-0.573199,-0.0906737,-0.0266005,0.260818,-0.0137147,-0.267618,-0.148848,-0.132342,0.330089,-0.325071,0.166307,-0.26578,0.199569,-0.622921,-0.368416,0.0266064,0.222891,0.264804,0.0720546,0.245177,-0.103533,-0.165095,-0.320207,-0.0953095,0.480281,-1.07571,0.646733,-0.276987,-0.44946,-0.0692322,0.293334,0.133258,0.18127,0.365045,0.425758,-2.32551 +3412.56,0.938324,0.0912059,4,1.49991,1.03722,-0.604212,0.298373,0.721795,0.0309186,-0.072596,0.223304,0.707331,0.0506172,0.171613,0.0366907,0.0302513,0.302806,0.183509,0.934352,0.0281272,-0.0458913,0.236701,-0.220606,-0.609956,-0.317917,-0.941973,-0.118879,-0.264357,-0.08667,0.054416,0.595395,-0.545961,0.0140186,1.04608,0.245882,0.112718,0.144326,-0.342002,-0.281009,-0.537085,0.474394,0.617724,-0.0647081,0.738301,0.632417,0.574169,-0.185297,-0.218405,0.486547,-0.891324,0.0650702,0.314304,-0.00665453,-0.324678,0.766401,0.480309,-0.61159,0.295242,-0.0589018,-0.0427764,-1.04104,-0.00497109,-0.298938,-0.125752,0.8545,-0.262012,-1.11697,0.0708335,-0.00895786,0.0691722,-0.0917418,-0.171387,-0.297861,0.277782,0.404054,0.6444,0.280793,0.76838,0.701956,0.404005,-0.186763,-0.0420097,0.504486,0.338742,-0.497228,0.50189,-0.0296292,-0.319774,0.0780335,-0.459464,0.261985,0.519576,-0.236124,0.162721,0.16044,0.071379,0.210144,0.277082,-0.558629,-0.335947,-0.276508,0.489215,0.341447,-0.0702671,0.219427,-0.719468,0.127945,0.0209776,0.830507,-0.0206614,-0.300242,0.266197,0.711915,-0.0723621,-0.677719,0.298196,0.439631,0.183916,0.184069,0.166068,0.166493,-0.460694,0.23525,0.0591948,0.437514,-0.331061,0.643722,-0.406847,0.765964,0.0401684,-0.0251451,0.48004,-0.259118,0.175952,0.30186,0.0185809,0.493356,0.056094,0.269374,0.146187,0.137124,0.58754,-0.953364,-0.648939,0.344862,0.626916,-0.832008,0.450661,0.257296,-0.345665,0.823677,-0.22331,0.375876,-0.527416,0.493614,0.355378,0.146387,-0.394674,0.563615,0.39434,-0.244882,0.393967,0.184808,0.415008,-0.444737,0.559122,0.306622,-0.0452885,0.249461,-0.228425,-0.203674,-0.0142624,-0.251803,0.0550795,-0.042224,0.111684,-0.24113,0.0768954,-0.389908,-0.302278,-0.403167,0.925353,0.704207,-0.225466,-0.0806197,0.557242,-0.0435584,0.0621906,-0.117424,-0.249852,-0.180442,-0.00619401,-0.438584,0.289994,-0.319029,-0.450857,-0.474921,0.420859,0.522125,0.30629,-0.47931,-0.235133,0.230065,-0.198108,-0.377514,0.0143484,-0.164879,-0.539242,0.703709,-0.359933,0.744687,0.378903,0.542011,0.220057,-0.0182813,-0.220071,0.156063,0.404064,-0.104983,0.117858,0.241557,-0.0232537,0.314576,-0.577616,-0.46133,-0.0967435,0.377222,-0.0788305,0.299214,-0.0464186,-0.307561,0.755617,-0.381452,-0.339753,0.139315,-0.524296,0.241716,-0.498265,0.464636,-0.330733,-0.039365,0.376318,-0.584068,-0.179931,0.12677,0.449065,0.273282,-0.286237,0.183789,0.45541,-0.117686,0.21401,-0.612945,-0.537612,-0.520877,0.469541,-0.102593,-0.072243,0.105561,0.137472,-1.15092,-0.131396,0.433125,0.0543669,-0.113211,-0.0292685,0.275562,0.398209,-0.271548,-0.354328,-0.390999,-0.176597,0.0097184,-0.668742,-0.337978,-0.133157,0.0527077,0.0220745,-0.296709,0.209789,-0.199273,0.250548,-0.529764,0.162389,-0.440243,-0.117698,-0.14484,0.129888,-0.0896947,-0.0448064,0.364737,-0.190374,0.244006,0.0387023,-0.151177,-0.6067,0.1771,0.530146,-0.469739,0.663558,-0.187963,-0.550391,-0.222368,0.0316132,0.131398,0.15444,0.362489,0.392988,-2.70329 +3420.64,0.671128,0.0912059,4,1.55333,1.02849,-0.872558,0.272663,0.327978,0.0578374,0.00226174,0.140475,0.87175,0.156243,-0.27378,-0.0345412,-0.218406,0.218649,-0.00687883,0.869857,-0.0220021,-0.16152,0.234677,0.129287,-0.455385,-0.549792,-0.785433,0.0553716,-0.220405,0.252486,0.0726092,0.549695,-0.0556459,-0.0300481,0.779298,-0.0519219,0.327358,-0.00692274,-0.581006,0.101704,0.063696,0.43375,0.31913,0.0327454,0.697916,0.739619,-0.259671,-0.118718,-0.210385,-0.0888027,-0.410166,0.197391,0.25945,0.00424076,-0.255386,0.450597,0.485715,-0.456949,0.487243,-0.358368,-0.398056,-0.903578,0.00124058,-0.192661,0.107509,0.732539,-0.446551,-0.569336,-0.654509,0.993566,-0.216225,-0.495974,-0.259209,-0.182164,0.0435681,0.761533,0.739113,0.288313,0.629984,0.567091,0.210831,0.0632896,-0.110636,0.584347,0.313928,-0.402674,0.263464,-0.0596201,-0.42345,-0.0947624,-0.0268125,0.16539,0.508697,-0.4921,0.121286,0.164902,0.162206,-0.166793,0.0952818,-0.277725,-0.62234,0.0170589,0.109349,0.470276,0.221588,0.0880742,-0.58536,-0.054818,-0.151992,0.0940119,0.471407,0.232546,0.130739,0.707226,0.329101,-0.578065,0.456587,0.507394,0.626867,0.48466,-0.240591,0.435563,0.342319,0.192174,0.206897,0.395572,0.211407,0.424332,-0.593521,0.44511,-0.12952,-0.537425,0.187995,-0.200232,-0.0884245,0.208659,0.377282,0.502455,-0.129322,-0.319987,0.0201177,-0.154325,0.619689,-0.986782,-0.651742,-0.0625161,0.3764,0.0359854,0.795732,-0.252625,0.0275355,0.614756,-0.298124,-0.0251921,-0.295221,0.259286,0.704206,-0.240454,-0.581576,0.289084,-0.260418,-0.20879,0.475653,0.37071,0.222313,-0.100935,0.734638,0.571013,-0.187388,0.16411,-0.120431,-0.164537,-0.0111928,0.109312,0.0707323,-0.18972,-0.237952,0.21778,0.481495,0.116607,0.122485,-0.479402,-0.0359041,0.633469,-0.00595595,0.553002,0.125722,-0.539345,-0.0768128,-0.208007,0.700963,-0.203302,0.0545174,0.145693,0.049776,-0.141341,0.0619535,-0.469295,0.0567891,0.000138804,0.0419247,-0.431956,-0.446649,-0.158322,-0.236526,-0.120296,-0.149279,-0.124826,-0.370534,0.358663,-0.816959,0.821887,0.251554,0.388268,0.19025,0.246444,-0.203685,-0.367344,0.200955,0.271596,0.212859,0.0395216,-0.126238,-0.146109,-0.460059,-0.559028,-0.17801,0.095809,0.333866,0.546529,-0.357759,0.0941404,0.732567,-0.353325,-0.0423186,0.21069,-0.0328309,0.211076,-0.34285,0.953403,0.522212,0.1066,0.53999,-0.493168,-0.473116,0.273024,-0.0851072,0.419675,-0.243031,-0.25162,-0.0141796,0.00351815,-0.0760015,-0.460426,0.243594,-0.342194,0.327798,-0.342251,-0.283998,0.25769,-0.412297,-0.824551,0.0484528,-0.0570489,0.236355,-0.0837769,-0.303368,0.125226,0.519973,-0.517969,-0.51638,-0.587718,0.407168,0.0178923,-0.424832,0.106857,0.0998125,-0.23104,-0.0657227,-0.0128821,0.411785,-0.101561,0.219596,-0.360993,-0.048598,-0.49236,-0.0656058,-0.27503,-0.252058,0.0176814,-0.0421346,0.149456,-0.052289,-0.0310069,-0.245377,-0.255361,-0.117729,0.686924,0.165838,-0.433952,0.585098,0.247638,-0.0391982,-0.387798,0.484608,0.152079,0.197363,0.389973,0.444256,-1.16839 +3432.74,0.781796,0.0912059,4,1.68359,0.967165,-0.441253,0.0883162,0.477277,0.0103738,0.24196,-0.121244,0.0944021,0.232205,-0.17621,-0.140525,-0.153663,0.290168,-0.280052,0.758832,0.0741094,0.303298,-0.248637,-0.0588009,-0.437565,-0.738997,-0.165263,0.0365088,-0.120971,0.000209795,0.111257,0.452088,-0.670514,-0.0652093,0.723766,-0.280303,-0.109102,0.069647,-0.284404,-0.130327,-0.390443,0.700512,0.133206,-0.746363,0.567416,0.611983,0.426886,-0.63153,-0.518658,-0.698808,-0.571333,0.241485,0.202488,0.0254599,-0.182774,0.0901942,-0.144082,0.200353,0.790077,-0.307307,-0.499235,-0.458097,0.540569,-0.543558,-0.158827,0.863372,-0.344687,-0.536869,0.576912,-0.316937,0.376456,0.459075,0.305896,-0.128815,-0.274701,-0.129225,0.532102,-0.458747,0.519484,0.463774,-0.0426091,0.249731,-0.437683,-0.108074,0.294555,-0.438826,-0.00316789,-0.758649,-0.0723864,0.219892,-0.0619598,0.00707761,-0.150793,-0.43508,-0.122717,-0.322047,0.154999,0.059533,0.0199051,-0.089446,0.237643,-0.234472,0.593987,0.566944,-0.199362,-0.256427,-0.6592,0.0763374,0.317265,-0.283069,0.154073,-0.516804,0.286718,1.02776,-0.115298,0.386254,-0.337395,0.362892,0.392641,0.42822,0.195699,0.151662,0.350616,0.210683,-1.01772,-0.880645,-0.604137,-0.687805,0.250547,0.32052,0.0641894,0.295748,0.194998,-0.441004,0.611351,-0.100585,-0.33076,0.544312,-0.471953,-0.26701,-0.107828,-0.276385,0.562369,-0.560316,0.0681883,-0.0143443,-0.264439,-0.945371,-0.552226,0.0423627,-0.0805761,0.350158,-0.213907,-0.26504,-0.0968992,-0.212406,-0.111188,-0.249075,0.388752,0.437551,0.552967,0.181782,0.226381,-0.74594,0.564107,-0.534229,1.03942,0.161374,-0.0120474,0.338035,0.0788077,-0.0781945,0.0508766,-0.64431,0.146499,-0.281409,0.0113432,-0.137043,-0.127934,-0.349939,-0.301446,0.293114,0.0671439,1.00357,-0.214187,-0.353248,0.698419,0.1976,0.127745,0.100142,-0.757016,-0.477271,0.196352,-0.50112,0.0192408,0.244019,-0.207833,-0.342423,-0.265493,-0.224129,0.0878438,0.117036,-0.830976,-0.315817,-0.198422,-0.0229686,0.0270179,0.0610228,0.0159557,-0.159344,-0.131039,0.614065,-0.489498,-0.0370574,0.141306,0.0455728,0.202938,0.0516364,-0.624862,0.609313,-0.0975983,0.553387,0.138439,-0.121719,-0.170496,-0.070818,0.125918,0.636762,-0.788053,0.219,-0.47533,0.360864,0.196409,-0.080274,-0.0748311,-0.100664,0.411926,-0.152804,0.0293382,0.161519,-0.0510002,0.673361,0.616062,-0.433685,0.160289,-0.15421,-0.120711,-0.265048,0.332264,0.435216,0.604304,-0.248606,-0.322846,-0.351253,-0.185936,-0.25287,0.467882,-0.443343,-0.393648,-0.081226,0.0892905,0.231978,-0.0224022,-0.0365969,0.167997,-0.0212479,0.221384,-0.148822,-0.0789318,0.0838403,-0.0930102,0.493243,-0.699336,-0.0447366,0.148645,-0.438062,-0.362222,0.140492,0.233584,-0.876258,-0.073986,0.0834707,0.193243,-0.530711,-0.0759303,0.11422,-0.636981,0.0872385,0.0720806,0.300371,0.19503,-0.395375,0.0233795,-0.385549,0.169271,0.0671678,0.532492,-0.301057,-0.0617499,-0.110281,-0.24557,-0.0393541,-0.217456,-0.446309,-0.191614,0.135378,0.152456,0.367937,0.390456,-1.46527 +3423.99,0.78324,0.0912059,4,1.42384,1.00201,-1.14107,0.418745,0.992523,-0.187026,0.118475,0.557598,0.745708,0.181768,-0.324093,-0.052247,0.0778397,0.442968,0.214447,0.834011,0.271049,0.271264,-0.150048,-0.159253,-0.458532,-0.871046,-0.68836,0.175716,-0.159998,0.269618,0.171599,0.135551,-0.430547,0.292007,0.714196,-0.67928,0.691716,0.258889,-0.0548532,0.202522,-0.543399,0.128676,0.944852,-0.843417,0.716351,0.208107,-0.017663,0.126396,-0.126101,0.953396,-0.208991,0.0538665,0.214366,0.22489,-0.395492,0.469243,0.379196,-0.437252,0.625371,-0.0146874,-0.123647,-0.481415,0.149766,-0.101751,0.22437,0.781451,-0.184794,-0.632937,0.0527703,0.546589,-0.349128,-0.025861,0.0366077,-0.430469,-0.0369794,0.962598,0.429858,-0.301614,0.620619,0.122148,-0.153261,0.2183,-0.572884,-0.273753,0.649991,-0.288712,0.0492213,-0.471642,-0.273061,-0.142151,0.312163,0.370405,0.0853359,-0.432976,-0.142684,-0.057781,-0.14204,-0.0167684,-0.103094,0.499488,0.608907,-0.353127,0.699068,0.584334,0.10842,-0.479264,-0.56091,0.289617,-0.151058,-0.339166,0.236878,0.048522,0.607023,0.526558,0.480265,-0.250007,0.283137,0.27092,0.465262,0.413775,-0.222561,0.28182,0.152093,0.251606,-0.910266,0.75828,0.33127,-0.59036,-0.268727,-0.110975,0.0548798,-0.0659682,0.630032,-0.443814,-0.295952,-0.239714,-0.444337,0.460914,-0.275601,-0.178837,-0.089134,0.00965291,0.644371,-0.278227,-0.431305,-0.136745,0.08942,-0.22005,0.0408954,0.578826,0.257699,0.396647,-0.145404,-0.170777,0.22063,0.148729,-0.0731025,0.261084,0.150481,0.139771,-0.450391,0.655948,0.636074,-0.272602,0.146745,-0.145978,0.903451,0.168897,-0.0178627,0.297386,0.140325,-0.548996,0.499004,0.568256,-0.0371621,-0.402679,-0.216015,0.0804963,-0.252739,-0.138364,0.102861,-0.163578,-0.0150389,0.618593,-0.112581,-0.203861,-0.397617,0.171954,-0.710188,-0.403859,-0.61564,-0.106638,0.0066111,-0.535797,-0.223696,-0.0467496,0.161096,-0.862604,-0.202964,0.529702,0.0729029,0.0268834,-0.973221,-0.352833,-0.0782434,-0.369924,0.198157,0.152419,0.446542,0.281851,-0.395036,0.86069,-0.0106765,0.282713,0.386055,-0.160444,-0.279638,0.162208,-0.426648,0.086136,-0.168358,0.333664,0.315843,-0.159185,-0.216253,-0.0995962,-0.217761,-0.0107935,0.063953,0.453996,-0.736396,-0.00773416,0.398597,0.108199,-0.705068,0.0744743,-0.378562,0.117991,-0.719264,0.659226,-0.640413,-0.167421,0.567456,-0.308376,-0.709897,0.112351,0.133221,-0.109199,0.265315,0.434129,0.836257,0.334956,-0.0736284,-0.448444,-0.0504136,-0.388787,-0.0188815,-0.906865,0.269858,0.700467,-0.399443,0.254186,-0.107749,-0.193255,0.193062,0.344531,0.142505,-0.264016,0.18891,-0.153809,-0.211724,-0.390627,0.232645,0.291284,-0.405487,-0.872053,0.129284,-0.0216569,0.410624,0.0395699,0.258731,0.103434,0.343822,-0.206265,0.0652724,-0.675983,-0.333469,0.34464,0.527963,0.0580595,0.250586,-0.159752,-0.204188,-0.0485817,-0.280547,-0.332645,-0.253314,0.269612,-0.0649527,-0.193505,-0.154253,0.284931,-0.636101,-0.275464,-0.21055,0.142644,0.200926,0.377682,0.448247,-3.39346 +3434.11,0.939078,0.0912059,4,1.52265,0.933542,-0.893052,0.258204,0.717657,-0.0935588,-0.193383,-0.0489721,0.0506335,0.551776,-0.0697064,-0.435538,-0.248513,0.393934,-0.489804,0.562559,-0.143351,0.495523,0.191892,-0.1929,-0.0407152,-0.487144,-0.147611,0.321529,-0.302037,-0.0739001,-0.0207206,0.484732,-0.0234944,-0.0749791,0.517554,0.0424362,-0.632514,0.203453,0.149012,-0.0779657,0.0749623,0.724424,0.0960887,0.0152779,0.881813,0.555579,0.50846,-0.598467,0.0749313,-0.290921,-0.278802,-0.200747,-0.0357236,0.297233,0.254358,-0.0881865,0.209609,-0.18693,0.920171,-0.294675,-0.49825,-0.695355,0.752978,-0.178004,-0.281869,1.01574,-0.750384,-0.704648,0.192765,-0.123984,-0.0095109,0.312313,-0.461856,0.163909,0.00580927,-0.239226,0.384768,-0.117327,0.483612,0.342637,-0.15046,-0.13608,0.242148,-0.0611767,0.25346,-0.309376,-0.0857112,0.294548,0.114469,-0.352246,0.0648151,-0.81933,0.246693,-0.14249,0.000919447,0.395677,0.393852,-0.131666,0.00834561,-0.514918,-0.116407,-0.189632,0.352251,0.227537,0.2043,0.570707,-0.500136,-0.235987,-0.138154,0.116706,0.421926,0.0125365,-0.0313634,0.547759,-0.11485,-0.000786607,-0.163107,0.27895,-0.125821,0.534056,-0.28258,-0.065679,-0.289723,0.185275,-0.26238,-0.071378,-0.684361,-0.292619,0.253817,0.27133,0.0569402,-0.190024,0.154185,-0.428796,0.0839847,-0.0517678,-0.286156,0.298669,-0.279069,-0.714392,0.122602,-0.247992,0.200921,-0.683304,-0.283458,-0.0373513,0.302297,-0.432998,-0.0443413,0.0302006,-0.00535318,0.51935,0.00248938,-0.130666,-0.101723,0.380559,0.227382,-0.519032,0.0270849,0.321195,0.832451,-0.107132,-0.0557876,0.470006,0.047472,-0.201586,0.591828,-0.563995,0.133498,0.553843,0.317452,-0.00320778,-0.443999,-0.583524,-0.203161,-0.593188,0.0106436,0.221343,0.737315,-0.0941417,-0.204774,-0.433352,0.912589,0.724022,0.170611,0.212392,0.251199,-0.0825564,-0.0821478,-0.262632,-0.164884,0.246812,0.496205,-0.220714,0.000180046,0.358717,0.173327,-0.177736,-0.0485222,-0.268834,-0.223826,-0.183671,-0.356607,0.154097,-0.216988,-0.83558,-0.152409,-0.251421,0.0933972,-0.730348,-1.02525,1.0195,-0.323146,-0.155274,-0.446501,-0.334399,0.292962,-0.0861474,0.107396,0.583355,-0.111949,0.129681,0.296327,-0.467652,-0.155479,-0.616998,0.429532,0.302193,-0.348698,0.912949,-0.105772,-0.128013,-0.117105,-0.444973,0.213029,-0.106339,-0.0419874,0.163949,0.0806325,0.402866,0.36152,0.881431,0.41258,0.183129,-0.0711555,0.473579,-0.0764364,0.0722205,0.337425,-0.480986,0.435422,0.263707,-0.0213003,-0.257683,0.00157261,-0.544224,0.485961,-0.034264,-0.399579,-0.0078567,0.0502182,-0.337485,-0.466805,-0.0437167,0.342632,-0.0108212,-0.0670267,-0.46937,-0.409258,0.142749,0.280768,0.142373,0.503726,0.189181,-0.160839,-0.0248684,0.434949,0.696215,0.245225,0.602075,0.202186,0.153753,0.519926,0.315426,0.00365777,0.201612,-0.590815,0.0324631,0.234051,0.219555,-0.254951,0.297134,0.304033,-0.27306,0.100242,0.520852,0.149336,0.104435,-0.0038037,-0.587176,0.190389,-0.15324,-0.0667855,-0.470083,-0.370224,0.114862,0.178358,0.338913,0.422324,-2.26253 +3426.85,0.962012,0.0912059,4,1.64357,0.955989,-1.115,0.373193,0.336903,-0.0832659,0.104552,0.126247,0.126688,0.150468,-0.0741224,-0.427098,-0.407656,0.148926,-0.283302,0.706375,0.12071,-0.0755496,-0.0316281,-0.208866,-0.549237,-1.09851,-0.972732,-0.0027502,-0.267945,-0.192873,0.00415299,0.485148,-0.548604,0.131106,0.501953,-0.843367,0.218806,-0.023532,-0.185998,0.0732665,-0.566049,0.255584,0.118137,-0.748295,1.11353,0.38352,-0.0803947,-0.509099,-0.0039854,0.206831,-0.555325,-0.406769,0.130241,0.107011,0.145907,0.313804,-0.041802,0.0675261,0.36755,-0.00375039,-0.321635,-0.618075,0.326222,-0.362479,-0.125579,0.774168,-1.21757,-0.272988,0.361337,0.409609,0.243432,0.35526,0.170145,-0.556277,0.639801,0.829224,0.653358,-0.437268,0.880224,0.624615,0.0769925,-0.172988,-0.187388,-0.0129542,0.626017,-0.385006,0.277904,-0.604907,-0.0321987,0.0207557,-0.201197,-0.0544071,-0.0192728,-0.0686957,0.0742513,-0.712846,0.169807,-0.50752,-0.478837,0.0132752,-0.0409127,0.166395,-0.496853,0.0619155,0.029616,0.309211,-0.117863,-0.406582,0.342197,-0.140311,0.223054,0.467886,0.283754,0.403596,0.163719,0.178061,-0.316556,0.504526,-0.00231479,0.673351,-0.378468,-0.241407,0.6367,-0.214688,-0.50302,0.261551,0.0880508,-0.0658554,0.15381,-0.0731643,-0.00327786,0.361199,-0.0721058,-0.265884,0.488281,0.0457388,0.296147,0.518878,-0.285628,-0.0673837,0.261721,0.363845,0.59016,-0.409288,-0.485324,0.00750485,0.457571,0.178835,0.240326,-0.198997,0.141804,0.354317,-0.153112,0.078369,-0.0484521,0.327718,-0.00398659,-0.153116,0.18357,0.694815,0.737505,-0.419036,-0.142876,-0.454697,-0.219878,0.407877,0.550732,-0.277818,-0.122909,0.556457,0.363165,-0.36902,-0.52288,-0.0270664,0.59171,0.323937,-0.0603038,0.508517,-0.329075,-0.1699,-0.316122,-0.340343,0.135109,0.919415,0.0347761,-0.560788,-0.313398,0.0281985,0.125929,-0.512329,-0.622598,-0.285619,0.0241528,-0.250981,0.0604047,0.352396,0.308963,-0.693269,-0.168555,0.367925,0.216437,-0.282781,-0.0697003,-0.806288,-0.267917,-0.220602,0.417729,0.201719,-0.257382,-0.2699,-0.431022,1.10622,0.0643096,-0.132029,0.0181889,-0.160095,0.286554,0.318686,0.14799,0.806115,0.0559005,0.243845,-0.225157,-0.760455,0.189593,-0.738538,0.477102,0.215651,-0.988938,0.633624,-0.550261,-0.389194,-0.109935,-0.134743,0.194857,0.183902,-0.251965,0.128434,-0.413554,0.433663,0.117942,0.244283,0.0883713,0.50185,-0.395583,-0.548176,0.297879,0.0861273,0.211284,-0.0941746,0.320592,0.225262,0.583844,-0.594385,0.0875576,-0.465313,0.263819,-0.445108,0.0644921,0.247323,-0.379368,-0.367195,-0.344126,-0.105277,0.0309549,0.686077,0.217867,0.196759,0.380173,-0.155143,-0.218313,-0.292132,-0.0314085,-0.270672,-0.20795,-0.319257,-0.553823,0.154752,0.248733,-0.0646248,0.0326232,0.556422,0.732891,-0.128005,-0.00417184,0.0895139,-0.180293,-0.107996,0.0720473,0.0631215,0.0951344,0.0969775,0.361835,-0.62202,-0.0508596,0.184173,0.0766103,0.822904,-0.0784004,-0.585891,1.01316,0.361063,-0.610146,-0.391308,0.370669,0.148176,0.184364,0.384936,0.429376,-0.912282 +3438.92,0.583859,0.0912059,4,1.64463,0.864106,-0.967496,0.389554,0.653854,-0.0015158,-0.420158,-0.149877,-0.0921461,-0.0970144,-0.0807087,-0.241992,-0.199233,0.521479,-0.381934,-0.0108844,-0.191835,0.149227,-0.233958,-0.0623356,-0.0554712,-0.515484,-0.0577116,0.00393748,-0.337439,-0.370972,0.0183322,0.379862,-0.527179,0.0116115,0.809354,-0.252716,0.454301,0.27731,-0.123883,0.00758512,-0.0686399,0.61652,0.404105,-0.0334523,0.69171,0.277946,0.197319,-0.732193,-0.19915,-0.408798,0.175471,-0.648503,0.000859266,0.0340931,0.223036,0.282593,-0.100011,-0.282323,0.534449,-0.484483,-0.232119,-0.952591,0.445205,-0.277359,-0.05466,0.901044,-0.692031,-0.86372,0.335313,0.0708484,-0.176669,0.766267,-0.659142,-0.648179,0.151911,0.366052,0.385989,-0.184342,0.822816,0.400968,0.187602,-0.166455,-0.53912,0.0911372,0.0221547,-0.264316,0.208614,-0.235877,0.119727,0.118734,-0.201475,-0.00496156,-0.246453,-0.0400747,-0.0460932,-0.348155,0.0311591,-0.118364,0.195703,0.0675054,-0.340376,0.258494,-0.390608,0.202965,0.500455,0.145325,-0.796765,-0.0527791,0.574895,-0.622042,0.386558,-0.208045,0.0540609,0.585449,0.803194,-0.0911797,0.351074,0.308065,-0.363671,0.122898,-0.00518075,0.0366496,-0.0252684,-0.390575,-0.0327183,0.2436,-0.231529,-0.212746,-0.212127,0.0840201,0.563819,0.0649815,0.277594,-0.245134,0.341416,-0.0607601,0.183991,0.705826,0.0478134,-0.148486,-0.296606,-0.205835,0.162933,-0.485541,-0.461848,0.222256,0.0996133,-0.0280703,-0.17821,-0.165612,0.161478,0.0263629,-0.0172215,-0.315329,-0.122196,0.290185,0.0865797,-0.149353,-0.566578,0.391706,-0.00625865,-0.0759982,0.341009,-0.20717,-0.176286,-0.327833,0.590971,0.149562,-0.867613,0.0352231,0.18348,-0.260022,-0.7782,0.297031,0.319216,-0.0912419,-0.0205539,0.233048,-0.0146731,0.363964,-0.154104,0.464279,0.407914,0.737604,0.350942,0.301862,0.01688,-0.283537,0.0495118,0.0883973,-0.142656,0.00940638,-0.0347661,-0.409811,0.0732259,0.242078,-0.0171542,-0.475429,0.300598,0.0480204,-0.238764,-0.0656986,-0.319916,0.0296221,0.0619893,-0.472938,-0.358014,-0.149195,0.0366021,-0.221216,-0.647676,0.675197,-0.265846,-0.417,-0.312798,-0.351532,-0.0843058,-0.185853,-0.139814,-0.112319,-0.496433,0.302192,0.295119,0.370961,-0.0924287,-0.415243,0.506144,0.0244755,0.0686566,0.584851,-0.222781,-0.419361,-0.174477,0.162196,0.321053,0.0190208,-0.180526,-0.155633,-0.372616,0.512732,-0.528882,0.0564301,0.471543,0.17666,-0.455419,-0.449208,-0.393704,0.543604,0.509897,0.553613,0.568135,0.0325212,-0.254257,-1.01509,0.112005,-0.271365,0.55625,-0.594604,-0.0433532,0.209085,-0.0873616,0.0875408,-0.303461,0.233049,0.567515,0.339183,0.248183,0.0878875,0.448615,0.294681,-0.128291,-0.120644,-0.185186,0.0739036,-0.514108,-0.547206,0.00832311,-0.0686038,-0.935338,0.165032,-0.244085,0.445027,0.218086,0.0457194,-0.140362,-0.283514,-0.102921,0.296964,0.313628,0.247914,-0.388186,-0.284342,-0.149942,-0.949091,0.0464013,0.109242,-0.236511,0.168189,-0.204554,-0.122011,0.346298,-0.262553,0.253385,-0.733419,-0.326199,0.11409,0.175179,0.337772,0.418544,-1.91445 +3448.38,0.826856,0.0912059,4,1.63665,0.963311,-0.690485,0.133303,0.639024,-0.140965,0.437591,0.248968,0.252156,-0.0826809,0.186591,-0.270487,-0.399724,0.486495,-0.0280248,0.782861,-0.36471,-0.250969,-0.0323638,-0.24689,-0.292047,-0.671133,-1.55047,0.0605729,-0.0156481,0.0946357,-0.410778,0.0524903,-0.595269,0.0167635,0.393297,-0.47041,-0.0605233,-0.337275,0.105218,-0.532654,-0.191291,0.194595,0.627345,-0.0995915,0.799976,0.342069,0.0224054,-0.221098,0.296425,0.282717,-1.10428,0.295597,0.447872,-0.0317965,-0.318177,0.314533,0.244479,-0.279031,0.970474,-0.141236,0.000670118,-0.452767,0.277754,-0.694366,0.160843,0.8474,-0.750253,-0.616375,-0.20164,0.118925,-0.206009,-0.468494,0.298614,-0.325919,0.161301,0.1776,0.262006,-0.447086,0.309739,0.530766,0.253976,0.175907,-0.286933,-0.232109,0.320642,-0.0192539,0.230831,-0.530467,-0.0401912,-0.215016,0.118889,0.175329,0.145774,-0.48499,-0.265599,0.177901,0.746251,-0.307972,0.105088,-0.549337,0.442911,-0.437136,-0.186355,0.414274,-0.0628722,0.226382,0.165283,-0.656431,0.254037,0.552764,0.00254053,-0.261868,0.576651,0.349652,-0.37536,-0.145564,-0.303804,0.153855,0.324702,-0.199285,-0.266459,0.488782,0.475931,-0.061912,-0.688789,0.440636,0.0104427,-0.72951,-0.200119,0.0582058,0.145256,0.233874,0.0176885,-0.669742,-0.287964,-0.590129,-0.179742,0.819146,-0.0120634,-0.0951479,0.183508,-0.0736507,0.364042,-1.00626,0.298831,-0.178137,-0.206025,-0.602618,0.524916,0.379268,0.149758,0.198377,-0.193024,-0.0625743,-0.461478,0.217188,-0.09862,0.368862,0.705557,0.153692,0.454879,0.00111069,0.145412,-0.3324,-0.0615086,-0.296795,0.54764,0.0305227,0.589662,0.655661,-0.046763,0.282578,0.165179,-0.160711,0.393347,0.149827,-0.176314,-0.21811,0.00191254,-0.460504,0.0083112,-0.53895,0.156251,0.64128,0.484292,-0.170135,0.019164,0.0962682,-0.426728,-0.781062,-0.0882466,-0.444861,0.109928,0.0904225,-0.482964,-0.415553,-0.094333,-0.378547,-0.186469,0.304854,0.286395,-0.285226,-0.999153,0.394467,-0.193883,-0.0810448,0.227529,0.259919,-0.180146,0.213872,0.158528,1.22002,-0.18944,0.270743,0.6812,-0.349143,0.632194,0.193085,0.318905,0.313564,0.106073,0.0735077,0.131898,-0.346062,-0.206818,-0.386647,-0.179299,0.115549,-0.123515,0.249167,-0.0748221,-0.345971,-0.328656,-0.0866893,-0.154864,-0.0188796,-0.0379798,0.154471,-0.0186295,0.557352,0.482331,0.0823894,0.407772,-0.281875,0.163403,0.220752,-0.0173816,-0.577929,0.161665,-0.0101844,0.233796,-0.0494903,0.333106,-0.160461,-0.342625,-0.47914,0.244728,-0.173031,-0.203906,0.20842,-0.436352,-0.408997,0.374471,-0.0280161,-0.643571,0.3005,0.118826,0.210462,0.10351,-0.158586,0.256788,0.0441027,0.000218665,0.450607,-0.265426,-0.187672,-0.430455,-0.0749303,0.266645,-0.0571787,0.40572,0.0374004,0.279262,0.156109,0.0239405,-0.0386844,-0.558862,-0.126275,-0.128473,0.136333,0.225954,0.213818,-0.067968,0.341432,-0.0239102,0.425767,0.100113,0.157541,-0.0873988,-0.110793,-0.167263,0.2004,-0.28743,0.440959,-0.451051,0.110539,0.143697,0.332474,0.379074,-1.91625 +3419.43,0.950874,0.0912059,4,1.62427,0.898526,-0.789605,0.207206,0.534167,-0.213629,0.162509,0.194101,0.107868,-0.232344,0.0629553,-0.326891,-0.293613,0.344199,0.17558,0.643416,0.143141,0.142452,-0.0953888,-0.0390938,-0.412975,-0.320547,-0.815119,-0.0500295,-0.133579,-0.332808,-0.00973785,-0.078111,0.167558,-0.025715,0.567712,-0.72214,-0.162973,-0.205835,0.331405,-0.556909,-0.451795,0.180137,0.178839,0.273054,0.652182,-0.0630355,0.345185,-0.790332,0.1379,0.250615,-0.814825,-0.206585,0.581484,-0.226374,0.28245,0.172651,0.0682274,-0.623364,0.984588,-0.000106243,-0.377192,-0.674443,0.586379,-0.525898,0.0949757,0.797314,-0.76565,-0.383307,-0.00219938,0.092542,0.208837,-0.249576,0.597588,-0.642018,-0.0923473,0.239381,0.197337,-0.246481,0.360586,0.21492,0.28398,0.0508414,-0.772439,0.0754378,-0.14036,-0.225271,0.228944,-0.530066,-0.329624,-0.403971,0.00610877,-0.0928274,-0.0989178,-0.318117,-0.38706,0.224497,0.363376,-0.440771,-0.511707,-0.264543,0.106914,-0.403163,-0.209889,0.24522,0.415677,0.479553,-0.184264,-0.719662,-0.138348,-0.17422,0.380784,-0.136345,0.93169,0.50122,-0.469281,0.0927298,0.762091,0.369565,0.0876328,-0.277982,0.0370819,-0.0849467,0.762917,-0.245576,-0.796644,-0.170635,-0.668945,-0.719052,-0.430548,0.0370449,0.375567,-0.174894,0.0171054,-0.234183,0.183467,-0.333497,0.00189617,0.114448,0.0407625,-0.0180695,-0.131608,-0.173334,0.391123,-0.386353,0.206694,-0.228381,-0.358853,-0.252713,0.331961,0.0435595,0.20671,-0.092368,-0.0561237,0.437741,0.0998475,0.539121,-0.492268,0.357683,0.0367103,0.135776,0.23277,-0.0502626,0.107937,-0.553032,-0.113768,0.0672599,0.738928,-0.384606,0.400596,0.43041,-0.110994,0.0225716,0.0348802,0.094337,0.0849639,-0.310638,-0.357394,-0.20861,-0.302401,-0.0342779,-0.360733,-0.364422,-0.0115321,0.835975,0.177394,-0.139444,0.546767,0.201672,-0.492575,-0.507718,-0.129168,-0.377985,0.219203,-0.0148232,-0.32281,-0.00373867,-0.394478,-0.976038,-0.070827,0.362527,0.242465,-0.407553,-0.867354,-0.272413,-0.0170005,-0.0651903,0.125216,-0.593441,-0.33481,0.316637,-0.577117,0.889104,-0.296833,0.252676,0.417756,-0.343208,0.402302,-0.11899,0.110103,-0.232224,-0.643041,0.604121,0.357779,0.0491917,-0.115882,-0.292309,-0.423371,-0.0246675,-0.848239,-0.0178727,-0.124025,-0.200673,-0.340951,-0.0193676,0.0657808,-0.220152,-0.24862,0.0914033,-0.268777,0.391688,0.362483,0.274314,0.628355,-0.433506,0.373769,-0.276347,0.0833507,-0.290427,0.119831,0.400462,0.0881624,0.118302,0.344727,-0.347061,0.116276,-0.627911,0.732399,-0.229368,0.14991,0.200993,0.150204,-0.405394,0.596545,-0.099055,-0.0662734,0.622166,0.713657,0.124282,0.293304,0.119229,0.258934,-0.282242,-0.459062,0.334918,-0.152065,-0.359828,-0.220332,-0.418306,0.394988,0.021659,0.212755,0.148061,-0.219243,0.106371,-0.298514,-0.00933059,-0.794335,-0.886456,-0.187142,0.119583,-0.00880175,-0.717556,0.274892,0.0236703,0.0467489,0.323117,0.150356,0.232122,-0.139976,-0.0687822,-0.2462,0.224063,-0.93005,0.467831,-0.173343,0.141616,0.18406,0.376318,0.429023,-1.46583 +3430.6,0.578684,0.0912059,5,1.70904,0.924942,-0.259581,0.0356798,0.354885,-0.23529,0.347215,0.162823,0.115236,0.377428,0.140248,-0.277781,-0.30909,0.673271,0.0963749,0.666167,-0.0200146,-0.157471,-0.281565,-0.195214,-0.24186,-0.24664,-0.84186,0.301729,-0.152376,-0.178093,-0.200328,-0.0724682,-0.406626,0.000314585,0.677411,-0.41962,-0.286554,-0.0770178,0.114969,-0.307011,-0.129594,0.0453664,0.196065,0.0515809,0.785316,0.339666,-0.0859241,-0.447729,-0.115976,0.0719497,-0.790505,0.0307153,0.447207,-0.580978,-0.22197,0.441012,-0.0199716,-0.39213,0.900945,-0.177086,-0.0885745,-1.06777,0.558808,-0.301739,0.336909,0.912733,-1.05604,-0.728753,0.119428,-0.0375227,0.262441,-0.262979,0.571912,-0.535844,-0.120996,0.392751,-0.0307933,-0.263032,0.767829,0.365717,0.291692,-0.0394836,-1.02277,0.0785833,0.0862438,-0.305632,0.268729,-0.238749,-0.50381,-0.780186,-0.206898,-0.0740746,0.189559,-0.446013,-0.229983,0.154805,0.137913,-0.24672,-0.443872,-0.21164,0.425295,-0.424041,0.0939017,0.261469,-0.0113062,0.281997,-0.513105,-0.625184,0.0677142,-0.110776,0.418944,-0.932028,0.795709,0.637549,-0.200572,-0.379467,0.41318,0.154371,0.352296,-0.22467,-0.288933,0.200978,0.816743,-0.402304,-0.756364,-0.151447,-0.166988,-0.522493,-0.263364,0.404495,0.646469,0.131954,0.304847,-0.536059,0.590014,-0.130508,-0.0718951,0.119747,-0.121656,-0.304199,-0.296437,-0.220137,0.204588,-0.493441,-0.0256355,-0.0461532,-0.229118,0.0212597,0.0811558,0.517822,-0.247785,0.0883991,-0.474621,0.109072,-0.140191,0.372396,-0.208368,0.462469,0.162476,-0.350135,2.90413e-05,-0.133969,0.0760657,-0.0125115,-0.240757,0.209046,0.518647,0.0105777,0.295955,0.187626,-0.063169,-0.12812,-0.443631,0.441533,0.143353,-0.209379,-0.136962,0.240226,-0.531435,-0.166273,-0.398671,-0.152146,-0.439359,0.823801,0.449083,-0.559836,0.52054,-0.0368582,-0.00178287,-0.181212,-0.475662,-0.469944,0.0497209,0.123836,-0.152981,-0.167033,-0.497454,-0.781921,-0.427616,0.334762,0.191351,-0.461233,-0.912319,0.213074,-0.375109,0.0536924,0.0139416,-0.527614,0.0323109,-0.445249,-0.435631,0.961121,-0.141878,0.0171431,0.38675,-0.289716,0.360351,-0.149782,-0.0351528,0.238534,-0.470513,0.204967,0.118959,0.320662,-0.530708,-0.140547,-0.189732,0.231366,-1.14042,0.292443,-0.654512,-0.326136,0.00337305,0.263788,-0.153399,0.0109267,-0.11174,-0.109645,-0.179326,0.330385,0.196469,0.28152,0.27799,-0.471103,0.230769,-0.471361,-0.157272,-0.022211,-0.133476,0.347562,0.371577,-0.111087,0.113894,-0.414616,-0.208734,-0.577207,0.559032,-0.389985,0.172824,0.233061,-0.168681,0.0719423,0.691656,-0.0735606,0.514313,0.714345,0.240191,-0.135122,0.372454,0.151241,0.0585246,-0.54541,-0.0260538,0.443061,-0.231019,-0.152522,-0.609332,0.280738,-0.00468745,-2.85801e-05,0.219429,0.290971,0.136081,0.198985,-0.0549665,0.275113,-0.484717,-0.75087,-0.293595,0.119562,-0.00857297,-0.23853,0.128359,0.0290011,0.147641,0.0899289,0.26455,0.297116,-0.323729,-0.135834,-0.102542,0.108814,-0.569819,0.429273,-0.253365,0.119603,0.227879,0.345837,0.477367,-0.942983 +3432.49,0.999842,0.0912059,4,1.64855,0.914213,-0.852775,0.269777,0.43174,-0.151618,0.344609,-0.0773803,0.841054,0.358164,-0.13784,-0.42136,-0.353382,0.455481,-0.0657113,0.930785,-0.0744456,-0.118377,-0.377727,-0.0360574,-0.235071,-0.498399,-0.913709,0.287196,-0.090361,0.0366618,0.252667,-0.167146,-0.566188,-0.0497046,0.709381,-0.267325,-0.0761293,0.0273753,-0.217444,-0.238901,-0.170632,0.14651,0.488348,-0.209212,0.678289,0.137305,-0.0466418,-0.57548,-0.00346809,-0.84681,-0.580087,0.388602,0.720977,-0.37187,-0.0327112,0.35926,0.0944867,-0.248389,0.604007,-0.363729,0.120906,-0.949745,0.396786,-0.401626,0.302453,0.796749,-1.06457,-1.27495,-0.425693,-0.260229,0.379163,-0.0780604,0.163185,-0.363386,-0.306887,0.133848,0.0926266,-0.683043,0.78856,0.393613,0.515609,-0.0954133,-0.59906,-0.0944495,-0.1872,-0.239026,-0.16006,-0.302664,-0.471208,-0.214427,0.0916182,-0.177184,-0.167555,-0.507254,-0.0272635,0.13319,0.0260307,-0.133451,-0.151519,-0.647638,0.0915279,-0.404455,0.356979,0.405678,-0.490549,-0.0405696,-0.634106,-0.75003,0.101564,-0.237484,0.367829,-0.705509,0.539426,0.427863,-0.0512011,-0.233379,0.156224,0.355693,0.486495,-0.0522334,0.0417676,0.109769,0.527252,-0.290827,-1.19263,-0.0829691,0.364352,-0.388715,-0.366556,0.233761,-0.216586,0.193597,0.195946,-0.536948,0.167534,-0.140979,0.159529,0.455877,-0.150076,-0.149738,0.0117191,-0.162529,0.505803,-0.251805,0.0970187,-0.237228,-0.347595,-0.0215032,0.0360526,0.205712,-0.194182,0.528575,-0.296543,0.0654315,-0.596715,0.0980451,-0.644623,0.233611,0.00687862,-0.221283,-0.157901,-0.0651736,-0.0669641,0.197674,0.0974857,0.154158,0.73472,-0.109038,0.0655381,0.456109,-0.0695144,-0.0244877,0.129213,0.445136,0.00596646,-0.153467,-0.0841866,0.516049,0.0129635,-0.410615,-0.128638,0.109003,0.240926,0.587314,0.295323,-0.378641,0.526346,-0.215139,0.0256641,-0.263402,-0.480199,-0.735503,0.102986,0.0954535,-0.131412,-0.00107363,-0.640655,-0.497417,-0.305483,0.416216,-0.125819,-0.348417,-0.885412,-0.311899,-0.521193,0.031204,-0.279066,-0.0276443,0.200599,-0.448979,-0.1108,0.833183,0.1682,-0.154448,0.159427,0.130116,-0.123105,-0.213533,-0.101366,0.255536,-0.847438,0.390129,0.0527607,0.25142,-0.189557,-0.447598,-0.14219,0.19322,-0.754744,0.111431,-0.590488,0.0567449,0.437605,0.469863,-0.137232,0.243816,-0.379143,-0.225027,-0.119724,0.359543,-0.187637,0.00999415,0.22239,-0.725397,0.250604,-0.516993,0.0787127,0.0344584,0.145959,0.0772481,0.341556,0.128445,0.526329,-0.456454,-0.0815547,-0.172916,0.461317,-0.801497,0.327764,0.615073,-0.447464,-0.186194,0.949129,-0.417021,0.533083,0.930971,0.291805,0.0870446,0.325259,0.306401,0.0435275,-0.0835332,-0.562651,0.333785,-0.385473,-0.350522,-0.526303,-0.0510583,-0.276357,0.233949,0.249499,-0.0134457,0.363408,0.26802,0.108754,0.252019,-0.385993,-0.411068,-0.0207747,0.204043,-0.193191,-0.104606,0.104094,-0.0774847,0.174498,-0.115916,0.202873,-0.091504,-0.140487,-0.215285,-0.517249,-0.170262,-0.201438,0.315033,0.132592,0.160006,0.206746,0.400007,0.454693,-1.1709 +3420.56,0.959652,0.0912059,4,1.66197,0.964436,-0.303621,-0.0101794,-0.0671596,-0.110482,0.166569,-0.286122,0.418861,0.325748,0.0626325,0.300806,-0.235175,0.443834,-0.113493,0.37506,0.0385994,0.0067513,-0.375846,0.0785908,-0.30333,-0.644777,-0.785413,0.116574,-0.366253,-0.146048,-0.12721,0.243575,0.0276772,-0.136148,0.715382,-0.106483,7.19849e-05,0.0516623,-0.282228,0.0349725,-0.414432,0.138446,0.351099,-0.43727,0.835766,0.440636,-0.300106,-0.477717,-0.208734,-0.264144,-0.264746,0.242789,0.482569,-0.473421,0.111397,0.316261,0.101431,-0.280355,0.953546,-0.810078,-0.143724,-0.87994,0.101055,-0.696458,0.240196,1.21148,-1.06377,-1.75044,-0.257174,-0.565292,-0.0140685,-0.0294913,-0.207521,-0.57231,-0.341383,-0.362542,0.569676,-0.32456,0.588362,0.384805,0.498995,-0.716551,-0.430956,-0.0434985,-0.152199,-0.778811,-0.325365,-0.0756367,-0.39097,-0.640077,0.00242186,-0.280119,-0.191568,-0.496981,-0.487156,-0.0175208,0.143895,-0.0277248,0.865106,-0.017454,0.409872,-0.700323,0.118186,0.504603,-0.053438,0.123634,-0.605465,-0.37245,0.49393,-0.398683,0.080492,0.0191482,0.166179,0.599882,-0.228745,-0.156575,0.139706,0.374408,0.206183,-0.0800351,0.114795,0.454562,0.256297,0.450622,-0.43061,-0.110181,0.263297,-0.0500347,-0.521356,0.342756,0.146101,-0.429636,-0.207339,-0.803656,0.0866184,0.0375999,0.12538,0.897258,0.14201,-0.549726,-0.0983197,-0.0474653,0.236113,-0.242958,-0.601667,0.13254,-0.050828,-0.710626,-0.129452,0.259732,-0.186536,0.432025,-0.534818,-0.0183126,-0.323697,-0.253825,-0.123149,-0.056665,-0.614151,-0.211129,0.135782,-0.054561,-0.0359818,0.0129318,0.568931,0.000120155,0.591738,-0.222839,-0.151515,0.377918,-0.569756,-0.0290113,0.160911,0.182321,-0.0869297,0.263077,-0.0275219,0.0784086,-0.173917,0.340952,0.0399257,-0.0556574,-0.0293053,0.537083,0.514226,0.098681,0.546673,-0.551476,0.219296,-0.254435,-0.516536,-0.368072,0.264439,0.078893,-0.102869,0.104161,-0.123817,-0.465835,0.292495,-0.10955,-0.174726,-0.573112,-0.838815,0.579661,-0.150144,-0.424903,-0.0277659,-0.0750243,0.349604,-0.235572,-0.44312,0.877267,-0.170979,0.311854,0.173589,0.205842,0.147692,0.287063,0.168777,-0.10495,-0.748928,0.562093,-0.127162,0.344899,-0.154809,-0.265911,-0.49453,-0.0838815,-0.947727,0.149946,-0.243972,-0.152106,-0.485261,-0.102768,-0.8731,-0.202165,-0.0784473,-0.227772,0.156195,0.664982,-0.0727669,-0.208472,0.124466,0.0234121,0.32944,0.341143,0.188106,0.0718987,-0.0225507,-0.241707,0.218193,-0.224386,0.21406,-0.239126,0.186867,0.00976829,0.222394,0.0138597,0.349596,-0.108093,-0.669288,-0.246214,0.273678,0.151706,0.589326,-0.0341991,-0.0318414,0.225317,0.502897,0.523188,-0.0243088,-0.207124,-0.336785,-0.0199531,-0.130127,-0.860143,-0.295259,0.821817,-0.242368,-0.124803,-0.121915,0.135258,0.356296,0.22227,-0.300531,0.493776,-0.548074,-0.191546,-0.066669,0.14157,-0.429762,0.0856091,-0.0319397,-0.235786,-0.0978595,0.554827,-0.175818,0.660252,-0.167384,-0.262154,0.154558,-0.1391,-0.346285,-0.0470993,0.632701,0.106787,0.245023,0.326783,0.494998,0.37665 +3425.61,0.989186,0.0912059,4,1.66525,0.955092,-0.330852,-0.000403871,-0.0922797,-0.107954,0.188923,-0.268444,0.399953,0.355402,0.0919167,0.30188,-0.221384,0.435191,-0.111884,0.383416,0.0373787,-0.00642202,-0.37498,0.116978,-0.331915,-0.636344,-0.738582,0.107833,-0.385708,-0.169232,-0.131921,0.228797,0.0559456,-0.125638,0.69876,-0.0944174,-0.0387088,0.0760662,-0.266554,0.03095,-0.416686,0.118498,0.385855,-0.444863,0.858602,0.456667,-0.334255,-0.495694,-0.211706,-0.285016,-0.277451,0.249356,0.495834,-0.49842,0.116467,0.32477,0.0825246,-0.283453,0.968352,-0.845852,-0.150755,-0.855624,0.0764285,-0.683352,0.276985,1.24852,-1.00242,-1.74387,-0.214515,-0.518167,0.0115667,-0.00477607,-0.230617,-0.574855,-0.355619,-0.300159,0.603733,-0.322309,0.603542,0.387633,0.472016,-0.713281,-0.40909,-0.0820289,-0.108823,-0.757834,-0.302262,-0.0651554,-0.417439,-0.649811,0.00293547,-0.279258,-0.23355,-0.526023,-0.475803,-0.0347717,0.16304,-0.026755,0.855455,0.0279825,0.432962,-0.679967,0.0974378,0.472875,-0.0315091,0.0974562,-0.609565,-0.344786,0.488549,-0.39579,0.0778276,0.00167647,0.166412,0.587488,-0.196383,-0.216152,0.125546,0.34381,0.18189,-0.0352837,0.126432,0.44125,0.30366,0.404025,-0.478294,-0.135856,0.246948,-0.0244479,-0.535774,0.322238,0.147648,-0.469744,-0.235259,-0.790763,0.151212,0.0411421,0.100633,0.885267,0.191894,-0.51576,-0.0945522,-0.0540718,0.244873,-0.291881,-0.572131,0.10291,-0.0803177,-0.701882,-0.167134,0.283917,-0.164633,0.434833,-0.556606,-0.0395014,-0.325855,-0.21828,-0.125901,-0.0214102,-0.628069,-0.108919,0.130141,-0.0692568,-0.062751,0.0296744,0.545529,-0.00805027,0.566553,-0.255801,-0.109181,0.347959,-0.532278,-0.0301698,0.159212,0.162608,-0.0813896,0.286696,-0.0089064,0.0927006,-0.15714,0.345765,0.0505361,-0.032046,0.0429174,0.530846,0.491398,0.0902148,0.535548,-0.525613,0.17641,-0.216938,-0.506344,-0.360561,0.27935,0.0709789,-0.0912223,0.124897,-0.109312,-0.489605,0.316509,-0.00733872,-0.184556,-0.600305,-0.814064,0.55834,-0.125902,-0.405825,-0.00877373,-0.0779314,0.309723,-0.283273,-0.414138,0.866744,-0.167134,0.357366,0.176308,0.168557,0.141984,0.339769,0.132493,-0.0848874,-0.733514,0.545158,-0.111244,0.290018,-0.138204,-0.245783,-0.472924,-0.0936049,-0.898866,0.210085,-0.229681,-0.165641,-0.496935,-0.0950152,-0.882242,-0.201317,-0.0457359,-0.210834,0.130915,0.64088,-0.101114,-0.214159,0.0873206,0.0503596,0.323589,0.362992,0.251132,0.0852806,-0.0128252,-0.228075,0.235914,-0.243374,0.191342,-0.200074,0.166441,0.00104143,0.206029,-0.035817,0.376865,-0.0886048,-0.678079,-0.268067,0.283722,0.140265,0.593627,-0.0132856,-0.0833282,0.205382,0.533431,0.499963,-0.0318306,-0.164004,-0.323419,-0.0430173,-0.107755,-0.789702,-0.286883,0.836905,-0.265172,-0.118348,-0.105767,0.129407,0.357312,0.253752,-0.318477,0.489386,-0.528626,-0.181346,-0.0556675,0.102954,-0.41326,0.0912936,-0.0256417,-0.259608,-0.0577533,0.533903,-0.155642,0.661577,-0.153787,-0.314987,0.193568,-0.135398,-0.32708,-0.0519499,0.582996,0.107913,0.242776,0.328502,0.492723,0.48425 +3425.04,0.918272,0.0912059,4,1.65017,0.820986,-0.601091,0.167463,0.353911,-0.0729236,0.248398,-0.13258,0.276712,0.339403,0.224136,0.334266,-0.0442076,0.449107,-0.0367695,0.551536,0.0323591,0.0285785,-0.458973,0.142054,-0.0949564,-0.625556,-0.757207,0.204955,-0.26244,-0.250554,0.0721052,0.00497339,0.0205185,-0.136709,0.83308,-0.199109,0.209795,0.109158,-0.149094,-0.060048,-0.732955,-0.108445,0.742727,-0.294241,0.719796,0.685654,-0.330458,-0.519181,-0.077944,-0.293002,-0.00201562,0.357247,0.53907,-0.191526,0.087722,0.277036,0.206859,-0.503213,1.06939,-0.768219,0.016997,-0.594456,0.237634,-0.605719,0.101702,1.03703,-1.17159,-1.27253,-0.221561,-0.318811,0.323078,-0.234407,-0.202378,-0.653738,-0.251213,0.192936,0.59934,-0.0369125,0.590641,0.601364,0.346262,-0.46336,-0.336432,-0.00601563,-0.292376,-0.4663,-0.231159,-0.160086,-0.316685,-0.657795,0.516528,-0.303231,0.158958,-0.452457,-0.246427,0.206856,0.528659,0.0773339,0.389987,0.0481384,0.473835,-0.475597,0.0629452,0.314291,-0.393514,-0.32946,-0.902426,-0.00719254,0.36922,-0.670507,0.0606973,0.137383,-0.0207154,0.835558,-0.134531,0.0118805,0.440108,0.249923,0.150342,-0.311333,-0.250492,0.243436,0.204719,-0.0567331,-0.168573,-0.202096,0.268888,-0.271739,-0.148335,0.29277,0.320451,-0.579548,0.0723862,-0.837132,0.488388,-0.0605636,-0.105987,0.711834,0.244896,-0.497048,0.257357,-0.0982612,0.339267,-0.368133,-0.815114,0.377074,-0.0323387,-0.898885,-0.237302,0.223587,-0.349787,0.096286,-0.301667,-0.103167,-0.553712,0.104458,0.0150687,0.317439,-0.265193,0.251302,0.12284,0.195789,-0.00103426,-0.220079,0.261593,0.238961,0.534891,-0.0391169,0.0493594,0.405089,-0.340129,-0.178694,-0.0414018,0.421762,-0.086807,0.0252721,-0.161537,0.144853,0.0528718,0.582025,-0.0633327,-0.0431841,-0.262212,0.557022,0.516806,0.37394,0.313966,-0.678766,-0.0862529,0.22388,-0.545677,-0.843483,-0.129516,0.0797752,-0.300541,0.274561,-0.324357,-0.309903,0.0847084,0.306794,0.089473,-0.500266,-0.54242,0.673712,-0.177577,-0.238309,0.129,0.221931,0.0574756,-0.526352,-0.662666,0.844317,-0.0953684,0.560442,0.406187,0.162121,0.287301,0.63239,-0.242851,0.142843,-0.348449,0.598667,-0.269351,0.236172,0.250924,-0.210321,-0.377948,-0.0420902,-0.935455,0.277248,-0.113643,-0.377902,-0.378348,-0.225092,-0.886997,-0.243286,-0.0821813,-0.163445,0.407524,0.891627,-0.0722324,0.130041,0.369877,0.115236,0.0796575,0.470667,0.132812,0.357934,0.135646,0.0197496,0.254987,-0.177395,-0.0794663,-0.168136,-0.0174129,-0.131342,0.471229,-0.351647,0.472732,-0.146447,-0.53813,-0.531851,0.379259,0.190456,0.727899,0.0892139,-0.136639,0.320012,0.332553,0.359095,0.0116819,-0.0278567,-0.678661,0.0217105,-0.299551,-0.517873,-0.308167,0.629335,-0.493616,0.0056812,-0.156645,0.165508,0.265138,0.307251,-0.0899154,0.599788,-0.507549,-0.159636,-0.309122,0.162609,0.0880093,-0.228602,-0.111117,-0.449294,-0.234306,0.123464,-0.063826,0.251344,0.258368,-0.363421,0.394088,-0.071814,-0.221369,-0.300826,0.683987,0.151834,0.272728,0.389659,0.522234,-0.800965 +3419.29,0.963636,0.0912059,5,1.69159,0.877831,-0.792579,0.279904,0.823267,-0.0308067,-0.365507,0.0832055,0.00793382,-0.53126,0.094083,-0.224368,-0.0496961,0.340843,-0.0917456,0.727887,0.171578,-0.225232,-0.267105,-0.114162,-0.194967,-1.1332,-0.693254,0.0357021,-0.31272,-0.282069,0.0596101,0.439294,-0.690546,0.0915246,0.79677,-0.586963,0.0214798,0.112205,0.000264805,-0.310935,-0.289526,0.60579,0.517536,-0.504961,0.783692,0.28826,0.532683,-0.31367,-0.742029,0.0741227,-1.25763,-0.196753,0.215418,0.495451,-0.306886,0.374738,0.188789,-0.244041,0.387607,0.0701128,-0.636321,-1.02018,0.530386,-0.287575,0.284156,1.01719,-0.509974,-0.743139,0.167436,0.581269,-0.575321,0.400134,0.382013,-0.406217,-0.143182,0.262258,0.419509,-0.0599038,0.600671,0.390913,0.121817,0.66176,-0.146359,0.190288,1.11148,0.0507989,0.440923,0.230508,0.404071,0.199021,-0.34481,-0.152103,-0.112686,-0.46637,0.302731,-0.105826,-0.0243585,-0.201929,-0.141456,-0.479282,-0.221784,0.0490406,0.226183,0.249511,0.392975,0.357079,0.251548,-0.0717995,-0.145618,0.172817,-0.0280554,-0.581731,0.125881,0.54267,0.039495,-0.207884,-0.337922,0.642266,-0.193962,0.520174,-0.147198,0.199369,0.285648,-0.192512,-1.04228,0.295783,-0.347506,0.137161,0.0185084,-0.210953,0.224405,0.976854,-0.0121283,0.131606,-0.361032,-0.0951179,0.156414,0.260944,-0.341964,0.225953,-0.0476105,-0.119163,0.204221,-0.459357,0.488988,-0.189498,0.32049,0.531098,-0.0557258,0.116804,0.112345,0.355116,-0.414166,-0.0305563,0.341484,0.423196,0.0475962,-0.251302,0.616585,0.543856,0.160976,-0.169937,0.154893,0.0713621,0.0595337,-0.277604,1.16143,-0.0650417,-0.153973,-0.596834,0.222952,-0.312255,0.140397,-0.468849,0.362355,-0.268089,0.306777,-0.201649,-0.14257,-0.652799,-0.0569272,0.0853636,0.375357,0.664123,-0.15996,-0.334513,0.000278258,0.552677,-0.0544018,-0.401357,0.198873,-0.0266249,0.319003,-0.68901,0.0700928,-0.357217,0.434037,-0.416585,-0.121931,0.241991,0.017575,0.109533,-0.374556,-0.411563,0.292552,-0.0284467,0.344483,-0.65829,0.0147047,0.313333,-0.177527,0.643293,0.0983972,-0.180776,-0.0313308,-0.582547,0.0846138,-0.490598,0.0753968,0.183281,0.0289965,-0.288039,0.547644,-0.681107,-0.273495,-0.209184,0.272953,0.393001,0.0785568,0.434759,-0.634027,0.320088,0.382457,0.304921,0.291306,0.368445,-0.182741,-0.0620769,-0.921833,0.333906,0.196978,-0.219886,0.500327,-0.449807,-0.314542,-0.263186,-0.325232,-0.558574,0.589567,0.225207,0.0226257,0.228693,-0.0869355,-0.692441,-0.107074,-0.78972,0.418548,-0.175582,-0.67783,0.384717,0.0679409,0.568774,-0.11582,0.0357664,-0.517462,0.652919,0.000280506,0.0251434,-0.301739,-0.336525,-0.379429,-0.152771,0.68826,0.37039,-0.203664,0.171124,-0.109449,-0.362505,0.3989,-0.0820029,0.139069,-0.347747,0.157442,-0.345674,0.15067,-0.71569,0.243732,0.0649933,0.366091,-0.226636,0.0272983,0.541124,0.176011,0.154596,0.131664,-0.095359,0.0605294,0.0709559,-0.175495,-0.229749,-0.653046,-0.170333,0.0856757,0.0582018,-0.721071,0.137393,0.271452,0.370666,0.521011,-2.43475 +3414.81,0.993913,0.0912059,4,1.73666,0.680905,-1.10375,0.249374,-0.0502963,-0.257491,-0.423294,0.186226,0.32765,-0.0191112,-0.289127,-0.594889,-0.392078,0.203319,0.402697,0.2676,-0.0780805,-0.15338,-0.594636,-0.240866,-0.485156,-0.981153,-0.777896,0.239323,-0.832203,-0.731109,-0.274815,-0.457451,0.0305112,-0.380985,0.504994,-0.656263,-0.581299,-0.0800069,0.170521,0.290993,-0.068448,0.0937166,0.00995258,-0.115939,0.820338,0.56351,-0.103093,-0.828902,0.123768,-0.195817,-0.543237,0.634941,0.385782,-0.397397,0.264848,-0.00574404,0.182439,-0.437386,0.873203,-0.468977,0.206181,-0.367322,0.126285,-0.745351,0.0975133,0.823046,-0.615409,-1.33037,0.286637,-0.012919,0.0637236,-0.591326,0.0576738,-0.21049,0.312135,0.313184,0.715187,-0.591559,0.499605,0.598268,0.669551,-0.088878,-0.361694,0.356132,-0.0110568,-0.707479,-0.0441328,0.0711499,-0.134236,-0.343167,-0.223153,-0.0626466,0.299482,-0.531517,-0.310229,-0.0482863,0.0448842,-0.28825,-0.14724,-0.711797,0.215621,-0.344426,0.353427,0.0885893,-0.0737407,-0.347009,-0.955675,-0.330412,0.0914649,-0.256996,0.41098,0.24459,0.333912,0.894762,-0.416453,-0.311155,0.423193,0.630506,0.340147,-0.0807371,-0.285078,0.301692,0.576241,0.137437,-0.753217,-0.218389,0.228626,-0.620666,-0.038541,0.0960539,0.0675516,0.115459,0.467345,-0.495608,0.218066,0.148198,-1.08561,0.650344,0.140008,-0.207907,0.166153,0.0369859,0.747783,-0.355545,-0.774006,0.0959156,0.299296,-0.859462,0.18939,0.106654,-0.583053,0.115006,-0.184942,0.026993,-0.223129,-0.126971,-0.345929,0.0788575,0.00525262,0.396182,-0.0534347,-0.0307322,-0.0926634,-0.240087,-0.0204127,0.0970185,0.540751,0.564951,0.511355,-0.0485824,-0.158041,-0.102554,-0.165387,0.507501,0.107354,0.183396,-0.0499499,-0.303115,-0.030245,0.205457,-0.360823,-0.574966,0.115173,0.79645,-0.384267,0.111905,0.254654,-0.00978014,-0.534315,-0.926531,-0.646034,-0.455208,0.0388193,-0.00575529,0.0313416,-0.226922,-0.162778,-0.330003,0.246703,0.338303,0.385454,-0.587413,-0.600608,-0.301639,-0.361447,0.117091,0.485614,-0.203315,0.272047,-0.50833,-0.384065,0.759573,0.0247385,0.135725,0.0902824,-0.251431,0.276157,0.179423,-0.0973051,0.564836,-0.0804265,0.451644,-0.0667855,-0.207993,0.367266,-0.0333464,-0.322647,0.346918,-0.831029,0.679668,-0.0197357,-0.686322,-0.589347,-0.203156,-0.683988,0.101643,-0.0479989,0.183355,-0.0565249,0.805953,0.254916,-0.23384,0.5687,-0.071727,-0.399443,0.323098,0.296424,0.196189,-0.300654,-0.0247683,0.790036,-0.00247589,0.00462992,0.082453,-0.686266,-0.321025,0.449273,-0.46911,0.184616,0.164293,-0.0401077,-0.211692,0.24747,0.0506616,0.710217,-0.167703,0.247096,0.564279,0.178081,0.717562,0.0138025,-0.367996,-0.159255,-0.102177,-0.326792,-0.442791,-1.04149,-0.0592813,-0.105944,-0.550908,-0.0612837,0.561108,0.404255,0.177557,-0.249699,0.316511,0.416822,0.0843271,0.049965,0.684055,0.122842,0.258697,-0.497867,-0.787607,0.196369,0.191689,-0.0699458,0.68909,0.300839,0.167939,0.43344,0.333521,-0.395367,-0.219397,-0.0711744,0.156962,0.246471,0.396185,0.496459,1.10763 +3389.23,0.717209,0.0912059,4,1.65285,0.669022,-1.71531,0.435385,-0.158152,-0.197714,-0.48863,-0.476378,0.316229,-0.168765,-0.217938,-0.541421,-0.842923,0.231113,0.277247,-0.0139077,-0.328859,-0.328093,-0.641303,-0.173448,-0.385065,-0.952585,-0.709902,0.205228,-0.817371,-0.540326,-0.435009,-0.464141,-0.285842,-0.599336,0.74251,-0.973032,-0.798134,-0.18721,0.212751,0.205797,-0.480446,0.510865,-0.106728,-0.561576,1.34615,0.687306,0.299976,-0.331023,0.0336025,0.290696,-1.02933,0.341554,0.676134,-0.315243,0.167687,0.0532581,0.507022,0.0320098,0.691294,-0.0364415,0.0380154,-0.481383,0.308324,-0.217465,0.452209,0.951207,-0.386134,-0.760637,0.340063,-0.469334,0.465404,-0.536058,0.3882,-0.467653,0.668619,0.423782,0.637384,-0.556711,0.613553,0.619359,-0.142295,0.133388,-0.21748,0.0229089,0.330473,-0.0361192,0.250774,0.400253,-0.153275,0.349799,-0.517008,-0.649516,0.443913,-0.438185,-0.197759,0.234564,-0.241352,-0.449441,0.0119302,-0.677673,-0.175084,-0.28506,0.290903,0.166257,0.283139,0.0187646,-0.819266,-0.134719,0.204952,0.0726527,0.782534,-0.226843,0.446393,0.791123,-1.42365,-0.427148,0.147926,0.532382,0.280959,-0.0343957,-0.11172,0.729602,0.335224,0.243912,-0.505404,0.668499,0.368429,-0.4804,-0.679892,0.290089,-0.48575,0.119845,-0.0608783,-0.0112937,0.279993,0.335939,-0.922035,0.486208,0.236955,-0.506072,-0.0700282,-0.436402,0.242358,0.34349,-1.07453,-0.126198,0.143415,-0.850635,0.210267,0.123271,-0.866521,0.483763,0.0681036,-0.22989,0.533473,0.00456634,-0.398874,-0.251862,-0.03599,0.327001,0.233503,-0.0585815,-0.0904043,-0.27853,-0.0623147,0.300455,0.78141,0.196079,0.314157,-0.0533583,-0.29268,-0.0450513,-0.324292,0.370774,0.31891,0.191832,0.224746,-0.135633,-0.792874,0.471262,-0.568394,0.378171,-0.0719933,0.770228,-0.334923,-0.183897,0.209709,-0.30896,-0.000612806,-0.469174,-0.72299,-0.641497,-0.0585337,-0.247599,0.372674,-0.715066,0.612249,-0.424967,0.278409,0.160604,0.0612416,-0.0973499,-0.398365,-0.281084,-0.460437,0.52722,0.24786,-0.693068,-0.280773,-0.797962,-0.306332,0.949869,0.106689,-0.888611,0.297311,-0.712569,-0.00535261,0.423116,-0.261877,0.480245,-0.0732874,0.273945,0.495797,0.139421,-0.0582076,-0.42238,0.163039,-0.016154,-0.0282417,0.520887,0.449694,-0.0706016,-0.0853779,0.0248622,0.289878,0.306244,-0.681357,-0.198159,-0.187477,0.488931,0.461911,-0.161771,0.397378,-0.245582,0.0918508,0.123847,-0.108119,-0.268971,0.464162,-0.120993,0.308408,0.192916,-0.355115,0.0627085,-0.544563,-0.38647,0.869313,-0.363619,0.0435555,-0.0833597,-0.208027,-0.242579,0.196166,0.266003,0.674405,0.65622,0.657177,0.314948,0.222624,0.299342,-0.0199813,-0.375587,0.278351,0.121874,-0.346053,0.295833,-0.637634,0.0317572,-0.388027,-0.0607062,0.313039,-0.00716068,0.0190069,0.418881,-0.119748,-0.0272409,-0.374471,0.444501,0.0474177,0.0703739,0.62534,-0.313706,0.204587,-0.139584,0.432477,-0.457773,0.206982,0.456674,0.0935167,0.222758,0.159474,0.239121,-0.35022,-0.39828,0.021158,0.158275,0.310018,0.397838,0.556792,1.53286 +3405.55,0.814797,0.0912059,5,1.57587,0.883994,-0.732509,0.39919,0.892031,0.0116121,-0.0754769,0.548838,0.057897,0.0314075,0.0166485,0.278357,0.126291,0.538061,-0.812696,1.43684,0.458825,0.152122,0.24903,-0.370216,-0.0464901,-0.570167,-0.894836,0.220101,0.504138,0.369697,0.322894,0.539045,-0.644517,0.626804,0.909747,-0.355265,0.253697,0.417548,-0.889432,-0.323826,-0.725867,0.253575,0.184068,-0.54971,0.865377,0.390067,0.390203,-0.572916,-0.150695,-0.226534,-0.46195,0.569662,0.317663,0.0451365,0.0525459,-0.21352,0.0102065,-0.621147,0.429125,-0.434377,-0.389182,-0.629894,0.453134,-0.20506,0.222359,0.899323,-0.616526,-0.702565,0.138858,0.478315,-0.390471,0.400232,0.144631,-0.103971,-0.614209,0.0321751,0.219259,0.423281,0.0903077,-0.0119326,0.744839,-0.0319401,-0.0449898,0.362106,0.469162,-0.43497,0.411194,-0.571816,0.179344,-0.575716,0.305569,0.672951,-0.268278,-0.354554,0.169401,-0.124336,-0.0434931,0.342749,-0.0441316,-0.137214,0.190721,-0.33491,-0.371444,0.356967,-0.00384991,-0.0243661,-0.0221065,-0.184371,0.0817575,-0.606339,-0.0927752,-0.192544,0.183517,0.282944,1.25792,-0.134513,-0.209637,0.343233,-0.162581,-0.166395,-0.588859,-0.246821,0.366516,-0.362121,-0.863228,-0.816965,-0.554294,0.238991,0.498093,-0.112658,0.967735,-0.107171,0.477504,-0.50687,-0.394763,-0.256535,1.23226,0.47316,-0.72062,-0.0458457,-0.222335,0.191196,0.509115,-1.28734,0.532622,0.0503663,-0.163235,0.239532,0.140035,-0.129019,0.703026,0.108292,-0.0353967,-0.19591,-0.893842,0.0576203,0.628301,0.063709,0.0305494,0.156576,-0.164171,0.0653217,-0.315872,-0.0406579,0.475479,-0.312595,0.759676,-0.125555,-0.402119,0.498569,0.0485432,0.0187513,-0.179318,-0.593556,0.150535,-0.123862,-0.0501065,0.320953,0.336904,-0.432053,-0.0624985,-0.727591,0.40413,0.780691,0.531971,-0.130962,0.221127,-0.109015,-0.13298,-0.0406486,0.44997,0.130607,0.579828,-0.401645,-0.2174,0.365001,-0.462345,-0.445916,-0.326485,0.167836,0.166068,-0.201521,-0.491412,0.234303,-0.271236,-0.711433,0.440435,0.340897,0.464234,0.00246024,-0.6466,0.930543,-0.419475,0.793985,-0.0042764,0.577971,0.237442,-0.153919,0.0278757,0.146219,-0.444911,0.319781,0.0622133,-0.761368,-0.0779361,-0.453334,-0.110379,0.0560195,-0.528634,0.281427,-0.948909,-0.292159,-0.0613535,0.399437,-0.533658,-0.0152511,0.498561,-0.454845,-0.41659,0.198996,-0.249669,0.61158,0.497331,-0.152545,-0.391031,0.067026,0.108002,0.349033,0.14773,0.304316,0.633024,0.0964894,0.0944749,-0.240611,0.472395,-0.571344,0.141946,-0.208349,-0.0611956,0.727664,-0.14061,0.00939989,-0.136446,-0.110324,-0.279516,0.372359,-0.0518036,-0.094114,0.127908,-0.0413671,0.141893,0.0381646,-0.311187,0.122084,0.0957528,-0.665233,0.170505,0.0275548,0.255387,-0.355806,-0.194695,-0.281479,0.468999,-0.559908,-0.00971751,-0.249202,-0.133576,-0.353541,-0.066147,-0.145608,-0.677897,0.641011,0.268309,-0.0277642,-0.134955,0.280541,-0.287159,-0.0595466,-0.269993,-0.83872,-0.0505001,-0.183113,0.14249,0.218587,0.243825,0.172971,0.264214,0.415898,0.514017,-2.94495 +3431.31,0.977244,0.0912059,5,1.45939,0.945213,-1.04806,0.520116,0.723253,0.0285452,-0.177109,0.356522,0.61082,0.028871,-0.144905,0.245659,0.186568,0.70334,-0.710169,1.07398,0.541714,-0.084221,0.38337,0.109051,-0.25202,-0.819494,-0.593838,0.252697,0.0258733,-0.216295,0.232582,0.678357,-0.239835,0.300919,0.649312,-0.204358,0.263984,0.379727,-0.363828,-0.318666,-0.423131,0.582169,0.472545,-0.238161,0.812261,0.389531,0.36017,-0.771695,-0.409008,-0.289798,-0.0952346,0.5127,-0.0450211,0.392113,-0.155809,0.601654,-0.0738343,-0.39084,0.598835,0.0307347,-0.247856,-0.654205,0.154444,-0.912785,-0.290539,0.847506,-1.0476,-1.16857,-0.0870525,0.140403,-0.767162,0.325315,0.561675,-0.093527,-0.463793,0.262488,0.531256,0.354723,0.338485,0.174376,0.844141,-0.318049,0.207258,-0.28762,0.57055,-0.588656,0.295913,-0.213355,-0.275011,-0.334977,0.13971,0.250296,-0.407171,-0.472282,-0.0259597,0.0658394,-0.295999,-0.19028,0.352482,-0.211785,0.0436592,-0.196967,0.144987,0.320923,0.060078,0.246402,-0.117087,-0.108637,-0.0375482,-0.239312,-0.376082,0.0440102,0.284139,0.577422,0.536835,-0.103614,0.150739,0.213125,-0.262481,0.409401,-0.400533,0.11627,0.270256,0.141458,-0.316295,-0.643477,-0.0257303,0.197272,-0.223926,0.625555,0.544737,0.546991,0.236185,-0.67797,0.0273,-0.344911,0.994171,0.386755,-0.409086,0.0134355,-0.00886197,-0.24354,0.359511,-0.609265,0.0986031,0.19263,0.148236,-0.128969,0.475625,0.428858,0.278302,0.14872,0.233719,-0.496517,-0.542961,0.35391,0.181569,0.326742,0.402,0.0266182,0.141202,0.436069,-0.257981,-0.0859534,0.593607,0.0527024,0.94832,0.335283,0.253882,0.0592063,-0.101368,-0.438723,-0.4219,0.0179326,0.252308,0.109622,-0.37459,0.21283,0.399217,0.181159,-0.0400479,-0.394442,0.343142,0.616915,-0.225589,0.60759,0.74729,0.223625,-0.257947,-0.142703,-0.548324,0.141463,-0.119273,-0.560977,-0.225327,0.532938,-0.296911,-0.675962,0.123551,-0.260261,0.307395,-0.070984,-0.311451,0.661106,0.302669,-0.527514,0.265106,-0.357655,-0.183345,-0.195993,-0.241441,1.239,-0.329854,0.610303,0.394842,0.11416,0.188218,0.535472,-0.108857,0.117377,-0.684817,0.112407,0.370195,-0.707164,0.0914649,-0.326775,0.142098,0.499247,-0.418485,0.44007,-0.558303,0.0737694,0.29394,0.0506664,-0.0625463,-0.0821299,0.118015,0.108475,-0.336506,0.640271,0.418208,0.358109,0.434846,-0.598576,0.317691,0.326102,0.217314,-0.644075,0.162754,0.526263,0.789807,-0.381202,-0.0857414,-0.494604,0.0847278,-0.408441,-0.0190159,-0.259519,0.0489034,0.320701,0.19606,-0.00505251,0.0614795,-0.0126727,0.00601145,0.439216,-0.187859,-0.319174,0.310907,0.138997,0.0492019,-0.347498,-0.255145,0.0267915,0.0383051,-0.219601,0.179228,0.079871,0.203974,-0.555585,0.208023,-0.0157001,0.805286,-0.175192,-0.473592,-0.229524,-0.422196,-0.491517,0.0606978,-0.614005,-0.0935596,0.1974,0.00172271,-0.00142629,-0.413519,0.0548062,0.232973,-0.034274,-0.285502,-1.06076,-0.0819187,-0.554192,-0.201268,-0.299871,0.363155,0.131599,0.207679,0.362766,0.455718,-2.56247 +3399.91,0.970645,0.0912059,4,1.5308,0.854491,-0.924807,0.310095,0.470077,0.12925,-0.0749376,0.585842,0.70452,-0.249961,-0.0404232,0.384146,0.326615,0.427835,-0.493815,0.945321,0.416603,0.187064,-0.223483,-0.295123,-0.293261,-0.405222,-0.790274,0.0400318,0.277777,-0.0217564,0.128522,0.695337,-0.480526,0.350443,0.920436,-0.699137,0.131965,0.237414,-0.304529,-0.131914,-1.04743,0.710053,0.331974,-0.164302,0.929477,0.440361,0.389837,-0.965231,0.194554,0.135713,-0.791162,0.475482,0.266128,0.00895229,0.271059,-0.14029,0.291132,-0.175866,0.846441,-0.82833,-0.365325,-0.775652,0.24573,-0.0801537,-0.233532,1.1775,-1.23517,-0.774476,0.00554671,0.424668,-0.433491,0.132535,0.0574327,-0.029902,-0.0698817,-0.0435139,0.308764,0.34727,0.617848,0.0559513,0.672605,-0.139621,0.226193,0.325595,0.199369,-0.269009,0.253752,0.157219,-0.0563722,0.149145,-0.199533,0.135924,-0.187765,-0.352626,-0.451221,-0.215422,0.0639645,-0.198265,0.000344134,-0.281178,0.856565,-0.271798,-0.334333,0.139248,0.409491,0.130393,-0.313634,0.0683853,0.169507,-0.213245,0.135888,0.0633267,0.0722611,0.512725,0.159175,-0.00670897,0.273635,0.340207,0.148797,0.311441,-0.94665,0.396389,0.221761,0.212245,-0.18054,-0.429922,-0.353206,-0.160027,-0.116244,0.332196,0.211532,0.853596,0.311998,-0.418934,-0.298155,-0.236804,0.718002,0.625137,-0.2206,-0.392739,0.117725,-0.0758549,0.790775,-0.548012,-0.0612614,-0.174792,-0.596474,-0.380001,0.0666703,0.0600359,0.130648,-0.277552,-0.101855,-0.22548,0.259391,0.0818222,0.38508,0.126636,0.502202,0.617533,0.673858,0.868263,0.410724,-0.456977,0.376489,0.561618,0.871755,0.467508,0.157469,-0.0794633,0.117702,-0.251675,-0.307562,-0.272706,-0.269147,0.285479,0.0890097,0.463163,-0.455788,0.346039,-0.26209,-0.327336,0.452736,0.572109,-0.280549,0.021243,0.019196,0.0978342,-0.159011,-0.453795,-0.323211,-0.533204,-0.56664,-0.410181,0.126862,0.362232,-0.391646,-0.628445,-0.0594499,0.143052,0.236209,0.0237749,-0.0700956,0.4737,-0.200507,-0.402473,0.865448,-0.39272,-0.162745,-0.237073,-0.310661,0.792822,0.0531242,1.01185,-0.0110185,0.0617198,0.180686,0.167582,-0.367281,0.175304,-0.334048,-0.0893865,0.187546,-0.549798,0.422498,-0.713394,-0.145085,0.738951,-0.0150491,0.378127,-0.363832,-0.26493,0.0756001,-0.182783,-0.170157,-0.0392,0.34892,-0.0295466,-0.787336,0.676192,0.17112,0.0725803,0.576637,-0.354164,0.592795,0.257152,-0.213441,-0.002444,-0.367567,0.337155,0.588722,-0.214269,0.151006,-0.811565,0.26898,-0.0741149,-0.331504,-0.373138,0.249118,0.275869,-0.183321,-0.451338,-0.0976652,0.197008,-0.173523,0.198812,0.0127,0.214356,0.69731,0.0315207,-0.368831,-0.108946,-0.294288,0.310813,-0.590014,-0.136252,0.119193,-0.227638,-0.0914439,-0.537628,-0.0940026,0.400134,0.524521,0.209599,-0.219471,-0.367271,-0.113469,0.565768,0.388384,-0.16143,-0.260277,0.620025,0.304375,-0.216976,-0.309047,-0.281945,-0.56382,0.273195,0.0328594,-1.21881,0.674803,-0.205255,-0.160949,-0.0265362,-0.357509,0.16662,0.356918,0.408191,0.597426,-1.38094 +3404.1,0.987207,0.0912059,4,1.47963,1.12478,-0.234222,0.0964075,0.590757,-0.0157233,-0.1002,0.522313,0.709769,0.271908,0.0802198,0.387843,0.179083,0.624912,-0.361867,0.444279,0.225625,0.0498404,-0.0195354,-0.0573027,-0.461851,-0.344412,-0.432151,0.118199,0.423461,0.273635,0.686369,0.300126,-0.584694,0.225759,0.787605,0.349327,0.0877697,0.51445,-0.284979,-0.276056,-0.639661,0.561669,0.352289,-0.301542,1.09541,0.433844,-0.230849,-0.619771,-0.270036,0.415111,-0.589229,-0.0302278,0.320881,0.145355,0.298015,0.0599531,0.0449457,-0.604795,0.803561,-0.814218,-0.620712,-0.954468,0.105742,-0.219806,0.104277,0.990209,-0.762413,-0.681461,-0.184261,0.525109,-0.260456,0.0229654,0.136939,-0.0796512,-0.00301804,-0.127671,0.406835,0.325438,1.23586,0.155884,0.778606,0.330543,0.214849,0.530262,0.325808,-0.408412,0.112256,-0.10158,-0.112689,-0.114359,0.0632086,0.0507561,-0.499486,-0.619079,-0.563068,-0.138132,0.024356,-0.0708521,-0.153353,0.151842,0.391012,-0.647045,0.0128433,0.180959,0.147918,-0.137546,-0.267605,0.260056,0.114781,-0.152341,0.483407,-0.193037,0.380341,0.376383,0.27283,-0.0123623,-0.151408,0.221383,0.101439,0.127585,-0.84035,0.562368,0.177495,-0.102521,-0.46804,-0.786312,-0.491882,-0.0677871,0.225866,-0.222721,-0.152614,0.660964,0.101603,-0.561865,-0.0729611,-0.581345,0.516614,0.941721,-0.189607,-0.472221,0.297877,-0.12706,0.158211,-0.392213,-0.146339,-0.133457,-0.116249,-0.475874,-0.172127,-0.0281801,-0.0943079,-0.157673,-0.0894207,-0.144127,0.293943,-0.0226835,-0.0662128,-0.0838892,0.558559,0.704734,0.870944,0.349642,0.404877,-0.0992782,0.406221,0.304848,0.656195,0.443355,0.482215,-0.152569,0.148813,-0.169928,-0.062352,0.0168355,-0.105817,0.0454736,-0.253113,0.685947,-0.181218,0.0244587,-0.222512,0.0294316,0.514819,0.693364,-0.172766,-0.167186,0.0141082,-0.00896302,-0.224288,-0.902654,-0.160315,-0.491228,-0.628864,-0.170832,-0.0588525,0.641613,0.0420087,-0.258508,-0.221307,-0.0340079,0.100136,-0.117874,-0.597118,0.592915,-0.0409075,-0.169107,0.529713,-0.049406,-0.246877,-0.193983,-0.36563,1.02812,-0.0817163,0.431903,-0.26051,0.103306,0.40143,0.211066,-0.412456,0.348271,0.226573,0.205694,0.0335559,-0.405868,0.382523,-0.139136,-0.0790488,0.403885,0.0130062,0.680554,-0.506376,-0.0237967,0.0682412,-0.0999418,-0.384948,-0.165829,0.110486,0.179775,-0.500816,0.630841,-0.165472,-0.18963,0.485521,-0.636199,0.763278,0.617043,-0.603872,-0.326576,0.173807,0.323559,0.258715,-0.204462,0.119002,-0.737894,0.342978,0.416268,-0.196579,-0.248705,0.0391043,0.149196,-0.19093,-0.331165,-0.320219,0.202884,-0.102673,-0.379444,0.463462,-0.0225969,0.424482,0.0346503,-0.33245,-0.545265,-0.631698,0.0463666,-0.240117,-0.0192405,0.321665,-0.455049,0.1565,-0.438172,0.0699763,0.419536,0.444503,0.773269,-0.191262,-0.514448,-0.191566,0.716957,0.0319459,0.178581,0.206368,0.532357,0.375837,-0.0585247,-0.328724,-0.0308861,-0.158264,0.303916,0.262743,-0.799856,0.605069,-0.0783054,0.100945,0.0964839,0.235269,0.12694,0.345567,0.356287,0.58785,-2.43454 +3398.83,0.889912,0.0912059,4,1.57045,1.12299,-0.305488,0.17506,0.56495,-0.0771718,0.277197,0.515985,0.874522,0.30721,0.0195504,0.280198,0.297257,0.811201,-0.284137,0.745644,0.26404,0.0782773,-0.0964513,0.0266468,-0.397715,-0.799286,-0.762679,0.0248116,0.147744,0.13897,0.0360984,0.22379,0.183215,0.693426,0.909072,0.298075,-0.329767,0.323906,-0.456778,-0.432224,-0.384138,0.453341,0.447323,-0.344702,0.577385,0.667491,-0.0936875,-1.07134,-0.139616,-0.153154,-0.644939,0.276062,0.376001,-0.270881,-0.407844,0.687734,-0.171388,-0.531524,0.363906,-0.587465,-0.197878,-0.388837,0.200721,-0.390753,-0.0438297,0.696245,-0.892998,-0.599235,-0.082185,1.02068,-0.357164,-0.440625,0.336303,-0.261878,-0.680237,-0.0330342,-0.0466513,-0.211145,1.15229,0.23953,0.118577,0.591979,-0.225829,0.14731,-0.0384172,0.0216308,0.28939,-0.362425,-0.0556346,-0.342717,0.480189,-0.435193,0.216337,-0.285978,0.0966875,-0.352884,-0.260472,-0.0877721,1.01592,-0.402928,-0.191119,-0.331376,0.393841,0.341985,-0.280027,0.171601,-0.362089,-0.17165,0.012874,0.164431,0.185676,0.0165705,0.537906,0.595093,0.379978,0.186603,1.02324,0.266837,-0.539085,0.134613,-0.797058,0.408242,0.373862,0.0804482,-0.102512,-0.218591,0.306336,-0.475636,-0.217037,-0.0751798,-0.43967,0.623533,-0.0641504,-0.292681,0.259943,-0.431549,0.261948,0.659615,-0.381917,0.565401,-0.222237,-0.12658,0.325898,-0.934934,-0.294272,0.0282076,-0.386872,-0.290629,0.112469,0.61207,-0.725393,-0.0253617,-0.241896,0.126973,0.204203,-0.137234,0.635992,0.238555,0.490767,0.374601,0.10273,0.408584,0.0692259,0.544993,-0.0847355,0.777938,0.842326,0.875662,0.0594051,0.555568,-0.263094,-0.0402562,-0.366231,0.25765,0.462127,-0.00972395,-0.0926914,0.514697,0.0252923,0.0676194,0.234415,0.0559812,0.478675,0.8384,-0.553681,-0.510649,0.364913,-0.0179045,-0.236248,-0.393787,0.058192,-0.348116,0.262135,-0.914279,-0.346125,0.203458,0.416321,-0.56809,0.12838,0.184039,0.105873,0.131583,-0.582681,0.326578,-0.095658,-0.454162,0.266391,-0.172517,0.302282,-0.367399,-0.396602,0.556659,-0.356905,0.590931,-0.276164,0.157006,0.106535,0.145927,-0.201142,0.338825,-0.306884,0.238756,0.13591,-0.157613,-0.412003,-0.544957,-0.072793,0.591777,-0.209546,0.255375,-0.125732,0.468831,0.574745,-0.193796,-0.096593,-0.0597691,-0.0544202,0.138204,-0.364649,0.435195,-0.0777712,0.773596,0.0947193,-0.33216,-0.122503,0.299678,-0.932743,0.261112,0.729781,0.413712,0.0727774,-0.282591,0.153739,-0.500462,0.0430706,-0.0678375,0.46203,-0.377138,-0.0702982,-0.0477254,-0.408315,-0.186805,-0.17302,0.0758192,-0.158116,0.65445,-0.0245774,0.0136034,0.224506,-0.19624,-0.129672,-0.0917916,0.979368,-0.370154,0.117985,0.101858,-0.511717,-0.365161,0.00906498,0.120985,0.445638,0.0197345,-0.224252,-0.207239,-0.41838,-0.651646,-0.0503719,-0.272867,-0.0503646,0.132627,-0.0374671,-0.198249,0.365625,-0.408752,-0.0123182,0.382969,-0.103097,0.0718507,-0.0845266,-0.772292,0.329982,0.160755,-0.0304058,0.140341,-0.568458,0.154097,0.164077,0.392552,0.405064,-2.27668 +3418.06,0.999293,0.0912059,4,1.57022,0.730289,-0.544776,0.229516,0.146495,-0.030477,0.150085,0.0145371,-0.0215664,0.375153,-0.0967768,-0.160371,-0.178792,0.522918,0.441234,0.903386,0.43237,-0.0696508,-0.170835,0.465126,-0.519162,-0.237235,-0.213203,0.560666,-0.0149702,-0.190734,0.214847,0.478601,-0.121751,-0.255714,1.14513,-0.735437,0.63452,0.145651,0.0871664,-0.74466,-0.52507,0.302833,-0.0658074,-0.563327,0.809936,0.0265846,0.681369,-0.528499,-0.245908,-0.0524486,-1.00762,-0.169448,0.279121,-0.130264,-0.12822,-0.392033,-0.171479,-0.183407,0.93108,-0.174833,0.0699852,-1.40803,0.696722,-0.213466,-0.0514065,0.914641,-0.708096,-1.20085,0.322799,-0.333,0.344434,0.429622,-0.151129,-0.433604,0.161139,0.703627,0.775489,-0.13814,0.344134,0.531193,0.628879,0.307445,-0.612576,0.530325,0.410999,-0.840292,0.0331261,0.223761,-0.174189,0.393771,-0.072897,-0.124045,-0.124771,-0.708983,-0.021989,0.596378,0.205182,0.237583,-0.287359,-0.325162,-0.0995533,-0.130923,-0.0263697,0.414784,0.242878,-0.181897,-0.239392,-0.266384,-0.0523276,-0.460053,0.0569188,-0.375656,0.280084,0.631816,-0.284856,0.243761,-0.723491,0.503485,0.53916,-0.237425,0.535722,-0.171082,-0.026487,-0.508269,-1.06673,0.317716,-0.832266,0.0312855,0.0663853,0.162102,0.83996,-0.0106131,0.510618,-0.424328,0.210485,0.035213,-0.170699,0.699323,0.0360129,-0.687023,0.340644,-0.286387,0.994197,-0.463588,0.212513,-0.109759,0.265298,-0.431885,-0.155978,-0.0797949,0.589469,0.601378,-0.337152,-0.0864129,-0.32338,0.254567,-0.170628,0.420986,0.154169,0.277247,0.212513,-0.299842,0.109493,-0.412886,0.119514,-0.618194,0.491163,-0.302098,0.137977,-0.404509,0.0358531,-0.0799121,0.202915,-0.407765,0.309988,-0.478876,-0.145847,-0.075859,-0.481462,0.277132,-0.565836,-0.0153068,0.0216734,0.455614,0.538402,0.392273,-0.225349,0.0957423,0.530747,-0.330521,-0.0633187,-0.210328,-0.0829794,-0.264788,0.0262712,-0.130203,-0.125488,-0.397047,0.284192,0.446106,-0.0673142,0.022916,-0.525834,-0.586039,-0.0508218,-0.00974708,0.198523,0.468309,0.0342252,0.0242257,-0.314865,0.864261,0.268872,-0.142462,0.18471,-0.450687,0.847184,0.0388032,-0.153837,0.25572,-0.081307,0.267846,0.202165,-0.525611,0.322857,-0.212848,-0.331158,0.0116759,-0.400644,0.521416,-0.295149,-0.609138,-0.667721,0.588639,-0.295136,0.031249,-0.664971,-0.476013,0.297527,0.48543,0.0603954,-0.470561,0.848086,-0.0853624,-0.0607535,-0.353345,0.713875,-0.214509,0.326942,-0.0591077,0.615936,0.278744,-0.0528701,-0.481113,-0.0632536,-0.379832,0.0292171,0.00905403,0.0514708,-0.0340357,0.285061,-0.229684,0.365179,-0.150022,0.171071,0.11629,0.382878,0.396513,0.0349366,0.226911,-0.388143,0.0857453,-0.774734,0.262649,-0.392787,0.058797,0.0105576,0.424614,-0.0105715,-0.12826,-0.15068,0.0654968,-0.302033,0.369804,0.294342,-0.108521,-0.25768,0.294991,0.0581348,0.254239,-0.0507518,0.474028,0.100957,-0.0720029,0.00525256,0.0133972,0.00565507,0.227874,-0.63933,-0.385653,-0.379656,-0.144911,0.0356644,-0.392604,0.00877357,0.126975,0.319099,0.356335,0.564888,-0.131036 +3455.34,0.996594,0.0912059,5,1.51047,0.725113,-1.23487,0.479252,0.128878,-0.0801341,0.18793,0.289905,0.829183,0.635915,0.432431,-0.0462595,-0.207875,0.750001,-0.0887147,0.96559,0.814877,-0.113993,-0.317732,0.269908,0.240462,-0.861968,-0.69685,0.415827,-0.190063,-0.148795,-0.328622,0.206869,0.0309666,0.196757,1.38544,0.287496,-0.387905,0.836117,-0.0812049,0.0562797,-0.676837,0.53297,0.19234,-0.0637458,1.2191,0.92444,-0.409395,-0.271232,-0.453147,-0.397172,-0.413979,0.29967,0.692815,-0.0626091,0.0284785,0.302969,-0.0551433,-0.421084,0.775698,-0.0125079,-0.21298,-0.379946,0.308274,-0.468553,0.644146,1.13004,-0.836957,-1.08532,-0.304237,0.688949,-0.12027,-0.304838,0.253776,-0.439544,-0.135055,0.31872,0.327283,0.0773075,0.524398,-0.0891629,0.295058,-0.0116322,-0.119989,-0.108263,0.368563,0.198253,0.300751,-0.274788,-0.100028,-0.114785,0.0945241,-0.117634,0.190642,-0.544962,-0.101958,-0.775268,-0.347872,-0.367887,0.395654,-0.0821049,0.0391583,-0.111722,0.0594696,-0.0801573,-0.0768341,0.161868,-0.174734,-0.0621924,0.395133,-0.102069,0.260194,-0.0500343,0.258457,0.40122,0.201516,0.137314,0.715975,0.261027,-0.577723,0.162951,-0.844452,0.233548,0.383035,0.207594,-0.213065,-0.19472,0.526785,-0.305178,-0.0656999,0.370096,-0.424225,-0.0975421,-0.144957,-0.0769812,0.152726,-0.0411693,0.234004,0.0887363,-0.609579,0.607012,0.0315453,-0.154479,0.172541,-0.491476,-0.611023,0.115524,0.133981,-0.298181,0.503868,0.272571,-0.696497,0.016962,-0.651476,-0.180748,-0.0670624,-0.190285,0.36529,-0.302479,0.236476,0.259971,0.161544,0.137345,-0.151758,0.287406,0.179734,0.528998,0.747268,0.0591704,-0.0337961,0.48053,-0.19808,0.0106521,-0.423115,0.455339,0.619088,-0.104504,-0.142711,-0.11509,0.0437612,-0.0520285,0.0361689,-0.0230916,0.0870621,0.672048,-0.387408,-0.632727,0.150307,-0.029592,-0.283174,-0.225724,-0.363179,-0.459087,0.370026,-0.0709403,0.0518802,0.216157,-0.0456242,-0.776421,0.135099,0.196343,-0.0621758,-0.204072,-0.464575,0.181952,-0.0204448,-0.322009,-0.155458,-0.478459,0.00598018,-0.040116,-0.380873,0.49075,-0.151266,0.286843,-0.31939,0.131151,-0.499999,0.0422182,-0.243932,0.243531,-0.420137,-0.103953,0.237042,0.00535284,-0.115334,-0.481738,0.50512,0.314267,-0.229722,0.0696709,-0.122153,0.140827,0.564272,0.040297,-0.229105,-0.00573961,0.098115,0.00721939,-0.473299,0.409791,-0.0978842,0.347751,-0.0262359,-0.388794,-0.0546232,0.396626,-0.530946,0.261607,0.197623,0.167122,-0.0558926,-0.0957294,0.0753948,-0.246518,0.0116038,-0.566067,0.166276,-0.266009,-0.0654704,0.104485,-0.52452,0.0868515,-0.272475,0.184748,0.163921,0.0843351,-0.0754461,-0.149826,0.309066,-0.141429,-0.331568,-0.312922,0.442148,-0.493849,-0.0326829,-0.342663,-0.387942,-0.359606,0.0868097,-0.0670686,-0.0623216,-0.115075,0.277385,-0.0893921,-0.527713,-0.213823,-0.178742,-0.286582,-0.0763066,-0.0238952,-0.135664,0.172739,0.557479,-0.403879,-0.123082,0.0740442,-0.196149,0.21616,0.274525,-0.271146,0.0161241,-0.166722,-0.230624,0.29886,-0.188849,0.0926724,0.224223,0.304421,0.473521,0.0150043 +3445.3,0.94013,0.0912059,4,1.56652,0.815908,-0.738948,0.267733,0.14165,-0.15734,0.232465,0.0210661,0.846933,0.667992,0.473238,-0.2969,-0.0397759,0.766834,0.0335539,1.137,0.472215,-0.379131,-0.432208,0.109765,0.0206611,-0.752533,-0.944538,0.556634,0.221634,-0.138862,-0.391418,-0.00745596,-0.0476854,0.412142,1.18632,-0.058641,-0.409335,0.420295,-0.396332,-0.101039,-0.664718,0.495572,0.334596,-0.220844,1.41324,0.461321,-0.595513,-0.595017,-0.223144,-0.263558,-0.850062,0.299636,0.644902,-0.0310793,0.122772,0.475723,0.156351,-0.331222,1.0129,-0.10267,-0.186426,-0.103067,-0.000530278,-0.497004,0.187695,0.988203,-0.521267,-0.949715,-0.324517,0.24559,-0.203933,-0.449341,0.0611589,-0.988778,-0.0974132,0.0630969,0.200548,-0.26612,0.242408,-0.0865074,0.871033,-0.116543,-0.408273,-0.202733,0.303907,-0.279631,0.00907436,-0.119323,-0.135346,0.160302,-0.256011,0.0950768,0.163294,-0.76678,-0.622296,-0.233808,-0.301112,-0.0619811,-0.110641,0.14888,0.0726709,-0.333703,-0.212521,0.00277901,-0.24621,0.232441,-0.297771,0.238023,0.382079,0.13115,0.443639,-0.634791,0.204419,0.206511,0.288389,0.237813,0.349536,0.159481,-0.30487,0.105234,-0.692321,0.311944,0.311149,0.407024,-0.641983,-0.0935606,0.351785,-0.0309137,-0.153624,0.174749,-0.604195,-0.306565,-0.0402305,-0.361249,0.2521,0.0219523,0.19312,0.24463,-0.476968,0.477251,-0.157496,0.0724446,0.0957927,-0.78414,-0.602937,-0.125039,0.154149,-0.0783739,0.170914,0.0387261,-0.446407,0.163147,-0.445416,-0.43846,-0.0881681,-0.0917866,0.322237,-0.438211,-0.234271,0.493594,0.233983,0.276811,0.0919456,-0.459358,0.163953,0.0153269,0.809596,-0.269424,-0.169671,0.499347,0.0256206,-0.229329,-0.377986,-0.27752,0.264607,-0.0761337,-0.394072,-0.172023,-0.0341293,-0.300561,0.0442086,-0.360946,0.067095,0.586533,-0.29727,0.0272866,0.0449679,-0.353642,-0.220643,-0.345616,-0.161258,-0.24261,0.291208,0.0201351,0.0791839,-0.0612319,-0.245914,-0.920153,0.225003,0.191346,0.121233,-0.332133,-0.266059,-0.201085,-0.426434,-0.645364,-0.19152,-0.455822,0.0979017,0.169267,-0.0299674,0.628526,0.0116706,0.0425001,-0.29423,-0.14166,-0.979384,0.531844,-0.230758,0.258169,-0.246099,-0.184738,0.0422326,-0.190207,-0.171591,-0.152385,0.216016,0.127369,-0.338557,0.171514,-0.286737,-0.121896,-0.181682,-0.0739296,-0.349272,-0.13443,0.328712,0.505723,-0.4309,0.778774,0.280127,-0.131467,0.108205,-0.436197,-0.0801366,0.367649,0.00135229,-0.372902,0.0976398,-0.115925,0.205313,-0.353469,-0.0421311,-0.38243,-0.447632,-0.925873,0.237781,-0.142064,-0.414314,0.0315697,-0.241612,-0.23425,-0.12925,0.23732,0.0115913,0.503316,0.103351,-0.176601,0.277332,-0.193686,-0.140873,-0.330812,0.387614,-0.253935,0.07845,-0.0551456,-0.42709,0.0881977,-0.141278,0.320509,-0.0651464,-0.209349,-0.11473,-0.298431,-0.292514,0.105912,-0.461163,-0.0993543,0.341683,0.0933332,-0.288086,-0.498306,0.425622,-0.405533,-0.111617,0.334807,0.12693,0.0227016,-0.0578546,-0.184719,-0.0380537,0.191199,-0.0380741,-0.155389,-0.0654638,0.0963477,0.30195,0.310399,0.5495,-0.172536 +3453.47,0.586624,0.0912059,4,1.6832,1.15119,0.0368896,-0.0346259,0.309223,0.0197548,0.25087,0.356455,0.51438,0.459901,-0.28747,-0.337724,0.0231776,0.337818,0.10073,1.11627,-0.387695,-0.0709039,0.144618,-0.069817,-0.463765,-0.46757,-0.764608,0.0928702,-0.536607,0.0289106,0.349252,0.597961,-0.767141,-0.221178,0.57723,0.0887643,0.577121,0.296164,-0.310283,-0.27973,-0.523815,0.29852,0.0882549,-0.719848,0.691043,0.15012,0.409584,-0.527266,-0.407248,-0.384004,-0.157143,-0.222033,-0.0375528,-0.404801,-0.45013,0.249091,0.047474,-0.643146,0.491723,-0.17379,-0.71746,-1.04283,0.430674,-0.346504,0.0728952,0.62803,-0.837689,-1.1071,-0.176806,0.0421657,0.283573,0.0150906,-0.100236,0.155986,0.206107,0.354694,0.722478,0.0540092,0.371148,0.56677,-0.0454445,0.173551,-0.140216,0.0110453,0.0519445,0.22416,0.155775,0.247073,-0.0758632,-0.166368,0.373999,-0.0177801,-0.441151,-0.0581225,0.286091,0.303806,-0.0194489,-0.033363,-0.109418,-0.371623,0.0915275,-0.00259131,0.350337,0.198563,0.155399,0.160001,-0.281164,-0.36409,-0.0172469,-0.667625,-0.0583267,0.245403,0.44859,0.794039,-0.507804,-0.500515,-0.0672942,0.358234,0.17968,0.25357,0.052803,-0.361246,-0.124893,-0.549156,-0.474265,-0.0660013,-0.597186,-0.121534,0.000414619,0.0974129,0.615942,0.0845226,0.224598,0.334262,0.0708318,-0.191364,-0.437948,0.381145,0.0777541,-0.346481,0.174164,-0.392648,0.241882,-0.267453,0.518297,-0.105337,0.0631928,-0.344495,0.102179,0.366422,0.461505,0.145217,-0.0192612,0.0342271,0.0718229,-0.121234,-0.114864,-0.119884,0.668166,0.0303368,0.120207,-0.261559,-0.203036,0.154934,0.496164,-0.284002,0.668961,0.368951,-0.096865,-0.358441,0.00463821,0.00364666,0.0227778,0.163975,-0.0288019,0.0504178,-0.237846,-0.23267,0.32456,0.033964,-0.650838,0.182317,0.0681491,0.282716,0.45397,0.0479762,0.405693,0.203962,0.117898,-0.031472,-0.244158,-0.396458,0.219543,-0.779479,-0.138365,-0.118782,0.0529426,-0.0335685,0.0718164,0.106729,-0.28321,-0.429659,-0.735387,0.480657,0.123629,0.218547,0.274461,0.585614,-0.0344589,-0.0688675,-0.776378,0.843007,-0.193082,0.0413621,-0.141834,-0.0762518,0.61857,-0.334565,-0.0382423,0.186519,0.0122181,0.320858,0.0229668,-0.239157,0.116231,-0.0869883,-0.283054,-0.0435704,-0.198721,0.601309,-0.189664,-0.139657,0.101082,0.0016878,-0.0385108,0.296046,-0.761617,-0.549921,-0.181829,-0.193127,-0.242088,0.214814,0.460401,-0.210401,-0.125225,-0.2883,0.00416994,0.424697,0.298292,0.151789,0.325192,0.742944,0.0654146,-0.185313,0.119983,-0.217452,0.299979,-0.194826,0.301619,0.292191,-0.462222,0.0673621,0.208259,-0.317759,0.22097,-0.0780427,0.259826,0.544449,0.455512,0.296426,-0.093698,-0.0274856,-0.279786,-0.177371,-0.227846,-0.515514,0.18527,-0.210839,0.247223,-0.200577,0.0605198,0.0245236,-0.127206,0.126011,0.0849543,-0.305132,-0.1209,0.0716815,-0.202019,0.325628,0.102743,0.366662,-0.496403,0.121569,-0.0947889,-0.294093,0.194639,-0.0665103,-0.206724,-0.475086,-0.118783,-0.454377,-0.201895,-0.242869,0.0916325,0.0867931,0.235739,0.294607,0.48553,-1.3701 +3439.11,0.77784,0.0912059,4,1.6485,1.06368,-0.437878,0.166282,0.292578,-0.254221,0.0770374,-0.0999484,0.83181,0.789508,0.0527455,-0.182499,0.233463,0.569488,0.0780296,1.22932,-0.361517,-0.0521026,-0.0800768,-0.319446,-0.748158,-1.0582,-0.581487,0.180416,-0.370123,-0.00645059,0.200748,0.460835,0.302394,0.180972,0.676106,-0.181892,-0.409247,0.148146,-0.273784,-0.223725,-0.571489,0.686878,0.262928,-0.20328,1.09794,0.475481,-0.250938,-1.07947,-1.02909,0.105464,-1.26078,0.312237,0.377297,-0.405843,-0.15582,0.33975,-0.0599591,-0.53085,0.872169,-0.794828,-0.266978,-0.693212,0.0287875,-0.885887,0.00642884,0.771034,-1.05069,-1.07496,-0.557466,0.374895,-0.0562665,-0.151752,0.0993859,-0.890615,-0.0676623,0.148947,0.158319,-0.326591,0.262026,0.43177,0.43849,0.0429696,-0.223346,0.103129,0.518989,-0.6836,0.00687442,-0.277615,0.0882855,-0.0394671,-0.200872,-0.135199,0.453901,-0.64922,-0.37606,-0.0682734,-0.287966,-0.17397,0.178363,-0.0656935,-0.572456,-0.483545,-0.0672772,0.0237868,-0.0205429,-0.400577,-0.42193,0.534287,-0.0462683,0.1366,0.362902,-0.563109,0.232217,0.646109,-0.177096,0.0374227,0.455801,-0.0596053,-0.177891,0.0423925,-0.536543,0.16767,0.612313,0.433076,-0.543051,0.0749489,0.595779,-0.108197,0.305378,0.246531,-0.153713,0.0621881,0.0889084,-0.606803,0.132336,-0.0863003,0.230365,0.161311,-0.093241,0.108478,-0.0258915,0.182623,0.450759,-0.45439,-0.967182,-0.117682,0.702125,-0.272186,-0.0110384,-0.193498,-0.444862,0.41457,-0.28938,-0.422089,-0.0581767,-0.0320323,0.180352,0.0857315,-0.314372,0.243624,0.088173,-0.129184,-0.0891536,-0.247432,-0.44599,0.336067,1.03914,-0.463052,0.0812881,0.267975,0.00387448,1.88266e-05,-0.0246639,-0.224667,-0.0401845,-0.0247229,-0.408814,0.453832,-0.322992,-0.172436,-0.0835981,-0.191326,0.243247,0.886893,-0.125074,-0.12913,0.218006,-0.164117,0.0955685,-0.481093,-0.15512,-0.148753,0.228402,0.097529,-0.0625692,0.0781526,-0.29012,-0.605999,-0.222501,0.157448,0.50283,0.0266141,-0.556428,-0.273188,-0.399467,0.108297,-0.0996355,-1.08656,-0.139619,0.0437534,-0.0217347,1.01143,0.24134,0.372138,-0.202635,-0.346308,-0.500027,0.300846,-0.452739,0.336829,-0.339866,-0.245098,0.102556,-0.139415,-0.187889,-0.291757,0.359962,0.195815,-0.588349,0.206734,-0.223941,0.172434,-0.239911,-0.195302,-0.68681,-0.410192,0.124336,0.171059,-0.179652,0.659364,0.401358,-0.358889,0.422217,0.102325,-0.188084,0.884475,-0.164235,-0.223073,0.217307,-0.185921,0.37085,-0.254555,-0.333818,-0.592647,-0.182183,-0.730836,0.594358,-0.26115,-0.691034,0.177696,0.0401872,-0.169834,0.0303296,0.255787,0.362535,0.312606,-0.161613,-0.196202,-0.257203,-0.313849,0.032915,-0.179552,0.305519,-0.246468,-0.0692998,-0.18916,-0.584037,0.0291232,-0.429114,0.0253511,-0.103251,0.0758318,0.440503,-0.0269204,0.0042514,0.143981,-0.321206,-0.0756236,0.344854,0.321932,-0.0675129,-0.134184,0.434921,-0.506965,-0.421526,0.516183,0.109612,0.326696,-0.187231,-0.33223,0.11222,0.392982,-0.119547,-0.219381,-0.174689,0.123348,0.341572,0.35121,0.584442,-1.06741 +3437.64,0.815317,0.0912059,4,1.69339,0.999616,-0.52438,0.142521,-0.0175816,-0.215769,0.142074,-0.0955167,0.497967,0.676817,-0.0981349,-0.217124,-0.0758496,0.450619,-0.00158296,0.998431,-0.189952,-0.261179,-0.0180468,-0.236385,-0.43348,-1.11679,-0.62323,0.109318,-0.348141,-0.439273,0.171501,0.692666,0.318869,0.270889,0.663779,-0.180092,-0.0230778,0.171588,-0.364578,-0.27344,-0.666015,0.419203,0.13992,-0.298028,0.896477,0.425951,-0.116733,-0.918951,-0.983899,0.0257919,-1.22749,0.22857,0.43688,-0.464424,-0.170463,0.129037,-0.15745,-0.599338,0.975982,-0.867489,-0.294276,-0.485857,0.00166646,-0.362034,0.091823,0.794082,-0.830125,-1.33042,-0.556686,0.167369,-0.0594791,-0.361932,0.289553,-0.88915,-0.141083,0.153545,0.410524,-0.0999839,0.209519,0.547258,0.489202,0.310216,0.165217,-0.169114,0.424514,-0.633272,0.142624,-0.257186,0.292311,-0.0367984,-0.0794505,-0.510651,0.494711,-0.534937,-0.583515,-0.0434034,-0.242245,-0.00609155,-0.0333221,-0.14248,-0.331944,-0.2899,0.0816815,-0.0898557,0.163844,-0.542734,-0.426795,0.59951,0.399522,0.256385,0.185589,-0.548099,0.374252,0.695202,-0.0900412,-0.067321,0.586961,-0.314468,0.0425167,0.226605,-0.414925,0.0956991,0.530173,0.264808,-0.635106,-0.265903,0.137791,-0.0645632,0.245793,0.397946,0.0158515,0.120293,0.0839046,-0.544521,0.0904334,-0.151651,0.0256778,0.331902,0.157873,-0.0142081,0.0722464,0.016817,0.476154,-0.343939,-1.07766,-0.0105358,0.583366,-0.495555,-0.217118,-0.317894,-0.563243,0.170644,-0.316889,-0.388174,-0.276719,-0.0633248,0.18148,0.288389,-0.00715918,0.380543,0.168508,-0.424986,-0.139806,-0.327195,-0.322315,0.369386,1.2156,-0.109084,-0.179615,-0.0741627,0.076462,-0.140182,0.0400706,-0.402591,0.0258528,-0.015367,-0.400029,0.837223,-0.246948,-0.0311877,-0.0644154,-0.105907,-0.048743,0.80776,-0.317302,-0.392306,0.30274,-0.115639,0.336144,-0.366579,-0.424855,-0.263232,0.133475,0.0207325,-0.0843549,0.0875456,-0.241813,-0.184977,0.034951,0.198013,0.55158,-0.211535,-0.589623,-0.371367,-0.371261,-0.202031,0.0221553,-0.879023,-0.25555,0.103397,-0.192967,0.720939,0.216196,0.348371,-0.213492,-0.311607,-0.352142,0.36325,-0.515498,0.450606,-0.205851,-0.34075,0.0746541,0.1867,-0.292381,-0.0288943,0.392776,-0.00119504,-0.742273,0.111202,-0.0885525,0.0564615,-0.161688,-0.140806,-0.67213,-0.550955,-0.0468968,0.0710599,-0.11976,0.531771,0.491652,-0.451864,0.191583,0.0345435,-0.0727963,1.03029,-0.330218,0.0383424,0.287624,-0.241285,0.478139,-0.25341,-0.171467,-0.470386,-0.234574,-0.753464,0.655794,-0.334805,-0.673782,0.13285,0.195495,-0.142952,-0.282437,0.159,0.117278,0.0230888,-0.267722,-0.227303,-0.254959,-0.0652364,-0.155393,-0.363775,0.417827,-0.106476,-0.0868785,0.105022,-0.0575799,0.183867,-0.814683,-0.0156779,-0.131404,0.364814,0.695889,0.17639,0.12229,-0.0124784,-0.255076,0.134631,0.226907,0.401545,0.146602,-0.158996,0.278816,-0.435067,-0.389223,0.479458,-0.00141719,0.294394,-0.279854,-0.331915,-0.0983692,0.213226,-0.098914,-0.164622,0.0237077,0.117488,0.377729,0.342765,0.614596,0.178779 +3431.57,0.922287,0.0912059,4,1.51739,1.02478,-0.210685,0.106302,-0.0147518,0.0147695,0.395347,0.299933,0.761785,0.114257,0.130035,0.286975,0.638179,0.472639,-0.112898,1.44523,0.156063,-0.0844558,0.162096,-0.123839,-0.0872563,-0.750711,-0.552433,0.25828,-0.245738,-0.12164,0.334238,0.248756,-0.476139,0.0742163,1.00227,-0.0873722,0.343761,0.354812,-0.212634,-0.317155,-0.156924,0.858405,-0.0960537,-0.644424,1.06909,0.448815,0.573404,-0.982672,-0.1608,-0.844256,-0.474177,0.674929,0.445782,-0.175598,0.0547746,0.557446,0.248064,-1.44029,0.992729,-0.421681,-0.292745,-0.848687,0.096761,-0.292511,0.271839,0.809423,-1.53694,-1.1666,0.34223,0.0764854,0.519641,-0.0555008,0.0769092,-0.106769,-0.208636,-0.0303763,0.767133,0.124182,0.249295,0.474425,0.350621,-0.496625,0.0218544,0.0420363,0.44037,0.0970962,0.299023,0.157859,-0.189602,0.0899591,0.169643,0.125102,-0.336913,-0.4682,0.05408,0.0114425,-0.0395556,-0.239753,0.417345,-1.08645,0.0477325,0.322967,0.347073,0.364611,-0.114356,0.0910716,-0.0999247,-0.771544,0.00733524,-0.828128,-0.082447,-0.102841,0.441152,0.669189,-0.383967,-0.192026,-0.338697,0.170774,0.484926,-0.0592661,-0.190917,0.166819,-0.13574,-0.511526,-0.277648,0.00294873,-0.11943,-0.198315,-0.194834,-0.128364,-0.20402,0.288366,0.0874568,-0.179729,0.0714343,-0.0169305,0.00311899,0.354935,-0.181997,0.152151,0.00415796,-0.330008,0.262468,-0.412491,0.057766,0.0745527,-0.477465,-0.501081,0.157951,0.27569,0.330714,-0.0585931,-0.331308,-0.247525,-0.217576,0.26258,-0.474037,-0.101659,-0.138677,-0.00615234,0.0941629,-0.0590037,-0.0427459,0.440588,0.145767,-0.259546,0.711955,0.159068,-0.346059,-0.25196,-0.374164,-0.169151,-0.102325,-0.31376,0.189452,0.379912,-0.522175,-0.513479,0.306744,-0.109801,-0.113523,-0.854393,0.188767,0.548772,0.144039,-0.134937,0.330902,0.0488829,-0.203903,0.169688,-0.315716,-0.185056,0.0507194,-0.830983,0.180336,0.149729,-0.264198,-0.382571,0.125926,-0.41525,0.0688021,-0.534056,-0.252403,0.614324,0.334512,-0.113673,0.76346,0.625933,0.0270973,-0.343593,-0.255825,0.692877,-0.987957,-0.0389885,0.186394,-0.10918,0.669174,0.0777374,-0.11883,0.13897,-0.140478,0.252564,0.380543,-0.731898,0.502032,-0.30015,-0.499259,0.36063,-0.17745,0.683011,-0.116553,-0.180444,0.474714,-0.206738,-0.106947,-0.304735,0.280692,-0.247441,-0.528944,0.586194,-0.285119,0.0814839,0.447155,0.193873,0.0262178,-0.421763,0.0979098,-0.180756,0.286988,0.3413,0.255883,0.0592524,-0.532766,-0.231781,0.0115631,-0.301724,0.123268,0.187109,0.347109,0.256257,-0.621316,0.334338,0.569157,-0.0277104,0.349124,0.480529,0.231776,0.315545,0.569818,-0.342435,-0.214598,0.427041,-0.552635,-0.050571,-0.385016,-0.251449,-0.100338,-0.125582,0.850966,0.104889,-0.058088,-0.0842585,0.156823,-0.156067,0.149575,0.189897,-0.0984954,-0.564826,-0.220597,0.198232,0.103514,0.0259538,0.0544554,-0.0939397,-0.514558,0.161493,-0.0382992,0.00857477,0.155277,-0.289357,0.350315,-0.15105,0.35933,-0.217386,-0.216734,0.113661,0.323406,0.337136,0.568688,-0.239202 +3415.64,0.556505,0.0912059,4,1.47871,1.0473,-0.399976,0.168057,0.231809,-0.104184,0.122957,0.499645,0.848072,0.603503,0.111211,0.0795395,0.0607112,0.548864,0.0274724,1.26214,0.25123,0.0475032,-0.0620312,0.244589,0.0109301,-0.738844,-1.31396,-0.0384653,-0.289746,0.130809,0.016816,0.934428,-0.0753944,0.504581,1.03648,-0.414172,0.520193,0.0131279,-0.0853483,-0.126113,-0.337143,0.546503,0.180818,-0.32932,0.813456,0.393522,0.504528,-0.555479,-0.132084,-0.318019,-0.772847,0.174037,0.250982,0.108388,-0.117392,0.351651,0.557955,-0.939489,0.797499,-0.364253,-0.113946,-0.940452,0.165021,0.392213,0.24232,1.02207,-0.45395,-1.45492,-0.127717,0.456545,0.0401664,0.163883,-0.372711,-0.136356,-0.00435125,0.555739,0.420815,-0.449782,0.235702,0.464034,0.438591,-0.206884,-0.127538,-0.273105,0.237411,-0.273791,0.172237,0.811016,0.0781394,-0.19514,-0.0625609,0.218025,0.459494,-0.531756,-0.0357343,-0.306811,-0.129968,0.000111055,0.642158,-0.597032,0.35734,0.235325,0.163665,-0.157618,0.230019,-0.000980043,-0.0241648,0.221304,-0.232854,-0.0667998,0.0207408,0.0296013,0.331376,0.522488,0.00834298,-0.558687,0.274627,-0.0455504,0.703986,0.0238044,-0.549258,0.393433,-0.00871601,-0.782651,-0.917582,-0.0411898,-0.475047,-0.305458,-0.253459,0.359654,0.148113,0.476326,0.099309,-0.309646,0.518801,0.113247,0.121305,0.0702891,-0.309468,-0.119156,0.209253,-0.0513427,-0.120796,-0.435699,0.096711,-0.0820384,-0.0630413,-0.246558,0.329277,-0.49749,-0.263115,0.0244667,-0.228035,-0.475759,-0.869407,0.133504,-0.204469,-0.198459,-0.11968,0.228902,-0.233586,-0.162219,0.0841811,-0.0835813,0.16939,-0.0173267,0.525347,0.150547,0.0214013,-0.389671,-0.0684516,-0.186279,-0.780122,-0.272997,-0.325576,0.672176,-0.145396,-0.479785,-0.0951788,0.167691,0.447907,0.00153285,0.289174,0.469238,0.591713,0.152253,0.231568,0.199119,0.188833,0.134622,-0.389962,-0.486872,0.198495,-0.184459,0.00365616,0.153906,-0.247903,-0.105425,-0.700086,0.322297,0.0752211,0.0761229,-0.263447,0.0695318,-0.167054,-0.463665,-0.0759579,-0.295715,0.406702,-0.453397,-0.421825,0.755849,-0.206499,0.764206,-0.161113,-0.0364474,-0.0159892,0.3148,-0.33128,-0.112848,0.0040853,0.314342,0.569093,-0.693228,-0.026554,-0.130889,-0.252626,-0.000518546,-0.186546,0.31857,-0.0682696,0.0451635,-0.456596,-0.124594,-0.205439,-0.192436,-0.0613345,0.0859485,-0.716862,0.602616,-0.172921,0.109225,0.570479,-0.0925819,-0.4154,0.0276208,0.0930142,-0.364721,0.0494973,-0.339614,-0.37093,-0.558435,0.156044,-0.124704,0.266538,-0.871844,0.297922,-0.181234,-0.126388,0.0561845,-0.123986,-0.151118,0.471048,0.376478,0.357164,0.0984085,0.397522,0.177023,-0.00209131,0.370578,-0.255014,-0.0367065,-0.117874,0.0924011,-0.256486,-0.147779,-0.320335,-0.985611,-0.384873,0.134623,0.196686,-0.0309509,0.00946331,-0.271726,0.0679258,0.354401,-0.45524,0.298681,0.476343,-0.293436,0.0218005,-0.00653565,-0.232066,0.392067,-0.14057,0.271891,-0.111063,-0.0144157,0.0640157,-0.13279,-0.320429,-0.0268502,-0.325328,-0.134464,0.229951,0.116739,0.376123,0.34167,0.613288,-1.06559 +3438.36,0.926357,0.0912059,5,1.63424,0.761388,-0.855472,0.262052,0.112264,-0.00998609,-0.0243743,-0.146444,-0.21231,-0.1382,-0.510241,-0.326464,-0.071289,0.335924,-0.00216817,0.419849,0.162346,-0.313592,-0.179917,0.331888,-0.144105,-0.759371,-0.423652,0.392913,-0.274541,-0.230157,0.1334,-0.320057,-0.246803,0.197969,0.886215,-0.259662,-0.401934,0.153878,-0.146444,-0.321758,-0.553434,0.191191,0.109948,-0.231649,0.92521,0.535841,0.0311184,-0.832016,-0.0341056,0.0837987,-0.249836,-0.126886,0.474433,-0.249807,0.199202,0.0491592,0.399328,-0.27964,1.14259,-0.278042,0.05349,-0.302024,0.840803,-0.998146,-0.282856,0.901768,-0.734355,-0.589065,0.222089,-0.190424,-0.0713441,-0.266919,0.505004,-0.409157,-0.136981,-0.110879,0.593173,0.271747,0.315157,0.712326,0.0358834,0.163304,-0.381672,0.300138,0.734591,-0.272733,0.13174,-0.814778,-0.280788,0.0247722,0.177239,-0.3196,-0.380568,-0.208255,-0.0696033,0.308474,-0.187021,-0.0309573,-0.417151,0.22919,-0.431341,-0.438973,-0.19412,0.587671,-0.0915497,-0.0618519,-0.420123,-0.564532,0.319491,-0.221604,0.0979961,-0.186795,0.0795711,0.276758,-0.0819802,0.00308795,-0.0870603,0.109704,-0.598926,0.142572,-0.0372366,-0.128282,0.501882,0.5781,-0.239631,-0.0600307,0.171151,-0.0322937,0.120628,-0.0912259,0.079531,-0.31503,0.364042,-0.262181,-0.354922,-0.0742535,-0.0657636,0.591392,0.31931,-0.0873047,-0.245782,-0.22875,0.730187,-0.241301,-0.591347,-0.0449241,0.260301,-0.469079,-0.326526,0.732085,0.144564,0.496758,-0.102717,0.18006,0.452966,-0.0812371,0.399441,0.335136,0.525096,0.305331,0.539492,-0.032077,0.0248746,0.0462143,0.0795545,0.168506,0.722108,-0.0987246,0.00202624,0.30596,0.0796484,-0.0275557,0.389862,0.253969,0.213644,-0.572777,-0.229346,0.306913,0.013072,-0.439219,-1.01032,-0.0881531,-0.184839,0.446732,-0.406657,-0.347074,-0.0233457,-0.333966,-0.237821,-0.629443,0.0309489,0.0845907,-0.0360114,-0.324051,0.0717862,-0.104888,0.0950569,-0.545542,0.557949,-0.0141571,-0.06829,-0.586379,-0.265649,-0.107509,0.141514,0.233215,0.286898,0.111332,-0.27883,0.416177,-0.258156,0.738052,0.166266,-0.40631,-0.120866,-0.249862,0.517114,-0.0350785,-0.114099,0.517134,-0.457191,-0.167198,-0.161372,0.212059,0.15143,-0.48089,0.114722,0.41307,-0.358967,0.415575,-0.392759,-0.302878,0.586286,-0.0944722,-0.0483848,-0.0620368,-0.164254,-0.239505,0.0736561,0.200578,0.238333,-0.0474938,0.130501,-0.305829,0.101814,0.0070369,-0.193787,0.292021,0.290721,0.396692,0.605662,0.620745,-0.313069,-0.489118,-0.360802,-0.167332,0.549923,-0.280913,-0.185856,0.169598,-0.462162,0.28947,-0.447632,-0.326372,-0.0633065,0.264801,-0.400207,0.111771,0.300805,-0.300643,-0.319062,-0.136207,-0.0175168,-0.49556,-0.18643,-0.0675597,-0.00251008,0.77946,0.379087,-0.287601,-0.168175,-0.00815126,0.228064,0.425606,-0.42638,-0.484549,0.0106924,-0.539547,-0.19861,0.408845,-0.428514,0.307103,0.0163197,-0.519155,-0.0652615,-0.186418,0.127854,0.092293,-0.34176,-0.448135,0.17901,-0.353349,0.0833062,-0.120136,-0.317349,0.110176,0.21111,0.331928,0.459467,0.118905 +3433.89,0.907022,0.0912059,4,1.66298,0.825334,-0.844862,0.280695,0.337187,0.121849,0.133455,0.13569,0.00303314,-0.055703,-0.415084,-0.209172,0.105992,0.552978,-0.250304,0.477522,-0.0459587,-0.292386,-0.180554,-0.0762647,-0.541109,-1.07882,-0.0133649,0.330246,-0.209914,0.0399154,-0.0427711,-0.220051,-0.656058,-0.10642,0.840061,-0.332794,-0.216695,0.487138,-0.214856,-0.0762967,-0.394523,0.193698,0.24884,-0.236478,0.758451,0.47177,0.113527,-0.564383,-0.150705,-0.292101,-0.802324,0.0457349,0.412307,-0.0226846,0.0269554,-0.0887074,0.225202,-0.0198242,0.553957,0.0435038,-0.0674819,-0.455364,0.587641,-0.668549,-0.248989,1.23683,-0.855615,-0.858738,0.57905,0.126393,-0.15509,0.153602,0.218065,-0.0598491,-0.339876,0.411981,0.454632,0.00261642,0.227677,0.481739,0.238931,0.038312,-0.388921,0.257332,0.0600369,-0.420033,0.068324,-0.470253,-0.48211,0.0212874,-0.0628558,-0.133874,-0.195697,-0.352211,-0.320939,-0.128658,-0.444294,-0.22609,-0.359213,-0.156165,0.339468,-0.541594,-0.0830146,0.463138,0.0449697,-0.274137,-0.00645595,-0.296753,0.149811,-0.0470004,0.0121189,-0.0990967,0.226468,0.259058,0.0192425,-0.50097,0.000474249,0.608436,-0.479106,-0.272427,-0.380824,0.0937374,0.48569,0.281693,0.0538957,-0.197309,-0.45604,0.0109164,0.220647,0.00635656,-0.131366,-0.244951,0.758492,-0.529679,-0.158076,0.261506,0.21233,0.696912,0.221968,0.25284,-0.33631,-0.379168,0.747653,-0.5541,-0.643361,-0.134788,0.160999,-0.740633,-0.0984694,0.520944,-0.0935484,0.222021,0.0390527,0.196274,0.08474,0.249657,0.234674,0.261508,0.498699,0.27895,0.803589,-0.0218433,0.145572,0.153601,0.337827,-0.254833,0.591031,0.0650756,0.390277,-0.141232,-0.000303141,0.0071244,0.288026,-0.0202664,0.251209,0.00691051,0.0903128,0.188912,-0.415712,-0.149142,-0.650926,-0.111658,-0.330806,0.467687,-0.3519,-0.476413,-0.0316361,-0.278466,0.263985,-0.0513954,0.0987052,-0.00219559,-0.219971,-0.36465,0.180974,-0.0281578,0.1717,-0.611657,0.82378,0.319386,-0.258471,-0.762337,-0.178039,0.209553,0.0276653,-0.0324513,0.235766,-0.243529,-0.152517,0.457114,-0.418912,0.868728,0.193559,0.212749,-0.223998,-0.1774,0.474301,-0.168411,-0.197967,0.109753,-0.605219,-0.270459,0.373722,0.256483,0.0728843,-0.186975,0.298597,-0.1305,0.268159,0.704716,-0.218789,-0.488694,0.764596,-0.0739689,0.347864,0.100578,-0.521448,-0.35013,0.112201,0.332963,0.28337,0.245162,0.354139,-0.444974,-0.128106,-0.106713,-0.451088,0.391381,0.580442,0.447144,0.62571,0.300921,-0.176563,-0.47622,-0.0628186,-0.501911,0.194206,-0.294853,-0.750391,0.0360588,-0.0241047,0.549305,-0.498498,-0.159399,0.199854,0.587336,-0.271929,0.0643488,-0.117493,-0.202434,-0.0354833,0.27453,0.267398,-0.175633,-0.604562,-0.214678,-0.0710872,0.527858,0.145837,-0.142805,-0.348433,-0.366535,0.280971,0.395838,-0.708378,-0.341967,0.102669,-0.429782,-0.136018,0.213529,-0.0373384,0.125148,-0.071086,-0.157325,-0.127125,-0.056839,-0.293478,0.0301332,-0.38163,-0.496714,0.529456,-0.252419,0.205693,0.218337,-0.362846,0.119945,0.20497,0.34633,0.452737,-0.768317 +3426.51,0.853565,0.0912059,4,1.63783,0.794981,-0.905499,0.331242,0.251509,0.0429471,0.689908,-0.179212,-0.0980573,-0.000713974,-0.195161,-0.236714,0.217526,0.401113,-0.000433641,0.81846,0.432269,-0.142828,-0.415938,0.481025,0.112653,-0.919268,-0.777111,0.249186,-0.296033,0.0031907,0.585245,-0.151752,-0.323671,-0.155949,0.826962,-0.313338,-0.127077,0.0169494,-0.199922,-0.594642,-0.264282,0.116282,0.00419919,-0.111306,1.26258,0.300184,-0.0282521,-0.555303,0.145374,0.458769,-0.572831,-0.249498,0.293109,-0.0137866,0.13832,0.177996,0.105499,-0.254155,0.669334,0.107408,-0.0822195,-0.433765,0.672753,-0.32606,-0.129667,0.85421,-0.994678,-0.882821,0.240148,0.0171579,-0.0486131,-0.500728,0.0347261,-0.129849,-0.228155,-0.0133056,0.61534,-0.0431538,0.75387,0.182434,0.145027,0.0282199,-0.42911,-0.217584,0.766875,-0.500037,0.414816,-0.593143,-0.390887,-0.864117,0.348286,-0.173017,0.280157,-0.542746,-0.476322,-0.0117463,-0.158233,0.472854,-0.227459,-0.321483,0.375032,-0.534048,-0.279647,0.384455,-0.122483,-0.321026,-0.194256,-0.105525,-0.0134445,-0.0188334,0.343154,-0.231269,0.0960504,0.465685,-0.146589,-0.320833,-0.0984352,0.309109,-0.218691,0.0740166,-0.141542,-0.0264483,0.16032,-0.0459603,-0.786916,-0.703489,0.329546,0.0313058,0.0156194,-0.415555,0.183822,-0.0572382,0.443608,-0.0161023,-0.238608,-0.16705,0.262217,0.0427313,0.211912,-0.04294,0.28899,-0.357818,0.443661,-0.631235,-0.764695,-0.111998,0.219638,-0.585001,0.0896693,0.280125,0.226747,0.329442,-0.126469,0.0630084,-0.678564,0.317982,-0.0839165,0.669163,0.173011,0.273911,-0.270502,-0.179988,-0.0730508,-0.223203,0.579726,-0.405705,0.514752,0.0750677,0.399831,0.169809,-0.0284577,-0.204419,0.304784,-0.186565,0.200515,-0.0722202,0.0654736,0.174885,0.492429,-0.356322,-0.389626,-0.220226,-0.182346,0.27125,0.365483,-0.318034,-0.663726,-0.338586,-0.202841,-0.671496,-0.262724,0.293693,0.334125,-1.13821,0.187407,-0.261284,-0.201035,-0.742344,0.233938,0.20885,-0.402956,-0.36099,-0.146587,-0.11449,-0.00537095,-0.0845322,0.00329992,-0.134356,-0.461789,-0.110205,-0.218278,0.992483,0.370788,0.575406,-0.239267,-0.417645,0.250818,0.639086,0.0261984,0.655615,-0.408863,-0.0106459,-0.101813,0.132254,0.0689368,-0.277422,0.0935445,-0.0384731,0.20076,0.472014,0.404528,0.418511,0.335745,-0.0376443,0.0843612,0.17836,-0.0433677,-0.0236098,0.287099,0.0718655,0.394379,0.277116,0.478613,-0.290646,-0.034859,-0.273044,-0.916742,-0.136322,0.080396,0.0905494,0.157568,0.0477545,-0.268036,-0.446552,-0.178321,-0.195281,0.124784,0.33071,0.0700713,0.262346,-0.715165,0.367569,0.338757,-0.0393986,0.155132,0.0357153,-0.38518,0.312965,-0.108224,-0.185371,-0.378137,-0.284754,-0.474592,-0.152483,-0.355797,-0.054133,0.0522582,0.392779,0.0236638,0.0297264,-0.142549,-0.143973,-0.150213,-0.111365,-0.912805,-0.539205,-0.0187466,0.0984053,0.272608,0.0275807,-0.0482004,-0.310006,-0.0747738,-0.235198,0.0618207,0.0217403,-0.104229,0.128882,-0.652642,-0.30806,0.260582,-0.471231,0.329074,-0.0541504,-0.0891971,0.113414,0.217619,0.33677,0.466496,-0.451724 +3450.88,0.559382,0.0912059,4,1.6722,0.87193,-0.427389,0.121022,0.420331,0.0465165,-0.386617,0.455248,0.409527,0.203473,-0.00167633,-0.289079,-0.104424,0.496173,-0.115922,0.683717,0.0541815,-0.27453,0.373318,-0.093509,-0.0818545,-0.848771,-0.359732,0.133592,-0.0376814,-0.260542,-0.268327,0.514065,-0.752993,0.241616,0.78341,-0.450423,-0.330092,0.406444,-0.0925478,0.0497307,-0.667235,-0.0263047,0.20734,-0.123198,0.759798,0.507919,-0.0209565,-0.300782,-0.0175883,-0.322659,-0.88986,0.0213567,0.439318,0.0470544,-0.138968,0.100883,0.562465,-0.795634,0.724581,-0.254663,-0.817417,-0.804979,0.527503,-0.191197,0.526004,0.768066,-0.300915,-0.560737,0.182936,-0.158227,-0.215595,0.641835,0.296786,-0.487585,-0.148201,0.269653,0.547623,0.0449113,0.123775,0.378838,0.1277,-0.0988579,-0.426624,0.185327,-0.00531565,-0.0880855,0.329999,0.190852,0.172508,-0.0851541,-0.261644,0.267833,0.102573,-0.0733608,-0.128654,0.0717698,0.0200423,-0.437913,0.219914,0.0223684,0.201543,-0.0209012,0.188991,0.101427,-0.0602693,-0.0691076,-0.719004,-0.135865,0.0715011,-0.440017,0.323885,-0.117958,0.205274,0.676781,-0.352082,-0.544525,0.262318,0.673188,0.0130644,0.626557,0.196647,-0.0278581,-0.320589,0.0826258,-0.834849,0.00767524,-0.270462,-0.0873976,-0.22154,0.433424,-0.0909628,0.320053,0.0261008,0.239126,-0.0110791,0.029136,-0.130184,0.643059,-0.202413,0.381147,-0.316536,-0.0756363,-0.0497829,-0.285697,-0.66279,0.209428,-0.0298416,-0.22298,0.116042,0.126566,0.0735386,0.138567,-0.155967,-0.222187,-0.468321,-0.0526577,0.197671,0.0959818,-0.0324245,0.356724,0.0617279,-0.717645,0.172574,0.100462,-0.480788,0.113476,0.215029,0.223008,0.263602,-0.258368,-0.0066925,-0.248182,-0.108575,-0.10434,-0.311462,0.112019,0.0941748,-0.264522,0.280497,-0.151453,-0.288569,0.296014,-0.00470647,1.16068,-0.0962868,-0.429487,0.179111,-0.426932,-0.233196,0.0365525,0.278362,0.00220987,0.145703,-0.861045,-0.0376795,0.250281,-0.314158,-0.392309,0.273234,0.0808753,0.0780512,-0.784608,-0.220716,-0.0149361,0.0896838,-0.257883,0.252859,0.137218,-0.0573018,-0.00347677,-0.624486,0.965321,0.105236,0.536544,0.0557418,-0.036433,0.426849,-0.240946,-0.254127,0.40774,-0.667752,0.247921,0.146173,-0.123881,-0.323831,-0.630666,-0.274683,0.699354,-0.486711,0.192091,-0.775623,-0.681278,-0.0675048,-0.259058,-0.425081,0.163636,-0.192212,0.149129,-0.902845,0.427266,-0.0619016,-0.261516,0.515213,0.248622,-0.247709,0.0790492,0.110785,-0.0930256,0.0458126,-0.0328915,0.259905,0.177902,-0.219437,-0.133036,-0.141147,-0.353343,0.218493,-0.286554,-0.660687,-0.198183,-0.295879,-0.103359,0.154964,0.00577644,-0.0640676,0.417078,-0.0423098,-0.18667,0.448092,0.0635374,0.0173427,0.0521283,0.403573,0.0310626,-0.389634,-0.339365,0.0118101,0.192588,-0.0792163,0.149106,-0.675329,0.252553,0.544145,-0.157892,0.25781,0.244661,-0.0552467,-0.18561,0.0784593,-0.0927736,0.0396328,0.679242,-0.117613,0.303593,-0.119782,-0.239676,0.373516,-0.10838,-0.44138,0.0208339,-0.343578,-0.468193,-0.493137,-0.0306932,-0.0943581,0.109338,0.144836,0.330662,0.380573,-1.16659 +3451.08,0.884501,0.0912059,4,1.67252,0.882377,-0.455901,0.131402,0.321351,0.0329998,-0.397967,0.40318,0.416735,0.156784,-0.0524621,-0.247962,-0.0591362,0.454754,-0.0719746,0.686572,0.0680609,-0.249217,0.430715,-0.0256419,0.0125748,-0.846607,-0.4331,0.0311176,-0.0393194,-0.224642,-0.269882,0.518482,-0.782235,0.267662,0.746504,-0.371358,-0.264486,0.479192,-0.0718805,0.0371183,-0.727843,-0.19724,0.265531,-0.126563,0.802122,0.50202,-0.0561364,-0.301511,-0.0161507,-0.309957,-0.908478,0.0689865,0.439108,-0.00472869,-0.0760336,0.0135311,0.516902,-0.823821,0.751849,-0.272678,-0.848986,-0.878905,0.537876,-0.259415,0.577441,0.767438,-0.285817,-0.659554,0.205937,-0.158187,-0.264037,0.625968,0.325713,-0.508486,-0.161644,0.31588,0.500498,-0.0121751,0.101874,0.372163,0.0357117,-0.0729705,-0.330981,0.19525,0.0781485,-0.0519824,0.264027,0.146194,0.141944,-0.0426229,-0.272305,0.192791,0.0935993,-0.0521875,-0.172753,0.125293,-0.078117,-0.440814,0.185391,-0.0456251,0.226758,-0.0625696,0.0947659,0.10186,-0.0894929,0.0064953,-0.780263,-0.205156,0.129164,-0.31153,0.372767,-0.160085,0.268236,0.616257,-0.220022,-0.572118,0.324354,0.640424,-0.0185192,0.616275,0.16869,-0.054664,-0.326651,0.0669384,-0.789777,-0.0661748,-0.225467,0.0181636,-0.173146,0.333841,-0.0729761,0.306776,0.00848863,0.212356,-0.0738228,0.0291643,-0.0737037,0.717631,-0.225201,0.414007,-0.210317,-0.0751906,-0.0236262,-0.285223,-0.619066,0.164484,-0.0442955,-0.22109,0.0860802,0.1068,0.106197,0.20361,-0.228188,-0.2297,-0.401408,-0.012016,0.223296,0.0717396,-0.013107,0.359092,-0.0344588,-0.697312,0.221574,0.116543,-0.489564,0.129324,0.255869,0.208419,0.20527,-0.26356,-0.0777436,-0.219818,-0.110947,-0.0406267,-0.332181,0.0587156,0.110678,-0.181487,0.323483,-0.225806,-0.241627,0.215794,-0.00135208,1.18705,-0.074066,-0.491343,0.186811,-0.334235,-0.301235,0.0580284,0.23753,0.0255948,0.219285,-0.90864,0.00118781,0.258699,-0.351843,-0.403196,0.338839,0.0477298,0.136052,-0.726394,-0.195403,-0.00958155,0.0531263,-0.0994861,0.266134,0.190105,0.0225511,0.0131658,-0.567432,0.969047,0.104168,0.417369,0.0816783,-0.0598009,0.503115,-0.251901,-0.291215,0.37324,-0.594933,0.171994,0.135749,-0.160122,-0.404118,-0.583489,-0.254771,0.715398,-0.577136,0.193095,-0.755657,-0.657121,-0.117116,-0.213058,-0.369845,0.222656,-0.260442,0.147321,-0.84357,0.41549,-0.123849,-0.189442,0.508043,0.344264,-0.276632,0.0211555,0.0933412,-0.138922,0.0401553,0.0244015,0.258313,0.169815,-0.21127,-0.17142,-0.165169,-0.432184,0.251999,-0.207095,-0.678829,-0.21086,-0.249937,-0.0743913,0.14237,-0.0087129,-0.053884,0.43807,-0.158646,-0.121457,0.437229,0.073357,0.00866783,0.0494171,0.365757,-0.0432706,-0.393286,-0.354845,0.0800349,0.137919,-0.102275,0.175222,-0.697425,0.286147,0.537933,-0.290388,0.302858,0.306921,0.012028,-0.227286,0.0711852,-0.117642,0.0314955,0.568363,-0.200342,0.335549,-0.217628,-0.272078,0.369305,-0.149135,-0.436624,-0.0614439,-0.314089,-0.519795,-0.433998,-0.02703,-0.143813,0.107232,0.150004,0.327463,0.387303,-0.847626 +3471.13,0.999162,0.0912059,4,1.56696,0.944278,-0.913078,0.27106,-0.229289,-0.252049,0.547797,-0.432496,0.346445,0.161024,-0.240382,-0.197181,-0.28108,0.569661,-0.0863923,1.07182,-0.045659,-0.151496,-0.492431,0.32568,-0.511213,-1.05462,-0.913001,0.0835926,-0.287462,-0.419296,0.425157,-0.0640516,0.133927,-0.0647652,0.464714,-0.375192,-0.105051,0.0991459,-0.471758,-0.0587861,-0.0692179,0.824229,0.371363,-0.288263,1.1557,0.650932,0.486019,-1.23224,0.00616206,0.486156,-0.201408,0.131674,0.802931,-0.0700374,0.396115,0.492472,-0.0050189,-0.152301,0.298005,0.0864863,0.0428078,-0.14418,0.245249,-0.439493,0.0951791,1.21269,-1.24489,-0.638156,0.164286,0.26235,0.170373,-0.382718,0.0141429,-0.13486,0.154696,-0.166866,0.57112,-0.0720754,0.415053,0.459173,0.564285,0.0228483,-0.403513,-0.162594,0.786552,-0.343701,0.171754,-0.184632,-0.23498,-0.0684038,0.199131,-0.115102,-0.21378,-0.22233,0.385061,-0.0337874,0.150005,0.203344,-0.236045,-0.266633,0.133762,-0.309395,-0.210179,0.126137,0.166686,0.129786,0.200925,-0.225839,-0.0199045,-0.170929,-0.0623472,-0.292105,0.169046,0.352092,0.053617,0.0583757,0.0386529,0.549531,0.0290185,-0.317697,-0.737574,0.124965,0.771167,-0.205192,-0.332873,0.140621,-0.0612754,-0.208862,0.0349259,0.0605186,0.115052,-0.114857,0.356334,-0.631107,0.35717,-0.00367847,0.327017,-0.082651,0.115519,-0.336528,0.0141282,-0.417244,0.554792,0.00661123,0.0826547,-0.111402,0.252989,-0.127619,0.105203,-0.0113609,0.0249384,0.169171,0.29894,0.219368,0.244635,0.158802,-0.307389,-0.00859311,0.225435,0.316147,0.168633,0.518201,-0.325074,-0.226881,0.621062,-0.237299,0.526309,-0.334163,-0.129496,0.394884,-0.037666,-0.150354,-0.116147,0.106562,0.259756,-0.0205306,0.102146,-0.0813213,-0.154313,-0.11097,-0.133084,0.109073,0.0351042,-0.0228423,0.191802,-0.112759,0.0579657,0.255833,0.324412,-0.783199,-0.274318,-0.250548,-0.0574825,0.4334,0.0906676,-0.210536,0.0755544,-0.296205,-0.21562,0.0310504,-0.425382,0.263562,-0.394264,0.11189,-0.0418768,-0.0612524,0.113282,-0.383524,-0.0248069,-0.0460682,-0.557266,1.07765,-0.294532,-0.0416532,-0.0675882,-0.538102,-0.276953,0.205569,0.13932,-0.0436572,0.166815,-0.13184,0.169197,-0.202432,0.395501,-0.105566,0.0109406,-0.311003,0.276704,0.377114,0.0393994,0.163783,0.0751867,-0.0278863,0.195268,0.296062,0.122297,-0.180224,0.171653,0.359509,0.431492,-0.111237,0.434709,-0.566103,-0.0680484,0.0151928,-0.00631288,0.141596,0.217519,0.168882,0.470504,0.0467788,0.168906,-0.44003,0.199695,-0.468936,0.461578,0.022027,0.341321,0.151809,-0.120589,0.283774,0.109876,0.234663,0.104901,0.227708,0.253688,0.327905,-0.12538,-0.0439654,0.285783,0.0590002,-0.0410674,0.0676431,-0.0140874,-0.151624,-0.190562,-0.0673016,0.00968828,-0.328711,0.51764,-0.278349,-0.335648,0.222608,-0.73275,-0.196814,-0.522799,0.428313,-0.078131,0.400507,-0.151588,-0.305528,-0.0353661,-0.298284,0.412273,0.237247,-0.0920845,0.0991344,0.239863,-0.527647,0.131669,0.292676,0.185871,-0.0385143,-0.0531148,0.0750354,0.351228,0.273926,0.592645,0.944408 +3465.93,0.938799,0.0912059,4,1.57525,0.941155,-0.97416,0.291047,-0.0308112,-0.229954,0.562521,-0.353459,0.243468,0.00354926,-0.500408,-0.154931,-0.211385,0.576632,0.0919201,1.24622,-0.0777011,-0.358448,-0.424315,0.403157,-0.309235,-1.2096,-0.845347,0.00799885,-0.0921856,-0.413383,0.165264,-0.0171572,0.0858059,0.0757202,0.548023,-0.608,-0.118722,-0.0789003,-0.350976,0.110289,0.00458029,0.835708,0.512159,-0.617284,0.963041,0.565351,0.596441,-1.32604,0.113562,0.468927,-0.466724,0.344221,0.493928,0.0281965,0.304451,0.118953,0.039676,-0.519877,0.37074,0.266993,0.114196,-0.312179,0.363968,-0.559957,-0.0605242,1.27578,-1.06793,-0.824527,0.221393,0.340533,-0.00491557,-0.483589,-0.111754,-0.131138,0.328536,-0.132551,0.524478,-0.180225,0.171212,0.643556,0.376748,0.0184443,-0.304797,-0.0474397,0.490037,0.111556,0.159586,-0.0182771,-0.378857,-0.0143344,0.135683,-0.227265,-0.075716,-0.307988,0.327725,-0.068165,0.0785134,0.125223,-0.0747855,0.0268695,-0.1489,-0.50864,-0.159336,0.124698,0.189449,0.242132,0.103221,-0.0821981,-0.118758,-0.18408,0.0444654,-0.0764717,0.291199,0.288435,0.0949752,-0.287646,-0.00401093,0.624547,-0.128046,-0.25529,-0.710761,0.0752305,0.49751,-0.146592,-0.184979,0.290255,-0.346247,-0.344031,-0.240759,-0.158035,0.151343,0.0336183,0.294575,-0.437292,0.0632954,-0.0746311,-0.145962,0.159633,-0.116175,-0.35168,0.266055,-0.419305,0.420023,0.30899,0.151093,-0.216338,0.597931,0.00765487,-0.252767,-0.0705702,-0.010946,0.0582152,0.0972858,-0.00603127,-0.0422344,0.166692,-0.24602,0.214277,0.340521,0.207807,0.0470794,0.360997,-0.295543,-0.166265,0.635298,0.0925231,0.450683,0.0354706,-0.0861177,0.24809,0.0238369,-0.18156,0.064603,-0.0354649,0.40535,0.102067,0.0598386,-0.0248672,-0.100447,-0.352193,-0.160809,0.019466,0.0138518,0.0645695,0.0936106,0.239694,-0.0605294,0.161598,0.362364,-0.609099,-0.364771,-0.265361,-0.174009,0.322675,-0.0607279,-0.0201444,-0.0428425,-0.380229,-0.31788,0.169248,-0.362708,0.130357,-0.00594751,0.208505,-0.152865,-0.138241,-0.339766,-0.130422,-0.137311,-0.177362,-0.228922,0.934817,-0.23577,-0.201047,0.0607995,-0.509021,-0.255078,0.715288,0.14152,0.167062,-0.144947,-0.12121,0.422574,-0.309833,0.133376,-0.0181764,-0.0278036,-0.245399,-0.00200037,0.376942,0.0886369,-0.0666307,0.113907,0.0972939,0.397447,0.269539,0.0507195,-0.290985,-0.0793935,0.42701,0.22175,0.000747657,0.224246,-0.58301,0.164435,0.106631,-0.119371,0.0457219,-0.121391,-0.00469062,0.570305,0.0281343,-0.017035,-0.500162,0.0160664,-0.461643,0.466636,-0.0120946,0.424917,-0.00699886,0.199078,0.446942,0.0672046,0.358071,0.211553,-0.206521,0.0623456,0.446316,-0.112932,0.235955,0.312566,0.092987,-0.178559,0.411015,-0.331449,-0.42529,-0.29552,0.10157,0.00607385,-0.172468,0.424582,-0.166157,-0.217664,0.039617,-0.589845,-0.208996,-0.902648,0.300172,0.168596,0.169938,-0.271703,-0.0634573,0.135116,-0.214081,0.347302,-0.128036,-0.25469,0.0437103,0.159956,-0.60166,-0.117386,0.126411,0.142196,0.236701,-0.0330163,0.0689528,0.373225,0.262589,0.610921,0.306927 +3471.66,0.926186,0.0912059,4,1.56674,1.03042,-1.19314,0.402255,0.762198,-0.204136,-0.148696,0.244441,0.445261,0.278863,0.0469719,-0.235152,0.519538,0.268891,-0.177036,0.418553,-0.000512845,0.160706,0.0425468,0.132508,-0.207131,-1.04441,-0.743823,-0.00925349,-0.545072,0.0979589,-0.237096,0.287613,-0.585151,0.00802388,0.673178,-0.147595,-0.000281787,0.310732,-0.687165,0.0084588,-0.552935,0.400134,0.397383,-0.150835,1.32436,0.77959,0.117776,-0.310006,-0.491691,0.273428,-0.617633,0.00112154,0.31467,-0.00117952,-0.18124,0.977469,0.0900048,-0.349208,0.53541,-0.519392,-0.891078,-0.929583,0.769848,-0.42603,0.639711,0.953876,0.0438028,-0.870136,0.244307,-0.180827,-0.0534632,0.193099,0.201416,-0.255756,-0.499785,0.0960214,0.226616,-0.0804919,0.547937,0.0548639,0.0554854,0.0264285,-0.263941,0.136284,0.369741,-0.403565,-0.0847659,0.0777519,0.101918,-0.00118213,-0.0333661,-0.0200952,0.148735,-0.38813,-0.362177,0.06739,-0.14242,-0.190961,-0.0548527,-0.308091,0.173639,0.0372119,0.236481,-0.26281,-0.210732,-0.290328,-0.588518,-0.0295075,0.088477,-0.0747847,0.343002,-0.227793,0.0354919,0.506252,-0.195541,0.0458096,0.166929,0.208685,0.13658,0.587962,0.353199,-0.126687,0.0187524,0.00232326,-0.653924,-0.401731,0.225186,0.153301,0.0924024,0.372494,-0.214135,0.0625263,0.14469,-0.00428478,-0.214573,-0.172066,0.0356831,0.419885,-0.0592557,0.148211,-0.227693,-0.0301503,0.171647,-0.674622,-0.441558,0.0510764,-0.454501,-0.552066,0.366727,0.265291,-0.0675442,0.335048,-0.283423,-0.112694,-0.170743,-0.1159,0.441574,-0.424408,-0.17835,0.203215,-0.100123,-0.261949,-0.139275,0.0249081,-0.382683,-0.244013,0.68462,-0.115024,0.0698437,-0.00158682,-0.218148,-0.0100852,-0.232367,-0.0882341,-0.228705,-0.165865,-0.215122,-0.117867,0.306535,0.249927,-0.375713,0.202715,0.101644,0.846701,-0.114703,-0.426782,0.239343,-0.269731,-0.403924,0.0992669,0.0964991,0.0114047,0.340271,-0.921051,-0.126039,-0.159389,0.0118556,-0.268938,0.325051,0.00312568,0.0221085,-0.497287,-0.458077,-0.137608,-0.118248,-0.0723221,0.325508,0.161468,0.27091,0.0409278,-0.317961,0.628402,0.220219,0.311442,-0.13713,0.30772,0.260979,-0.672861,-0.314611,-0.119996,-0.0498666,-0.177828,-0.235371,0.0525981,-0.301429,-0.319539,-0.0554242,0.470648,-0.232851,0.135864,-0.423973,-0.219253,-0.0810686,-0.127449,-0.52135,-0.0113248,-0.238524,0.280895,-0.224717,0.0830323,0.0315816,0.0494519,0.451394,0.179157,-0.300367,-0.0117641,0.1283,-0.0204137,0.273867,0.214223,0.36718,0.217925,-0.243613,0.0278434,-0.04322,0.00467323,0.327814,-0.393841,-0.524763,0.20088,-0.396197,-0.0153499,0.108007,-0.189915,0.0181587,0.463937,0.17881,-0.146704,0.26251,0.0122421,-0.178909,-0.161715,0.220765,-0.33035,0.225155,0.0930486,0.0699832,0.0487462,-0.0991139,0.339981,-0.567786,0.16149,0.349065,-0.0118614,0.684735,0.0253546,0.718081,-0.0929021,0.0538103,0.0823161,0.265744,0.245409,0.0363442,0.121414,-0.20851,0.239617,0.607163,0.189216,-0.353977,0.33501,0.11124,-0.105756,-0.27033,-0.339366,0.0472537,0.0747572,0.250658,0.273418,0.500657,-2.48888 +3471.94,0.719554,0.0912059,4,1.64931,0.788928,-1.31494,0.560583,0.481359,0.088967,0.118348,-0.353195,0.0454443,0.129572,0.310006,-0.267554,-0.646264,0.557925,-0.247426,0.898452,0.218527,-0.157027,-0.198995,-0.248118,-0.171636,-0.653592,-0.767301,0.208404,0.0809521,-0.282848,0.279462,-0.136537,0.0170435,0.0487362,0.669901,-0.999763,0.171848,0.330156,-0.553777,-0.544602,0.0618369,0.455404,0.330284,-0.547358,0.773307,0.365889,0.510271,-0.999343,-0.483859,0.201005,-0.55351,0.297536,0.16393,-0.176675,0.0919494,0.138177,0.0533916,-0.241131,0.0282342,-0.168131,-0.246845,-1.14875,0.13375,-0.953132,-0.208053,1.20399,-0.897904,-0.922122,-0.0433939,0.241257,0.0897204,0.0516313,-0.221668,-0.333785,0.369826,0.0844554,0.529468,-0.0849963,0.293599,0.624239,0.0690907,0.0901154,-0.1146,-0.289493,0.232013,0.00934244,0.471114,-0.184534,-0.544909,-0.102059,0.246453,-0.18554,0.0142406,-0.224002,0.401298,0.0603646,0.0800047,0.43634,0.276868,0.00749662,0.0738978,-0.204111,0.00100991,0.369459,0.201588,0.225373,0.113531,-0.083377,0.0449759,-0.139559,-0.0139318,-0.136927,0.295995,0.11776,0.186822,-0.321511,-0.0729526,0.584447,0.100053,-0.196016,-0.425689,0.200634,0.584565,-0.209588,-0.364139,0.171852,-0.27844,-0.469727,-0.111622,-0.0353861,0.389163,-0.135762,0.221009,-0.477853,0.316123,-0.0801411,-0.131377,0.322444,-0.217817,-0.405681,-0.0430679,0.042451,0.269883,0.248725,0.176997,-0.0466732,0.435531,0.174896,-0.352149,0.00333252,-0.14826,0.196591,0.0155777,0.0556943,-0.147916,0.153253,0.155189,0.492764,0.423881,0.243522,0.398117,0.284937,-0.215141,-0.11261,0.557052,0.21352,0.839043,0.0790305,-0.204275,0.156976,0.110519,-0.070717,-0.0178642,-0.056286,0.422007,0.264049,0.261404,-0.000656647,-0.187126,-0.120297,0.0323334,0.0702313,0.00925223,-0.0156741,0.0355913,0.191157,0.0147373,0.136169,0.441808,-0.391591,-0.538025,-0.322583,-0.106937,0.338002,-0.0766226,0.067206,-0.0068367,-0.465869,-0.535295,0.333015,0.209484,0.0368405,-0.303072,0.319876,0.0587995,-0.391886,-0.302743,-0.286903,0.0626868,-0.273782,-0.373459,0.966577,-0.154376,-0.14891,-0.0392754,-0.334002,-0.0203564,0.612381,0.405339,0.627579,-0.221126,0.118961,0.497673,-0.17472,0.220305,0.0077572,0.0687145,-0.123848,-0.181122,0.469577,0.146316,-0.250736,0.217809,0.11801,0.434456,0.160257,0.253007,-0.162748,0.116897,0.734723,0.200008,0.0290101,0.132121,-0.724637,-0.00842526,0.201606,-0.141387,0.0808993,0.075814,-0.254748,0.231504,-0.105687,0.0191928,-0.767514,-0.0351861,-0.572759,0.208122,-0.0763292,0.355999,0.281296,-0.118244,-0.000632142,-0.00134054,0.171316,0.0212816,-0.127417,-0.0953563,0.478512,-0.057527,0.22493,0.0294452,0.0448027,-0.205568,0.115828,-0.305511,-0.41183,-0.421044,0.125884,0.0550567,-0.14145,0.351344,-0.187092,-0.158186,-0.121367,-0.547993,-0.0768548,-0.998798,0.0996583,-0.0538789,0.0427997,-0.5727,-0.107819,-0.0626457,-0.356921,0.0103252,0.00186449,-0.134645,0.320668,0.22253,-0.505065,-0.174209,-0.266054,-0.0234687,0.325074,-0.0649734,0.0791389,0.261757,0.281316,0.511622,-1.20647 +3470.96,0.984232,0.0912059,4,1.67028,0.768912,-1.32735,0.614676,0.40119,0.0784971,0.0624188,-0.407512,0.0792572,0.182298,0.300981,-0.303859,-0.662146,0.487071,-0.21082,0.908341,0.266686,-0.102609,-0.177442,-0.21918,-0.21801,-0.703143,-0.795593,0.16229,0.078938,-0.325298,0.213766,-0.151734,0.0126488,0.0698586,0.670062,-0.989865,0.126182,0.372684,-0.536036,-0.543467,0.0126281,0.481537,0.373816,-0.545216,0.805339,0.38549,0.512439,-0.949347,-0.488849,0.215818,-0.538433,0.357704,0.147304,-0.114341,0.108204,0.207261,0.0879499,-0.244391,0.0279705,-0.187819,-0.205038,-1.07322,0.131554,-0.994765,-0.245504,1.22195,-0.90823,-0.850817,-0.149393,0.216466,0.0908742,0.0792714,-0.230376,-0.342945,0.354803,0.0366792,0.491178,0.0128398,0.268201,0.687829,0.0397295,0.10224,-0.163169,-0.281365,0.222336,0.103166,0.434647,-0.066772,-0.507817,-0.100829,0.264794,-0.115901,-0.0418776,-0.259548,0.455131,0.0829472,0.052757,0.386358,0.191493,0.0230968,0.0971868,-0.243814,-0.00893744,0.394585,0.23896,0.244062,-0.0189741,-0.0479032,0.0666467,-0.139248,-0.0651106,-0.111132,0.304523,0.0640654,0.250467,-0.221089,0.0126398,0.628991,0.183482,-0.0664751,-0.436652,0.169891,0.650603,-0.196942,-0.320095,0.201436,-0.270521,-0.535746,-0.0213029,0.0353798,0.551029,-0.117416,0.190694,-0.464585,0.321781,-0.0395509,-0.144671,0.322383,-0.226248,-0.425057,-0.0305155,0.0863483,0.235263,0.212718,0.078532,-0.0267691,0.448898,0.19758,-0.278127,0.0456986,-0.24939,0.229691,0.0440493,0.0158805,-0.178307,0.0914567,0.210926,0.481059,0.448763,0.240763,0.464154,0.285115,-0.266806,-0.0369862,0.588609,0.197295,0.858245,0.0269937,-0.270144,0.152851,0.14768,-0.0981655,-0.112423,-0.0509697,0.347279,0.320976,0.313551,0.00895873,-0.209572,-0.132972,0.0312875,0.0277731,0.0332686,0.0185742,0.0456843,0.217595,-0.0327845,0.190251,0.418108,-0.283203,-0.601194,-0.302773,-0.0447209,0.460285,-0.00886771,0.0478215,0.0442473,-0.479604,-0.529178,0.43554,0.221015,-0.0258172,-0.293974,0.316851,0.142946,-0.327834,-0.295343,-0.326544,0.101527,-0.306393,-0.38443,0.98402,-0.133356,-0.267134,0.0264135,-0.358272,-0.0483579,0.614344,0.284777,0.625017,-0.27361,0.0934661,0.561034,-0.153361,0.219479,-0.0515209,0.034259,-0.105746,-0.159566,0.462249,0.139616,-0.213843,0.229287,0.102727,0.38625,0.212157,0.283289,-0.159543,0.110472,0.682635,0.214469,-0.0412995,0.107305,-0.640459,0.0632045,0.210777,-0.0664149,0.0507774,0.0983477,-0.149841,0.227951,-0.086371,-0.0679613,-0.777097,-0.0725389,-0.545851,0.191289,-0.112665,0.362954,0.295962,-0.152524,-0.0220964,0.137691,0.152625,0.00277819,-0.0956032,-0.115449,0.473163,-0.00252787,0.200706,0.0526845,0.0394253,-0.234481,0.1595,-0.298236,-0.389526,-0.42389,0.135531,0.137672,-0.159125,0.326852,-0.157383,-0.0912323,-0.118206,-0.508661,-0.133715,-0.891437,0.0968709,-0.12591,-0.0219418,-0.594938,-0.0933608,-0.105046,-0.313012,0.0411807,-0.0450856,-0.10407,0.318503,0.194431,-0.515687,-0.144802,-0.31462,-0.0815991,0.209256,0.0304282,0.0765865,0.260455,0.276743,0.510348,-0.926131 +3453.63,1,0.0912059,4,1.6861,0.773129,-1.48895,0.528655,0.359844,-0.0973383,0.14557,-0.395616,0.103268,0.210802,-0.080296,-0.0493841,-0.463772,0.2427,-0.571132,0.926449,0.00568227,0.203379,-0.333691,-0.0162218,0.147579,-1.12597,-0.728,0.335019,-0.337785,-0.118638,0.0441768,-0.201644,-0.724132,0.016675,0.628129,-0.861319,0.126592,0.13984,-0.543697,-0.364492,-0.400044,0.801202,-0.0412996,-0.253665,0.742546,0.598373,0.394266,-1.20044,-0.35531,0.511467,-0.625843,0.186948,0.12478,0.0408384,0.310239,0.741673,0.0490326,0.0924959,0.149602,-0.882393,0.0407108,-0.830971,0.116825,-1.15201,0.268538,0.90164,-0.848597,-1.0337,-0.18425,-0.794302,0.302318,-0.141085,-0.277405,-0.146264,0.0449339,0.301593,0.612081,0.306674,-0.00660354,0.218878,0.413715,0.0382854,-0.652465,-0.257677,0.233085,-0.557092,-0.326537,-0.45358,0.0099979,-0.31168,0.137623,-0.588516,-0.181085,-0.0294724,0.396942,-0.183563,-0.0529822,-0.211887,0.403182,-0.195397,0.0451344,-0.0655427,0.0956711,0.467813,-0.325998,0.26034,-0.10679,0.101963,0.0373768,0.375418,0.518442,-0.0230728,0.323486,0.16946,0.306077,0.236145,-0.523718,0.658967,0.0341711,-0.238691,0.20251,0.105644,0.165162,0.0190336,-0.592049,0.322615,-0.159856,-0.208814,-0.398192,0.113594,-0.11665,-0.0461967,0.0683548,-0.236541,-0.0994192,-0.0593807,0.388175,0.133353,-0.233211,-0.522096,0.0511178,-0.164205,0.107472,-0.223187,-0.598942,0.051316,-0.107875,-0.0185892,0.0776786,0.0512746,-0.115029,0.271802,-0.326249,-0.290436,-0.49194,-0.0450055,0.374768,0.261327,0.06265,0.232842,0.0204799,-0.0207676,0.136396,-0.0202373,-0.0178102,0.032146,0.564866,0.264605,-0.278035,0.309273,-0.114815,-0.233608,0.0506153,-0.124874,-0.0410047,-0.356435,0.135323,-0.0251192,0.330832,0.232003,-0.0551654,0.0680802,-0.0572535,0.535757,0.0150502,0.0978164,0.433767,-0.0508183,-0.119135,0.104506,0.130529,-0.127413,-0.611178,-0.553181,0.135801,0.0896722,0.020717,-0.396239,-0.414016,-0.236921,-0.0475919,-0.311583,-0.257029,-0.436551,-0.143682,-0.211882,-0.275149,-0.142167,0.0667619,0.12884,-0.265883,1.08966,0.132226,-0.0785962,-0.126464,0.313944,-0.0560019,-0.271331,-0.389371,0.273699,-0.200453,0.124902,-0.280977,-0.100509,0.0540549,0.417194,0.275949,0.199807,-0.0592263,0.538515,-0.249319,-0.254171,-0.0944267,-0.164628,-0.428959,0.389636,0.0767937,-0.383749,0.541265,0.317801,0.749843,0.4237,0.504301,-0.165681,0.281174,0.237495,-0.418043,-0.11564,0.532332,-0.245816,0.0418352,-0.167032,0.252696,-0.735763,0.0426317,-0.957106,0.185873,-0.0922547,-0.303251,0.228163,-0.238977,-0.0283899,-0.0118304,-0.0898231,-0.192883,-0.173626,-0.106229,0.220503,-0.201186,-0.183727,-0.27367,0.201595,-0.391439,-0.379326,-0.0470368,-0.397426,-0.142659,0.0857144,-0.130652,-0.161002,-0.0705468,-0.0651754,0.210096,0.42527,0.350969,0.0924573,-0.237773,0.135913,0.276087,-0.236452,-0.366026,0.363203,-0.0176833,-0.438961,0.353855,0.242071,-0.245807,0.238592,-0.0345497,-0.0706614,0.222097,-0.181471,-0.0731546,-0.341512,-0.0963175,0.0970632,0.373919,0.31155,0.611489,-0.570063 +3440.1,0.701899,0.0912059,4,1.70354,0.772698,-1.73662,0.612142,0.367461,-0.00706598,0.175486,-0.301555,-0.003115,-0.0544133,-0.072486,-0.270789,-0.624877,0.169335,-0.634035,0.933375,0.178189,-0.455822,-0.59141,-0.323466,-0.229852,-0.643051,-0.514123,0.411222,-0.45217,-0.25584,0.0538308,0.00277347,-0.628676,-0.211831,0.448107,-0.795741,0.236292,0.161108,-0.672727,-0.445154,-0.228,0.755237,0.318465,-0.429116,1.0858,0.8061,-0.188933,-0.879236,-0.357678,0.232045,-0.819102,0.260061,0.19006,0.119595,0.216787,0.625347,0.140441,0.362995,0.048073,-0.77939,0.2136,-1.27139,0.364207,-1.09788,0.285456,0.916749,-0.694518,-0.969802,-0.328637,-0.576789,-0.166827,-0.323268,-0.121355,-0.327443,0.285846,0.269918,0.584816,0.363347,0.0239035,0.157557,0.376753,0.112605,-0.36323,-0.313864,0.138249,-0.490681,-0.282554,-0.442399,-0.0473054,0.0284076,-0.0644472,-0.775589,-0.141005,-0.038946,0.273329,0.225442,-0.22064,-0.199173,0.420487,-0.138673,0.15605,-0.279669,0.509066,0.26183,-0.0406896,0.21137,-0.365857,0.122501,-0.0826212,-0.201442,0.396392,0.258622,0.331035,0.398155,0.178046,0.370993,-0.383886,0.499611,-0.0047314,-0.2942,0.371066,0.0437314,-0.0108794,-0.261729,-0.90762,0.340039,-0.364942,-0.433521,-0.239246,-0.0661764,0.257273,0.261974,-0.0819734,-0.169539,-0.0550722,0.00753099,0.192582,0.129936,-0.107726,-0.427562,-0.166912,-0.290278,0.294184,-0.176079,-0.567283,-0.207891,0.426065,0.0156608,0.320261,0.22201,0.227734,0.219752,-0.224539,-0.129959,-0.352502,0.0681521,0.0921137,0.207968,0.0327049,0.254487,0.0995714,0.0733429,0.226282,-0.191314,-0.188132,0.075565,0.610847,0.48684,-0.0716055,0.0679403,0.206156,-0.283153,0.0944103,-0.103196,0.187368,-0.428882,0.155466,-0.189159,0.118295,0.0642027,-0.11103,0.0992793,0.186739,0.252304,0.0693565,0.0564859,0.0888751,-0.117933,0.0112876,-0.00835605,-0.404041,0.0517294,-0.456953,-0.574235,0.0874955,-0.265383,-0.29903,-0.497121,-0.656199,0.0360848,0.0292268,-0.042738,0.0436171,-0.677444,-0.196898,-0.401964,-0.0418168,-0.120416,0.0176831,0.0413253,-0.352426,0.944981,0.560049,0.328019,0.113384,0.072687,-0.0989111,-0.303146,-0.188336,0.187174,-0.579394,0.311543,-0.172465,0.0248039,0.0563683,0.114047,0.374806,-0.157727,-0.150424,0.434689,-0.636452,0.043909,-0.0267901,-0.192053,-0.274464,0.315198,0.0184058,-0.326811,0.393105,0.46131,0.655143,0.162601,0.662325,-0.17688,0.194945,0.217161,-0.258066,-0.203124,0.397704,0.236689,0.230653,-0.146831,0.498643,-0.198286,0.0262701,-0.675731,0.241099,-0.0480767,-0.221909,-0.103758,0.0931621,-0.576267,-0.353611,-0.0505082,-0.183964,-0.131697,-0.315431,0.0611594,0.064765,-0.267238,-0.267727,0.45445,-0.0905952,-0.32873,-0.0357622,-0.0558932,-0.130638,0.0859226,-0.144982,-0.185334,0.0251001,-0.19014,0.0158467,0.631633,0.406742,0.191356,-0.0752342,0.046383,0.438481,-0.00337398,-0.345298,0.257433,-0.0169365,-0.627998,0.233194,-0.204514,-0.472711,0.375335,-0.172349,-0.0841035,-0.0494593,-0.229423,0.313177,-0.267937,0.0238464,0.0771421,0.309883,0.277745,0.556671,-0.548756 +3445.3,0.861102,0.0912059,4,1.76892,0.800953,-1.46582,0.606184,0.748012,-0.121526,-0.264004,-0.222673,-0.0274909,-0.100499,-0.0860633,-0.31017,-0.425353,0.236898,-0.549393,0.722487,-0.0808853,0.0556833,-0.169854,-0.177143,0.0846761,-1.20448,-1.57256,0.372306,-0.572228,-0.260994,0.0715053,-0.335819,-0.656345,-0.461064,0.764906,-1.46096,-0.710928,0.648904,-0.678956,-0.815983,0.72749,1.05746,0.670696,-0.784248,0.676249,0.667464,-0.397454,-1.0996,-0.0877674,0.134762,-0.60661,-0.0418597,0.156197,0.210938,-0.146882,0.659686,-0.185919,0.0202506,0.00932776,-0.208699,-0.134285,-1.51755,0.205803,-0.609296,0.379684,0.905438,-0.477526,-1.1166,0.087852,0.379029,-0.0824333,-0.0138951,0.338258,-0.150986,-0.227693,0.553984,0.485281,0.102849,0.363479,0.203176,0.20108,0.433158,-0.0533817,-0.130185,0.0586478,0.130703,-0.0753243,-0.50634,-0.374476,-0.253818,-0.0746468,0.0493486,-0.077104,-0.471462,0.141843,0.355445,-0.684125,0.0695923,0.31875,-0.538203,-0.0719106,0.326531,0.214854,-0.00234636,-0.384672,-0.365635,-0.133988,-0.185916,-0.136048,-0.229407,0.211994,-0.584944,-0.0962873,-1.66154e-06,-0.384035,0.0201584,-0.0943912,0.685492,0.189809,0.128633,-0.231368,-0.391917,0.297176,-0.188864,-0.231189,0.00737888,-0.039117,-0.353374,-0.111402,-0.213578,-0.414131,0.374881,-0.197111,-0.2473,0.274188,-0.0163753,-0.0585477,-0.310395,-0.256731,0.354582,0.0990854,0.205517,-0.314201,-0.852234,-0.244719,-0.267878,-0.190421,0.0675201,-0.266697,0.169631,0.197572,0.541795,-0.131069,-0.603213,-0.137031,-0.418365,-0.0623947,0.137353,0.0690025,0.325742,-0.264751,0.522929,-0.173728,0.100036,0.283084,0.145863,0.352492,-0.0414013,0.070396,0.281824,0.213195,-0.730736,-0.0465373,-0.0283281,0.109686,-0.183322,0.20691,0.000177371,-0.372113,0.185715,-0.297019,0.0583294,0.0963497,0.725749,0.0980982,0.0453909,0.253498,0.121503,-0.23405,-0.0597492,-0.221264,-0.25209,0.225577,-0.19957,-0.218318,-0.151838,-0.0664845,-0.520973,0.284327,0.0361543,0.0786415,-0.596383,0.0447869,-0.0546576,-0.200583,-0.179465,-0.117066,-0.00135807,0.0937154,-0.553132,-0.315721,0.829973,0.209875,0.0693451,-0.219419,-0.0223539,0.181933,0.0392094,-0.291326,0.113727,0.435358,-0.0691212,0.881586,0.0723698,-0.288849,-0.469839,0.0807981,0.335671,-0.137587,0.0757843,-0.370681,-0.0628689,0.0121847,0.0318963,0.0895111,0.231259,0.00360195,-0.611186,-0.157345,0.321945,0.0984,-0.105049,0.446499,-0.286407,-0.0697267,0.18019,-0.0629819,-0.325575,0.0856056,0.0564951,0.406365,0.347445,0.120458,-0.380335,-0.225373,-0.354801,0.397197,0.0489164,0.27875,0.340107,-0.624594,-0.199906,-0.0781014,-0.49087,0.0111709,0.136362,0.170775,-0.000258504,-0.10568,0.426002,-0.0723906,0.137567,-0.00308837,-0.414815,0.0652847,0.0924992,-0.114784,-0.236489,-0.0473662,0.176623,0.187681,-0.239702,0.438947,0.415819,-0.0833486,0.206184,-0.115676,0.304458,-0.0769046,0.256222,-0.522151,0.078606,-0.0607269,-0.882647,0.161764,0.489995,-0.181649,0.22988,0.177835,0.0990205,-0.392704,-0.0524381,-0.123563,0.00103477,0.175079,0.0957745,0.392311,0.309475,0.626348,-1.9047 +3467.7,0.942163,0.0912059,4,1.75126,0.750062,-1.58062,0.688814,0.931014,-0.120421,-0.0314716,-0.0631341,-0.334775,-0.180142,0.222953,-0.513695,-0.257203,0.0963738,-0.284468,0.823148,0.0256641,-0.0859878,0.180937,-0.477916,0.223863,-1.13506,-1.41673,0.364792,-0.565403,-0.135963,-0.21021,0.0125781,-0.226921,-0.292054,0.823269,-1.39811,-0.5617,0.935987,-0.392098,-0.446864,0.40605,0.723739,0.742129,-0.71871,0.805548,0.528927,-0.0786627,-0.992785,-0.0511476,-0.0643504,-0.705388,-0.102839,0.167243,0.0363252,-0.284319,0.628769,-0.0793555,-0.336972,0.1119,-0.369659,-0.330055,-1.27776,0.322227,-0.806765,0.516405,0.623941,-0.671683,-0.716328,0.049906,0.26947,0.0111707,-0.11646,-0.279605,-0.252436,-0.598031,0.563182,0.70779,-0.0309754,0.386099,0.445027,-0.0966117,0.154805,-0.347776,-0.0862155,0.0713323,0.186319,-0.0540975,-0.337403,-0.275003,0.116312,0.246338,0.0263979,-0.0348091,-0.67767,-0.041612,0.516866,-0.552825,0.381494,0.252152,-0.611105,0.0830868,0.324158,0.430546,-0.105761,-0.0920964,-0.174355,0.0746596,-0.306997,-0.150973,-0.0444429,0.144753,-0.414264,-0.202803,0.558436,-0.048911,-0.0546761,-0.275992,0.486069,0.222436,0.108407,-0.277722,-0.216929,0.188172,0.0759019,-0.355551,0.195372,-0.247723,-0.118722,0.0262278,-0.327805,-0.0246425,0.0812079,0.0744044,-0.276429,0.371283,-0.0861204,-0.0736027,-0.238733,-0.188707,0.0643185,0.0436657,0.127911,-0.0305677,-0.58804,-0.221344,-0.246538,-0.192381,-0.120222,-0.108867,-0.222983,0.18265,0.410619,-0.114214,-0.252616,0.0668531,-0.225927,-0.200172,0.332617,0.193095,0.105828,-0.279599,0.226604,-0.0273545,0.0628323,0.478283,-0.0402541,0.105182,0.0945975,0.357429,0.178662,0.00734652,-0.745899,-0.0638791,-0.129767,0.0126729,-0.0610002,0.161849,-0.0498183,-0.445969,0.420365,-0.00268985,0.272346,-0.030373,0.641658,0.0185197,0.131856,-0.256561,0.224822,-0.128,0.136457,-0.509531,-0.308667,0.221732,-0.333867,-0.174067,0.14404,-0.321344,-0.430404,-0.0273646,0.242726,0.163793,-0.772764,-0.188803,-0.0529463,-0.0376428,-0.149655,-0.171213,0.0179483,0.567185,-0.746622,-0.257062,0.69601,0.357293,0.0863408,-0.341857,0.0290285,0.16338,0.141554,0.166395,0.326939,0.1625,-0.0443931,0.597504,0.442937,-0.143728,-0.563227,0.320839,0.127144,-0.110301,0.357036,-0.206536,-0.225438,0.153167,0.31279,-0.0886073,0.140021,0.0178719,-0.4267,-0.187487,0.360472,0.0759387,-0.0488435,0.413848,-0.552231,0.0425915,0.35709,-0.0262242,-0.355524,0.0443541,0.08264,0.308961,0.491327,-0.1113,-0.404319,-0.188686,-0.407453,0.243697,-0.0798197,-0.285883,0.163185,-0.460678,-0.0292312,0.167381,-0.423474,0.182857,0.178879,-0.0290563,0.0179192,-0.132444,0.358978,-0.161327,-0.280494,-0.0894822,-0.288946,-0.0911934,0.0561213,-0.296359,-0.338943,0.0180272,0.223589,0.111352,-0.218159,0.27025,0.288701,0.164019,-0.114526,-0.179249,0.121773,-0.288155,-0.271218,-0.216602,0.574685,0.409297,-0.336591,0.00798174,0.0195595,-0.419501,0.454275,-0.222467,0.0156902,0.156603,0.0345781,0.151817,-0.0580394,0.0269615,0.0687684,0.401667,0.262237,0.633772,-2.45823 +3458.16,0.744755,0.0912059,4,1.71029,0.705164,-1.76893,0.7401,1.06511,0.0115449,-0.229385,-0.0143672,0.278187,-0.417081,0.0173741,-0.202416,-0.700186,0.158481,-0.578381,0.618902,-0.0647629,0.23282,0.0370086,-0.263858,0.0250365,-1.28306,-1.15974,0.519929,-0.232657,-0.0920786,-0.242242,-0.134574,-0.261629,-0.317036,0.86439,-0.991973,-0.803171,0.724868,-0.670351,-0.78633,0.220406,0.834696,0.479739,-0.460984,0.872318,0.323181,0.116619,-0.989095,-0.102692,-0.279947,-0.134528,-0.293777,0.293136,-0.0228029,-0.20377,0.517599,-0.185796,-0.453503,0.234576,-0.451684,-0.250958,-1.13257,0.28188,-0.894435,0.18865,0.715482,-0.186788,-1.08912,0.0713708,0.430919,-0.229393,-0.0149489,-0.473554,-0.0964946,-0.291677,0.369482,0.494573,0.22187,0.313474,0.276399,0.434363,-0.117284,-0.271512,-0.272165,0.248727,-0.437957,-0.0752581,-0.358007,-0.0914668,0.0348021,0.206255,-0.049393,0.338675,-0.092642,-0.226175,0.279952,-0.381288,0.344959,-0.380579,-0.195994,-0.0880043,-0.24322,0.338054,0.0495475,0.0238168,-0.292494,0.0694634,-0.468181,0.138052,0.00011462,0.221916,-0.0735325,-0.109733,0.343219,-0.218867,-0.254763,0.5864,0.392458,-0.0218845,0.0274165,-0.754372,0.294417,-0.289415,0.183517,-0.47793,0.372577,-0.0472159,-0.368993,-0.317491,-0.16969,0.268204,-0.0221433,0.322017,-0.54963,0.0337598,-0.00458727,-0.19963,0.131344,-0.222796,-0.201938,0.33735,0.0159807,0.275705,-0.0961003,-0.0856456,-0.159197,0.148291,-0.242745,0.0655531,0.0341979,0.137308,0.695043,-0.135819,-0.0362308,-0.187749,-0.446846,-0.0560413,0.20787,0.0698772,0.0366439,0.103364,0.482132,-0.143447,-0.777402,0.599315,0.0386304,0.526131,-0.0508106,-0.0957817,0.0489218,-0.0644487,-0.47265,-0.655469,0.0718174,0.511913,-0.137154,-0.19577,-0.260355,-0.498315,-0.0513158,-0.042699,0.104012,0.456591,0.470583,0.195976,-0.386261,-0.0365785,0.0515425,0.00664412,0.128592,-0.307512,-0.163266,0.0657998,-0.133275,-0.219704,-0.0628525,-0.0260505,-0.566923,-0.340073,-0.1516,0.38456,-0.462368,-0.535252,0.197997,-0.370886,-0.25628,-0.342326,-0.0636723,-0.252997,-0.314565,-0.254352,0.654011,0.423765,0.206704,-0.667072,0.40058,0.317049,-0.0854432,0.122281,0.246599,-0.112005,0.0933412,-0.129195,-0.30126,0.0985656,-0.55219,0.161697,-0.165461,-0.134235,-0.0621342,-0.153587,-0.271021,0.514941,0.0738687,0.123356,0.0478337,-0.00247829,0.233475,0.0617314,0.316884,0.296043,0.551158,0.406469,0.111069,0.126708,0.269686,-0.245549,-0.199332,0.368613,-0.0702138,0.107867,0.130941,0.109272,-0.333377,-0.228662,-0.661525,0.379606,0.0322048,-0.418301,0.0192464,-0.646536,-0.347361,0.107003,-0.149182,0.290665,0.0210472,0.401496,0.345435,-0.206031,0.635281,-0.122967,-0.316317,0.414113,-0.0879753,0.267083,0.00920927,-0.456347,-0.0840423,0.06909,0.200469,0.173028,-0.159898,0.0226779,0.36789,-0.0439833,-0.217488,0.0954362,0.343839,-0.0982496,-0.00481619,-0.428099,0.0188636,0.263425,-0.530808,-0.0130932,-0.465951,0.279687,0.171903,-0.0335563,-0.0782409,-0.210277,0.235122,-0.472781,-0.164814,0.0683406,0.0987181,0.216143,0.314194,0.464912,-2.84768 +3432.41,0.937798,0.0912059,4,1.73584,0.767409,-1.74327,0.669891,1.27217,0.00347094,-0.69184,0.0191754,-0.184125,0.00243459,0.0795928,-0.293971,-0.311979,-0.0156821,-0.549467,0.502383,-0.00380109,0.190895,-0.418049,-0.392817,0.2177,-1.2281,-0.813397,0.311183,-0.0449309,0.0784609,-0.142531,-0.241995,-0.209999,-0.1658,0.525158,-1.202,-0.579196,0.404373,-0.242048,-0.274019,0.291237,0.967715,0.37741,-0.64523,0.879486,0.523442,0.356703,-0.990185,0.0958591,0.285768,-0.300658,0.051619,0.0320981,-0.217108,-0.13981,1.00268,-0.121031,-0.548402,0.362448,-0.228049,-0.466732,-0.358835,0.263375,-0.51527,0.00459724,1.17982,-0.471824,-1.21262,0.315752,0.111234,-0.372999,0.37573,-0.226487,-0.0956169,-0.322415,0.502017,0.302425,0.213284,0.528485,0.219848,0.248397,0.267003,-0.448819,-0.189173,-0.0548888,-0.407001,-0.290057,-0.28577,-0.368175,-0.622156,-0.462285,-0.244527,0.737366,-0.0293786,-0.296365,0.0841855,-0.418807,0.316146,0.166133,-0.63984,-0.218301,-0.525026,0.465322,0.380854,0.0932711,-0.443396,0.15839,-0.547744,0.163775,-0.287766,-0.0253581,-0.0217563,0.0170136,0.0616008,-0.364971,-0.000458093,0.531619,0.496824,-0.124565,-0.0266473,-0.210815,0.137075,-0.456915,-0.052517,-0.424263,0.0589702,-0.0873732,-0.406226,0.231471,-0.240798,0.210489,-0.012849,0.332564,-0.500474,-0.287931,-0.319222,0.0297761,0.0583036,-0.250185,-0.610127,0.638042,-0.308688,0.0118849,0.078058,0.179128,-0.343944,0.149199,-0.234974,0.255105,-0.00182067,0.264126,0.610851,0.109563,-0.14818,-0.397595,-0.385237,0.0443312,0.0386509,-0.040286,0.397169,0.385645,0.698402,0.0337655,-0.463137,0.357492,0.676752,0.367467,-0.109797,-0.325472,0.291441,-0.241902,-0.398023,-0.0867373,0.462055,0.583584,-0.158303,0.0432966,0.402688,-0.314395,-0.253299,-0.146485,-0.321805,-0.0631785,0.691414,-0.177563,-0.407384,0.108771,0.0969109,-0.286931,0.069012,-0.520981,-0.0551654,0.246011,0.226979,0.0230869,0.0232148,0.231465,-0.822711,-0.399154,-0.14789,-0.0621337,-0.455043,-0.0621671,0.181223,-0.279784,-0.116689,-0.199089,-0.0410955,-0.0878911,-0.279686,-0.15817,0.745357,0.125816,0.242683,-0.38664,0.356425,0.319163,-0.210983,-0.370479,0.326987,-0.204233,-0.111362,0.00966266,0.0708042,0.134379,-0.60143,-0.3787,-0.467456,-0.0286926,-0.00652561,-0.0507479,-0.374172,0.0198986,0.151807,0.385224,-0.0443427,-0.0234415,0.0967934,0.128227,0.400174,-0.019953,0.576362,0.672797,-0.0938924,0.458541,0.319181,-0.104555,-0.195637,0.305368,0.0311366,0.357692,0.022135,0.114097,-0.351487,0.0839397,-0.16366,0.119593,0.0612293,-0.265638,0.0704624,-0.39209,-0.224517,0.213447,-0.30208,0.0345204,0.0972873,0.23915,0.125535,-0.203827,0.283454,-0.472865,-0.385084,0.379152,0.0405323,0.0656022,0.144128,-0.256603,0.146142,-0.0066426,-0.0360287,0.0969566,0.00595491,0.12131,0.351895,0.0371524,-0.208545,-0.130957,0.129756,-0.216909,0.0865392,-0.218139,-0.0446795,0.422986,-0.252253,-0.194142,-0.177895,0.47615,0.350462,-0.0299081,0.211702,-0.263293,-0.0564892,-0.457234,-0.0559863,0.0017735,0.0882226,0.255437,0.297023,0.505408,-3.56445 +3432.83,0.986907,0.0912059,4,1.69568,0.716342,-1.88705,0.767782,0.994383,-0.221372,-0.104399,0.081013,0.157586,-0.249183,0.265397,-0.547266,-0.362631,0.356515,-0.523091,0.734953,0.282104,-0.165651,-0.48809,0.00738205,-0.229997,-0.401771,-1.19719,0.166053,-0.96887,0.0317274,-0.307946,0.465774,-0.219722,-0.368448,0.617518,-0.654342,0.0237164,0.285223,-0.0696617,-0.539831,-0.0391022,0.687646,0.432776,-0.50592,1.25276,0.494409,0.649601,-0.611078,-0.0791353,0.16359,-0.129053,0.535035,0.291572,0.150313,-0.229802,0.753833,0.220667,-0.318529,0.196801,-0.393786,-0.247312,-1.19597,0.170092,-0.612529,0.200177,0.897714,-0.350757,-0.688379,-0.240419,0.289067,0.107192,0.020231,0.165598,-0.337348,0.450372,0.300969,0.272243,-0.779932,0.303063,0.13648,0.159108,0.166974,0.0510672,0.108691,0.32295,-0.517788,0.186409,-0.0331375,0.0260215,0.497094,0.362188,-0.277257,-0.113892,-0.571041,-0.170001,0.0243107,0.155133,-0.462121,0.114141,-0.0504684,0.00234757,0.840018,0.0329367,-0.0709816,-0.0422265,0.226699,-0.506894,-0.138199,-0.0383464,-0.394665,-0.438746,-0.313321,0.446649,0.871306,0.353495,-0.455217,-0.27606,0.240093,0.100692,0.5697,-0.932596,0.345884,0.243119,-0.0870895,-0.319544,0.435676,-0.0163788,0.611774,-0.169427,-0.157637,0.149631,-0.225246,-0.0266414,-0.233941,-0.205668,-0.408509,-0.0754112,0.0591906,-0.360707,0.229121,-0.100193,-0.270613,0.30115,-0.453109,0.066204,-0.209617,0.0803887,-0.351294,-0.296177,0.390569,-0.80518,0.124075,-0.31553,0.101079,0.37044,0.318283,-0.0542708,-0.465796,0.153526,-0.16078,0.571001,0.000603655,-0.234453,0.195049,0.00427382,-0.241917,0.688959,0.0457078,-0.226942,0.0304861,0.00233291,0.190057,-0.133457,-0.239906,-0.27502,0.402949,-0.138457,-0.0681534,-0.0272898,-0.114062,-0.0486135,0.260456,0.149226,-0.217402,-0.50559,-0.503667,0.354681,0.125234,-0.312254,-0.446666,-0.14102,-0.744753,0.182417,-0.707539,-0.239344,-0.215859,-0.415213,-0.619435,0.0754321,0.645299,-0.213164,-0.567896,-0.171175,-0.148105,-0.245212,-0.0136952,0.13071,-0.298172,0.141187,-0.426499,-0.384594,0.899516,0.209812,0.556532,0.0154259,-0.855656,-0.000264104,-0.266288,-0.0522566,0.136292,-0.102004,-0.0788767,0.300838,-0.566904,0.0886841,-0.240748,0.502345,0.002314,-0.775071,0.508692,0.0792773,0.196388,0.00150076,-0.111364,0.43407,0.0562014,-0.122631,0.0741569,-0.448259,0.387909,-0.280955,-0.109146,0.231023,-0.362415,-0.197036,-0.11954,-0.0703502,-0.0446175,0.17691,-0.391634,0.166989,0.184445,-0.79062,-0.409898,0.24752,-0.180832,0.246195,-0.407125,-0.187134,0.101643,-0.110093,-0.212033,-0.0122226,0.00960033,-0.0855871,0.247567,-0.0397148,0.371089,-0.376606,0.0822742,0.183302,-0.0206571,-0.0764042,-0.0298481,-0.192388,-0.075367,-0.322245,-0.202419,0.107402,-0.020614,-0.32491,0.0715738,0.159017,0.110245,-0.132806,0.225976,-0.423312,-0.449856,0.233329,0.232746,-0.205984,0.0469124,-0.178864,0.263952,0.279823,0.152033,-0.239165,-0.282718,-0.462204,-0.28424,0.12201,-0.00810348,0.391447,-0.211354,-0.0320074,0.099599,0.301357,0.315593,0.54896,-2.55322 +3433.45,0.665322,0.0912059,4,1.59142,0.848901,-1.63865,0.613399,0.97206,-0.142185,-0.307216,-0.115171,-0.113073,-0.110951,0.293341,-0.306407,-0.670656,0.170325,-0.275448,0.883477,0.0544223,0.0223965,-0.510663,-0.195058,-0.190159,-0.878874,-0.796678,0.00652709,-0.221771,-0.22836,-0.0510535,0.146221,-0.0892813,0.147627,0.36631,-0.762824,-0.254529,0.264156,-0.246448,0.110869,0.134799,0.462009,0.00544529,-0.254289,1.04243,0.478611,0.49297,-0.956458,-0.161795,-0.214569,-0.310961,0.113537,-0.0841992,-0.18235,-0.255508,0.381169,0.565612,-0.488322,0.345947,-0.369884,-0.242315,-0.518516,0.0860498,-0.183258,0.403561,1.22667,-0.194873,-1.11936,-0.541914,-0.385629,-0.367444,0.298418,0.0609826,-0.930404,0.236511,0.110306,0.434892,-0.263232,0.432312,0.0535555,0.345396,0.587416,-0.359523,0.0502264,0.125632,-0.220258,0.382094,-0.0322955,-0.361198,-0.214555,0.153604,0.109405,0.158594,-0.163338,-0.0857425,0.0608168,-0.0860233,0.0698262,0.31122,0.0348647,-0.184565,0.206544,-0.566847,-0.362384,0.170201,-0.15055,-0.226743,-0.341695,0.135807,-0.451385,-0.26531,-0.696921,0.50973,0.539095,-0.220862,-0.525256,0.294018,0.275915,-0.328191,0.272101,-0.536637,0.246557,-0.271766,-0.119808,-0.471715,-0.337431,-0.611233,0.395096,-0.239977,0.112157,-0.207228,0.299667,0.275004,-0.18039,-0.0408359,0.068533,0.104831,0.323883,-0.467309,0.0669501,-0.00492028,-0.118988,0.356469,-0.182611,-0.240548,0.167876,0.100493,-0.537018,0.24117,0.392868,-0.666975,0.191539,-0.0759366,-0.155721,0.37842,-0.109015,0.108416,-0.0161256,-0.132489,0.444426,0.736294,0.193186,0.0160921,0.0683879,0.297282,-0.140093,0.219227,0.217299,0.229423,0.278531,-0.113589,0.156291,-0.385566,0.368119,0.218379,0.368407,-0.00251123,-0.0436969,-0.0579879,-0.101133,-0.190835,0.0991019,0.199557,0.413934,-0.218785,0.0129327,0.342387,-0.246726,-0.0764089,-0.66221,0.190004,-0.909524,0.509996,-0.480344,-0.153323,0.241589,-0.262309,-0.600878,-0.246094,0.466618,0.162193,-0.354229,-0.414952,0.267184,0.0909091,-0.260067,0.39847,0.0207766,-0.316693,-0.168887,-0.260851,1.16205,0.422769,0.0597471,-0.212958,-0.913096,-0.0818773,-0.088313,-0.0605978,0.0255208,0.210041,-0.0195985,0.472591,0.52894,0.439403,-0.178372,0.479016,0.458482,-0.365777,0.275671,-0.0272083,-0.201766,-0.052224,-0.0883824,-0.125253,0.116139,-0.12326,-0.168168,-0.569856,0.843393,0.130869,0.216741,0.703617,-0.188456,0.177385,-0.594602,0.361699,-0.104854,0.248035,-0.433217,0.0644935,0.219899,-0.446789,-0.0882116,0.00212254,-0.449202,0.161696,-0.0927243,0.623115,-0.106475,-0.231469,-0.273951,-0.0475419,0.32331,0.304141,0.561328,-0.00347054,0.294652,0.134497,-0.208618,0.376691,-0.29644,-0.439417,0.0223224,-0.245278,-0.468885,-0.414863,-0.0835586,0.124373,-0.353042,-0.11536,0.712848,0.476155,0.354004,-0.409562,0.358044,-0.385412,0.273421,0.184775,0.0905947,-0.338213,-0.0514873,-0.0413031,0.0740723,0.00257894,0.541723,-0.0905912,0.0106898,-0.221606,-0.619026,-0.0340524,-0.43138,0.703508,-0.0267205,0.541335,0.120428,0.189397,0.347028,0.435198,-2.82162 +3423.13,0.980693,0.0912059,4,1.6407,0.790613,-1.14277,0.392749,0.68637,-0.0540648,0.0624678,0.180274,0.192862,0.157651,-0.0644977,-0.738758,0.334399,0.168662,-0.448087,0.879677,-0.103697,-0.216767,-0.415862,-0.205298,-0.145412,-0.740876,-1.02818,-0.0977223,-0.464161,-0.165944,0.000430127,0.509654,-0.986655,0.198531,0.417842,-1.22601,-0.190729,0.564002,-0.164807,-0.148488,-0.0238392,0.457506,0.396368,0.0352841,1.13043,0.266953,0.153111,-0.750145,0.264468,0.14309,-0.869618,0.476095,0.304144,-0.131338,0.289971,0.398751,-0.115249,-0.223058,0.588374,-0.0808538,-0.193584,-0.656269,0.23326,-0.678517,-0.0698795,0.489101,-0.733441,-0.486691,-0.184848,0.106064,-0.258437,-0.0994176,-0.134101,0.219705,-0.158054,0.197694,0.700846,0.328179,0.0736496,0.469689,0.326182,0.206321,-0.013057,0.0838264,0.309939,0.0348142,0.50934,0.00898209,-0.0887277,-0.239539,-0.280746,0.124547,-0.0301675,-0.142815,0.18292,0.0977197,-0.116263,-0.137756,-0.630015,-0.160084,0.381079,0.283209,-0.300815,0.212612,-0.199771,0.517189,-0.202449,-0.489266,-0.30762,-0.195189,0.391082,-0.014819,0.690979,0.606744,-0.112345,-0.319993,0.160104,0.51001,0.540599,-0.00576955,-0.184027,0.316777,0.297495,0.209292,-0.226104,0.603547,-0.137067,0.42314,0.281449,-0.174474,0.500973,-0.141297,-0.222442,-0.0497243,0.122467,-0.0897027,-0.18831,-0.272871,-0.112027,-0.217592,-0.487604,-0.204645,0.172164,-0.620831,-0.863505,0.33782,0.0300864,-0.316345,-0.326769,0.00670654,0.060342,-0.177514,0.17593,0.3663,-0.312503,0.245697,0.261183,-0.517871,0.076261,0.320379,0.245585,-0.0291755,-0.030166,0.20289,-0.252346,0.343959,0.457774,-0.099193,-0.744508,-0.0533087,-0.158548,-0.431024,-0.199281,-0.0969379,0.0405366,-0.0818274,-0.00840326,-0.0518316,-0.11171,0.0376342,-0.0193265,-0.330079,0.0111215,0.815258,0.0153368,-0.343828,0.825567,-0.0336733,-0.167694,0.0549528,-0.91079,-0.0433425,0.172939,0.261867,0.52125,-0.310086,-0.111175,-0.370167,0.452732,0.1979,0.0658098,0.0357454,0.285785,0.144313,0.384154,-0.114919,0.471592,-0.204377,-0.164691,0.422774,-0.605675,1.06528,0.493891,0.384698,-0.222692,-0.220755,0.0291342,0.141346,0.152572,0.399327,-0.401683,-0.13199,-0.16015,-0.465137,0.00810743,-0.274074,-0.539155,0.359212,-0.60505,0.393399,-0.568628,-0.608217,0.284086,-0.337349,-0.223261,0.0599519,-0.212966,0.130056,-0.379661,0.29089,0.0500935,-0.140854,0.401256,-0.879785,-0.187698,0.41908,-0.621437,0.0415744,-0.224937,0.44034,0.475742,0.457602,-0.0683099,-0.212634,-0.144832,-0.339251,0.397036,-0.513017,0.0993688,0.172818,-0.315096,0.0608387,0.469321,0.444098,-0.0175096,0.195552,0.311182,-0.239008,0.18663,-0.00975543,0.0886073,0.363501,0.825602,-0.667117,-0.132531,-0.511941,-0.710145,0.0904084,0.715634,-0.299609,-0.0591731,-0.452351,-0.241287,0.158483,0.0297951,0.577392,0.213987,-0.224194,0.000441179,0.308422,-0.28035,0.410817,-0.431249,-0.413796,0.0704826,-0.218169,-0.0632097,0.085287,0.0022244,-0.284496,0.0663887,0.0572093,-0.85349,-0.418593,-0.366096,0.114993,0.251962,0.339106,0.501958,-1.79418 +3404.33,0.864175,0.0912059,4,1.47888,0.806775,-1.28686,0.562571,0.444155,-0.123507,0.250159,-0.0787587,0.504126,0.125563,-0.00493617,-0.388569,-0.497098,0.720027,-0.133809,0.979972,0.71652,0.229369,0.0877129,-0.079834,-0.0885689,-0.683736,-0.694621,-0.0153381,-0.503362,-0.211848,0.291423,0.323832,-0.267544,0.377343,0.510034,-1.08327,-0.0263575,0.117767,-0.763634,0.127166,-0.589058,0.00251665,-0.292546,-0.647737,0.756928,0.909082,0.645243,-0.436461,-0.293721,0.246817,-1.28086,0.253579,0.263104,-0.201569,-0.207046,0.372556,0.49889,-0.113042,0.680575,-0.0634157,-0.444342,-1.22079,-0.0102644,-0.366312,0.223133,0.800596,-0.532495,-1.16711,0.392273,0.00873124,0.519611,-0.00760296,0.288239,-0.710392,0.302979,0.213345,0.446113,0.000600055,-0.017697,-0.0230033,0.164136,0.0957709,0.0319496,0.114241,0.144785,-0.0847371,0.624332,0.200878,-0.12031,-0.120707,-0.168697,-0.285283,0.152752,-0.0139261,0.1676,-0.370066,0.205233,0.44994,0.203643,-0.16683,-0.153049,-0.267066,0.852026,0.191223,0.0536738,-0.521971,-0.436516,0.129093,-0.155619,0.366207,-0.612942,-0.25449,0.439139,0.564195,-0.717744,-0.13778,-0.578191,0.145094,-0.561999,0.533647,-0.196224,0.0581152,0.312524,0.24137,-0.184788,-0.610827,0.186775,-0.113369,-0.708959,0.17768,-0.402862,0.323335,0.721159,-0.063009,0.0155898,-0.14411,0.371732,0.601187,-0.350801,0.149383,-0.0177316,-0.31154,0.625151,-0.0915566,0.103335,0.515894,0.462244,-0.176216,0.0998581,0.240432,0.217271,0.15691,0.0142507,-0.0822192,0.350599,-0.125031,0.389338,0.0768469,0.298845,0.567488,0.442324,0.163744,0.14262,-0.141653,0.876095,-0.122451,0.398968,-0.205139,0.623881,0.122287,0.371651,0.495227,-0.00602141,0.350368,0.154146,0.126127,-0.16296,0.166023,0.324883,0.226975,-0.128608,-0.104415,0.465365,0.897721,0.584632,-0.488491,-0.262485,-0.0485991,-0.0252584,-0.579787,-0.147456,-0.59665,0.862589,-0.904745,-0.398122,0.415772,-0.0438779,-0.681252,-0.295567,0.281063,0.0480954,-0.671747,-0.630082,0.715307,0.352411,0.114713,0.135846,0.331184,-0.0646011,0.288144,-0.370807,1.12795,-0.665865,-0.280235,0.10101,0.461348,0.0731542,-0.132466,-0.567415,0.265738,-0.160408,0.114417,0.447877,-0.448315,-0.199553,-0.146147,0.593289,0.189574,-0.318702,0.55073,0.0389259,0.0663599,0.0396942,0.119019,-0.489772,0.00950734,0.0114647,-0.174901,-0.0218812,0.929893,0.455605,-0.0730228,0.677402,-0.103512,0.0771066,-0.456489,0.0443604,-0.142826,0.521345,-0.166966,0.626085,0.255263,-0.313333,-0.503124,0.203742,-0.552044,-0.0130885,0.346227,-0.0238334,0.635219,0.0925361,-0.0848726,-0.309363,0.355969,0.357332,0.454099,-0.571085,-0.0664072,0.478823,-0.0200025,0.313029,-0.09534,-0.334507,0.631905,0.0247094,0.174321,0.121159,0.783345,0.391245,0.051823,0.32093,0.427771,0.359549,-0.00256117,-0.273925,-0.319786,-0.407503,-0.306459,-0.196127,0.184429,0.17386,0.534069,0.108666,0.0200755,-0.0807396,-0.321116,0.211285,0.639786,0.311914,-0.0578128,0.251135,0.321598,0.166156,-0.196088,0.231305,0.125055,0.333527,0.353632,0.577518,-1.24847 +3394.93,1,0.0912059,4,1.5121,0.805558,-1.12947,0.389483,0.549837,-0.133285,0.153126,0.607146,0.360199,0.28896,0.0284876,-0.221934,-0.40502,0.499548,-0.635285,0.642071,-0.01369,-0.219051,0.231033,-0.277155,-0.129483,-0.694309,-1.00783,0.120641,-0.551671,0.124296,-0.283063,0.24849,-0.480279,0.0117683,0.60892,-0.123439,0.218274,0.650912,-0.354729,-0.146076,-0.40348,0.392537,-0.199643,-0.280318,1.32056,0.579428,0.233901,-0.474105,0.357076,0.107353,-1.00059,0.562305,0.545019,0.0201264,0.238733,0.663673,0.583844,-0.173149,0.906372,0.200325,-0.210475,-0.719982,0.26333,-0.634042,0.0576981,0.986158,-0.384829,-0.526392,-0.0901572,0.418983,-0.816799,0.146981,-0.625914,0.0736282,0.132861,0.498769,0.590147,-0.0282264,1.03055,0.511856,0.707675,0.0438572,0.417202,0.220977,0.104536,0.235513,0.441646,0.132232,-0.433138,-0.0762596,0.071113,-0.877598,-0.088855,-0.167998,0.546988,0.0339537,0.0126956,0.0217927,-0.218911,-0.212162,-0.455638,0.0795049,0.392061,0.157637,-0.390377,0.382329,-0.80363,-0.420621,0.54687,0.276519,0.281153,-0.372767,0.375194,0.564248,-0.357295,-1.03452,0.25521,0.420133,-0.735867,0.196069,-0.368212,0.397821,0.188186,0.23762,-0.410107,-0.0784043,0.0734053,-0.2552,-0.301643,0.186712,-0.544448,0.165747,0.239875,0.0263018,-0.207548,-0.234511,0.0970503,0.559126,0.0542938,-0.47027,0.244827,0.329776,-0.213428,-0.486814,-0.0809993,0.0496215,0.0443719,-0.207592,0.0982547,-0.0744034,0.249791,0.0663307,0.352752,0.297923,-0.432103,0.140022,0.286136,-0.529469,0.895172,0.119711,0.959024,-0.397553,0.220352,-0.268787,0.171593,-0.175304,0.742641,0.654813,0.841772,0.223868,-0.413531,-0.0353316,-0.424523,0.11769,-0.811212,0.664043,-0.0627562,0.316761,-0.157932,0.386641,-0.0972196,0.884159,0.616279,0.441526,-0.110856,-0.00190421,0.551532,-0.182021,-0.20252,-0.349303,0.250448,-0.280169,0.476502,-0.0441587,-0.213265,0.369605,-0.215572,-0.85893,0.27458,-0.371086,0.443137,0.163677,-0.40319,-0.0626769,0.0131201,0.16232,0.302532,-0.11009,-0.187646,0.126067,-0.293002,1.15369,0.297781,0.250081,-0.615149,-0.224626,-0.00391595,-0.221026,-0.389902,0.778858,0.448617,-0.120952,0.0249964,-0.345428,0.0211464,-0.697385,0.0806197,-0.113317,-0.845704,0.238994,-0.10118,-0.34948,-0.31979,-0.355246,0.0621219,-0.0953794,-0.65399,0.210204,-0.236574,0.560209,0.194682,0.388933,0.650917,-0.285123,0.248413,0.1549,0.534381,-0.089802,0.421902,0.0889711,0.567541,0.128332,-0.467785,-0.285515,-0.210675,-0.0168091,0.623184,-0.515354,0.0365489,0.144988,0.0760254,0.0418301,0.41395,0.266746,-0.0336364,0.319363,0.676759,-0.160431,-0.0929103,-0.0559018,0.361967,-0.00228962,-0.0342943,-0.185749,0.573961,-0.922842,-0.384322,0.307469,0.426994,-0.0342102,-0.299638,-0.38895,0.343102,-0.238628,0.0692234,-0.691206,-0.282022,-0.141155,0.158151,0.23447,0.216225,-0.0346217,-0.841614,-0.323187,-0.0822256,0.0647797,0.740942,0.620964,0.313457,-0.368458,0.318617,0.0871192,0.231122,0.288898,-0.414886,0.150997,0.242515,0.388584,0.492458,-1.48003 +3388.62,0.977676,0.0912059,5,1.41126,0.773409,-1.47434,0.564033,0.0290913,-0.214534,-0.171878,-0.0713319,0.265736,-0.117729,0.203808,0.251788,0.179186,0.917277,0.207534,1.02204,0.628845,-0.138803,-0.177728,0.559287,-0.374207,-0.75022,-0.238771,0.498943,0.200641,-0.874824,0.536383,0.191916,-0.24487,0.318478,0.727409,-1.12057,-0.0235643,0.429535,-0.570442,-0.284844,0.0496116,0.892306,1.02984,-0.534086,1.08184,0.525194,0.465576,-0.767575,0.602605,-0.108602,-0.196176,-0.00406201,0.560802,-0.235732,-0.0677549,0.466396,-0.0594525,-0.21968,0.412797,0.00157695,0.146251,-0.352655,0.404389,-0.0544871,0.671131,1.24367,-0.183976,-0.946402,0.399323,0.156048,0.48593,-0.241223,0.961352,-0.757153,-0.492478,0.156999,0.338278,-0.13297,-0.185894,0.189404,0.0841558,-0.0636356,-0.97883,0.0621858,0.964657,-0.804445,-0.0663078,-0.27536,0.429007,-0.00663491,-0.272908,0.251118,0.109288,-0.0543115,0.0190981,-0.61315,-0.272586,0.436886,0.0248228,-0.233436,0.478744,-0.37463,0.293901,0.455103,0.575063,-0.098292,0.00142261,-0.566013,-0.230834,-0.49091,0.160761,-0.258329,0.589841,0.959346,0.301957,0.310678,-0.344558,0.552398,0.56086,0.0461632,0.144894,-0.0263592,0.475723,-0.32575,-1.07931,-0.263663,-0.674199,-0.062104,0.393889,-0.0354853,0.676171,-0.006014,0.410238,-0.954361,-0.14509,-0.32116,0.205185,0.239267,-0.611565,0.28595,-0.117467,-0.678487,0.896303,-0.364052,-0.693582,0.165124,0.057598,-0.292936,-0.317169,0.0924265,0.241704,0.440067,-0.150649,-0.361379,-0.115715,-0.0903222,0.545566,0.314678,-0.269635,0.629969,-0.2551,0.522584,-0.00839597,0.26222,0.538573,-0.00395112,0.0998187,-0.0950669,-0.408787,0.126628,0.188785,-0.0631202,0.488009,-0.13906,0.588421,-0.775489,-0.148193,-0.54053,0.174789,-0.262516,-0.170186,-1.22664,-0.105934,0.734924,0.0466932,-0.0270141,-0.228917,0.25565,-0.0104558,0.0176408,-0.81059,-0.0730105,-0.326214,-0.684389,-0.168555,-0.0515279,0.0426688,-0.429232,-0.0319844,0.81623,-0.38111,-0.543229,-0.28186,0.163716,0.109501,-0.603618,-0.0235603,-0.0438233,0.0731041,0.104108,-0.652037,1.11472,-0.0834651,-0.175886,0.355907,0.425502,0.123816,0.490206,0.150099,0.101427,-0.531082,0.5474,0.521694,-0.0012974,-0.222496,-0.540544,-0.135879,0.814411,0.0436308,0.519147,-0.340252,0.181139,0.411185,-0.211279,0.0221251,0.079041,0.188643,-0.191025,-0.280836,0.537242,0.195575,0.122333,0.200367,-0.474331,-0.619958,0.0738885,-0.449048,-0.115702,0.129201,0.497333,0.406035,0.0352507,0.108471,-0.733788,0.475023,-1.28399,-0.325468,0.429053,-0.346321,0.298039,-0.432671,0.214846,-0.0209681,0.116769,0.311286,0.385471,-0.483303,0.154258,0.644379,0.207964,0.179055,-0.527756,-0.366872,-0.0771966,-0.418651,0.441439,-0.0384598,-0.0282256,0.107971,0.418396,0.643772,0.533142,0.47208,0.241898,-0.687932,0.437081,-0.00280716,0.337999,-0.0976326,0.527453,-0.128538,0.621217,0.435388,0.0159811,0.161761,-0.105081,-0.229763,-0.224268,-0.221586,-0.0011715,-0.2481,-0.271952,-0.54506,-0.670466,0.502401,0.172271,0.315275,0.415055,0.561494,0.240702 +3390.56,0.884718,0.0912059,4,1.39869,0.767744,-1.6121,0.592774,0.0276167,-0.131799,-0.211012,-0.0596832,0.361478,0.0961985,-0.0784127,0.206296,-0.748131,0.685777,-0.507287,1.11334,1.02152,-0.132501,0.0530578,0.470268,0.0245827,-1.20322,-0.735284,0.513374,-0.485117,-0.49266,-0.243339,0.0321882,0.0363406,0.114519,0.754127,-0.294482,0.0707393,0.177267,-0.340065,0.115067,-0.75513,0.835173,0.573064,-0.51911,0.797188,0.694683,0.397205,-0.483709,0.217355,0.213593,-0.39388,0.643376,0.663908,0.0728845,0.0963935,0.659048,0.380218,0.294354,0.675076,0.0639913,-0.21892,-0.292493,0.606345,0.356089,0.957143,1.04751,-0.438729,-0.853558,0.540892,0.19091,-0.253923,-0.567053,0.132521,-0.176615,-0.29596,-0.00850452,0.416259,-0.20167,0.520871,-0.236228,0.490603,-0.227457,-0.506099,0.0868897,0.559663,-0.243231,0.171148,-0.227291,0.801015,-0.582809,-0.444375,-0.421208,-0.590696,-0.150129,-0.1002,0.243008,0.107276,0.0522557,0.487554,0.718365,-0.163772,-0.618329,0.692552,0.523506,0.365875,0.369599,-0.206318,-1.20266,0.269798,-0.172,0.535498,0.0990792,0.0696085,0.718868,-0.142145,0.0937459,0.36299,-0.0285856,0.517262,-0.0067141,-0.219193,-0.252841,-0.196059,-0.0146409,-0.733549,0.257176,-0.160719,-0.844702,-0.286824,0.433851,-0.117614,-0.335641,0.273865,-0.448204,0.380209,-0.111807,0.412588,0.290794,-0.861104,0.180015,-0.0487648,0.0076812,0.518608,-0.160723,-0.520961,-0.263958,0.53532,-0.654702,0.476674,0.470608,-0.363716,-0.00921527,-0.084511,-0.418213,0.19061,0.504766,-0.0529978,0.203764,0.199885,0.271399,0.323075,0.452445,0.0311896,-0.320087,0.639239,0.165118,0.632328,-0.186841,-0.356118,-0.150037,-0.0729877,-0.18204,0.116838,0.0484711,0.39654,-0.64212,-0.131443,0.0154143,0.0465028,0.0619446,-0.500738,-0.474382,-0.119284,0.908888,-0.0355338,0.775377,0.526872,-0.0848502,-0.451054,-0.0977534,-0.244565,-0.459108,0.188822,0.145927,-0.421468,-0.275836,-0.48216,-0.870536,0.387521,-0.234175,-0.272529,-0.035095,0.158319,0.331372,-0.182869,0.353234,0.606566,-0.0391554,-0.147765,-0.0844104,-0.544287,1.04054,0.236193,0.651407,-0.131588,0.138746,0.392647,0.0666004,-0.341399,-0.261925,-0.588054,0.386344,0.449394,-0.348054,0.293595,-0.373434,1.04762,0.334631,-0.3237,0.373167,-0.262862,0.191487,0.276496,0.0941526,-0.178148,-0.174104,0.160374,-0.761143,-0.367421,0.663649,-0.0381919,0.0742287,0.679058,-0.333651,-0.78051,0.0162592,0.277025,0.480585,0.459908,-0.865486,0.680469,-0.163337,0.34329,0.129227,0.17674,-1.26355,0.213086,-0.184952,0.389666,-0.214396,0.103959,0.606906,0.530839,-0.0557978,0.511628,0.685538,-0.417135,0.0135024,0.253794,-0.23343,0.404794,-0.727902,-0.207581,0.0196058,0.0948345,0.0611263,-0.702694,-0.0827688,0.113405,-0.608631,0.249568,0.27636,0.557523,-0.38155,-0.367903,-0.556799,-0.122444,0.316167,-0.0414546,0.460248,0.423876,0.270898,-0.0325934,-0.105763,-0.045411,0.136741,0.500885,-0.718498,0.0319602,-0.871687,-0.383656,-0.120079,-0.188452,-0.854006,0.169776,0.173026,0.28013,0.415964,0.529273,0.267479 +3379.1,0.776891,0.0912059,5,1.49613,0.678516,-1.87164,0.626931,-0.0162807,-0.181613,-0.0585801,0.0453749,-0.362005,0.643509,-0.256862,-0.191826,-0.508886,0.785301,-0.466382,0.66568,0.772906,-0.14186,-0.432433,0.578743,-0.249556,-0.876426,-1.31502,0.596157,-0.274639,-0.383857,-0.0482214,-0.162121,-0.466779,0.12934,0.610512,-0.193045,-0.255834,0.0751035,-0.109563,0.00976649,-0.311148,1.41338,0.32647,-0.178294,1.33687,0.348357,1.02731,-0.601314,0.0438332,-0.285213,-0.231411,0.509596,0.420693,0.322942,-0.0168683,0.772547,0.179417,0.319575,0.799816,-0.42365,-0.242468,-0.620922,0.306629,0.264087,0.314402,0.973413,-0.877707,-1.39278,0.15021,0.0358926,-0.0252323,-0.149332,-0.627558,-0.512527,0.35428,0.0667039,0.539036,0.192086,0.343352,-0.241642,0.434247,0.0633299,-0.575707,0.0849162,0.315634,-0.533329,-0.0257929,-0.553766,0.173755,0.271604,0.172211,-0.424079,-0.399676,0.00350586,-0.741951,-0.192728,0.368021,-0.378024,-0.0133031,0.186416,0.103757,-0.226253,0.363581,0.536941,0.295865,0.582814,-0.828506,-0.590822,-0.465839,-0.593299,0.149787,0.218834,-0.108092,0.835281,0.00969751,0.0640161,0.592129,0.296307,0.424332,0.29139,-0.242385,0.15418,-0.0335272,0.0854459,-0.964874,0.41438,-0.0761198,-1.05854,0.0371805,0.583421,-0.344112,-0.0276609,0.0943558,-0.585938,0.220783,-0.320247,0.452713,0.844533,-0.809991,-0.0140825,-0.32933,-0.566966,0.426164,0.0909408,-0.917905,-0.118453,0.588445,-0.408183,-0.132826,0.308416,-0.128508,0.11632,-0.186589,-0.299853,-0.0616072,-0.0253973,0.106392,0.349786,0.447018,0.0419241,-0.00380848,0.419626,0.257481,0.0838157,-0.0999764,-0.434141,0.286536,0.390678,-0.320078,-0.314001,-0.482981,-0.0728447,-0.178969,0.339677,0.451184,0.0197665,-0.410424,0.0540409,0.0519359,0.262185,-0.144114,-0.209633,0.548746,1.18266,0.222304,0.687772,-0.0806944,-0.23974,0.293645,-0.568606,-0.777988,0.137046,-0.235465,0.344086,-0.257591,-0.437893,-0.619392,-1.18531,-0.121405,-0.278012,-0.262845,-0.540841,-0.304253,0.505048,0.0220438,-0.485252,0.742039,-0.166762,-0.0735816,0.0627221,-0.271683,1.21482,0.281282,0.533307,0.0692696,-0.430726,0.177834,0.640561,-0.920441,-0.373365,-0.0906806,0.199036,0.336804,-0.243886,0.181416,-0.150154,0.0520345,1.10956,-0.555856,0.77633,-0.68921,0.124332,0.590648,-0.550796,-0.221903,-0.00856074,-0.604938,-0.327117,-0.340788,0.46811,-0.533028,0.508549,0.862558,-0.505858,0.0384838,0.0705289,0.671572,0.328306,0.973199,-0.739574,0.532176,0.535952,0.0850276,-0.490008,-0.0324607,-1.01998,-0.0878888,-0.600297,-0.700819,-0.228873,-0.185373,0.562689,0.259342,0.0756101,0.14348,0.833993,-0.290878,-0.154476,0.313646,-0.141341,0.695525,-0.286502,0.395521,0.455183,-0.377029,-0.243793,-0.290596,-0.24396,-0.160237,-0.212344,0.265616,0.265566,0.387635,0.118119,-0.283042,-0.51814,-0.485898,0.415794,-0.0789771,0.154574,0.207792,0.154088,0.306355,0.252171,-0.29133,0.273931,0.353053,0.0716203,-0.15121,-0.36492,-0.343022,3.60548e-05,-0.151219,-0.511041,0.0225052,0.176542,0.422375,0.420169,0.649904,0.78484 +3370.54,0.838381,0.0912059,5,1.47681,0.791656,-1.87234,0.626453,0.105185,-0.201189,0.0328882,-0.209616,-0.387069,0.484871,-0.0729851,-0.404172,-0.637976,0.55439,-0.528137,0.848954,0.891437,-0.0711294,-0.305918,0.554988,-0.159265,-0.72128,-1.11498,0.39029,-0.343231,-0.607939,-0.18604,-0.396392,-0.0928848,0.299705,0.374408,-0.33687,-0.277644,0.160909,-0.248379,-0.079428,-0.32888,1.33512,0.351936,-0.146044,1.0905,0.380945,0.70325,-0.662406,-0.0275826,-0.684943,-0.229319,0.628079,0.352641,0.414175,-0.0771372,0.269841,0.437426,0.290324,0.620974,-0.669872,-0.143878,-0.589664,0.222156,0.33134,0.569584,1.14194,-0.844133,-1.78684,0.391603,0.0650196,-0.218776,0.282786,-0.413842,-0.560575,0.298017,0.01011,0.296234,-0.0870102,0.422557,-0.181645,0.353866,-0.00607115,-0.693342,0.481844,0.509063,-0.680003,0.186089,-0.68776,0.341153,0.210904,0.025716,-0.494765,-0.24301,-0.0838553,-0.54375,-0.178247,0.190399,-0.234885,0.25523,0.650505,0.339214,-0.173165,0.303898,0.547063,0.0180418,0.39348,-0.744243,-0.657233,-0.406849,-0.739591,0.264549,0.275008,-0.0977616,0.974649,0.268329,-0.137669,0.658933,0.134927,0.691896,0.595357,0.174754,0.265602,0.187808,-0.0264354,-1.21308,0.54675,-0.157841,-1.12632,-0.280886,0.494208,-0.399062,0.0748443,-0.00363784,-0.427872,-0.0523446,-0.188057,0.425643,0.916614,-0.736769,-0.0540188,-0.107149,-0.743622,0.488652,0.194121,-0.491369,-0.177438,0.623465,-0.552945,-0.0943183,0.497223,0.129963,0.298473,-0.37076,-0.356236,0.150087,-0.307539,0.260397,0.653652,0.633933,-0.355067,0.366417,0.33812,0.115648,-0.00409611,-0.0729127,-0.254854,0.464913,0.373959,0.167732,-0.319278,-0.265181,-0.0251056,-0.0349965,0.238862,0.487383,0.0139454,-0.242272,0.209818,0.0431173,-0.109895,0.00563989,-0.133131,0.622178,1.23467,0.104783,0.455806,0.00280723,-0.216927,0.412784,-0.395551,-0.560189,0.0982526,0.0074723,-0.0363018,-0.19673,-0.452957,-0.308229,-1.01831,-0.15392,-0.201533,-0.0119419,-0.51741,-0.542563,-0.00168253,0.0632811,-0.0678862,0.642804,0.0526933,-0.349882,-0.356488,-0.308312,1.06452,-0.0558646,0.571328,0.307799,-0.434719,0.0172729,0.197039,-0.754979,-0.243912,0.0572094,0.00174359,0.0242081,-0.517603,0.0793575,-0.121777,0.0492001,1.04597,-1.07907,0.722998,-0.611756,-0.243319,0.812542,-0.69,-0.179342,-0.102584,-0.754496,0.121229,-0.372004,0.511835,-0.370775,0.105998,0.96566,-0.839965,0.033302,-0.133993,0.503968,0.425358,0.770329,-0.441348,0.73784,1.00381,-0.0398084,-0.420354,-0.216929,-0.744852,-0.0218278,-0.532491,-0.628391,-0.281637,-0.360242,0.240689,0.427938,-0.0163784,0.0166455,0.95972,0.0929162,-0.257947,0.187915,0.177425,0.432052,-0.00340087,0.116005,-0.169536,-0.370688,-0.271991,-0.795369,-0.0897856,-0.215026,-0.214088,0.390629,0.0918625,0.371455,0.146105,-0.007692,-0.482993,-0.486354,0.170766,0.00144765,-0.0423791,-0.103882,-0.0622949,0.200209,0.208273,-0.161789,0.296691,0.233063,0.324756,-0.111363,-0.328368,-0.204108,0.150919,-0.151616,-0.196935,0.31049,0.163072,0.343688,0.403821,0.586249,0.167961 +3384.79,0.721631,0.0912059,4,1.49936,0.758338,-1.43364,0.497323,0.169575,-0.151344,-0.0703998,-0.0586643,0.143115,0.452395,-0.428719,-0.16675,-0.605502,0.74579,-0.160411,0.516538,0.829324,-0.00223037,-0.0930012,0.233535,-0.288246,-0.623374,-0.474554,0.369447,-0.368473,-0.30704,-0.233095,-0.130957,-0.317079,0.217343,0.931624,-0.441133,-0.419757,0.237528,-0.176999,0.152506,-0.225661,0.951052,0.747649,-0.478798,1.12643,0.419714,0.618148,-0.767022,0.0419852,-0.39048,-0.247597,1.00281,0.342949,0.103244,-0.0332015,0.600151,0.283233,0.340942,0.75638,-0.742505,-0.466933,-0.312407,0.261037,-0.0874899,0.621226,0.73483,-1.49555,-1.02009,0.179035,0.30504,-0.270882,0.193584,-0.197515,-0.115481,-0.16126,0.618464,0.294872,-0.0103553,0.0744864,-0.355249,0.571982,-0.060246,-0.575049,-0.00520397,0.296475,-0.514641,0.224378,0.219906,0.441382,0.174525,-0.179183,-0.753368,-0.534013,-0.260583,-0.707134,0.176011,0.159457,-0.0211744,0.0545429,0.215358,0.0148061,-0.957006,-0.0477557,0.256059,0.255749,-0.18915,-0.8065,-0.190511,-0.105277,-0.657855,0.455159,-0.133124,-0.151591,0.699612,0.592667,0.46314,0.423051,0.204741,0.694809,0.223547,0.0275158,0.704409,0.223909,0.0447234,-1.3613,0.29423,0.271631,-0.698914,0.00458362,0.371987,0.400552,0.360638,0.159551,-0.349613,-0.107347,-0.177624,0.0571278,0.26379,-1.042,0.0466454,0.510783,-0.63338,0.210021,0.0186816,-0.616754,-0.234279,0.149928,-0.50654,0.549068,0.687892,-0.0708907,0.0242575,-0.108625,-0.0234679,0.266423,0.157042,0.0393117,-0.00548404,0.208019,0.202271,0.378931,0.215904,-0.165333,0.11692,0.647828,0.0111175,0.418496,0.0729234,0.118528,-0.511087,0.105249,-0.446383,0.0757556,0.541734,0.229073,-0.153562,-0.417633,0.823998,0.256174,-0.302204,-0.174668,0.0453597,0.7467,0.74044,0.504164,0.310499,0.147202,-0.102321,-0.271048,-0.168331,-0.390496,0.341182,-0.163828,-0.264305,-0.151444,-0.149404,-0.53694,-1.17938,-0.240365,-0.0718134,-0.0487767,-0.0336353,-0.419873,-0.353014,-0.131268,-0.202323,0.247663,-0.530436,-0.140782,0.197597,-0.750547,1.00694,-0.0568646,0.79136,-0.0334344,-0.318749,0.0886112,0.287007,-0.364098,0.287409,-0.513303,0.0287002,0.634381,-0.631066,0.386086,-0.0882647,-0.0664097,0.372164,-0.264627,0.622301,-0.338817,-0.137322,0.522469,-0.472335,0.259069,-0.0399014,-0.879014,-0.141008,-0.271311,0.586088,-0.112853,-0.104542,0.646225,-0.871846,-0.613591,0.147852,0.378963,0.0973733,0.699184,0.1862,0.844494,0.0290661,-0.364038,-0.231292,-0.336151,-0.64931,-0.0933168,0.0239629,-1.01318,-0.0985202,-0.43658,0.607298,0.0932445,0.00934693,0.035758,0.955191,-0.045461,-0.624551,0.510443,-0.249061,0.321002,0.794495,0.306741,0.504342,-0.0714532,-0.499627,-0.720468,0.172836,0.526072,-0.0649273,0.0519418,0.279861,-0.136462,0.225569,-0.518988,-0.0591706,-0.471871,0.0793948,0.191784,0.119501,0.290975,-0.251469,-0.0515065,-0.3526,-0.203752,0.688745,0.22775,0.193225,-0.613974,0.0914517,-0.354463,0.0821874,0.40067,0.0782883,0.0548642,0.191794,0.414801,0.437943,0.644051,-0.0848453 +3389.36,0.992026,0.0912059,4,1.58584,0.698309,-1.46461,0.588547,0.678541,-0.101076,-0.00303846,-0.627639,0.272659,-0.200797,-0.0518081,-0.339395,-0.569237,0.452612,-0.197155,1.19538,0.816462,-0.308855,0.301101,0.164645,0.0958548,-1.10248,-0.874042,0.209332,-0.559851,-0.552076,0.253821,0.612099,-0.300524,0.423346,0.993455,-1.03024,-0.500302,0.208887,-0.32038,-0.246346,-0.708957,0.390927,0.337649,-0.457043,1.41916,0.370999,-0.306218,-0.7919,-0.180945,0.238945,-0.520473,-0.161766,0.0256565,0.25355,0.0210153,0.0498795,8.07133e-05,-0.612086,0.875538,-0.583701,-0.0648232,-0.756646,0.191511,-0.714928,-0.159749,1.25697,-0.576218,-1.4741,0.287121,-0.144123,0.739987,-0.48016,-0.441041,-0.123934,0.231842,0.753823,0.394799,0.103268,0.248814,-0.0725765,0.847678,-0.391148,-0.662006,-0.072748,0.481175,-0.23954,0.328113,0.296043,0.751586,-0.416317,0.33277,-0.307205,-0.128706,-0.379742,0.460305,0.0833936,0.149552,-0.169987,-0.0736222,-0.171493,0.124685,-0.225844,0.294089,0.00414998,0.267791,0.169371,-0.150858,-0.194432,-0.177688,0.236441,0.323624,0.04378,0.221077,0.807034,-0.097974,-0.460835,0.243833,2.82897e-05,0.912208,0.0794107,-0.146525,0.0490188,0.459692,0.203104,-0.287659,-0.0842554,0.521786,-0.0513193,-0.323803,0.572506,-0.294054,-0.780299,0.893814,-0.519264,0.439768,-0.247607,0.196721,0.118779,-0.667619,-0.404649,-0.300306,0.000774003,0.724062,-0.417332,-0.527765,0.232927,0.544654,-0.709431,-0.165912,-0.46267,-0.191084,0.0210476,-0.168222,-0.12595,-0.480913,-0.023848,0.217837,-0.552385,0.193581,0.331483,-0.146249,-0.292641,-0.85227,-0.191299,0.589475,0.223721,0.572737,0.14257,-0.00536732,-0.128206,0.228005,-0.0469931,-0.349633,-0.463977,0.0686096,0.299516,-0.26891,0.208687,0.354564,0.0155857,-0.0661202,0.0904821,0.126237,0.619188,0.901748,-0.200617,0.801553,0.241695,-0.403714,-0.4223,-0.410102,0.100952,0.650885,-0.382867,-0.458125,-0.646711,0.16791,-0.817704,-0.27725,-0.359389,-0.145683,-0.524584,-0.609463,0.414873,0.194059,0.136598,0.265156,-0.0516441,0.289257,-0.613909,-0.558779,0.967282,0.524209,0.0241596,0.0463526,-0.418784,0.404112,0.538287,-0.0484726,-0.0309901,0.0666184,-0.212192,0.620343,0.0811666,-0.133831,0.103158,0.433116,0.295005,-0.958212,0.316046,-0.193395,-0.454834,-0.252714,0.275032,0.14144,-0.43727,-0.653636,-0.26636,-0.270633,0.673339,0.036136,-0.102321,0.231706,0.123953,-0.428706,0.274678,0.0456217,-0.0127785,0.298255,0.14112,0.707048,-0.462242,0.515413,-0.486406,-0.329282,-0.383049,-0.425924,-0.567354,-0.332611,0.255495,-0.526033,0.236964,-0.308131,0.240022,0.226975,0.112764,0.173522,0.025505,0.280079,0.278024,-0.115673,-0.0353944,0.226389,-0.135733,-0.306731,-0.118328,-0.329892,0.322962,-0.0137308,0.516572,-0.477254,0.143545,1.00531,0.452212,0.0594007,-0.442426,-0.208207,-0.446973,-0.018756,0.159069,-0.684794,-0.0522444,-0.0593956,-0.479868,-0.331888,0.11921,0.175428,-0.178305,0.114406,-1.0785,-0.413609,0.055094,0.0653723,-0.188152,0.293294,0.127434,0.235456,0.356979,0.485238,-1.6647 +3422.96,0.909121,0.0912059,5,1.56295,0.61415,-1.72033,0.71966,0.768828,-0.0570755,-0.242242,-0.442852,0.0813155,-0.395971,-0.0763463,-0.190066,-0.53797,0.74744,0.007262,0.762144,0.682953,0.0339981,0.317992,0.0856299,-0.0203464,-0.822634,-0.679877,0.431934,-0.911897,-0.641442,0.0846141,0.344248,-0.28966,0.28502,0.987106,-1.05033,-0.353725,0.517008,-0.116335,-0.334864,-0.919337,0.196712,0.561356,-0.430668,1.37829,0.58111,-0.229777,-0.684676,-0.195745,0.0495721,-0.287081,0.0562046,0.197576,0.293921,0.162404,-0.110042,0.187292,-0.45701,0.58506,-0.695108,-0.293691,-0.782333,0.228209,-0.472845,-0.1147,0.989638,-0.462512,-1.27203,0.433437,0.129334,0.68651,-0.220372,0.0360836,-0.268788,0.167304,0.811705,0.326077,0.0845503,0.13813,0.0175234,0.682331,-0.288472,-0.656389,0.0814676,0.747692,-0.497186,0.331774,-0.0134809,0.448746,-0.504551,-0.108385,-0.312418,-0.0245781,-0.265873,0.880339,0.22884,0.216143,0.0611276,-0.303947,-0.254696,-0.024273,0.0341702,0.719639,0.110008,-0.0423565,0.0693686,0.147012,-0.189984,0.0845791,-0.0171275,0.244553,0.143861,0.0500408,0.626319,-0.109623,-0.741261,0.577812,0.273561,1.08454,-0.0759586,-0.0761196,0.198919,0.734264,0.269487,-0.538521,0.000409743,0.607251,-0.0126558,-0.291544,0.665382,-0.288794,-0.873496,0.627509,-0.469837,0.237671,-0.144145,0.00399168,0.286772,-0.657084,-0.227148,-0.0878053,0.0699293,0.866092,-0.500367,-0.365533,0.129496,0.578039,-0.588639,-0.228358,-0.583424,-0.0761345,0.0984646,-0.234525,-0.0457783,-0.123231,0.222419,0.0961732,-0.327651,0.383543,0.278383,-0.222059,-0.120899,-0.513207,0.0323287,0.468506,0.304149,0.436823,0.0556841,0.209391,0.259982,0.120539,-0.0774843,0.193809,0.0266585,0.155697,-0.201135,-0.152285,0.539043,0.424858,0.0992996,-0.20178,-0.390112,0.244771,0.782809,0.613244,-0.222013,0.390759,-0.0140438,-0.150978,-0.00899519,-0.236878,-0.244237,0.575967,-0.0956115,-0.405834,-0.584754,0.00972918,-0.550736,-0.186609,-0.354047,-0.318649,-0.465612,-0.600025,0.255346,0.233534,0.144742,0.300207,-0.174783,0.189747,-0.12314,-0.560409,0.881818,0.153352,-0.0752641,-0.0240343,-0.350059,0.219395,0.744679,0.238852,-0.0390493,0.102496,-0.213826,0.355911,0.155794,-0.0345269,-0.0565686,0.169009,0.28284,-0.658175,0.407482,-0.376101,-0.545793,-0.222422,0.490872,-0.0447576,-0.290947,-0.319464,0.00769917,-0.256605,0.486703,0.119087,-0.170119,0.553895,-0.222829,-0.171231,-0.0250882,0.220962,-0.00175001,0.530184,0.140357,0.572314,-0.134236,0.716735,-0.691453,-0.503996,-0.513879,-0.212343,-0.411272,-0.441365,0.272476,-0.466413,0.230513,-0.228739,0.194628,0.328463,0.530405,0.227207,0.184781,0.481187,0.122033,-0.366922,-0.299876,0.0214917,0.0201406,-0.491656,0.291836,-0.33993,0.211552,-0.196104,0.164462,-0.495616,0.00962082,0.874785,0.329774,0.063217,-0.257318,-0.381003,-0.204458,0.2938,0.307158,-0.759726,-0.0545149,0.216557,-0.603557,-0.236692,0.0848743,0.174212,0.0430923,-0.0580867,-0.904382,0.0951436,0.231572,0.340266,0.221742,0.336915,0.145423,0.265122,0.381344,0.5149,-1.83952 +3432.67,0.983483,0.0912059,4,1.57223,0.634741,-1.44791,0.611302,0.758988,-0.157633,-0.38398,-0.168772,0.120263,0.423944,0.417468,-0.141568,-0.54788,0.395214,-0.135732,0.824883,0.513605,0.0404977,0.0771663,0.0671964,0.118266,-0.902006,-1.05792,0.524225,-0.320018,-0.16235,-0.28396,0.117072,-0.631997,0.141125,0.735355,-0.989656,-0.295448,0.461925,0.0758238,0.315506,-0.664828,0.251534,1.03484,-0.0409428,1.18348,0.460351,0.257277,-0.751006,0.0218888,0.578978,-0.765455,-0.00167731,0.21045,0.0569945,-0.0478897,1.14058,0.00113587,-0.40288,0.903698,-0.148941,0.0262585,-0.530714,0.64255,-0.497237,0.509321,0.746564,-0.506624,-0.807987,-0.128338,0.245536,0.0309409,0.0796308,0.152119,-0.568974,-0.0408275,-0.223864,0.582588,-0.873515,0.275175,0.056296,0.443126,-0.601292,-0.0149039,0.0186057,0.607814,0.141988,0.272786,-0.586346,0.746837,-0.134214,-0.269142,-0.319195,-0.032021,-0.14164,0.116472,0.0126021,-0.364459,-0.164855,-0.206884,-0.150748,0.540626,-0.587159,-0.203247,0.0526552,0.0942001,-0.0748886,-0.35734,0.216997,0.17644,-0.0239987,1.10216,-0.114903,0.275661,0.444918,-0.224441,-0.187843,-0.241998,0.0799666,0.170398,0.427254,-0.312517,-0.135422,0.259481,-0.202248,-0.250202,0.0753263,-0.665823,-0.474265,0.113198,0.0528605,0.0570184,-0.343565,0.0269891,-0.438963,0.126779,-0.0198758,-0.189606,-0.226593,-0.201905,-0.389307,-0.640916,-0.208432,0.409656,-0.624278,-0.27109,-0.12144,0.436118,-0.696922,0.216857,-0.000811018,0.253425,0.228776,-0.0118003,-0.110643,-0.205016,-0.0137062,0.0722453,0.12887,0.864348,0.311087,0.331781,-0.056376,0.0640172,0.0850145,0.515411,0.0450206,0.711278,-0.233811,-0.171504,0.633962,0.0836361,-0.432411,0.0951542,-0.653568,0.435971,0.983545,-0.316042,-0.0965019,-0.0120968,-0.310758,-0.234705,-0.061156,0.362338,0.963062,0.473925,0.402463,0.0668914,-0.496542,0.375429,-0.391279,-0.895948,-0.0239545,-0.166857,-0.506427,-0.113961,-0.364825,-0.229581,-0.903766,-0.215215,0.232451,0.177615,-0.255968,0.00571429,0.441143,-0.129735,-0.364358,-0.289232,0.0053822,0.451082,0.368832,0.0411501,0.990988,-0.314114,0.130842,0.0988225,-0.351713,-0.108731,0.649303,-0.116889,0.0356544,-0.513552,-0.0124002,0.321491,0.10471,0.253468,-0.571708,0.512768,0.509716,-0.0602519,0.544983,-0.881131,0.171984,0.105094,-0.06629,-0.111059,-0.0331263,-0.173387,-0.872372,-0.16029,0.364814,0.757414,0.305659,0.240759,-0.14621,-0.512307,-0.135448,-0.0713761,-0.0102024,-0.190576,0.292984,0.548949,-0.218902,-0.318056,-0.214572,0.31579,-0.671463,0.149045,0.0703152,-0.315275,-0.0807628,-0.570177,0.106313,0.253919,0.291988,0.455918,-0.137848,-0.0262453,-0.203384,0.196932,-0.174606,0.431883,0.388045,0.00920955,-0.272369,-0.219527,-0.261288,-0.308259,0.10015,-0.299802,-0.0141564,0.0649016,0.517226,0.314857,0.284068,-0.117068,-0.685927,-0.349306,0.225502,-0.013269,0.498617,0.0960586,0.512527,0.192973,0.155174,-0.081581,0.455427,-0.190487,0.105156,-0.220784,-0.401641,0.083036,0.522894,-0.19038,-0.236385,-0.0738579,0.132244,0.293144,0.363654,0.541427,-1.84921 +3437.37,0.985913,0.0912059,5,1.61895,0.599177,-1.73041,0.662401,0.429135,-0.0920653,-0.511075,-0.406512,-0.0964332,-0.424121,0.262857,-0.509526,-0.0986498,0.454903,-0.236825,0.603574,0.488372,0.0492395,-0.204598,0.311629,-0.097195,-0.883532,-1.00343,0.623947,-0.431072,-0.235793,-0.277647,0.130752,-0.502112,0.208479,0.812523,-0.548933,-0.598123,0.599529,-0.3677,-0.281904,-0.28906,0.714779,0.495595,-0.0948178,1.35369,0.67952,0.298911,-0.54372,-0.345908,-0.496104,-0.594123,-0.103808,0.620871,0.340842,0.156297,-0.170877,-0.101336,-0.124625,0.603613,-0.725209,0.077354,-0.773415,0.441164,-0.389615,0.175596,0.871094,-0.971637,-1.0908,0.157837,0.521422,0.305537,-0.00867637,-0.355932,-0.427553,0.421457,-0.0493612,0.562533,-0.169832,0.330607,0.204748,0.150904,0.0715951,-0.547595,0.165344,0.520816,-0.222643,0.145821,-0.636193,-0.468979,0.161055,0.2164,0.183115,-0.233983,-0.172506,-0.295387,-0.224275,-0.02502,0.393631,0.16923,-0.287286,-0.141679,0.0324455,0.197917,-0.0330615,0.31692,0.552137,-0.157959,-0.404415,-0.142743,-0.164208,0.207248,0.0203083,0.386284,0.343516,-0.25439,0.0661364,0.252962,0.372991,-0.431287,0.108128,0.0289818,0.17076,0.186099,0.145768,-1.08376,-0.0609528,0.26239,-0.100879,-0.464947,0.126966,-0.147118,-0.65164,0.285896,-0.786575,-0.278657,-0.0575242,0.0149776,0.199916,-0.50013,-0.5311,-0.134993,-0.159962,0.266675,-0.137579,-0.784643,-0.0705978,-0.289623,-0.463473,-0.284751,-0.222031,-0.151308,0.328519,-0.142262,-0.141849,-0.539733,-0.137703,0.153786,-0.0394155,-0.0167311,0.208948,-0.158314,-0.254134,-0.13119,-0.0598591,-0.260298,0.205811,0.854064,0.418306,0.623831,-0.13391,-0.0309798,-0.0600241,0.0223653,-0.0625918,0.326593,-0.432377,-0.0209065,0.158008,-0.680667,0.115703,-0.24845,0.25499,-0.158196,0.648024,0.37379,-0.460432,0.79978,-0.656966,-0.0106253,-0.0940686,0.0343837,-0.731964,-0.170542,0.174328,0.252525,0.213248,-0.421329,-0.518879,-0.0205555,-0.23349,-0.597799,-0.02936,-0.321169,0.440383,-0.0821525,0.0881993,0.136361,-0.0450499,-0.424285,-0.0567825,-0.896261,0.989097,0.252599,-0.0497848,-0.733861,-0.164516,0.348682,-0.170438,-0.418545,-0.0751154,-0.54562,-0.149554,0.152965,-0.21428,-0.260175,0.110626,-0.0720676,-0.130226,-0.0416354,0.16766,-0.354591,-0.00360394,0.236558,0.438415,-0.114861,-0.127507,-0.103664,-0.0119989,-0.283746,0.353653,-0.355088,-0.157395,0.946146,-0.249613,0.555358,-0.118867,0.0481188,-0.274228,0.0920385,-0.198752,-0.0677268,0.855012,0.159604,0.192872,-0.132514,-0.320111,0.211471,-0.211372,-0.0423497,-0.145689,-0.150729,0.120082,0.144175,-0.287633,-0.0161359,0.550425,0.360679,-0.0811803,0.242208,-0.430385,-0.078263,-0.114097,-0.221409,-0.0710406,-0.457989,-0.652308,-0.329131,0.337187,-0.393582,0.503659,-0.469819,-0.226458,-0.117222,0.16796,0.146507,0.188491,-0.0417255,0.287291,0.452464,-0.059165,-0.168289,-0.023951,0.187842,-0.641835,-0.0457147,0.549302,-0.119901,0.469735,0.106055,-0.32841,0.0255807,0.208386,-0.101912,0.168052,-0.0726855,0.0967333,0.278086,0.31102,0.527339,-0.560994 +3429.92,0.953216,0.0912059,4,1.63914,0.533865,-1.61945,0.643788,0.590041,-0.0639819,-0.534851,-0.317851,-0.211701,-0.059059,0.401024,-0.447203,-0.301868,0.287382,-0.372643,0.653943,0.470528,0.191239,-0.324615,0.114923,-0.261917,-0.765734,-0.739003,0.602902,-0.362882,-0.213724,-0.422531,0.267131,-0.610027,0.423568,0.848777,-0.623253,-0.22182,0.719925,-0.596385,-0.314456,-0.431417,0.744072,0.368117,0.0185046,1.33345,0.775378,0.347482,-0.653789,-0.289687,-0.701369,-0.717423,-0.0887821,0.523586,0.351343,0.0436971,-0.00214079,-0.10954,-0.234033,0.794118,-0.718019,-0.0858768,-1.1159,0.492863,-0.372953,0.288478,0.679135,-0.683312,-1.0157,0.170979,0.651705,0.150142,-0.0258093,-0.359435,-0.439906,0.402181,0.00696798,0.591706,-0.121418,0.100461,0.23742,0.257665,0.0537374,-0.58552,0.0477977,0.332766,-0.420034,0.0876624,-0.505238,-0.433905,0.0466853,0.183862,-0.0730148,-0.071893,-0.220161,-0.283063,-0.50079,-0.208521,0.362469,0.104457,-0.374502,-0.113436,-0.133855,0.0782881,-0.136503,0.444298,0.391164,-0.122152,-0.410028,-0.12779,-0.0411108,0.129232,-0.14411,0.412135,0.169313,-0.221025,0.265191,0.178785,0.350254,-0.278262,0.0043009,0.362213,0.0570554,0.120097,0.28136,-1.21206,-0.0995435,0.307014,0.274768,-0.217979,0.135835,-0.0657756,-0.51015,0.600117,-0.724634,-0.220035,-0.438245,0.0481926,0.29946,-0.532005,-0.26139,-0.0154166,-0.1707,0.0655761,-0.127524,-0.620326,-0.182181,-0.154409,-0.601057,-0.11986,-0.244705,-0.19637,0.279983,0.0573065,0.0217126,-0.42579,0.135494,0.310742,-0.031109,-0.118051,0.128538,0.0110289,-0.344639,-0.129313,0.153864,-0.124072,0.111919,0.94163,0.19968,0.531523,0.200882,-0.194213,-0.180473,0.106893,0.139373,0.32106,-0.357785,0.0712303,0.145236,-0.639854,0.124717,-0.415534,0.25924,0.0653031,0.534647,0.305442,-0.389042,0.874556,-0.367912,0.148385,-0.0353899,0.0421743,-0.541283,-0.126324,0.0711014,0.133655,0.169391,-0.745825,-0.64686,0.17924,0.0287387,-0.505423,0.0744614,-0.407791,0.0374329,-0.0207929,-0.0608495,0.203025,-0.0870575,-0.369028,0.0708236,-0.70544,0.99464,0.305364,0.0634004,-0.673232,-0.104019,-0.00699777,-0.269871,-0.108987,-0.148894,-0.685638,-0.275024,0.0433204,-0.0350074,-0.340764,0.136753,0.295095,-0.153408,0.234152,0.282722,-0.187952,0.210461,-0.150227,0.47092,0.182794,-0.053502,0.00995505,-0.0416173,-0.0513651,0.366606,-0.327911,-0.217032,0.876012,-0.274813,0.506469,0.223199,-0.082058,-0.27573,0.048985,-0.346605,-0.0562757,0.775777,0.289499,-0.168873,0.159393,-0.363648,0.269835,-0.179942,0.164837,-0.0150623,-0.174752,0.127959,0.294431,-0.0781218,0.219374,0.702423,0.260836,0.104924,0.173358,-0.380849,-0.147111,0.136323,-0.238318,-0.110756,-0.355871,-0.528003,-0.446157,0.174652,-0.326781,0.582153,-0.286613,-0.052195,-0.50096,0.15972,0.28632,0.372547,0.035318,0.416539,0.240575,0.056876,0.187707,-0.0578653,0.0212894,-0.72787,-0.0216391,0.622696,-0.143268,0.249803,0.166456,-0.201667,0.134156,-0.141827,0.0630057,-0.0509764,0.342695,0.112449,0.256141,0.335333,0.506104,-1.00718 +3442.75,0.831429,0.0912059,4,1.61455,0.583581,-1.72189,0.753203,0.577126,-0.115325,-0.200512,0.114823,-0.315279,-0.0238486,0.272529,-0.388895,-0.113127,0.321221,-0.476251,0.372934,0.217045,-0.427978,0.148994,0.129221,0.249991,-0.806949,-1.17254,0.6833,-0.450779,-0.479905,-0.181874,0.0858211,-0.478285,0.0608545,0.933427,-0.740529,-0.401035,0.461038,-0.216494,0.253094,0.0389028,0.474969,0.89421,-0.529831,1.33029,0.120751,1.11708,-0.740426,-0.292149,0.176446,-0.899032,-0.111014,0.280889,-0.0898179,-0.0867063,0.708804,-0.0212329,-0.235235,0.640594,-0.371788,-0.136252,-0.712805,0.0856491,-0.573018,-0.216612,1.033,-0.554968,-0.443059,-0.122461,-0.322847,-0.157531,-0.0557423,0.114283,-0.0802194,-0.303876,0.142169,0.481148,0.0290435,0.421025,0.260117,0.561994,0.0265872,0.172929,0.00152842,0.479667,-0.191531,0.066609,-0.0240325,-0.152501,0.15848,-0.144185,0.0908578,-0.0830486,-0.360865,-0.430951,0.515038,-0.0986372,-0.300883,0.041627,-0.376561,-0.0933329,-0.0426001,-0.280747,-0.128495,-0.343498,-0.343241,-0.626441,-0.459392,0.958709,-0.681012,0.595268,-0.165792,-0.0771744,0.478302,0.062041,-0.150566,-0.541059,0.254419,0.191062,0.132093,-0.42096,0.126483,0.657214,-0.214645,-0.670598,0.422955,0.171474,-0.97495,0.269867,0.00307947,0.469006,-0.010696,-0.158259,0.255185,-0.293528,0.36412,-0.0877807,0.64246,-0.0614198,0.308319,-0.0068896,-0.0597066,0.578935,-0.270812,-0.294178,-0.0366152,0.295393,0.27336,0.0438356,0.223686,0.0817869,-0.0773826,0.00224413,-0.0947388,0.105692,0.0596415,0.22133,-0.418332,0.467163,0.12341,0.0170131,0.518172,-0.372865,0.280682,0.024141,-0.259349,0.684825,0.219251,0.15212,-0.0868746,0.0256835,0.0685496,-0.0526447,0.30693,-0.0641885,0.263134,-0.338302,0.139916,0.20306,-0.0826801,-0.243337,-0.289286,0.0769093,0.849112,-0.131905,-0.127412,-0.317144,0.565525,-0.590386,-0.302998,-0.456824,-0.327887,0.688065,-0.344501,0.0739225,-0.0166583,0.314273,-0.777856,0.174704,-0.0766189,0.227805,-0.346372,0.0770586,0.49054,-0.222026,0.115273,0.127656,0.0933958,0.0705812,-0.107859,-0.254423,1.02164,0.0361534,0.0865963,0.052478,-0.183877,-0.041253,-0.235697,-0.605096,0.374598,-0.0189346,-0.206517,0.172241,-0.848101,0.0720248,-0.269812,-0.221817,0.53875,-0.658678,0.139095,-0.494976,-0.422763,0.113861,-0.392578,-0.115454,-0.0161831,0.240327,-0.35675,0.115933,0.264462,0.117906,0.367804,0.382917,-0.586578,-0.235227,0.0199127,-0.137693,0.0113589,0.294547,0.0804659,0.744991,-0.0144478,-0.661046,-0.28256,0.261823,-0.216231,0.16877,-0.487486,-0.554445,0.128459,0.170456,-0.0717189,0.366014,0.047858,-0.278721,0.378107,-0.269642,-0.419249,0.181081,0.174052,0.0486449,-0.16154,-0.333701,-0.320736,-0.068788,-0.617019,-0.352374,0.444136,-0.306609,-0.0420445,-0.530061,-0.292532,-0.0665997,0.178021,-0.116327,-0.0374814,-0.407431,0.0464624,-0.332365,-0.1321,-0.212836,0.242561,0.530823,0.0507457,-0.0963537,-0.104491,0.221662,0.30249,-0.396625,-0.360502,0.327888,0.0815492,-0.430413,-0.0489788,-0.159605,0.105655,0.281749,0.325046,0.5308,-1.11389 +3401.64,0.955713,0.0912059,4,1.63638,0.754366,-2.00876,0.971656,0.651462,-0.197478,-0.418994,-0.128364,0.423565,-0.245389,-0.153673,-0.297387,-0.371165,0.240457,-0.144593,0.400864,0.157929,0.592086,-0.170823,-0.220761,0.169286,-0.996581,-1.48031,0.541269,-0.494053,-0.220988,-0.0087357,-0.238349,-0.985735,0.378158,0.931099,-0.0736353,-0.174152,1.00593,-0.403823,-0.316666,-0.473131,1.06264,0.588448,0.00144128,0.718274,1.04101,-0.0309299,-1.24441,-0.0431813,0.515382,-0.46362,0.345826,-0.0164964,-0.0108288,-0.372135,-0.183866,-0.0721286,-0.709597,-0.139586,-0.37679,-0.916691,-0.923237,-0.100236,-0.804981,0.584463,0.833679,-0.728631,-1.118,0.91197,0.864321,-0.407129,-0.00516654,-0.208057,-0.0515999,-0.0499407,-0.34891,0.649334,-0.0048832,0.424928,0.469844,-0.32563,0.0962584,-0.375952,-0.251704,0.381022,0.185531,0.0537646,0.0422911,0.132144,-0.343434,0.136079,-0.0680826,-0.174149,-0.479499,0.106299,-0.463794,-0.472994,-0.11666,-0.37797,0.094577,-0.0784018,-0.587704,0.166579,0.194777,0.044099,-0.580748,0.0593574,-0.13402,-0.387801,0.362349,-0.450999,-0.516631,-0.189977,0.660668,0.338403,-0.238262,0.288945,0.138043,-0.00859657,0.281005,-0.05185,-0.393449,-0.197107,-0.113502,-0.419252,-0.0502461,0.147011,0.151182,-0.350065,0.237467,0.00759899,0.483192,0.571643,-0.495495,-0.89082,-0.370835,0.0857203,0.386833,-0.118173,-0.774649,-0.495828,-0.200492,0.150422,0.318841,0.142473,-0.196493,0.152957,0.0861199,-0.0408222,0.229521,0.0987514,0.19161,-0.125708,-0.630142,-0.571828,-0.329074,-0.396066,-0.162302,0.340446,0.275732,-0.389675,-0.860999,-0.0778048,-0.104394,0.158866,-0.0150932,0.187855,-0.132268,-0.191652,0.425991,-0.176247,-0.270769,0.0302929,0.0644073,0.100675,0.368338,-0.111687,0.277132,0.14134,-0.658804,-0.469923,0.639435,0.263855,0.281753,0.227332,-0.39506,0.493123,-0.0462117,0.145161,-0.603797,-0.316725,0.261172,-0.155294,-0.0937879,0.0598308,-0.214075,-0.399046,-0.702654,0.085765,0.235366,0.0550662,0.112297,-0.173681,0.700316,-0.140582,-0.364199,0.0557057,-0.721212,0.162241,0.262215,-0.580868,0.855078,-0.267415,0.391777,-0.642349,-0.355276,-0.445187,0.172561,-0.025756,-0.151173,-0.439548,-0.158567,0.299785,0.196564,-0.0104884,-0.207391,0.532748,-0.0275357,-0.118031,0.447012,-0.0860782,0.273891,0.0113432,0.325339,0.29478,-0.174856,-0.443584,0.0880778,-0.252149,0.136003,0.276781,-0.576695,0.281117,-0.145061,-0.176274,0.127187,-0.555457,-0.150309,0.263786,0.179261,0.337886,0.563668,0.803507,-0.19487,-0.0158453,0.0227434,0.595872,-0.125358,-0.133754,0.235173,-0.488712,0.124277,0.302229,-0.284514,0.271735,0.412913,0.44557,0.625394,0.484755,0.126512,0.144906,-0.308068,0.910875,-0.237624,-0.445131,-0.224864,-0.1767,0.0389069,-0.234351,0.110337,0.385134,0.149013,0.173404,-0.0416678,-0.197503,-0.409982,-0.0136233,0.291134,0.194593,0.413215,0.257189,-0.157486,-0.0755511,-0.00511173,-0.165925,0.0595962,0.187544,-0.240374,-0.242461,-0.0500466,0.357817,0.240324,-0.136086,-0.562696,-0.141636,0.111629,0.333541,0.334109,0.57753,-1.67669 +3408,0.969823,0.0912059,4,1.49445,0.79939,-2.28704,1.04727,0.494868,-0.323322,-0.30944,-0.0408573,-0.172808,0.232135,0.0344816,-0.305904,0.00227178,0.489968,-0.136841,0.652582,0.416554,0.116377,-0.162459,-0.188757,0.354755,-0.580932,-0.445089,0.202417,-0.12013,0.00180684,-0.194783,0.239834,-0.19302,-0.0399216,1.0883,-0.698284,-0.258904,0.425553,-0.502329,-0.0995902,0.279712,0.427041,0.881184,-0.462202,0.706305,0.435519,1.29013,-0.93847,-0.267861,0.612767,-0.461504,0.386346,0.384727,-0.345564,-0.233345,1.77428,-0.195011,0.815394,-0.226639,0.113878,0.226315,-0.98918,-0.179367,0.0236389,0.349982,1.36802,-0.668453,-0.663306,-0.0540436,-0.292436,0.455287,0.111035,-0.0412303,-0.438179,0.00916218,0.435188,0.103586,-0.339511,0.436344,0.0828408,0.0549802,-0.383425,0.00489234,-0.144573,0.358488,-0.296862,0.142286,-0.319393,-0.409019,0.350749,-0.278026,0.142541,0.0578657,-0.346779,-0.372616,0.147281,-0.333851,-0.54407,0.21018,-0.586928,-0.0852983,-0.254593,0.225527,0.192929,-0.122148,0.235503,-0.74365,-0.596102,0.509736,-1.15466,0.366418,-0.219877,0.436931,0.521744,0.218264,0.146885,-0.145014,0.00734451,-0.0610245,-0.559693,-0.225424,0.0341134,0.2548,-0.353264,-0.691648,0.192496,-0.404097,-0.502984,0.501358,-0.28106,-0.101973,-0.0694598,0.04782,-0.41868,0.716479,-0.0571165,-0.310752,0.335454,-0.362233,0.101322,0.664519,-0.0191069,0.25306,-0.931141,-0.520497,0.0290954,-0.346823,-0.487848,0.037248,0.333912,0.125813,0.133877,-0.317972,-0.155255,0.0101659,-0.246167,0.0924898,-0.219824,-0.134789,0.405451,0.47043,0.663434,-0.0500702,0.128514,-0.0487729,0.0233386,0.504195,0.059332,0.101942,0.022535,-0.143758,-0.235126,0.074326,-0.302378,0.0266074,-0.503811,-0.300716,-0.138906,-0.202909,0.40887,-0.364786,-0.544359,-0.122621,0.576877,-0.195801,0.263314,-0.457203,0.252295,-0.123005,0.548558,-0.124788,-0.387582,0.453836,-0.272266,-0.329704,0.014407,0.340346,-0.291067,-0.467364,-0.100286,-0.0508846,-0.926857,-0.740451,-0.157689,-0.0847648,0.230953,0.0949688,0.365193,-0.00695379,-0.185785,-0.0343378,0.685024,0.0470734,0.228834,-0.176978,-0.180853,0.349768,-0.0417015,0.0101123,0.425467,-0.108901,0.289422,0.197878,-1.08696,-0.0767379,-0.638168,-0.346683,0.341418,-0.182586,0.1007,-0.42412,-0.373763,0.0717837,-0.326713,-0.21713,-0.298163,0.207907,-0.420107,-0.132262,0.11418,-0.303728,0.415482,0.365845,0.032944,0.50147,-0.0722976,0.924148,0.137717,0.310191,0.066741,1.00749,0.181159,-0.929201,-0.175955,0.213573,-0.56571,0.0745431,-0.538938,0.125916,0.555692,-0.160432,0.0589131,0.00889424,0.586115,0.124462,0.0537245,-0.204497,-0.192874,0.0898017,0.182673,-0.122812,0.215636,-0.376456,-0.194602,-0.210756,-0.000809551,-0.100175,0.481097,0.0267505,-0.240034,-0.033347,-0.212812,0.55562,0.253978,0.145791,0.0643201,-0.150818,-0.308945,0.0719864,0.350254,0.0337858,0.111555,0.384326,-0.0210846,0.260341,-0.389507,-0.475003,0.425374,-0.106091,-0.421011,-0.308551,-0.11186,-0.137805,0.38499,0.181771,0.113391,0.283124,0.336736,0.532094,-1.2724 +3392.71,0.892865,0.0912059,5,1.59137,0.569865,-1.95208,0.859077,0.614224,-0.114854,-0.710222,-0.302861,-0.0735278,-0.059458,0.0783083,0.101624,-0.867498,0.962806,-0.20637,0.0913273,0.162164,-0.00164325,0.0226176,-0.273119,0.421446,-0.783789,-1.26323,0.496752,-0.651272,-0.0550194,-0.288229,-0.207948,-0.745314,0.193307,0.944928,-0.608307,-0.0254875,0.17673,-0.383792,-0.355648,-0.680885,0.795894,-0.0695677,-0.42608,0.894708,1.35619,-0.189446,-0.671114,-0.501871,-0.385402,-0.205558,0.373749,0.467288,0.261999,0.166248,-0.330539,0.467136,-0.825602,0.124386,-0.217669,-0.239141,-0.751466,0.186241,-0.385843,0.5823,0.869265,-0.781062,-0.813894,0.665387,0.821682,-0.396183,-0.0191778,0.0505451,-0.0312543,-0.382917,-0.0161972,0.0129543,-0.0447606,0.472463,0.521216,0.252343,0.160994,-0.57708,-0.231563,0.259247,-0.37201,0.33371,-0.0572063,-0.285274,-0.476752,0.0539772,-0.270567,-0.0132357,-0.370962,0.340049,-0.488935,0.14479,0.229368,-0.173406,0.297468,0.522394,-0.167276,0.180997,0.158617,-0.14934,-0.708127,0.235755,0.259091,-0.243754,0.303116,0.0594275,-0.285462,-0.10393,0.3589,-0.323714,-0.496408,0.145619,0.638748,-0.0589179,0.0777169,-0.0985723,-0.287336,-0.00637272,0.141286,-0.431347,0.00706142,0.254844,0.0899078,-0.0581156,0.412502,0.437921,-0.394522,0.586321,-0.197543,-0.721001,-0.797721,0.351559,0.568422,-0.0505249,-0.506494,-1.11331,-0.150626,0.0746989,0.279858,0.000712839,0.0166581,0.573054,-0.54948,0.056238,-0.385651,-0.059351,0.424741,-0.00817059,-0.0350926,-0.444695,0.310323,-0.197564,0.154315,0.345523,0.438271,0.00220241,-0.556307,0.0856505,-0.337634,0.342002,-0.0246653,0.855274,-0.0281878,-0.472313,0.106819,-0.112074,-0.00854056,-0.401638,0.226697,-0.0825973,0.0542041,0.194559,0.0319202,-0.400672,-0.431695,-0.430658,0.489138,0.0359296,0.445223,0.427357,-0.443321,0.683908,-0.0837961,-0.0295203,-0.822271,-0.398562,0.25353,-0.41815,-0.258613,-0.442827,-0.215458,-0.443292,-0.786198,0.284651,0.232192,0.271936,0.0913503,-0.037511,0.173417,0.112681,-0.436168,-0.076223,-0.557172,-0.085886,-0.00205381,-0.584478,0.880611,-0.207164,-0.170261,0.0954319,-0.493404,-0.231364,0.381081,-0.291121,0.0905401,-0.0164292,-0.162346,0.0425514,0.545608,0.23893,0.191847,0.316744,-0.219081,-0.36153,0.468565,-0.00706284,-0.0286677,0.147085,0.236278,0.069614,0.290139,-0.339907,-0.254924,0.0649236,0.263458,0.157918,-0.420832,0.370093,-0.137255,-0.639278,0.175465,-0.693143,-0.110365,0.281868,-0.00177643,0.288596,0.0452144,0.968896,-0.855745,0.0199953,-0.121913,0.685012,-0.209823,-0.323071,0.204635,-0.334569,0.198436,0.0459324,-0.0646609,0.261171,0.326091,0.53059,0.450283,0.302006,0.193594,0.263355,-0.289991,0.058834,0.382726,-0.158212,-0.419133,-0.755418,-0.214119,0.325381,0.811196,0.281154,0.142575,0.192203,0.33434,0.0446246,-0.0838963,-0.287497,0.4331,0.121483,0.0836059,-0.0180146,-0.0954696,-0.101644,-0.0303838,0.0246124,0.443507,0.48271,0.131496,-0.103722,0.0283094,-0.0141456,0.115143,0.151151,-1.159,-0.133641,0.12944,0.323176,0.359778,0.568486,-1.21556 +3406.96,0.995848,0.0912059,5,1.5258,0.609616,-1.83186,0.733953,0.250167,-0.136457,-0.270669,-0.14303,0.190154,-0.494523,0.0614479,-0.131032,-0.517473,1.04309,-0.385473,0.639967,0.213958,0.1384,0.0877741,0.219006,-0.0887513,-0.76417,-1.16868,0.462292,-0.371282,-0.306928,-0.254581,0.237385,-0.354395,0.104898,0.819916,-0.684814,0.267198,0.43719,-0.281604,0.358895,0.0061114,0.704525,0.0578464,0.021721,1.23372,0.666028,0.380631,-0.830621,-0.165297,-0.352,0.180599,0.847544,0.431807,0.323727,-0.059996,0.420825,-0.0179379,-0.71918,0.375287,-0.0473282,-0.280793,-0.846413,0.671659,-0.216228,0.262077,0.897239,-1.08787,-0.712334,0.487725,0.132116,-0.50951,-0.00983742,0.268458,-0.153607,0.376764,0.457835,0.284636,0.20525,0.932392,0.400834,0.40436,0.0778919,-0.643752,-0.100496,0.670873,-0.160678,0.180058,-0.0210585,-0.264873,-0.32589,-0.0278284,0.253337,-0.301212,0.133213,0.118303,0.241251,0.0900353,0.0936858,-0.201438,-0.201091,0.0930145,0.492253,0.453813,0.0929329,-0.348861,-0.0975447,-0.413837,-0.0309175,-0.231498,-0.416282,-0.490717,-0.184208,0.18523,0.465057,0.381961,-0.586904,-0.426876,0.560725,-0.283574,0.116994,-0.307179,0.291814,0.512675,-0.532806,-0.16528,-0.279573,0.33774,-0.0431808,0.0166334,0.574666,-0.144151,-0.334856,0.196847,-0.440748,-0.189257,-0.39427,0.0333904,0.500331,-0.249558,-0.0599617,-0.605957,-0.401884,0.436301,-0.390675,0.118303,-0.0525939,0.228421,-0.0269518,-0.19405,-0.443384,-0.0853201,0.706546,-0.255622,-0.117384,-0.339317,0.554547,0.162717,0.299783,0.0948538,0.109033,-0.0798766,-0.0609089,-0.0600145,-0.517232,0.248905,0.228963,0.819314,-0.308276,-0.246839,0.126717,-0.11318,-0.0948011,0.467958,-0.212416,-0.146238,-0.0772261,0.0668466,0.584335,0.180646,0.405248,-0.0889528,0.505465,0.228091,0.645717,0.105865,-0.248795,0.0856546,0.29096,-0.245617,-0.46773,-0.135051,-0.0792369,-0.460431,-0.316935,-0.522796,0.113058,-0.355632,-0.81412,-0.541699,0.337732,0.39364,-0.223834,0.00411988,0.219853,0.44785,-0.00650671,-0.247925,0.487554,0.494856,-0.0606783,-0.694895,0.978042,-0.0200293,-0.257767,-0.0604273,-0.380454,0.0509169,0.651796,-0.126777,0.351283,0.302482,-0.166785,-0.0315119,0.163699,0.116456,-0.143863,0.379648,-0.571709,-0.548658,0.122942,-0.430313,-0.0102172,-0.00556433,-0.257026,0.241283,0.0838933,0.196511,-0.0727803,-0.094298,0.210687,0.0222002,-0.122936,0.646965,-0.218452,-0.428713,0.159039,-0.177965,0.342658,0.197628,0.0971281,0.374236,0.271856,0.374778,-0.577958,-0.574,-0.359308,0.609231,-0.0265397,-0.140835,0.278539,-0.13261,0.48707,0.20234,-0.226089,-0.256214,0.3566,0.165742,0.672359,-0.105766,-0.0290309,-0.0075041,-0.132528,-0.308001,0.0858577,-0.350643,-0.86057,-0.614777,0.358461,0.198435,0.561716,0.258056,-0.283228,0.335347,0.201189,0.0533008,-0.0935613,-0.158922,0.356348,-0.178136,-0.0161235,0.133597,0.217783,-0.749895,-0.366465,0.443586,0.577721,0.756989,0.336389,-0.218158,-0.579079,0.117424,0.173674,0.00429139,-0.783371,-0.0628732,0.113608,0.26206,0.337057,0.511918,-0.0819196 +3399.96,0.486073,0.0912059,5,1.41334,0.838196,-0.959856,0.256697,0.019139,-0.141276,0.502348,0.0101009,0.00402367,0.261906,-0.0723441,-0.260547,-0.00136048,0.539747,-0.0725177,0.473922,0.367039,-0.175489,-0.138866,0.109062,0.14716,-0.813416,-0.490442,0.560245,-0.155241,-0.351708,-0.144638,0.0309162,-0.3797,-0.0778121,1.05666,-0.293668,-0.409754,0.3159,-0.200291,-0.144374,-0.457439,0.178448,0.323447,-0.724188,1.28413,0.785495,0.396491,-0.284726,-0.0532345,-0.124873,-0.631634,0.0514518,1.04763,0.116616,0.137821,-0.0450558,0.62922,0.299188,0.817998,-0.304444,-0.52971,-0.546255,0.663706,-0.128724,0.917168,0.991501,-0.691502,-0.471708,0.186335,0.0148468,-0.609845,0.281148,0.197082,-0.359831,0.210055,0.481801,0.308876,-0.453701,0.581386,0.320304,0.255198,0.0543633,-0.160845,-0.393881,0.203651,-0.328799,-0.113373,0.230421,0.247362,0.120545,0.259347,0.100539,0.0452687,-0.570793,0.135435,0.175379,0.1787,0.003497,0.349472,-0.605542,0.306851,-0.43754,0.488675,0.131101,0.371032,-0.371567,-0.321906,-0.141525,-0.0468816,0.0598282,0.0663591,-0.375362,0.517608,1.01474,0.193643,0.218784,0.112572,0.523884,0.339001,0.797015,-0.170346,-0.394701,0.0825839,0.261612,-1.1209,0.473794,-0.456981,-0.734858,-0.367012,0.374155,-0.132086,0.721582,0.661731,-1.13643,-0.374464,0.0858408,-0.841666,0.349207,-0.115818,0.16984,0.120962,-0.169659,-0.108552,-0.699638,0.0846453,-0.0684651,0.103353,-0.387797,0.355402,0.0465095,-0.486411,0.552389,-0.0103113,-0.133614,-0.287814,-0.221963,0.297711,-0.238431,0.0974589,1.09314,0.590139,0.315901,-0.213182,0.0348495,0.249183,0.0794038,0.904671,0.706884,0.285651,0.241211,-0.172126,-0.318862,-0.0648075,-0.104939,0.512071,0.455545,0.174219,-0.538829,0.0164662,0.190921,-0.74658,-0.168152,-0.346045,1.06013,0.576121,-0.00871074,0.278903,-0.366217,0.39327,-0.294022,-0.388634,-0.0829364,0.538493,-0.336122,-0.0510147,0.35374,0.263655,-0.176614,0.344954,0.0905148,-0.0454334,-0.673587,-0.277691,0.142923,-0.692431,-0.0611079,0.601213,-0.192254,-0.332908,-0.076331,-0.892081,0.895692,0.179077,0.172505,-0.193984,0.250219,-0.142248,-0.0225194,-0.0602802,0.496292,-0.0848935,0.235804,0.873313,-0.935638,0.163586,-0.743967,-0.0385167,0.368282,-0.548183,0.319711,-0.558827,0.0889763,0.00647993,0.385512,0.429874,0.330609,0.639106,0.117519,-0.266899,0.653755,-0.126071,-0.136972,0.527963,-0.331297,0.2534,0.271088,0.0445508,-0.490506,0.770622,0.663544,0.700207,0.57556,-0.350825,-0.636455,0.244021,-0.4115,0.359059,-0.0407514,-0.512039,0.120449,-0.430203,-0.042272,0.329666,0.237147,0.240536,1.04383,0.766344,-0.0674067,0.756766,0.375598,-0.0181601,0.35519,0.471395,-0.142199,0.222072,0.150785,0.0853698,0.13057,0.407757,0.179634,-0.248414,0.100572,0.472849,-0.20228,0.0489052,0.357112,-0.398978,-0.531734,0.109853,0.287512,-0.0605534,-0.733349,0.0728849,0.00100827,0.033523,0.0536983,0.102532,0.556465,-0.243043,-0.265922,-0.292328,-0.293952,0.505923,-0.0961455,0.21954,0.148191,0.23041,0.384956,0.48001,0.164111 +3385.32,0.965244,0.0912059,4,1.41264,0.82895,-0.852365,0.213106,0.219497,-0.200334,0.276344,0.0148659,0.40674,0.196386,-0.236528,-0.163373,0.0278082,0.713497,0.0352578,0.798693,0.190763,-0.659639,0.00112633,0.259658,0.228799,-0.531404,0.0500608,0.517574,-0.476464,-0.379162,0.170279,0.0703123,-0.292155,-0.233183,1.0617,-0.329456,-0.264992,0.178522,-0.222511,0.0677579,-0.195014,0.319747,0.217135,-0.533018,1.31694,0.481962,0.378285,-0.357968,0.163492,0.440642,-0.338213,0.140087,0.8324,0.178265,0.316108,0.109119,0.144911,0.226653,0.907129,-0.269286,-0.53999,-0.325211,0.64102,-0.509932,0.774424,1.05263,-0.529658,-0.748714,0.648251,0.079823,-0.384003,0.325198,0.0801205,-0.370314,0.246765,0.359987,0.445412,-0.491645,0.691894,0.202013,0.257325,0.0795554,-0.365281,-0.596997,0.0287292,-0.205093,-0.00220592,0.489992,-0.1033,0.321767,0.116118,0.0808371,0.462868,-0.580563,0.0503158,0.0346067,0.235724,0.048351,0.159727,-0.348615,0.124768,-0.617812,-0.0429662,-0.0425656,-0.0446888,-0.39276,-0.250512,-0.391773,0.0852196,-0.0505273,-0.343506,-0.588088,0.476666,0.936597,-0.026428,0.0129344,0.309751,0.637774,0.49224,0.875168,0.244492,-0.0758199,0.412932,0.243246,-0.845685,0.564407,-0.361838,-0.507984,-0.238004,0.455339,-0.102369,0.565627,0.71691,-1.01077,-0.317116,0.160987,-0.500849,0.900482,0.172227,0.242101,-0.177474,-0.147298,0.0220501,-0.808223,-0.0931841,-0.015795,-0.0917723,-0.183651,0.612151,0.0231869,-0.596778,0.733608,-0.201168,-0.262581,-0.106122,0.30283,0.359071,-0.270293,0.0354372,0.916824,0.444375,0.447279,-0.0286929,0.0951957,0.0127263,0.407839,0.641352,0.0855092,0.437918,0.236809,-0.403543,-0.210086,0.457906,-0.26677,0.703662,0.0200196,0.160091,-0.738561,-0.117903,0.275526,-0.651977,0.118257,-0.211121,1.24062,0.397739,0.247252,0.961254,-0.701408,0.0975373,-0.308612,-0.617008,-0.410703,0.286513,-0.744736,-0.139959,0.466822,-0.00279675,-0.261628,0.123343,-0.076428,0.0179044,-0.681745,-0.289445,0.272185,-0.470316,0.0531002,0.418973,0.0959458,0.119463,-0.252834,-0.504154,0.484121,0.332501,0.154616,-0.134755,-0.0313959,0.227024,-0.154663,-0.0399213,0.542639,0.152852,0.147714,0.813921,-0.922704,0.0155074,-0.654618,-0.182386,0.0289106,-0.619407,0.277479,-0.791799,0.124991,0.278565,-0.144602,0.301992,0.331861,-0.00155832,0.0373379,-0.0878339,0.911633,-0.0494468,-0.224089,0.47582,-0.354276,0.096527,0.258628,0.15458,-0.676357,0.814358,0.254992,0.717508,0.664613,-0.339886,-0.604474,0.418283,-0.000310178,0.519952,-0.22241,-0.769026,0.221843,-0.18272,0.281839,0.257322,0.135629,-0.0926253,1.12671,0.675617,-0.279882,0.507847,0.583784,0.0323926,-0.197714,0.362927,-0.0723285,0.588975,0.204589,0.0280798,0.0688339,0.347368,-0.0401383,0.0748532,0.121016,0.320779,-0.223636,0.0450229,0.31232,-0.270045,-0.665838,0.46433,0.640095,-4.14099e-05,-0.890989,-0.133577,0.0199519,0.0822274,0.13732,0.449752,0.808494,0.0923131,-0.0593227,-0.314562,0.10661,0.44913,0.18409,0.126493,0.199871,0.265503,0.447069,0.515269,-0.485757 +3398.46,0.548198,0.0912059,4,1.46287,0.826977,-1.01531,0.296967,0.0480324,-0.271497,0.379526,0.268875,0.31716,0.0185303,0.313045,-0.0704744,0.126106,0.370409,-0.348508,0.401495,0.15806,0.133351,-0.117878,-0.0589214,-0.137613,-0.731811,-1.22739,0.146357,0.124735,-0.209069,-0.329098,0.0710714,-0.257467,-0.0694584,0.983954,0.0170511,0.117852,0.148646,0.335006,-0.175789,-0.276226,0.586263,0.308099,-0.211789,0.965789,0.8,0.880803,-1.12837,0.390535,-0.21822,-0.372521,0.719307,1.18056,0.0277625,-0.175952,0.237707,0.374086,-0.427786,0.845568,0.0232921,-0.107663,-1.04853,0.715474,0.0669048,0.614399,0.914712,-0.896841,-1.42172,0.123436,0.18628,0.142805,0.174003,0.172427,-0.23175,-0.162189,0.527547,0.797336,0.24823,0.539095,0.77965,0.732364,-0.43421,-0.00397036,0.0821005,0.676005,-0.437544,0.424944,-0.171454,0.111908,-0.477501,0.0966343,-0.351742,0.385879,-0.467771,-0.0583353,0.409809,-0.230121,-0.595332,0.543215,0.125284,-0.108199,-0.252784,0.300868,0.540834,-0.194147,-0.416951,-0.307972,-0.146707,0.563144,-0.139679,0.677228,-0.399253,0.503715,0.889995,0.136244,-0.019019,0.309888,0.432374,0.459323,0.279665,-0.384274,0.0566936,0.389822,-0.733797,-0.66033,-0.036599,-0.0589046,-0.36228,-0.250984,0.607743,0.540676,0.272442,-0.37743,-0.246653,0.388308,-0.202939,0.17026,0.410615,-0.108059,0.234464,0.419563,-0.480573,0.0750699,-0.719671,-0.476819,0.129397,0.114042,-0.240368,0.40401,0.151068,0.219268,0.310857,-0.532242,-0.298003,-0.181596,-0.0647066,-0.325351,0.130298,0.124988,0.380739,0.448785,0.296089,-0.186992,0.312863,-0.191302,0.334424,0.129729,-0.115428,-0.312447,0.0223214,-0.339404,0.0907991,-0.00597015,0.342698,-0.0224585,-0.415812,0.00105127,0.579011,0.317438,-0.301969,-0.384708,-0.480773,0.0887817,0.400623,-0.0996323,-0.200027,-0.247087,-0.0100368,-0.793877,0.158093,-0.883896,-0.488574,0.287958,-0.268951,0.288605,-0.0519885,0.814343,-0.456998,0.312417,0.140623,-0.0190418,-0.397436,-0.764015,0.0568306,0.216962,-0.249725,-0.0927091,-0.0738572,0.0802565,0.00305913,0.0622858,0.803179,-0.440648,-0.193357,0.328801,-0.468014,0.513917,0.362163,-0.056158,0.24084,-0.153432,-0.0461539,-0.00556726,-0.328645,0.524586,-1.00778,0.280594,-0.0118935,0.412314,0.0579985,-0.478,-0.311237,0.38943,0.119088,-0.867639,-0.0150784,-0.115647,-0.362477,0.037813,-0.0863868,0.177619,-0.200993,0.827019,0.103254,-0.292214,-0.731167,0.0577857,0.199306,-0.171284,0.509535,0.358139,-0.0735761,0.00607327,0.223564,0.498339,0.135904,0.602297,0.292218,0.448114,0.66825,-0.415793,-0.116694,-0.155673,0.39762,0.485318,0.218903,-0.000766278,0.572043,0.368304,0.0512838,-0.299341,0.119401,0.245419,0.326412,-1.12853,-0.26257,-0.228001,0.0765993,0.238462,0.0836722,0.118605,0.311167,0.0805632,0.952532,-0.0258562,-0.215935,-0.758373,0.428688,-0.194306,-0.300375,0.380428,0.284609,0.163476,-0.346231,0.497161,0.408624,0.678701,0.553169,-0.0164265,-0.0634978,-0.399599,0.0323189,-0.889629,0.117484,-0.0820765,0.160032,0.266859,0.400041,0.516584,0.161059 +3417.82,0.749794,0.0912059,4,1.38032,0.852938,-1.21187,0.435651,0.00408974,-0.264313,0.353553,0.349946,0.712268,0.00471213,0.163054,0.0104674,-0.147763,0.482889,-0.303382,0.624142,0.152681,-0.161098,-0.278942,0.300706,0.386645,-0.756052,-0.779639,0.0608846,0.00851149,-0.439693,-0.0478827,-0.0490072,-0.459514,-0.3037,1.14718,-0.107249,0.160846,0.280254,0.0748193,0.140976,-0.154953,0.669321,0.353513,-0.537295,1.26904,1.01433,0.622039,-0.745015,0.236423,-0.0934626,-0.473507,0.855562,0.985361,0.15362,0.127682,0.322942,0.373112,-0.432135,0.512394,0.248283,-0.440501,-0.760462,0.72163,-0.277455,0.403502,0.83596,-0.589295,-1.47815,-0.0141687,0.176905,-0.311696,0.169358,0.458771,-0.14467,0.378281,0.538301,0.660415,0.0120757,0.447764,0.597597,0.39677,-0.0155713,-0.172669,-0.149756,0.546548,-0.0685679,0.41408,0.272711,-0.181748,0.089382,-0.184859,-0.210426,0.404381,-0.617065,0.238344,0.687895,-0.296953,-0.325164,0.242268,-0.146438,-0.199303,-0.462222,0.232864,0.319052,0.051458,-0.287594,-0.0706324,-0.377432,0.50374,-0.283559,0.843828,-0.649207,-0.104828,0.936061,0.0246288,0.241814,-0.427226,0.352769,0.671613,0.264038,-0.323543,0.0169333,0.549812,-0.505125,-0.947816,0.172806,0.0808465,-0.406347,-0.466026,0.396785,0.38895,0.183674,-0.0902167,-0.137622,0.225694,0.0269823,0.029499,0.874051,-0.263805,0.220412,0.370938,-0.279142,-0.0390529,-0.252543,-0.486112,0.404664,0.219578,-0.29844,0.373547,0.140192,0.402603,0.158911,-0.467029,-0.0994108,-0.299274,0.0354393,-0.225614,0.364596,0.087906,0.0980521,0.377186,0.603943,0.18819,0.0203574,-0.346719,0.188666,0.217981,-0.152964,0.0816135,-0.433154,-0.368689,-0.0647515,0.243744,0.0105466,-0.113147,0.0501456,0.0331018,0.0768176,0.132499,-0.171885,-0.513308,-0.276245,-0.042644,0.792957,-0.0294867,-0.358956,-0.0963645,-0.49027,-0.429057,0.102487,-0.786076,-0.364929,0.197492,-0.564152,0.2936,-0.233995,0.307399,-0.240838,0.40051,-0.0510586,0.081686,-0.257662,-0.30031,-0.056043,0.207936,0.28696,0.0597824,0.437319,-0.162898,0.00322484,-0.369852,0.811193,-0.107824,-0.121587,0.140702,-0.724797,0.348087,0.222406,-0.245648,0.2828,0.140756,-0.204323,-0.189244,-0.46225,0.312647,-0.426418,0.253607,0.186256,-0.0743258,-0.0648811,-0.461973,-0.194548,0.200637,0.123233,-0.807475,0.0474458,-0.109038,-0.370083,-0.232564,0.0676683,0.193617,-0.418528,0.942466,-0.200476,0.018945,-0.447103,-0.619314,0.366706,-0.149277,0.688416,0.484446,0.0535743,-0.295762,-0.0743933,0.395009,-0.040561,0.598839,0.179379,0.342734,0.637385,-0.409862,-0.522887,-0.0889881,0.303124,0.158972,0.529286,0.704229,0.556049,0.0642043,0.14194,-0.0417795,0.125718,-0.225543,0.295268,-0.684895,-0.288213,-0.145538,0.702498,0.245711,0.434222,0.163182,0.604656,-0.231678,0.592012,0.233099,-0.46402,-0.827739,0.0489803,-0.359238,0.258069,0.386029,-0.0944917,0.596373,-0.178945,0.252551,0.435594,0.251295,0.331244,0.0690319,-0.24134,-0.779544,0.340641,-0.837017,0.23852,-0.423081,0.135581,0.348719,0.368213,0.590524,0.148452 +3428.33,0.92608,0.0912059,4,1.51967,0.835995,-1.40896,0.565665,0.248231,-0.085298,0.156417,0.048429,-0.241167,0.185279,-0.0489922,-0.371794,-0.367043,0.675384,-0.120351,0.557567,0.528699,0.0649359,-0.199414,-0.00771638,0.132135,-0.91262,-1.01633,0.404057,0.0957413,-0.190398,-0.272537,0.423738,-0.433213,0.371995,1.01824,-0.117194,-0.0555624,0.0305485,-0.353222,-0.566198,0.113293,0.377241,0.336699,-0.334023,0.894932,0.848137,0.688923,-1.21593,-0.134765,0.329606,-0.02511,0.422984,0.40666,0.293802,0.0397064,0.984001,-0.399858,0.512555,0.411896,-0.341455,0.227436,-0.62804,0.261131,0.198029,0.550835,0.897665,-0.624012,-0.283307,0.460584,0.126208,-0.180125,0.0662641,-0.259691,-0.185206,0.0865565,0.22736,0.354385,0.0740269,1.00089,0.189703,0.248746,0.170278,-0.19825,-0.00039583,0.462311,-0.120258,0.13679,-0.840503,0.219428,0.180985,-0.202224,0.280957,0.100826,-0.28923,-0.416092,-0.553983,0.567517,-0.207787,0.151818,-0.506028,0.871954,-0.0359026,0.0648921,0.290296,0.0385258,0.159413,-0.650495,0.0605515,0.220791,-0.0638725,-0.431165,-0.154594,0.046603,0.671569,0.199771,0.136143,-0.104713,0.341918,-0.303901,0.0649943,0.137773,0.0343244,-0.221214,0.23007,0.0599806,0.299403,-0.137946,0.293427,-0.00971917,0.00123861,0.139437,0.195745,0.661542,-0.579107,0.340756,-0.0867419,0.59017,0.608959,-0.315181,-0.198272,-0.0813428,0.0885671,0.430846,-0.171202,0.0607382,-0.178685,-0.342536,0.0801889,0.242234,0.0130757,0.0824125,0.217547,-0.159845,0.146348,-0.304352,0.275408,0.0316203,0.0891244,0.24335,0.910232,0.431131,-0.251764,0.141205,-0.297431,0.425754,0.800452,0.874124,0.203581,-0.230546,0.433189,0.0691737,-0.472685,-0.365059,-0.0340382,0.706459,-0.727651,-0.130097,0.110561,-0.310696,0.404269,-0.0917019,-0.558325,0.695398,0.923929,0.015516,-0.0652183,0.0471531,0.132652,0.33491,-0.359446,0.633146,-0.358108,0.253994,0.530431,-0.231145,0.424861,-0.0976247,-0.332623,-0.389734,0.396825,-0.05662,-0.761626,-0.238018,0.20668,-0.0105679,-0.74764,0.0228431,-0.382219,-0.484069,0.225285,0.0318055,0.717802,-0.516057,0.130767,0.195772,-0.176372,0.176161,-0.682498,-0.405283,0.238468,-0.20154,0.340937,0.108383,0.0317646,0.240263,-0.837228,-0.380049,-0.169508,-0.548273,0.419846,-0.704453,0.338885,-0.0160139,0.365407,-0.0777503,-0.0512869,0.102076,0.0516841,-0.227102,0.60501,-0.0823629,-0.18315,0.439105,-0.351678,-0.115081,0.500934,0.342106,-0.509389,0.636702,0.0307478,0.482486,-0.0354969,-0.0435843,-0.371929,0.0599353,-0.696405,0.182594,-0.0397106,-0.165427,0.0296428,-0.324333,0.593664,0.30522,0.0842556,-0.0845233,0.485466,-0.186951,0.227757,0.799158,0.108083,-0.0391977,-0.644251,0.205941,0.094543,0.0170513,0.471593,-0.672752,-0.163223,0.0410139,0.159309,0.222927,-0.224828,0.0621619,-0.00350626,-0.511863,0.165274,0.016643,0.0123061,0.159287,0.017763,0.141922,-0.103107,-0.286,0.00209349,-0.216699,-0.356165,-0.13235,0.620917,-0.290769,-0.148434,0.479741,-0.192196,0.0662878,-0.175434,0.321453,0.125106,0.221187,0.353703,0.470305,-0.557237 +3414.14,0.962451,0.0912059,5,1.47898,0.837005,-1.13781,0.447359,-0.0553817,-0.0745253,0.604482,-0.229255,0.0992927,0.0998999,-0.419442,-0.20617,0.0582385,0.666126,-0.179668,0.940762,0.397245,-0.0862662,0.155175,0.360499,-0.138027,-0.696704,-0.994229,0.473507,0.363663,-1.02288,0.347511,0.435755,-0.791817,0.25095,0.952144,-0.0561239,0.325031,-0.163619,-0.545466,-0.196692,0.0868522,-0.144868,0.40052,-0.875297,0.918874,0.694955,-0.250809,-0.735486,-0.103048,0.583579,-0.26619,-0.0845556,0.285944,-0.0552123,-0.289814,0.384188,0.0914328,-0.484443,0.618521,0.327855,-0.12416,-0.975684,0.338877,-0.0532053,0.344434,0.842944,-0.839659,-0.225437,-0.061363,0.242099,0.396223,0.619923,-0.223045,-0.0131301,0.304026,0.712685,0.564108,-0.503615,0.510423,0.363283,0.0384217,0.0649499,-0.611376,-0.0608877,0.918892,-0.172946,0.0570503,-0.545588,0.374025,0.0111628,0.270746,0.370064,-0.557716,-0.558984,-0.126023,-0.180766,0.586353,0.051757,0.401305,-0.261606,0.305115,0.136468,-0.0630784,0.535073,0.395582,0.0500743,-0.689156,-0.590838,0.140073,-0.382692,-0.158187,-0.0574791,-0.219008,0.645707,-0.083346,-0.248541,-0.0609316,0.116532,0.0582367,-0.124722,0.255834,0.203898,0.231469,0.0518012,-0.126414,0.266408,-0.567301,-0.196982,-0.281866,0.228364,0.605342,0.0626434,0.548093,-0.649201,0.366236,0.311527,-0.482291,0.375543,-0.157194,0.39552,0.308081,0.155074,0.342119,-0.0850328,-0.155293,-0.111862,-0.157553,-0.266207,-0.201661,-0.405299,0.0998741,-0.367167,0.0284374,-0.456528,-0.661537,0.668717,0.302382,0.150579,-0.0952775,0.760527,0.155022,0.192399,0.177056,0.466329,0.393487,0.358006,0.423547,0.231751,-0.120034,0.44882,0.255847,0.154486,0.182638,-0.170391,0.752265,-0.0979454,-0.18273,-0.352736,0.125306,-0.481527,-0.49076,-0.446042,-0.00172738,0.612999,0.151864,-0.395757,0.0799196,-0.616693,0.161241,-0.391032,-0.495555,0.135019,0.3106,-0.295245,0.270339,0.3945,0.320819,-1.11904,-0.0682873,0.306756,0.0223323,-0.309336,-0.375845,0.537325,-0.492973,0.041959,0.621641,0.34234,-0.174008,0.630803,-0.569256,0.864963,0.211845,-0.202076,0.345858,0.387009,0.183627,0.591496,-0.553648,-0.0101696,-0.0856256,0.476494,0.157389,-0.165278,0.119421,-0.594913,-0.195444,-0.594977,-0.655745,0.587002,-0.237925,0.236875,-0.302918,0.256578,0.309798,-0.171735,-0.0769565,-0.230097,0.0384497,0.611446,0.294944,0.538078,0.642183,0.112976,-0.437725,0.648989,-0.258933,-0.0903288,0.379883,-0.0108072,0.653856,-0.15701,-0.116398,-0.61974,0.258962,-0.352127,0.359946,-0.355356,-0.591967,0.270424,-0.241847,-0.212441,0.541081,-0.102497,-0.057641,0.798291,0.112888,-0.0605272,0.815666,0.0928307,0.163309,-0.434715,-0.108986,0.0590953,0.0134907,0.405937,-0.506847,0.745116,-0.367714,0.0907838,0.0375292,0.353679,0.250519,0.262867,0.122535,0.293484,0.130779,0.36833,0.285665,0.147653,0.451097,0.0544953,0.413489,0.0488392,-0.0820173,0.540794,-0.156038,0.68284,-0.00686926,-0.465556,-0.0920039,-0.0707203,-0.124538,-0.29266,0.323487,0.14002,0.260153,0.374193,0.510051,0.375251 +3432.57,0.832215,0.0912059,4,1.51385,0.82873,-0.913467,0.266734,-0.359058,-0.0593858,0.295379,-0.374395,-0.283893,-0.0222796,-0.486127,-0.310621,-0.0889739,0.590221,0.164848,0.907264,0.703813,0.0419927,-0.270246,0.207058,0.0845081,-1.14548,-1.20616,0.681851,0.0553203,-0.677906,-0.0456006,0.0348642,-0.343211,-0.0307926,0.808935,-0.0436434,-0.095898,-0.0287614,-0.525141,-0.0950234,-0.439308,0.345328,0.347871,-0.194087,0.859362,0.616948,-0.041488,-0.555636,-0.435738,0.311913,0.235919,0.0967522,0.479541,-0.025547,0.172043,0.289395,0.227011,-0.86343,0.839841,0.311942,0.0746689,-0.45319,0.215572,0.307044,0.520674,0.756714,-0.916315,-0.514619,0.0199459,0.261786,0.512293,0.460357,-0.210044,0.424907,0.375999,0.174936,0.815028,-0.261853,0.133675,0.284595,0.207459,0.0941879,-0.161768,-0.0707464,0.458129,-0.518682,0.238282,-0.0675324,0.0907206,-0.104505,0.45845,0.492861,0.120207,-0.657969,-0.0117275,0.00632918,-0.175143,-0.0999154,0.575822,-0.2707,0.942975,-0.0619829,-0.0295702,0.619387,0.208777,0.617453,-0.0760722,-0.695529,0.502544,-0.173263,-0.177949,-0.0891166,0.009194,0.643212,0.206238,-0.12528,-0.144579,0.403633,0.192733,0.385084,0.0912241,-0.075486,0.486183,-0.0638351,-0.114326,-0.0705709,0.286415,-0.200321,0.120791,0.281776,0.552268,-0.161533,0.698765,-0.232911,0.358374,-0.304974,-0.175961,0.279719,-0.668282,0.0216382,-0.238144,-0.389703,0.0988048,-0.43723,0.520389,-0.352038,-0.226358,-0.369125,-0.244286,0.0589292,0.189399,0.365026,-0.0341398,-0.253966,-0.542646,0.476982,0.290278,0.395805,-0.0570271,0.439944,0.0721474,0.22032,0.395879,0.096972,0.64156,0.0226348,0.787694,-0.351626,0.227254,0.418804,0.446873,0.022902,0.00621555,0.396871,0.202675,-0.269808,-0.00777975,-0.43634,-0.469272,-0.0393537,-0.123551,-0.573039,0.0988691,1.00294,-0.106945,-0.0600516,0.450395,-0.0458347,0.0154295,-0.0279871,-0.41104,-0.0571288,0.13519,-0.652726,0.163499,0.0813627,0.00802281,-0.750378,0.285951,0.264643,0.110529,-0.279447,-0.669777,0.425533,-0.228337,-0.207113,0.564043,-0.309829,-0.0407647,0.0302255,-0.204267,1.02458,-0.452917,0.285335,0.382882,0.158253,0.326564,-0.467294,-0.670105,-0.338024,-0.0790841,0.386326,0.0286291,-0.233099,0.0590132,-0.671253,-0.133373,0.197789,-0.449743,0.439969,-0.136106,0.166377,-0.352458,-0.30062,0.175105,0.0666409,-0.107707,-0.19763,-0.749856,0.852887,0.1582,-0.220544,0.401926,0.0222594,-0.227117,-0.209121,0.287444,0.221255,-0.0670037,0.0359343,0.869954,0.0330713,-0.137727,-0.465367,0.0744583,-0.625583,0.0402035,-0.0453915,-0.893934,0.291959,-0.221709,0.29066,0.0916344,-0.180791,0.279777,0.555867,-0.155936,0.441777,0.0524562,-0.193425,-0.038834,0.341877,0.0143637,0.330659,-0.450804,0.536997,-0.14015,0.568085,-0.0127265,-0.214937,0.241027,0.290508,0.34075,-0.0514302,0.118078,0.205388,-0.835758,0.0982637,0.471071,0.0411499,0.222115,0.203896,0.0923979,0.116418,-0.140413,-0.269474,-0.705258,0.0617666,-0.241538,0.0529874,0.0854242,-0.407527,-0.109494,-0.0865898,-0.161432,0.128677,0.24156,0.358716,0.491488,1.48253 +3435.03,0.529718,0.0912059,4,1.70312,0.776622,-1.26492,0.505435,0.0976017,-0.223189,-0.158125,-0.0564271,-0.0208938,0.326829,0.218359,-0.0112268,0.197246,0.412046,-0.385488,0.671479,0.389688,-0.371495,-0.124329,-0.0264502,-0.0971306,-0.882934,-0.468688,0.305027,-0.445753,-0.253697,0.249131,-0.222182,-0.486626,-0.427577,0.749463,-0.42266,-0.287653,0.583655,-0.497666,0.171904,-0.583481,0.193148,-0.196992,-0.534341,0.843576,0.341139,0.503646,-0.66857,-0.474187,-0.379807,-1.18997,0.498812,0.317709,-0.431924,0.208904,0.0598061,0.136615,-0.162232,0.699625,-0.298659,-0.229103,-0.707722,0.150499,-0.454146,-0.0492618,0.781533,-0.43075,-0.939788,0.0875613,-0.147067,-0.547872,-0.176546,0.18915,-0.891483,-0.50484,-0.124075,0.338738,0.304382,0.751527,-0.0161675,0.52881,-0.337773,-0.431379,-0.132695,0.407538,0.244431,-0.119784,0.313338,-0.353147,-0.104014,-0.366175,-0.780797,0.189446,0.0422794,-0.133145,0.031381,-0.0562689,-0.0864397,-0.540522,-0.020528,-0.72851,-0.533943,0.167153,0.157918,0.126512,-0.669921,-0.209761,0.373329,-0.473044,-0.698745,0.386599,-0.0800034,0.572151,0.425141,-0.57654,-0.272097,0.469698,0.119743,-0.277635,-0.317081,-0.467976,0.242275,-0.0381264,-0.216493,-0.94429,0.0094553,-0.587029,0.340976,-0.318881,0.117622,0.0413212,-0.0666506,0.0504424,-0.298704,-0.505575,0.357396,0.209877,0.539156,-0.0787228,-0.0340473,0.163316,0.131415,0.396176,-0.149976,-0.718344,-0.0349389,0.249117,-0.392171,0.0102211,0.0044386,-0.250076,0.452831,-0.282225,-0.0946374,-0.0241581,-0.420661,-0.160191,-0.218036,0.263554,0.515294,0.293764,-0.435881,-0.00246474,-0.0587842,-0.313444,0.0766636,0.480717,0.533671,-0.374964,-0.193373,-0.227099,-0.345506,-0.0758277,-0.335381,-0.19679,0.391461,-0.518815,0.277084,-0.0128348,-0.122394,-0.283428,0.531747,-0.124856,0.326687,0.0643525,-0.31418,0.171517,-0.199967,-0.0510602,-0.308868,-0.109765,-0.222798,0.00884785,-0.233159,0.0466652,-0.0393402,-0.113061,-0.667275,-0.0779399,0.0493136,-0.122092,-0.404043,-0.295721,-0.0568543,-0.150301,-0.007738,-0.580526,0.0427433,-0.117876,0.0747501,-0.605093,0.838546,0.263484,-0.0464458,-0.52452,-0.496333,-0.0304238,0.674706,0.548939,0.970478,-0.150647,0.107509,0.642503,-0.555605,0.182722,-0.092921,-0.0507296,-0.216659,-0.00660508,0.566052,-0.135214,-0.402456,0.395672,0.0868505,-0.356286,-0.163545,-0.217253,-0.15911,0.19266,-0.0285196,-0.14684,0.178506,0.585104,-0.667404,0.105361,0.137568,-0.273909,-0.205676,0.742297,-0.0236961,0.388281,0.105538,-0.184357,0.139209,-0.11328,-0.52655,0.215406,0.0266596,0.391113,0.166016,-0.341329,-0.211541,-0.0730889,0.0734054,-0.135456,-0.20472,0.0657334,-0.11947,0.25421,0.601232,0.115194,-0.63131,-0.137725,-0.379658,0.150879,-0.747493,-0.112454,-0.0369285,0.363856,0.28398,0.207674,-0.0277009,0.139966,0.2924,-0.209295,-0.276697,0.379744,-0.105455,-0.0611036,-0.0447033,-0.281482,0.354207,-0.132584,-0.336821,-0.332662,0.255704,0.375877,0.267799,0.197295,-0.568972,-0.35863,0.386157,0.000604574,-0.207628,0.228078,0.121008,0.198205,0.347863,0.445203,0.247149 +3440.71,0.934454,0.0912059,4,1.69039,0.836102,-0.702528,0.270646,0.419979,-0.129291,-0.0361851,0.0527948,0.168266,0.255465,0.192805,-0.11027,0.0658001,0.134314,-0.388828,0.391856,0.166787,-0.212895,0.0169482,0.0959451,-0.246285,-1.06723,-0.718293,0.376161,0.015109,-0.520431,-0.134775,0.225678,-0.410571,-0.418085,0.615186,-0.0453472,-0.412622,0.60576,-0.114246,-0.150366,-0.180109,-0.183557,0.33767,-0.336041,0.797133,0.264747,0.4901,-0.954646,-0.572518,-0.727028,-0.718674,-0.0104474,0.152124,-0.279933,0.378627,0.0952519,0.010569,-0.45216,0.73316,-0.287769,-0.389341,-0.727916,0.473089,-0.346196,0.18466,0.553913,-0.817573,-0.760835,-0.219858,0.121627,0.178697,0.0725476,0.014477,-0.65595,0.0339212,0.0809442,0.598572,0.642937,0.506235,0.244784,0.636853,-0.211365,-0.458228,-0.231766,0.63863,-0.355839,0.0437177,-0.195611,-0.0173418,-0.581434,0.196197,-0.14828,0.372754,-0.0731739,-0.343073,-0.017132,-0.389148,0.0191247,-0.0586006,-0.0925412,0.255966,-0.300084,0.18544,0.151754,0.0526516,-0.512565,-0.174116,0.207086,-0.0791689,-0.124374,0.18578,0.115395,0.346887,0.168944,0.0791596,-0.025815,0.439187,0.107733,-0.121577,-0.46563,-0.256939,-0.0478543,-0.0549823,0.07916,-0.57482,-0.100988,-0.660453,-0.0169511,-0.630996,0.47372,0.605659,-0.281054,-0.197573,-0.917908,-0.438001,0.273095,0.435374,0.364158,0.0641396,-0.256325,-0.0132622,-0.17775,0.440143,0.0121492,-0.553371,-0.150596,-0.39089,-0.414555,0.273588,0.528312,0.0704927,0.575194,0.245002,-0.739239,-0.0889111,-0.404223,-0.0964349,-0.585116,0.486001,0.587195,0.350103,-0.258689,-0.0197059,0.263033,0.122818,-0.349128,0.932171,0.332306,-0.135083,-0.424448,0.174848,0.352158,-0.117497,-0.592153,-0.126711,0.0913606,-0.184567,-0.281821,0.43208,-0.0570379,-0.386371,-0.0633793,-0.361092,0.811587,-0.132797,0.324698,-0.105766,0.182235,0.243856,-0.218389,-0.622536,-0.662241,0.375225,-0.457694,-0.11303,-0.0266026,0.123154,-0.310406,0.174975,0.000918314,0.0682083,-0.384558,-0.160629,0.133561,-0.17115,-0.101327,-0.0533955,0.20415,0.187443,-0.123905,-0.320808,0.989211,-0.847339,0.301461,-0.495045,-0.00172443,0.215521,0.00968632,-0.0663562,0.697029,0.0714672,-0.00665457,0.480849,-0.299903,-0.0203849,0.0989615,-0.221896,0.381109,-0.0667905,0.456133,-0.149203,-0.355244,0.352054,0.0835727,-0.473159,-0.307641,-0.0484287,-0.242263,0.236917,0.30136,0.423104,-0.0758036,0.666658,-0.20718,0.0777759,0.130507,0.0216468,-0.0638422,0.451855,0.0997819,0.21762,-0.12611,-0.250431,0.0951151,-0.00518484,-0.339566,0.113766,-0.343843,-0.317389,0.623167,-0.273332,-0.0935284,-0.0929277,0.320028,-0.27152,0.144206,-0.0504453,0.813218,0.361634,0.226447,-0.129852,0.617954,0.2816,0.130516,-0.291174,-0.866725,-0.0394905,-0.200094,-0.0335587,0.413531,0.0781284,0.526695,0.217915,0.151418,-0.289214,-0.463697,-0.0270339,-0.530859,-0.317318,0.23815,-0.276135,0.436291,0.0609635,-0.576774,0.12668,0.121662,0.246312,0.0387633,0.0448617,-0.395947,-0.207414,0.316315,0.144145,-0.488423,-0.258437,0.113441,0.265499,0.33681,0.515266,-1.03727 +3437.1,0.945803,0.0912059,4,1.69362,0.84274,-0.685866,0.26296,0.470377,-0.115993,-0.0399148,0.069416,0.234648,0.261562,0.161149,-0.118021,0.0981098,0.120527,-0.363888,0.35901,0.134439,-0.174051,-0.0281292,0.0844708,-0.229175,-1.08447,-0.698391,0.315019,-0.0214577,-0.496173,-0.136806,0.200598,-0.404213,-0.39166,0.553718,-0.0127083,-0.425962,0.611382,-0.125878,-0.146376,-0.159869,-0.120151,0.333339,-0.339463,0.805513,0.294432,0.517,-0.923001,-0.598401,-0.721895,-0.713555,-0.0568634,0.170338,-0.267819,0.375682,0.107598,0.0329865,-0.388379,0.721948,-0.312452,-0.375747,-0.765499,0.484628,-0.332355,0.147171,0.572895,-0.812194,-0.791104,-0.225049,0.131076,0.225,0.0685795,-0.00140439,-0.617338,0.00124031,0.114697,0.593546,0.660679,0.464905,0.269914,0.627336,-0.236652,-0.459373,-0.232005,0.652909,-0.394113,0.040518,-0.212352,-0.0112681,-0.581748,0.20035,-0.121996,0.385348,-0.0646611,-0.35161,0.0197473,-0.423998,0.00180509,-0.0367542,-0.0926713,0.274554,-0.328425,0.176762,0.149155,0.102675,-0.481891,-0.172762,0.21581,-0.109659,-0.0861168,0.160316,0.105457,0.338443,0.177926,0.104203,-0.0243796,0.42714,0.111694,-0.138304,-0.460046,-0.24865,-0.0194345,-0.0839138,0.0628216,-0.585694,-0.102687,-0.680876,0.0077285,-0.62756,0.493227,0.602424,-0.271539,-0.210291,-0.912555,-0.455946,0.26952,0.446312,0.371415,0.0552143,-0.237907,0.00885753,-0.171994,0.460945,-0.0423192,-0.549758,-0.14737,-0.404646,-0.446386,0.277082,0.565173,0.0841355,0.587216,0.246377,-0.731791,-0.0980002,-0.422444,-0.0811383,-0.596093,0.458327,0.602831,0.388047,-0.289163,-0.0482165,0.276728,0.131543,-0.37474,0.915783,0.300547,-0.149375,-0.351982,0.191795,0.365118,-0.0719154,-0.577633,-0.151218,0.093133,-0.191753,-0.275427,0.438115,-0.0524966,-0.365252,-0.111941,-0.350731,0.812007,-0.0908353,0.308681,-0.116225,0.158347,0.229561,-0.218998,-0.625708,-0.690426,0.382305,-0.477243,-0.121348,-0.00586652,0.108416,-0.288846,0.175289,-0.0403021,0.0830493,-0.389123,-0.180009,0.124889,-0.183433,-0.0554171,-0.070978,0.200294,0.183806,-0.167467,-0.314401,0.995311,-0.857156,0.291174,-0.468199,-0.017655,0.228404,0.0086931,-0.134126,0.688981,0.0707347,0.00974966,0.516256,-0.290816,-0.0442444,0.107513,-0.187641,0.320786,-0.129801,0.457059,-0.156241,-0.306078,0.341708,0.131839,-0.48864,-0.346698,-0.0708022,-0.239639,0.250538,0.320467,0.396719,-0.047808,0.656068,-0.184336,0.0722842,0.135223,0.0478314,-0.0624532,0.46635,0.129244,0.215798,-0.15064,-0.300539,0.122924,0.0015436,-0.404603,0.147232,-0.328373,-0.323475,0.61667,-0.273468,-0.0677812,-0.121126,0.303643,-0.233144,0.126149,-0.0612889,0.827828,0.388725,0.227131,-0.14541,0.647414,0.296767,0.0902621,-0.298364,-0.935132,-0.0198498,-0.19332,-0.0526892,0.417301,0.086747,0.522536,0.207955,0.143573,-0.258309,-0.466238,-0.069854,-0.503061,-0.319511,0.220823,-0.314077,0.428942,0.075759,-0.600769,0.142105,0.13041,0.20824,0.0753002,0.0342632,-0.383289,-0.232754,0.312249,0.210139,-0.486383,-0.253039,0.110749,0.25934,0.332789,0.509254,-1.21788 +3434.48,0.602417,0.0912059,4,1.66313,0.899701,-0.900608,0.360355,0.160547,-0.0789923,0.177684,0.0702077,0.312482,0.353821,0.164479,0.0801084,0.0315904,0.468051,-0.382533,0.371975,0.100166,0.0675152,0.082881,0.0519338,-0.161527,-0.875441,-0.914703,0.244106,-0.0841386,-0.401616,-0.0202285,-0.136513,-0.0575877,-0.538497,0.451351,-0.180299,-0.405051,0.510909,-0.112005,0.0155457,-0.0929625,-0.186163,0.289435,-0.373388,0.878586,0.349909,0.544435,-0.848717,-0.491693,-0.469467,-0.687625,-0.0713207,0.0337599,-0.324358,-0.0236261,0.0830635,0.057943,-0.482793,0.597696,0.0106254,-0.482811,-0.567389,0.181756,-0.450761,-0.138145,0.54913,-0.911804,-0.560572,-0.271245,0.343716,0.109246,0.0533518,0.44295,-0.624325,0.0909174,-0.113391,0.5739,0.44586,0.469942,0.507633,0.574303,-0.098934,-0.803708,-0.398635,0.846905,-0.221952,-0.0266131,-0.294052,0.0273887,-0.567264,-0.029089,-0.190507,0.560951,0.153557,-0.376281,-0.332297,-0.43813,-0.0663509,-0.368872,0.175186,0.314047,-0.359446,0.238708,0.0292433,-0.00353671,-0.575918,-0.400956,0.0820347,-0.0449892,-0.0301987,-0.0520969,0.159899,0.292115,0.159908,0.407145,-0.159203,0.643822,0.102428,-0.195378,-0.438428,-0.239539,-0.107587,0.0458323,0.0346347,-0.613837,0.16325,-0.780074,0.143361,-0.612828,0.409952,0.296187,-0.169332,-0.141364,-0.640597,-0.300461,0.430644,0.177686,0.426997,0.0508398,-0.164304,-0.207321,-0.159451,0.362584,-0.390156,-0.457645,-0.0941392,-0.615229,0.00592663,0.256506,0.564406,-0.0347615,0.490779,0.213763,-0.529531,-0.364345,-0.037498,0.00185317,-0.468328,0.28152,0.562425,0.435909,-0.0794464,0.0167725,0.123697,0.155647,-0.520506,0.919884,0.170958,0.096897,-0.104335,0.145787,0.452673,-0.0691554,-0.415771,-0.152834,0.168339,-0.216619,0.0868361,0.154514,-0.148978,-0.397656,-0.294478,-0.509953,0.779821,0.0732247,-0.00810842,-0.122481,0.18749,0.121652,-0.159741,-0.468418,-0.65735,0.136027,-0.430174,-0.300236,-0.0742544,0.136847,-0.217193,0.124192,0.0126551,-0.121844,-0.365266,-0.169875,0.10667,-0.265671,-0.0623432,0.0859866,0.310768,0.235951,-0.186082,-0.166944,1.07438,-0.743823,0.302149,-0.33937,-0.165666,0.399601,-0.214315,-0.168263,0.670209,-0.0325715,-0.047314,0.189341,-0.296202,0.0626435,0.0853843,-0.345901,0.554568,0.0806767,0.677807,0.0166661,-0.328897,0.42484,-0.0613286,-0.255734,-0.0907951,0.10172,-0.175087,0.246865,0.304781,0.531806,-0.285872,0.620027,-0.113069,0.197868,0.316219,0.103624,-0.202369,0.171212,0.142227,0.339368,-0.103221,-0.287563,-0.0128643,0.13701,-0.412974,0.182092,-0.461535,-0.309413,0.540983,-0.484044,0.00425823,-0.150658,0.150136,-0.238022,0.275634,0.146232,0.849289,0.496985,0.59799,0.0019744,0.657031,0.338417,0.0736907,-0.314418,-0.810956,0.0447683,0.0586362,0.192843,0.114009,0.139724,0.168368,0.126671,-0.0025883,-0.344334,-0.0814023,0.0383721,-0.584805,0.104958,0.384733,-0.290396,0.578481,0.0680542,-0.567753,-0.117406,-0.18568,0.489363,0.273237,-0.0995236,-0.407167,-0.212891,0.385932,0.295497,-0.308824,0.0102753,0.110987,0.318042,0.333148,0.563953,-0.309289 +3442.65,0.778282,0.0912059,4,1.67893,0.819108,-0.880459,0.404179,0.21994,-0.0914761,0.213163,-0.41676,0.232804,0.44558,0.172109,0.0476107,0.215111,0.522639,-0.31333,0.538011,0.072199,-0.0239878,-0.202007,0.160703,-0.183263,-0.959009,-0.777608,0.523898,-0.225395,-0.216662,0.0852231,-0.321767,0.190539,-0.747355,0.599276,-0.665658,-0.824842,0.588138,-0.413354,-0.157966,-0.081835,0.061179,0.412769,-0.230374,0.919893,0.366823,0.614161,-1.12515,-0.358617,-0.393298,-1.13828,0.359256,-0.0805359,-0.379925,0.0517551,-0.236412,0.147721,-0.766298,0.611993,-0.157276,-0.307924,-0.73793,0.280824,-0.509993,0.109408,0.62937,-0.634538,-0.967213,-0.148518,0.204665,0.144899,-0.17768,0.0360204,-0.416305,-0.285772,-0.0113701,0.572248,0.157366,0.686605,0.72962,0.54939,-0.212858,-0.590168,-0.44726,0.583993,-0.450367,0.121387,-0.522252,0.646358,-0.812244,0.340507,-0.451141,0.251906,0.0106637,-0.571706,-0.265504,-0.519268,-0.00314906,-0.4846,-0.00981291,0.326316,-0.568503,0.0314835,-0.0633915,-0.0662014,-0.769171,-0.147449,0.0702892,0.0361224,0.364496,-0.0978976,-0.114379,0.264574,0.225528,0.466393,-0.226622,0.73676,0.122596,-0.241624,-0.376535,-0.0266417,-0.190704,-0.0290768,0.233972,-0.59025,-0.0947036,-0.262017,-0.192148,-0.477569,0.221009,0.382788,-0.408999,-0.0312649,-0.664427,-0.294897,0.158019,0.31984,0.607908,0.137064,-0.144594,-0.12797,-0.149838,0.497228,-0.386007,-0.473651,0.1302,-0.282825,-0.367701,0.0160307,0.501699,-0.234012,0.401088,0.176336,-0.479715,-0.408929,-0.0641234,-0.118197,-0.0751603,0.12113,0.258689,0.199621,-0.0594538,0.135294,-0.0157987,-0.0982081,-0.421881,0.681468,0.00666968,0.315219,-0.0675044,0.152793,0.364788,-0.0666024,-0.34017,0.238316,-0.0343316,-0.238412,-0.245502,0.0663167,0.111091,-0.303536,-0.200675,-0.581513,0.626628,0.393194,-0.0862472,0.163142,0.0665761,0.0357586,-0.168892,-0.380133,-0.355762,-0.0730976,-0.360503,-0.183249,0.190444,0.362694,-0.353058,0.017641,-0.0285318,-0.0496381,-0.371673,0.079685,-0.167441,-0.242689,-0.241184,0.077225,0.0706476,0.39278,-0.367636,0.0135267,1.29321,-0.409323,-0.153126,-0.186674,-0.388907,0.0593436,-0.153865,-0.0357372,0.397933,-0.233011,-0.171859,0.136612,-0.497696,0.0331031,-0.232528,0.162965,0.339685,-0.073073,0.4914,0.104734,-0.372073,0.46523,-0.271519,-0.442394,-0.116912,0.353569,-0.115273,-0.258397,0.454057,0.59489,0.18193,0.607802,-0.289162,-0.420845,0.331075,0.123958,-0.282167,0.114035,-0.0800757,0.301153,-0.246395,-0.145301,-0.12661,-0.139175,-0.421912,0.177898,-0.215824,-0.186994,0.523336,-0.547646,0.0685985,-0.267419,-0.0254803,0.242257,0.198172,0.116563,0.765735,0.686152,0.628113,-0.0330842,0.52058,0.201447,-0.0651848,-0.498082,-0.835677,-0.0939143,0.122582,0.161782,-0.078374,-0.0300171,0.241838,0.164107,-0.151246,-0.685361,-0.162225,-0.197959,0.0670167,-0.000986103,0.5921,-0.0772902,0.240451,0.0693992,-0.0894474,-0.0892568,0.0416892,0.399605,-0.264126,0.0481473,-0.35799,-0.244417,0.291438,0.0193839,-0.224807,0.0942654,0.105598,0.209519,0.324959,0.457732,-0.397197 +3419.71,0.969058,0.0912059,4,1.49343,1.04921,-1.27582,0.479296,0.696302,-0.127297,-0.292915,0.1311,0.92514,0.362891,-0.0663617,-0.252677,0.104977,0.176404,-0.312331,0.599808,-0.0954767,0.156782,0.360944,-0.161246,-0.0115548,-1.506,-0.63045,-0.0313213,-0.215028,-0.559011,0.0231939,0.292808,-0.775882,0.0133872,0.679864,-0.217385,0.33395,-0.135423,-0.406503,0.0173244,-0.672549,1.58767,-0.013856,-0.368051,0.774844,0.933724,0.90833,-0.342397,-0.268637,0.221611,0.193241,0.642176,-0.0356034,-0.444694,0.0510216,0.682036,-0.053009,0.330626,0.367441,-0.384483,-0.308088,-1.00992,0.497852,-0.392849,0.101974,1.03841,-0.875054,-0.416855,0.533482,0.515107,-0.185451,0.193483,-0.1412,-0.413991,0.0110936,0.0391609,0.510256,0.338871,0.890829,0.360391,-0.107381,-0.731155,0.255774,-0.0379586,0.712939,-0.07158,0.278781,-0.358619,0.037739,0.509726,-0.076328,0.0853215,0.455281,-0.252429,0.293016,-0.385946,0.28917,-0.235789,0.442152,-0.563817,-0.662617,0.059866,-0.252956,0.605172,0.339926,0.330066,-0.908807,-0.251047,0.372802,-0.330898,-0.25518,0.241797,0.819218,0.655895,-0.5349,-0.00295631,-0.144855,0.232469,0.35667,0.228362,0.135283,0.305777,0.444538,-0.279769,-0.652231,-0.0199291,-0.0440788,-0.0376332,0.445244,0.460338,-0.66102,-0.0949441,0.185844,-0.36087,0.174511,-0.31234,-0.0275352,0.236745,-0.361885,-0.342461,0.0547044,-0.255102,-0.261865,-0.202956,-0.738655,-0.129036,0.174725,-0.274383,-0.250916,0.187673,-0.448703,0.729703,-0.215851,0.257774,-0.230771,0.149094,0.196019,0.239285,0.0202225,0.0310763,0.348425,0.438387,0.0561475,-0.104721,-0.135552,0.0467496,0.540219,0.153146,-0.650899,0.158343,0.103934,-0.405096,-0.265489,0.390449,0.0209001,-0.0673119,-0.235862,-0.207344,-0.117104,-0.0302504,-0.254471,0.312302,1.2279,0.886153,-0.260717,-0.360366,-0.274519,-0.249034,0.3428,-0.624528,0.171899,-0.395924,0.0601235,-0.520166,-0.00135898,-0.335755,-0.123396,-0.356279,-0.465668,-0.0654343,-0.212019,-0.678121,-0.162261,0.166923,0.0684359,0.123311,0.215992,0.135074,0.0340379,-0.0268874,-0.484664,0.812403,-0.206391,0.862427,0.0994936,0.0437712,-0.363653,0.451065,-0.101628,0.262785,-0.0367836,0.511812,-0.0412965,-0.22055,-0.458388,-0.0705326,-0.512767,0.105798,-0.843291,0.637389,-0.328506,0.0195289,0.220535,0.0858165,-0.308804,-0.209556,0.0622481,-0.0670253,0.10709,0.327491,-0.175271,0.164601,0.402165,-0.437625,0.237907,0.0762259,-0.238865,0.182439,0.117336,-0.19611,0.139052,0.561541,-0.589386,-0.340755,0.247774,-0.359533,0.651572,-0.264225,-0.0942217,0.0204194,-0.387931,0.610909,0.0855996,0.108591,0.348423,0.64161,0.114627,0.0464283,0.0312409,0.427197,0.182745,-0.535473,0.116236,0.0843857,0.0425651,-0.228108,-0.33107,-0.219423,0.431931,0.144703,0.143887,-0.0585171,-0.501421,-0.314211,0.649526,0.00439564,-0.378324,-0.11741,0.235127,0.408718,0.0896808,-0.210002,0.139771,-0.358445,-0.277907,0.121401,-0.0205113,0.489696,-0.713392,-0.252336,-0.153177,0.143485,-0.0723308,-0.0390613,0.232858,0.139435,0.318074,0.373411,0.563981,-2.42549 +3429.97,0.980289,0.0912059,4,1.51593,0.924973,-1.37173,0.516215,0.121354,-0.122081,0.225931,-0.124549,0.63312,0.585526,-0.031858,-0.219684,0.141112,0.354002,-0.269546,0.765025,-0.00186725,0.434397,0.14295,-0.0162769,0.00445862,-1.239,-0.536087,-0.0526463,-0.215644,-0.511038,0.163304,0.180165,-0.902859,-0.228985,0.675607,-0.424029,0.160726,0.00420842,-0.845993,-0.126266,-0.410331,0.986644,-0.0622228,-0.210884,0.779312,0.907327,0.420165,-0.562676,-0.539574,0.0261177,-0.210093,0.57429,0.288918,-0.376897,-0.0926855,0.226168,-0.0283939,-0.0830486,0.593267,-0.348505,-0.105601,-0.982176,0.511951,-0.334434,-0.0652361,1.1773,-0.688187,-0.736776,0.492651,0.273008,0.00537854,0.270965,-0.352184,-0.553984,-0.141706,4.48736e-05,0.676924,0.375819,1.14328,0.607049,-0.106992,-0.0408083,0.203486,-0.173318,0.70586,-0.247944,0.307369,-0.444501,0.102499,0.510254,0.116939,0.0684755,0.143997,-0.32873,0.29894,-0.374743,0.220386,-0.187874,0.0762299,-0.831061,-0.410169,-0.0621954,-0.476748,0.480292,0.116679,0.245692,-0.422338,-0.114894,0.300417,-0.757293,-0.192918,-0.0426239,0.217886,0.837838,-0.168602,-0.035787,-0.062765,-0.109179,0.23657,0.399767,0.358364,0.0241474,0.193547,-0.0670739,-1.00531,-0.107987,-0.0347545,-0.503831,0.268464,-0.0733514,-0.381304,-0.324514,0.112583,-0.221581,0.699551,0.00922756,0.0717298,0.320497,-0.5814,-0.280415,-0.25847,-0.293493,0.174368,-0.294585,-0.876177,-0.0272543,0.183068,-0.434282,-0.07662,0.223826,-0.300589,0.715664,-0.135128,-0.286928,-0.389349,-0.0779572,0.26818,0.195465,-0.0932731,0.0240586,0.37149,-0.0417,0.295944,-0.103735,0.132151,-0.0724461,0.670389,0.25608,-0.331169,0.577496,0.383581,-0.00202762,-0.201187,0.21166,0.126203,-0.370655,-0.397738,-0.443294,0.00181196,-0.0141665,-0.513026,0.184341,0.490034,0.773669,0.117262,-0.332243,-0.249619,-0.23243,-0.0798395,-0.499957,0.154972,-0.19916,0.401624,-0.581401,0.117586,-0.130545,-0.266132,-0.795116,-0.545698,-0.11421,-0.367509,-0.592687,-0.269875,0.377594,-0.0139858,0.111539,-0.123286,-0.385936,0.0928078,-0.121931,-0.516128,0.906215,0.158005,0.486106,0.185818,0.148644,-0.31179,0.570006,-0.145339,0.201478,-0.207796,0.492145,-0.154773,-0.229378,0.0358727,0.497993,-0.713065,-0.0803041,-0.245468,0.431269,0.27818,-0.191313,-0.0226413,0.00880408,-0.360451,-0.282548,0.058206,-0.124109,-0.0436686,0.0215307,0.156046,-0.0708694,0.637284,-0.792959,0.0867493,-0.268955,-0.0192807,0.405933,-0.407343,-0.0075081,0.161666,0.261877,-0.316312,-0.796226,0.299057,-0.220154,0.561658,-0.31043,-0.084559,0.042199,-0.381185,0.129113,-0.162136,0.0590345,0.0444163,0.44247,0.335475,0.172268,-0.312295,0.324504,0.213105,0.0812655,-0.138825,0.414969,0.216395,-0.347933,-0.115703,-0.166788,0.419333,-0.0760136,0.382974,0.0489687,-0.369986,-0.455403,0.239024,0.217705,-0.654266,-0.290982,0.35536,0.143738,0.13382,0.289861,0.591334,-0.337277,-0.268786,0.354363,0.239701,0.385431,-0.484848,-0.592901,-0.171509,0.605346,-0.342241,-0.512669,0.103412,0.122197,0.315012,0.349566,0.561259,-0.260554 +3413.2,0.821486,0.0912059,4,1.59268,0.984569,-1.16282,0.4322,0.248166,-0.15833,0.114997,-0.279564,0.622204,0.524724,-0.000412404,-0.332344,0.271048,0.325368,-0.325393,0.77582,-0.0536839,0.176454,0.197224,-0.0149334,-0.216717,-1.10208,-0.396472,0.0695154,0.0167869,-0.345433,0.275938,0.268273,-0.605349,0.106801,0.65141,-0.412574,0.236734,-0.19473,-0.725029,-0.368562,-0.198243,0.811001,-0.298271,-0.0970681,0.732172,1.02276,0.868473,-0.516345,-0.631855,0.0653643,-0.528445,0.68241,0.205201,-0.0241941,-0.383385,0.569013,0.188983,0.747206,0.547638,-0.549779,-0.147404,-1.1459,0.294189,-0.329843,-0.055592,0.980495,-0.656409,-0.897499,0.945793,0.10515,-0.118947,0.212887,-0.369698,-0.890528,-0.194589,0.048665,0.852175,-0.0318477,0.945399,0.573771,-0.122596,-0.0873121,-0.153531,-0.16946,0.558872,-0.181789,0.336366,-0.580656,0.219508,0.42014,0.113218,0.158588,0.209459,-0.221518,0.455869,-0.304383,0.0276573,-0.221257,-0.000415399,-0.744865,-0.0931272,0.14425,-0.551936,0.361209,0.159496,0.304117,-0.703249,-0.312583,0.469705,-0.593433,-0.0944595,-0.1155,0.132248,1.00164,0.0144381,0.141784,-0.117745,0.00621285,0.159795,0.157224,0.177303,-0.264573,0.711105,-0.0574897,-0.751755,0.12063,-0.269334,-0.696244,0.118043,-0.203139,-0.465453,-0.13349,-0.0111778,-0.192106,0.46773,0.155389,0.0569015,0.642834,-0.288237,-0.105687,-0.14498,-0.384526,0.179149,-0.497212,-0.744766,0.129876,0.0110544,-0.778158,-0.478131,0.407916,-0.446993,0.724288,-0.0437476,0.0614184,-0.324674,-0.134444,0.461766,0.0107566,0.232845,0.270399,0.416665,0.16986,0.344759,0.126405,-0.19072,-0.15998,0.81912,-0.14213,-0.500502,0.45639,0.238974,-0.123024,-0.161117,0.0911255,0.0913042,-0.502888,-0.34758,-0.165581,0.356803,-0.113553,-0.421911,0.083009,0.274231,0.492765,-0.0322007,-0.0301073,-0.106435,-0.318311,-0.344454,-0.55845,0.153869,-0.374296,-0.180092,-0.44264,-0.167015,-0.00120044,-0.396424,-0.634792,-0.818428,-0.535049,0.0735803,-0.823369,-0.15564,-0.0686629,-0.0934911,0.158393,0.233515,-0.541992,0.130238,-0.40147,-0.768425,0.907557,0.450618,0.574411,0.318453,0.228149,-0.0458326,0.408268,-0.442388,0.152049,-0.25478,0.397663,-0.0375213,-0.284713,0.0443359,0.113942,-0.61756,-0.0446678,-0.21679,0.589204,0.302828,0.240128,0.0156822,0.096916,-0.112691,-0.41765,0.306453,-0.26015,0.00413032,0.0562054,0.241946,0.285095,0.512167,-0.80234,-0.114805,-0.0505521,-0.14491,0.168518,-0.392388,0.129438,0.0471193,0.124239,-0.428308,-0.801641,0.167949,-0.404196,0.337055,-0.499221,0.0756675,0.0653026,-0.471131,0.392644,-0.239415,-0.0796829,0.461372,0.46615,0.13433,0.141331,0.0903714,0.534894,-0.049363,0.027535,-0.206662,0.438074,0.119258,-0.532607,-0.491958,0.258409,0.40673,-0.0709278,0.337579,0.527941,-0.179743,-0.456447,0.227756,-0.0518349,-0.22657,-0.136748,0.205653,0.391956,0.394469,0.703581,0.217369,-0.255364,-0.112624,0.170986,0.426198,0.537179,-0.475849,-0.68095,0.216734,0.304293,0.174616,-1.04997,0.431901,0.126781,0.334951,0.356063,0.578749,-0.731187 +3415.4,0.606778,0.0912059,4,1.60723,0.986914,-1.14605,0.435783,0.0330254,-0.128831,-0.118795,-0.0774932,0.650279,0.357652,0.0688141,-0.346385,-0.0132064,0.220174,-0.353865,0.758075,0.167024,0.190755,0.0487518,-0.0174632,-0.200899,-1.01636,-0.481767,0.0124876,-0.190854,-0.31295,0.375383,0.371122,-0.63372,0.0210979,0.738277,-0.198789,-0.0229873,-0.205676,-0.831898,-0.369732,-0.605702,0.758002,-0.0869672,-0.0100397,0.605716,0.714898,0.652988,-0.662118,-0.563835,-0.174743,-0.574594,0.44118,0.224636,-0.275018,-0.543531,0.274628,0.0515418,0.642689,0.443585,-0.519598,-0.0765737,-1.27024,0.416221,-0.545848,-0.0763933,1.01323,-0.66677,-0.739108,0.81404,0.0966308,-0.0883521,0.367103,-0.12347,-0.967743,-0.112888,0.166078,1.00145,-0.0730866,0.913406,0.818028,0.0802148,0.024656,-0.15667,-0.263513,0.903394,-0.180818,0.123975,-0.360432,0.204122,0.793319,0.205047,0.215701,0.327667,-0.253939,0.414936,-0.378614,-0.0251359,-0.211752,-0.127117,-0.6491,-0.0998728,0.0356942,-0.610583,0.318816,0.236779,0.0396764,-0.654434,-0.331347,0.362495,-0.514811,0.120571,-0.121209,0.0562392,1.06889,0.0500864,0.165395,-0.101985,0.0417567,0.201331,0.168041,0.22255,-0.212088,0.67852,-0.000461193,-0.763442,0.0755682,-0.0303833,-0.682208,0.0503695,-0.0788619,-0.269711,-0.319568,-0.0432236,-0.39784,0.303089,0.0924578,0.15959,0.581881,-0.173919,-0.296782,0.248665,-0.278611,0.0461821,-0.475406,-0.624887,0.213339,-0.0738808,-0.480136,-0.354641,0.498026,-0.21147,0.50961,-0.0765193,0.0642698,-0.584313,-0.102189,0.0939345,-0.270991,0.0659715,0.26681,0.522053,-0.0799568,0.478011,0.0409971,-0.0239462,-0.055197,0.8655,0.0847668,-0.378946,0.128102,0.0909024,-0.0101651,-0.221056,0.337163,0.138769,-0.854464,-0.446061,-0.27823,0.460117,-0.174898,-0.508574,-0.0444652,0.226317,0.254186,-0.0871708,-0.100769,0.0376756,-0.468187,-0.214241,-0.497677,-0.173685,-0.400638,-0.0686232,-0.412835,-0.104532,0.111008,-0.15683,-0.749485,-0.784278,-0.461944,-0.0231031,-0.800271,0.0998257,-0.0251879,-0.120642,0.130734,0.152738,-0.79115,-0.138283,-0.512634,-0.770372,0.789774,0.256044,0.399075,0.40983,0.13664,-0.0549658,0.260617,-0.530367,0.262038,-0.303422,0.423278,0.101676,-0.166286,-0.0518925,0.185303,-0.495942,0.084617,-0.14509,0.764142,0.391689,0.257106,0.0721969,0.10715,-0.198877,-0.281677,0.322355,-0.182542,-0.00603427,0.0613097,0.101192,0.17361,0.246935,-0.502006,-0.0510936,0.00348328,0.173416,0.241593,-0.42324,0.220506,-0.0222199,0.071034,-0.516276,-0.687156,0.053701,-0.385289,0.291789,-0.756913,-0.0909489,0.156633,-0.280949,0.342435,-0.0708863,-0.152057,0.182805,0.354338,0.268224,-0.00203141,0.221395,0.558106,-0.196958,-0.069303,-0.212667,0.351756,0.335887,-0.670425,-0.251758,0.021554,0.432452,-0.0720557,0.487053,0.570354,-0.20759,-0.488142,0.0323459,-0.196155,-0.0624494,-0.311874,-0.0614952,-0.0290858,0.125299,0.546324,0.0997694,-0.0144393,-0.226009,0.2887,0.461652,0.596538,-0.319642,-0.67184,0.387586,0.115558,0.211168,-1.01269,0.554138,0.124261,0.33753,0.352507,0.580973,-0.0261446 +3397.53,0.841279,0.0912059,4,1.60643,1.11401,-0.930105,0.212985,0.472288,-0.0446937,-0.338814,0.176528,0.906237,0.851523,-0.0172226,-0.110049,0.0371051,0.0218253,-0.274604,0.809234,0.0279146,-0.13139,-0.00448029,-0.48886,-0.576859,-1.63014,-1.11839,-0.159798,-0.357954,-0.449705,-0.191216,-0.121927,-0.319201,-0.0711596,0.123692,-0.603021,0.365234,0.0370576,-0.781934,0.334816,0.22625,1.18511,0.660154,-0.495336,0.76891,0.596482,0.364507,-0.973431,-0.0539517,-0.53742,-0.534252,0.498763,0.0239759,-0.113327,-0.234601,0.528207,-0.289108,-0.288132,0.647393,-0.551479,-1.00538,-0.938926,0.677947,-0.494205,0.251302,1.34071,-0.934835,-1.58459,0.153862,0.00783581,0.248389,0.254869,-0.0722244,-0.664198,0.23874,0.494887,0.269737,0.237659,0.708273,-0.059246,0.0409907,-0.488094,-0.598306,0.138358,0.542532,-0.736148,0.116578,-0.04787,0.387956,-0.0708128,0.328319,0.282702,-0.342429,-0.400722,0.535054,0.232656,0.0541278,0.225302,-0.13394,-0.402585,0.0900404,-0.293071,-0.481675,0.17179,0.012443,0.130757,-0.461308,-0.368735,0.8923,-0.383009,0.0758761,0.128322,0.202024,1.03168,0.660258,-0.0464399,-0.269357,0.235942,0.51561,0.256102,0.429584,-0.301376,-0.0226252,0.144109,-1.02411,0.0337212,-0.0731113,-0.1224,-0.499654,0.637982,-0.528764,-0.13414,-0.036794,-0.29821,0.349866,-0.227931,0.0630638,0.564023,-0.188097,-0.138523,-0.0039296,0.220836,0.217057,0.031658,-0.687935,-0.185268,0.333524,-0.124926,-0.253716,-0.480878,0.262996,0.360849,0.15442,0.174219,-0.315452,0.202769,0.352796,0.587851,-0.522801,0.156275,0.0121848,-0.00346348,0.284241,-0.00488766,0.233157,0.0969757,0.779918,-0.217789,0.327313,0.0507379,0.264412,0.0868571,0.0744991,0.16234,0.345003,-0.422734,-0.149049,0.451855,0.136482,-0.192317,-0.591755,0.895718,0.333908,0.63697,0.573685,-0.18223,-0.0800974,0.354942,0.442701,-0.439836,-0.155628,-0.636572,0.175972,-0.772302,0.367797,0.350592,0.0275996,-1.11326,0.605401,0.0253344,0.0784347,-0.374552,-0.445179,-0.47779,-0.143001,-0.332683,0.419376,0.0366616,-0.041797,-0.630429,-0.241076,1.10628,-0.167359,-0.137976,-0.0213932,0.260536,-0.0350977,0.00918143,-0.60925,-0.0193223,-0.0531209,0.337533,-0.227763,-0.296727,0.231752,-1.29077,0.371181,-0.237322,-0.246336,0.585641,-0.0364311,0.326239,-0.0059063,0.202897,0.0682016,-0.141869,-0.0931282,-0.0286238,0.309006,0.248721,0.0335251,0.168771,0.207468,-0.394193,-0.256132,-0.219611,0.447695,0.0839185,0.163948,0.115263,0.109254,-0.203045,-0.0952733,-0.300927,-0.122144,-0.179202,0.143328,0.236337,-0.0840512,0.74819,-0.441256,-0.112658,-0.299029,0.2142,0.470151,0.419394,-0.0374309,-0.089603,-0.0262223,-0.603796,0.0399919,0.424832,0.435168,0.0818498,0.158254,-0.660277,-0.117822,0.23905,-0.0859516,0.139111,0.35395,0.183064,0.661225,0.125313,-0.181775,-0.500595,-0.542219,0.121506,0.0624488,0.449141,0.486925,0.283339,0.555226,-0.0836067,-0.243879,0.681025,-0.400658,0.557128,-0.449823,-0.192369,0.473522,-0.267655,-0.225651,-0.419223,0.00295064,0.159428,0.330814,0.399285,0.575164,-1.6331 +3407.9,0.984338,0.0912059,4,1.62682,1.08589,-0.846721,0.191724,0.363089,-0.133459,-0.545232,-0.210565,0.627724,0.511329,-0.26397,-0.114592,0.155472,0.182347,-0.185612,0.944846,-0.029357,-0.21858,-0.0348726,-0.281225,-0.511651,-1.52988,-0.886981,-0.34133,-0.311675,-0.438066,-0.207116,-0.0757522,-0.122389,0.00328059,0.078213,-0.971275,0.00967831,0.079257,-0.590524,0.265266,0.344872,1.04969,0.845605,-0.517579,0.428064,0.475044,0.291477,-0.787356,-0.0292568,-0.214178,-0.403234,0.422582,0.0613056,-0.160578,-0.169913,1.10088,-0.0832883,-0.575812,0.691491,-0.644847,-0.854737,-0.975555,0.64944,-0.517232,0.0976162,1.11921,-0.866161,-1.25019,0.230095,0.312363,0.107145,0.183698,-0.306561,-0.764923,0.132439,0.40457,0.336422,0.227052,0.614536,0.127525,0.0990053,-0.0778386,-0.591833,0.00940651,0.611509,-0.516656,0.308143,-0.300018,0.230485,0.0189309,0.302706,0.34555,-0.25524,-0.404022,0.383827,0.200399,0.0376656,0.0856131,-0.0138471,-0.959771,-0.196909,-0.633478,-0.112364,0.342306,0.208414,0.110193,-0.36289,0.0719556,0.605643,-0.292071,-0.112294,0.145405,0.0734506,0.798612,0.82146,-0.0656567,-0.0565842,0.202474,0.383498,0.0459154,0.837536,-0.233473,0.1415,0.0610429,-0.890979,-0.0213468,-0.115791,-0.199661,-0.726206,0.555802,-0.289125,0.0476822,-0.160026,-0.376705,0.386548,-0.237337,0.176707,0.670018,-0.455798,-0.392718,0.210506,0.451683,0.300771,-0.0158665,-0.444749,-0.0269199,0.350383,-0.122568,-0.184389,-0.530796,0.515946,0.455391,0.00993243,0.0721386,0.0938943,0.00640377,0.466205,0.244202,-0.52441,0.16075,0.092564,0.0683982,0.15546,-0.0549882,0.25444,-0.105065,0.903589,-0.032798,0.360215,0.0833683,0.45917,0.0338985,-0.0700917,0.00428086,0.23801,-0.241256,-0.183407,0.371438,-0.0928318,0.0127762,-0.520682,0.439014,0.0855421,0.473663,0.667373,-0.128513,0.0199454,0.254555,0.428489,-0.428909,-0.00716238,-0.499917,0.516001,-0.943484,0.144971,0.331537,-0.0781206,-0.977503,0.400753,0.0153879,0.108432,-0.197119,-0.729818,-0.253481,-0.306994,-0.246564,0.342392,0.0122343,0.0979998,-0.450573,-0.117054,1.1029,0.162201,-0.293192,0.0319574,0.432568,-0.0447259,0.135986,-0.843386,0.0929305,-0.660786,0.48616,-0.0377932,-0.38378,0.283957,-1.16462,0.201137,-0.00714611,-0.363469,0.650233,-0.105178,0.109001,0.131633,0.215187,0.425744,-0.250015,-0.267752,0.0906406,0.499145,0.430552,-0.295889,0.211438,0.254541,-0.380651,-0.715588,-0.172702,0.185823,-0.0917602,0.255314,0.0490893,0.274732,-0.0968295,0.221068,-0.247052,-0.055099,-0.33121,-0.0302583,0.0562124,0.0714212,0.437565,-0.44408,0.230657,-0.287643,0.251526,0.151334,0.449267,-0.0329632,0.198111,0.13338,-0.58067,0.12073,0.573145,0.261186,0.207537,-0.0396351,-0.27717,0.120173,0.235963,-0.137742,-0.035053,0.436259,0.258444,0.449234,0.277094,-0.12735,-0.408473,-0.392864,0.27381,0.201174,0.418302,0.191716,0.237205,0.824925,-0.260462,-0.0425648,0.505533,-0.159963,0.414535,-0.357037,-0.0697495,0.348104,-0.377883,-0.28339,-0.248981,0.104737,0.132645,0.488178,0.364205,0.698698,-1.20194 +3400.71,0.908218,0.0912059,4,1.56375,1.19977,-0.326696,-0.00206997,-0.308388,-0.00869006,0.850896,0.0126946,0.791397,0.659957,-0.457621,-0.785091,-0.210765,0.499346,0.169541,0.557568,0.306451,0.0562028,-0.229372,-0.148001,-0.801213,-1.5408,-0.233476,-0.307412,-0.271287,-0.485552,-0.0619373,-0.0584819,-0.117029,0.221238,0.522434,-0.569402,0.145898,-0.197271,-0.625079,-0.138906,0.19844,0.886163,0.116661,-0.354934,1.00824,0.607019,0.225304,-1.09424,-0.332295,0.223029,-0.413774,0.797596,0.231365,-0.040905,0.163653,0.134779,-0.511202,-0.246156,0.656779,-0.342613,-0.41654,-1.19996,0.43467,-0.194175,-0.0480245,1.18648,-1.11794,-0.855634,0.263827,0.0173809,-0.586175,-0.0651498,0.24049,-0.0388333,0.482845,0.223905,0.421767,-0.202373,0.531062,0.424748,-0.0581686,-0.04876,-0.403409,-0.145297,1.01924,0.126118,0.136317,-0.78029,-0.402316,0.182105,0.000187481,-0.523016,0.117617,-0.0669706,0.151421,0.58556,-0.152204,0.0911988,-0.0933872,-0.609713,-0.7189,-0.569425,-0.572292,0.518072,-0.168984,0.509034,-0.390429,-0.557945,0.536574,-0.364477,0.235634,-0.136824,0.147887,0.621472,-0.668501,0.217304,0.363075,0.17589,0.321545,0.44347,0.0375289,-0.114685,0.41216,0.244674,-1.38064,-0.0420144,0.0427318,-0.495733,-0.195063,0.253573,0.0334295,0.154754,0.18443,-0.28874,-0.188587,-0.541743,-0.0147343,0.658255,-0.308634,0.0909317,0.275962,-0.00570808,0.297475,-0.0553825,-0.460316,0.135888,-0.0594979,0.847983,-0.471243,0.0997144,0.0973233,0.298936,0.00996856,-0.293748,-0.471309,0.29066,0.53886,0.268791,-0.255195,-0.143759,0.05804,-0.0892285,0.367364,0.0653088,-0.0837055,0.364077,0.53733,0.303149,0.136844,-0.219856,-0.174449,-0.410587,0.113908,-0.350887,0.0620817,-0.0732473,-0.233321,0.0589251,-0.125881,-0.257004,-0.747817,0.132511,0.608757,0.276664,0.424546,0.413235,0.0289094,-0.680978,0.835027,-0.582773,0.0247981,0.0454652,0.224844,-0.0825545,-0.0431655,-0.317981,0.0403437,-0.774458,0.159546,0.296656,0.0191158,0.118505,-0.599603,0.177557,-0.203966,-0.00649637,-0.00186556,0.254356,0.143972,0.140451,-0.614947,0.963587,-0.0542907,0.0110742,-0.012165,-0.239204,-0.150401,-0.0944581,0.218091,0.468379,-0.541774,0.367256,-0.0193689,-0.173863,0.320452,-0.119805,-0.621991,0.213805,-0.621591,0.766483,-0.532776,-0.391696,0.00672182,0.0623867,-0.088099,-0.0226026,-0.121722,0.734195,0.436425,0.220294,0.120157,0.0934243,0.621186,0.10406,-0.594194,0.325338,0.111455,-0.0307338,0.273839,0.115209,0.50449,-0.155142,0.400962,-0.425683,-0.289046,-0.127742,0.179464,-0.34134,-0.110812,-0.0279638,-0.0619826,0.661542,-0.212834,0.201275,0.230773,0.700599,-0.176305,0.516415,-0.162473,-0.103688,0.162945,-0.177739,-0.581642,-0.196511,-0.357221,-0.900699,-0.178851,-0.288199,-0.0496948,0.0236362,0.20541,0.755894,0.683566,-0.0142178,-0.0528148,-0.216932,-0.331118,0.23635,0.365471,-0.0848027,-0.259247,0.146105,0.560211,-0.507444,-0.482187,0.515836,0.22428,-0.383956,-0.464045,-0.17369,0.0992091,-0.0806958,0.120734,-0.0498001,-0.0743208,0.144065,0.222129,0.379559,0.471306,0.64219 +3424.11,0.954764,0.0912059,4,1.61066,1.08008,-0.52464,0.0196705,-0.352868,0.0430486,0.346773,-0.216939,0.491633,0.575634,-0.562746,-0.597352,0.337794,0.661746,0.10355,1.20739,0.254736,-0.126049,-0.246948,-0.121751,-0.629198,-1.76295,-0.232216,-0.0483409,-0.430979,-0.507599,0.0943849,0.156211,0.0122039,-0.00861945,0.362879,-0.0933149,0.0291598,0.0793588,-0.623233,0.244572,0.0149215,0.682964,0.220301,-0.0979855,0.786974,0.876943,0.258459,-0.86695,-0.128313,-0.726439,-0.266973,0.153226,0.192804,0.102649,0.437863,0.233391,0.190119,-0.707036,0.941554,-0.0330639,-0.679593,-1.07378,0.872385,-0.207095,-0.0129741,0.881042,-0.80778,-1.05328,0.0719919,-0.458739,-0.0809744,0.409643,-0.17527,-0.253899,0.125909,0.443052,0.184399,-0.238641,0.636877,0.344858,-0.0706173,0.00706769,-0.000293329,0.0542628,1.00004,-0.29101,0.122751,-0.498321,-0.211155,0.515258,-0.0604789,-0.463332,-0.126946,-0.144126,-0.183733,-0.143609,0.0794183,0.27952,0.165193,-0.990472,-0.157526,-0.695749,-0.398806,0.340655,0.2927,0.439568,0.223324,-0.556596,0.111299,-0.330668,-0.28464,0.303096,0.265863,0.373169,-0.611614,0.0161251,0.438738,0.209736,0.331623,-0.00778701,-0.0967421,-0.343767,0.502972,0.436287,-1.38857,-0.433018,-0.214474,-0.325346,-0.441086,0.456166,-0.120758,0.0125763,0.0688609,-0.565871,0.227724,-0.0477197,-0.160564,0.516029,-0.228757,-0.239338,0.167557,0.104306,0.694059,-0.25398,-0.255177,0.125516,0.0586116,0.415611,-0.373842,0.293462,0.0309832,0.323938,-0.0790717,-0.0175326,-0.275624,-0.128318,0.20193,0.274229,-0.390232,-0.105907,0.144266,-0.350693,0.133974,0.0817422,-0.11982,0.0744481,0.570076,0.862993,0.0231678,-0.056082,-0.267955,-0.49938,-0.151954,-0.0199913,-0.342692,0.231083,-0.246403,-0.116188,-0.368752,0.322561,-0.879237,-0.0224618,-0.304091,0.384931,-0.226161,0.382757,0.189381,-0.345545,0.655441,-0.353038,-0.393426,-0.33953,0.152446,-0.682623,0.110919,-0.308617,0.0472517,-0.649033,-0.138542,0.22018,0.421272,-0.0193183,-0.742897,0.11075,0.0507577,0.343035,-0.082032,-0.0497866,-0.0139129,-0.338991,-0.837089,1.11948,-0.143871,-0.0474158,0.0802831,0.0342472,-0.171665,0.0603596,-0.407694,0.097441,-0.020287,0.221513,-0.0854786,-0.159426,0.381034,-0.12972,-0.0975076,0.554075,-0.65647,0.834992,-0.104064,-0.139095,-0.26162,0.380457,-0.0435279,-0.0626853,0.0684594,0.313108,0.223306,-0.28046,-0.105404,0.288486,0.352776,-0.0334241,0.163136,0.445772,-0.20544,0.189296,-0.195253,0.353928,0.314904,0.128961,-0.024607,-0.164396,0.116178,-0.387942,-0.000975746,-0.0695162,-0.0509843,0.0663806,-0.0521746,0.379829,0.125811,-0.1251,0.596485,0.476916,0.182277,0.22915,0.128818,-0.262724,0.0615547,-0.372209,-0.278896,0.1159,0.0460775,-0.474042,-0.244344,0.108743,-0.654394,0.0118202,0.107682,0.0702785,0.103267,0.467358,-0.268059,-0.338599,-0.172195,0.435877,0.28103,-0.232116,0.100484,0.583935,0.217669,-0.39427,-0.285846,0.38557,0.419338,0.00976282,-0.460804,0.121858,0.243134,-0.445004,0.187408,-0.667406,0.187252,0.120994,0.355603,0.347841,0.596325,1.11882 +3403.82,0.983267,0.0912059,4,1.65763,1.19214,-0.426538,-0.00620357,-0.148739,0.0134832,0.554156,-0.196285,0.451516,0.478999,-0.581528,-0.5664,0.289125,0.566348,0.0288918,1.05495,-0.0180608,0.0122713,-0.613011,-0.495673,-0.811971,-1.67455,0.133199,-0.132441,-0.383458,-0.305341,0.260656,-0.236487,-0.276607,0.00213369,0.375703,0.171759,-0.253065,-0.124593,-0.65176,0.0907046,-0.201463,0.739053,0.456148,-0.367094,1.09515,0.583827,0.215451,-1.5429,0.0473515,-1.35737,-0.558547,0.421398,0.306954,0.10545,0.561565,-0.0316541,-0.0302013,-0.971263,0.758456,-0.178412,-0.501139,-0.81814,0.741345,-0.876187,0.644846,1.06882,-0.682453,-1.52469,-0.172843,-0.581464,0.378713,-0.0180456,-0.0110257,-0.461989,-0.193419,0.506828,0.338739,0.0189064,0.578224,0.177684,-0.0276551,0.196688,-0.331636,0.0262532,1.03207,-0.0133072,0.00989237,-0.759692,-0.369843,0.347275,0.0726823,-0.212066,-0.269181,0.0827344,-0.233864,0.157272,-0.114553,0.345961,0.434709,-0.847859,0.0605044,-0.704598,-0.0769703,0.422765,-0.201595,-0.049083,0.557435,0.0561851,-0.459978,-0.361928,0.0419425,-0.0369198,0.477546,0.297911,0.152512,-0.0625224,-0.125877,0.203603,0.362155,0.131313,-0.308188,-0.335308,0.567991,0.249427,-1.43028,-0.0517915,-0.257196,-0.293623,-0.0605862,0.0126987,-0.125303,0.300976,0.309129,-0.518727,0.39865,-0.158934,-0.265725,0.545098,-0.117588,-0.24318,-0.000497924,0.143805,0.299467,-0.52878,-0.491303,-0.0747268,0.0580927,0.0514426,-0.395719,0.091793,-0.132814,0.201521,0.252073,0.304262,-0.347396,0.0321221,0.254898,0.282523,0.0808322,0.0314093,0.103169,-0.13291,0.23699,-0.0682756,-0.0682206,0.439129,0.530538,0.669253,0.151099,-0.233466,-0.305199,-0.492108,-0.265591,-0.171572,-0.134476,0.113479,-0.100054,0.0772116,-0.113464,0.471791,-0.661664,-0.00161056,-0.567926,0.744944,-0.373354,0.527873,-0.197723,-0.400997,0.660707,-0.52945,-0.731564,-0.314529,0.122245,-0.654252,-0.22429,-0.0161961,-0.0541931,-0.99627,-0.0617749,0.195172,0.413548,-0.0388506,-0.312906,0.228613,-0.0541614,0.482658,-0.100794,0.26711,-0.0437581,-0.17297,-0.809829,0.905263,-0.485001,-0.176317,0.354406,-0.0451836,-0.413222,0.0636443,-0.268323,0.299658,-0.348444,0.246436,0.100338,-0.404452,0.355252,-0.140956,0.177493,0.680702,-0.524764,0.602212,-0.371241,-0.296038,-0.401958,0.684535,-0.166976,-0.271076,0.251071,0.540064,0.488279,-0.221225,-0.26579,0.295157,0.291013,-0.400241,0.357915,0.472497,-0.169897,-0.169062,0.199091,0.297054,0.476218,0.263155,-0.0918402,-0.41562,0.053869,-0.696255,0.375312,-0.00988177,-0.0363681,0.216597,-0.383205,0.446839,0.00138354,0.05579,0.423777,0.290328,-0.126196,0.748919,-0.0823057,0.0990383,0.175149,-0.899155,-0.24351,-0.39956,-0.0231617,-0.735864,-0.183738,-0.0524102,-0.426,-0.13514,-0.413202,-0.407243,0.279247,0.354813,-0.141842,-0.412589,-0.271718,-0.0637883,0.110997,0.208786,-0.492133,0.194892,0.266773,-0.324107,-0.187326,0.213283,0.119032,-0.316201,-0.573745,-0.00815522,-0.0700685,-0.230323,0.093647,-0.654443,0.115451,0.135819,0.372123,0.368536,0.610019,0.270389 +3400.01,0.960325,0.0912059,5,1.5798,1.1898,-0.28489,-0.0505822,0.0321513,0.0590985,0.876074,0.0544804,1.06717,0.197189,-0.406261,-0.13215,-0.29411,0.327253,-0.052925,1.06311,-0.0776537,-0.0702775,-0.674941,-0.32329,-0.709825,-1.36113,-0.937941,-0.238135,-0.746999,-0.082114,0.300006,0.529458,-0.464313,0.293948,0.340514,-0.364111,-0.325306,-0.206463,-0.530656,0.0127884,-0.271673,0.603219,0.123847,-0.343211,0.848848,0.797701,0.232239,-0.886628,-0.0168933,-1.00322,-0.621812,0.155511,0.779624,0.048361,0.709105,0.0517482,-0.400669,-1.1363,0.960384,-0.718234,-0.185402,-1.15598,0.828883,-0.759829,0.422989,1.07723,-0.481212,-1.15267,0.377469,0.215807,-0.338715,0.0174196,0.631713,-0.482515,-0.131179,0.245139,0.333498,-0.163453,0.469366,0.56812,0.0900538,0.270009,-0.0419358,0.350825,0.86273,-0.862746,-0.0914693,-0.446651,-0.242572,0.208115,-0.113543,-0.0562482,-0.0771514,-0.112281,0.225876,0.14708,0.199766,0.132043,0.198223,-0.637388,0.229094,-0.685648,-0.0126969,0.454897,-0.271678,-0.08321,-0.332015,0.0281575,-0.440982,0.167995,0.514302,-0.846473,0.270506,0.0925439,-0.0210783,0.0964685,1.00893,0.12207,0.148324,0.355348,-0.285884,-0.210695,0.352284,-0.178288,-1.23061,0.0105416,-0.0144431,1.01969,-0.369823,0.604139,-0.0150655,-0.263981,0.311929,-0.511047,0.39692,-0.0464787,-0.0647136,0.18493,0.0414299,-0.384871,-0.053623,-0.401473,0.502156,-0.280924,-0.643609,-0.163171,0.208065,-0.455066,-0.484763,0.344593,-0.293788,-0.00785493,-0.104733,-0.101174,0.364179,0.381887,0.397552,0.0419995,0.75908,-0.349909,0.61537,-0.0405669,-0.03311,0.477185,0.480542,0.215225,0.0967563,0.422526,-0.419473,0.544906,-0.245106,-0.268806,-0.779958,0.223789,-0.00948024,0.285355,-0.294193,-0.120401,0.510563,0.439317,-0.897552,0.0146771,-0.292229,0.664063,-0.588498,0.363576,-0.129496,-0.593875,0.256921,-0.314146,-0.484447,-0.470459,0.291158,-0.879314,0.118592,0.120937,0.245416,-0.417358,-0.109711,0.182823,0.413937,-0.0152855,-0.204113,0.55414,-0.0341372,0.511887,-0.038052,0.0869383,-0.190115,-0.0398714,-0.271195,0.994648,-0.425343,0.386023,0.0584122,0.276449,-0.0698758,0.155676,-0.0354697,-0.328878,-0.527133,0.254538,0.35612,-0.00124183,-0.0407577,-0.314107,0.331812,-0.151298,-0.0444757,0.42202,-0.608906,-0.646246,-0.294515,0.0634426,-0.254772,-0.0352213,-0.303841,-0.0520249,-0.323029,0.248768,0.0580489,0.160763,0.239957,-0.672115,-0.237689,-0.11442,-0.0482647,-0.319741,0.500281,0.38977,0.173214,-0.0525138,-0.0626582,-0.762005,-0.187522,-0.657846,0.120058,-0.242703,-0.279003,0.409732,-0.534558,0.601321,-0.309106,0.0161434,-0.403319,0.264624,-0.10114,0.288253,0.13933,-0.196872,-0.0684823,-0.356678,-0.0949164,-0.431263,0.082437,0.20048,-0.0380411,-0.426778,-0.200284,0.131458,-0.0938866,-0.189103,0.788551,0.722765,-0.395867,-0.391458,-0.55822,0.433711,-0.0767061,0.0490399,-0.509465,0.319102,0.213103,-0.341099,-0.666045,0.465571,0.138154,0.401614,-0.221992,0.325289,-0.0165892,-0.0992327,-0.319377,0.585174,0.095357,0.147001,0.530474,0.383407,0.728337,-0.447558 +3399.4,0.919292,0.0912059,4,1.59404,1.10766,-0.269945,-0.0738085,0.207096,-0.0234759,0.932532,-0.00294199,0.807639,0.125201,-0.475157,-0.202096,-0.379701,0.422044,0.120047,1.27314,-0.178513,-0.283159,-0.881552,-0.45677,-0.79048,-2.09382,-0.956193,-0.174019,-0.315354,-0.12449,0.461013,0.551079,-0.293071,0.111258,0.526343,-0.148647,-0.288996,-0.102671,-0.250138,-0.40097,-0.42314,0.715336,0.268918,-0.456205,0.849086,0.458734,-0.0893622,-0.729709,0.238988,-0.905574,-0.3962,0.414447,0.672294,0.0607424,0.422036,0.043003,-0.106522,-1.26231,1.18364,-0.856956,-0.35951,-1.26556,0.677657,-0.480066,0.294735,0.9419,-0.260051,-1.67748,0.237097,-0.0516477,-0.415423,-0.0679699,-0.0470202,-0.729618,-0.131485,0.136239,0.241903,-0.0623973,0.634653,0.575875,0.405804,-0.162784,0.0384146,0.322318,1.03642,-0.545495,0.0535287,-0.549063,-0.61862,0.331889,-0.466534,-0.165842,-0.175501,-0.279916,0.296685,0.367072,0.0869034,0.00438931,0.0769252,-0.174778,0.353174,-0.425927,-0.321501,0.423309,-0.730688,0.158384,-0.669199,0.0613118,-0.223098,0.0473932,-0.0497397,-0.354723,0.192362,0.878437,0.0475418,0.199143,0.718352,0.00970743,0.256618,0.641391,-0.119814,-0.213277,-0.0370912,-0.299059,-1.0328,0.0661101,-0.029406,0.705789,-0.251752,0.287057,-0.197866,-0.1174,0.393024,-0.482198,0.241584,-0.0992607,-0.181583,0.37598,-0.244007,-0.202528,-0.0623797,-0.368356,0.578234,-0.412644,-0.747689,-0.0706043,0.349116,-0.748599,-0.124989,0.493183,0.100679,0.340689,-0.176261,-0.937705,0.640717,0.423122,0.296158,-0.0485269,1.05671,-0.430278,0.340089,0.417455,0.0674079,0.185963,0.305391,-0.237434,0.239536,-0.0921373,-0.0723865,0.483846,0.0203646,-0.0441028,-0.730781,0.213356,0.0826561,0.164991,-0.566351,-0.1338,0.368985,0.666382,-0.644328,0.1948,-0.0268251,0.809798,-0.501745,0.203671,-0.459645,-0.505481,0.233285,-0.333225,-0.445096,-0.214252,0.232112,-0.650765,0.233875,-0.0154587,0.210278,-0.446108,0.104733,0.422379,0.42944,-0.237568,-0.359312,0.651914,0.152462,0.225227,0.161816,0.407596,-0.265516,-0.141746,-0.237185,0.988805,-0.572065,0.55595,-0.22716,0.0109562,0.285341,0.374043,-0.393767,-0.347568,-0.389727,0.305809,0.109007,-0.450687,-0.3049,-0.378397,0.262236,0.302951,-0.222892,0.286849,-0.343724,-0.198638,-0.00034819,-0.0698693,-0.432629,-0.217378,-0.499412,-0.616538,-0.27368,0.430008,0.360124,-0.036405,0.660519,-0.556719,-0.201923,-0.134131,-0.553099,-0.22733,0.697668,0.58479,0.358658,0.0146679,-0.441759,-0.659084,-0.143747,-0.411287,0.0889483,-0.511346,-0.378501,0.470018,-0.344817,0.431848,0.0404502,-0.0112721,-0.440885,0.120911,-0.311043,0.286767,0.251229,-0.250198,0.0283668,-0.25327,0.303971,-0.149764,-0.187852,0.199332,-0.142869,-0.0372742,-0.315369,0.000455789,-0.107823,-0.199027,0.71536,0.591474,-0.480554,-0.204698,-0.520269,0.00521609,-0.108698,0.326638,-0.128245,0.415186,0.436172,-0.0346112,-0.225273,0.390043,0.328705,-0.145415,-0.128255,0.0154448,-0.0217084,0.203773,-0.507815,0.621913,-0.131446,0.136142,0.616144,0.368974,0.784948,-0.834067 +3386.05,0.994414,0.0912059,4,1.60714,1.0501,-0.266794,-0.0841886,0.221655,-0.0878353,0.161366,0.480367,0.0984757,0.593368,-0.454414,-0.486562,0.382084,0.0706641,-0.0829677,0.559303,-0.0202061,-0.493189,0.255976,-0.520645,-0.535845,-1.52299,-0.692524,-0.0301264,-0.242752,0.0501397,-0.267691,0.238337,-0.208465,-0.371099,0.268899,0.16294,-0.791867,0.147717,-0.00144291,0.179589,-1.11331,0.746827,0.880763,-0.194028,1.24179,1.14143,-0.223159,-0.7049,-0.167449,-0.241204,-1.03606,0.212486,0.467708,-0.103348,0.0933299,0.773317,0.351029,-0.246136,1.12629,-0.311639,-0.034216,-0.717701,0.76533,-0.0759678,0.358762,0.768244,-0.649178,-1.65285,-0.0276368,-0.0806957,-0.241745,-0.394149,-0.164648,0.211217,-0.433261,-0.0691556,0.807175,-0.485123,0.545293,0.42336,0.75663,-0.401967,0.291894,-0.150515,1.03574,-1.02313,-0.155683,0.249984,-0.351263,-0.0708163,-0.691174,-0.0864573,0.476839,0.0742605,-0.0927053,0.143067,0.284007,-0.1113,0.217505,-0.324851,-0.492285,-0.14666,-0.344076,0.114208,-0.246491,-0.171633,0.510146,-0.0706297,0.911229,-0.0509072,-0.195782,-0.017856,0.607882,0.369936,-0.150058,-0.377848,0.962047,0.271013,-0.262739,-0.100544,-0.0402548,0.0475772,0.295363,0.0779896,-0.0986027,-0.317123,-0.334179,-0.51867,-0.495488,-0.233447,0.303797,-0.00337937,0.372,-0.408332,0.513249,-0.128515,0.284595,0.539852,0.000588332,0.372858,0.0630378,0.508021,0.206061,-0.244951,-0.0880047,-0.135697,-0.38113,-0.364622,0.310256,0.283843,0.209814,0.551126,-0.195001,0.15683,-0.363481,-0.236675,0.0209992,-0.195583,0.099365,0.106084,-0.418817,0.0214417,0.167048,-0.806615,0.328184,0.46032,0.860815,-0.703986,-0.546235,-0.295285,-0.344184,-0.225313,0.265887,-0.678932,-0.0217251,-0.544701,0.0375971,-0.206146,0.171003,-0.274292,-0.54589,-0.979001,0.203593,0.428469,-0.26679,0.365185,0.407763,-0.415217,-0.0677313,-0.28801,-0.622433,-0.645014,0.782674,0.479179,-0.10726,-0.128108,-0.41968,-0.396728,-0.0381845,0.443219,0.401005,-0.0921729,-0.394559,-0.00248821,-0.42382,0.118864,-0.123997,-0.100867,-0.474107,0.031801,-0.301999,1.01731,0.0506312,0.41319,0.0124379,0.00181945,-0.0137622,0.444908,-0.406267,-0.139261,-0.0944333,0.225541,0.155812,-0.404769,-0.143931,-0.857771,0.501989,0.476081,-0.625769,0.590701,-0.432752,-0.874195,0.0778174,0.080056,0.263912,-0.114563,-0.0726821,0.264944,-0.0582673,0.0521683,0.0458453,-0.140008,0.501391,-0.950074,0.411366,-0.389558,0.670056,-0.19835,0.640611,0.20571,0.52667,0.0530281,0.150389,-0.0835876,-0.620497,-0.589016,0.312463,-0.131377,0.190985,0.463567,-0.209359,0.708293,-0.0498429,-0.0169567,0.286857,0.0154958,-0.323308,0.188324,-0.26632,0.366124,0.186673,-0.411906,-0.440747,-0.506926,-0.527888,-0.157445,-0.0495376,0.167955,0.0130544,-0.408937,-0.108496,0.101466,0.328463,0.193142,0.0125291,-0.593394,-0.01174,-0.134848,0.0544587,-0.124201,-0.00985303,0.516619,0.292452,0.385547,-0.191156,0.736008,-0.429957,0.652424,-0.153614,-0.591185,-0.234302,-0.150317,0.307521,-0.197648,0.212437,0.156097,0.340964,0.395091,0.583921,-0.743253 +3396.56,0.951391,0.0912059,4,1.46592,1.13705,-0.40215,-0.0960409,0.0926299,-0.0626113,-0.28143,0.376274,0.239405,0.355763,-0.293554,-0.204399,-0.0813788,0.315355,0.0735354,1.25113,-0.0630832,-0.447651,-0.483947,-0.394373,-0.361939,-1.44983,-0.658249,0.134194,-0.417271,-0.0736054,0.421237,0.301366,-0.217182,-0.46508,0.650835,0.0320279,0.199411,0.00434161,0.307394,0.22248,-0.970275,0.731047,0.872079,-0.205473,1.23138,1.02633,0.0819112,-0.623234,-0.0567338,-0.216983,-0.677515,0.334067,0.677962,0.0966825,0.640553,0.410358,0.476304,-0.206036,1.17571,-0.409122,0.180234,-0.758629,0.676868,0.0174467,0.390454,1.13981,-0.448325,-1.73308,-0.212984,0.0433196,-0.00882524,-0.07406,0.298379,-0.0101298,-0.0551947,0.244178,0.493217,-0.0934276,0.389437,0.457574,0.893196,-0.628721,-0.197194,0.0443012,0.673761,-0.600749,-0.205486,-0.0242486,0.423699,-0.447643,-0.376561,-1.00986,-0.0998145,-0.339249,0.0377569,0.0962526,-0.212873,-0.0358766,0.341194,-0.486485,-0.544884,-0.349057,0.456922,0.190558,-0.315188,-0.71649,-0.127802,-0.119655,0.61744,0.232601,-0.0922203,-0.0552402,0.534469,0.354665,-0.165248,-0.309291,0.993931,0.428815,0.206859,0.117078,-0.348399,-0.164648,0.32773,-0.605644,-0.653165,-0.487076,0.0495867,-0.325584,-0.228455,0.633435,0.450687,-0.212324,0.209704,-0.599195,0.254848,-0.104774,0.00680078,1.01619,-0.123669,-0.417161,-0.14209,0.673934,0.250218,-0.212161,-0.223602,-0.0635566,0.0399024,-0.747445,0.274143,-0.114088,-0.0800169,0.616083,-0.13975,0.79033,-0.406074,0.069085,0.0326023,-0.0408326,0.823617,0.250836,-0.290929,-0.0187711,0.0810641,-0.69259,-0.0033886,0.310561,1.25018,-0.587581,0.214518,0.176133,0.00065894,0.563541,0.160108,0.652841,0.261346,-0.0398279,-0.290826,-0.175831,0.00866429,-0.0949641,0.121194,-1.22376,0.454784,0.754986,-0.13288,0.488795,0.441457,-0.411458,0.147728,-0.0654117,-0.774338,-0.509281,0.288513,0.154464,0.16901,-0.00440543,-0.269827,-0.623163,0.389514,0.237645,0.367959,-0.613633,-0.847474,0.194811,-0.363842,-0.180598,0.154318,-0.00533694,-0.181414,-0.17516,-0.502098,1.10473,-0.018443,0.458107,0.134407,-0.0816211,-0.0448536,-0.0362354,-0.109208,-0.782093,-0.513572,0.0807949,-0.175915,-0.308212,0.428162,-0.752586,0.671329,0.944817,-0.619854,0.60277,-0.407857,-0.198657,-0.230083,0.121848,-0.083602,0.123542,-0.40289,-0.239902,-0.0658935,0.678787,0.0877118,-0.200573,0.875443,-0.193273,-0.076849,-0.365621,0.12723,-0.593154,0.215103,0.539101,0.325344,0.289185,0.146384,-0.0800552,-0.815607,-1.18017,0.338939,-0.187581,-0.108999,0.348883,-0.389678,0.584943,-0.14723,-0.0610612,-0.0612672,0.364359,-0.494727,0.19257,0.264704,0.612516,-0.0299224,-0.459173,0.13536,-0.4757,-0.946459,-0.716215,-0.272618,0.0573173,-0.440524,-0.464589,0.23937,-0.228659,0.62105,0.189832,0.0949086,-0.390283,-0.0915735,0.00488655,-0.301781,0.1458,-0.146088,0.216154,-0.5238,0.169067,-0.0345907,0.24893,0.0373993,0.66581,0.0018747,-0.185473,-0.113042,-0.240847,0.288365,-0.0916987,-0.248021,0.170369,0.354714,0.412758,0.595579,-0.533817 +3421.2,0.443036,0.0912059,4,1.51844,1.10775,-0.33116,-0.152796,-0.0277572,-0.0599092,0.108812,0.346432,0.0300603,0.580679,-0.3094,-0.218693,-0.105969,0.313618,0.134285,1.24981,0.217043,-0.447802,-0.355462,-0.750842,-0.445537,-1.25609,-0.863399,0.0569666,-0.179528,-0.177449,0.394983,0.330452,-0.371596,-0.151296,0.498631,0.058999,-0.0811294,-0.0897744,0.170172,0.0576474,-0.558091,0.774889,0.923769,-0.256302,1.24033,0.98972,-0.120826,-0.933959,-0.05809,-0.181899,-0.892347,0.319425,0.699326,0.0326389,0.559287,0.287554,0.438048,-0.357703,1.19315,-0.224342,0.215878,-0.917977,0.582183,-0.38296,0.422874,1.29439,-0.552329,-1.44695,0.213131,-0.0655137,-0.115765,0.00800372,0.507314,-0.209864,0.01341,0.806972,0.526655,0.0982537,0.095361,0.553197,0.706308,-0.63691,-0.0516032,-0.133941,0.591693,-0.381278,0.0420888,0.138075,0.366085,-0.255845,-0.119281,-0.651007,-0.262583,-0.651951,-0.0458967,0.121334,-0.223345,0.050937,0.184211,-0.326662,-0.225399,-0.202804,0.489759,0.255276,-0.332029,-0.459991,-0.0621983,-0.231644,0.40127,-0.12875,-0.127306,-0.0696595,0.426844,0.0927136,-0.00704234,-0.339322,0.871929,0.566389,-0.00275546,0.0607375,-0.12257,-0.0711494,0.0866037,-0.366771,-0.953361,-0.311925,0.0316405,-0.202154,-0.270732,0.475439,0.363784,-0.286349,0.160702,-0.696217,0.188676,-0.0534167,0.0400079,0.691636,0.0368535,-0.519487,0.327051,0.518986,0.457633,-0.522935,-0.129127,-0.219537,0.276749,-0.465874,0.286089,-0.0679985,0.0766947,0.353928,-0.193708,0.469786,-0.433432,-0.105632,0.120573,0.475649,0.767902,0.0327673,-0.250102,-0.223895,-0.0762663,-0.522764,-0.108857,0.541877,0.962635,-0.505594,-0.0105363,0.00339482,-0.304792,0.663306,0.0553186,0.595369,0.0997133,-0.282072,0.0146913,-0.105728,0.0707895,0.159754,-0.127388,-1.00985,0.108035,0.515613,0.167307,0.192274,0.0252202,-0.549139,0.0233455,-0.168209,-0.729846,-0.45954,0.192068,0.0902367,0.0109935,-0.0484308,-0.404998,-0.330175,0.174073,-0.0120185,0.272835,-0.526991,-0.994036,-0.0488422,-0.2449,0.0352824,0.0256349,-0.380386,-0.288887,-0.367371,-0.48081,0.896551,0.212762,0.514257,-0.10217,0.0480348,-0.00432145,0.165653,-0.168926,-0.394446,-0.639448,-0.0327169,-0.0820532,-0.605526,0.542065,-0.565561,0.506618,0.797534,-0.552906,0.588913,-0.119417,-0.102937,0.0499325,0.277284,0.18504,-0.0653905,-0.486788,-0.223429,-0.0617413,0.55728,0.26606,0.0834307,0.68192,0.188944,-0.278978,-0.130768,0.303997,-0.506716,0.0632979,0.414626,0.321332,0.00536391,0.102711,-0.268308,-0.690954,-1.12004,0.300564,-0.0836583,-0.342477,0.287461,-0.429378,0.334603,0.245932,-0.18027,-0.334539,0.29307,-0.125217,0.202585,0.574931,0.540858,0.193269,-0.607497,0.178438,-0.540048,-0.790632,-0.553599,-0.442417,-0.104823,-0.139198,-0.398234,0.236392,-0.423563,0.324268,0.617468,-0.145612,-0.399677,-0.404058,0.0182878,-0.238293,0.0777715,-0.216115,0.11422,-0.139669,-0.108706,0.00788134,0.199285,0.0772923,0.956015,-0.165157,-0.325013,-0.12771,-0.522684,0.537327,-0.161607,-0.4955,0.157104,0.380021,0.396364,0.616458,-0.0139735 +3417,0.681366,0.0912059,4,1.37475,0.952546,-0.781506,0.102829,0.61589,-0.00851507,0.460841,0.2199,0.761345,0.265267,-0.321877,-0.283945,-0.361483,-0.362655,-0.11387,1.01989,-0.129832,0.175857,0.336064,-0.0116562,0.0195869,-1.24476,-0.707832,0.329702,-0.0572584,-0.140013,0.0188745,0.446897,-0.461404,-0.0952897,0.569119,-0.289461,0.103815,0.593804,0.266857,0.363707,-0.728857,0.747078,0.810454,0.281659,0.844836,0.989019,1.07192,-0.507873,0.149646,-0.22556,-0.224553,-0.0661331,1.30609,0.179019,0.535672,0.650605,0.338134,-0.397596,1.2364,0.509188,0.083127,-1.45435,0.926676,0.174486,0.235257,1.22274,-0.359427,-0.668339,0.484069,-0.03967,-0.117178,0.0286543,-0.335522,-0.723109,-0.368584,-0.0154956,0.998427,-0.113801,0.448019,0.393274,0.411357,-0.0467335,0.168515,0.0832365,0.991892,0.141556,-0.14598,-0.0872933,0.00395148,-0.199652,0.376616,0.252939,0.505927,-0.0413324,-0.223881,0.311104,-0.308375,0.101952,0.227561,-0.637977,0.0750837,0.0227029,0.0225313,0.611478,-0.272919,0.0660654,0.417204,-0.151401,0.322066,-0.434735,0.698576,-0.698596,0.153199,0.18192,-0.0685787,-0.217161,-0.235095,0.203766,-0.355279,0.507445,0.120605,-0.043677,0.642478,0.22717,-0.414898,-0.149764,-0.230924,-0.0214876,0.126412,-0.268667,0.114073,0.313802,0.604103,0.198187,-0.294933,0.418517,-0.32121,0.17562,-0.00901025,-0.216336,0.176062,-0.384357,0.235749,-0.131048,-0.557192,-0.233793,-0.383636,-0.81714,-0.0970711,0.0988928,0.253035,0.569786,0.0307841,-0.661225,0.235831,0.0743903,-0.165685,-0.679707,0.612068,0.203172,-0.0902976,0.301103,0.331652,0.115195,-0.00553057,0.637045,0.828031,-0.512131,0.313952,0.214396,-0.374189,-0.124987,-0.279494,-0.517454,0.354049,-0.0423568,0.0498442,0.0526185,-0.38811,-0.384473,-0.403219,0.142372,0.161769,0.664939,-0.0908959,-0.201016,0.196675,-0.133934,0.229851,-0.471797,-0.874197,-0.140937,0.343365,-0.229228,0.383396,-0.207111,-0.264064,-0.516941,-0.171415,0.0565436,0.0598721,-0.495436,-0.420285,0.104338,-0.355516,-0.661268,-0.0903317,-0.22416,0.398601,0.233518,-0.147854,0.959751,0.12704,-0.419497,-0.142134,-0.120069,0.435556,0.0168677,-0.0552641,-0.178216,0.248255,0.505198,-0.00474495,-0.305554,0.0680292,-0.677487,-0.0371203,-0.038002,0.134337,0.0467356,-0.26431,-0.158488,0.521384,0.195202,-0.224367,0.320752,0.125954,-0.178982,0.127093,0.146549,-0.172174,0.485823,0.126083,-0.327862,-0.156276,-0.316749,-0.160458,-0.37315,-0.0747717,-0.044402,0.526601,0.309825,-0.0927241,0.089032,-0.065732,-0.357242,0.188614,-0.560249,-0.35825,0.445235,-0.792124,0.282956,0.0506965,-0.326993,0.560479,0.322338,0.261745,0.0911345,0.294342,-0.00362632,-0.316317,-0.172506,0.23771,-0.161069,-0.00634646,-0.572665,0.338272,0.208243,-0.283762,-0.289155,-0.0694056,0.140093,-0.188192,0.563716,0.437647,-0.329039,-0.150417,0.755275,-0.190723,0.23552,0.245079,0.0276827,-0.00261727,-0.345843,-0.0753335,-0.128217,0.159936,0.906049,0.10286,-0.629095,0.180387,-0.321927,-0.312126,-0.116319,0.359423,0.144018,0.386278,0.379497,0.621512,-2.03869 +3419.6,0.995935,0.0912059,4,1.41939,0.97395,-0.903749,0.10706,0.627206,-0.0594596,0.45728,0.107827,0.628271,0.198584,-0.32264,-0.283314,-0.255309,-0.197446,-0.298353,1.07876,-0.0695623,0.0966833,0.240715,-0.194705,-0.0510964,-1.65389,-0.804819,0.4623,-0.138662,-0.0649965,0.0306843,0.361117,-0.472419,-0.236625,0.594634,-0.258754,0.0322236,0.458745,0.246098,0.322192,-0.698245,0.839098,0.791834,0.162208,0.750831,0.944285,1.11786,-0.703612,0.168692,-0.184648,-0.345771,0.0121016,1.25838,0.0996388,0.556277,0.656214,0.331713,-0.461169,1.3167,0.502979,0.0424064,-1.39895,1.01814,0.172266,0.129709,1.24233,-0.325471,-0.866119,0.330646,-0.269234,-0.256532,0.0325415,-0.250222,-0.567787,-0.263,0.0749644,0.994592,-0.15474,0.41473,0.472608,0.336623,-0.0757164,0.0789883,0.0811838,0.978949,0.0888735,-0.0651037,-0.124424,-0.158623,-0.0658463,0.385367,0.200885,0.547637,0.0692587,-0.0768286,0.159049,-0.257921,0.12543,0.285849,-0.778078,-0.244345,-0.014773,0.113322,0.636188,-0.191696,0.157202,0.316605,-0.0838631,0.384146,-0.407264,0.70584,-0.731023,0.200028,0.302306,-0.250376,-0.278266,-0.234425,0.296258,-0.403883,0.551457,0.0280501,-0.156874,0.527909,0.248282,-0.537309,-0.339184,-0.271773,0.106426,0.147327,-0.283159,0.124714,0.286819,0.660724,0.352678,-0.141211,0.4679,-0.443446,0.232405,0.0403341,-0.235413,0.116436,-0.331613,0.183554,-0.135409,-0.609033,-0.175539,-0.401348,-0.752906,0.0492095,0.0198414,0.336563,0.448787,0.193067,-0.490531,0.104312,-0.154511,-0.0124293,-0.633806,0.528253,0.323728,0.132154,0.477175,0.365847,0.195791,-0.0154813,0.62279,0.940033,-0.565423,0.356259,0.368381,-0.349744,0.0136099,-0.292348,-0.409544,0.347585,-0.0541339,0.00383405,-0.0516564,-0.343164,-0.300817,-0.338587,0.0143377,0.296292,0.664261,0.0713244,-0.313571,0.107114,-0.220227,0.228849,-0.369802,-0.927053,-0.101748,0.166013,-0.242809,0.399842,-0.150701,-0.139606,-0.513032,-0.26589,0.0319126,0.069884,-0.386876,-0.43956,-0.0604041,-0.375258,-0.569242,-0.0484693,-0.224297,0.463682,0.203795,-0.138552,1.02523,0.2211,-0.412165,-0.142202,-0.239638,0.302797,0.147645,-0.203417,-0.148227,0.207189,0.422653,-0.0252621,-0.405341,0.146936,-0.645711,-0.0590205,-0.309669,0.190778,0.0423495,-0.308858,0.00530297,0.347541,0.144896,-0.0384604,0.328257,0.0215718,-0.0717193,0.0953711,0.194117,-0.0446682,0.300603,0.00638564,-0.477353,-0.0894329,-0.357852,-0.15695,-0.486189,-0.0368679,-0.166564,0.655582,0.534636,0.0645461,0.203991,-0.128964,-0.278726,0.137169,-0.839191,-0.347551,0.292739,-0.760705,0.038503,0.214031,-0.418339,0.435912,0.257318,0.220211,0.105365,0.527107,0.165016,-0.389742,-0.207368,0.211388,-0.144456,-0.0295283,-0.41846,0.280603,0.153696,-0.432659,-0.443757,0.0511889,0.25042,-0.0253967,0.694425,0.426781,-0.296585,-0.11489,0.820526,-0.262099,0.281295,0.297131,-0.195362,0.0295196,-0.329705,-0.0541705,-0.0778517,0.092594,0.899091,0.102772,-0.607142,0.0446622,-0.214793,-0.271978,-0.151757,0.128482,0.139828,0.363992,0.373936,0.603317,-1.99651 +3406.28,0.688536,0.0912059,4,1.44019,0.826411,-0.876567,0.122252,0.610824,-0.103268,0.452641,-0.112814,0.744031,0.155221,-0.284525,-0.296268,-0.182238,-0.329533,-0.372534,0.989192,-0.218017,0.168824,0.428366,-0.0443954,-0.034784,-1.59024,-0.759603,0.528426,-0.250429,-0.138645,0.108326,0.385197,-0.562627,-0.288831,0.449393,-0.094352,0.0159903,0.462245,0.145057,0.225586,-0.584391,0.856036,0.620382,0.111785,0.789848,1.05453,1.14889,-0.653534,0.188858,-0.0106657,-0.389689,0.0868804,1.3212,0.225891,0.566016,0.794113,0.263761,-0.383936,1.36989,0.526768,0.144741,-1.17595,1.19477,0.166898,0.0541338,1.18975,-0.377518,-1.08002,0.416724,-0.355314,-0.267085,0.0979765,-0.117766,-0.653647,-0.242157,0.0479328,0.940149,-0.257343,0.540653,0.394796,0.264625,-0.0581025,0.0226398,0.171168,1.03146,0.117616,-0.0347349,-0.125371,-0.21355,-0.097097,0.32312,0.178973,0.362026,0.0446269,-0.0232735,0.142385,-0.458588,0.0307526,0.344661,-0.975189,-0.21178,0.0461437,0.158685,0.575154,-0.332044,0.0408319,0.156436,-0.0488142,0.354504,-0.556237,0.632107,-0.661547,0.281499,0.293716,-0.131744,-0.279585,-0.0865279,0.293936,-0.47856,0.574162,-0.291201,-0.139311,0.489475,0.234413,-0.49075,-0.295766,-0.180221,0.0342959,0.104991,-0.127933,-0.00484193,0.377972,0.528539,0.372308,-0.199426,0.441039,-0.458992,0.17592,0.132623,-0.314392,0.0861243,-0.302054,0.237251,-0.0281127,-0.744286,-0.147748,-0.324691,-0.82127,-0.0087794,0.167527,0.00289314,0.525289,0.0999438,-0.50345,0.051709,-0.192486,0.033941,-0.619063,0.369249,0.138261,0.313121,0.584142,0.233994,0.0130399,-0.0904533,0.558848,0.937115,-0.498223,0.363587,0.493936,-0.447937,0.0394588,-0.343134,-0.260856,0.429353,-0.0150366,0.0615074,0.0127468,-0.279615,-0.343767,-0.224768,0.0851238,0.311806,0.778649,0.103719,-0.205141,0.0851684,-0.139854,0.278759,-0.0946013,-1.19536,-0.13952,0.0617585,-0.353765,0.435736,-0.130911,-0.173601,-0.522311,-0.240529,-0.229893,0.0629995,-0.303645,-0.516224,0.0442857,-0.322839,-0.706515,0.032776,-0.130842,0.413537,0.0743185,-0.0722015,1.10115,0.0851638,-0.243786,-0.117915,-0.141291,0.457323,0.1797,-0.318042,-0.270939,0.178464,0.400984,0.049877,-0.387685,0.0760995,-0.712111,-0.11088,-0.288859,0.147818,0.0459825,-0.178834,-0.0739639,0.314225,0.270455,0.00547505,0.411684,0.030468,0.080009,0.00637207,0.27048,-0.0423494,0.290446,0.084145,-0.455772,0.212385,-0.303321,-0.231703,-0.261361,-0.0183319,-0.195428,0.791819,0.593102,-0.0795647,0.295916,-0.0722066,-0.437079,0.203313,-0.768734,-0.319385,0.271296,-0.624467,-0.0137909,0.215631,-0.472129,0.372292,0.25653,0.141619,0.172578,0.523769,0.0200596,-0.247824,-0.159132,0.0369552,-0.154634,0.0727805,-0.419564,0.111926,0.1723,-0.564118,-0.34074,0.0266477,0.11154,0.0334836,0.728561,0.550521,-0.311164,0.0106483,0.567441,-0.260393,0.244769,0.193145,-0.202326,-0.051612,-0.268715,-0.245962,-0.0252576,0.0626851,0.775023,0.0651567,-0.564377,0.111064,-0.0539767,-0.179097,-0.114454,-0.221357,0.147458,0.37786,0.384003,0.614703,-1.67823 +3405.59,0.970221,0.0912059,5,1.38231,0.955113,-0.709457,0.157171,0.353324,0.00277259,0.408057,-0.0290129,0.814745,0.393181,-0.146453,-0.374198,-0.404744,0.228414,-0.0853523,1.05214,0.179242,0.163134,0.207362,-0.0681589,-0.261622,-1.38476,-0.619556,0.483294,-0.28049,0.0257576,0.0820766,0.413634,-0.731326,-0.442983,0.525053,-0.35492,0.232559,0.659276,0.135476,0.353126,-0.506944,1.06332,0.851571,0.180249,1.02079,0.943972,0.683642,-0.99401,0.209557,-0.0415687,-0.294297,0.276994,0.806269,0.252445,0.651395,0.555787,0.310659,-1.07111,0.93911,0.482851,-0.144962,-0.7966,0.89246,-0.0205734,0.0405256,1.45484,-0.373769,-1.64128,0.232484,0.00137337,-0.281065,0.122395,-0.306347,-0.373394,0.17056,0.276315,0.928847,-0.0888642,0.1239,0.366823,0.556542,0.352163,0.0350545,0.0663579,1.0103,-0.463386,-0.18413,-0.106904,-0.114575,0.084698,0.165206,0.303773,0.638068,0.0200539,0.0689934,0.0239271,-0.511625,0.192827,0.00740597,-0.690728,-0.452253,0.0278926,0.307859,0.508081,-0.582023,0.226804,0.213203,0.165455,-0.0158956,-0.476836,0.67425,-0.464613,0.410202,0.247778,-0.0787761,-0.0937186,-0.117285,0.459434,-0.327438,0.371101,-0.372452,-0.175539,0.445976,0.290366,-0.609934,-0.2239,-0.251065,0.0891577,-0.136973,0.109772,0.566837,0.429372,0.512595,0.354414,-0.0736232,0.347809,-0.732336,0.17384,0.159774,-0.350476,-0.420211,0.118964,0.380199,-0.297855,-1.10261,-0.259123,0.258459,-0.611955,0.0247944,0.344236,-0.194687,1.06844,0.549679,-0.296261,-0.319127,-0.383655,0.105865,-0.599407,0.287914,0.231828,0.454568,0.350933,0.173365,0.0820774,-0.22533,0.250976,0.786881,-0.647564,0.054691,0.247207,-0.155956,-0.185406,-0.796409,-0.687768,0.27151,-0.186061,-0.0790324,-0.326309,-0.213948,-0.000850793,-0.0860268,0.274548,-0.155139,1.08195,0.0795499,-0.126403,-0.0419594,-0.048872,0.335896,-0.0666435,-0.741865,-0.0313377,-0.0413785,-0.254993,0.409035,-0.137887,-0.0495182,-0.612228,0.0296512,0.209933,0.157751,-0.406875,-0.587235,-0.140449,-0.572705,-0.171229,-0.126043,-0.54469,0.185097,-0.0125914,-0.265155,1.32552,0.418597,-0.0696608,-0.0110023,-0.205723,0.113198,0.435753,-0.377944,0.136915,-0.15056,0.569039,-0.245521,0.0718934,-0.0993004,-0.679425,0.00130452,0.0894787,0.0616706,0.0837423,0.0523459,-0.174108,0.582972,0.448431,-0.014765,0.0245553,-0.137529,-0.148697,-0.279609,0.0601603,0.004132,0.512612,0.605603,-0.405828,0.407396,-0.214281,-0.851222,-0.226265,0.264093,-0.239556,0.624008,0.413644,0.233147,0.193967,0.185378,-0.142917,0.321987,-0.447513,-0.415578,-0.074731,-0.691753,-0.413665,0.172248,-0.368313,0.489878,-0.0769976,0.159992,-0.11194,0.612146,0.0178431,-0.263167,-0.10364,-0.0181207,-0.135452,-0.225265,-0.242377,0.173608,0.219412,-0.413772,0.135371,-0.149024,-0.172457,0.489059,0.584291,0.304297,0.158895,0.202529,0.493288,-0.142687,0.258783,-0.114383,-0.187482,0.23128,-0.279759,0.158698,0.303754,0.18664,0.431837,0.123188,-0.45785,0.0191614,-0.108881,0.309854,0.113311,-0.173334,0.123792,0.376155,0.351841,0.613315,-1.25623 +3416.77,0.72013,0.0912059,4,1.38255,0.967894,-0.884747,0.22882,0.740236,-0.0192482,0.53057,0.111657,0.621236,0.415722,0.214382,-0.280824,0.0291367,0.170678,-0.153298,0.929562,0.183581,0.0286565,-0.0523997,-0.0559641,-0.129032,-0.483797,-0.306965,0.18466,0.0261511,0.17167,0.297224,0.659799,-0.342593,-0.0979116,0.501573,0.0512965,0.412383,0.488365,-0.114884,0.019246,-0.154351,0.259472,0.513851,0.141701,1.31192,1.15717,-0.263943,-0.195657,0.245833,0.194069,0.0224433,0.281761,0.774616,0.378711,0.316298,-0.251189,-0.45844,-0.166753,0.610381,-0.0140955,0.414539,-0.881176,0.748418,-0.449343,0.784903,0.846268,-0.190042,-0.773648,0.408417,-0.0851009,-0.27766,-0.382945,0.0313155,-0.74984,-0.0563074,0.168086,0.77354,0.140177,0.983027,0.325997,0.299901,0.153039,-0.0430018,0.142566,0.563693,-0.681721,0.000570992,-0.297945,-0.710993,0.291052,-0.118964,-0.210465,0.0641487,-0.0132411,-0.199769,-0.0917952,-0.310936,0.309287,0.101255,0.176596,0.541699,0.0129499,-0.363403,0.293076,-0.557538,-0.124335,-0.221619,0.0220813,0.00370988,-0.366496,0.215649,-0.172353,0.100205,0.329632,-0.45441,0.0337971,0.530992,0.628854,0.145981,-0.0495428,-0.110552,0.0103667,0.418619,0.150405,-0.890045,0.113406,0.329793,-0.409345,-0.00769486,0.39267,-0.0658813,-0.018088,0.143918,-0.39724,0.7942,0.116292,0.126382,0.513991,-0.313125,-0.167627,0.163834,-0.0101611,0.399468,-0.344111,-0.618691,-0.243677,-0.0195934,-0.569705,0.125848,-0.155056,0.174402,0.47939,-0.195453,-0.360614,0.252756,0.280627,0.257403,0.207337,0.624665,0.580924,-0.00770853,-0.194493,0.185159,-0.131353,0.749176,0.471043,0.373359,0.380788,-0.0797696,0.173044,-0.34932,0.398874,-0.14678,0.996153,0.978329,-0.410786,0.340693,-0.0687395,-0.125628,0.379124,-0.106777,0.171762,0.408674,0.422735,-0.183373,-0.276704,0.432687,0.0742983,0.336163,-0.437237,0.0492555,-0.0517406,0.845165,-0.51552,0.180893,0.0333462,0.217021,-0.685779,0.133443,-0.237569,-0.263703,-0.382484,0.0734662,0.445809,-0.0951978,-0.483132,0.135566,0.0322688,0.31957,0.22617,-0.651506,1.04921,-0.0751934,0.186792,-0.140653,0.117294,0.445124,0.173754,-0.829298,-0.380633,-0.258734,0.201028,0.244759,-0.148317,0.399537,0.0100585,-0.603251,0.203747,0.0367482,0.422266,-0.686729,0.193356,-0.0892344,-0.0177738,-0.142954,0.407736,0.00911178,-0.234413,-0.265491,0.758608,0.0394731,0.351761,0.54546,-0.0218767,-0.334701,-0.167564,0.146431,0.0454072,0.183298,0.34507,-0.06981,0.381547,0.729082,-0.686304,0.0341734,-0.757238,0.162523,-0.49549,0.511883,0.21451,-0.447203,-0.0779903,0.0950186,-0.157759,-0.0126652,0.126559,-0.0330339,-0.282944,0.577917,-0.0183285,0.237967,0.0127805,-0.0949828,-0.306554,0.0761109,-0.00788267,-0.033421,0.660377,0.444207,0.699318,-0.325341,0.0548189,0.582337,0.100352,-0.753873,-0.221916,0.0501977,-0.474295,0.108688,0.0752182,-0.279975,0.677531,0.356952,-0.135788,0.0657609,-0.336038,0.143199,0.320069,-0.0896921,-0.515758,-0.464634,-0.129092,-0.219711,-0.26691,0.356638,0.135475,0.326226,0.368069,0.571162,-2.53339 +3402.16,0.883813,0.0912059,4,1.43105,0.995377,-0.462307,0.0306553,0.987564,0.0478363,0.209804,0.361307,1.26683,0.0569099,0.393607,-0.217547,-0.122661,0.24773,-0.116443,0.779841,0.0765568,0.377622,0.0594523,-0.341344,-0.0897242,-0.990336,-1.14462,0.17953,0.37806,-0.115819,0.0151876,0.326647,-0.280642,0.256438,0.74867,0.014491,-0.205328,0.611569,0.242467,-0.375032,-0.653224,0.447953,0.776752,0.248974,1.25256,0.780856,-0.0280052,-0.764111,-0.0977267,-0.213674,0.131638,0.0499977,0.5952,0.39578,0.0816695,0.565745,0.0631443,-0.619169,0.894441,-0.279363,0.490415,-0.645078,0.642851,-0.392266,0.184506,1.29379,-0.762233,-1.62473,0.0977996,0.113404,-0.259915,0.0168846,0.473103,-0.491487,0.0903712,0.298856,0.723746,0.0340884,0.860466,0.36695,0.149946,0.413981,-0.428202,-0.248383,0.470182,-0.256694,0.357792,-0.333357,0.0112874,-0.0572721,0.0677195,-0.713549,0.105784,-0.486744,-0.261488,0.523166,0.098368,0.0705815,0.0463651,0.601241,0.0239596,0.329749,-0.356677,0.123103,-0.360059,0.135732,-0.425016,0.497194,0.308923,-0.466912,0.38893,-0.968858,0.264683,0.627829,-0.160109,0.0607127,0.00775918,0.874876,-0.462101,-0.033901,-0.329884,0.0499393,0.295045,0.0950038,-0.415458,0.547764,-0.471841,-0.178714,-0.35521,0.065368,-0.362851,0.14238,-0.0651733,-0.464433,0.836496,0.0782584,-0.212602,0.436021,-0.0938205,0.137631,-0.0339446,0.402805,0.150125,0.101626,-0.544598,0.0264074,-0.341027,-0.17683,0.128514,-0.25716,-0.421916,0.85916,0.00910015,-0.232531,-0.46652,-0.0121326,0.204828,-0.112894,0.856607,0.72189,-0.00169623,0.185692,-0.0210161,0.150918,0.720272,0.283727,0.774319,-0.112903,-0.172225,0.202504,0.0903235,0.256222,0.294048,0.0694915,0.710169,-0.377912,0.264031,0.190882,-0.0748683,0.288218,-0.186861,0.00394589,0.21423,0.582158,0.0748913,0.0503164,0.317102,-0.509035,-0.210363,-0.288681,-0.387007,-0.401341,0.272883,-0.695615,-0.0809954,-0.26804,-0.0462168,-0.432473,0.0287749,-0.429568,-0.0815368,-0.434344,-0.594466,0.105044,-0.339139,-0.489925,0.260186,-0.314478,0.387626,-0.163152,-0.132058,1.17523,-0.0655423,0.20983,-0.271877,-0.488384,0.386849,0.396511,-0.393452,0.0603974,-0.174029,0.24478,-0.0703673,-0.261507,0.614405,0.101454,-0.512876,-0.262163,-0.111711,0.322648,-0.354894,-0.595846,0.782893,0.388863,-0.216342,0.568692,0.0674779,-0.421157,-0.211031,0.554344,0.560902,0.0168321,0.749126,-0.607082,0.0693555,-0.236643,0.109868,0.125873,0.196877,0.615711,0.144207,-0.0357988,-0.579226,-0.247524,-0.0116474,-0.735318,0.571511,-0.494957,-0.191838,-0.246768,-0.104412,0.181038,0.0395824,-0.00643131,-0.08451,0.294788,-0.290131,-0.555596,0.573516,-0.0865292,0.105504,-0.641492,0.0649635,-0.529016,-0.0359467,0.267503,0.292587,0.699934,0.334247,0.2831,-0.3311,-0.308952,1.35828,-0.0311344,-0.877387,-0.35559,0.0895074,-0.0771959,-0.00659424,0.409096,-0.306193,0.241328,0.189378,0.22117,0.235091,0.341224,-0.404232,-0.232665,0.0185102,0.079412,-0.518456,-0.434316,0.717467,-0.597918,0.0126681,0.1478,0.366152,0.384448,0.605105,-3.40536 +3409.66,0.709382,0.0912059,4,1.47217,0.839126,-0.601059,0.197565,1.03286,-0.126133,0.419283,0.593099,0.730303,0.131026,0.462955,-0.232742,-0.315951,0.0989356,0.0595217,0.858184,-0.0205732,0.154454,-0.647656,0.0351609,0.063936,-0.873508,-0.0638505,-0.0377748,-0.274516,0.165583,0.396353,0.9035,0.0196484,0.0234383,0.735403,-0.310605,0.400915,0.588089,0.0529878,-0.428776,-0.611783,0.223996,0.841182,0.182218,1.0253,0.478596,-0.241776,-0.267174,-0.0672683,-0.150901,-0.243614,-0.473781,0.549839,0.219985,0.0222416,-0.496355,0.175669,-0.0103352,0.919814,-0.34297,0.442984,-0.434438,0.793595,-0.928856,0.120253,0.941515,-1.25227,-1.41397,-0.0754533,0.273985,-0.355667,-0.178333,0.0795571,-0.225168,0.1038,0.145067,0.855708,0.539363,0.504171,0.473922,0.363366,0.20347,-0.156484,0.0198861,0.67605,-0.780577,0.444997,-0.287855,0.189885,-0.00843104,0.0661217,-0.716781,-0.0411108,-0.300764,-0.297133,-0.086187,-0.144437,-0.206212,0.915605,-0.127919,-0.0013331,-0.102143,-0.370991,0.330616,0.00128836,-0.0556142,-0.0431801,0.153392,0.336867,-0.344599,0.383194,-0.546973,0.137209,1.04568,0.584595,-0.129737,-0.150245,0.624105,-0.419412,0.0150964,0.0182133,0.00295796,0.622891,-0.198961,-0.200554,0.458071,-0.462894,0.225723,-0.403872,-0.321325,-0.164654,0.121915,-0.0203494,-0.647204,0.112748,-0.173654,-0.981018,0.348649,-0.630211,-0.457379,0.00761132,0.215514,0.486128,-0.0678696,-0.571959,-0.0782879,0.197911,-0.463882,-0.337226,-0.00435552,-0.353989,0.738287,-0.0815633,-0.257647,-0.00379361,0.280897,0.617581,0.268567,0.597375,0.306916,0.317427,0.144352,-0.382366,0.161775,0.828967,0.139679,0.877116,0.0451293,-0.111976,0.0505214,-0.113581,-0.220344,0.0607379,-0.158941,0.420193,-0.572365,0.450981,0.254174,-0.0262263,0.142475,-0.0665592,0.43077,0.0267969,0.416608,0.0298328,-0.228133,0.0606127,-0.0175747,0.0222166,-0.705344,-0.363995,-0.366018,0.158004,-0.208392,-0.281426,-0.340255,0.362493,-0.20172,-0.35683,-0.115252,0.400935,-0.339368,-0.43247,0.348437,0.0857753,-0.47022,0.0957299,0.236464,-0.319409,-0.0347792,-0.0483723,0.794086,-0.0305081,0.526037,0.16596,0.118053,0.527143,0.935215,-0.322975,0.0590722,-0.0619055,0.325895,-0.0646586,-0.172001,0.307668,-0.360887,-0.0960151,0.132917,-0.421249,0.262931,-0.230372,-0.428169,0.0173941,0.0853927,0.118069,0.341895,0.113028,-0.328956,-0.43278,0.34528,0.244359,-0.173855,0.346545,-1.05451,-0.194867,-0.357302,0.462964,-0.201888,0.0879882,-0.105571,0.20751,0.335244,-0.585789,-0.474682,-0.0307241,-0.441898,0.340732,-0.0656297,0.730045,-0.0610239,-0.479493,0.0839793,-0.347578,0.226239,0.399736,0.630561,0.0543446,-0.22042,0.435286,-0.208043,0.0532799,-0.218007,0.391126,0.0155186,-0.0453434,-0.0601321,-0.378027,0.184932,0.142469,0.00464599,-0.395238,0.104256,0.640256,-0.21218,-0.311234,-0.425119,0.129691,0.106229,0.17311,0.0721173,-0.149656,-0.20592,0.102402,-0.279064,0.175482,0.29795,-0.527439,-0.10041,0.253284,-0.169019,-0.710007,-0.282298,0.00876372,-0.673913,0.330344,0.136302,0.40722,0.369191,0.638138,-3.28027 +3421.89,0.977362,0.0912059,4,1.49633,0.764268,-0.239802,0.140768,0.705885,0.0708263,-0.116007,0.348228,0.516408,0.148709,0.315349,0.438985,0.327834,0.155664,-0.267321,1.12137,0.792503,0.439601,-0.321742,-0.332968,0.176537,-0.781772,-0.911551,0.139045,-0.0170868,-0.14243,-0.128396,0.820399,-0.294224,0.688537,1.17615,-0.309813,-0.156346,0.552478,0.184011,-0.178221,-0.34004,-0.0927268,0.504223,-0.171818,0.863257,0.0615672,-0.0440908,-0.719742,0.272677,-0.113227,-0.789827,-0.204393,0.600648,-0.0184673,-0.336362,0.0564261,0.353054,-0.753824,0.978218,-0.365729,-0.0447942,-1.18768,0.542731,-1.18761,0.277811,1.2808,-0.639772,-2.01022,-0.239792,-0.0272453,0.0170537,-0.210749,0.100682,-0.495377,-0.286636,0.197674,0.51105,-0.0476845,0.341834,0.0387972,0.288832,0.318635,0.119595,0.320383,0.397697,0.0839081,0.246373,0.0745888,-0.13866,0.266632,-0.304301,-0.0845379,-0.209952,-0.292951,-0.203383,0.461366,0.279009,-0.107376,-0.452584,0.176005,-0.0407136,-0.811669,0.390045,0.444102,-0.0121368,-0.370805,-0.187393,-0.426265,0.239207,-0.380108,-0.0422342,-0.00773673,0.308559,0.52446,-0.946826,-0.321808,0.112145,0.681165,0.440153,0.0923914,-0.154436,0.308771,0.20031,-0.179997,-0.773067,-0.446051,0.458518,-0.194402,0.397483,0.0141133,0.463139,0.0599295,0.300932,0.0510432,0.37532,0.457797,0.412264,0.445201,-0.335816,-0.288964,-0.0756741,-0.0382724,0.356254,-0.308921,-0.413681,0.521006,0.0789575,-1.04236,0.266918,-0.0687181,-0.141288,-0.120609,-0.434859,0.00124159,-0.134817,-0.0997426,0.144433,-0.392016,0.465967,0.473842,-0.130856,-0.167989,0.287172,-0.0260112,-0.0380292,0.0860498,0.432676,0.0841217,-0.0187884,0.650399,0.203471,0.00435576,-0.0640983,-0.159538,0.0276135,0.289615,0.00428529,-0.0314935,-0.318327,-0.285762,0.0223876,0.659086,0.307629,0.341228,-0.430873,-0.0767058,0.0141593,-0.41441,-0.245183,-0.866417,-0.172707,-0.248865,-0.295335,-0.0950023,0.211862,0.0190627,-0.425838,-0.67928,0.367044,0.382424,0.196791,-0.221055,-0.41149,-0.379808,0.21779,0.0787312,0.0763523,-0.033069,-0.148012,0.175509,-0.532066,0.774237,-0.215897,0.340145,-0.227415,0.0175748,0.150176,-0.0456362,0.583369,0.463805,-0.673908,-0.0723968,0.14885,-0.208935,-0.0530378,-0.0675254,0.438022,-0.0637178,-0.452992,0.327579,0.192981,-0.477825,0.375962,-0.288259,-0.162228,0.242066,-0.475184,-0.327027,-0.461152,0.704879,0.23128,0.0699082,0.269834,-0.0729424,0.0709894,0.492317,-0.201265,-0.266054,0.42582,-0.170302,0.483062,-0.356351,0.187973,0.379257,-0.0831883,-0.650708,-0.0448367,-0.424886,-0.247533,0.606545,-0.420433,-0.434427,0.770845,0.164784,-0.202489,0.371309,-0.0542795,0.0239655,-0.208704,-0.212877,-0.250671,0.147468,-0.19166,-0.137394,-0.134627,0.196087,0.513157,0.000682214,-0.0431729,-0.517638,0.125111,0.200554,-0.0628896,0.20851,-0.224874,-0.414921,-0.652589,-0.0449447,-0.255976,0.583493,0.0788763,0.857899,0.0836456,0.170929,0.332156,0.251239,0.00735625,0.0427677,-0.137486,-0.277625,-0.240517,-0.476044,0.09324,0.25853,-0.524876,0.133745,0.349822,0.365711,0.591457,-2.22346 +3422.32,0.89695,0.0912059,4,1.59059,0.760901,-0.513896,0.207374,0.547405,-0.0693969,-0.026797,0.207284,-0.312721,0.0557935,0.25038,0.0780821,-0.441655,0.0211906,-0.266899,1.16001,0.2887,0.0209079,0.168367,-0.0543903,0.031117,-0.682664,-0.551851,0.297577,-0.426757,0.0446113,-0.0535738,0.573291,-0.18751,0.254965,1.25945,0.130601,-0.240692,0.651419,0.213054,-0.322381,-0.814423,0.532334,0.411791,-0.254517,0.971644,0.174099,-0.127136,-0.461568,0.0292372,-0.359689,-0.577999,-0.317035,0.0244128,0.33369,0.0965253,0.0970974,0.155663,-0.856887,1.01402,-0.568987,-0.00895924,-0.708399,0.444558,-1.08896,-0.401983,0.88499,-0.61509,-1.18667,0.21123,0.418637,-0.537961,-0.294335,0.30566,-0.147131,-0.1138,0.236459,1.02801,-0.116453,0.078855,0.165192,0.0610716,0.221869,-0.0966146,0.0238492,0.74672,-0.573881,0.394027,0.324561,-0.331978,-0.347211,-0.39585,-0.177948,0.0697934,-0.425683,-0.361694,-0.0739696,-0.104154,-0.37556,0.00318172,-0.538974,0.488008,0.0654396,-0.201608,0.199585,0.0762878,-0.327833,-0.40905,-0.508724,0.177429,-0.167826,0.230192,0.0941544,0.128688,0.737143,-0.751003,-0.282554,0.412376,0.434124,0.215853,0.0764788,0.272088,-0.146611,0.886977,0.353159,-0.524405,0.0310249,-0.481218,-0.0104678,0.0291208,0.249236,0.145363,0.259371,0.136653,-0.715998,-0.257098,0.168639,0.17913,0.0401846,-0.160898,-0.412631,0.0923625,-0.102775,0.303499,-0.294885,-0.544704,0.16328,0.314522,-0.469582,-0.0131199,-0.265936,-0.136397,0.381154,-0.270449,-0.426896,-0.208274,0.250225,-0.0178658,-0.401986,0.376885,0.00102121,0.197286,-0.372536,-0.348273,-0.0530351,0.418083,0.193149,0.589131,-0.585224,-0.12049,0.0649057,0.183827,-0.273062,0.214679,-0.887424,0.0683669,0.0709732,0.386943,-0.27485,-0.238871,0.0924028,-0.0490024,0.0174478,-0.41462,0.0984823,0.0337277,-0.0343914,0.360157,-0.0749567,-0.859963,-0.315979,-0.0161479,-0.151292,-0.223267,0.0553559,0.306432,0.310546,-0.244324,-0.172804,0.0674036,0.317351,0.679008,-0.193047,-0.109006,-0.0772895,0.248583,0.788959,0.264538,0.225818,-0.061343,0.0626662,-0.384549,0.796094,-0.1326,0.516143,-0.163955,-0.400218,-0.10961,0.459957,-0.528133,0.250906,-0.232862,0.0218123,0.407465,0.739986,0.308903,-0.177325,-0.236106,0.242047,-0.393777,0.636101,0.0359421,0.530967,-0.176966,0.170428,-0.410444,0.221558,-0.192042,0.256787,0.24683,0.371529,0.333575,0.265627,0.159993,-1.06182,-0.0185433,0.30768,0.0400912,-0.332324,0.583957,-0.0972346,0.314033,0.0617976,-0.419723,-0.38141,0.47001,-0.778272,0.0115279,-0.227746,-0.346101,0.19408,-0.264637,0.168162,0.150813,0.0352885,-0.116074,0.525518,0.136494,-0.428059,0.0710464,0.0949474,-0.279841,-0.113241,0.00231803,-0.450116,-0.164921,-0.387116,-0.102141,0.0136705,0.00371212,0.332048,-0.00118523,-0.0800437,0.657167,0.581469,-0.0924386,-0.551295,-0.0614835,0.0745508,0.283415,-0.254362,-0.381521,0.337782,0.243019,-0.198662,-0.152211,0.291046,-0.0230956,0.516521,-0.119263,-0.781342,0.146468,-0.05419,0.313369,-0.885998,-0.0557901,0.104309,0.402229,0.322969,0.634215,-1.48122 +3441.8,0.936996,0.0912059,4,1.67167,0.723947,-0.9055,0.385433,0.545293,-0.00628608,-0.0715599,0.336844,0.0847665,-0.0910859,0.209317,-0.143071,-0.26147,0.0865556,-0.253134,1.02445,0.300529,-0.0566865,-0.12528,-0.148544,-0.250071,-0.744148,-0.281002,0.0176492,-0.434949,0.257501,0.023945,0.488515,-0.595666,0.172237,0.970947,-0.137429,-0.475411,0.253833,-0.189032,-0.00497005,-0.459807,0.0287209,0.0704998,-0.376925,0.849329,0.449294,0.358451,-1.00709,0.0294248,0.45316,-0.914517,0.143327,0.197816,0.126034,0.0225968,0.487292,-0.416511,-0.319171,0.630206,-0.700286,-0.404136,-0.897902,0.288585,-0.962907,0.665234,0.989888,-0.921014,-0.888107,0.0931855,0.231268,0.0748034,0.273926,-0.228035,-0.105198,-0.00479468,0.295526,0.862715,-0.418431,-0.19522,0.359814,0.514168,-0.167548,-0.399635,-0.169133,0.179441,-0.503615,0.63121,-0.20811,-0.267924,0.330667,-0.416233,-0.372278,-0.278168,-0.176927,-0.213878,0.136898,-0.0926383,-0.331978,0.401743,-0.584058,-0.023707,-0.34844,-0.148838,0.099926,-0.312207,-0.178637,0.148876,-0.307789,0.253119,-0.0477301,0.468623,-0.484535,0.367731,0.149078,-0.269525,0.172241,0.511376,0.369598,-0.12528,-0.0661374,-0.762961,0.146104,0.576503,-0.105827,-0.28794,-0.170602,-0.100904,-0.165722,0.00102454,-0.337184,-0.213674,-0.0419463,-0.0342822,0.223852,-0.213649,0.598306,-0.0825825,0.2725,0.135977,0.331419,0.267655,-0.153165,0.552264,-0.143332,-0.145449,0.301591,-0.0196603,-0.684423,0.305407,0.10026,-0.269194,0.330291,-0.137792,-0.172855,-0.158627,0.240854,0.338828,-0.17238,-0.0642722,0.273619,0.217458,-0.593156,0.165596,0.174162,0.253616,0.181191,0.129381,0.325793,-0.147727,0.269187,0.135092,-0.457143,-0.281559,-0.563514,0.487962,0.194435,-0.32529,0.180558,-0.0686152,-0.257955,0.0990204,-0.0124658,-0.0829184,0.191749,0.00250922,-0.0932387,-0.0859113,-0.646977,-1.03744,-0.221282,0.247762,-0.4171,0.196589,-0.152512,0.571104,0.502725,-0.58667,-0.494767,-0.158091,0.147284,0.315915,0.255625,-0.126556,-0.354182,0.336508,-0.244747,0.078421,-0.126956,-0.0239916,-0.123882,-0.0536355,0.432148,-0.270043,0.477568,-0.253892,-0.43505,-0.107322,-0.296223,-0.582802,0.154683,0.0364074,0.192657,0.0927738,0.0881587,0.13407,-0.450094,-0.166965,0.169916,-0.359463,0.5889,-0.17177,-0.38486,-0.263594,-0.263838,0.17671,-0.0078563,0.11043,0.144163,-0.11037,0.552149,-0.0589474,-0.0600382,0.342073,-0.647723,-0.503411,-0.231635,0.395642,-0.457971,0.0656301,-0.213785,0.232047,0.120992,0.122036,-0.0305808,0.0329981,-0.433097,0.137589,-0.0555087,-0.312264,0.17074,0.0956699,-0.0646073,-0.160026,-0.0415796,0.0700654,0.300754,0.295044,0.421231,-0.0190341,0.165071,-0.19573,-0.158272,-0.309521,0.0291509,-0.202813,-0.0949937,-0.189856,-0.0503848,-0.311124,-0.0676614,0.139608,0.278213,0.467065,-0.138156,-0.211471,-0.433729,-0.635881,0.0347323,0.176979,-0.0789738,-0.102842,-0.605875,0.234008,-0.325937,0.0451741,0.169622,0.440036,0.367773,0.120552,-0.226871,-0.166729,-0.0587797,-0.0229741,-0.199964,-0.347822,0.111259,0.295004,0.333556,0.543143,-1.30668 +3450.27,0.997452,0.0912059,4,1.64299,0.815799,-1.28749,0.621314,0.342745,-0.117121,-0.227971,0.158155,0.326155,0.290667,0.342355,-0.383521,-0.330569,-0.0312278,-0.188085,1.01945,0.303323,0.16112,-0.301984,0.0199203,-0.191503,-0.949345,-1.30531,-0.0360738,-0.399212,-0.120923,-0.495294,0.309029,-0.887494,0.0984041,1.21201,-0.38884,-0.161002,0.536765,-0.567985,0.0268445,-0.174057,0.100251,0.116592,-0.113305,0.883039,0.547755,0.623421,-1.45425,-0.149882,0.255037,-0.984274,-0.177,0.0241809,-0.445586,0.0662068,0.366038,-0.0297299,-0.431737,0.279833,-0.231004,-0.724758,-0.615287,-0.184563,-0.581315,0.394705,0.981323,-0.509006,-1.56801,0.125745,0.0619937,-0.170315,0.113572,0.080379,-0.274292,0.087685,0.121551,0.79691,-0.281586,0.21079,0.405575,0.327766,0.110917,-0.401756,0.266138,0.578166,-0.505034,0.774185,-0.0228121,-0.194865,0.504781,-0.0603847,0.579422,0.0535343,-0.355422,-0.137246,0.389915,-0.451877,0.169181,-0.287385,-0.202149,0.490812,-0.575613,0.173223,-0.149455,-0.232582,0.0413132,0.234221,-0.0656135,-0.045854,-0.301487,-0.039323,-0.155727,0.562318,0.490534,0.0630788,0.222684,-0.0498441,0.202014,-0.153329,0.435658,-0.238849,0.290657,0.75681,-0.293725,-0.694992,0.0585159,-0.0796073,-0.125496,0.0587693,0.291152,0.390024,0.042547,-0.155319,-0.279661,-0.128428,0.518106,-0.133494,0.37763,-0.05804,-0.118089,0.279564,-0.480679,0.201165,0.0261229,-0.352011,0.221757,0.43209,-0.497693,-0.138728,0.209673,0.018784,0.192757,-0.111175,-0.0283204,0.0997851,0.00666864,-0.288733,-0.303192,-0.155102,0.266806,0.422525,0.209343,-0.0277832,0.213837,0.342605,0.602446,0.404599,0.0276886,0.140485,-0.134662,0.154803,-0.037567,-0.232813,0.361996,0.455049,-0.360061,-0.0407896,0.384115,-0.28883,0.0439676,-0.0258755,-0.341474,-0.134024,0.567253,0.00889157,0.199477,-0.107396,0.518745,-0.479122,0.0116291,0.0769938,-0.790737,0.231527,-0.181748,0.187514,-0.12698,-0.00607516,-0.558848,-0.221382,0.534062,0.334301,0.0930595,-0.21445,-0.0343456,0.460844,-0.381915,0.325305,0.101319,-0.383925,-0.0132919,-0.743768,0.710313,-0.296553,0.275055,-0.259225,0.0524808,-0.494665,0.437274,-0.484596,0.114398,0.0747733,0.213083,-0.0385039,0.0719359,0.517302,-0.540439,-0.344127,0.446877,-0.217338,0.444814,-0.199314,0.161686,0.0476632,0.100814,-0.32167,-0.00597098,0.0209193,-0.110215,-0.585076,0.520149,0.0532813,-0.179845,0.196161,-0.472575,-0.2271,0.366504,-0.0901892,0.171722,0.296278,-0.169001,0.193487,0.0530558,0.0286349,0.279825,-0.17097,-0.853561,-0.0673317,-0.290816,-0.321359,0.624802,-0.237269,0.149763,-0.198861,0.574785,0.273087,0.572886,0.234698,-0.0278972,0.135619,-0.356446,-0.296271,0.0978648,0.352724,0.189279,-0.109325,-0.521692,-0.284471,0.148463,0.215033,0.36344,-0.0155288,0.169871,0.426874,0.45818,-0.195842,-0.630394,-0.199801,0.161108,0.336789,-0.0352795,-0.0546339,0.591584,0.0141693,-0.133728,-0.152085,0.250276,0.39877,-0.118143,-0.102844,-0.268025,-0.342866,0.00553094,-0.409439,-0.176994,-0.0802615,0.0848987,0.426994,0.291374,0.653448,-0.82063 +3436.44,1,0.0912059,4,1.57244,0.935149,-1.81945,0.986493,0.853998,-0.19636,-0.455774,0.214704,0.055185,0.300711,0.144617,0.18081,0.41955,0.16651,-0.242001,0.903071,-0.0698353,0.0621834,0.123346,-0.241132,-0.284295,-1.01307,-0.0714778,0.260811,-0.209826,0.0609196,0.210882,0.657963,0.203387,0.600294,1.01437,-0.239795,-0.0549438,0.290544,-0.961835,-0.857453,-0.3883,1.45767,0.839471,-0.985647,0.592269,0.686495,-0.0088039,-1.05255,-0.57996,-0.207384,-0.510071,0.720257,-0.373962,-0.661485,-0.529414,0.920135,-0.222868,0.442798,-0.461105,-0.0731126,-0.2524,-1.25684,-0.0491974,-0.492093,0.609526,0.855034,-0.507016,0.0550981,0.218929,0.556131,-0.10124,0.0497634,-0.0219871,-0.619202,-0.228541,-0.0757949,0.562065,0.213198,0.469521,0.213535,0.222669,-0.0471713,-0.0515263,0.103022,0.318862,-0.0775826,-0.00237463,-0.0406687,-0.00920535,-0.64492,0.0652566,-0.750277,-0.132749,-0.434836,-0.236654,-0.145606,0.403186,0.0680641,0.0582934,0.0725846,-0.176726,0.324627,0.181401,0.683887,0.103873,-0.020909,-0.95848,-0.4748,0.295007,0.0202198,-0.0241617,0.114071,0.21396,0.47745,-0.175408,-0.36857,0.200979,0.221367,-0.0923838,-0.279492,-0.39574,-0.259673,-0.30333,-0.40872,-0.34382,-0.226784,-0.32761,0.242297,-0.0691922,-0.0555668,-0.0566339,-0.0440331,0.199193,-0.576599,0.293911,-0.271546,-0.0453231,0.278032,-0.324034,-0.196125,-0.362143,0.301824,0.582929,-0.393219,0.203865,0.0867421,-0.154879,-0.0833562,0.435655,-0.166051,0.134278,-0.100735,-0.414211,-0.294818,-0.313024,0.076695,0.432118,0.188833,0.455609,0.150477,-0.286343,-0.200921,0.186319,-0.144082,0.119623,-0.403511,0.58538,-0.00247963,-0.11452,0.343543,0.106133,0.436736,0.0145515,-0.162568,-0.128022,0.257149,-0.238115,-0.736716,0.130513,-0.102801,-0.423539,-0.240092,0.140284,0.545337,0.0396128,-0.367566,0.484049,-0.0913398,0.464665,-0.0288905,-0.573981,0.090578,-0.162974,-0.532184,0.190913,0.371288,-0.0677118,-0.468943,-0.213565,0.0463698,-0.207907,-0.435371,-0.339622,-0.251794,-0.156301,-0.0559834,-0.435453,0.0688596,-0.0375929,-0.143961,-0.430179,0.896403,0.00814288,0.40191,0.25001,-0.111389,0.383853,-0.248179,-0.00537062,0.104866,-0.169918,0.154607,0.666951,-0.0872209,-0.327786,-0.229911,0.604481,0.0352842,-0.438686,0.668375,0.273874,-0.718999,0.134551,-0.288101,-0.219187,-0.225086,-0.192623,-0.121537,0.0951751,0.136823,0.26898,0.0187009,0.592905,-0.25543,0.12137,-0.056315,-0.0322947,-0.506981,0.268729,0.246097,0.147231,-0.00145821,-0.218944,-0.56141,0.466804,0.0410847,0.631498,-0.253636,0.113496,-0.229707,0.0196062,0.276838,0.262916,-0.0630618,0.291103,0.0540327,0.26259,0.232419,0.20932,0.253503,0.143527,-0.0428676,-0.0195764,-0.198139,0.0786694,0.130858,-0.357227,-0.130822,-0.0047542,-0.346091,0.239003,-0.167394,0.25355,-0.355383,-0.0866766,0.110631,0.0417134,-0.0977527,0.103602,0.708861,-0.00685878,-0.118888,-0.0568252,-0.170636,-0.155995,-0.119783,-0.368095,0.273948,-0.115275,-0.323588,0.158094,0.128147,0.024586,0.183837,0.290194,0.0844451,0.2216,0.290594,0.470745,-2.84645 +3439.57,0.788502,0.0912059,4,1.55966,0.835334,-1.28925,0.607154,0.420701,-0.134153,0.233904,0.54682,0.575365,-0.163861,0.0896334,-0.415895,-0.25162,0.228288,-0.191632,0.814738,0.0191629,-0.00746764,0.0368173,0.333342,-0.00845026,-0.706888,-1.61406,0.396125,-0.0544275,0.238549,-0.0798072,0.299992,-0.64542,0.217971,1.24264,-0.748731,0.183421,0.332772,-0.804993,-0.0376311,-0.131609,0.519086,0.342098,0.102706,0.841595,0.800974,1.08652,-0.749437,-0.293091,-0.148105,-0.643474,0.161138,0.113939,-0.429942,0.185387,0.18275,0.17007,-0.280431,0.403513,-0.178716,-0.535266,-0.416403,0.378366,-0.837208,0.0591901,1.05024,-0.717972,-1.73523,0.320619,-0.0415227,-0.234733,-0.0524999,-0.0394833,-0.0489515,0.309984,0.396741,0.501138,-0.365125,0.417115,0.593669,0.272902,0.140996,-0.565737,-0.0828159,0.214065,-0.265754,0.250629,-0.0690004,-0.0924995,0.287916,0.0272259,-0.0133584,-0.158896,-0.279828,0.234467,0.760632,-0.360194,0.0415189,0.140061,-0.462087,-0.181421,-0.819137,0.224707,-0.11151,-0.415925,-0.00508445,0.154663,-0.288573,0.554281,-0.305982,0.197949,-0.187803,0.526808,0.2928,-0.179159,0.0831052,-0.0170843,0.130488,0.0177061,0.144713,-0.3439,0.0817245,0.588173,-0.0767965,-0.653349,0.48416,0.153065,-0.497758,0.48355,-0.0365096,0.372867,0.5308,-0.0976597,0.0653011,-0.281384,0.150195,0.185226,0.745212,0.109477,-0.103171,-0.0563451,-0.822687,-0.086383,-0.308622,-0.44009,-0.279627,0.187203,-0.757682,-0.38177,0.237596,-0.0096602,0.0603039,-0.100043,0.366365,-0.536255,0.237758,-0.19299,-0.234774,-0.126041,0.188501,0.582679,0.337203,0.166678,0.0881037,0.302901,0.11668,0.678157,0.261285,0.422635,-0.325976,0.244129,0.0503893,-0.276576,0.237562,0.122075,-0.285125,-0.287345,0.601866,-0.145661,-0.281547,-0.38912,0.385534,0.18233,0.5553,-0.0454484,0.235031,-0.143907,0.28319,-0.829249,-0.489535,0.233582,-0.609809,0.477153,-0.531045,-0.0175221,-0.256019,-0.0607817,-0.241608,0.142186,0.0951495,0.0916342,-0.0435029,-0.432314,0.623887,0.00604495,-0.536341,0.135822,-0.0995812,0.259881,-0.0867727,-0.501851,0.698854,0.298368,-0.129423,-0.251052,-0.131216,-0.218428,0.310793,-0.303341,0.336868,-0.0398476,0.22118,-0.205012,-0.199724,0.0574939,-0.380082,-0.157747,0.0395145,-0.0794568,0.273596,-0.219303,0.2033,-0.0651859,-0.0011435,-0.26233,0.0310431,-0.258475,-0.274087,-0.541603,0.332152,0.0772225,0.146203,0.156418,-0.419548,-0.206934,-0.0520251,-0.00461351,0.184531,0.435311,-0.249641,0.396197,-0.0895703,-0.149398,0.245226,-0.346444,-0.769121,0.143171,0.133412,-0.311418,0.279737,-0.428709,0.334388,-0.104771,0.0527298,-0.0463593,0.338151,0.0476932,-0.298427,0.0868458,-0.383256,-0.2853,0.0933429,0.0126601,0.465838,-0.257057,-0.372342,0.18474,0.120827,-0.0187208,0.0522436,0.143196,0.0357392,0.141521,0.263417,0.118883,0.135725,-0.122849,0.0498249,0.412763,0.10555,-0.15159,0.588422,-0.149474,-0.0346234,-0.0834218,0.205175,0.500471,-0.0184337,-0.381614,-0.0335795,-0.357106,-0.0421698,-0.0981397,-0.623197,-0.601328,0.107901,0.34496,0.328483,0.587333,-1.17867 +3427.56,0.664661,0.0912059,4,1.47338,0.997453,-1.29288,0.506776,0.714244,-0.195766,0.230739,0.627041,0.424388,-0.00166547,0.154619,-0.214684,0.0203534,0.108205,0.0498994,0.784022,0.162812,-0.0582049,-0.21207,0.351547,0.0743222,-0.686964,-1.3515,0.00336161,0.122655,0.0657211,0.369592,0.215681,-0.281358,0.382517,0.846854,-0.813385,0.337199,0.367578,-0.402101,0.0978167,-0.174261,0.576931,0.915046,-0.143632,0.84849,0.657516,0.611887,-1.08989,-0.231596,0.261713,-0.875409,0.367797,0.29033,0.0544415,0.00977973,-0.105889,0.186781,-0.331512,0.576399,-0.375204,-0.364431,-0.521986,0.172361,-0.669601,0.0468004,1.12968,-0.704612,-0.93316,0.102719,0.127677,-0.453487,0.340972,0.23878,-0.289198,0.609065,0.356585,0.940284,0.192747,0.691349,0.298708,-0.0137065,0.279803,-0.506815,-0.354141,0.20829,-0.157024,0.382483,-0.0953495,-0.0504361,0.474132,0.381592,0.00309797,0.0900274,-0.207375,0.322133,-0.140396,-0.196003,-0.0662099,-0.303181,-0.0282597,0.258337,-0.198309,0.492785,0.157063,-0.0146272,0.0777782,0.0451856,0.178593,-0.0891835,-0.275237,0.194851,-0.221959,0.586375,0.185595,-0.387158,0.113253,-0.0715517,0.0441719,0.204274,0.228352,-0.319921,0.215312,0.200599,-0.569646,-0.693335,0.584275,0.119569,-0.457691,-0.138497,-0.026286,0.102686,0.173751,-0.201504,0.560475,0.158809,0.0315662,-0.127663,0.618779,0.213242,-0.407234,0.0481346,-0.633716,0.054507,-0.143774,-0.163161,0.0217825,-0.150751,-0.707114,0.392867,0.0689903,0.174294,0.646738,-0.288089,0.0598014,-0.720049,-0.0264968,-0.158219,-0.381205,0.123482,0.181828,-0.181347,-0.0229685,0.217767,0.148068,0.571122,0.0935385,0.513852,0.40602,0.843515,0.0547645,0.246239,0.197165,-0.0634407,0.377224,0.28951,-0.284466,-0.31662,0.388707,-0.162634,0.083051,-0.445403,0.18153,0.171368,0.628448,-0.193282,0.724415,-0.186736,-0.12323,-0.281168,-0.288964,-0.301238,-0.261001,0.193694,-0.471538,0.0955454,-0.181305,0.0921811,-0.185802,0.331217,0.225454,-0.205558,-0.460237,-0.788174,0.158287,-0.0184624,-0.0613986,0.379865,0.138114,0.602226,-0.354044,-0.132147,0.370997,0.658597,-0.236047,0.0100992,0.140693,-0.0307014,0.424465,-0.101786,0.118825,-0.0958783,0.345501,-0.397524,-0.560801,-0.126159,0.159188,0.0343792,0.428609,0.126952,0.174406,-0.118634,-0.359657,-0.356365,-0.113515,0.0857494,-0.441669,-0.207522,0.0171359,-0.241476,0.580874,0.295606,0.0854822,0.486365,-0.27546,-0.0932638,-0.41541,-0.330023,0.22417,0.695613,0.160001,0.612753,-0.0371089,-0.495221,0.214513,-0.200098,-0.552893,0.520045,-0.0442916,-0.453962,-0.154305,-0.165181,0.188883,-0.133307,0.0861346,0.355913,0.0528436,-0.258526,-0.434743,-0.0847628,-0.0731944,-0.0822231,0.453722,0.175438,0.142993,-0.417056,-0.170261,0.0676494,-0.523803,-0.592283,0.424383,0.0953306,0.572581,-0.363145,0.133248,0.107107,0.00203466,-0.125535,0.0454621,0.25116,0.447946,-0.140335,0.275009,-0.176589,-0.0702299,-0.435202,0.417634,0.588582,0.0938324,-0.298816,-0.212201,-0.395304,0.0480132,-0.133393,0.0702688,-0.204556,0.0926646,0.300708,0.304409,0.548368,-2.41357 +3429.93,0.947199,0.0912059,4,1.56967,0.660239,-1.48845,0.636888,0.174553,-0.0103827,0.578393,-0.0656847,-0.392128,0.0834832,0.080716,-0.425502,-0.11533,0.293861,-0.221228,0.674391,0.195922,0.217471,0.067268,0.132265,-0.0113239,-0.970135,-0.121942,0.793505,-0.55061,-0.365966,0.168382,-0.0602408,0.105909,-0.0413071,1.23091,-0.587683,-0.209671,0.40458,-0.411122,-0.295854,-0.170208,1.23748,0.0767767,-0.378955,1.06999,0.916967,0.59728,-0.843301,-0.538414,0.228376,-0.659917,-0.304046,0.237551,-0.324231,0.0978755,0.381417,0.0199657,-0.204643,0.745365,0.147779,-0.0696473,-0.514428,0.310346,-0.00695567,0.580289,1.17945,-0.549317,-0.382952,0.418613,-0.168219,0.214586,0.0113357,0.0229125,-0.090951,0.069043,0.179931,0.737501,0.0306487,0.62606,0.687598,0.545345,0.0336276,-0.14129,0.126096,0.622386,0.215004,-0.107933,0.334585,0.267284,-0.380126,0.129188,-0.269044,-0.107949,-0.808077,-0.215223,0.109934,0.0925648,0.25902,0.36193,-0.334008,-0.395413,0.296263,-0.443681,-0.0106053,0.208029,-0.458238,0.00232234,0.053573,0.373128,0.257025,0.59387,-0.0799093,0.0798511,0.826354,0.224987,0.0358712,0.30462,0.121351,-0.0537909,-0.0474464,-0.295492,0.114329,0.457095,0.0453424,-0.583825,-0.243291,-0.125447,0.338316,-0.331991,-0.111554,-0.140336,0.661228,0.576025,-0.226714,-0.0642417,0.812944,0.480547,0.368742,-0.120181,-0.224367,-0.275417,-0.0219335,0.294995,-0.0786234,-0.0356839,-0.186589,-0.046618,-0.223569,-0.635811,-0.123774,-0.528126,0.115598,-0.498599,0.00643566,-0.0457022,-0.097403,0.279051,0.0666017,-0.172411,-0.411678,0.513278,0.551602,0.135878,-0.0613347,-0.111312,0.491046,1.15134,0.135889,-0.340109,0.0731983,-0.0622875,0.0155331,0.107559,-0.00027076,0.387684,0.00786398,-0.32488,-0.259426,0.165225,-0.538329,-0.103899,-0.128972,0.0580525,0.545634,0.484976,-0.490362,0.345971,-0.538742,-0.15674,0.0426299,-0.478301,-0.0796269,0.112662,-0.68117,0.392353,-0.0924603,-0.313344,-0.388221,0.00678017,0.158186,0.325206,-0.388133,-0.375467,0.170556,-0.25305,0.341807,0.0886453,-0.105733,0.339936,0.111867,-0.432662,0.71115,0.231243,0.748554,0.159598,-0.422996,0.493033,-0.0967514,-0.328558,0.431146,-0.285953,0.0632071,0.228378,-0.157071,0.0582427,-0.520438,-0.140379,0.408619,-0.519406,0.817125,-0.20833,-0.258509,-0.514756,-0.436004,-0.714164,-0.0219406,0.18487,-0.244264,-0.532971,0.29745,-0.30044,-0.0514295,-0.0554427,0.466218,-0.800506,-0.1899,-0.0963756,-0.3273,-0.17574,0.788339,0.000648258,0.0347312,-0.203209,0.189548,-0.157065,-0.338076,0.338127,-0.539591,-0.125431,0.114109,-0.0460855,0.478659,-0.182258,-0.0580429,-0.249828,0.443197,-0.0533091,0.139906,0.225641,-0.094005,-0.292454,0.0550705,0.207788,-0.180835,-0.14953,-0.219279,-0.727699,0.262543,0.373232,0.100432,0.0939861,0.0408058,0.562896,0.333943,0.162984,-0.185847,0.201853,0.328816,-0.210153,-0.109424,0.218418,-0.311708,-0.12541,-6.62311e-05,-0.0455126,0.208783,-0.390099,0.410559,0.0248207,-0.148773,0.176634,-0.348459,-0.295649,-0.0545256,0.596365,0.110839,0.203416,0.332925,0.451016,0.00356756 +3450.03,1,0.0912059,4,1.54719,0.719305,-1.32715,0.531158,-0.0787495,-0.0682711,0.500422,0.175148,-0.157176,-0.453061,0.0862979,-0.592718,-0.018285,0.498309,-0.136425,0.843849,0.164275,0.055696,-0.000256217,0.335723,0.0703958,-0.933919,-0.718681,0.821119,-0.520959,-0.686239,-0.161289,0.204518,-0.227643,0.0763309,1.29161,-0.323518,-0.316543,0.147606,-0.35015,-0.146992,0.31728,0.516625,-0.0441916,-0.419355,1.06662,0.688734,0.423382,-0.754607,-0.534569,0.0579525,-0.622569,0.0653278,0.160529,-0.208624,-0.000907387,-0.00629085,0.0970711,-0.159515,0.564813,0.0853054,0.0916074,-0.850037,0.269279,-0.0375552,0.506018,1.23541,-0.871252,-0.621096,0.0400165,-0.135795,0.536285,0.0467815,0.020566,-0.0728632,0.0651982,0.209163,0.582383,-0.117428,0.373485,0.721596,0.417201,0.11236,0.035408,0.174952,0.781601,0.393072,-0.0343574,0.116196,-0.134648,-0.54939,-0.0573952,0.130008,0.0366984,-0.740098,-0.223864,0.34285,0.216071,0.0747014,-0.0770442,-0.357179,-0.122918,-0.347924,-0.418902,0.10484,0.103475,-0.0902502,-0.0180466,0.273243,0.428777,0.113798,0.802542,-0.0619643,0.37704,0.734637,0.0707497,0.013264,0.446794,0.27765,0.0379551,-0.184617,-0.15908,0.0956078,0.0542919,-0.0426309,-0.803844,-0.0327898,-0.166347,0.387315,-0.28011,0.0556391,0.125494,0.61052,0.492791,-0.273811,-0.081256,0.324344,0.430465,0.4756,-0.0634382,0.185032,-0.280771,-0.348042,0.127114,-0.349885,-0.214403,-0.357247,0.687354,0.199545,-0.256103,-0.210215,-0.274996,0.136393,-0.242445,-0.38346,0.0320984,0.289997,0.215269,0.349505,-0.0718395,-0.533211,0.78971,0.31132,0.0747673,-0.324212,-0.148836,0.325086,0.861289,0.330141,0.113161,0.122588,-0.11807,0.127691,0.0730618,0.412808,0.458063,-0.216349,-0.162321,0.0511894,0.157245,-0.638449,-0.133753,0.122926,0.0288573,0.354256,0.372794,-0.297338,0.410391,-0.624907,-0.0365952,0.379121,-0.252419,-0.0760469,0.335349,-0.726875,0.261928,-0.0729756,-0.597377,-0.268541,-0.0766886,-0.144643,-0.12425,-0.256639,-0.709684,0.0255534,-0.323935,0.294197,0.216624,-0.29949,0.254671,-0.438799,-0.305897,0.72059,0.090425,0.441279,-0.0530338,-0.313429,0.236552,-0.131136,-0.162498,0.452937,0.0860889,0.189803,0.471745,-0.237453,-0.156322,-0.676017,0.105724,0.380925,-0.434624,0.783439,-0.460526,-0.215037,-0.186484,-0.380139,-0.628689,-0.0349339,-0.420636,-0.168909,-0.664985,0.367085,-0.090527,-0.0919522,0.260957,0.291934,-0.901725,0.117984,-0.156326,-0.0980184,-0.180812,0.566773,-0.0655025,0.211605,-0.59202,-0.0884608,0.0204176,-0.416174,0.777623,-0.321161,-0.631133,0.322923,-0.234498,0.407302,-0.306491,-0.160903,-0.283874,0.729061,-0.0227301,0.0340414,0.35129,0.0869629,-0.203157,-0.13611,0.361114,0.163166,-0.200027,-0.428834,-0.464884,-0.0894318,0.281866,-0.272335,-0.0845658,0.398973,0.713018,0.321102,-0.207632,0.102184,-0.0134145,0.61394,0.114952,-0.203185,0.194906,-0.0486815,-0.276392,-0.572379,-0.0146603,0.248299,-0.245828,0.0410958,-0.00955688,-0.117728,0.00830478,-0.173145,-0.189226,-0.0631404,0.0852583,0.121378,0.259296,0.348393,0.509211,0.74757 +3428.63,0.558119,0.0912059,4,1.60226,0.647927,-0.9309,0.489532,0.331694,0.026041,0.445258,0.0688373,0.0895361,-0.177341,0.363528,-0.287572,-0.601643,0.755136,-0.157771,0.671201,0.133188,-0.0130842,0.0476622,0.307006,0.341181,-0.844785,-0.310355,0.947435,-0.220698,-0.981696,0.0930319,0.12699,-0.48607,0.363508,1.04595,-0.251767,0.121288,0.113866,-0.125726,-0.233026,0.242581,0.777448,-0.220782,-0.080378,1.07088,0.423335,-0.200186,-1.2722,-0.134382,0.202233,-0.71491,0.0118586,0.440656,-0.278339,0.0547384,0.290368,-0.0764153,-0.494766,0.666167,-0.535293,0.00514336,-1.22323,0.364271,-0.194794,0.033567,1.17097,-1.00888,-0.56623,-0.334099,-0.0989504,-0.290788,0.234844,0.332428,-0.243166,0.195966,0.31596,0.407577,-0.0524198,0.406195,0.666201,0.198832,0.569102,-0.222834,0.123606,1.14805,0.230388,-0.186182,-0.0806143,-0.507652,-0.00568651,-0.20192,-0.116785,-0.0578746,-0.456143,-0.0713452,0.200526,0.299123,-0.0103779,-0.14935,-0.498795,0.00856045,0.11731,-0.623991,0.272438,0.245559,0.213299,-0.503694,0.189346,0.00339678,-0.180286,0.485793,0.0638737,-0.0559957,0.579793,-0.0636939,-0.0745692,0.761441,0.427317,0.37512,-0.121727,-0.266779,0.46875,-0.32445,-0.0681846,-0.254699,-0.343684,0.146536,0.0224609,0.175036,0.125666,0.308822,-0.0274965,0.171414,-0.263575,-0.304307,0.235471,0.319208,0.477884,0.31522,0.404431,0.312649,-0.367132,0.14976,0.223807,-0.0879711,-0.107199,0.480483,0.325419,-0.0139122,0.280904,-0.571707,0.0704352,-0.132066,-0.470851,-0.754184,0.587891,-0.0731411,0.405242,-0.0567029,0.00484808,0.584282,-0.107773,-0.0617992,-0.156548,0.522011,-0.00325303,0.653908,0.0652182,-0.0204044,-0.296817,0.0524768,0.0338807,-0.346886,0.522086,0.476925,0.0797438,0.0748423,-0.0619378,-0.250314,-0.0254648,-0.340975,0.144832,0.567288,0.0703338,0.556385,-0.344571,0.475597,-0.521808,-0.167752,-0.183835,0.352689,-0.15138,0.00940713,-0.322815,-0.226822,0.183933,0.0208716,-0.434876,-0.0449985,0.237247,0.147692,-0.171388,-0.568661,0.254762,-0.589185,0.0329552,0.433304,-0.245679,0.435798,-0.291323,-0.176429,0.835955,-0.091277,0.248541,0.455051,-0.105027,0.551539,-0.147132,-0.340473,0.402725,-0.588263,-0.0103244,0.277689,-0.118317,0.0890473,-0.499979,0.0341044,-0.00870846,-0.403376,0.243388,-0.0619335,-0.53092,-0.464982,-0.123039,-0.021457,0.141474,-0.223044,-0.469805,-0.840015,0.500776,-0.303999,-0.243423,0.372167,0.0971933,-0.755264,0.0702182,-0.169302,-0.187129,0.438445,0.407079,0.183569,0.327695,0.0517649,-0.345224,0.338303,-0.402587,0.416192,-0.179607,-0.615668,-0.0276957,-0.653833,0.401684,-0.297492,-0.139664,0.160347,0.104495,-0.408632,-0.0405638,0.283137,0.112979,-0.032224,-0.763647,-0.0257094,0.197586,-0.273362,-0.518325,-0.901632,-0.511497,0.0664671,-0.000138299,-0.369023,-0.0765578,0.56766,0.465337,-0.436531,-0.358577,0.623843,0.115094,-0.177514,0.555033,0.239181,0.408228,-0.328034,-0.416875,-0.232728,-0.293357,-0.111504,0.111633,-0.21882,-0.319588,0.171069,-0.3459,0.160637,-0.668015,-0.341358,0.120871,0.266905,0.347666,0.516629,-0.626053 +3439.29,1,0.0912059,4,1.63283,0.825798,-1.1121,0.591014,0.265074,0.00799177,-0.0109259,0.200827,-0.104268,0.307049,0.285067,-0.224022,-0.0207752,0.571252,0.00631217,0.945953,0.184638,0.104026,-0.357577,0.257919,0.0370469,-1.00721,-0.880369,0.69452,-0.418846,-0.392697,0.218551,0.337304,-0.0396384,-0.0980842,0.788218,-0.703849,0.233944,0.14163,-0.784769,-0.304405,-0.359207,-0.0577484,0.494243,-0.184737,0.921851,0.483849,0.468722,-0.655987,-0.708218,-0.210344,-0.652429,0.203309,0.0812004,-0.515167,0.194508,0.247485,0.0249006,-0.491333,-0.176944,-0.239247,-0.22612,-0.754454,0.0971279,-0.086984,-0.176256,0.443991,-0.844263,-0.663208,-0.0517432,-0.0753119,0.611657,0.0111095,-0.145994,-0.401117,0.300722,-0.11803,0.547663,0.0937724,0.456133,0.449243,0.553476,-0.415478,-0.512505,-0.0933997,0.0446184,-0.191493,0.0741092,-0.22853,-0.0986604,-0.319014,-0.0238433,0.170409,0.48297,-0.266277,0.536505,-0.559606,0.235765,-0.355976,0.320231,-0.0426929,0.281173,-0.524741,-0.0612049,-0.125375,-0.343513,0.497541,-0.119621,-0.269925,0.403856,0.0850432,-0.0207207,-0.451095,0.323008,0.170976,0.188313,-0.24621,-0.171495,0.532347,-0.74638,-0.18818,-0.526709,-0.605456,-0.100652,0.0819165,-0.382757,0.458941,-0.40028,-0.0527731,0.10066,0.131258,0.243861,-0.516258,0.124657,-0.193691,0.176889,-0.173562,0.112548,0.176982,-0.271328,-0.659462,0.170397,-0.243477,-0.163874,-0.233181,-0.305818,-0.471906,0.168461,-0.00090705,0.210185,-0.148759,0.270877,0.144435,-0.0138365,-0.0815516,-0.163191,0.364893,0.110529,-0.147977,-0.11451,0.185747,0.128432,-0.288387,-0.0278071,-0.335199,-0.188593,0.005026,0.990316,-0.0749906,0.0472236,-0.625781,-0.0962395,-0.141552,-0.387983,-0.107221,0.0958554,0.198772,0.0529539,-0.112681,-0.133377,0.0727655,0.0605609,-0.567384,0.36631,0.523758,-0.0810759,0.201582,0.263612,-0.130016,-0.367699,0.34381,-0.501507,-0.570339,0.488314,-0.125246,0.118614,0.196844,0.0638321,0.0676188,0.29626,0.0894602,0.0810393,-0.450444,-0.725833,-0.306024,-0.0224803,0.261021,-0.0711858,0.346594,-0.0721083,0.373848,-0.378549,1.09737,-0.31888,-0.231,-0.167884,-0.159087,-0.526546,-0.19652,0.0460992,0.407178,-0.0219752,-0.0560484,0.35928,-0.330997,-0.0946387,-0.534797,0.624543,0.285315,0.0837137,0.340957,-0.280451,-0.176465,0.246649,-0.204799,-0.312055,0.150248,0.0147612,-0.231008,0.165854,0.22388,0.0394493,0.540123,0.739075,-0.208787,-0.109199,0.471611,0.0685275,-0.139178,0.504995,0.0965012,0.0154627,0.197807,-0.0195221,-0.387611,-0.7932,-0.359959,0.388668,-0.451092,0.305537,0.202641,0.0648257,0.537629,0.0326467,-0.402253,0.420539,0.67643,0.328826,0.00799691,0.251448,0.13759,-0.0181607,0.51596,-0.146765,0.0899381,-0.288344,-0.127949,0.0205558,-0.054979,-0.267583,0.114679,-0.264386,-0.171304,-0.20919,-0.0179566,0.138817,-0.304951,-0.133226,0.0987695,-0.31292,-0.0288047,-0.644455,0.14451,0.18218,-0.157445,0.274659,0.710259,-0.165632,0.0510732,-0.124938,-0.751203,-0.342073,-0.0690018,-0.235585,-0.49116,-0.0213211,0.0898224,0.23547,0.299704,0.485253,-0.685312 +3458.35,0.996285,0.0912059,4,1.67082,0.860571,-1.09153,0.469627,0.206655,-0.170995,0.403055,-0.163811,0.392032,0.69123,-0.00129635,-0.663058,-0.519605,0.349863,0.145084,0.548038,0.0259506,0.0934544,0.116333,-0.109544,0.0729338,-0.651971,-0.959095,0.297162,-0.0589843,0.160888,-0.0958399,0.0192927,-0.40799,0.0981797,0.662815,-0.155571,0.179224,0.323479,-0.776582,-0.359177,-0.124293,0.222511,0.228768,-0.274702,1.23862,1.14724,0.00117171,-1.22215,-0.308562,-0.0911734,-0.605994,0.607883,0.40353,-0.0700895,0.349831,-0.089071,0.0419323,-0.265996,0.195607,-0.445776,-0.189666,-0.989242,-0.0577416,-0.077325,-0.0762759,0.98723,-0.620242,-1.56362,-0.347596,0.260711,-0.0795665,-0.00355426,0.0811862,-0.452002,0.254603,0.130285,0.707845,-0.112818,0.676193,0.37069,0.00643979,-0.369148,-0.0231744,-0.0521428,0.224987,-0.355035,-0.0122486,-0.146558,-0.116865,0.118109,0.665734,-0.586472,-0.297121,-0.370177,0.274811,-0.653363,0.0675154,0.386494,0.196886,-0.0155818,0.185371,-0.515803,-0.433875,-0.113293,-0.497038,-0.477846,-0.535506,-0.221119,0.213919,-0.0187606,-0.12809,-0.0732786,0.358747,0.190563,0.0555155,-0.385605,-0.511046,0.454401,-0.257506,-0.312657,-0.467136,0.476708,0.494428,-0.0612006,-0.768793,0.350821,0.0438892,-0.0995451,0.070751,0.0255167,0.333353,-0.236064,0.14728,0.0295396,0.508637,-0.30129,-0.204775,0.407487,0.0252883,-0.193865,0.161186,-0.178251,0.0286514,-0.416186,-0.0609312,-0.274862,-0.188049,-0.332431,0.320203,-0.0124362,0.441126,0.227588,0.0639536,0.0734761,-0.313784,-0.320687,0.560355,-0.212447,0.183239,0.539054,-0.0638458,-0.612111,-0.0945691,-0.0304213,0.254438,-0.0695178,0.617748,-0.377989,-0.380038,-0.381388,-0.0237215,-0.216098,-0.369014,0.0460721,-0.0578375,-0.222169,-0.0408027,-0.217146,0.165931,0.175448,0.129407,-0.212179,0.361202,0.383064,-0.385224,0.450746,0.721321,-0.308447,-0.29784,-0.458305,-0.33033,-0.399411,0.0337652,-0.323276,0.143825,-0.133091,-0.204276,-0.0697642,-0.134892,0.43973,0.163141,-0.665855,-0.091439,-0.0450028,-0.119506,0.0451692,0.0421984,-0.304671,0.304365,0.0427006,-0.0879631,0.960468,-0.536287,0.202951,0.152081,-0.144826,0.358007,0.467784,0.0315643,0.33448,-0.432519,-0.397577,-0.0388523,0.256792,0.280345,-0.432458,0.0641859,-0.195569,-0.354317,0.201984,-0.537897,-0.687688,-0.00610636,-0.175041,-0.195866,0.221085,-0.181909,-0.245225,0.0717596,0.513856,-0.40358,-0.0434217,0.650279,-0.383212,-0.390375,0.563504,-0.166487,-0.0496095,0.278034,0.136403,0.608495,-0.107939,0.12971,0.048705,-0.328242,-0.0590854,0.396442,-0.11995,-0.155876,0.331263,-0.248926,-0.395638,0.317598,-0.0109196,-0.0171825,0.362802,0.12825,0.557975,0.301432,0.104348,0.117532,0.119646,-0.389028,0.0215077,-0.251309,-0.400356,-0.0762493,-0.190013,-0.287678,0.137744,-0.196784,-0.633644,0.676718,-0.329722,-0.175206,0.159138,-0.13067,-0.0766228,0.00119402,0.509557,-0.223849,0.348052,-0.192469,-0.286249,-0.0287065,-0.0661347,-0.058932,0.586013,0.0226459,-0.222337,-0.00230206,0.0759244,-0.395854,-0.126491,-0.284354,0.119619,0.281791,0.34586,0.53084,-0.365802 +3467.63,0.430592,0.0912059,4,1.69469,0.922736,-0.794878,0.232554,-0.094332,-0.205177,-0.0953767,0.366227,0.595386,-0.119654,-0.0334602,-0.131762,-0.477297,0.650151,0.0650399,0.811651,0.320984,-0.0192011,-0.457839,0.100843,-0.264275,-1.29714,-0.648778,-0.0673604,-0.214846,-0.377192,0.0942884,0.0642211,0.0803712,-0.441878,0.533107,-0.919608,0.311028,0.249036,-0.713811,-0.446268,-1.60569,0.49462,0.453086,-0.220433,0.960786,0.279799,0.45726,-0.546874,-0.398928,-0.541172,-0.490157,0.291896,0.27631,-0.280308,0.118968,0.098347,0.425928,-0.519959,0.468158,0.114119,-0.179673,-0.58239,0.0572366,-0.422308,0.243686,0.657119,-1.33673,-0.437132,0.303747,0.129796,-0.229271,-0.348354,0.430984,-0.218192,0.23896,0.417651,0.320016,-0.333766,0.385158,0.462022,-0.218381,0.195165,-0.340502,-0.101961,0.593758,-0.271432,0.157312,-0.260675,0.242488,-0.155774,-0.331155,-0.138625,0.421373,-0.0181982,0.200402,-0.392552,-0.234123,0.185517,0.403661,-0.303741,0.111262,0.0752909,0.0206606,0.182248,0.153845,-0.109741,-0.248774,0.0865237,0.206911,-0.310692,-0.0408628,0.0353139,0.103623,0.510634,-0.0813808,-0.607078,-0.11177,0.316325,0.552351,0.230785,-0.344058,-0.339228,-0.355931,0.174316,-0.0988957,-0.0713856,-0.0999014,-0.460745,-0.192967,0.283861,-0.139703,0.325872,0.282388,-0.0498537,0.142671,-0.104883,0.182185,0.498128,-0.574766,-0.14421,0.122567,-0.415683,0.259047,-0.173949,-0.526672,0.146816,-0.113835,-0.325298,-0.197767,-0.279801,-0.310418,0.457087,0.0228259,-0.19711,0.0189586,0.0748399,0.171026,0.234575,0.214435,-0.0480281,0.386083,-0.152085,-0.043098,0.161289,-0.00248341,0.0249971,0.691629,0.153806,-0.00108268,0.0913916,-0.0892434,-0.566935,-0.065387,0.105776,-0.00881048,0.0780992,-0.010946,-0.514251,-0.361634,-0.174136,0.116192,-0.0772264,-0.191065,0.474349,0.342867,0.0805573,0.353699,0.177943,-0.203059,0.313364,-0.111868,-0.749856,0.387745,-0.935956,-0.258301,-0.00171069,0.189663,-0.380546,-0.0447825,0.0746955,0.131919,-0.248675,-0.421272,0.261152,2.50363e-05,-0.141615,-0.128895,0.198171,-0.493042,-0.228049,0.0755392,0.936596,0.322064,-0.163022,-0.453867,0.162665,0.188233,0.421703,-0.103358,-0.141494,0.323546,-0.0482073,0.107464,-0.0290192,0.00925051,-0.279618,0.260522,0.310951,-0.0883427,0.254123,-0.217544,-0.362061,0.141586,-0.0442494,-0.0757057,-0.141594,-0.348918,-0.271473,-0.300845,0.531371,0.568911,0.267636,0.324041,-0.271294,-0.159475,-0.0410022,-0.0224254,-0.38701,0.200399,0.205256,-0.100384,0.197645,0.0477833,-0.362354,0.129645,-1.06087,0.28792,-0.296122,-0.314884,0.280884,-0.533184,0.229935,0.286752,0.264098,-0.298319,-0.116063,0.249114,-0.0580067,-0.179193,-0.129864,0.299848,0.0904389,-0.430673,-0.0307014,-0.200112,-0.0131486,-0.0691066,0.218653,-0.226669,-0.121359,0.121066,0.386774,-0.0597199,0.368783,0.0340044,-0.307943,0.266916,-0.11988,0.31904,0.228062,-0.165669,0.774011,0.0240582,0.20999,0.174907,0.107433,0.104865,0.181823,0.0770241,-0.110797,0.0915363,-0.371007,-0.0268783,-0.0866294,0.298081,0.0838579,0.242149,0.289582,0.492087,0.624892 +3471.14,0.686499,0.0912059,4,1.62738,1.0027,-0.98176,0.326934,-0.233899,-0.0962838,0.3528,0.568639,0.315236,-0.0987844,-0.323255,-0.481364,0.0799924,0.433412,0.0971623,0.792088,0.0203796,-0.222965,0.0245013,-0.460151,-0.634992,-1.12365,-0.947144,-0.158631,0.176875,-0.273608,0.0510087,0.398806,-0.170815,-0.318399,0.491991,-0.472634,-0.157201,-0.157559,-0.671256,-0.219172,-1.26982,0.789544,0.0912449,-0.751085,0.948356,0.606982,0.108483,-1.47284,-0.448361,-0.0573625,-0.836345,0.722372,0.191696,0.000612237,0.0260329,0.350047,0.114124,-0.582637,0.551986,-0.44407,-0.437311,-0.306557,-0.121538,-0.0129078,0.197125,0.977498,-0.635004,-0.903262,0.336506,0.0379687,-0.13717,0.371799,-0.378673,-0.320482,-0.12066,0.573934,0.501556,0.275664,0.393235,0.188225,-0.133625,-0.207531,0.207491,0.275847,0.484408,0.0220302,0.236445,-0.335638,0.0726876,0.0155715,-0.283652,-0.307115,0.156315,-0.498773,0.0038395,-0.167765,-0.147498,-0.0875517,0.335529,0.229041,0.19912,0.117827,0.18004,-0.0603768,-0.188021,-0.235889,-0.426688,-0.0700208,-0.32695,0.299811,0.216909,0.176377,0.171212,0.45215,0.189154,-0.148737,0.0253212,0.176904,0.332199,0.176498,-0.474566,0.0630926,0.285984,-0.489354,-0.642356,-0.0884865,-0.295955,-0.401959,-0.427399,-0.401171,0.608983,0.197117,-0.0349883,-0.390593,0.00711664,-0.121124,0.149677,-0.00742591,-0.448353,-0.305348,-0.146796,0.0139705,0.379893,-0.365614,-0.218322,0.259397,0.151679,-0.568051,0.228688,-0.106131,-0.57767,0.83765,-0.0864287,0.109951,-0.0832653,-0.168665,0.561456,0.320217,0.41899,0.548032,-0.138423,-0.105488,0.241813,-0.132562,-0.120643,0.000991993,0.698707,0.0272801,-0.448836,0.170735,0.0351045,-0.316404,0.133832,0.0896677,-0.043038,0.094713,-0.390912,0.488417,0.177638,-0.0952833,0.047564,-0.0687502,-0.00182695,0.481214,0.242014,0.456067,-0.238246,-0.128534,-0.248084,-0.288945,-0.0667899,-0.280632,-0.0696173,-0.181358,0.0113047,-0.137448,-0.0855057,-0.395038,0.315636,0.210238,0.677359,-0.254847,-0.065376,0.137587,0.156915,0.0694401,0.410495,-0.312342,-0.208276,-0.0299835,-0.460146,0.986226,0.480255,0.28243,0.383093,-0.279428,-0.263616,-0.0659438,-0.496959,-0.264037,-0.272155,0.421969,-0.00305017,0.0771562,0.20425,-0.0876384,0.321704,0.256993,-0.414521,0.497133,-0.14193,-0.163366,-0.0864643,-0.0505884,-0.0124498,-0.133584,0.0145868,-0.121808,-0.270012,0.714459,0.0982236,-0.106955,0.403867,-0.429383,-0.25661,0.426885,-0.11502,0.129197,0.0164872,0.455544,0.217662,0.21456,0.147377,-0.179658,-0.372121,-0.757137,0.429548,-0.513561,-0.177646,0.616062,-0.297577,0.127586,0.243257,-0.0287729,0.0807392,-0.157748,-0.195748,0.156706,-0.079643,0.433044,0.115519,-0.00849655,-0.439723,0.133718,-0.391831,-0.000336219,-0.320434,-0.228268,0.216844,0.236019,-0.47452,0.0660189,0.272296,-0.0368988,-0.190582,-0.390524,0.192064,-0.0247664,0.164296,0.0414844,0.198169,0.472623,0.192038,-0.0289461,-0.243948,0.255451,0.281441,-0.184266,0.177,-0.563174,-0.0323344,0.143585,0.145753,-0.0747663,0.207008,0.0924931,0.277194,0.304127,0.526492,0.861007 +3445.62,0.704946,0.0912059,4,1.51915,0.907691,-0.841849,0.292223,0.435053,-0.167081,0.310203,-0.37957,-0.120806,0.525763,-0.103757,0.0282652,-0.153136,0.644108,-0.271712,0.795453,0.53897,0.389242,-0.105324,-0.254948,-0.320643,-0.992171,-0.518716,0.19407,-0.294701,-0.456035,0.502557,0.239272,-0.0943758,-0.452427,0.677076,0.11088,0.0703266,0.156615,-0.341207,-0.0131715,0.00368857,0.485888,0.304594,-0.0289405,0.832818,0.552504,0.308769,-0.221243,0.0751348,0.636353,-0.0263132,0.014209,0.492678,0.117569,-0.0253029,0.00850238,-0.0166245,-0.217928,1.05837,0.00220427,-0.0908331,-0.451273,0.363683,-0.493652,0.668514,0.739397,-0.659832,-0.705878,0.265892,-0.162588,0.0878956,-0.609496,0.350663,-0.119377,-0.180014,-0.121054,0.49162,-0.440564,0.403274,0.169445,0.144543,-0.158356,-0.0630926,-0.303715,0.192594,-0.202523,0.30599,-0.29109,0.38928,-0.267448,0.0225841,0.0133925,0.363147,0.211273,-0.248365,0.137396,0.0673044,0.0369678,-0.13804,-0.501587,-0.372719,-0.147856,0.148375,0.16801,0.385034,0.107672,0.0637121,-0.314614,0.479757,-0.645814,-0.00167091,-0.49751,-0.298404,0.493397,-0.102902,0.101522,-0.00791548,0.0517751,-0.553289,0.00137261,-0.182434,0.199555,0.210012,-0.153191,-0.187995,0.226206,0.0178611,-0.228303,0.0245793,-0.128691,-0.0157318,-0.319496,0.387711,-0.43118,-0.472055,-0.0684864,0.0700932,0.714372,-0.235041,-0.164884,0.116436,0.664373,0.501233,-0.284052,-0.171236,-0.092087,-0.0527125,-0.273132,-0.219006,0.365201,0.129936,0.554437,0.0238716,-0.482036,0.00292648,0.477233,-0.508827,-0.5193,-0.358761,0.0155646,0.171992,-0.0995071,-0.247296,-0.00863208,0.130187,-0.200793,0.255025,0.112151,0.176653,-0.243586,-0.248883,0.114523,-0.0527809,0.0404465,0.175762,-0.0219469,-0.177398,-0.624643,-0.223454,-0.251061,-0.181273,-0.523197,-0.103109,0.633818,-0.0721249,-0.457017,0.276115,-0.223728,0.155912,-0.170788,-0.282555,-0.176319,0.557188,-0.30897,-0.194117,-0.208856,-0.0512875,-0.557999,-0.526235,-0.198196,-0.0988933,-0.052055,0.19812,0.161732,-0.039397,-0.604777,0.0480485,-0.238721,-0.374225,-0.0909473,0.0385033,0.888773,-0.681756,-0.074633,0.0183532,0.117721,0.303711,0.581581,0.239802,0.394955,0.00481959,-0.436048,0.0731089,-0.650807,-0.26197,-0.372227,-0.514803,-0.281624,-0.0282327,0.441754,-0.269241,-0.107424,0.06791,-0.272606,-0.257665,-0.211996,-0.0436084,0.0854379,-0.286663,0.349028,-0.0320211,-0.131951,0.0793264,0.330684,0.395827,-0.362388,-0.0117177,0.101306,0.243699,-0.20648,0.531023,0.100819,-0.291626,-0.295325,0.558615,-0.618078,-0.009025,-0.0973473,0.0715269,0.253292,-0.236674,0.124243,-0.570131,0.243177,0.0981428,0.617394,-0.12779,0.041449,0.0277969,0.118561,0.0530405,0.105676,0.256389,0.218422,0.299361,-0.138083,-0.152512,0.0820588,0.0374114,-0.030312,0.398711,-0.105371,0.0351305,0.171178,0.0107172,-0.195219,-0.244441,-0.0706772,0.378797,-0.201301,-0.144203,-0.010348,-0.055912,-0.379668,-0.171443,0.0716295,-0.376256,-0.192218,0.256603,0.0250773,0.0646279,0.176471,-0.55805,-0.146505,-0.205022,0.0880692,0.184774,0.296765,0.429854,-1.32293 +3432.28,0.782058,0.0912059,4,1.55984,0.902183,-0.623805,0.177005,0.340096,-0.186399,0.225355,-0.277861,0.196716,0.771212,0.0964794,0.17338,0.0418256,0.330727,-0.0643747,0.700148,0.476718,0.178052,-0.21502,-0.0251794,-0.068638,-0.925364,-0.713877,0.274351,0.118972,-0.299935,0.267865,0.135135,-0.326189,-0.118069,0.825176,-0.367571,0.380671,0.0693023,0.0454157,-0.08809,-0.276932,0.535213,0.535547,-0.273161,1.108,0.480563,0.223991,-0.37481,0.0950102,0.530067,-0.197144,-0.0248301,0.112939,0.382271,0.26355,0.165302,0.450628,-0.343292,0.980618,-0.172177,0.416916,-0.362356,0.188742,-0.444565,0.552927,0.761611,-0.517779,-0.905458,-0.238655,-0.0312349,-0.346,-0.130241,0.0963201,-0.160171,-0.017781,0.102438,0.521701,-0.284288,0.6105,0.214799,-0.180349,0.0856594,-0.034086,-0.409596,0.741425,-0.494209,0.3207,-0.118176,-0.00928157,0.0229395,0.215281,-0.237082,0.231635,0.0602088,-0.376679,0.00395222,0.0594279,-0.0674714,0.149005,-0.383632,-0.0687,-0.0702612,0.0955989,0.39215,0.244177,-0.224511,0.0143999,-0.466298,0.233033,-0.533141,0.238276,-0.389507,-0.548841,0.735704,-0.184549,0.264792,-0.0623165,0.221329,-0.389913,-0.287349,-0.216285,0.208318,0.158093,-0.256906,-0.510262,0.177623,0.36226,-0.590495,-0.146827,-0.0924979,0.120421,-0.0760495,0.320035,-0.804035,0.106569,0.0060073,0.133042,0.887102,-0.401492,0.14341,-0.269003,0.382661,0.387026,-0.246805,-0.32741,-0.264627,0.104991,-0.263427,-0.259216,0.656495,0.102949,0.606598,0.0524931,0.28906,-0.225223,0.380673,-0.412221,-0.53005,-0.237645,0.240372,-0.159421,0.141156,-0.0269354,0.132652,0.354274,0.0158449,-0.116511,0.0373819,0.309943,-0.446255,0.0535645,-0.0859637,0.0364625,0.344022,0.134996,0.258239,-0.181578,-0.722908,-0.205238,0.0571888,-0.0233909,-0.337652,-0.116014,0.466612,0.167261,-0.375285,0.197671,-0.38939,0.37819,-0.0243191,-0.752684,-0.236705,0.459374,0.057824,-0.0233858,-0.276302,-0.0198087,-0.367336,-0.632782,0.00235694,0.0585043,-0.181752,-0.102894,0.770707,-0.179768,-0.237975,0.195283,-0.000123347,-0.204228,0.318606,0.069591,1.10362,-0.419403,0.599713,-0.090797,0.0318693,0.13102,0.381787,0.244571,-0.0349414,-0.0885411,-0.690206,0.22422,-0.386119,-0.651357,-0.550179,-0.420451,0.141827,0.199358,0.473822,-0.336702,0.0373204,0.193659,-0.0311459,-0.381696,-0.19198,0.0813512,-0.322916,-0.0941572,0.737094,0.364583,-0.117961,-0.0738935,0.0517812,0.316508,0.0136877,-0.0852597,0.163679,0.0326674,-0.178806,0.291379,0.0255205,-0.223229,0.0503841,0.305542,-0.589386,-0.256942,0.184696,0.120738,0.102276,-0.174361,0.00729767,-0.225896,0.436487,0.312339,0.24739,-0.134256,-0.0880959,0.167302,0.24735,-0.0748515,-0.0234591,0.262339,0.0074553,0.0370929,-0.439521,-0.499476,0.461663,-0.0311022,0.194477,0.453667,0.220084,-0.209535,-0.283128,0.253819,0.0294217,-0.342096,-0.224435,0.127918,0.00553107,0.0254237,0.149812,0.0739006,-0.112235,-0.112109,-0.207039,-0.0508105,0.266233,0.116181,0.201039,-0.19616,0.103573,-0.173992,-0.319147,-0.0155923,0.0889497,0.225284,0.298244,0.474641,-0.957731 +3435.74,0.998754,0.0912059,4,1.4438,0.822902,-1.10261,0.372363,0.820074,-0.28985,0.0125037,0.303328,0.106019,0.651549,0.395387,0.341984,-0.0572013,0.272739,-0.382717,0.681844,0.511889,-0.0147547,-0.364219,-0.0591307,0.231444,-0.683337,-0.600074,0.159991,-0.12909,-0.0905805,0.144552,-0.189439,-0.164871,-0.0652252,0.534478,-0.375717,0.24554,0.562819,-0.0222761,0.14216,-0.117136,0.669775,1.01907,-0.175335,0.909635,0.359315,0.113449,0.0285441,0.373745,0.357283,-0.221014,-0.244891,0.330964,0.632464,-0.236299,0.502081,0.251925,-0.901001,1.01788,-0.447298,0.455645,-0.90181,0.242054,-0.436791,0.411854,1.0814,-0.65064,-1.04435,-0.247985,-0.0515742,-0.516043,0.340971,0.244243,-0.373211,-0.274571,0.360831,0.762825,-0.648627,0.286384,-0.0178396,-0.0327009,-0.10023,-0.604501,-0.351231,0.153576,-0.451874,0.176561,-0.374693,-0.622625,-0.272457,0.0725612,0.0730038,-0.0247839,-0.124968,-0.177752,-0.153004,-0.0466248,-0.119789,0.18642,-0.35279,-0.201927,0.0225478,0.0643217,0.520575,0.20434,-0.0672597,-0.43166,-0.240813,0.618824,-0.414339,0.167037,0.218653,0.0670906,0.39773,-0.231116,-0.219894,-0.332495,0.244924,-0.0197735,-0.229206,-0.494183,0.547925,0.296284,0.213455,-0.502722,0.287068,0.269363,-0.288665,-0.0638073,0.020133,0.66953,-0.833042,-0.0828669,-0.399796,-0.362691,0.0972127,0.223617,0.804535,-0.595403,0.182835,-0.287838,-0.169471,-0.0895153,-0.194207,-0.455166,0.0408489,0.395596,-0.050086,0.156589,0.360515,-0.0907182,-0.161854,0.0361335,-0.122561,-0.253213,-0.00988731,0.0199023,-0.13499,-0.207152,0.434606,0.124844,0.200704,0.154548,-0.357903,0.377548,-0.305649,-0.231802,0.164325,0.143194,-0.155345,0.24494,-0.47286,-0.25119,0.339136,0.352288,0.256553,-0.162034,-0.601584,-0.185506,-0.313035,0.15251,-0.185798,-0.126606,0.384219,0.123107,-0.231025,0.569415,-0.0639705,-0.174671,-0.0637858,-0.14454,-0.584111,0.508793,-0.150624,-0.0231468,0.310684,0.101155,-0.484641,-0.182556,-0.37746,0.00602961,-0.289262,-0.15597,0.190886,0.202473,-0.368584,-0.0542911,-0.738836,-0.462926,-0.109291,-0.163196,0.992131,-0.201657,0.446874,0.175817,0.106703,0.301232,-0.164328,-0.0442466,0.0041232,-0.378967,-0.00198803,0.329289,-0.360659,-0.190299,-0.050313,-0.193745,0.266416,-0.265806,0.629284,-0.272757,-0.168316,-0.340519,-0.345456,-0.0351859,0.163741,0.190773,-0.188578,-0.322671,0.749203,-0.0326012,-0.156068,0.519733,-0.0107661,-0.00830107,0.445069,-0.000222424,0.0308888,-0.122642,0.183076,0.435778,-0.236472,0.234645,0.00763799,0.0758767,-0.648269,0.107181,0.0644502,0.183577,0.0906882,0.0754023,0.48437,0.339712,0.319505,-0.128947,-0.178817,0.115577,0.0789785,-0.0500119,0.0531335,0.33249,0.0487498,0.16648,0.150772,-0.0424051,-0.405472,-0.52294,0.249666,-0.022661,-0.153414,0.464788,0.756863,-0.30325,-0.12955,0.197126,-0.128517,-0.189153,0.280835,0.516163,0.0505522,-0.0250077,-0.182087,-0.0284821,0.183913,0.0996911,-0.134427,-0.359303,0.389348,0.138384,0.516469,-0.203756,0.275755,0.0709961,-0.157051,-0.188258,0.100996,0.230187,0.317799,0.479778,-2.43486 +3445.55,0.584858,0.0912059,5,1.60065,0.680587,-1.23156,0.571569,0.979519,-0.00740925,-0.187908,-0.317471,0.360757,-0.564592,0.288746,-0.815149,-0.695256,0.366167,-0.457596,0.976774,-0.0927143,-0.0421367,0.0911961,0.0185434,-0.0703078,-0.686007,-0.730324,0.320509,-0.410474,0.267711,0.00555421,0.31025,-0.962976,0.301816,0.99943,-0.866243,0.0145858,0.583821,0.0676673,-0.550078,-0.260542,0.0317072,0.264922,0.0586332,0.714334,0.6632,0.598067,-0.660899,-0.144536,-0.361732,-0.567656,0.1427,0.231617,-0.169736,-0.00896972,0.0701114,0.26378,0.0916181,0.560932,-0.037948,-0.626479,-0.726958,0.512426,-0.601362,0.0685303,1.01446,-0.435362,-0.734887,-0.0367844,0.218511,0.369957,-0.5075,-0.234281,-0.370024,0.148494,0.198963,0.524115,0.638906,0.64049,0.597385,0.445486,-0.0842116,0.0183743,0.337494,0.548006,0.00812663,0.222727,0.146896,0.2866,-0.0636715,-0.12638,-0.395138,0.0572269,-0.304839,-0.0733885,0.0360677,0.113644,-0.111297,-0.229503,0.0360655,0.141002,-0.482398,-0.141031,0.234445,-0.297775,0.0109394,-0.043553,-0.196342,-0.557579,-0.0897137,0.299816,-0.24926,0.290537,0.225438,0.241508,-0.140878,0.502924,0.286816,0.0420792,0.224595,0.0472064,-0.146011,0.0749293,-0.531337,-0.593355,-0.256225,-0.394704,0.00483335,-0.0684859,0.127401,-0.410837,0.7999,0.300729,-0.104252,0.558985,-0.0120641,-0.0868816,0.0129576,0.230773,-0.462224,0.0613115,-0.192115,0.576124,-0.618626,-0.125178,0.127958,-0.438884,-0.718054,-0.25892,-0.292409,0.00266587,0.582719,-0.0882147,-0.272163,-0.173984,0.254224,-0.0424388,0.0278732,0.554677,-0.0366887,0.0642158,-0.24671,0.220578,0.0989921,-0.221797,0.359679,1.26296,-0.0602403,-0.273491,0.380608,0.14026,0.158693,-0.20787,-0.324681,-0.267576,-0.108362,-0.0102497,0.570806,-0.0458125,0.0877628,-0.328445,0.13744,0.145008,0.689213,0.0456493,0.147447,-0.110091,-0.043079,0.0136132,-0.360116,-0.307942,-0.0054535,-0.352535,-0.431421,0.122774,-0.163308,-0.0933122,-0.437588,0.11535,0.420208,-0.0934433,-0.25861,-0.491428,-0.338159,-0.102137,-0.0634962,0.190503,0.494655,0.409923,-0.0437487,-0.558724,0.839,-0.0549324,-0.349143,-0.149492,-0.602712,-0.239816,0.378142,-0.284503,0.231558,-0.0221231,0.37501,-0.14932,-0.11824,0.236637,-0.696477,0.159062,-0.0620853,-0.14492,0.615926,-0.342343,-0.476122,0.671291,0.0196405,-0.0719,0.166023,-0.416769,-0.217203,-0.0763863,0.333044,0.16448,-0.0530415,0.25687,-0.365943,-0.100524,-0.0670764,-0.00294357,-0.070884,0.629154,-0.0433556,0.215002,0.613505,-0.285445,-0.252591,0.0600266,-0.190551,0.71093,-0.524707,-0.532126,0.20175,-0.436161,-0.394434,-0.20912,0.0754804,0.265976,0.575146,-0.0225275,0.110491,0.441398,0.177287,0.00608113,-0.372169,-0.403846,0.0591853,-0.301093,0.143149,0.313548,-0.242904,0.0454558,0.17638,0.106904,-0.869364,0.272464,0.189414,-0.351936,-0.139942,-0.128622,-0.0745926,0.175682,0.271275,-0.178504,0.679454,0.126017,-0.273634,-0.164063,0.395033,0.460799,-0.0815508,0.179628,-0.945551,0.0822916,-0.339386,-0.180925,-0.035864,0.365237,0.107329,0.227303,0.32761,0.476764,-2.74751 +3448.04,0.983816,0.0912059,4,1.5764,0.6892,-1.03743,0.455136,0.696295,-0.12625,-0.187008,-0.276445,0.446678,-0.10014,0.377618,-0.657042,-0.189736,0.499885,-0.155541,0.725791,-0.112889,0.0316025,-0.0155412,0.190928,0.201531,-0.488378,-1.02786,0.530736,-0.219834,0.153689,-0.150471,0.167497,-0.40072,0.182705,1.00496,-0.93262,-0.110488,0.563102,-0.0842883,-0.23577,-0.34986,0.394514,0.302357,0.110786,0.668765,0.87088,0.137163,-0.580387,-0.308734,-0.104934,-0.276045,0.200818,0.216558,0.0975185,-0.209117,-0.224656,0.351164,-0.932747,0.780464,-0.129724,-0.39107,-0.531629,0.683923,-0.321276,0.0723875,0.893853,0.218552,-0.690572,-0.0154971,0.151822,0.442962,-0.0909134,-0.194329,-0.543894,0.289269,-0.257098,0.41483,0.102913,0.641071,0.541206,0.620118,-0.0176889,-0.315435,0.451089,0.358536,-0.125487,0.257524,0.268113,0.42464,-0.192092,-0.260541,0.0103793,0.386332,-0.0478704,-0.319609,0.208045,-0.0264195,-0.0274214,0.015094,-0.768208,0.48428,-0.734188,-0.151605,0.435701,-0.159894,0.0508664,0.0823377,0.221488,-0.525054,-0.408862,-0.483182,0.0688289,0.0656867,0.457273,-0.180857,-0.581975,0.951674,0.328197,0.111751,0.270888,-0.29555,-0.36798,0.452328,-0.685682,-0.83333,-0.125407,-0.219421,-0.103413,0.0821932,0.258332,-0.267913,0.351187,0.190701,-0.484857,0.130353,0.0169665,-0.085751,0.0468861,-0.00372511,-0.208825,0.128051,-0.0492637,0.212798,-0.404195,-0.00443853,0.152617,0.0863873,-0.445704,-0.31767,-0.266487,0.172724,0.313279,-0.168785,-0.294271,-0.370635,-0.0027018,0.551625,0.183193,0.759964,0.988766,0.469024,-0.101124,0.129171,-0.187098,0.149927,0.162868,0.735218,-0.329754,0.275668,-0.0450856,-0.108359,0.724804,-0.00200551,-0.443421,0.0325051,0.142343,-0.0725716,0.164007,-0.413227,-0.045356,-0.281716,0.0846472,0.121746,0.707294,-0.333071,-0.122446,-0.197196,-0.0703274,-0.440474,-0.470288,-0.473862,-0.487032,0.291931,-0.371544,-0.112052,0.224427,-0.0117225,-0.282392,0.0879293,0.383895,-0.226471,-0.267966,-0.237004,-0.0599851,-0.144002,0.0714813,0.563652,0.0547932,0.635186,0.157871,-0.482738,0.792597,0.0961265,-0.0467459,0.115458,-0.358869,0.419936,-0.0776203,0.0762597,-0.12009,-0.528345,0.259544,-0.280636,-0.0780266,0.10038,-0.0774948,0.12367,0.294049,-0.239392,0.483774,-0.325982,-0.160111,0.0262702,-0.24491,-0.0912583,0.119157,-0.219869,-0.103456,-0.243693,-0.0713608,-0.26871,0.143448,0.419537,-0.589994,-0.292825,0.248249,0.135655,-0.156789,0.134542,0.171758,0.0044233,0.453884,-0.0736038,-0.28279,0.0268406,-0.438269,0.739016,-0.350942,-0.591576,0.133221,-0.307251,-0.0228345,-0.214796,0.227241,0.32967,0.340098,-0.0399667,0.307673,0.7609,-0.201199,-0.372859,0.302258,-0.403344,0.146311,-0.181689,0.0831905,-0.443806,-0.729296,0.46957,0.0873015,0.377336,-0.157749,0.492872,0.209097,-0.275589,0.450883,-0.273528,-0.023845,-0.313433,0.157966,0.572749,0.361824,-0.290954,-0.239413,-0.0700351,0.166335,0.432409,0.256426,-0.234492,-0.317034,-0.436557,0.0397277,-0.429214,0.197833,0.023114,0.108546,0.25291,0.329463,0.502901,-1.80861 +3452.42,0.839795,0.0912059,4,1.61212,0.809248,-1.36928,0.498348,0.300097,-0.186092,-0.013296,-0.133757,0.0135006,-0.182331,0.227057,-0.00820697,0.0102247,0.494267,-0.188561,0.363366,0.0795816,-0.108619,-0.317873,-0.130219,-0.226863,-0.520889,-0.00580153,0.331562,-0.716673,-0.396387,-0.0992762,-0.0800432,-0.513647,0.0467993,0.736495,-0.122173,-0.0469487,0.177366,-0.148819,-0.129808,-0.245809,0.360035,0.820475,-0.111869,1.04051,0.336864,0.473557,-0.782086,0.0390696,0.606661,-0.752985,0.126688,0.28663,0.0647064,0.161064,0.780054,0.0534376,-0.151201,0.720276,-0.112403,-0.163728,-0.725243,0.193989,-0.476966,0.421565,0.820956,-0.57305,-0.794485,0.0578027,0.159558,0.02233,-0.436001,0.184946,-0.436703,-0.316364,0.0276337,0.352709,-0.249522,0.252883,0.347399,0.303307,0.267948,-0.163967,-0.439039,-0.0409827,0.0788109,0.115262,-0.059566,-0.408117,-0.225574,0.0260061,-0.0204682,-0.1818,-0.600958,-0.51286,0.431587,-0.00528781,-0.0104061,0.122647,0.440153,-0.516139,-0.265618,-0.208425,0.00539972,-0.450329,-0.418479,-0.186896,-0.282104,0.0149852,-0.525462,0.145883,-0.715974,0.0173789,0.0942849,-0.068668,0.0298976,-0.163713,0.1555,-0.421226,0.0695653,-0.251493,0.14958,-0.303057,-0.677585,-0.178384,-0.144213,-0.27003,0.170254,-0.319708,0.645899,0.047394,-0.23233,-0.14866,-0.0831958,0.0564341,-0.310405,-0.592813,0.89517,-0.170522,-0.323115,0.196917,-0.297244,0.379462,-0.528442,-0.795933,-0.0840924,-0.162938,-0.53489,-0.176035,0.354258,0.16963,0.091081,-0.163574,0.314128,0.404351,0.191656,-0.232202,-0.323751,-0.29826,-0.146318,-0.329955,-0.0155402,-0.0599527,0.146397,0.0281861,-0.0297623,0.511901,0.312906,0.0484802,0.298521,-0.0291119,-0.724372,-0.247823,0.0933395,0.0950909,0.0489051,-0.247818,-0.00730029,0.242396,-0.0170729,-0.0623679,-0.0639246,0.0658376,0.643096,-0.0751843,0.242597,0.12217,-0.207581,0.408323,0.123712,0.47388,-0.109737,0.28669,-0.44315,-0.303564,-0.212834,0.292239,-0.40424,0.134619,-0.183962,0.0880429,-0.0313691,-0.610274,-0.776542,0.113055,-0.188223,0.0290545,0.126168,-0.251378,-0.0586018,-0.0868723,0.815889,0.152787,0.361803,-0.0472788,-0.0683033,-0.0303921,0.40354,0.171711,0.00901588,-0.124319,0.147606,0.330406,-0.342059,0.0131239,-0.517629,-0.765314,0.286857,-0.586171,0.323528,-0.521488,0.0366478,0.359731,0.124842,-0.13682,-0.293872,-0.163883,0.113199,-0.0850921,0.47574,0.416136,-0.08005,0.326603,-0.436609,-0.257031,0.105221,0.243696,-0.219285,0.541144,0.355747,0.422361,-0.317023,-0.127674,-0.224679,0.39352,-0.405542,0.173044,0.0368981,0.163148,0.165303,-0.0980541,0.0411236,0.128472,0.128634,0.473883,-0.00299244,0.435249,0.107673,-0.4692,0.287409,0.245722,-0.149826,-0.0405027,0.0399001,-0.0827853,-0.660966,0.0462642,-0.0308021,-0.559042,-0.58464,0.0516432,-0.442036,-0.230337,0.22051,0.147461,-0.288717,-0.341848,0.173787,0.461894,0.187522,-0.506697,-0.151399,0.175858,-0.0416304,-0.0237075,0.00580603,0.125041,0.182679,0.0241342,-0.357115,0.573931,0.092848,0.0741342,-0.29712,-0.531487,0.0859144,0.132245,0.293112,0.363655,-0.521495 +3445.2,0.984945,0.0912059,4,1.58163,1.01331,-0.8668,0.38781,0.784849,-0.0419069,0.0962394,-0.322322,0.343439,0.0817,-0.027395,-0.458801,-0.161217,-0.09415,-0.377033,1.03917,0.14586,0.0783583,0.375686,-0.144653,-0.364608,-0.477313,-0.839307,0.0353008,-0.0242261,0.527115,-0.143168,0.440471,0.0701219,0.00216482,0.819599,-0.464463,0.0312747,0.245245,-0.47782,-0.127027,-0.228271,0.520893,0.244918,-0.234329,0.65651,0.715526,0.424094,-0.654584,0.214577,-0.341899,-0.237842,-0.178488,-0.0272957,-0.0706537,0.0491101,0.0811752,-0.0684579,-0.663606,0.391018,-0.402714,-0.42742,-0.595875,0.276375,-0.232813,0.0820597,0.81286,-0.572342,-0.297156,-0.012362,0.420338,0.398311,0.0266623,0.122142,-0.0738428,-0.213136,0.182497,0.621041,0.374347,0.731966,0.308103,0.242362,-0.255215,-0.475776,0.490261,0.396889,-0.654086,0.387725,-0.0205597,0.152287,-0.0436415,0.193032,0.0398554,0.104794,-0.171977,0.169955,0.290851,0.248378,-0.112297,-0.187242,-0.680574,0.710937,-0.234011,0.011884,0.370085,0.176744,-0.288758,-0.354754,-0.478661,-0.357705,-0.19142,0.402828,0.193626,0.213352,0.0740141,0.456901,0.0355999,0.298672,0.300548,-0.0763558,-0.167919,-0.058583,-0.0576291,0.391593,-0.159086,-0.706619,0.410157,-0.184097,-0.503028,0.100722,0.30906,0.0821098,0.51439,0.125516,-0.149541,0.25135,-0.0807442,0.625544,0.0765561,0.0530315,0.236003,-0.229437,0.325342,0.274787,-1.26004,0.32196,0.253017,0.263604,-0.510298,0.13133,0.135712,-0.264962,0.784613,-0.368172,-0.489505,-0.482281,0.291197,0.437809,-0.0288287,0.644526,0.483028,0.362665,0.392587,0.242758,0.0729649,0.337112,0.0146123,-0.304141,-0.348322,-0.310323,0.291781,0.0365099,0.0978054,-0.339598,-0.264499,0.220239,-0.336594,-0.129205,-0.124926,0.17278,-0.59464,0.0126083,-0.18511,0.194049,0.507642,0.0790362,-0.445531,0.286319,-0.316906,0.0902118,-0.0846484,-0.855866,-0.304366,0.092719,0.121707,0.201341,0.289336,-0.272655,-0.506429,-0.0492067,0.448398,-0.108637,-0.0419102,-0.0860642,0.231717,-0.0823453,0.247109,-0.429334,0.0732192,0.477453,-0.0174745,-0.297971,0.70453,-0.0342004,0.305395,0.128723,-0.22123,-0.0425479,-0.183361,-0.103169,0.0705347,-0.313868,0.271849,-0.149193,-0.0566549,-0.164223,-0.408795,0.143932,0.293364,0.219024,0.369977,-0.34358,-0.451606,-0.220091,-0.0523982,0.612415,0.076154,0.293869,-0.23745,-0.142268,0.588462,-0.570954,-0.0627476,0.625182,-0.426346,-0.0195573,0.251785,-0.0567999,0.622982,0.194023,-0.546146,0.371821,0.670539,0.0414152,-0.0201853,-0.444534,-0.725074,0.034945,-0.125028,-0.36194,0.359022,0.0404505,-0.314311,-0.164586,-0.0810952,-0.022297,0.577497,0.0891279,0.0345321,0.0896228,-0.120446,-0.349084,-0.0510844,-0.25761,0.143596,-0.0383754,0.0213164,-0.443922,0.241958,0.306786,0.101239,-0.18198,0.0704614,-0.424242,0.254903,-0.613968,-0.126502,-0.0637929,-0.543268,-0.214909,0.153649,-0.00656298,0.446992,-0.331835,0.0483407,-0.206537,-0.323925,-0.269606,-0.145734,-0.0321007,-0.303885,-0.556719,-0.00483497,0.2041,-0.744269,0.457352,0.108834,0.185057,0.3299,0.430182,-2.71725 +3450.64,1,0.0912059,4,1.53923,0.892117,-1.21001,0.413002,0.39311,0.0709237,-0.373195,0.0223467,-0.0204386,0.12191,0.0524049,-0.157051,0.20396,0.268636,-0.229868,0.636634,-0.229255,-0.0998663,-0.376017,-0.467041,-0.354127,-1.02458,-0.283125,0.239612,-0.390636,-0.118448,0.211227,0.333127,-0.234735,0.0425739,0.798284,-0.362493,0.584411,0.118783,-0.170865,-0.398709,-0.218761,0.452873,0.65343,-0.380255,0.923065,-0.0477171,0.816173,-0.661759,0.124762,-0.0557003,-0.0313444,0.277493,0.286054,-0.0236872,0.0280585,0.649237,0.0578228,-0.696119,0.528954,0.099115,0.313069,-0.730458,0.204281,-0.40475,0.327521,0.819218,-0.654936,-0.812249,0.0303273,0.292259,-0.0137499,-0.235133,0.254519,-0.438584,0.161076,0.0664306,0.83164,0.158821,0.857093,0.435058,0.38978,-0.176432,0.130681,0.16866,0.687951,-0.187492,0.08624,0.000199594,-1.00574,0.278957,0.26591,0.0334778,0.263046,-0.622917,0.196204,-0.230801,0.0379908,0.127397,0.0662995,0.262356,0.179556,-0.708476,-0.0108803,0.185197,-0.0243945,-0.373986,-0.134065,-0.0973523,-0.0252003,-0.423383,0.680702,-0.0102902,0.443777,0.618555,0.323164,-0.182131,0.303943,0.442481,-0.0369409,-0.0949768,0.178237,0.396957,-0.0671586,0.0943588,-0.240461,0.243668,0.0661619,-0.594697,-0.0579701,0.511613,0.245766,-0.0977744,0.269929,-0.632941,0.0284664,0.177586,-0.143832,-0.199593,-0.0296937,-0.278517,0.227734,0.027749,0.672896,-0.427891,-0.149581,-0.132459,0.133377,-0.720613,0.105877,0.189093,-0.33279,0.401684,-0.000115214,0.295865,0.10252,0.0405882,0.0262619,0.144655,0.340242,0.495488,0.188399,0.30762,0.0937937,0.271246,-0.239455,-0.0231575,0.722364,0.190717,-0.42142,0.217842,0.289879,-0.237353,-0.0981191,0.0958137,0.246849,0.567438,0.0379952,0.280558,-0.475513,-0.574803,-0.0329301,-0.312043,0.125254,1.14511,0.105885,-0.669969,0.376948,-0.114052,0.00129573,0.225302,-0.0947061,-0.458791,0.473809,-1.04329,0.180975,-0.0798674,0.0733271,-0.56913,0.0672688,-0.082198,0.685917,0.0202219,-0.846906,-0.206393,0.102357,-0.0330805,0.21053,-0.071916,-0.0120204,-0.525003,-0.244818,0.944052,0.0196317,0.0487437,0.353685,0.000182198,0.421711,0.107243,-0.483451,0.256823,-0.542626,0.132367,0.747782,-0.0813031,0.0172993,-0.288523,0.0115744,-0.119919,-0.43372,0.555365,-0.344051,-0.0929052,-0.513957,-0.287123,-0.692898,0.0295723,-0.574945,-0.277103,-0.112895,0.558582,0.212491,-0.148395,0.148243,-0.662813,-0.318458,-0.0146774,0.325995,0.538328,0.0946126,-0.138854,0.467847,0.206323,-0.381166,-0.624278,0.052473,-0.924242,0.533609,-0.453161,0.0921403,0.355367,-0.386799,-0.552268,-0.0644628,0.175901,0.340464,0.0343401,0.154023,0.262747,0.0922347,-0.0207579,-0.159196,-0.261369,-0.324839,-0.0653521,-0.197859,0.0112342,-0.362891,-0.172317,0.400637,-0.0840391,0.255863,-0.36253,0.147082,0.0572479,-0.337115,-0.0580947,-0.724026,0.256981,-0.086482,0.0871386,-0.0709906,0.784349,0.45605,0.392937,-0.0334497,-0.0275786,0.258466,0.181359,-0.123629,-0.554113,0.53861,0.205272,0.262873,-0.282403,-0.298093,0.13569,0.171612,0.368362,0.414261,-1.11668 +3432.93,0.794669,0.0912059,4,1.50873,0.864826,-0.701099,0.215986,0.464905,-0.0803902,0.355422,-0.0334073,0.684284,0.46045,0.0835072,-0.113268,-0.266091,0.355785,-0.0518143,1.37304,0.167557,0.378224,-0.10847,-0.175762,0.0276316,-0.473738,-0.651203,0.325218,-0.321473,-0.0833252,0.21822,0.206401,-0.232941,0.304961,1.02925,-0.446605,-0.185257,0.279404,0.0957272,-0.131397,-0.0556207,0.631705,0.618326,-0.304796,0.750085,0.0468943,0.292439,-0.443988,-0.202041,-0.678778,-0.269217,-0.0452275,0.258807,0.166527,0.116181,0.343958,0.0737988,-0.281795,0.710812,-0.616048,-0.20723,-0.463779,0.592973,-0.0605751,0.590541,0.554512,-0.889497,-0.533518,0.647209,0.227878,0.153624,0.392878,-0.122325,-0.460686,-0.0156437,0.450168,0.562944,-0.0830996,0.168186,0.559404,0.222249,-0.056454,0.161323,-0.0839645,0.375837,-0.13361,0.353907,0.485163,-0.30337,-0.41092,0.204416,-0.0800315,-0.0926275,-0.0603723,0.397285,0.4532,0.228032,-0.39913,0.654244,-0.570589,0.161953,-0.497269,0.172733,0.67486,0.871193,0.171661,-0.33466,0.134751,0.0259056,0.062131,0.639748,-0.140422,0.38767,0.491763,0.0245352,0.0725909,0.158253,0.656771,0.188377,-0.416241,-0.520688,0.24114,0.438078,-0.243534,-0.279067,0.205298,0.326876,0.113977,-0.712716,-0.257407,0.119275,-0.335024,0.54623,-0.471247,0.191933,0.0297655,-0.327532,0.529461,0.0613955,0.00532215,-0.0384723,-0.232274,0.327935,-0.330351,-0.045051,0.00504638,0.30012,-0.192789,0.00200118,0.248824,-0.102342,0.320819,-0.350201,-0.359608,0.0816813,0.639659,0.226436,0.151616,0.443275,0.76664,0.209608,-0.185592,0.359026,0.401244,0.217257,0.170258,0.934262,-0.0800888,-0.378258,-0.0779998,-0.0571338,-0.0779164,0.167929,-0.430243,0.251489,0.90291,0.225319,0.183265,-0.0108651,0.150571,-0.677438,0.259544,-0.502329,0.910728,0.491214,-0.0654242,-0.257261,0.464423,-0.103022,-0.144716,-0.219502,-0.287256,-0.369005,-0.302072,0.156883,0.113087,-0.540299,-0.925098,-0.183621,0.249057,0.284181,-0.160649,-0.286417,0.300973,-0.237461,-0.250175,0.198878,-0.333281,0.0877494,-0.154355,-0.249751,0.736092,-0.313108,0.282601,0.00265456,-0.0918437,0.428111,0.286232,-0.412668,0.338417,-0.213774,0.656301,0.35092,0.170087,0.46632,-0.453571,-0.0939709,-0.550068,-0.306935,0.431274,-0.513098,0.190077,0.260746,0.44113,-0.151639,0.355084,-0.460203,-0.160291,0.310902,0.765622,-0.137535,-0.414903,1.23162,-0.123493,-0.318608,-0.353511,0.143199,0.236721,0.679584,0.00325303,0.405565,0.134157,0.120805,-0.148658,0.238925,-0.724016,0.277234,-0.384189,0.0653787,0.690694,-0.341235,-0.506244,-0.0196703,-0.222778,0.268284,0.37893,-0.141585,0.254354,-0.264346,-0.264937,-0.281808,0.23912,-0.0848868,0.169833,-0.661509,-0.720772,-0.759714,-0.402354,-0.127367,-0.526994,0.203819,0.211627,0.032246,-0.205654,-0.160984,-0.34687,-0.464088,-0.302877,0.164864,-0.0462041,-0.421526,0.474135,0.430265,0.324161,0.126447,0.670168,0.0230232,0.170968,0.208863,-0.419228,-0.522145,0.330245,-0.379636,-0.881116,-0.16288,0.128244,0.26998,0.358111,0.519596,-1.37999 +3430.24,0.847383,0.0912059,4,1.47568,0.788061,-1.00218,0.392294,0.689792,0.0890821,-0.0136252,0.107644,0.474137,0.372744,0.22831,0.0345519,0.0807226,0.293233,0.179504,1.21113,0.436385,0.192511,-0.306323,-0.219882,-0.0616547,-0.325871,-0.916696,0.601921,-0.380212,-0.467957,0.0981982,0.0998372,-0.527039,0.332318,1.07769,-0.569305,0.161461,0.130149,0.0771756,-0.339671,-0.207449,0.457769,0.35564,0.0877089,0.481207,-0.0415775,0.461604,-0.54435,-0.203552,-0.953782,-0.0286634,0.180216,0.368652,-0.0154056,0.107078,0.308401,-0.162479,-0.0501631,0.521946,-0.487894,0.336802,-0.644977,0.271086,-0.423928,0.414714,0.694284,-0.704488,-0.43134,0.437291,0.15008,0.0995766,0.170199,0.00574681,-0.36039,-0.18492,0.463164,0.782401,0.0423169,0.40963,0.47702,0.338268,0.191187,0.243177,0.341886,-0.101238,-0.117771,0.16647,0.334583,-0.211385,-0.174814,0.0563685,-0.247802,-0.170052,-0.130761,0.241126,0.498045,0.317057,0.0235001,0.738692,-0.473224,0.232416,-0.337482,0.0849256,0.551557,0.620995,-0.0247758,-0.193952,0.0244989,0.282971,0.211536,0.770638,-0.0584833,0.677565,0.358772,0.30379,-0.159963,0.122323,0.720718,-0.054291,-0.267478,-0.545865,-0.0437391,-0.18505,-0.238965,-0.560812,0.102166,0.321064,0.0271462,-0.259868,0.229038,0.282123,0.112607,0.416623,-0.0360061,0.240623,0.152789,-0.00864201,0.209318,-0.151963,-0.202145,-0.288124,-0.0538425,0.452856,-0.245448,-0.0577006,-0.0406517,0.0651515,-0.262621,-0.0894625,0.160389,-0.202678,0.612604,-0.345931,-0.13412,0.101755,0.632441,0.15316,0.473294,0.747134,0.732932,0.383611,0.104569,0.717463,0.343761,0.305021,0.357358,0.890788,-0.21199,-0.221512,0.0760923,0.173549,-0.0640256,0.183464,-0.087121,0.155813,0.72926,0.44493,-0.0632681,-0.00226275,-0.0117849,-0.33629,0.268153,-0.296781,1.09815,0.573338,-0.211749,0.413928,0.19739,-0.0187284,0.293827,-0.447734,0.00460232,-0.439972,-0.371877,0.244635,0.0856124,-0.414731,-0.711809,-0.398832,0.0933826,0.392521,-0.100007,-0.252958,0.0492416,-0.203167,-0.800527,0.229204,-0.417266,-0.147326,-0.186265,-0.466811,0.716138,-0.0723005,-0.00458455,0.0824262,-0.0861153,0.545163,0.125934,-0.448229,0.664195,-0.055072,0.321627,0.600039,-0.450122,0.350715,-0.719335,0.151006,-0.590002,-0.437924,0.570219,-0.570543,0.110845,-0.24362,0.139643,-0.145613,0.383227,0.0443383,-0.106458,0.357453,0.659298,0.304101,0.0745012,1.04899,-0.179919,-0.459925,-0.639102,-0.390345,-0.117498,1.01581,-0.14404,0.372757,0.0359519,-0.0281972,-0.15041,0.173015,-0.831854,0.386924,-0.322582,0.218876,0.64514,-0.321276,-0.29051,0.0380728,0.0232948,-0.145947,0.127881,-0.0275271,0.612084,0.016147,-0.182126,-0.0163467,0.481976,0.334592,-0.193274,-0.614764,-0.86632,-0.446986,0.0594313,0.279269,0.0396919,-0.14908,0.244131,0.227437,0.00367676,-0.0959677,-0.356889,-0.4087,-0.306507,0.285692,0.135983,-0.37078,0.760656,0.302647,-0.0483355,0.0665705,0.424896,-0.0924766,0.00485831,0.0890518,-0.318585,0.0917536,0.616972,-0.216686,-0.126903,-0.203809,0.148924,0.190786,0.385907,0.43679,-2.07528 +3430.4,0.971946,0.0912059,4,1.47574,0.775236,-0.991625,0.419912,0.682265,0.0956967,0.0120702,0.132988,0.471578,0.345037,0.2411,0.0527109,0.077037,0.36529,0.174951,1.19832,0.432549,0.186938,-0.29269,-0.199586,-0.0714176,-0.351668,-0.953279,0.583846,-0.38879,-0.429276,0.106062,0.0734969,-0.484484,0.324381,1.07324,-0.568094,0.209785,0.125292,0.0482845,-0.309469,-0.195622,0.463418,0.376587,0.12913,0.477741,-0.0239285,0.43208,-0.551385,-0.184416,-0.993103,-0.0150517,0.213097,0.351837,-0.0227995,0.132589,0.264458,-0.198184,-0.0790111,0.525884,-0.543935,0.343408,-0.655457,0.316231,-0.404172,0.430907,0.691218,-0.688608,-0.45954,0.453039,0.168879,0.168867,0.182201,0.00256829,-0.393193,-0.189112,0.473626,0.800933,0.0466925,0.422091,0.483812,0.330388,0.156397,0.251127,0.373743,-0.0970445,-0.0939556,0.220041,0.284842,-0.188936,-0.111048,0.0462857,-0.214333,-0.151597,-0.109731,0.211046,0.429819,0.293762,0.0081958,0.761636,-0.461457,0.204126,-0.363203,0.0903916,0.592157,0.613332,-0.0491308,-0.239121,0.0327018,0.297693,0.17168,0.746566,-0.028699,0.658138,0.380294,0.299537,-0.159411,0.126432,0.735129,0.00208765,-0.285919,-0.498824,-0.0153847,-0.201976,-0.259167,-0.562311,0.154443,0.357962,0.0296979,-0.234392,0.178376,0.211155,0.0815417,0.429274,-0.0368101,0.281804,0.166617,0.00269972,0.172778,-0.162765,-0.16115,-0.295311,-0.0517892,0.476531,-0.260335,-0.086762,-0.0513668,-0.00230094,-0.240533,-0.0869915,0.12218,-0.194463,0.64392,-0.354582,-0.176764,0.080018,0.626628,0.163229,0.438645,0.735249,0.728082,0.377222,0.0996915,0.692373,0.332143,0.367283,0.381677,0.880123,-0.229167,-0.268132,0.116962,0.182704,-0.0252617,0.142558,-0.125994,0.117446,0.728822,0.451947,-0.101728,0.0286771,0.0289166,-0.336663,0.283644,-0.300154,1.14219,0.585588,-0.195078,0.438701,0.126101,-0.00131601,0.300382,-0.429847,-0.00885085,-0.438735,-0.39384,0.271682,0.0591232,-0.402868,-0.749089,-0.408013,0.0595316,0.421081,-0.0913783,-0.238828,0.065257,-0.205462,-0.810009,0.186403,-0.430752,-0.118485,-0.213518,-0.500455,0.723782,-0.0470492,-0.0127537,0.0604623,-0.0874257,0.574087,0.0607353,-0.450058,0.652138,-0.0376968,0.28648,0.614457,-0.471209,0.332075,-0.691064,0.178514,-0.622665,-0.423,0.590403,-0.593774,0.0726358,-0.279097,0.149853,-0.165925,0.368122,0.0508207,-0.152183,0.357566,0.642996,0.25297,0.0932224,1.00522,-0.218994,-0.417246,-0.616271,-0.382598,-0.173733,1.03204,-0.172392,0.344749,0.0143633,-0.0819249,-0.165286,0.173548,-0.8481,0.374939,-0.32455,0.224017,0.671214,-0.310873,-0.263791,0.0178091,0.0442549,-0.110534,0.150537,-0.00633657,0.618138,0.0142145,-0.170942,-0.00870578,0.499575,0.300762,-0.193199,-0.643079,-0.883832,-0.404106,0.0861973,0.246153,0.00048275,-0.153649,0.245914,0.200494,-0.0110416,-0.124728,-0.32359,-0.406244,-0.298571,0.285822,0.133195,-0.345448,0.72001,0.286311,-0.0858857,0.0453964,0.379844,-0.0882171,0.0209908,0.0606207,-0.290671,0.0542802,0.629074,-0.252834,-0.140086,-0.158162,0.146244,0.184342,0.382418,0.42935,-2.06095 +3443.19,1,0.0912059,4,1.52522,0.849869,-0.903802,0.30313,0.379714,0.0369065,-0.0692692,0.214032,0.4134,0.0209882,-0.0259913,-0.11017,-0.101958,0.319696,0.204308,1.39106,0.315178,0.24212,-0.236314,-0.282643,-0.188909,-0.840006,-0.447392,0.25481,0.182662,-0.200602,0.0129877,-0.155273,-0.225799,0.36036,1.07044,-0.365743,0.131039,0.174244,0.0290239,-0.270682,-0.483994,0.327335,0.413524,-0.0794621,0.888999,-0.0841492,0.354086,-0.70101,0.106425,-0.528823,0.0766863,0.442132,0.259317,0.0267221,0.253533,0.282603,0.278762,-0.950147,0.496289,-0.452217,0.148209,-0.9677,0.686991,-0.553122,0.143111,0.679155,-0.676643,-1.37178,0.118118,0.312399,0.150008,0.144487,0.235966,-0.858021,-0.345603,0.375471,0.831295,-0.0712789,0.109477,0.413357,0.323233,0.325591,0.0906965,0.168453,-0.0310142,-0.314283,0.27762,0.286138,-0.503975,-0.0563051,0.182543,-0.225446,0.253323,-0.284774,0.314288,0.275261,0.611929,-0.0209292,0.510532,-0.560838,0.33368,0.222834,0.203582,0.340075,0.439642,-0.288645,-0.0244424,-0.0667432,0.561073,0.012066,0.490761,0.0424612,0.418534,0.661176,0.18047,-0.39595,0.141,0.667507,0.215607,-0.382626,0.0158221,-0.432531,0.308752,-0.205123,-0.712209,0.115213,0.645472,-0.224829,-0.176733,0.564726,0.141464,-0.194697,0.372829,-0.356969,0.519768,0.234619,-0.146961,0.210259,-0.246395,-0.44958,0.181188,-0.232102,0.339411,-0.347676,-0.208853,0.000466521,0.375713,-0.203132,-0.0836619,0.335921,0.244844,0.544502,-0.309889,-0.785257,0.234993,0.397508,0.41973,0.66223,0.448795,0.675122,0.601133,0.154549,0.731756,0.442971,-0.0347892,0.425219,0.774788,-0.131834,0.17728,0.325942,0.0348804,-0.185476,-0.18449,0.14377,0.196168,0.908955,0.207861,0.107513,0.0793774,-0.383219,-0.251371,0.334055,0.245544,0.820484,0.193347,0.149995,0.277777,-0.165846,-0.220133,-0.180895,-0.638779,0.128907,-0.157687,-0.298939,-0.00918969,-0.187027,-0.419352,-0.61101,-0.239028,0.465335,0.195325,0.128004,-0.199097,-0.329373,0.130483,-0.455013,0.191433,-0.598049,0.0910801,-0.160999,-0.309973,0.702905,-0.154335,-0.252244,0.421009,-0.223484,0.346799,0.0613657,-0.391783,0.477027,0.11236,0.323565,0.195241,-0.604988,0.228372,-0.58746,0.293098,-0.259967,-0.417605,0.443383,-0.40822,-0.320171,-0.42096,0.522088,0.0392361,0.356857,0.409094,0.0566104,-0.223491,0.314008,0.231994,0.164458,0.636402,-0.272018,-0.559794,0.0362473,-0.237086,-0.00874485,0.881072,-0.200839,0.430082,0.0902264,0.0412285,-0.24035,0.171225,-0.805803,0.0218767,-0.444713,0.065229,0.513271,-0.326087,-0.149719,-0.0879368,0.0258368,0.0563395,-0.00772314,-0.0112959,0.412061,-0.116735,-0.241285,-0.172382,0.391154,0.286302,0.0246061,-0.882669,-0.598017,-0.0908033,0.192569,0.0991176,0.0834088,-0.206297,0.0391457,0.298685,0.137851,0.00111166,-0.2563,-0.211682,-0.225543,0.253961,0.325773,-0.413994,0.733927,-0.165303,-0.0688394,0.26199,-0.0797688,-0.484929,0.301086,-0.166205,-0.171732,-0.0353399,0.115585,0.10473,-0.248152,-0.193875,0.125502,0.298563,0.354263,0.546409,-1.05971 +3434.24,0.817138,0.0912059,4,1.47267,0.991316,-0.569383,0.182458,0.83061,0.00106278,0.28423,-0.13429,0.492578,0.0446519,-0.00210298,0.140584,0.0978967,0.160845,0.0846957,1.1851,-0.0424842,0.136432,-0.0485791,-0.120045,-0.170704,-0.422927,-0.393798,0.280003,-0.239134,0.29312,0.294295,-0.137743,-0.855685,0.480706,0.759258,-0.0983175,0.0343067,-0.0713605,-0.154828,-0.549661,-0.0356593,0.795039,0.488821,-0.0573215,0.694247,0.274401,0.891995,-0.493302,-0.19559,0.22403,-0.169367,0.127934,0.359153,0.121375,0.112281,0.0566861,0.622002,-1.18468,0.625258,-0.16689,-0.0774306,-0.7673,0.767737,-0.936057,-0.370666,0.942161,-0.745492,-1.74968,-0.314326,0.215003,0.361948,-0.223093,-0.106459,-0.0960027,-0.586138,0.449061,0.609117,-0.313651,-0.054658,0.338859,0.408161,0.0882804,0.242342,-0.00356772,0.65671,-0.342586,0.169293,0.361572,-0.204669,0.284312,-0.207124,-0.62115,-0.209345,-0.285281,0.234207,0.394599,0.185333,0.0630006,0.372082,-0.538811,0.384572,-0.465937,-0.0374244,0.366393,0.041924,-0.515736,-0.00407189,0.374646,0.465871,-0.111409,0.684221,-0.0326535,0.622854,0.518317,0.139579,-0.739428,-0.0552444,0.534207,0.246896,-0.20424,-0.022281,0.141733,0.770216,-0.125061,-0.81198,-0.0479488,0.0712547,0.151901,0.0440752,0.0568739,0.168398,0.651761,0.314113,-0.476466,0.148202,-0.114669,0.245323,0.255988,0.194999,-0.16157,0.209709,-0.0922545,0.550013,-0.635165,-0.0741568,-0.0728622,0.313091,-0.602589,-0.236677,0.0489666,-0.0383739,-0.0508029,-0.58218,-0.116362,0.0718037,0.220859,0.269677,0.224208,-0.244173,0.182828,0.302536,-0.0880531,0.260601,0.241584,-0.392249,-0.165235,0.625163,-0.657369,-0.241045,0.247171,0.112571,-0.0805377,0.426773,-0.230221,-0.224882,0.273116,0.258296,0.431179,-0.0501865,-0.0770077,-0.548609,0.265592,0.383603,0.917134,0.200423,0.129969,0.336349,-0.354891,0.582322,-0.215033,-0.11683,-0.268996,-0.155804,-0.747718,0.128722,-0.143972,-0.7364,-0.480421,0.0949215,0.287985,0.112795,-0.335485,-0.441897,-0.479011,-0.2217,-0.369734,0.122818,-0.276811,-0.0318562,0.0910398,0.00918143,0.905969,0.167265,0.698812,0.545603,-0.274163,0.0465607,0.0863772,-0.757643,0.435429,-0.352458,0.34899,0.462926,0.0381918,0.0170504,-0.319049,0.577512,-0.449352,-0.0699033,0.383515,-0.149972,-0.595686,0.127181,-0.0643361,-0.070873,0.441941,0.268003,0.28732,0.159728,0.309528,-0.191157,0.51898,0.689768,-0.178583,-0.291112,0.341606,-0.0909497,0.22708,0.55213,0.310479,0.760558,0.570232,-0.440788,-0.167793,-0.0177282,-0.715593,0.153363,-0.366528,-0.143015,0.363895,-0.238302,-0.344046,0.233655,-0.274204,-0.175938,-0.013326,-0.0287753,0.546039,0.697694,-0.468066,-0.399316,-0.473084,-0.0792827,0.0522069,0.0620185,0.213623,-0.162806,-0.129565,-0.143002,0.0341314,0.270682,0.628784,0.272426,-0.217803,0.324735,-0.0507013,-0.220955,-0.0406772,0.28893,0.0478852,-0.197078,0.0816366,-0.391923,0.0693724,0.0533457,-0.27224,-0.274125,0.494765,0.0759601,-0.0306636,-0.0922742,-0.0828768,-0.0240252,0.0113568,0.19801,0.127428,0.277936,0.35697,0.527196,-2.91152 +3442.81,0.997592,0.0912059,5,1.60124,1.04529,-0.399919,0.0894374,0.65331,-0.0288689,0.0350373,-0.465265,0.25477,-0.199425,-0.597275,-0.131725,0.181867,-0.0683031,-0.394473,1.26667,-0.121486,0.349558,-0.270119,-0.44572,-0.56585,-0.910895,-1.11842,0.141754,-0.44408,0.178156,0.287772,0.647468,-0.244371,0.318001,0.866636,-0.289063,0.260433,0.288832,-0.182588,-0.168884,0.353003,0.726159,0.509137,-0.917629,0.721405,0.608781,0.222675,-0.473266,0.0747215,0.216691,-0.0603974,-0.0403169,0.262375,0.00122773,0.0434742,-0.141454,0.37124,-0.854281,0.578681,-0.360209,-0.26992,-1.1353,0.232382,-0.600039,0.0194204,0.646923,-0.58797,-0.904112,-0.23715,0.0932295,0.217861,0.0162532,0.212749,-0.414688,0.0757242,0.260725,0.611611,-0.639003,-0.0171873,0.772321,-0.0496554,0.010732,-0.253705,0.236166,0.395288,-0.37376,-0.20607,-0.393487,0.0221085,-0.375662,0.0232077,-0.825008,-0.551032,-0.452291,0.0984545,0.212669,-0.242035,0.0984631,-0.30601,-0.17905,-0.0916761,-0.366977,0.798946,0.64142,0.192455,0.330016,-0.0870732,-0.31899,-0.198832,-0.36225,0.0555239,-0.0851646,0.347158,0.411006,-0.0526572,0.214789,0.199057,0.679856,-0.248881,-0.0913735,0.168392,0.275087,0.0284406,0.151683,-0.462653,0.143349,-0.195532,-0.0279781,0.0607088,0.482429,0.798511,0.99249,0.612669,-0.243128,-0.0626378,0.305659,0.378195,0.63748,-0.229976,-0.434955,-0.00803417,-0.558483,0.199196,-0.719308,-0.351873,-0.106521,0.6322,0.0503749,0.123123,-0.00518859,0.289381,0.387884,0.0331825,0.145715,0.0759339,0.110788,0.506084,-0.196893,-0.240061,0.252373,0.222341,0.295372,0.360301,-0.0774806,0.00844775,-0.134652,0.424851,-0.424041,-0.356053,0.172691,-0.0707311,-0.32964,0.0977662,-0.352765,-0.32028,-0.0600991,0.13593,0.21422,-0.0817183,-0.498018,-0.0661861,0.0715066,0.2517,0.874687,-0.215646,0.115842,0.207733,-0.30136,0.23558,-0.218556,-0.661502,-0.160532,0.113622,-0.380284,0.376195,0.232397,-0.311735,-0.430116,-0.380232,0.304985,0.352363,-0.0293604,-0.487419,0.173527,-0.0414654,-0.506199,-0.0495992,0.265866,-0.21114,-0.474321,-0.615658,0.759583,0.0602174,0.270031,0.110514,-0.517608,0.667268,-0.532791,-0.278118,0.18576,-0.298089,0.271275,-0.289168,-0.197332,0.0629137,-0.0584589,-0.319706,-0.0782023,-0.210321,0.373986,-0.578913,-0.226947,0.439591,-0.0409117,-0.211034,0.161865,0.038433,0.0952412,-0.235474,0.357519,0.352743,0.520876,0.172526,-0.33134,0.319437,0.423197,0.341013,-0.41133,0.459354,-0.0524802,0.497517,-0.250259,-0.241863,-0.369558,0.298906,-0.22132,0.465089,-0.493345,-0.307542,0.273292,-0.280128,0.132845,0.165027,-0.23349,0.285679,-0.207535,-0.0804951,0.43374,0.142792,-0.00992549,-0.119021,0.0266351,0.191898,0.0873514,-0.510562,-0.272396,0.0379003,-0.234455,0.0868572,0.257756,0.341101,0.115559,0.337239,-0.0116943,-0.333147,-0.420401,0.194527,0.148145,0.0686376,-0.283982,-0.211469,0.129345,-0.0825363,0.199616,0.235475,-0.101171,-0.0349392,0.342226,0.0014612,0.137951,-0.204916,0.173464,0.0723644,-0.904551,-0.105816,0.114735,0.339708,0.338725,0.582845,-2.2831 +3448,0.827772,0.0912059,4,1.59348,1.12205,-0.493921,0.0844746,0.574984,0.00782859,0.101309,-0.181904,0.270069,-0.0888187,-0.381016,-0.208628,0.160034,0.0102212,-0.178192,1.33734,-0.266298,0.347101,-0.311849,-0.297529,-0.799716,-0.886769,-0.797287,0.0612584,-0.181335,0.0839265,0.132333,0.371595,-0.226382,0.409234,0.675237,-0.129435,0.191068,-0.0856219,-0.13627,-0.12761,0.254615,0.65369,0.440374,-0.911754,0.729164,0.538907,0.0471186,-0.516877,-0.119486,-0.0958256,-0.089804,0.0604452,0.312072,0.117545,0.111037,-0.655552,0.263597,-0.816749,0.419167,-0.324287,0.00242515,-0.983916,0.282009,-0.695264,0.147784,0.77374,-0.820773,-0.956417,-0.228897,0.245618,0.141384,-0.0387326,0.512204,-0.617443,-0.132212,0.257523,0.567032,-0.269322,-0.0418225,0.772406,-0.0409653,0.0960064,0.00721777,0.143693,0.348242,-0.324996,-0.187087,-0.338685,-0.109121,-0.28242,-0.253743,-0.503483,-0.296436,-0.300605,0.0922116,-0.0458751,-0.441584,0.0314113,-0.531602,-0.107886,0.0172513,-0.310701,0.548968,0.591239,0.112793,0.414482,-0.369098,-0.140162,0.073715,-0.112824,-0.0300546,-0.00656491,0.411291,0.499332,0.144728,0.146939,0.0703717,0.59017,-0.0523554,0.100689,0.179227,0.383222,-0.0489926,0.174307,-0.40473,0.23096,-0.0901932,-0.00709511,0.102314,0.445514,0.765398,1.0996,0.779411,-0.264528,0.235896,0.118787,0.239231,0.5707,-0.131232,-0.372961,0.0342611,-0.347697,0.263502,-0.668095,-0.316053,-0.111782,0.609263,-0.109451,0.238984,0.250031,0.385494,0.189057,-0.228852,0.359543,-0.104911,0.0435292,0.449888,-0.333289,0.0180431,-0.039502,0.100109,0.529171,0.360627,-0.308959,-0.163677,0.288167,0.384647,-0.420709,-0.252034,0.305189,-0.18607,-0.242623,0.105198,-0.0416667,-0.27725,0.238478,0.22329,0.105825,-0.222334,-0.458187,-0.0271624,-0.204035,0.0446222,0.905797,-0.026404,0.0750103,0.188211,-0.125092,0.084998,-0.174458,-0.583062,-0.0461794,0.544017,-0.447834,0.297868,0.300713,-0.207872,-0.339018,-0.486939,0.599769,0.235376,0.0765822,-0.787251,0.190872,-0.126222,-0.60658,0.13774,0.257126,-0.162243,-0.226606,-0.394779,0.813758,0.237897,0.397937,0.0732887,-0.297308,0.535801,-0.209576,-0.410564,0.0842286,-0.139187,0.378694,-0.0564777,0.0986642,-0.0726213,-0.0019546,-0.520258,-0.333287,-0.0207432,0.217837,-0.420542,-0.410451,0.678524,-0.0913491,0.188043,0.0753388,-0.184587,-0.0315043,-0.0425852,0.34864,0.158208,0.470767,0.257402,-0.203166,-0.00907273,0.510265,0.252081,-0.371778,0.599436,0.0736731,0.23043,-0.329152,-0.0790416,-0.332804,-0.028309,-0.140744,0.554513,-0.388294,-0.219285,0.329832,-0.206066,-0.0382831,0.0697923,-0.171463,0.33979,0.068453,-0.203248,0.545365,0.0889409,-0.331255,-0.253835,0.0680542,0.182788,0.104509,-0.414616,-0.486716,0.110714,-0.243134,0.246758,0.253308,0.450456,-0.108926,0.33997,-0.160182,0.0612208,-0.35318,0.0301373,0.34236,0.127263,-0.253526,-0.39168,0.0676509,-0.198745,0.318242,0.305969,0.313845,-0.216604,0.395864,-0.0468999,0.198527,0.184679,-0.0487252,0.241553,-0.69673,-0.133087,0.129178,0.343888,0.359414,0.58642,-2.12164 +3457.5,0.841927,0.0912059,4,1.6492,1.09645,-0.489885,0.0354294,0.50683,-0.109461,0.30788,0.41717,0.257837,0.316584,-0.262886,-0.0900553,-0.246667,0.268047,-0.561995,0.892465,-0.36512,0.0207267,-0.176707,-0.201581,-0.526404,-0.971772,-0.636678,-0.0968885,-0.531959,-0.692675,-0.286288,0.529577,-0.491286,-0.0428414,0.492226,-0.368871,-0.00622514,0.180395,-0.231546,-0.0998464,-0.860958,0.25535,0.518242,-0.0830619,0.63315,0.728084,0.0393448,-0.862625,-0.297949,0.511887,-0.969768,-0.0950731,0.220402,0.106839,0.117685,0.837807,0.23912,-0.667104,0.740969,-0.295271,-0.358313,-0.377615,0.602436,0.0128577,-0.199607,0.885505,-0.176879,-0.816081,-0.00607242,0.0858491,-0.3439,0.451987,0.0303284,-0.54644,-0.595869,0.172262,0.506839,-0.172858,0.339011,0.437604,-0.16883,-0.0492115,-0.335497,0.0978359,0.473381,-0.604946,0.0941011,-0.540081,0.116891,0.622544,-0.0196903,0.132195,0.0558317,-0.336595,0.182693,0.289557,0.21014,0.179251,0.386137,-0.100977,-0.131257,-0.0703211,-0.0953892,0.523199,0.12291,0.0819354,-0.065926,0.265337,0.0440568,-0.0563781,0.223186,0.0369735,-0.01136,0.423016,0.0600316,-0.201351,0.0197507,0.205528,0.168782,0.413876,-0.480978,-0.151832,-0.319563,0.0870453,-0.73695,-0.0541382,-0.359935,-0.433914,0.0854146,0.0839621,0.116874,0.0608653,0.0154903,-0.687162,0.257341,-0.488825,-0.464142,-0.0454385,0.395254,-0.0538018,-0.116726,-0.141457,0.554688,0.0112246,-0.284123,-0.52257,0.0269613,-0.71284,-0.0843666,-0.300647,-0.113193,0.0706195,0.0732031,-0.184599,-0.380451,0.131059,-0.174209,0.0798987,-0.112609,0.740424,0.121897,0.276941,0.353598,-0.172277,0.786791,0.00448116,1.01607,-0.843033,0.185468,0.32322,-0.0499017,-0.0806444,-0.744118,0.0701003,0.246725,0.00172642,-0.10914,-0.181531,0.245988,0.376078,-0.213818,-0.345876,0.309393,0.542677,0.0889182,0.0847109,0.0767071,-0.140307,-0.0915042,-0.0954844,-0.0557924,-0.235276,0.0353994,-0.440857,-0.124305,0.341401,0.169814,-0.765104,-0.120279,0.507896,-0.23643,-0.400121,-0.744635,0.0110696,-0.258349,0.0996115,-0.0386628,-0.0901007,0.0328028,0.391391,-0.476664,0.875491,-0.0851184,0.146051,-0.0925196,-0.328027,-0.0512038,0.173467,0.279777,0.28809,-0.163858,0.155551,0.298709,-0.165261,0.385278,-0.34314,-0.0201864,0.570438,-0.0713222,0.818087,-0.185782,-0.17241,-0.57139,0.0280915,-0.146914,0.223909,0.0850162,-0.702312,-0.344555,0.481311,0.0343394,-0.0195456,0.752617,-0.631838,-0.157799,-0.0541383,-0.198923,0.18567,0.188379,0.176234,0.228301,0.186901,-0.165653,0.00524127,0.405211,-0.671014,0.442289,-0.393746,0.231466,-0.0413765,-0.133905,-0.0765773,0.0656757,-0.282626,0.228432,0.254916,0.0866778,-0.00983108,0.107924,0.0799049,0.0375314,-0.17386,-0.082265,-0.188409,-0.0802607,-0.267405,-0.1598,0.562659,-0.0634763,-0.246491,0.228031,0.0255655,0.322794,0.463325,-0.0770708,-0.144802,-0.486737,0.112099,0.374871,0.350293,0.133718,0.242796,-0.210564,-0.431269,-0.1398,0.0116244,0.11021,-0.273725,-0.588029,-0.456887,0.55429,0.163822,-0.0265121,0.50581,-0.334413,0.0933663,0.157527,0.305559,0.396897,-1.72067 +3444.64,0.877687,0.0912059,4,1.70875,0.995499,-0.552561,0.0458067,0.373158,-0.0966486,0.188968,-0.0864091,-0.291806,0.343796,-0.0794459,-0.235719,-0.287183,0.107362,-0.466129,1.09924,-0.218413,-0.215038,0.112383,0.27609,-0.815993,-0.972668,-1.04822,0.0797097,-0.404301,-0.265965,-0.407312,0.350262,-0.348618,0.0443669,0.380044,-0.641589,0.077524,0.0195582,-0.0429978,-0.374616,-0.842571,-0.140019,0.169906,0.0515883,0.697429,0.539422,0.405422,-0.779295,-0.16467,0.0141439,-0.715598,-0.199399,0.433144,-0.03457,-0.0599163,0.205842,0.131844,-0.640393,1.05225,-0.384041,-0.580731,-0.681281,0.604833,0.084879,-0.100298,0.893928,-0.568974,-0.616277,0.298428,0.339414,-0.0141871,0.296333,-0.177829,-0.588476,-0.114349,0.407231,0.352643,-0.15068,0.216999,0.403938,-0.0411689,-0.390809,-0.874625,0.465061,0.483325,-0.756741,0.0103559,-0.200919,0.210176,0.223867,0.156314,0.021924,-0.278396,-0.782256,-0.231644,0.196134,0.0397181,-0.00213604,0.512538,-0.0284318,-0.139952,-0.0426394,-0.307097,0.267546,0.00481642,-0.179154,0.319989,-0.0965074,-0.140271,0.123355,0.0244799,-0.220402,0.232389,0.463813,-0.112335,-0.159796,-0.0133882,0.299652,0.0677778,0.471392,-0.655967,-0.372662,0.0907532,0.515659,-0.160219,-0.475646,-0.350856,-0.287705,0.395391,-0.0037101,0.000611879,-0.114368,0.13798,-0.851023,0.335266,-0.571596,-0.43345,0.118172,0.173275,0.198848,-0.138554,-0.463742,0.402825,-0.396757,-0.308118,-0.336317,-0.194531,-0.736646,-0.0288897,0.296606,0.152528,0.261582,-0.0685749,-0.0804249,-0.0942991,-0.396025,-0.247853,-0.0637752,-0.00167759,0.403487,-0.12875,-0.235746,0.088217,-0.358225,0.322341,-0.0782194,0.914134,-0.132502,0.15923,0.246414,-0.146355,-0.353731,-0.55084,0.0875193,0.164005,-0.216298,-0.217945,-0.156247,0.401755,-0.13425,-0.225018,-0.30323,-0.179744,0.358573,0.612974,0.135088,-0.0640539,-0.253741,0.0881767,-0.460739,-0.00850855,-0.402753,0.146442,-0.508992,-0.398937,0.167419,-0.083089,-0.377604,-0.0422622,0.347467,-0.197669,-0.192575,-0.806349,0.531766,-0.277064,-0.20036,-0.298429,0.044985,0.245821,0.488508,-0.316214,0.892277,0.0515771,0.285666,-0.206234,0.296021,0.311921,0.0763648,-0.203495,0.244833,-0.467238,0.202046,-0.0619779,-0.441723,0.134178,-0.0602988,-0.170758,0.327948,0.148602,0.710477,-0.120909,-0.157018,-0.360536,-0.154242,-0.304351,-0.1357,-0.170403,0.101252,-0.0636304,0.390513,-0.271669,-0.0234724,0.0467023,-0.95865,0.551402,0.452129,0.0656324,0.091322,0.0196227,0.111844,0.340601,-0.176702,-0.00402431,0.0275752,0.276687,-0.336619,0.448456,-0.310194,-0.104959,-0.00371981,0.0740972,1.88059e-05,-0.145577,-0.247034,0.247938,0.492426,-0.296528,0.426014,-0.052835,-0.145249,0.143282,-0.00847283,-0.187822,-0.487604,-0.240769,0.181389,0.218928,0.259486,-0.095934,-0.433194,0.0823138,-0.0585156,0.768887,0.730931,-0.0727939,0.133956,-0.232335,0.131242,0.335618,0.253023,-0.266918,0.158436,-0.270932,-0.77907,-0.0706772,0.153375,-0.0131796,-0.00211461,-0.398959,-0.135999,-0.279424,0.247563,-0.027595,-0.338136,0.137542,0.109688,0.224787,0.331192,0.474117,-1.019 +3447.59,0.89911,0.0912059,4,1.60459,1.09203,-0.128521,-0.102164,0.84382,-0.0871593,-0.248598,0.524647,0.339426,0.401594,-0.0560218,-0.0870527,-0.438997,0.402459,-0.160295,0.92203,-0.156398,0.0049701,-0.334888,-0.112732,-0.549687,-0.814579,-0.155801,-0.000395714,-0.367296,-0.310637,-0.149346,0.194899,-0.653705,0.191599,0.443557,-0.661741,0.50153,0.420233,0.0301408,-0.0417142,-0.8736,-0.121222,0.515221,-0.144321,1.04631,0.647299,-0.14129,-0.877375,-0.114271,-0.0402806,-0.53798,0.0175161,0.0340183,0.220047,0.225847,-0.208976,0.177128,-0.492412,1.22446,-0.520468,-0.315617,-0.980856,0.725798,-0.502978,0.220865,0.818072,-0.620091,-0.989917,-0.287232,0.0969252,-0.19788,0.320896,0.000584694,-0.61514,-0.269038,0.296848,0.271453,-0.241486,0.407577,0.48464,0.252408,0.14318,-0.366424,0.314638,0.419373,-0.580799,-0.226433,0.0853241,0.607523,-0.136297,-0.0871364,-0.12971,-0.214696,-0.228363,0.207027,-0.150687,-0.244127,-0.147999,0.216918,-0.437314,-0.113174,-0.170846,0.213146,0.280144,-0.289371,0.10247,0.257997,0.273908,0.272035,-0.00298816,-0.148701,-0.0643634,0.138228,0.527765,0.20058,0.121984,0.380805,0.162351,0.25935,0.275169,-0.588659,-0.0351214,-0.0706362,-0.271034,-0.91167,-0.244412,-0.25141,-0.146676,0.0911658,0.253016,0.0320278,0.276178,0.0435916,-0.585207,0.493551,-0.153072,0.116937,0.806762,-0.390156,0.00033318,0.0907406,-0.376872,0.241558,-0.358426,-0.243818,-0.345596,0.34476,-0.300398,0.0142865,0.533506,-0.246817,0.495702,0.249453,-0.686953,-0.483885,0.464104,0.093924,-0.360477,0.361685,0.911551,0.0583112,-0.401248,0.0568647,-0.115277,0.488951,0.196091,0.567062,-0.225353,0.854667,-0.0444544,-0.238482,0.178918,-0.574943,-0.200313,0.579664,-0.166147,-0.336757,0.308837,0.600518,-0.157191,-0.0711811,-0.269964,0.314576,0.381148,0.136646,-0.344918,0.212204,0.250633,-0.145089,-0.757404,-0.164995,-0.0296787,0.431134,-0.0673543,-0.0908577,0.164293,-0.240442,-0.843687,0.183811,-0.0578428,-0.440439,-0.0924258,-0.621733,0.283336,-0.540109,-0.0266554,0.0373555,0.016689,0.348787,0.216608,-0.472329,1.11145,0.0887191,0.252376,0.0331392,-0.1127,-0.128556,-0.0294641,-0.0489973,0.273561,-0.704226,0.357111,-0.1767,-0.0328106,0.457358,-0.116787,0.344219,0.681228,-0.0754437,0.283514,-0.102196,-0.150775,0.335616,0.349834,-0.0155632,0.0534342,0.462611,0.595304,0.0766349,0.190479,-0.0466137,-0.160971,0.487312,-0.311868,-0.0368724,0.184443,-0.495564,-0.405731,0.343025,-0.346992,0.0823595,0.0105987,0.0759185,-0.738679,0.203228,-0.548886,0.0991982,-0.592732,-0.0545996,-0.111902,-0.291258,-0.0903066,-0.147495,-0.100171,-0.141025,0.491487,0.169622,0.0414144,-0.208983,-0.154248,0.0606551,0.009774,0.268406,-0.0986567,-0.437372,-0.0561471,0.18819,-0.228656,-0.15122,-0.226268,-0.0389693,-0.576618,0.125495,0.330086,-0.309637,-0.0493025,-0.10112,0.109198,0.298464,0.502017,-0.261871,0.317479,-0.0948771,0.0611563,-0.13085,0.160076,-0.0620631,0.361784,-0.273739,0.192358,-0.268875,0.300127,-0.170762,-0.14586,-0.0360544,0.100294,0.238248,0.316693,0.488107,-2.94117 +3440.94,0.991547,0.0912059,4,1.57443,0.936075,-0.840917,0.244279,1.13527,-0.111748,0.285609,-0.228549,0.629041,0.51661,0.163077,-0.48506,-0.470288,0.194346,-0.29492,0.978351,0.0732201,-0.114442,-0.336525,-0.130139,-0.471386,-0.607352,-0.999279,-0.0444051,-0.160799,-0.547545,0.160064,0.920645,0.074172,0.490744,0.40835,-0.507566,-0.0307419,0.248925,0.0921449,-0.544063,-0.85235,0.0923092,1.3175,-0.162022,0.988577,0.907027,0.546661,-0.170457,-0.0230893,-0.237799,-0.588425,-0.155829,0.295385,0.311215,-0.0281991,-0.287904,0.0891751,-0.286324,0.847007,-0.292795,-0.28675,-0.778518,0.530767,-0.0257063,0.408207,1.24923,-0.9196,-0.864353,-0.266666,-0.190726,-0.104237,0.0396458,0.152725,-0.431925,0.368066,0.540565,0.319374,-0.218757,0.552454,0.299801,0.225131,0.179867,-0.197258,0.205893,0.275805,-0.0204968,0.29955,-0.201298,0.610536,-0.177974,0.209858,0.0906653,-0.275748,-0.170967,-0.0637486,0.139741,-0.892575,0.0846787,0.441532,0.307054,0.0135639,-0.060767,-0.316935,0.222759,-0.549919,-0.184908,-0.143934,0.148617,0.164267,-0.104303,-0.0359529,0.081637,0.314582,0.497253,0.0439504,0.0721946,-0.268724,0.429085,0.178791,0.20948,0.305028,0.0110813,-0.039755,-0.289653,-0.494506,0.441518,-0.26785,-0.334763,-0.310582,0.269215,0.0170446,-0.187982,0.0372724,-0.329422,0.283985,-0.500129,-0.0202111,0.215343,-0.111411,0.159829,0.262233,0.269568,0.734496,-0.383326,0.189745,0.0425985,-0.200207,-0.487402,0.59725,-0.0423058,-0.259107,-0.0958392,0.16476,0.0805064,0.0815024,0.0949444,0.454293,0.331946,0.495198,0.778574,-0.0762217,-0.0936405,-0.16646,-0.174306,-0.186881,-0.0959464,0.417034,-0.352071,0.0927949,-0.0504824,0.481039,0.140044,-0.335319,0.160766,0.413532,-0.0501548,0.0591055,0.161873,0.230858,-0.00527296,-0.0129717,-0.550448,0.186037,0.0965649,0.013758,-0.064758,0.270874,-0.41786,-0.180229,-0.104108,-0.263749,-0.345689,0.40505,0.0703688,-0.474557,0.0271406,-0.232195,-0.676674,0.282386,0.14224,-0.239802,-0.270055,-0.438456,-0.196519,0.0899321,-0.491338,0.168503,-0.41314,0.0603145,0.291419,-0.620838,1.14564,-0.286912,0.288911,-0.0587203,-0.0939382,0.282922,0.0749868,-0.0805963,-0.147291,0.297966,-0.143871,-0.666958,-0.216598,0.0327188,-0.249881,-0.258415,0.294495,0.200898,0.681809,-0.530382,-0.878654,0.748779,-0.0561697,-0.234909,-0.0900457,-0.0388882,-0.099242,0.265868,0.702953,-0.330581,0.172851,0.146574,-0.305308,-0.155577,0.306139,-0.307585,0.0866878,0.345179,-0.547536,0.615422,0.251749,-0.184575,-0.345351,0.268464,-0.254818,0.428933,-0.451865,-0.019106,-0.0187852,0.167925,0.197686,-0.235578,0.0671416,-0.226247,0.721796,0.212513,0.122358,-0.107728,-0.14528,0.441273,-0.0367039,-0.0891815,-0.229456,-0.321112,-0.0680802,-0.0674155,0.0386148,0.393752,-0.2402,-0.359307,-0.060119,0.048303,0.109945,-0.36557,-0.384109,0.268069,-0.46348,0.299902,-0.0147193,-0.216191,0.189806,-0.321009,0.312581,0.157833,0.192092,0.267591,0.382057,-0.149645,-0.438067,-0.305939,-0.443058,-0.0339534,0.0900313,-0.211465,0.116192,0.318026,0.34087,0.563938,-3.61125 +3430.61,0.725909,0.0912059,4,1.55519,0.92495,-1.03872,0.320001,0.822729,-0.0348333,0.4054,0.280909,0.0756084,-0.528211,0.133013,-0.105332,-0.70608,0.388325,-0.34191,0.677506,-0.267901,0.319449,-0.0651729,-0.408215,-0.470407,-1.2029,-0.623318,-0.164185,-0.408327,-0.147567,-0.328776,0.0422033,-0.762269,0.154076,0.71978,-0.570254,0.293854,0.438381,-0.459134,-0.190668,-0.0993577,-0.234575,0.35783,0.19556,1.10621,0.805096,0.409971,-0.610922,-0.0231457,-0.0440173,-1.12711,0.1686,0.418979,-0.197068,0.0747487,0.393096,0.384713,-0.378468,0.475169,-0.463698,-0.0872323,-1.49617,0.437809,-0.536952,-0.0324012,1.02984,-0.561193,-1.17442,0.455042,0.187199,0.171492,-0.0737295,0.261207,-0.23512,-0.38041,0.6816,0.40972,-0.272226,0.526928,0.438735,0.0945409,0.171203,0.059544,0.319318,0.585023,0.0362164,0.476006,0.395224,0.407596,0.0215414,-0.419644,-0.242321,0.250657,-0.213811,-0.450054,-0.181965,0.455297,0.108506,0.10257,-0.0997468,0.520115,-0.331144,0.313089,0.134092,-0.0727667,-0.245062,-0.407028,-0.221296,-0.101184,0.151541,0.305138,-0.368393,0.299905,0.444258,-0.107008,-0.218961,0.257004,0.558712,-0.0969213,0.309031,-0.230575,0.496573,0.0575643,-0.0977346,-0.70541,0.577063,-0.195777,0.30716,-0.156148,0.0886628,-0.0147651,0.103585,0.365472,-0.48844,0.193026,-0.213164,0.0144401,0.326311,-0.63164,-0.147632,0.315672,-0.0493102,0.316966,-0.484622,-0.0565298,0.30821,-0.197066,-0.246899,-0.538064,-0.183516,0.115738,0.237179,0.00169331,0.0255304,-0.107051,0.137406,0.308641,0.322979,0.327563,0.117859,0.189052,0.0120218,0.00234553,-0.107963,0.388487,0.13999,0.833636,-0.0581526,-0.293635,0.0143043,-0.400574,0.197291,0.0331884,0.715847,0.0964396,-0.351446,0.0924181,-0.0528556,0.20601,0.0280098,0.00413344,-0.11925,-0.0758263,0.630796,0.549917,-0.294866,-0.260932,0.0461168,-0.219216,-0.0545451,-0.241925,-0.49211,0.0736636,-0.446071,0.281435,0.536399,-0.521999,0.0898166,-0.22942,0.000100711,-0.187928,-0.2681,-0.379628,-0.790653,0.135643,-0.0546502,0.327696,0.0712364,-0.431287,-0.498213,-0.275719,0.892132,0.533555,0.200256,0.291152,0.0276137,-0.0636408,0.0565053,0.194331,0.160185,-0.644867,-0.0167515,0.103345,-0.235616,-0.174194,0.0441542,0.170563,0.0810609,-0.302903,-0.0396552,-0.057074,-0.0960105,0.182424,-0.0554998,0.0876854,0.408868,0.409158,-0.322389,-0.327037,0.236457,0.0985383,-0.188879,0.567978,-0.361433,-0.518556,-0.642487,-0.280179,0.181818,0.569575,-0.286232,0.242242,0.144787,0.19423,-0.334495,-0.457417,-0.538474,0.358362,-0.544358,-0.383189,0.510734,-0.35581,-0.0437883,-0.317307,0.186718,0.234314,0.128179,-0.0237945,0.063881,-0.161351,-0.314082,-0.357951,-0.144561,0.404716,0.228847,0.5132,-0.435838,0.183967,0.419711,-0.365059,-0.0113114,0.409925,-0.424587,-0.536154,-0.145069,0.12468,-0.298907,-0.371057,-0.0747223,-0.0869796,0.204308,0.0577925,0.577113,-0.263483,-0.101303,0.158187,-0.278641,0.0180198,0.562711,0.190628,-0.356808,-0.176917,0.133737,0.610633,-0.324227,0.0633573,0.104468,0.301999,0.323215,0.549544,-2.56037 +3431.95,0.891291,0.0912059,4,1.67169,0.972305,-1.11548,0.343333,0.850437,-0.0863621,0.330755,0.10497,0.253137,-0.461315,-0.288017,-0.141364,-0.349393,0.101853,-0.253998,0.966444,-0.588167,-0.0700242,-0.253288,-0.215418,-0.549447,-0.882943,-0.637358,-0.257834,-0.55682,-0.102803,-0.197267,-0.0398835,-0.334624,-0.176645,0.579503,-0.773259,0.368031,-0.0134144,-0.544441,-0.219498,0.0519553,0.307933,0.0630521,0.219784,0.749829,0.473558,0.473694,-0.562797,-0.156496,-0.242016,-0.986519,0.454566,0.593424,-0.354646,0.130507,0.10254,0.0360096,-0.0656676,0.411765,-0.378187,-0.179676,-1.59651,0.341766,-0.823287,-0.0375373,0.822586,-0.803564,-0.654716,0.260041,0.11969,0.258063,-0.262941,0.405519,-0.472077,-0.23536,0.740755,0.180207,-0.293171,0.474157,0.265162,0.30558,0.178733,0.166376,0.105534,0.846549,-0.0338703,0.354281,0.506658,0.41154,0.00272601,-0.343127,-0.0962317,0.222336,-0.140487,-0.730027,-0.0671995,0.193283,-0.217185,0.0698867,-0.5058,0.0896242,-0.3377,0.149202,0.218508,-0.191318,-0.120464,-0.643267,0.0858707,-0.107437,-0.0576849,-0.254835,-0.329588,0.395307,0.340136,-0.370074,-0.521556,0.206632,0.385317,0.217454,-0.352085,-0.279609,0.270149,0.257985,-0.002777,-0.726814,0.171642,0.00764231,0.220219,-0.118219,0.186894,-0.481509,0.520114,0.614418,-0.267574,-0.243054,-0.104838,0.139493,0.236257,-0.277021,-0.29039,-0.0278921,-0.371355,0.702311,-0.717827,-0.288975,0.214336,0.203336,-0.0768442,-0.141409,0.194888,0.011445,0.44362,-0.439235,-0.456194,-0.100655,0.0298264,0.313184,-0.122341,0.453672,0.571588,0.0722861,-0.174373,0.145526,-0.201311,0.317326,0.121575,0.704239,-0.46451,0.00333443,0.434609,-0.309358,-0.0426499,-0.130267,0.710879,0.238096,-0.136857,0.143697,-0.204233,0.190621,0.281919,0.00319139,0.384336,0.083264,0.745799,0.0753007,-0.138417,0.0387293,-0.257314,-0.322572,0.108725,-0.0792919,-0.401934,0.280999,-0.193848,-0.134729,0.310001,-0.429332,0.0469791,0.0916524,0.381534,-0.145801,-0.24941,-0.19375,-0.859937,0.0672593,-0.14362,0.00674971,0.614716,-0.121428,-0.503728,-0.085126,0.813641,0.327824,0.290301,0.165942,-0.0603051,0.228153,0.124438,0.500205,0.416162,-0.252314,-0.00931295,0.216775,-0.117964,-0.461176,-0.340555,-0.0822363,0.178574,-0.303785,0.215457,-0.0660152,-0.391033,0.4319,0.133931,0.226146,0.193675,0.135091,-0.649978,-0.444176,0.259582,0.121503,0.0233278,0.550515,-0.0978892,-0.571083,-0.415613,0.167497,0.0849968,0.647612,-0.401243,0.345686,0.186804,0.437169,-0.260925,-0.675886,-0.58276,0.702798,-0.931991,-0.446007,0.466657,-0.5423,0.227594,-0.472086,0.241348,-0.138598,0.193439,0.0906736,0.243336,0.0696742,-0.376004,-0.0768083,-0.156303,-0.0501338,-0.030787,0.269307,-0.361669,0.0937312,0.716481,-0.268785,0.0715705,0.235156,0.198553,-0.713656,-0.660784,-0.0776409,-0.210782,-0.127319,-0.156631,-0.108836,0.216885,-0.291035,0.587156,-0.397366,0.00971173,0.0924876,-0.127842,0.319851,0.190667,0.224694,-0.00288094,0.0676462,0.0564268,0.308377,-0.140418,-0.06768,0.108286,0.284382,0.329068,0.533275,-2.58849 +3436.36,0.82458,0.0912059,4,1.67143,1.00187,-0.984375,0.345015,0.652016,-0.0809546,0.116685,0.162401,0.132275,-0.526474,-0.278241,-0.0427235,-0.278151,0.162301,-0.360216,0.961866,-0.53042,-0.0066826,-0.242726,-0.198612,-0.690529,-1.07172,-0.482781,-0.25541,-0.355124,0.0034698,-0.158819,-0.135185,-0.471213,-0.180085,0.643593,-0.697579,0.162029,0.019257,-0.452102,-0.452356,-0.0649948,0.38832,0.0662003,0.0432114,0.772989,0.497929,0.388757,-0.395144,-0.20589,-0.118782,-1.09752,0.635039,0.340555,-0.486521,0.286422,0.0919824,-0.00694064,0.148044,0.365935,-0.623865,-0.342308,-1.534,0.222674,-0.790029,0.284263,0.610986,-0.754616,-0.186553,0.20488,0.331395,0.270188,-0.172008,0.174342,-0.414629,-0.28647,0.790418,0.316944,-0.0784197,0.317979,0.279855,0.141527,0.0343708,0.117144,0.206815,0.829149,0.0916921,0.342178,0.319707,0.0798222,0.0231384,-0.360631,-0.248961,0.225307,-0.3181,-0.447874,-0.248979,0.137598,-0.140562,0.255989,-0.251199,0.188491,-0.496941,0.363068,0.184288,-0.305259,-0.206512,-0.726865,0.191158,-0.0499633,-0.178805,-0.196696,-0.448367,0.375263,0.122949,-0.216465,-0.48781,0.144399,0.388812,0.0808644,-0.614749,-0.246841,-0.061915,0.147459,-0.134738,-0.563513,0.114337,0.0765252,-0.0969955,-0.268403,0.168572,-0.563483,0.262745,0.748545,-0.38705,-0.0138772,-0.176076,0.239624,0.24322,-0.34887,-0.252298,0.0412004,-0.493882,0.606623,-0.579834,-0.34964,0.345005,0.166604,-0.265595,-0.220768,0.341113,-0.00122562,0.558732,-0.220492,-0.265252,-0.409219,0.0459191,0.432755,-0.120935,0.376328,0.5998,-0.0937328,-0.33035,0.214821,-0.068222,0.411563,0.00097751,0.784126,-0.487299,-0.236414,0.170236,-0.23404,-0.0161305,-0.127454,0.72495,0.155637,-0.184062,0.11373,-0.236615,-0.0060587,0.200808,0.202297,0.525843,0.17538,0.677748,0.171372,-0.211065,-0.0692787,-0.246316,-0.116532,0.0885897,-0.082016,-0.437323,0.219073,-0.265603,0.00167335,0.145749,-0.36687,-0.206615,-0.115104,0.456158,-0.0617125,-0.248667,-0.29904,-0.873443,0.0624458,-0.288696,0.26406,0.797174,-0.244257,-0.146944,0.190097,0.895095,0.154923,0.334362,0.186184,-0.0053478,0.242379,0.226813,0.0627768,0.399731,-0.100135,0.130346,0.345838,0.145213,-0.0842911,-0.423672,-0.14376,0.0157603,-0.583076,0.311688,0.0726532,-0.25701,0.229591,0.227801,0.0635689,0.171382,0.178822,-0.385695,-0.291562,0.0773511,-0.219273,0.104251,0.686902,-0.171342,-0.371357,-0.3755,0.364129,-0.0626254,0.285109,-0.42251,0.296571,-0.165091,0.205482,-0.561227,-0.840319,-0.644116,0.489628,-0.689553,-0.55819,0.27766,-0.495033,0.310033,-0.568702,0.066652,0.0155923,0.12436,0.108998,0.280945,0.119451,-0.209091,-0.101059,-0.0806399,-0.428236,-0.197691,0.287508,-0.0358231,0.0984185,0.594535,-0.0945611,-0.0683796,0.395133,0.167146,-0.430182,-0.674184,-0.0632185,-0.339831,-0.157282,0.186737,-0.13713,0.189722,-0.227212,0.550087,-0.257528,0.16219,-0.0249462,0.00709026,0.230474,0.362608,0.0889395,-0.0488758,-0.0113663,-0.0525511,0.239429,-0.170371,-0.0513318,0.118628,0.250036,0.344424,0.500036,-2.05414 +3446.57,0.660895,0.0912059,4,1.60378,0.973429,-1.12639,0.345506,0.747008,-0.086332,-0.32264,0.0285311,0.695311,0.749768,-0.354035,-0.304601,-0.44773,-0.000756639,-0.189625,1.04678,-0.640293,0.0589953,0.131691,-0.151268,-0.499533,-1.32665,-0.762116,0.0615513,-0.151497,-0.70008,-0.115438,0.302205,-0.274387,-0.273147,0.596514,-0.413998,-0.0739844,-0.0197724,-0.122664,0.033564,-0.639854,0.261816,1.05617,-0.626813,0.784703,0.720023,0.211857,-0.549912,-0.361367,0.0267526,-0.00716154,-0.0921508,0.493811,-0.0184476,0.282751,-0.130334,0.320649,-0.753527,0.621656,-0.231757,-0.15063,-0.351862,0.494103,-0.363882,0.121824,0.635241,-0.674769,-1.64684,0.149967,0.0111323,-0.497591,-0.0377735,-0.0276132,-0.0810336,-0.308944,-0.0390652,0.595466,-0.0911748,0.153999,0.605596,-0.0330186,-0.491261,-0.389399,-0.121544,0.103127,-0.872651,0.0548194,-0.478554,-0.0613429,-0.254253,0.305386,-0.1615,-0.0619411,-0.23486,-0.0454614,0.212842,0.268399,0.439909,-0.0441629,-0.0903926,-0.00303052,-0.158983,-0.319407,0.398024,-0.171838,-0.230681,-0.461543,-0.305292,0.239823,-0.148338,-0.0578634,-0.14347,0.3483,0.158434,0.266422,0.113981,0.0186491,0.251805,0.0370266,0.355372,-0.131206,-0.054824,0.52343,0.117068,-0.411242,0.12956,-0.0219835,-0.051398,0.383074,0.122708,0.473542,-0.0043521,-0.211566,-0.590913,0.171556,0.0215905,-0.249949,-0.0470357,0.185009,-0.566164,-0.0983095,-0.0787636,0.100229,-0.272097,0.0519939,-0.361912,-0.120641,-0.109359,0.455973,0.105072,-0.389031,0.155534,0.0309665,0.0660956,0.152941,0.259871,0.143741,0.0302502,0.017985,0.227796,0.100805,0.45009,0.280889,-0.0779117,-0.242541,-0.504425,0.787139,0.365118,0.328933,-0.0695617,-0.0281781,0.241764,-0.76058,-0.285696,0.100496,0.157836,0.0532391,0.742044,-0.197704,-0.035381,-0.685455,-0.495399,-0.0809512,0.637347,-0.0157678,0.158315,0.220278,0.11461,-0.135711,-0.410088,-0.228259,0.243674,0.0581659,-0.178194,-0.162597,-0.360731,-0.233389,-0.347288,-0.153925,-0.0524847,0.102441,-0.041121,-0.318684,0.406589,-0.0879417,-0.0380144,0.0288458,-0.894886,0.470458,0.235534,-0.445248,0.941288,0.213398,-0.0123858,0.172829,-0.00616595,0.185108,0.156191,-0.0333029,-0.223796,-0.0384973,0.388535,-0.0391583,-0.270533,-0.434942,0.12336,0.301694,0.364333,-4.24208e-05,0.319593,-0.100715,-0.532366,0.292644,-0.279459,-0.137921,-0.0127359,-0.225944,0.0822505,0.120433,0.537333,0.266108,0.15082,0.299847,-0.0142721,0.133137,-0.0343073,-0.0949925,-0.117954,0.161294,0.14575,0.592648,0.133612,-0.395556,-0.0836723,0.753556,-0.655144,0.295485,-0.47637,-0.133667,0.113203,-0.0127377,0.480937,0.417677,-0.00489812,-0.121747,0.675931,0.308733,0.38737,0.173935,0.678525,0.0179883,-0.0861275,0.378146,0.258818,-0.409146,-0.280593,-0.187965,-0.083333,0.0362391,-0.0925613,0.041865,-0.276223,0.315774,0.133564,0.158704,0.290541,-0.144541,-0.458516,0.0241964,0.549113,-0.309226,-0.210969,-0.113866,-0.343579,0.0248346,0.194957,0.0381259,0.264159,-0.517729,-0.0558687,-0.114926,0.0174437,-0.139828,-0.245639,0.0194417,0.0917868,0.292514,0.302963,0.540846,-2.31136 +3461.6,0.979759,0.0912059,4,1.62157,0.993155,-0.655237,0.141929,0.361988,-0.239163,-0.296502,-0.109166,-0.0114456,-0.497487,-0.684809,0.102076,0.0894279,0.141958,-0.234574,0.791708,0.133965,-0.0498645,0.134689,-0.155425,-0.347536,-1.17589,-0.837817,0.0885977,-0.0545863,-0.145187,-0.0288435,0.201814,-0.387884,-0.103162,0.522991,-0.463174,0.291116,-0.114437,-0.436346,-0.189164,-0.072012,0.655048,0.2782,-0.227703,0.953421,0.370088,0.208489,-0.477811,-0.186904,-0.542809,-1.34478,0.696023,-0.0589086,-0.1985,0.362666,0.371711,-0.476431,-0.132281,0.548452,0.0183919,-0.295392,-1.12813,0.762412,-0.440055,0.375579,0.966529,-0.202865,-0.618911,0.109182,0.292863,0.366047,-0.0047571,-0.0206021,-0.327965,-0.421607,0.475126,0.485894,-0.106239,0.461057,0.469256,0.316487,0.0347883,-0.0939124,0.0628109,0.657537,0.00281271,-0.0632884,-0.120371,-0.203828,-0.0268515,0.0751832,-0.156719,0.166596,-0.0816721,0.355533,-0.426695,0.0838854,-0.117197,-0.167346,-0.408744,0.291,-0.31311,0.406315,0.0673602,-0.103876,0.283073,-0.267994,0.00734526,0.0249338,-0.0360436,-0.240073,0.192754,0.565143,-0.0218101,-0.384197,0.206411,-0.260105,0.583274,0.157962,-0.0252357,-0.327655,-0.0679486,-0.0565332,-0.0966996,-0.596008,-0.14482,0.0662155,-0.0333824,0.182511,-0.0516054,-0.110311,0.0591924,0.754928,0.0754779,-0.413815,-0.0505586,0.255574,0.73709,-0.0237155,-0.238812,-0.0703477,-0.259972,0.278969,0.28215,-0.475708,-0.00204397,-0.281623,-0.20023,-0.283878,-0.192075,-0.0405692,0.41968,-0.0414385,-0.185259,-0.0028631,0.026949,-0.0150108,0.0242306,0.522126,0.376943,0.0519844,-0.377303,0.0879465,0.267081,0.298201,0.317604,0.700258,-0.42726,-0.250584,-0.00607038,0.0313262,-0.442615,-0.158208,0.280229,0.54222,-0.0100763,-0.0253391,-0.558754,-0.188873,0.194715,-0.175579,0.194246,0.0603301,0.709216,-0.134903,0.0916573,0.108902,0.0135729,0.120566,-0.211519,0.344844,-0.331917,0.156433,-0.0975348,0.0689154,0.157095,-0.24755,-0.135318,0.283902,-0.200055,-0.0900239,-0.449004,-0.188236,0.0620261,-0.336763,-0.049318,-0.265193,0.655306,-0.207733,-0.115721,-0.131035,0.861874,-0.385654,0.250824,0.0451606,0.00838809,-0.139023,0.150363,-0.438908,0.0445412,-0.164583,-0.083481,0.132718,-0.13281,0.176578,-0.280497,0.165903,-0.200442,-0.5379,0.524052,-0.00725073,-0.261884,0.110333,0.073428,-0.292632,0.213306,0.00677661,-0.213865,-0.324538,-0.116585,-0.0831404,0.0149592,0.544999,-0.427329,-0.0844989,-0.20981,-0.335572,0.478881,0.250363,-0.183291,0.332194,-0.273645,-0.0808289,-0.294539,-0.457399,-0.127203,0.553281,-0.236583,-0.384592,0.21274,-0.589053,-0.259936,0.0553756,0.126988,0.058179,0.242313,-0.164522,-0.0499299,0.114041,0.181128,0.20893,0.30966,-0.311732,0.152477,0.0821385,-0.281083,-0.382247,-0.0632262,-0.243847,0.250815,0.12478,0.415414,0.364316,0.0128415,-0.296574,-0.29133,-0.179405,0.144915,0.19209,-0.116599,0.0895729,0.570943,0.42341,0.21344,0.225447,-0.00613954,0.317718,-0.549313,-0.150869,-0.475142,-0.098725,0.271056,0.229264,-0.323106,-0.241485,0.0796614,0.212302,0.282244,0.460762,-1.06654 +3445.98,0.502968,0.0912059,4,1.65921,0.970896,-1.08702,0.328476,0.341749,-0.00932238,0.260033,0.129715,0.279632,0.374825,0.0536492,-0.449645,0.11692,0.273131,-0.299004,0.542364,-0.443648,-0.438227,-0.150683,-0.0315013,-0.208532,-0.760619,-1.17923,-0.229253,-0.537984,-0.0431529,0.390636,0.659622,0.0361243,-0.153408,0.542892,-0.53634,0.113147,0.19422,0.204288,-0.0153916,-0.625035,0.0830382,0.645749,-0.00499692,0.725294,0.504138,-0.118327,-0.867436,-0.262198,-0.112744,-0.72377,0.591839,0.414312,-0.357187,0.106292,-0.0250056,-0.0798119,-0.142122,0.11707,0.114259,-0.212133,-0.562079,0.432906,-0.142406,0.0511297,0.657775,-0.254915,-0.967562,0.0297774,0.349489,-0.840777,0.0161563,0.204411,-0.133659,0.153946,0.0101031,0.390755,-0.1886,0.411922,0.443701,-0.0188635,0.158348,-0.290907,-0.118359,-0.0285341,-0.0941303,0.108749,0.160131,0.0547017,-0.317135,-0.229844,-0.30614,0.203766,-0.152562,-0.11448,-0.0828466,-0.0712431,-0.143848,-0.269523,-0.0440154,0.42628,0.242625,-0.404705,0.110513,0.0265647,-0.0672842,-0.215038,-0.496227,-0.147845,-0.457027,-0.0392991,0.115558,-0.0363571,0.543515,0.102928,0.180183,0.424588,0.562886,-0.348866,0.461467,-0.121542,-0.15223,-0.317611,0.230683,-0.546787,-0.269505,-0.43915,0.0383146,-0.40514,-0.158234,0.557767,0.150134,0.0326887,-0.316863,-0.21284,0.12921,0.0510663,0.495729,0.185085,-0.366407,-0.271792,-0.0974792,-0.0157095,-0.343442,0.00576452,-0.222945,0.411609,-0.617338,-0.0997406,0.33548,-0.272806,0.375376,-0.151793,0.352532,-0.249428,-0.0138799,-0.435805,0.0313459,0.442543,0.28733,0.0345338,0.617359,0.0813806,0.314924,0.167212,-0.255687,0.902356,-0.122943,0.144384,-0.482877,-0.286165,0.345837,-0.209309,-0.0748267,0.16601,-0.29873,0.25266,0.197218,0.112323,-0.517094,-0.502169,-0.160513,-0.135375,0.795136,0.168384,-0.21538,0.478267,-0.363952,0.106067,-0.131992,0.0678575,-0.0472861,0.00709717,-0.336651,0.181397,-0.212138,-0.0678836,-0.707171,0.146472,0.208529,-0.17076,-0.44549,-0.921756,0.583376,0.16349,-0.100311,0.328699,-0.347063,0.171897,-0.084406,-0.188235,0.920199,0.0652621,-0.200436,0.0644308,-0.369598,0.250709,0.291375,0.0544032,-0.348938,-0.0194155,0.619392,-0.291566,-0.391796,-0.147668,-0.364313,0.17985,0.628329,-0.325505,0.153916,-0.192504,-0.505641,0.135594,0.31332,-0.00191946,0.339258,0.235301,-0.150559,-0.142731,0.245584,0.254476,0.332226,0.308949,-0.687441,0.0830763,0.423365,-0.4144,-0.584345,0.449359,0.338828,0.218618,-0.330212,-0.559819,-0.15604,-0.113616,-0.288441,0.240965,-0.732647,0.239664,0.114773,-0.451143,0.378161,0.333766,0.207256,-0.118279,0.063895,-0.100491,-0.32638,-0.15056,0.0815591,0.0983047,-0.0863481,-0.331656,0.0141582,-0.727007,-0.119076,-0.29582,-0.100565,0.0628399,-0.237269,0.224114,-0.134963,0.0380487,0.183072,0.00916518,-0.115969,-0.0551262,-0.32385,0.482447,0.123258,-0.519,-0.125566,-0.0816315,-0.0836067,0.302936,-0.0794053,0.182769,0.290544,-0.342155,-0.181881,-0.173504,-0.40562,-0.654564,0.291227,-0.0656439,0.0902729,0.19313,0.300455,0.439465,-0.929869 +3447.18,0.899448,0.0912059,4,1.63844,0.979061,-0.700913,0.293302,0.381671,-0.038686,0.221774,0.348193,0.40389,-0.109543,-0.387868,-0.209413,-0.148701,0.276085,-0.401645,0.785029,0.233569,0.40853,0.0833563,0.0717228,-0.182112,-0.918604,-0.678284,0.194714,-0.591189,-0.204584,0.140279,-0.300609,-0.0431349,-0.0213934,0.731312,-0.446831,0.159715,0.0652892,-0.497294,-0.7515,-0.311085,0.592022,0.547961,-0.252579,0.633665,0.574285,0.562394,-0.603295,-0.22992,-0.184287,-0.614513,0.220459,-0.00609754,-0.138116,-0.0952079,-0.517937,0.0947792,-0.0372793,0.085753,-0.107821,-0.371837,-0.566045,0.461816,-0.260981,-0.0793741,1.08879,-0.514923,-0.325388,-0.246458,0.228211,-0.0728734,-0.244648,0.626768,-0.239595,-0.135976,0.0799371,0.526427,-0.0947228,0.432817,0.543734,-0.0841304,0.14142,-0.5802,-0.0452208,0.677268,-0.715811,0.165887,0.224044,-0.326453,0.195212,0.318778,-0.0674514,0.396458,-0.50615,-0.11515,-0.102932,-0.0963247,0.080512,0.559305,0.119952,-0.122598,-0.381296,-0.482928,0.763424,-0.426395,-0.156697,-0.277662,0.127416,0.0417098,-0.11069,0.363259,-0.014225,0.20488,0.759532,0.34932,-0.0264803,0.047179,0.787026,-0.187879,0.222409,-0.493151,0.0280521,0.646704,-0.399678,-0.229561,-0.239688,0.123855,0.0305849,-0.42305,0.26695,-0.195681,0.379252,0.215896,-0.273447,0.246264,-0.152192,0.152187,0.599012,-0.199121,0.384502,0.273659,-0.393829,0.257097,-0.550807,-0.295978,-0.13995,0.479469,-0.586034,-0.0797494,0.241212,0.168141,0.68667,-0.206533,-0.328989,-0.63782,-0.060864,-0.0820976,0.0427845,-0.0492049,0.116734,0.259516,-0.225077,-0.0596003,-0.0387641,0.178289,0.0857657,0.740893,0.466718,-0.0965798,0.245784,-0.00205582,-0.0284119,-0.179119,-0.0658457,0.131798,0.06643,0.29943,0.238396,-0.0433112,0.275609,-0.437637,-0.25849,0.180556,0.397088,-0.0476632,-0.114325,0.500971,-0.0193622,0.190277,-0.158968,0.110267,-0.0125551,0.601034,-0.200606,-0.155655,0.0770091,0.319481,-0.0583624,0.105379,-0.0683858,0.0406241,-0.155238,-0.888916,0.450719,-0.107312,-0.447091,-0.016933,-0.101811,0.456021,-0.394939,-0.267228,0.992044,0.0264665,0.0540771,-0.00461513,-0.489898,0.682553,0.284487,-0.0446623,-0.201684,-0.320919,0.103595,0.31053,-0.025767,0.145995,-0.75572,0.166215,0.490696,-0.183425,0.548656,-0.710154,-0.199621,-0.448864,-0.195034,0.0128999,0.381139,-0.31845,0.38184,-0.167101,0.297356,-0.33024,0.216702,0.468285,-0.54726,-0.114118,0.265378,0.129305,0.230812,-0.0107069,0.251666,0.251602,-0.0730569,-0.083477,-0.591272,0.0338251,-0.588662,0.335113,-0.510883,0.161802,-0.011327,-0.618391,0.15384,0.186262,-0.150843,0.55923,0.0439641,0.281937,-0.0621266,0.377835,-0.130491,-0.552996,0.00812955,-0.336452,0.397012,-0.509791,-0.18159,0.247371,0.217994,-0.531635,0.342725,0.273505,-0.00247373,0.12949,0.0977777,-0.36638,-0.036937,0.156768,0.223978,-0.3696,0.653059,-0.462614,0.231342,0.0495274,-0.152281,0.168178,0.0287385,-0.366531,0.0787339,-0.0109493,-0.34868,0.0558852,-0.206247,-0.283578,0.647599,-0.150375,0.129236,0.151862,0.359494,0.389695,-1.25977 +3429.96,0.92165,0.0912059,4,1.53357,0.912218,-1.1889,0.383563,0.362973,-0.0334671,0.051337,-0.10646,0.523005,-0.0460081,-0.165326,0.0461411,-0.0524438,0.393809,0.0587932,0.760203,-0.0265443,-0.25372,-0.26123,0.157551,-0.060331,-0.798422,-0.272876,0.0614298,-0.397486,0.126799,-0.102957,0.168747,-0.376009,-0.109833,0.875968,0.137701,0.143526,0.529135,0.216221,0.286499,-0.28869,0.523521,0.118421,-0.133165,0.909311,0.729111,-0.051617,-0.718763,-0.0410507,-0.366775,-0.41435,0.264829,0.552671,0.0142471,-0.361002,0.75853,-0.00232079,-0.0451314,0.264285,-0.349942,-0.316804,-0.426447,0.467668,-0.0412854,0.345974,0.784633,0.1121,-0.842651,0.191955,0.189654,0.16612,0.362052,0.105031,0.232531,-0.186342,0.878107,0.316938,-0.0385792,0.483358,0.216961,0.101044,0.462446,-0.451074,-0.23694,0.368133,-0.326336,0.0465229,0.568526,0.127696,0.091189,0.103527,-0.119163,-0.233684,-0.39243,0.390668,0.00410379,-0.154969,-0.523246,-0.159995,-0.228531,-0.00431609,-0.175432,0.533258,-0.0263785,-0.108586,0.338937,-0.178304,-0.312439,0.322189,-0.35888,0.407934,-0.340926,0.278544,0.871493,-0.0694418,-0.0642023,0.138377,0.511635,0.397243,-0.598813,-0.205645,-0.0264335,0.0475807,0.0807634,-0.698501,-0.468492,-0.139732,-0.677089,0.281475,-0.467796,0.528401,0.334691,0.396582,-0.348295,0.0549222,-0.0287112,0.0459269,0.337015,-0.178136,-0.380038,-0.156658,-0.228463,-0.153156,-0.442469,-0.237012,0.242698,-0.0461799,-0.727422,0.297954,-0.00240587,-0.372157,0.43202,-0.133212,-0.233071,-0.763619,-0.0209063,-0.251928,0.322109,0.230085,0.649734,0.635309,0.0731945,0.557897,-0.0640765,0.699705,-0.379992,0.780117,-0.193591,0.067171,-0.193053,0.0404535,-0.271353,0.461237,-0.0954031,0.161678,-0.00432232,0.203908,0.198246,0.524736,-0.20382,-0.273122,-0.395424,0.121782,0.684277,0.179746,-0.122474,0.683679,-0.226417,-0.207908,-0.232439,-0.008522,-0.509436,-0.220604,0.358798,0.103253,-0.0513741,-0.0625639,-0.458662,-0.119478,0.126312,-0.0286459,-0.424,-0.458479,-0.239076,0.281308,-0.360787,0.0491452,0.349046,0.690101,-0.33577,-0.441559,0.550814,-0.0246125,0.35889,-0.280083,-0.0581208,-0.330474,-0.125969,-0.430342,-0.051162,-0.0304647,0.574474,0.0396163,0.0330524,-0.343076,-0.568044,0.556883,-0.195928,0.115801,0.537908,0.0431954,0.241995,-0.209172,0.0838597,-0.194145,0.256454,-0.107214,-0.0450914,0.144308,-0.0267988,-0.259705,0.510445,0.410594,-0.160183,-0.363171,0.0157899,0.0687991,0.243851,0.0722903,-0.228252,0.777148,-0.311164,0.148213,-0.433488,0.117993,-0.276717,0.276441,-0.593351,-0.277164,0.0583677,-0.312997,0.169128,-0.278718,-0.0635651,-0.0502939,0.362281,0.150362,-0.173281,0.467131,0.286427,0.11999,-0.368996,0.542902,-0.500452,-0.355532,-0.530788,0.313455,-0.228544,0.310905,0.500327,-0.069254,0.101671,0.440141,0.219084,-0.338467,0.06476,-0.12245,-0.0584329,0.15131,-0.0879418,0.765364,-0.199363,-0.0034529,-0.533379,0.343022,-0.330938,0.577432,-0.0211736,-0.478791,-0.397751,-0.220871,0.0892813,-0.927891,-0.290604,0.227712,0.108079,0.154598,0.328754,0.393189,-1.0149 +3424.49,0.814023,0.0912059,4,1.50144,0.81373,-0.420187,0.203658,0.385288,-0.174399,-0.0103044,0.230594,0.323936,0.11975,-0.0224977,-0.0438698,-0.559102,0.510437,0.00662042,1.09524,0.580555,0.309801,0.175927,0.0950546,0.0158976,-0.662158,-0.366497,0.593579,-0.0331175,-0.42337,0.230607,0.361261,0.165655,0.42764,0.710226,-0.383635,0.0188616,0.523719,-0.292559,-0.132838,-0.220615,0.432951,0.317626,-0.259768,0.833328,0.275531,-0.187968,-0.303421,-0.106321,-0.243408,-0.289948,0.00866827,0.132707,0.13702,-0.0171751,0.308185,0.270076,-0.427858,0.632088,-0.165811,-0.376128,-0.474555,0.484441,0.0568914,0.325769,1.04209,-0.792751,-0.638875,-0.271964,-0.00940625,0.316015,-0.393439,-0.0363783,-0.292595,0.259144,0.539409,0.729488,0.149299,-0.142581,0.27516,0.58101,-0.0992945,0.0434897,0.340167,0.421862,-0.433344,0.262679,0.488282,0.483975,-0.0744503,-0.513342,0.0243915,0.147564,0.0610975,0.0751148,-0.339044,-0.0758983,-0.028436,-0.0859687,-0.241469,0.43884,-0.182725,-0.302265,0.194541,0.173353,0.111706,-0.51293,-0.134371,0.149553,-0.411125,-0.137207,-0.120699,-0.0287964,0.8146,-0.210875,0.174973,0.0936993,0.781518,0.219627,0.223945,-0.530061,0.0665371,0.00483392,-0.340437,-0.0968465,-0.308802,-0.242014,0.0462219,0.00607094,0.323183,0.00557285,0.317889,0.290565,-0.813111,-0.192952,-0.124439,-0.187237,0.399655,-0.0621537,0.371595,0.116306,0.366493,0.459399,-0.0116274,-0.369952,-0.368937,-0.116907,-0.149852,0.507684,0.294282,-0.495052,0.219003,-0.191003,-0.168682,-0.724935,0.137786,0.158093,-0.589521,0.151028,0.354598,0.479791,0.310894,-0.0889178,0.121375,0.0381421,0.428635,0.862088,0.101625,-0.232814,0.488647,-0.00105533,0.179588,0.0786395,0.0685089,-0.195349,-0.115074,0.253104,-0.0740193,-0.0536058,0.349342,-0.0439515,-0.720515,0.162726,0.480412,0.334058,-0.574322,0.217274,-0.114896,-0.360698,-0.689836,-0.208299,-0.123321,0.340293,-0.136389,-0.0405308,-0.601832,-0.4152,-0.355587,-0.0486904,0.151268,0.0224309,-0.108852,-0.0672369,-0.170011,-0.421985,-0.181597,-0.0822832,-0.316513,0.128881,-0.358198,-0.488683,1.39483,-0.347643,-0.2075,-0.409903,-0.0986972,0.215288,-0.348819,-0.11637,0.351449,-0.361725,0.249893,0.151554,0.262035,0.410379,-0.657847,0.320402,-0.434018,-1.11554,0.325212,-0.579192,-0.147636,-0.0129096,0.0502532,-0.197059,0.381743,0.173276,-0.48124,-0.567036,0.662308,-0.368602,-0.448468,0.587265,-0.420945,0.966303,0.0799005,-0.0339291,-0.22502,0.0875927,-0.0579166,0.526345,0.413681,0.0471639,-0.218963,-0.735445,0.12653,0.233338,-0.284969,-0.255881,-0.14952,-0.249493,-0.168619,0.100418,0.248685,0.317783,0.623629,-0.0640002,0.330144,0.343544,0.227694,-0.0392754,-0.0240375,-0.155502,-0.148849,-0.224317,-0.556068,0.221416,-0.108737,0.112129,-0.298509,0.611559,-0.0668711,0.385042,-0.382698,-0.413306,-0.225499,-0.207069,-0.438005,0.329057,0.283688,-0.11684,0.0794026,0.540179,0.0741779,0.201118,0.250838,0.205663,0.460947,-0.0745319,-0.124992,0.111194,-0.332188,0.616107,-0.545564,0.460922,0.154749,0.172231,0.393382,0.415007,-1.14504 +3413.89,0.990999,0.0912059,4,1.56215,0.88901,-0.900243,0.373972,0.128007,0.0362032,0.329274,0.361008,0.377639,0.324421,-0.238803,-0.0275778,0.456606,0.576159,0.0749292,0.809452,0.340036,-0.107185,-0.0577083,0.28047,-0.194666,-1.05357,-0.380656,0.192428,-0.108934,-0.201691,0.130708,0.133595,-0.38878,-0.143856,0.503501,-0.288941,-0.066523,0.194993,-0.0783144,0.112465,-0.397776,0.113956,0.136415,-0.165467,1.05639,0.37323,0.0816181,-1.22209,-0.00830273,-0.578754,-0.465674,0.426799,0.207184,-0.0579424,0.287899,0.290981,0.0273568,-0.683366,0.328049,-0.027984,0.188864,-0.963027,0.191136,-0.286063,-0.0392389,0.64804,-0.872525,-1.14559,-0.0773434,0.498217,-0.75817,0.425928,0.175578,0.0187487,0.0928555,0.145543,0.604682,0.0602962,0.682193,0.286816,0.243742,-0.127166,-0.317286,0.222878,0.931535,0.0517343,0.02048,-0.315798,0.231162,-0.33264,0.242983,-1.04121,0.305855,-0.178337,0.166882,0.244683,0.338164,-0.178834,-0.0109893,0.423601,-0.0565404,0.209304,-0.207586,0.319533,0.244787,0.323811,-0.204356,-0.00365313,-0.170694,-0.651652,-0.0406411,0.437843,0.28995,0.326135,-0.721657,0.141882,-0.264435,0.348758,-0.373055,-0.439904,0.246119,0.11406,0.226394,-0.0401064,-1.03379,-0.289253,0.259875,0.250786,-0.359111,0.105413,0.246233,0.619322,0.838149,0.0789531,0.481956,0.211978,-0.134041,0.71772,-0.562966,-0.178041,-0.0535089,-0.370304,0.377415,-0.299498,-0.236141,0.2737,-0.390836,0.016791,-0.0872111,-0.0673732,-0.0557111,0.155529,0.363418,0.0531176,-0.0284912,0.281855,0.0177897,0.294067,-0.0692855,0.602518,0.0589196,-0.681441,0.217887,0.335827,1.06057,0.309156,0.333484,0.232747,0.204901,0.134744,0.53057,-0.442784,-0.354949,0.395153,-0.00888947,0.0563219,0.038146,0.0219271,-0.0532292,0.0400838,-0.117524,0.085265,0.03057,0.892429,0.207548,0.254687,0.569963,-0.283798,-0.0517757,-0.341603,-0.405518,-0.174691,-0.0861281,-0.642949,0.00164068,0.660454,-0.238281,-0.695154,-0.150004,0.318098,0.194414,0.0933542,0.00957625,-0.107495,0.116464,-0.463532,0.366704,0.0958746,0.194886,-0.260327,0.115507,1.00107,0.302161,0.78096,0.0537048,-0.552702,-0.0555769,0.439796,-0.445016,0.547689,-0.185608,-0.143571,0.78931,-0.316455,0.0654256,-0.462471,0.227057,0.171544,-0.436358,0.849386,-0.00846297,-0.314372,-0.0302625,-0.41925,0.12763,0.0937419,-0.397609,-0.0273507,-0.371549,0.456916,-0.274902,-0.261234,0.290493,0.929987,-0.181598,-0.0409994,0.121884,-0.40465,0.46765,0.69218,0.51581,0.101096,-0.164591,-0.245716,-0.711472,-0.978903,0.218781,-0.888303,-0.399102,-0.00443932,-0.236748,0.136753,-0.041528,-0.158746,0.0575735,0.300503,0.315908,-0.173867,0.272701,0.174232,0.410511,-0.139555,0.0828128,0.264213,0.192117,0.171784,-0.566727,0.303958,-0.207857,-0.218046,-0.13638,-0.0951638,0.777234,0.0216498,0.122696,-0.441504,-0.596813,-0.0737159,0.00852809,0.114645,-0.230796,0.208495,-0.385607,-0.365523,0.137585,-0.0663167,0.161811,0.401531,0.0396227,-0.117859,0.644589,0.284892,-0.424513,-0.207292,-0.0536955,0.113015,0.206408,0.336177,0.454322,-0.325247 +3400.17,0.669559,0.0912059,4,1.64712,1.06288,-0.453525,0.102431,-0.108187,-0.152797,-0.0386903,0.105525,0.203992,0.290322,-0.0165013,0.0306695,-0.491568,0.407819,-0.173348,0.780671,0.096619,0.0145308,0.0546914,-0.0509576,-0.151529,-0.724795,-0.666978,-0.293013,-0.108065,-0.413825,-0.129796,0.323943,0.198607,-0.0451365,0.171128,-0.255719,0.121264,-0.0761515,-0.595579,0.00186006,-0.485581,0.475857,0.349016,-0.119551,0.843372,0.392196,-0.0584074,-0.222472,-0.685196,0.676605,-0.7096,-0.164893,0.398143,0.0108467,0.198711,0.21105,0.0625486,-0.177327,0.584116,-0.194249,-0.29477,-0.314635,0.0304249,-0.299517,0.659486,0.626264,-0.997,0.00929973,-0.1227,-0.285553,0.651964,0.105389,0.437424,-0.412074,-0.0545861,-0.000565736,0.484293,0.0515438,0.175633,0.400006,0.308916,-0.332072,-0.19681,0.0296023,0.220039,-0.291033,0.449907,0.2024,0.375627,-0.242628,0.0222455,-0.182909,0.212805,-0.00553619,-0.581379,0.0945811,-0.129162,0.137597,-0.0604339,-0.353873,0.497273,-0.56937,0.257929,0.154949,-0.263193,-0.286854,-0.174911,0.209063,0.356276,-0.284036,0.014283,-0.43322,0.0749892,0.273009,0.909829,-0.00218723,0.779689,0.295834,0.564731,0.157294,-0.645129,0.13628,0.432566,-0.701246,-0.0621172,0.609007,-0.6887,-0.727259,0.234475,0.305248,-0.053484,-0.584313,-0.0347675,-0.679079,-0.112998,-0.0927369,0.143532,0.643663,0.000874534,-0.0492726,0.177435,0.0741859,0.120181,-0.964632,0.100144,-0.176515,-0.143721,-0.455043,0.169332,0.283059,-0.0985713,0.844371,-0.108693,-0.842352,-0.607176,0.194953,0.365417,-0.490102,0.438093,0.345197,-0.22866,0.0564453,0.0254754,-0.0848408,-0.486692,-0.229413,0.856263,-0.348301,-0.0960322,0.157319,-0.20392,0.231469,-0.0769009,-0.638356,0.0387722,0.0293165,-0.150665,-0.0753175,-0.468948,0.133963,-0.081168,0.0713958,0.125282,0.721428,0.0342951,-0.32707,0.176665,0.356743,-0.270715,0.196969,-0.70635,-0.23172,0.0485906,0.080448,-0.143125,-0.225576,0.660842,-0.402603,0.0156562,-0.330068,0.133142,-0.412385,-0.686217,-0.532988,-0.0648268,0.126815,0.22319,0.491095,0.136291,0.307261,-0.520923,1.30536,0.252539,-0.619172,0.434404,0.202774,-0.0896694,-0.156532,-0.182371,-0.102474,-0.936533,0.483551,0.323892,0.0793596,-0.198742,0.111634,-0.607752,0.695108,-0.0456257,0.194965,-0.860498,-0.441993,-0.146256,0.47661,-0.328876,-0.0693682,-0.110203,-0.480738,-0.571297,0.555456,0.0566377,-0.265274,0.950892,0.13579,-1.02396,-0.00425131,0.175627,0.580513,0.269672,-0.0527198,0.367326,-0.317867,0.246937,-0.0978802,0.673838,-0.0626839,0.184516,0.121433,0.268134,0.62448,-0.554239,0.140399,-0.238891,0.444833,0.527207,0.233492,0.275165,0.369242,0.0927864,-0.0411567,0.134521,-0.251556,0.0906031,0.0662655,-0.640517,-0.722982,-0.689747,0.234849,0.291759,-0.0076124,0.388409,-0.21339,0.532582,-0.0495844,0.255396,-0.0182616,-0.3599,0.558109,0.458416,-0.186893,0.172505,-0.0297621,0.320477,-0.646736,-0.032492,0.277842,-0.207345,0.112914,-0.395039,-0.240668,-0.560721,-0.62308,-0.176893,-0.254931,0.917494,0.141489,0.151926,0.376151,0.389777,0.30651 +3415.2,0.734787,0.0912059,4,1.60474,0.88763,-1.45603,0.522657,0.434017,-0.132579,0.410409,-0.227865,0.158432,0.48839,0.0382702,-0.206537,0.0894339,0.292958,-0.52127,0.684005,0.459542,-0.218946,-0.272519,-0.428128,-0.159069,-0.649936,-0.344668,-0.00477437,-0.279024,-0.114596,0.0097019,0.414626,-0.557097,-0.0104355,0.358279,-0.195476,0.213652,0.483854,-0.505391,0.243617,-0.151808,0.800186,0.35357,-0.517118,0.961033,0.914266,0.3893,-1.17155,-0.200255,-0.0284514,-0.49745,0.108597,0.666848,-0.217268,-0.15076,0.411386,-0.18172,-0.104091,0.53109,-0.353205,0.115664,-0.690338,0.00344928,-0.75144,0.104659,0.936915,0.0506298,-0.884184,0.176435,0.00147437,-0.644405,0.411101,-0.0956311,-0.294085,-0.418808,0.345786,0.596302,0.0150759,0.660718,0.0865987,0.176225,0.611697,0.071689,0.024233,0.12603,0.19122,0.282419,-0.0436609,0.189973,0.176617,-0.415445,-0.402857,0.118435,0.152003,0.299702,-0.590109,-0.169774,0.298191,-0.606697,0.127411,-0.532768,-0.242617,0.360427,0.485838,0.253163,0.456433,-0.445371,0.188047,-0.0979685,-0.299394,0.631513,-0.23667,0.270645,0.951172,-0.612632,0.276896,-0.628415,0.175288,0.019296,-0.247135,-0.180691,0.0789271,0.619477,-0.0511836,-1.04656,-0.476941,-0.40266,-0.16313,-0.381058,0.284584,0.506524,-0.301773,0.420082,-0.163516,0.371615,-0.013181,0.386362,0.485308,-1.07867,-0.0142238,0.219991,0.0558054,0.421048,-0.858968,-0.471991,0.387918,-0.322731,-0.460748,0.139453,-0.685152,-0.470055,0.119367,0.362597,-0.0307486,-0.525592,0.0951547,0.0587553,0.0604533,0.426417,0.327025,0.470329,0.120799,0.28383,-0.393462,0.464709,-0.0819487,1.02623,-0.00970601,0.241109,0.404303,-0.570727,-0.0806876,-0.467967,0.552555,0.262933,0.11859,-0.246208,0.307333,0.0682969,-0.11348,0.103844,0.164184,0.115332,0.257003,0.186458,0.251182,0.418883,-0.406252,-0.432057,-0.202501,-0.242636,-0.761417,0.150751,-0.0491898,-0.00552166,0.127152,-0.267169,-0.818485,0.0812364,0.527648,0.190076,-0.517009,-0.727831,-0.273734,0.0395098,0.0379697,-0.417717,0.0516969,-0.168753,-0.10239,-0.526342,1.16829,0.129123,0.691295,-0.117463,0.0947085,-0.125539,-0.121986,-0.637498,0.161302,0.144716,-0.319102,-0.342182,-0.369965,0.153366,-0.773889,0.0659807,0.382451,-0.316127,0.0726038,-0.132082,-0.727466,0.0119295,-0.529314,-0.227579,-0.159321,-0.462809,-0.0709119,-0.466363,0.575773,0.104186,0.193469,0.571429,-1.13096,-0.652417,0.104869,0.215938,0.190031,0.657056,0.0103753,0.388505,0.33552,-0.177844,-0.812807,0.143927,-0.383128,0.157794,-0.295423,-0.574441,0.323747,-0.782124,-0.214511,0.221529,0.0329123,-0.314985,0.715237,0.0232837,0.223113,0.287108,0.11137,0.343901,-0.383272,-0.0443317,0.0959707,0.364375,-0.237003,-0.74803,-0.6262,0.0240027,-0.380291,0.0504285,0.280491,0.121624,0.0951538,0.0396017,-0.531849,0.223968,0.0210375,-0.339926,0.767721,0.0303206,0.183884,0.142949,-0.303214,-0.262697,0.0128244,0.153073,-0.0426195,0.500347,-0.00463142,-0.12258,0.553535,0.0245435,0.161366,-0.474924,0.162028,0.182648,0.402527,0.427374,-1.10289 +3414.53,0.549632,0.0912059,4,1.61566,0.84872,-1.26264,0.50636,0.646519,-0.126087,0.477809,-0.287122,0.131242,0.483251,0.128125,-0.0891716,0.105283,0.303733,-0.582799,0.524087,0.57192,-0.138507,-0.403793,-0.38523,-0.158197,-0.582181,-0.315371,0.0257569,-0.300382,-0.280807,0.0559594,0.484506,-0.550335,0.0104826,0.324361,-0.18831,0.142194,0.350566,-0.484121,0.335685,-0.302864,0.702931,0.45193,-0.581397,1.0117,0.753527,0.389925,-0.995692,-0.272108,0.0443664,-0.600401,0.106123,0.620884,-0.283901,-0.120192,0.354625,-0.0871588,-0.1435,0.505096,-0.3242,0.0183459,-0.636692,0.00288901,-0.776034,0.0385042,0.924382,0.0209294,-1.21988,0.238505,-0.211315,-0.660193,0.324044,-0.0195885,-0.353962,-0.342271,0.489913,0.506556,-0.126279,0.44567,0.250739,0.307192,0.629992,0.0335474,0.19109,-0.0481149,0.104798,0.302989,-0.0821243,0.0642004,0.213878,-0.528248,-0.397062,0.00396831,0.0168795,0.265387,-0.462751,-0.10939,0.212467,-0.454607,0.140625,-0.487476,0.0987944,0.172742,0.401171,0.0322581,0.405236,-0.376191,0.059738,0.0280908,-0.433529,0.672613,-0.422387,0.391834,0.870188,-0.69483,0.164143,-0.433832,0.0675354,0.21519,-0.197987,-0.257445,0.100467,0.618352,-0.0115038,-1.07251,-0.565663,-0.28103,-0.154939,-0.219793,0.568013,0.336508,-0.365371,0.569195,-0.134181,0.392682,0.0846062,0.31151,0.440575,-1.03512,-0.0183392,0.216845,-0.0546406,0.33625,-0.87125,-0.428954,0.317353,-0.511137,-0.454006,0.0820914,-0.524109,-0.424463,0.0238688,0.360804,-0.0403071,-0.657252,0.0399651,0.264855,0.00451674,0.257265,0.145674,0.412281,-0.161171,0.285369,-0.41865,0.290961,-0.13927,1.09899,-0.120712,0.0620637,0.400469,-0.534815,-0.0989911,-0.426299,0.382962,0.149887,0.0845605,-0.237932,0.209626,0.152331,-0.11212,0.0088297,0.144027,0.0547737,0.188915,0.153616,0.479169,0.325535,-0.45904,-0.295939,-0.460841,-0.271349,-0.710755,0.333788,0.102477,-0.0774792,0.185731,-0.256349,-0.82363,0.0275606,0.33535,0.219043,-0.435037,-0.697189,-0.325964,0.0539363,0.232149,-0.262974,-0.157579,-0.0203727,-0.0442575,-0.54729,1.10069,0.23552,0.74378,-0.109681,0.037551,-0.0259936,-0.377174,-0.52526,0.119073,-0.0243517,-0.266998,-0.280546,-0.2656,0.0654383,-0.600649,0.0366358,0.448714,-0.136244,0.0768527,0.0122655,-0.828326,0.108435,-0.49328,-0.0902626,-0.251966,-0.437375,-0.102986,-0.597367,0.613871,-0.0805262,0.129103,0.623344,-1.11842,-0.468375,-0.15108,0.404936,0.0401617,0.384176,0.0817401,0.443277,0.103154,0.0230448,-0.871855,0.121272,-0.543216,0.136075,-0.364651,-0.694591,0.329439,-0.821212,-0.332058,0.297436,-0.0730903,-0.124181,0.662045,0.0260197,0.414971,0.415871,0.0732891,0.242185,-0.459941,-0.149562,0.178125,0.259602,-0.163672,-0.726217,-0.491823,-0.15354,-0.47195,0.0194319,0.172639,0.0870939,0.0186692,0.0442851,-0.476391,0.300795,-0.0466329,-0.253796,0.660525,0.157905,0.358267,0.114872,-0.14866,-0.180432,0.0510185,0.0836562,-0.295878,0.506517,-0.123278,0.00436017,0.56009,0.147689,0.0672306,-0.478302,0.159601,0.18211,0.399501,0.426743,-1.81642 +3412.14,0.82006,0.0912059,4,1.60213,0.733343,-1.23618,0.46098,0.552411,-0.147339,0.364777,0.05281,-0.151708,0.132415,0.0675907,-0.39985,-0.603972,0.388834,-0.546778,0.756803,0.190995,-0.0459835,-0.364464,-0.177686,0.212315,-0.455498,-0.655219,0.0823345,-0.141705,-0.0414174,-0.058825,0.475966,-0.57473,0.1359,0.424512,-0.494184,0.234664,0.0972,-0.661138,0.328621,-0.196642,1.31909,0.52952,-0.602447,0.904791,0.527759,0.0919854,-0.486793,-0.754979,0.269128,-0.193729,-0.0304807,0.422383,-0.255056,-0.129398,0.118702,0.0888699,-0.257853,0.781782,-0.29369,0.0932907,-0.473366,0.385322,-0.343052,0.280282,0.870422,-0.549936,-1.04969,0.367746,-0.30255,-0.550966,0.353657,-0.345762,-0.239854,-0.110075,0.835954,0.403603,0.0050441,0.602241,0.114859,0.35074,0.512663,-0.196361,0.0524063,0.472204,-0.503916,0.256926,-0.034333,-0.194328,0.0634134,-0.348126,-0.056936,-0.146244,-0.175045,0.218311,-0.0566282,-0.240544,-0.0760257,-0.489802,0.036782,0.110586,-0.35461,0.0616449,0.00766364,0.12322,0.162537,-0.605213,0.00965137,-0.226377,-0.730452,0.655196,0.0473423,0.288746,0.838069,-0.145639,-0.0925627,-0.314314,0.217077,-0.178624,-0.106014,-0.538474,0.203061,0.325818,0.0961396,-0.748488,-1.00726,-0.142821,-0.0638842,-0.368654,0.532607,0.791938,-0.260979,0.395557,-0.0413045,0.299134,0.234609,0.413348,0.259984,-0.52554,-0.379146,-0.00602705,0.209861,0.381994,-0.900466,-0.704675,0.271062,-0.818242,-0.363404,0.282579,-0.356994,-0.604792,0.207956,-0.0369496,-0.0118374,-0.564618,0.298168,0.430078,0.0723819,-0.040542,0.25022,0.360078,-0.330636,0.0433041,-0.663887,0.403054,0.217649,1.44051,-0.105842,-0.0400415,0.271312,-0.408457,-0.515142,-0.244172,1.00459,0.12828,-0.101057,-0.164482,0.266457,-0.154636,-0.126761,-0.0670095,0.0178243,0.0684388,0.300769,-0.16865,-0.0868106,0.460282,-0.140936,-0.293697,-0.548714,-0.0508102,-0.311401,0.103346,0.524659,0.0576121,0.30166,0.388149,-0.702363,0.0631491,0.309031,0.263583,-0.4774,-0.55357,0.295955,0.133736,0.015342,0.0445951,-0.484983,-0.210844,-0.102764,-0.632463,1.45981,0.0265142,0.42493,-0.252613,0.187311,-0.117571,-0.27911,-0.525468,0.0149706,0.335987,-0.404731,0.0267662,-0.0572923,0.199685,-0.179174,0.124663,0.124395,-0.199957,0.21941,0.22048,-0.775268,0.392681,-0.419247,0.0862045,-0.20788,-0.339069,-0.186766,-0.787835,0.570976,-0.210424,-0.0479873,0.593136,-0.923202,-0.096446,-0.326042,0.0466198,-0.0526588,0.595827,0.234852,0.433233,0.190792,0.350704,-0.638994,0.373102,-0.590896,0.246392,-0.402263,-0.350721,0.25322,-0.900275,-0.155757,0.201102,-0.152347,-0.223365,0.465168,-0.231442,0.495578,0.147105,0.126837,0.330677,-0.861604,-0.0201942,0.288572,-0.0709706,-0.37632,-0.0213486,-0.101416,-0.242003,-0.621193,-0.0450779,0.410844,0.0333086,-0.0621962,0.247224,-0.203813,-0.0890389,-0.344163,-0.198869,0.672611,0.106334,0.209351,-0.233393,-0.0473744,-0.174124,0.248853,0.503972,-0.242981,0.303421,-0.297887,-0.17725,0.336327,-0.182933,0.303067,-0.241232,0.116481,0.226475,0.341294,0.475894,-1.2791 +3411.02,0.875379,0.0912059,4,1.53379,0.808508,-1.17818,0.451882,0.277222,-0.0662129,0.0283706,-0.175401,-0.210603,-0.0859199,0.100329,-0.419368,-0.513054,0.693788,-0.368829,0.423233,0.351596,-0.0329251,-0.171968,-0.0893313,-0.0927922,-0.660231,-0.369563,0.376324,0.0731303,-0.25576,0.0145866,0.280678,-0.0069302,0.493081,0.501684,-0.290998,0.136985,0.0885139,-0.388432,0.359494,-0.022256,0.688614,0.322916,-0.829053,1.06867,0.671511,0.0667952,-0.552814,-0.753506,0.601086,-0.0903402,0.387158,0.667758,-0.162741,-0.124855,0.0370788,0.317056,-0.4281,0.60755,-0.276011,-0.142422,-0.245365,0.307368,-0.27256,0.389211,0.704077,-0.248502,-0.910293,-0.132754,0.0331289,-0.337133,0.0730503,-0.49105,-0.290108,-0.110095,0.847336,0.23206,-0.126196,0.192756,0.452922,0.193903,0.766323,-0.0598266,-0.17316,0.211153,-0.440847,0.0413691,0.123244,-0.362793,0.119729,-0.829315,-0.507853,0.135224,-0.0748949,0.117329,-0.0572816,-0.0483432,-0.0846695,-0.153665,-0.66679,0.270027,-0.289594,0.0842467,0.000278901,-0.110604,0.229033,-1.00007,-0.180786,0.0376706,-0.478181,0.807464,0.0623102,0.162565,0.776968,-0.112437,-0.0679166,-0.318996,0.0480413,0.0818231,-0.121327,-0.198273,0.0358139,0.656597,-0.112751,-0.87331,-0.828054,0.0237703,-0.086318,-0.283563,0.788159,0.774266,-0.242159,0.267127,-0.119272,0.570677,0.0887873,0.328768,0.475319,-0.534488,-0.329729,-0.081238,0.244158,0.413274,-0.833971,-0.260807,-0.139498,-0.546803,-0.657534,0.292869,0.0993652,-0.520169,0.410896,0.0438304,-0.421736,-0.309448,0.165745,0.0523793,-0.131214,-0.102017,0.290373,0.221485,-0.310269,-0.079124,-0.62299,0.386394,0.232099,1.34943,0.241697,0.223106,0.214994,-0.24529,-0.506461,-0.201828,0.783635,0.0991434,0.0490166,-0.16077,0.354155,-0.456654,-0.271093,-0.113612,0.000357982,-0.0100935,0.632703,-0.0500697,-0.371375,0.592033,-0.182239,-0.419657,-0.0812762,-0.209945,-0.0326065,0.326024,0.340076,0.00448814,-0.00592548,0.0976178,-0.798683,0.103265,0.30872,0.264325,-0.311813,-0.761349,-0.00991556,0.132807,0.0345354,0.0389074,-0.190767,-0.306668,0.0815284,-0.478303,1.32098,0.0251992,0.469437,-0.00445044,0.298275,-0.235086,-0.227457,-0.309553,0.0702882,0.364143,-0.0444524,-0.0733874,-0.124922,0.163733,-0.354002,-0.365916,0.141747,-0.384586,0.29457,-0.13513,-0.333965,0.838597,-0.229314,0.149943,-0.0989821,-0.513959,-0.34548,-0.671052,0.53815,-0.126337,-0.0395191,0.525784,-1.04812,0.0960921,-0.280534,-0.00213428,-0.00627846,0.452556,-0.0685042,0.0620614,0.200348,0.282473,-0.304489,0.387982,-0.701017,-0.0237567,-0.563637,-0.464422,0.380338,-0.849559,-0.177501,0.122056,0.0732377,0.238368,0.285016,-0.269254,0.611393,0.534931,-0.110401,0.238309,-1.16835,-0.109385,0.666006,-0.174502,-0.257898,0.118623,-0.59828,-0.125174,-0.502579,-0.105442,0.138834,0.116828,0.309247,0.495028,-0.196437,0.263636,-0.53622,-0.34561,0.655889,-0.061435,0.434113,0.0384199,0.632131,-0.171638,0.620984,0.00744639,-0.206013,0.124335,-0.542125,-0.00878649,0.529921,-0.225094,0.503105,-0.125965,0.19102,0.164903,0.437059,0.406083,-0.608892 +3389.62,0.929588,0.0912059,5,1.5941,0.650158,-1.08106,0.496145,0.258618,-0.132515,-0.188546,-0.0391757,-0.16077,-0.104233,0.00960536,0.140619,-0.866082,0.700702,-0.319364,0.790271,0.643547,-0.208428,-0.631742,-0.127615,0.283076,-0.206548,-0.668217,0.625145,0.0823372,0.160918,-0.241346,0.0366679,-0.850758,0.0679633,0.958335,-0.275843,-0.711223,-0.00311733,0.0149165,0.0765993,-0.0621641,0.452107,0.386211,-0.239733,0.986737,0.719606,0.0225213,-0.474721,-0.430471,-0.1809,-0.563733,0.141716,0.561383,-0.265824,-0.031946,-0.24458,0.32976,-0.442737,0.711107,-0.264228,0.212791,-0.570591,0.336321,-0.75021,-0.0252766,0.748692,-0.294023,-0.69429,0.0351967,0.658566,0.115156,0.291522,0.736878,0.126114,0.376972,0.56943,0.651115,0.451601,0.879901,0.0453458,0.802295,0.0536687,-0.264346,-0.162005,0.433309,0.0388406,0.289529,-0.747924,-0.021549,-0.101668,0.428414,0.641295,-0.822738,-0.0938478,0.0913725,0.573442,0.553386,-0.0928326,-0.611076,-0.970047,0.244374,-0.0215413,0.407081,0.522903,0.11947,0.0920884,-1.01274,0.293873,0.183192,-0.728976,-0.110658,-0.665319,0.627759,1.0271,-0.152788,-0.605375,-0.0729017,0.367886,-0.0920999,-0.113683,-0.198785,0.29704,0.566276,-0.103519,-0.327064,-0.127754,0.0341802,0.176878,-0.123854,0.467607,0.334816,-0.00249159,-0.107189,-0.290001,0.371216,-0.134408,0.288367,0.340817,-0.492374,-0.186933,0.53587,0.287054,0.511589,-0.963859,-0.400025,-0.277857,-0.268101,-0.544587,0.0569484,-0.219659,-0.127292,-0.144936,0.0644,-0.443949,-0.438505,0.461913,-0.303521,-0.230809,-0.133404,-0.0858208,0.165103,0.542597,0.0155837,-0.283319,0.517658,-0.179918,1.27416,-0.0770463,-0.438612,-0.0052904,-0.64553,0.753696,0.0254463,0.349579,0.0424367,-0.0117931,-0.216175,0.18747,0.0352965,-0.155877,-0.639765,0.0112198,-0.11963,1.22162,-0.614475,-0.130936,0.0536511,0.287054,-0.160618,-0.592719,-0.0512061,0.0311311,-0.29889,-0.649462,-0.396869,0.495679,-0.426887,-0.38652,-0.151835,0.512862,0.191904,-0.675497,-0.407281,-0.553751,-0.301115,-0.59404,-0.0421374,0.199325,0.185847,-0.459193,-0.731361,0.926976,-0.408317,0.218812,0.167056,-0.566995,-0.20279,0.0695264,0.144428,0.0660657,-0.285307,-0.0308969,0.291953,-0.235318,-0.13137,-0.384782,-0.487765,0.730928,-0.375366,0.307013,-0.624761,0.212009,0.548405,-0.237316,-0.649375,-0.103673,-0.927057,-0.235236,-0.10714,0.708569,0.427038,0.409005,0.492148,-1.17938,-0.126825,0.570574,0.739905,0.071502,0.429865,0.402101,0.645229,0.119458,-0.300584,-0.375749,-0.334342,-0.0914209,0.160472,0.333204,-0.402009,0.193875,-0.373894,0.0390316,0.0538762,0.0648732,-0.235909,0.344825,-0.0185672,-0.00809667,0.564813,0.111779,-0.235205,0.289832,0.363088,0.31848,-0.548739,-0.305909,-0.472074,0.39213,-0.0969109,0.911381,-0.142856,0.223857,0.776089,-0.451762,0.0781015,-0.287106,-0.335912,0.260067,0.207364,0.191285,0.091082,-0.25425,-0.349223,-0.40448,-0.0352555,0.581672,0.0983249,0.0457219,-0.339109,-0.0555214,-0.187258,-0.222288,-0.0308834,0.626537,0.0070183,0.144976,0.236327,0.380757,0.486135,-0.283293 +3406.2,0.880923,0.0912059,4,1.56537,0.666893,-1.35734,0.533805,0.347437,-0.0981456,-0.333371,0.00718415,-0.225082,-0.143434,0.00517125,0.204012,-0.9678,0.64854,-0.189678,0.89526,0.610325,-0.118946,-0.392027,-0.200386,0.200589,-0.202749,-0.596775,0.724444,0.0520901,0.106073,-0.0350456,-0.0832677,-0.901955,0.115284,0.926784,-0.317413,-0.627635,0.0131378,-0.0532562,-0.0797417,0.308686,0.494485,0.500218,-0.0999097,0.925963,0.739277,0.298511,-0.562599,-0.528978,-0.200108,-0.612542,0.261302,0.629923,-0.13865,-0.223042,-0.103835,0.270824,-0.465388,0.708148,-0.132255,-0.0130619,-0.518704,0.568104,-0.81242,0.225709,0.811845,-0.325708,-0.818081,0.0599095,0.639882,0.035339,0.336932,0.593088,-0.144102,0.169164,0.585412,0.712118,0.398184,0.798828,0.208947,0.661846,-0.0974289,-0.324824,-0.232554,0.475128,0.0990976,0.12264,-0.641529,-0.0447889,-0.249656,0.305787,0.522753,-0.810073,0.0309722,0.0414971,0.443036,0.491676,-0.1577,-0.476458,-0.672401,0.259838,-0.14858,0.689837,0.484054,0.0332199,0.157362,-0.88904,0.258903,0.12339,-0.92289,0.00840208,-0.531319,0.426715,0.912487,-0.326949,-0.709945,-0.0357666,0.401374,-0.073753,-0.218992,-0.205468,0.185891,0.53988,-0.229812,-0.553786,-0.09698,-0.230702,0.135249,-0.0591266,0.398705,0.284952,-0.006572,0.00937632,-0.257398,0.315388,-0.11479,0.332645,0.43876,-0.358196,-0.454702,0.390426,0.298269,0.239831,-0.888895,-0.454309,-0.15742,-0.0119529,-0.560916,0.0326978,-0.0224155,-0.234848,-0.0485621,0.135655,-0.430891,-0.400053,0.324414,-0.319025,-0.246481,0.010923,-0.265063,0.205975,0.5402,-0.00058185,-0.676351,0.394703,-0.0133077,1.22286,-0.162299,-0.329383,0.199182,-0.44936,0.60736,-0.0847995,-0.061979,0.0689056,-0.102476,-0.218195,0.267888,0.257166,-0.27362,-0.558005,-0.086314,-0.112835,1.16782,-0.471387,-0.0513823,-0.0941982,0.452898,-0.2958,-0.646765,0.055362,0.257337,-0.169983,-0.653768,-0.406269,0.391346,-0.639188,-0.514639,0.0749028,0.36146,0.137966,-0.581414,-0.481475,-0.631137,-0.20216,-0.496197,0.00784371,0.170123,0.196205,-0.158823,-0.649183,0.897777,-0.0582031,0.306302,0.226605,-0.562001,-0.436947,-0.038508,0.153566,0.220479,-0.217806,-0.199776,0.382413,-0.307466,0.0323619,-0.234319,-0.182044,0.518916,-0.521127,0.386455,-0.716152,0.28251,0.678619,-0.228326,-0.679429,-0.155753,-1.07892,-0.198434,-0.189581,0.547851,0.235052,0.328697,0.518837,-1.23754,-0.0528214,0.431185,0.612077,0.0813856,0.41515,0.216534,0.398959,0.0843598,-0.16858,-0.551729,-0.207095,-0.487417,0.238072,0.283976,-0.504838,0.0713886,-0.362262,-0.00267441,0.0415278,0.0822002,-0.221956,0.494376,-0.125741,0.0276561,0.532573,0.116713,-0.219381,0.40294,0.294918,0.310777,-0.539232,-0.361746,-0.416748,0.0858954,-0.00789549,0.843515,0.154183,0.293393,0.800648,-0.474794,0.187769,-0.43317,-0.275065,0.0817322,-0.0124902,0.159602,0.160329,-0.334556,-0.176655,-0.382097,0.11038,0.391461,0.0703292,0.0705062,-0.362167,-0.147269,-0.095366,-0.0101871,0.0580071,0.487957,0.0747148,0.151372,0.193878,0.389065,0.440316,-0.535615 +3409.67,1,0.0912059,5,1.54929,0.644111,-1.39788,0.610465,0.303747,-0.082232,-0.475326,-0.0555965,-0.331135,-0.109904,0.0436709,0.218813,-1.03749,0.769666,-0.202712,0.874211,0.588228,0.00351509,-0.560548,-0.157132,0.160488,-0.260651,-0.733931,0.731826,0.053361,0.121559,-0.085635,0.0577715,-0.998236,0.127941,0.881183,-0.458556,-0.52095,0.050608,0.00582181,-0.0130289,0.112407,0.535592,0.502721,-0.179388,0.909018,0.769783,0.349886,-0.655365,-0.596903,-0.191895,-0.625261,0.57019,0.506004,-0.0809055,-0.22962,-0.132169,0.205188,-0.458879,0.611854,-0.0658689,-0.112708,-0.456867,0.510144,-0.835937,0.118978,0.709975,-0.43645,-0.776157,0.0266354,0.744892,-0.104311,0.30347,0.597278,-0.201888,0.160475,0.656866,0.663507,0.313109,0.804696,0.263443,0.71298,-0.00444511,-0.28071,-0.19392,0.481319,0.0840942,0.0459651,-0.646478,-0.0382532,-0.212465,0.167524,0.447014,-0.83986,-0.0304064,0.062814,0.267744,0.567167,-0.165742,-0.4182,-0.794564,0.328197,-0.0948877,0.699564,0.466557,0.100213,0.206096,-0.987107,0.305498,0.251301,-0.917357,0.203275,-0.513141,0.335839,0.940553,-0.247238,-0.713085,-0.0952122,0.356489,-0.133866,-0.25576,-0.0588794,0.190883,0.454908,-0.179643,-0.415192,-0.0502649,-0.0917632,0.186697,-0.00192831,0.405281,0.384315,-0.167547,0.231268,-0.171886,0.333127,-0.110791,0.325351,0.316355,-0.500059,-0.398607,0.425542,0.282952,0.131873,-0.755294,-0.517282,-0.192683,0.0351342,-0.665916,0.0472723,-0.069519,-0.182353,-0.0335254,0.240609,-0.229004,-0.494847,0.375381,-0.374565,-0.0580012,0.165374,-0.260381,0.293666,0.533283,-0.0118742,-0.447971,0.368257,0.140175,1.26252,-0.0879569,-0.282484,0.172376,-0.444631,0.574203,-0.141219,-0.11888,0.100706,-0.186641,-0.230596,0.38779,0.193825,-0.259699,-0.661651,-0.13141,-0.214511,1.15772,-0.552743,-0.208832,-0.142166,0.306477,-0.191973,-0.701472,0.170383,0.25804,-0.111286,-0.621584,-0.391441,0.395005,-0.612622,-0.526501,0.169475,0.291809,0.0858117,-0.629937,-0.500994,-0.615657,-0.234643,-0.503815,0.0654279,0.166021,0.193209,-0.0523592,-0.554302,0.981254,-0.0374151,0.35952,0.144478,-0.542245,-0.522257,-0.0753453,0.162268,0.192414,-0.188251,-0.131258,0.328732,-0.228527,0.0246264,-0.27075,-0.00388668,0.376425,-0.574048,0.36076,-0.815403,0.031324,0.689297,-0.230248,-0.63534,-0.108536,-1.0778,-0.199517,-0.228513,0.467258,0.297487,0.354706,0.603569,-1.11985,-0.133362,0.509383,0.665329,0.0527965,0.735957,0.145844,0.376806,0.0886995,-0.136296,-0.5858,-0.235479,-0.501509,0.0802988,0.250649,-0.377206,0.173717,-0.48065,-0.00772872,0.0423744,0.0601604,-0.157383,0.508623,-0.0722616,0.0273947,0.501838,0.167405,-0.134571,0.555085,0.307683,0.348313,-0.472889,-0.414165,-0.471174,0.118005,0.167658,0.771641,0.0846011,0.39694,0.738986,-0.44872,0.210992,-0.366474,-0.256854,0.0640211,-0.0284642,0.160476,0.122471,-0.374382,-0.193636,-0.426692,0.059472,0.179834,-0.0659949,0.005084,-0.399641,-0.142532,-0.142539,-0.00244577,0.0779624,0.634693,-0.0437528,0.160716,0.20627,0.400895,0.454169,-0.421751 +3374.86,0.931316,0.0912059,4,1.52053,0.710575,-1.4702,0.635841,0.512358,-2.66439e-05,-0.12201,-0.0750134,0.130654,-0.184631,-0.106802,0.0600406,-0.167079,0.636056,-0.486138,0.659193,0.176249,0.0200345,-0.0838327,0.176037,-0.0102633,-0.680353,-0.777957,0.536587,-0.449421,0.186942,-0.0682131,-0.314699,-0.0593319,0.500114,0.740908,-0.55702,0.192918,0.11538,-0.196571,0.104358,-0.366871,0.0543723,0.318647,-0.893652,0.984536,0.717752,0.357767,-0.267799,-0.0239782,-0.0897355,-0.915842,0.237147,0.486997,-0.291349,0.0650844,0.371202,0.446682,0.343255,0.76984,-0.182337,-0.058883,-0.618492,0.558333,-0.580844,0.251031,0.908592,-0.627439,-0.639138,-0.0324162,0.633164,0.0489831,0.901199,-0.0776245,-0.0332189,-0.335813,0.730907,0.338532,0.558444,0.26036,0.779221,0.0893272,0.00695234,-0.399736,0.179703,0.288491,0.240167,0.186951,-0.32294,-0.423918,0.262668,0.515831,0.194914,-0.383179,-0.0833579,-0.252621,0.556018,0.138992,-0.300739,0.0802362,-1.07292,0.100907,-0.463844,-0.104281,0.353138,-0.24621,0.605208,-0.75479,-0.48289,0.351014,-0.665349,-0.19718,-0.184787,0.666466,0.509856,-0.773204,-0.238996,0.13109,0.00698086,-0.221417,0.247805,-0.622172,-0.233181,0.174568,-0.337489,-0.801225,0.31246,0.778471,0.0177661,-0.289745,0.521034,0.0187226,-0.544916,0.528706,-0.233205,0.588532,-0.191698,-0.358354,0.118936,-0.136735,-0.560881,-0.0624481,-0.271328,0.677482,-0.892536,0.287232,-0.237454,-0.0531044,-0.812347,0.44601,0.183555,0.393742,0.429615,-0.277414,-0.136535,-0.619655,0.315047,-0.116668,-0.276566,0.602281,0.182903,0.1134,0.0647291,0.0108751,-0.212648,0.282717,0.0486638,0.663573,-0.299205,-0.549374,0.163448,-0.0701101,0.479039,-0.441886,0.0351939,0.495706,-0.0282367,-0.290016,0.0464773,-0.0475065,-0.834553,-0.0599848,0.0940519,-0.0777508,0.853753,0.276186,-0.459485,-0.0972617,0.321404,-0.181108,-0.590855,-0.467136,0.171074,0.0959942,-0.808129,-0.252037,0.292769,-0.156506,-0.361116,0.438345,0.0604905,0.646357,-0.0603256,-0.48361,-0.246952,-0.286957,-1.12852,-0.439499,0.651332,0.219541,0.409617,-0.36022,0.99817,0.185458,-0.0573069,0.253666,-0.0821189,0.124062,-0.0794427,0.188254,0.27918,0.444579,0.268619,0.431113,0.315825,-0.130808,-0.510497,-0.919402,0.411578,-0.295433,-0.0178759,-0.466974,0.189603,0.0477534,0.217406,-0.618612,-0.151464,-0.834175,-0.287127,-0.579853,0.0338773,0.463256,0.505175,0.67904,-0.613422,-0.353717,0.770637,0.271838,0.160397,0.0327948,0.428606,0.533499,0.0238694,-0.280572,-0.863948,0.0963723,-0.378871,-0.17753,-0.361618,0.447903,0.230377,-0.450146,-0.362094,1.2244,-0.130215,-0.434792,0.24266,-0.126845,1.0485,0.667297,0.00229894,0.173415,0.144107,0.263213,0.449503,-0.459101,-0.340567,-0.0357703,-0.0404862,-0.679806,0.36041,0.0894489,-0.111597,-0.36623,-1.05353,0.0135048,-0.515285,-0.45841,0.48384,-0.0249233,0.350289,0.0839804,-0.0610986,-0.441664,0.373578,-0.485491,0.254998,-0.220059,-0.0244148,-0.812294,0.298439,0.0879355,0.046894,0.107431,0.36139,0.638697,0.199663,0.229803,0.446836,0.479377,-1.26719 +3397.37,0.994382,0.0912059,4,1.49755,0.605262,-1.00482,0.39645,0.253138,0.0669062,0.0121717,-0.145032,0.0312291,0.170981,0.194304,0.0283092,-0.256988,1.04002,-0.359505,1.2087,0.480832,0.35304,-0.29364,0.393194,-0.0894439,-0.0413645,-1.04354,0.919502,-0.499078,0.139772,-0.303457,-0.445523,-0.871179,0.125664,0.996526,-0.606404,0.0699607,0.228682,0.211868,0.0773606,-0.303013,0.610601,0.582675,-1.12455,1.12466,0.839305,0.395675,-0.292493,0.0347803,0.148273,-0.667417,0.0896786,0.59474,-0.506994,0.118339,0.072951,0.149241,0.273633,1.48437,-0.498658,-0.0452216,-0.485881,0.775647,-0.265889,-0.0694665,0.855048,-0.189732,-1.11784,-0.297169,0.315827,0.371602,0.531265,0.209135,-0.239527,0.0148142,0.338782,0.521913,0.459663,0.177286,0.698013,0.595151,0.200343,-0.58128,0.158288,-0.108508,0.23877,0.0421316,0.13295,-0.0418575,0.100813,0.720914,0.267969,-0.280675,-0.322209,0.044557,0.362143,0.683342,-0.22361,-0.135692,-0.940099,-0.406631,0.0125954,-0.0408673,0.212306,-0.316895,-0.000311713,-0.404623,-0.607667,0.134427,-1.02232,0.117641,-0.360948,1.03196,0.319251,0.0235274,-0.0110011,-0.0849589,0.125245,-0.0274813,0.660745,-0.32507,-0.00175344,0.236129,0.0309644,-0.794613,0.217872,0.170362,-0.136113,-0.566761,0.498484,0.0587637,-0.404468,0.428602,-0.923459,-0.00730316,-0.0411163,0.100886,0.388119,-0.0889819,-0.321539,-0.395009,-0.450271,0.526043,-1.12093,-0.268044,-0.276917,-0.0656773,-0.753833,0.145034,0.133218,-0.357392,0.177627,0.505286,-0.677099,-0.636596,0.49929,-0.0204478,0.210629,0.351475,-0.135329,0.320744,-0.228763,-0.371389,-0.0666904,-0.0608521,-0.205302,0.733452,0.684035,0.198044,-0.0151515,-0.18279,0.345773,-0.136816,0.0501293,0.461021,-0.367244,-0.563494,-0.0360508,-0.551171,0.0495245,-0.282321,0.537494,0.79773,0.502563,-0.059277,-0.559102,0.539423,0.395068,0.137328,-0.498853,0.0650326,-0.0105103,0.458305,-0.0478217,0.0512609,0.473785,-0.530479,-0.186362,0.0906197,0.314607,-0.0776986,-0.107053,-0.395475,-0.29293,-0.0417902,-0.653049,-0.342128,0.295793,0.208544,0.112688,-0.172278,1.05213,0.308091,-0.313848,0.409413,-0.0869541,0.408085,-0.274011,0.396964,0.24951,0.184936,-0.1144,0.119898,0.266987,-0.0847531,-0.607732,-0.42326,0.145415,-0.117453,0.346321,0.0267975,0.458543,0.423607,-0.53109,-0.413065,-0.177681,-0.474469,-0.577325,0.0650029,0.26748,0.645148,0.459547,0.748997,-0.415317,0.230804,0.678953,0.039392,0.229961,0.260395,0.11898,0.413755,0.288088,-0.356544,-0.626088,0.741903,-0.72236,0.104131,-0.102886,0.439173,-0.165101,0.0957311,-0.363584,0.476896,-0.118502,-0.0242075,0.226125,0.379937,0.389473,0.115095,-0.152027,0.0396066,0.164615,0.187706,0.136613,-0.759746,-0.218009,-0.0103812,0.751575,-0.588398,0.196092,-0.300471,0.131804,-0.243156,-0.278349,-0.120355,-0.43825,-0.165633,-0.386079,-0.000686647,0.253057,0.0660179,-0.0157479,0.190635,-0.335,-0.432462,0.421176,0.192809,0.161733,-0.357231,0.304313,-0.0491564,-0.176254,-0.358228,0.0563511,0.0440469,0.153161,0.238805,0.391358,0.488677,-0.277644 +3401.73,0.761285,0.0912059,5,1.55977,0.646725,-1.06359,0.438997,0.347188,-0.159763,0.0152526,-0.0445715,-0.421293,-0.104702,0.14428,-0.316311,-0.382366,0.727331,-0.666177,0.637537,0.467395,-0.115123,0.0521026,0.16873,0.133736,-0.0215823,-0.334697,0.615352,-0.186746,0.526513,0.134611,-0.358805,0.169839,0.463658,0.851288,-0.145228,-0.511478,0.219001,0.0174278,-0.104365,-0.493816,0.00211471,-0.00294915,-0.506199,1.30532,0.39563,-0.0963012,-0.49018,0.185996,-0.752387,-0.466669,0.196353,0.470138,-0.240374,0.245473,0.92708,0.157457,-0.557479,1.13276,-0.0717794,-0.314127,-0.590406,0.464839,-0.931098,-0.138953,0.899778,-0.708252,-0.757293,0.0985645,-0.0969219,0.0636559,-0.728892,0.0856289,-0.406915,0.17262,0.287816,0.538368,0.751136,0.09731,0.0387922,0.160139,0.234567,0.186552,0.356429,0.113207,-0.954986,0.213315,0.0177681,-0.116973,0.140419,0.0639526,-0.785899,-0.051324,-0.170522,-0.807617,-0.295468,-0.319373,-0.25109,0.181512,0.236125,0.618123,-0.276026,0.670913,-0.0489718,-0.6085,-0.113147,-0.507072,0.325989,-0.0556827,-0.525923,0.440938,-0.0674879,0.334384,0.530238,-0.576256,-0.255879,-0.244885,0.122337,0.368569,-0.163124,-0.26278,-0.108169,0.162644,0.319264,-0.42311,0.0351261,0.476388,0.0609311,-0.374336,0.31131,0.787906,-0.105905,0.205431,-0.381873,0.631339,-0.216324,0.164344,0.369719,-0.292433,-0.210024,0.625941,0.185357,0.477631,-0.680433,-0.318407,-0.135907,0.0455931,-0.494339,0.203877,0.485464,-0.00220498,0.359581,-0.0807176,-0.106631,-0.175638,0.535588,0.0344005,0.117729,-0.171254,0.650317,0.702456,0.760138,-0.0295044,-0.37645,0.0193462,-0.104937,0.188028,0.0813108,0.291689,0.0522331,-0.287696,0.0941627,-0.0502132,0.124297,0.0667367,-0.0938415,-0.0487487,-0.327043,0.115942,-0.0516913,-0.253749,0.0671779,0.0559539,0.7558,0.574418,-0.432844,-0.0745907,0.0605123,-0.719195,-0.178605,-0.0802231,-0.424719,0.217663,-0.429995,-0.0885784,-0.201554,0.23229,-0.460271,0.368181,0.0299034,0.444081,-0.451701,-0.779337,-0.179172,-0.039918,-0.846439,-0.325356,-0.221838,0.415551,0.166814,-0.598508,1.13158,-0.2971,0.578666,0.0643545,-0.536644,-0.0631585,0.314265,-0.310813,-0.00609484,0.58534,0.0910324,-0.130306,-0.213057,0.376611,-0.680372,-0.0387893,0.431846,-0.636376,0.578335,0.0922581,-0.362651,0.0593118,0.235234,-0.726724,-0.173685,-0.328778,-0.133472,-0.392897,0.330112,0.736767,0.0384365,0.557565,-0.722119,-0.114402,0.651221,0.191038,-0.1382,0.170907,0.00510864,0.879054,-0.167154,-0.405436,-0.79136,0.866299,-0.808389,0.375594,-0.282003,-0.589292,0.0957219,0.258585,-0.299833,0.530211,-0.165666,0.289319,-0.361348,0.00578867,0.289554,0.569585,0.349069,0.0352877,0.025971,0.185033,0.0262613,-0.331259,-0.281242,-0.258607,-0.340399,0.200632,0.00535231,0.0543409,-0.598932,-0.445845,0.0208465,0.166679,-0.0404018,0.313064,0.251084,0.168706,0.853674,-0.133715,-0.172245,0.122902,-0.116483,-0.130489,-0.0328601,0.0665132,0.437254,-0.0670841,0.195473,0.420952,-0.150631,-0.72483,-0.149052,0.24569,0.13054,0.257924,0.361303,0.507863,-0.55376 +3397.96,0.903254,0.0912059,4,1.56916,0.612091,-1.14418,0.422437,0.365891,-0.184575,-0.00273675,0.0350968,-0.384845,-0.0474781,0.192346,-0.328845,-0.454323,0.7713,-0.576459,0.642313,0.494121,-0.0954084,0.191093,0.150283,0.175122,-0.0246183,-0.493737,0.68841,-0.107676,0.483361,0.147153,-0.296748,0.161489,0.430075,0.846698,-0.107457,-0.52441,0.180093,-0.0129599,-0.154047,-0.573217,-0.0281356,0.025061,-0.397526,1.2858,0.301693,-0.146611,-0.46532,0.175843,-0.73489,-0.495987,0.256564,0.387866,-0.25982,0.229595,0.853645,0.169963,-0.517382,1.1157,0.00668071,-0.310117,-0.577071,0.554723,-0.956674,-0.189558,0.895411,-0.765516,-0.830949,0.114255,-0.0902459,0.0373367,-0.650405,0.0751996,-0.316677,0.117107,0.306671,0.544045,0.737286,0.12284,0.0393211,0.158034,0.292831,0.152128,0.36403,0.094113,-0.859162,0.22341,-0.0199716,-0.0995115,0.0817468,0.0430953,-0.722852,-0.0409906,-0.185928,-0.699446,-0.229061,-0.217967,-0.217921,0.300655,0.180703,0.564327,-0.24941,0.651089,0.023774,-0.763594,-0.098544,-0.521519,0.239704,0.0187757,-0.575612,0.457765,-0.0964385,0.381506,0.509625,-0.52918,-0.263014,-0.202549,0.125629,0.496267,-0.191658,-0.231139,-0.0794847,0.175018,0.307517,-0.375909,0.0359552,0.519222,0.0557489,-0.305468,0.245737,0.792808,-0.161773,0.236509,-0.404327,0.662758,-0.196423,0.136594,0.302667,-0.230537,-0.161555,0.647936,0.229724,0.414532,-0.678187,-0.333083,-0.107273,0.0565159,-0.445851,0.276462,0.492216,-0.0184786,0.380918,-0.072353,-0.133863,-0.173668,0.513598,-0.0384812,0.0956607,-0.149395,0.606905,0.756343,0.838908,0.0164527,-0.379553,0.0072662,-0.106936,0.113431,0.158734,0.352758,0.181436,-0.286389,0.105236,-0.0756637,0.19489,0.110808,-0.0896235,-0.073263,-0.27097,0.213571,-0.0636286,-0.175801,-0.0164923,0.0663367,0.741354,0.587711,-0.506053,-0.106111,0.122347,-0.838465,-0.228127,-0.151931,-0.448232,0.127405,-0.355133,-0.106269,-0.296551,0.229943,-0.335074,0.460492,0.0168775,0.4449,-0.450981,-0.829388,-0.155177,-0.0887406,-0.891742,-0.290595,-0.233815,0.489266,0.0973537,-0.636342,1.1481,-0.381177,0.584104,0.0282284,-0.486419,-0.0654295,0.277106,-0.28339,0.00978853,0.694553,0.0959524,-0.108959,-0.252955,0.352742,-0.687902,0.0301308,0.365593,-0.593405,0.550243,0.108645,-0.374078,-0.00927635,0.140711,-0.77945,-0.123984,-0.297808,-0.174855,-0.397719,0.355234,0.654982,0.0237018,0.573758,-0.677065,-0.096475,0.711548,0.235779,-0.217471,0.201701,-0.0464672,0.92636,-0.1325,-0.451997,-0.752231,0.861279,-0.791417,0.332542,-0.269421,-0.532023,0.0330289,0.176645,-0.335042,0.429667,-0.188011,0.243413,-0.334786,-0.0999716,0.316478,0.597741,0.458491,0.00935506,-0.0290426,0.156296,-0.00103675,-0.233385,-0.312453,-0.117296,-0.300125,0.317171,0.0570384,0.024092,-0.503106,-0.518237,0.0294932,0.202159,-0.0830718,0.324193,0.102582,0.244546,0.856612,-0.154138,-0.100242,0.114469,-0.138484,-0.0505392,-0.0470579,0.0600533,0.517293,-0.117356,0.182478,0.380903,-0.120991,-0.62202,-0.214542,0.13844,0.13176,0.246115,0.362988,0.4961,-0.480973 +3415.24,0.824377,0.0912059,4,1.55716,0.604373,-1.05686,0.394992,0.413994,-0.215534,-0.0735803,0.164958,-0.21451,-0.0663639,0.143745,-0.0966519,-0.32665,0.773305,-0.378759,0.875791,0.464799,0.1785,-0.039934,-0.0209975,-0.0778456,-0.322673,-0.624625,0.556378,-0.115279,0.290387,0.267724,-0.170593,-0.136101,0.0733414,0.911366,-0.273476,-0.777173,0.397771,0.0651124,-0.0541071,-0.391921,0.160611,0.0579836,-0.689396,1.20717,0.3525,-0.235703,-0.798064,0.228872,-0.508068,-0.183236,-0.00562963,0.608855,-0.348369,0.381004,0.755561,0.366166,-0.493151,1.08037,-0.000417223,-0.146514,-0.676803,0.820224,-0.525378,0.102884,0.7675,-0.607925,-0.722611,-0.148844,-0.359456,-0.235249,-0.571256,-0.00138667,-0.352651,0.0584695,0.318445,0.57875,0.631506,0.213234,0.14883,0.240637,0.58113,0.37702,0.237408,0.279648,-0.979243,0.304828,0.081528,-0.216745,0.219077,0.426504,-0.466114,0.233095,-0.378809,-0.790946,-0.183064,-0.220176,-0.185135,0.240807,-0.157543,0.25135,-0.270423,0.73867,0.00323397,-0.706695,0.0880326,-0.392994,-0.00894565,0.0801377,-0.433212,0.491747,-0.125675,0.293989,0.598625,-0.616656,-0.429169,-0.274933,0.166618,0.290534,-0.166519,0.0608045,-0.0246142,0.20461,0.359088,-0.391286,0.323015,0.35928,-0.0800217,-0.0749064,0.50753,0.628047,-0.16019,0.444186,-0.265774,0.393801,-0.175375,0.105051,0.294812,-0.462945,0.108393,0.850725,0.23689,0.0550021,-0.538853,-0.606122,0.00707749,0.0451524,-0.710467,-0.125416,0.582475,0.0403923,0.295919,-0.1573,-0.170041,-0.0875969,0.606002,0.088498,0.167205,-0.194708,0.348639,0.713582,0.841358,-0.0542141,-0.197887,0.363084,-0.204604,0.253689,0.131251,0.377625,0.766453,-0.0718123,0.00517549,-0.0514101,0.258403,-0.0620277,-0.460243,-0.129167,-0.0229726,-0.104546,-0.246018,-0.265491,0.0302013,0.431267,0.67042,0.780467,-0.512465,-0.224513,0.0718392,-0.704107,-0.0267668,-0.306095,-0.314432,0.171366,-0.249965,-0.168832,-0.0825776,0.28144,-0.535694,0.205469,0.028366,0.596934,-0.274634,-0.912805,-0.0168226,0.0270144,-0.698764,-0.362861,-0.182228,0.625043,0.292339,-0.527528,1.03909,-0.0848438,0.431914,-0.0742066,-0.383648,-0.176998,0.422234,-0.339984,0.358653,0.493124,0.0466349,0.0129184,-0.121237,0.0994871,-0.629574,0.0600922,-0.127747,-0.739519,0.327081,-0.230887,-0.62034,-0.0747964,0.0587718,-0.508155,-0.331938,-0.13089,-0.478757,-0.279238,0.249342,0.420606,0.408139,0.802837,-0.571939,-0.152637,0.0609987,0.129468,-0.374455,0.342916,-0.240521,1.0318,0.165259,-0.330161,-0.898336,0.490944,-0.619934,0.437659,-0.166734,-0.40696,0.372078,-0.0120301,-0.249226,0.659603,-0.206462,-0.216224,-0.0823017,-0.161717,0.284971,0.36225,0.252398,0.103084,-0.210226,0.0476445,0.174143,0.00838727,-0.191694,0.152689,-0.327036,0.388463,0.288597,-0.0778294,-0.188711,-0.169584,-0.0797866,0.427381,-0.111251,-0.00395625,0.0293235,0.293954,0.895275,-0.0638947,0.159678,-0.0724565,-0.16848,0.0941628,-0.103034,-0.0215131,0.634699,-0.268454,0.210415,0.365058,-0.128834,-0.483701,-0.238483,0.357269,0.140623,0.241293,0.374997,0.491216,-0.651132 +3418.5,1,0.0912059,4,1.45944,0.752716,-0.785287,0.201627,0.0956377,-0.0935234,-0.00486005,-0.0844399,0.452486,0.613409,-0.174782,-0.116371,0.0535357,1.10367,-0.0876798,0.701707,0.397366,-0.131635,-0.686248,-0.190978,0.176994,-0.201088,-0.652842,0.329565,-0.109856,0.32574,-0.137287,0.0971556,0.0109801,0.391212,1.0343,-0.78008,0.125698,0.2066,-0.286541,0.28017,-0.730428,0.327794,0.471724,-0.115534,1.35926,0.979979,0.350692,-0.0207915,0.183577,0.45037,-0.774307,0.575971,0.609447,0.0204856,0.71641,-0.303469,0.017113,0.0559055,1.02095,-0.431898,0.341173,-0.768494,0.628747,-0.285005,0.373898,0.907417,-0.00902833,-1.11808,0.225896,0.489645,0.0100581,-0.0428006,0.215402,0.362335,0.263201,0.343345,0.0390874,-0.17672,0.980812,0.360634,0.553132,0.515032,-0.223707,-0.367767,0.0408785,0.25377,0.163259,0.309265,-0.347287,-0.396216,-0.43445,-0.542858,-0.250902,-0.312966,0.154422,-0.256718,0.191078,-0.0329655,0.265611,-0.187521,0.818966,0.00567797,-0.0927582,0.206581,-0.0142796,-0.540794,-0.787451,-0.347576,-0.00196074,-0.125208,0.0938068,-0.430233,0.670226,-0.00132023,0.261598,-0.255154,0.204773,0.463662,-0.0554743,0.23107,-0.158897,0.0569674,-0.072649,-0.381904,-1.03632,-0.795558,-0.374019,-0.153864,0.0984285,-0.38608,-0.201947,0.495332,0.369676,-0.705793,-0.135517,-0.228352,0.484358,0.4384,-0.159518,-0.390533,-0.395497,0.206543,0.440185,-0.682273,-0.560685,-0.0398835,-0.0228602,-0.671622,0.19952,0.0862196,-0.294544,-0.114817,-0.203663,0.0167848,-0.207259,-0.00529947,0.380977,-0.40353,0.0678421,-0.178476,-0.197945,-0.181748,-0.26771,0.137959,0.495949,0.610098,0.452838,-0.0512301,0.325084,-0.115419,0.309312,0.133917,-0.669748,-0.0557797,0.333677,-0.345085,-0.0768367,0.301938,-0.0919517,0.195422,-0.47021,0.10815,-0.313645,1.08376,-0.276621,0.135697,-0.0891382,0.432659,-0.0219253,-0.469533,-0.182324,-0.162965,0.45626,-0.0118734,-0.404989,0.529931,-0.362387,-0.657356,0.155064,0.648421,0.263892,-0.139645,-0.680935,0.373262,0.0278269,0.0664914,-0.33052,0.423983,-0.479755,-0.267568,-0.289906,0.894564,-0.438395,-0.0568871,0.374234,0.277815,-0.262778,0.630897,0.105617,0.411905,-0.426586,0.0136306,0.146789,-0.0442983,-0.030118,-0.258915,-0.0743424,0.238534,-0.880884,0.770674,-0.0994579,-0.35916,-0.0596711,0.278108,-0.278448,0.305106,-0.0485487,0.110628,-0.242281,0.228025,0.164952,0.119384,0.13628,-0.64486,0.226074,0.584765,0.129504,-0.0956266,0.0641854,0.330742,0.636317,0.332049,0.0878723,-0.2071,-0.0601726,-0.211106,0.0799283,0.0251316,0.149435,0.67602,-0.608548,-0.462904,0.0361225,0.348388,0.57466,0.0492494,0.54721,0.193515,-0.192235,0.374781,0.0854517,0.0999264,-5.11802e-05,0.182647,0.0945271,-0.118217,0.276111,0.0255455,-0.176439,-0.00735053,-0.0717563,0.0184448,-0.131805,0.0230182,-0.577663,0.430582,-0.504395,-0.399318,0.137026,0.326258,-0.0789574,0.660626,0.583235,0.236501,-0.185666,0.430853,-0.0235316,0.165272,-0.148283,0.0596579,-0.26613,-0.0511483,0.0429855,0.390604,-0.0587566,0.124616,0.273571,0.35301,0.52304,0.0559479 +3433.9,0.729771,0.0912059,4,1.49208,0.804642,-0.831629,0.181974,0.198501,-0.210975,-0.374746,0.565777,0.229455,-0.233168,-0.229361,-0.300021,-0.0531028,0.797261,0.140122,0.590491,0.478674,0.0853835,-0.0936384,-0.153495,-0.206794,-0.638876,-0.532608,0.710045,-0.739815,-0.0309068,-0.0278084,-0.0558641,0.140471,-0.0178916,0.697757,-0.389208,0.238994,-0.0816119,-0.138534,0.101507,-0.299727,0.313183,0.361081,-0.374658,1.25322,0.191624,0.414627,-0.6434,0.112994,-0.197048,-0.410836,0.221278,0.433584,-0.179039,0.598336,0.423069,0.430399,-0.581424,1.22191,-0.501003,-0.0772211,-0.737941,0.71911,-0.429514,0.634673,0.81382,-0.527419,-0.748126,0.427328,0.515093,0.0766888,-0.156552,0.0394516,-0.515727,-0.135933,0.423335,0.120668,-0.0779385,0.501801,0.46795,0.298624,0.259107,0.285811,-0.169575,0.12552,-0.57856,-0.30191,0.0152745,0.104085,-0.0635279,-0.563167,-0.388256,-0.304737,-0.0913663,0.385054,0.0547895,0.055638,-0.100431,0.0752331,-0.111647,0.412744,-0.218551,0.0819236,0.0254682,0.560483,0.175098,-0.38016,0.14114,-0.400163,-0.266021,0.225636,0.121897,0.332973,-0.0802071,0.0435059,0.309634,-0.329835,0.191262,-0.163084,0.0943005,0.0479919,0.0715989,0.656579,-0.166827,-0.77728,0.0168505,0.233957,0.0980623,0.369977,-0.250174,0.112764,-0.0319878,0.382161,-0.40675,-0.203771,-0.525434,-0.185663,0.293695,-0.775222,-0.217688,0.193364,0.0488806,0.017897,-0.259823,-0.38973,-0.33007,0.320102,-1.13419,0.28493,0.29637,-0.0261493,0.510415,-0.120037,0.266236,-0.0196017,0.708528,0.223428,0.346872,0.195078,0.201136,0.217154,0.10223,-0.165757,-0.668741,-0.0372403,-0.282524,0.827185,-0.0950684,0.24113,-0.16787,-0.0512401,0.154481,0.162037,-0.318949,-0.298493,0.18255,-0.15219,0.0534889,-0.196199,-0.0370198,-0.27056,-0.0827885,-0.150527,0.895254,-0.616003,0.201049,-0.0145313,0.00785795,-0.277044,-0.221797,-0.312803,0.0992678,-0.108355,-0.443928,-0.0807199,-0.62925,0.310265,-0.843591,-0.0521738,0.38024,0.55884,-0.0317479,-0.804093,0.0961469,-0.213475,-0.301156,0.160405,0.0335436,-0.57965,-0.0671719,-0.393772,0.990505,-0.0795496,0.230277,0.104976,-0.0965491,0.274766,0.181274,-0.644034,0.643306,-0.00611601,0.151723,0.104771,-0.0643458,-0.605588,-0.834806,-0.711237,0.268087,-0.429482,0.461568,-0.271201,0.0892785,0.574872,-0.180994,-0.206979,-0.233583,0.129619,-0.503385,-0.290202,0.293726,-0.0729511,-0.258065,0.192865,-0.695357,-0.200833,0.45492,0.143953,-0.127193,0.349992,-0.264843,0.720122,0.176897,-0.0214448,-0.421996,-0.0205863,-0.176775,0.517265,0.124433,0.249616,0.563907,0.133278,-0.244616,0.0772673,0.0892184,0.221441,-0.382191,-0.2389,-0.0445348,0.250283,-0.187884,0.275754,0.189179,-0.328746,0.210399,0.126632,0.121441,-0.32971,-0.0349553,0.22993,0.198523,-0.0593081,0.480397,-0.00902905,-0.260059,-0.327156,-0.0767457,-0.0525637,0.628554,0.379223,0.415297,-0.287245,0.0748486,-0.033842,-0.41008,0.0376807,0.0801741,0.227252,-0.141688,0.188938,0.0957366,0.0381777,-0.0910953,-0.148729,0.21479,-0.485145,0.119042,0.224236,0.345024,0.473535,-0.272348 +3432.27,0.68184,0.0912059,4,1.48858,0.793856,-0.859209,0.196896,0.178137,-0.208603,-0.401666,0.564211,0.201438,-0.21108,-0.20373,-0.325878,-0.0424571,0.76921,0.132542,0.58362,0.488202,0.0664754,-0.0886074,-0.185377,-0.198771,-0.651291,-0.49247,0.758949,-0.753961,-0.0439808,-0.0745141,-0.017594,0.155242,-0.0427556,0.676152,-0.411086,0.20696,-0.0443828,-0.195895,0.0998266,-0.320063,0.300279,0.387868,-0.377298,1.25257,0.202855,0.412865,-0.638318,0.134951,-0.13746,-0.433277,0.255499,0.449576,-0.172641,0.608071,0.400557,0.460768,-0.630562,1.20518,-0.498447,-0.0464953,-0.725817,0.736131,-0.481238,0.570427,0.807561,-0.502815,-0.785089,0.388612,0.520645,0.102771,-0.146738,0.0365764,-0.535921,-0.160694,0.412057,0.120883,-0.0366283,0.528504,0.476063,0.319577,0.221051,0.290775,-0.18048,0.121915,-0.570168,-0.33212,-0.00977707,0.130158,-0.1068,-0.581858,-0.423658,-0.307082,-0.0876751,0.41001,0.0418383,0.0541956,-0.0831731,0.0590471,-0.0931032,0.434459,-0.214011,0.105949,0.0323847,0.524778,0.213943,-0.424236,0.11843,-0.409065,-0.232671,0.21565,0.094606,0.390254,-0.107532,0.0095792,0.285681,-0.341229,0.188066,-0.162967,0.0849408,0.0435617,0.0517114,0.647174,-0.152833,-0.741239,0.0445527,0.258487,0.0988926,0.383405,-0.22704,0.121322,-0.0553785,0.377512,-0.379702,-0.200824,-0.480331,-0.204842,0.326855,-0.744481,-0.165672,0.232654,0.0445125,0.0250512,-0.258139,-0.381651,-0.337552,0.344807,-1.14018,0.307053,0.315959,-0.0693445,0.543224,-0.142632,0.25417,0.0120836,0.719843,0.221645,0.373151,0.202182,0.168379,0.20591,0.0976863,-0.142083,-0.739256,0.00652628,-0.308785,0.840921,-0.102313,0.238343,-0.148316,-0.0643403,0.16548,0.156205,-0.285938,-0.268398,0.185545,-0.126704,0.0286126,-0.157525,-0.0420577,-0.292073,-0.0831881,-0.1192,0.884431,-0.649876,0.203263,-0.0145499,-0.0267847,-0.292531,-0.212228,-0.29608,0.0949366,-0.119177,-0.435467,-0.0359908,-0.620775,0.290051,-0.814229,-0.0320748,0.360062,0.550953,-0.0175564,-0.780098,0.0645414,-0.205108,-0.293067,0.166288,0.0156586,-0.537231,-0.0442764,-0.3805,0.986907,-0.0591312,0.24218,0.108374,-0.10878,0.271478,0.112606,-0.637826,0.621907,0.0367182,0.12667,0.110552,-0.0544291,-0.591201,-0.833575,-0.727259,0.205917,-0.452605,0.423309,-0.323511,0.0821864,0.520523,-0.187561,-0.17556,-0.228106,0.112531,-0.502679,-0.275517,0.28941,-0.0930411,-0.297203,0.196174,-0.690827,-0.192763,0.482188,0.168689,-0.110308,0.368919,-0.260021,0.74912,0.16059,-0.0197207,-0.44371,-0.00987738,-0.136522,0.550512,0.102238,0.251211,0.596642,0.131536,-0.239983,0.0748483,0.0961569,0.162828,-0.364342,-0.238284,-0.0341207,0.227382,-0.179468,0.256997,0.197706,-0.315872,0.210799,0.119951,0.104716,-0.267001,0.00420536,0.215956,0.212355,-0.0586515,0.470919,-0.0239766,-0.257307,-0.330494,-0.125152,-0.0515677,0.662375,0.408055,0.397774,-0.291017,0.0399667,-0.0341903,-0.378006,0.0517626,0.106486,0.248317,-0.124845,0.154864,0.0525855,0.054111,-0.0815912,-0.166238,0.239462,-0.49088,0.120083,0.233769,0.34653,0.483497,-0.189433 +3438.63,0.985289,0.0912059,4,1.56017,0.749297,-0.777394,0.216922,0.0994198,0.00203739,-0.0408564,-0.458036,0.208489,0.492937,-0.0131231,-0.19696,-0.264432,0.558537,0.237581,0.37019,0.145204,-0.185046,-0.162218,0.133009,0.232861,-0.356119,-0.810109,0.639784,-0.492985,-0.260538,0.0711457,0.155796,-0.524552,0.571926,0.665916,-0.907692,-0.514369,0.154809,-0.373017,-0.476902,-0.395092,0.78926,-0.328069,0.19501,0.761934,0.897068,-0.0755234,-0.283959,-0.0470071,-0.215299,-0.950788,0.219478,0.580548,0.272365,0.0961625,0.251781,-0.0567422,-0.559639,1.04252,0.0905474,0.499022,-0.0418704,0.385546,-0.196445,0.053455,0.769494,-0.679707,-1.40178,0.211052,0.184534,-0.199087,-0.200839,-0.539931,-0.34633,0.0814809,0.36737,0.553778,-0.3607,0.635843,0.312989,0.130916,-0.105164,-0.390253,-0.0277061,0.282165,0.186114,0.228433,-0.075123,-0.178196,-0.182004,0.203309,0.00779177,-0.152396,-0.29412,-0.136435,0.021795,-0.0546629,0.102452,0.340418,-0.287177,-0.396263,-0.0706929,-0.0708743,0.658956,-0.219554,-0.092612,-0.318528,-0.441572,0.295778,0.128455,-0.271911,-0.0543865,-0.246029,0.551422,-0.0969368,-0.227999,0.296347,0.36695,0.202004,-0.50859,-0.517196,-0.204716,0.164138,0.28667,-0.348576,-0.411538,-0.211629,-0.269559,-0.233966,0.136389,0.205699,0.212962,0.249525,-0.00441159,0.00303141,0.139979,0.0394857,0.571672,0.156154,0.114896,-0.201587,0.0719669,0.470426,-0.414674,-0.399468,0.0101099,0.413477,0.0887109,-0.337992,-0.0106986,-0.0740382,-0.251657,0.172382,0.00737671,-0.269547,-0.166929,0.107419,0.408514,0.160533,0.182546,-0.170321,0.0302192,0.505898,0.0634816,0.176318,0.1509,0.266607,-0.15689,-0.38785,0.235155,0.264124,-0.483701,-0.192775,-0.00145695,0.384986,0.0442759,-0.212202,0.394422,-0.330192,-0.0255425,-0.126109,0.483888,0.227198,0.740027,0.79874,0.212438,-0.281594,0.0126537,-0.0572635,0.180401,0.241233,-0.492555,0.565557,-0.255652,-0.11595,0.164125,0.0270963,0.0698639,-0.112001,-0.171365,-0.134156,-0.274249,-0.621182,0.145734,-0.156384,0.153408,0.128432,0.299151,0.651578,-0.433356,-0.792716,1.00634,0.0909863,-0.0816943,0.345013,0.039357,0.191418,0.160915,-0.261535,0.163515,-0.330786,0.254057,0.385984,-0.481868,0.536596,0.189658,0.353626,0.434952,-0.0926437,0.40649,-0.279336,-0.343744,-0.332888,0.145696,-0.189091,0.0815546,-0.670455,-0.131218,-0.225854,0.32439,-0.0608864,0.171434,0.725798,-0.264339,-0.0250766,-0.294489,0.0656548,0.148549,-0.0402148,0.289688,0.39916,0.0973959,0.325903,-0.565258,-0.349994,0.125138,0.128188,-0.188594,-0.714641,0.202906,-1.03827,-0.548716,-0.328585,-0.171092,-0.021954,0.599916,-0.0505317,-0.107009,0.0487993,0.0731958,0.0213476,-0.126606,0.0052148,0.257059,-0.0802759,-0.0439158,-0.0240067,0.0930291,0.00517042,-0.55323,0.178814,-0.392955,-0.0709924,0.029242,-0.4645,0.48485,0.160512,-0.312793,-0.154721,0.264056,-0.0816057,0.489419,0.195593,-0.143514,-0.240806,0.21551,-0.443979,0.0816215,-0.322807,-0.0537414,-0.218444,0.228053,0.0353891,-0.0524966,0.052856,0.0791791,0.243179,0.281388,0.493132,0.107619 +3411.02,0.716767,0.0912059,4,1.61816,0.917465,-0.707392,0.342272,0.170495,0.00178989,0.00239758,0.486877,0.0310261,-0.403174,-0.0474836,-0.290354,-0.105808,0.401841,-0.371662,0.954748,0.0237721,0.0328869,-0.0417541,-0.00177934,-0.100343,-0.958735,-0.623514,0.520563,0.303698,-0.0635721,0.32368,0.137714,-0.022981,-0.228204,0.613228,0.00696861,0.338548,-0.0638183,-0.293791,0.313932,-1.06563,0.189247,0.669092,-0.47975,0.918503,0.205285,-0.0315533,-1.07879,-0.170726,-0.00210098,-0.403283,0.0956296,0.399246,-0.0258899,0.14201,0.0262598,0.116304,-0.405246,0.651171,-0.181074,-0.373494,-1.13971,0.094642,-0.787838,0.00130459,0.695221,-1.04668,-0.107712,0.291164,0.242479,-0.05384,0.2785,0.747389,-0.0616634,0.106864,0.158804,0.274855,0.562722,0.617391,0.721313,0.719542,-0.0965787,0.0150809,-0.0147625,0.423802,-0.861694,0.0238577,-0.367293,0.0515713,-0.0633853,-0.181385,-0.0263103,-0.125962,-0.00839236,0.335569,0.184728,0.229841,-0.0144328,-0.0960261,0.159373,0.273805,-0.10655,-0.239008,0.0166203,-0.108723,0.768236,-0.528291,0.122466,-0.0250893,-0.672249,0.542289,0.0671613,0.29855,0.550459,0.0476324,0.38781,-0.0110622,0.0867995,-0.257601,0.00815438,0.153309,0.123804,0.735612,-0.0745513,-0.253718,0.559579,0.2247,-0.095053,0.453492,0.34763,0.0978438,0.576151,0.494533,-0.738436,0.598284,-0.311013,0.0383653,0.251333,-0.172705,-0.121305,0.196976,-0.0750124,0.132785,-0.177129,0.0566238,-0.00708713,-0.21814,-0.391703,0.273271,0.199469,-0.202453,0.459962,-0.112557,-0.724828,-0.0853244,0.480046,0.229488,-0.844619,0.662598,0.130711,0.313591,-0.0995066,-0.432984,-0.327421,0.229396,-0.139548,0.673878,0.392777,0.552787,0.0222021,-0.289039,-0.300131,-0.0144277,-0.301014,-0.0604882,-0.224569,-0.0728971,-0.340479,-0.00582251,-0.264665,-0.652538,-0.617468,-0.352215,0.603745,-0.551666,-0.664426,0.349945,-0.0689418,0.026268,-0.270347,-0.27171,0.0605918,-0.0794311,-0.295751,0.045719,-0.211988,0.211168,-0.463708,0.188533,0.782217,0.445829,-0.257898,-0.103967,-0.0483913,-0.00133004,-0.357503,-0.290902,-0.694255,-0.383963,0.236205,0.39829,1.01512,0.0350003,0.238293,0.085589,-0.00248111,-0.0170915,0.520155,-0.0194944,0.0743529,-0.472938,0.21154,-0.0158867,0.0469308,-0.413473,-0.684996,-0.487555,-0.00565916,-0.285057,0.455742,-0.443082,0.318456,0.594059,-0.147128,-0.36331,-0.129305,-0.0901574,-0.228551,0.11045,0.0579956,0.0892028,0.147445,0.310904,-0.124073,-0.525743,0.0669843,0.0758447,-0.155921,0.552647,-0.15339,0.475816,0.351897,-0.526059,-0.433775,0.287301,-0.789991,0.459676,-0.248468,0.0139654,0.245297,-0.232447,0.150603,0.849404,-0.159807,-0.0541489,-0.14239,-0.0481145,-0.284835,0.412021,0.0569283,0.0367065,0.0052675,-0.0199727,-0.0377855,-0.0318788,-0.40459,-0.469628,-0.380681,0.0187303,0.13335,0.0499572,0.313333,0.435109,-0.028668,0.0721745,-0.762033,-0.492603,0.145511,0.20594,-0.286189,-0.122923,-0.146887,-0.322642,-0.208726,-0.35485,-0.450891,-0.190704,0.0122022,-0.257959,-0.189294,0.430386,-0.340045,-0.278495,-0.111487,-0.597587,0.12443,0.177352,0.352747,0.421132,-0.523249 +3403.89,0.992249,0.0912059,4,1.54891,0.919423,-0.952302,0.415872,0.69665,-0.124454,-0.163019,0.153661,0.281496,-0.072006,-0.0201366,-0.294041,0.379385,0.516824,-0.442159,0.612022,0.135634,-0.156691,-0.575684,-0.333103,0.172787,-0.625712,-0.494472,0.124924,0.0614806,-0.0311412,0.386418,0.414959,-0.00823017,-0.0620012,0.814431,-0.0370383,0.271892,0.367047,-0.72012,0.0633731,0.143511,0.883283,0.473498,-0.132125,0.799163,0.464268,-0.13777,-0.416084,-0.8871,-0.155903,-0.335212,0.0804084,-0.0551763,0.114241,-0.125805,0.673382,0.141789,-0.781715,0.554079,0.181008,-0.304052,-0.340412,0.676064,-0.47019,0.25721,1.15238,-0.778856,-0.868571,0.105324,0.299974,0.39007,-0.252388,0.624916,-0.270751,-0.205692,-0.141818,0.66792,0.64428,0.642559,0.558269,0.935854,-0.360316,-0.10321,-0.34436,0.732503,-0.582787,0.195472,-0.0951428,0.160687,-0.270617,0.0757857,-0.223598,0.114884,0.0942858,-0.0852166,0.412022,0.359838,0.114331,-0.764714,-0.15843,-0.081312,0.246294,-0.0370993,0.208524,-0.314494,0.187765,-0.553021,0.130131,0.338204,0.0161921,0.162579,0.145152,0.088791,0.338242,0.0761282,-0.218688,-0.234321,0.091106,-0.563317,0.465494,-0.185075,0.161753,0.528292,0.0696938,-0.734103,-0.0721624,-0.0939121,-0.683797,0.440082,0.0129925,0.83209,0.646946,0.225149,-0.0555312,0.0774126,0.165786,-0.135638,0.555925,0.183888,-0.0377337,0.254189,0.0734663,0.152649,-0.569085,-0.271095,0.164044,-0.0562384,-0.48954,0.428586,-0.0937278,-0.232156,0.198389,-0.286489,-0.154242,-0.659646,0.17657,0.39277,0.000926879,0.914196,-0.385565,0.139298,0.323961,0.0270727,0.0306109,0.722393,0.131741,1.15396,-0.172923,0.134387,0.129258,-0.405019,0.163571,-0.334162,0.439058,-0.0564616,-0.60614,-0.415927,0.326733,-0.011626,-0.255066,-0.420818,-0.387196,0.0953739,0.293471,-0.242978,-0.641173,0.0730887,-0.423238,-0.0774004,-0.835267,0.0253812,0.00580449,0.434232,-0.423648,-0.0365366,0.31116,-0.040633,-0.648202,0.412797,0.38234,0.366536,-0.0285546,0.111152,0.173209,-0.144842,-0.267562,0.0740414,-0.65943,-0.115277,-0.194519,-0.387307,0.971522,0.395277,-0.0498701,-0.0599722,-0.0592798,-0.646041,0.281371,-0.0369859,-0.293422,-0.594883,0.357191,0.553042,0.128337,-0.0838985,-0.0402274,-0.0172579,-0.288961,-0.00493367,0.475911,-0.400652,-0.435268,0.641754,0.170835,0.0308293,-0.278458,0.067363,-0.79617,-0.0806324,0.122972,-0.311708,0.259068,0.477081,0.245112,-0.0153634,0.274628,-0.0545475,0.0110387,0.969774,0.144438,0.33117,0.6116,-0.271331,-0.381938,-0.0630464,-0.253856,0.219012,-0.300155,0.250314,0.37295,-0.729188,0.36799,0.479304,-0.426279,-0.482093,0.238414,-0.036981,0.507796,0.238717,0.606705,0.04877,-0.536065,-0.291913,-0.00275515,0.166159,-0.608186,-0.153535,-0.522136,-0.754931,-0.284977,-0.00833182,0.411224,0.510882,-0.184177,0.151991,-0.0741994,-0.396422,0.221066,-0.068356,0.626095,-0.348514,-0.173157,0.193393,0.263653,-0.126732,0.0748663,-0.182432,-0.00550163,0.126987,-0.255163,-0.595591,0.0846493,-0.157268,0.11479,-0.162109,0.138796,0.211516,0.372554,0.459909,-2.25225 +3435.39,0.620686,0.0912059,4,1.51008,0.880084,-1.28047,0.51143,0.687418,-0.0143172,-0.0610687,-0.0445284,0.573271,0.0268367,0.166133,-0.0500993,0.351495,0.0140405,-0.14013,0.934704,-0.11708,-0.107406,-0.437648,-0.274647,0.00330342,-0.97071,-0.677815,0.360572,0.141039,0.0570044,0.509341,0.749841,-0.227049,0.110428,0.878159,-0.159124,0.0179766,0.283867,-0.383517,0.10017,-0.351427,1.02371,0.638265,-0.251092,0.773143,0.674248,-0.389244,-0.67179,-0.452504,-0.635517,-0.489487,0.0179461,0.108603,0.0965277,0.146243,0.606738,0.255773,-0.500614,0.560666,-0.0824729,-0.0577661,-0.543282,0.306974,-0.223451,0.0126305,0.81588,-0.556771,-0.277854,0.207452,-0.278165,0.296614,-0.0732054,0.110311,-0.455309,-0.190422,0.305048,0.832206,0.273786,0.00120714,0.729778,0.777808,-0.328694,-0.237253,-0.176622,0.772955,-0.861011,0.0918043,-0.199323,0.0259649,-0.373656,-0.111647,-0.559855,0.206188,-0.269707,0.0365696,0.113291,0.129009,-0.168444,-0.769294,-0.500078,-0.207585,0.186899,-0.209536,0.331588,-0.00964204,0.517016,-0.160425,-0.0273049,-0.133134,0.0572883,-0.0423958,0.340473,0.0956539,0.511484,0.091784,-0.0840791,-0.241791,0.0792159,0.0525103,0.177718,-0.25121,-0.000597264,0.470031,-0.11021,-0.763324,0.199603,-0.0334028,-0.6014,0.0843496,0.000406363,-0.21802,0.315824,0.0904189,-0.2269,0.00517893,-0.110743,-0.0906759,0.496746,-0.318307,-0.459347,0.371175,0.00130954,0.172631,-0.370608,0.0922884,0.20895,0.139684,-0.429217,0.305854,-0.119997,-0.0683826,0.412058,-0.167493,-0.311341,-0.329984,0.233356,0.120113,-0.186854,0.592492,-0.00898024,0.628607,0.294407,0.262137,0.007657,0.689448,0.253339,1.26625,0.0809935,0.11316,0.143682,-0.605512,-0.0945461,-0.0319268,0.0182569,-0.220522,-0.464651,-0.179531,0.0314202,0.248556,-0.251634,-0.499392,0.122113,0.0778415,0.489674,-0.156546,-0.489164,0.303405,-0.0377238,0.103843,-1.42063,0.17925,-0.272476,0.611654,-0.36547,0.151485,0.36179,-0.12098,-0.763473,0.436292,0.388855,0.315567,-0.473899,-0.144467,0.267987,-0.0236333,-0.108729,-0.0522358,-0.45874,-0.150321,-0.16963,-0.109132,0.704848,0.204942,0.164769,0.183841,-0.0624395,-0.0191163,0.456933,-0.326958,-0.376178,-0.505735,0.468135,0.390846,0.212497,0.0972258,-0.420848,-0.0796591,-0.055462,-0.0719955,0.692545,-0.393435,-0.527911,0.608804,0.0855833,-0.179215,-0.17352,0.198146,-0.403001,-0.281703,0.173684,-0.381574,0.489782,0.245283,0.0139799,-0.653774,0.295703,0.00522773,-0.125221,0.793152,0.0673912,0.224763,0.186595,-0.329298,-0.492672,0.108243,-0.228509,0.516566,-0.538673,0.159711,0.438459,-0.505181,0.0785076,0.412791,-0.219672,-0.189727,0.422175,-0.0738714,0.477429,-0.141925,0.559631,0.186981,-0.449773,0.103739,0.0881366,-0.00559116,-0.629043,-0.0243367,-0.172016,-0.662941,-0.285895,-0.0677496,0.0872464,0.700113,-0.46726,0.298014,-0.112506,-0.405908,-0.0608872,-0.150964,0.544461,-0.12977,0.040838,-0.0278269,0.26872,-0.273445,0.262845,-0.136566,0.205721,-0.251571,-0.419752,-0.595718,-0.0620135,-0.0840529,0.0852171,-0.337256,0.127723,0.218986,0.357383,0.467959,-2.13661 +3423.86,0.994412,0.0912059,5,1.52588,0.942294,-0.650092,0.124212,0.333827,-0.23593,-0.000652357,0.329653,0.248213,0.508371,-0.108338,0.161541,-0.617571,0.587777,-0.273361,0.552503,0.113063,0.0863975,0.194479,0.330104,-0.460462,-0.696921,-0.368172,-0.0119582,-0.178234,0.0865107,-0.334428,0.140468,-0.512801,-0.071291,0.707162,-0.2956,0.241221,0.169747,0.00873889,-0.0346606,-0.216633,-0.171196,0.150878,-0.533807,1.03963,0.314,0.651437,-0.322121,0.553581,0.714686,0.0324997,0.474391,0.569258,-0.0592378,-0.0223507,-0.0148596,0.685477,0.210654,0.758068,-0.0435315,-0.460922,-0.744764,0.436957,0.10273,0.134866,0.868895,-0.655575,-0.973352,0.0794108,1.01402,-0.298024,-0.115373,0.0160016,-0.340199,-0.238735,0.679074,0.0266119,0.124507,1.00179,0.287681,0.118841,0.135954,-0.313582,0.107367,0.46629,0.404521,0.178784,-0.190389,-0.293739,0.376561,0.0186259,0.238311,-0.0140061,-0.261081,-0.24063,0.121104,0.0659591,0.0604703,0.599045,0.0128538,0.576994,-0.403165,0.804563,0.440828,0.000205535,0.147129,-0.241431,-0.702806,0.342742,-0.820381,0.350322,-0.62277,0.351452,0.775733,-0.520868,-0.626546,0.106642,0.448972,-0.096098,-0.0226541,-0.463279,-0.0704699,-0.248086,-0.368351,-0.723137,-0.0858765,-0.406072,0.328607,-0.0179191,-0.166719,0.593518,-0.158962,0.20205,-0.729868,0.349513,-0.0972234,0.213587,0.429601,0.126173,0.361326,-0.126061,-0.288642,0.473122,-0.140781,-0.744835,-0.231776,0.0543457,-0.78438,0.0803291,0.348994,-0.0129351,0.721585,0.0788247,-0.226464,0.208108,0.146647,0.0924869,-0.0975136,-0.340798,0.862591,-0.355641,-0.0724738,0.0179395,-0.146725,0.0730275,0.089366,-0.0477754,-0.195662,-0.157202,-0.204252,0.580645,-0.0501255,-0.1178,0.054066,-0.143531,0.234503,0.00888569,0.0110698,0.0223914,-0.255976,-0.147487,-0.788649,0.34072,0.774212,0.657431,0.125943,-0.122019,0.249433,-0.365875,0.285577,-0.368414,-0.294627,-0.437889,-0.796895,-0.290397,0.0345601,0.0970831,-0.505129,-0.0763951,0.157389,-0.211758,-0.254414,-0.906373,-0.429047,-0.0642962,-0.471177,0.213524,0.499688,0.0418045,0.0537548,-0.534812,1.0539,-0.403087,0.242813,0.0692907,-0.341257,-0.024646,-0.238326,-0.10039,0.527209,0.0352041,0.0182388,0.0211311,-0.614435,-0.0631911,-0.420813,-0.203803,-0.285616,-0.681879,0.254049,-0.0787703,0.176437,-0.128407,-0.240141,-0.425749,0.197848,-0.574932,0.363993,-0.231649,0.499517,-0.0989969,-0.167914,0.659172,-0.393162,0.427286,0.0442616,0.247155,0.287936,-0.0785662,0.111896,0.469793,0.0805941,0.282697,-0.205629,-0.258704,-0.721257,0.22854,0.327143,-0.610104,0.0778718,-0.0314401,0.266817,-0.403811,0.338989,0.34884,0.313788,-0.0503036,-0.0571255,0.072335,0.108679,-0.0885922,0.36905,-0.266636,0.130968,-0.252869,-0.237585,-0.528491,0.623662,0.6926,0.623904,0.471715,0.053268,-0.331509,0.578848,-0.504996,-0.0750273,-0.331433,0.133864,0.350525,-0.300432,0.0624757,0.616558,0.0286406,-0.826391,0.13921,-0.299927,0.511691,0.113005,-0.174681,-0.221517,0.79781,-0.160051,-0.217109,-0.190574,0.0581618,0.152565,0.18622,0.390595,0.431532,-0.965528 +3435.69,0.78193,0.0912059,4,1.4728,1.01063,-0.416619,0.0674421,0.222192,-0.0877418,-0.32342,0.119421,0.294881,0.536538,-0.0167211,0.257062,-0.59513,0.640087,-0.157884,0.66031,0.208572,-0.233162,-0.227613,0.0840227,-0.346202,-0.66689,-0.345464,0.188791,-0.132328,-0.381732,0.16661,0.352804,-0.292419,0.277914,0.691034,-0.421572,0.174518,0.259999,-0.0164583,0.0342601,-0.696691,0.637553,0.125798,-0.359141,0.69722,0.325406,0.471689,-0.678402,0.303276,0.0724676,-0.748122,-0.00672867,0.518228,0.127038,0.262031,-0.26789,0.50155,-0.271555,0.943192,-0.124371,-0.264142,-0.26286,0.68107,0.061155,0.380205,0.894905,-0.982997,-0.978989,0.739347,0.663799,0.27364,-0.130502,-0.109125,-0.217799,-0.335097,0.881054,0.385534,-0.176698,0.90016,0.3987,0.152828,-0.285909,-0.644275,0.266524,0.458671,0.0226872,0.328449,0.155231,-0.364017,0.104205,0.203859,-0.0992148,-0.284337,-0.391141,-0.471481,-0.656717,0.0756762,-0.177478,0.0575395,0.29869,-0.0785741,-0.297839,0.509273,0.561865,0.108269,-0.163016,-0.181299,-0.413311,0.0866755,0.210161,0.00775036,-0.78701,0.541945,0.51378,-0.5247,-0.517521,0.114306,0.515847,0.0170421,0.296274,-0.0921811,0.0938483,0.265535,-0.602213,-0.843717,0.549339,-0.327758,0.205361,-0.516556,-0.28566,0.461972,-0.507031,-0.146802,-0.3938,0.358023,-0.248677,-0.0109421,0.738056,-0.142195,-0.0625348,0.144314,-0.0669206,0.539336,-0.853279,-0.527682,-0.19178,0.293,-0.954185,0.184434,0.392329,-0.428119,0.164836,-0.299078,-0.0532119,-0.480632,0.0278337,-0.0248752,0.0073641,-0.0584904,0.615975,-0.0480406,0.369038,0.21148,-0.212411,-0.384297,0.127018,-0.0663369,0.107506,-0.0452293,0.130456,-0.0071564,-0.0807871,0.0721569,-0.150363,-0.0466981,-0.114256,-0.159327,0.294556,0.101783,-0.292629,-0.521223,-0.0969769,0.290421,0.746414,0.667194,0.143132,0.0616289,-0.182159,-0.0477042,-0.00877098,-0.219612,0.000695751,0.130281,-0.188231,-0.0763715,0.412034,0.514034,-0.79394,0.137902,0.48441,0.263328,-0.523075,-0.754669,-0.4486,0.117717,0.204794,0.53837,0.420767,-0.197224,0.227578,0.0171645,0.849746,-0.5397,0.314322,-0.0508172,-0.393431,0.157152,-0.169121,0.239394,0.314518,0.0977386,0.116692,0.118133,-0.194096,0.0109037,-0.0819062,-0.278938,0.0573088,0.0455124,0.395221,-0.146327,-0.00485317,0.0809321,-0.168594,-0.503568,0.104575,-0.0803037,0.349946,-0.148562,0.49019,-0.536232,-0.161227,0.745453,0.419967,0.157193,-0.110229,0.589859,-0.400658,0.0199663,0.541627,0.333914,0.369192,0.298201,-0.129941,0.31179,-0.377072,0.613697,0.0780659,-0.462415,-0.271019,-0.178004,-0.272463,0.0336536,0.12719,0.0159447,0.636805,0.473675,0.191457,0.420747,0.431599,0.195149,0.640043,0.224923,0.0212222,-0.0710785,-0.0329465,-0.880422,0.229353,0.0483079,0.0346803,0.527918,0.125598,-0.050934,0.24845,-0.628966,-0.21971,-0.0543594,0.107508,-0.120443,-0.101321,-0.320809,0.414247,0.367114,0.0516452,0.0384073,-0.00301194,0.173292,0.113722,-0.110477,-0.3122,0.397134,-0.255418,0.321978,-0.142387,-0.679494,0.12748,0.197992,0.357043,0.444963,-0.874705 +3424.79,0.666614,0.0912059,4,1.59349,0.830372,-0.970171,0.26622,0.303468,-0.13739,0.0918383,0.444061,0.281704,0.471874,0.013757,-0.158827,0.0177697,0.648022,-0.168865,0.450483,0.113493,-0.138201,0.48135,0.122701,-0.345033,-0.678951,-0.71612,0.306896,-0.605186,-0.176121,-0.0549519,0.197966,-0.375325,-0.109517,0.689994,-0.108815,0.451947,0.0844566,-0.257056,0.426018,-0.333066,-0.639366,0.3048,-0.319064,1.02848,0.470895,-0.133522,-0.677184,-0.0516744,0.334801,-0.738915,0.307043,0.730549,-0.137344,-0.0823319,0.989113,0.238826,0.333531,0.761414,0.0952919,0.0101105,-0.752113,0.368055,0.0876767,0.153901,0.868942,-0.520191,-0.369607,-0.365739,0.152796,-0.461439,-0.308493,-0.199723,-0.438266,-0.471008,0.59037,0.387894,0.125987,0.683995,0.490694,0.77673,-0.263282,-0.315571,0.0785036,0.372206,-0.764862,0.161183,0.392088,-0.125003,0.222984,0.136427,-0.619958,0.268949,-0.308951,0.0237926,-0.275857,0.360361,-0.22538,-0.416155,-0.203369,0.318978,0.260447,0.177842,0.475803,0.0361023,-0.0527204,-0.539084,0.174527,-0.154075,-0.338998,0.575963,-0.43236,0.321243,0.641602,0.0760822,-0.691808,-0.731802,0.411265,-0.359294,-0.0654099,-0.253102,0.165433,-0.374196,-0.359479,-0.406656,-0.463261,-0.252694,0.0570604,0.317159,-0.399118,-0.0263024,-0.366259,0.422441,-0.507889,0.00837027,-0.299983,0.135371,0.736784,-0.286364,-0.274159,-0.191182,-0.253949,0.427814,-0.176577,-0.00396034,0.0458563,0.324904,-0.418806,-0.644734,-0.232304,0.534331,0.0559258,-0.0520468,-0.135552,-0.731353,-0.0074416,0.216937,-0.457343,0.525298,0.995586,0.305113,0.087087,0.0613365,-0.273659,0.279771,0.782329,0.545262,0.538453,-0.110532,0.446235,-0.0306097,0.473839,-0.234924,-0.466432,0.217462,0.228412,0.227592,0.281878,-0.0742461,-0.20735,-0.196986,-0.319917,0.359281,0.852968,0.121997,-0.727175,-0.197492,0.595642,-0.162965,-0.190106,-0.444427,-0.403489,-0.480085,-0.99615,-0.492262,-0.0561861,0.0916113,-0.869267,0.0383623,-0.0795817,0.131319,-0.0287556,-0.755359,0.267387,-0.0860508,-0.0802805,0.374884,-0.740351,-0.0448502,-0.0419536,-0.362541,0.890255,0.516339,-0.371769,0.135164,0.218995,-0.171057,0.148337,0.122909,0.629444,-0.0370015,0.284907,-0.102567,-0.0117782,-0.0573661,-0.645429,-0.121079,0.647611,-0.577706,0.206745,-0.558573,0.0385325,0.173124,0.194137,0.250163,0.18575,-0.31163,-0.702412,0.0205257,0.437707,-0.123249,0.382362,0.401008,-0.812063,-0.189055,0.279653,-0.092013,-0.625762,0.200746,0.242564,0.0160829,-0.213041,-0.00366559,-0.625818,-0.10486,-0.203137,0.17069,-0.224295,-0.66236,0.283105,-0.39203,0.122509,0.621031,0.215095,0.66655,0.351759,-0.357483,0.343319,0.0629386,0.179499,-0.11404,-0.93619,0.0620831,-0.127086,-0.0116136,-0.789289,-0.142865,0.0560116,0.0449722,-0.105445,0.258919,0.682285,0.178882,-0.0611617,0.149274,-0.0961385,0.0488007,0.0418856,0.013598,0.516594,0.738967,-0.0944284,-0.329893,-0.327849,0.144296,0.00631758,0.330968,0.288504,-0.451553,-0.295022,0.0299115,-0.0269643,0.232245,-0.360881,0.072382,0.148929,0.209903,0.385913,0.458152,-0.590398 +3395.32,0.981101,0.0912059,4,1.57531,0.995076,-1.14742,0.362398,0.3251,-0.0729847,-0.150933,0.178291,0.592597,0.174163,0.0441768,-0.109629,-0.72917,0.755195,-0.443883,0.24614,-0.0448791,-0.448107,0.0810623,-0.340574,-0.397308,-1.16116,-1.02396,-0.0602361,-0.698657,-0.60304,0.24635,0.255836,-0.501318,0.0598977,0.537108,-0.582406,-0.367589,-0.100508,-0.333621,0.309249,-0.0327749,0.561822,0.330654,0.0311895,1.04333,0.763263,0.341926,-0.675394,-0.114547,0.227753,-0.0999479,-0.160041,0.480135,-0.123697,0.0696824,0.0208781,0.417127,-0.459705,0.486477,-0.035497,-0.0449065,-0.869812,0.522431,-0.0116598,0.365405,0.837883,-0.711343,-0.233069,0.352393,0.525857,0.479705,0.221812,0.194428,-0.601354,-0.128513,0.273992,-0.00973765,0.410818,0.855877,0.322894,0.649527,-0.404121,-0.272028,0.267799,0.749801,-0.896584,0.231967,0.0771544,-0.507436,-0.0926732,-0.306739,-0.0296654,0.136909,-0.40312,-0.145793,0.301876,0.0365339,-0.173868,-0.240782,-0.717914,0.374199,-0.547488,0.0650258,0.143974,0.320113,0.486632,-0.385021,-0.227889,0.0120762,-0.587724,0.308086,-0.489454,0.149706,0.525929,0.300276,-0.488437,-0.195277,0.422103,-0.0588562,0.301397,0.390633,-0.279513,0.115437,0.149574,-0.633539,-0.19959,-0.66368,0.168612,-0.343181,0.446139,-0.11943,0.543943,-0.262943,-0.0492056,0.473144,-0.413545,-0.264223,1.16753,-0.638243,-0.281777,-0.310958,0.0828842,0.0673804,-0.504976,-0.593502,0.106229,0.252105,-0.517796,0.657749,0.325674,0.0809721,0.421463,-0.20273,-0.139828,0.379468,0.509607,-0.252399,-0.633308,0.230431,0.796228,-0.349709,-0.202431,0.254906,-0.28727,-0.125938,-0.768809,0.827944,-0.082417,0.264091,0.507155,-0.108504,0.166546,0.216522,-0.285112,0.0681441,-0.0875356,-0.241411,-0.573037,-0.103319,0.591201,-0.962039,0.225743,0.178473,0.611149,-0.441801,-0.467187,0.297361,-0.709467,-0.622212,0.00588896,-0.0431326,-0.430735,0.166967,-0.409985,-0.413147,0.621875,0.645864,-1.17715,0.0625295,-0.829527,-0.140991,-0.787293,-0.528338,-0.0866313,-0.0217036,0.256408,0.378134,-0.103655,0.206569,0.286462,-0.866843,1.01787,-0.254257,0.586109,0.140788,0.225461,-0.39632,0.346475,0.146421,0.333904,-0.87399,-0.400111,0.737105,-0.479122,0.194743,-0.755178,-0.223993,-0.290924,-0.293465,0.448355,0.316463,0.229157,0.0732651,-0.0520607,-0.224666,-0.0604445,-0.678062,-0.409265,-0.0369119,0.121576,-0.329979,-0.328877,0.980857,0.10641,-0.40964,0.698586,-0.0793991,-0.36691,0.46887,-0.401737,0.388986,0.369662,0.266086,-0.629632,-0.0871636,0.160407,0.492441,-0.376418,-0.874576,0.51758,0.0974237,-0.446182,0.339577,0.12158,0.443075,0.692204,-0.197013,0.0143389,0.443447,0.228776,-0.000929107,-0.559604,-0.334417,-0.0521402,-0.542959,-0.384709,-0.850921,0.567628,0.203577,0.642321,-0.348971,-0.474289,0.586581,0.382401,-0.351475,-0.815288,-0.529458,0.58608,-0.294703,-0.100815,-0.446033,0.322924,-0.360597,-0.460648,-0.0143433,0.731626,-0.231243,0.232059,-0.0160965,-0.662471,0.0268478,0.117258,-0.637907,-0.465098,-0.188953,0.168274,0.219289,0.410212,0.468283,-0.985769 +3396.9,0.997794,0.0912059,4,1.48704,0.904255,-0.90486,0.179459,-0.396646,-0.168278,0.146303,-0.233256,-0.187291,-0.0931155,-0.259449,-0.557589,0.152854,0.904308,-0.10285,0.491774,0.390624,0.0214719,-0.399567,0.102832,-0.388482,-0.498967,-0.160619,0.361107,0.114846,-0.324054,-0.041044,0.453204,-0.227558,-0.234022,0.68012,0.0152699,-0.13118,-0.116201,0.0460559,0.255055,-0.522843,-0.141027,0.355806,-0.52733,1.43198,0.510442,0.119649,-0.468529,-0.280555,0.0474096,-0.653403,0.358292,0.466795,0.0644406,0.699733,1.06596,0.746073,0.0703387,0.942907,0.114098,0.19625,-0.516184,0.438705,0.414716,0.330004,0.820599,-0.549597,-1.20295,-0.086254,0.211383,-0.118682,0.183332,0.293162,-0.608283,0.365749,0.783077,0.446149,-0.2439,1.06479,0.0989307,-0.0561903,0.55534,-0.157899,-0.391854,0.141101,-0.0174668,0.122438,-0.066301,0.163653,0.0422996,-0.415717,-0.22577,-0.13563,-0.125442,-0.438187,0.349227,0.0945864,-0.118696,-0.04711,-0.175783,0.367507,0.0449357,-0.184705,0.336198,-0.299351,-0.0557757,-0.396021,0.323454,-0.171557,-0.598828,0.729169,0.210996,0.239994,0.607861,-0.365063,-0.632828,0.086322,0.216884,0.184869,-0.687985,-0.497919,0.0639726,-0.0165709,-0.14293,-1.11984,0.0235711,0.0968776,0.226634,0.453033,-0.145684,0.0265931,0.179383,0.410823,-0.606082,-0.282278,-0.509895,0.493861,0.436917,-0.0863959,-0.0208917,0.084345,-0.011504,0.440775,-0.729613,-0.278339,-0.173482,0.159299,-0.271032,-0.759193,-0.579551,-0.12035,0.199794,0.043601,-0.0949854,-1.18391,0.116559,0.00285382,-0.459034,0.0902624,0.569768,0.474626,-0.127848,-0.200596,0.0505722,0.536512,0.240719,0.603215,0.161625,-0.446802,0.378488,0.258775,-0.300901,-0.258263,-0.0902738,-0.445473,-0.670212,0.0721832,0.483574,0.0596213,0.234595,-0.175067,-0.718722,0.315836,1.07277,1.11774,0.322998,0.476269,0.168372,0.58088,-0.193722,0.177648,-0.326043,0.0559622,-0.192516,-0.284722,-0.241732,0.11931,-0.0524019,0.0261636,0.709655,0.272245,-0.134056,-0.661204,0.0704423,-0.200434,-0.468474,-0.0552321,-0.397032,-0.538508,-0.828366,0.27521,0.931385,0.0793491,-0.24064,-0.269532,-0.911868,0.104418,0.151829,0.0733501,0.248596,0.386258,-0.00493185,-0.0123174,-0.447261,-0.179908,0.175409,0.236744,0.709657,-0.243325,0.431061,-0.286343,-0.313968,-0.354402,-0.685566,0.204363,-0.0578058,-0.133551,-0.020442,-0.572984,0.415048,-0.299125,0.140267,0.342717,-0.445032,0.103876,-0.357642,-0.29538,0.269313,0.217996,0.717351,0.130283,0.027135,-0.463546,-0.292457,0.55762,-0.408323,-0.0606293,0.115635,0.140733,0.173681,-0.96132,0.0213113,-0.471067,0.208142,-0.274753,0.434661,0.0276825,0.155585,0.617774,0.114519,0.166447,-0.194016,0.411391,0.190371,-0.251952,-0.194356,0.106116,0.403517,-0.208136,0.106774,0.260459,0.71563,0.57693,-0.0645007,0.71716,-0.027879,-0.209543,-0.0535144,0.38296,0.20856,0.135582,0.105211,-0.268322,0.332275,0.100223,-0.309696,0.0337039,0.358914,-0.231308,-0.351157,0.0722354,-0.161531,-0.15516,-1.01208,0.155277,0.139377,0.2949,0.373333,0.543047,1.55245 +3412.42,0.941233,0.0912059,4,1.49731,0.890032,-1.08246,0.287072,0.460555,-0.18788,0.164139,0.153116,0.171985,-0.1415,0.153786,0.0396128,-0.45595,0.412465,-0.355602,0.72714,0.327555,-0.247429,-0.528375,-0.254619,-0.179191,-0.651084,-1.49561,0.18155,-0.590292,-0.563724,0.127024,0.709951,-0.177045,-0.0588088,0.672264,-0.343467,-0.124988,0.335122,0.0756365,-0.219436,-0.365032,1.01298,-0.1024,-0.00413721,1.32318,0.797201,0.791354,-0.370451,-0.0684133,-0.344096,-0.542747,0.47703,0.528144,0.0413356,0.195241,0.164097,0.866044,-0.679099,0.861714,-0.545054,0.0540036,-0.300986,0.781373,-0.139679,0.539372,1.11348,-0.904105,-0.763416,-0.11953,0.168493,-0.244831,0.0163096,0.491892,-0.568479,0.270793,0.650496,0.301388,-0.242442,0.24117,0.536619,0.47306,0.0824841,-0.178579,-0.0328542,-0.249983,-0.0638969,0.366785,0.00837202,0.234927,-0.0600613,-0.326676,-0.0374985,0.486718,-0.712402,-0.419293,-0.0344505,-0.0532332,-0.444363,-0.0386098,-0.406792,-0.0481664,-0.424399,0.0460035,-0.218358,-0.553949,-0.425129,-0.392476,-0.0461265,0.0228748,-0.602793,0.301005,-0.212133,0.0390676,0.385588,-0.233097,-0.650761,0.884702,0.491503,0.477648,0.106502,-0.430987,-0.347064,0.367702,-0.0309142,-1.27729,0.0783554,-0.134253,0.330002,-0.362494,0.374239,-0.0180382,-0.0598328,-0.127582,-0.768624,-0.0335479,0.0211882,0.274845,0.776583,-0.436534,0.0100246,0.334687,0.071815,0.384503,-0.523114,-0.274909,-0.0656337,-0.0945653,-0.481284,0.588451,-0.0116081,-0.32113,0.474017,-0.229238,0.767583,-0.035304,-0.154089,0.0419917,-0.000526457,0.850749,0.621156,-0.0189264,0.370703,-0.214461,0.37879,0.466084,-0.363411,0.943311,0.339835,0.388794,0.150552,0.25196,-0.269428,-0.222748,-0.494158,-0.191511,-0.110685,-0.185357,-0.0379651,-0.273045,-0.425647,-0.258124,-0.0921908,-0.322908,0.774156,0.513534,-0.069851,0.199955,-0.21742,0.292064,-0.359338,0.269797,-0.286473,0.635947,-0.730283,-0.338828,0.0645859,-0.267445,-0.93183,-0.0487659,0.331105,-0.0221624,-0.477996,-0.214607,0.444837,-0.0971069,0.332967,-0.328613,-0.125918,-0.49932,-0.403357,-0.406352,1.02524,0.140335,0.192755,-0.322505,0.0431215,0.873185,0.38223,0.104263,0.487033,-0.12639,-0.20675,0.30369,-0.222873,-0.028973,-0.789862,0.0269052,0.0949092,-0.109293,0.53315,0.112997,-0.559189,0.0609778,-0.518258,0.256863,0.109006,0.233721,0.194558,0.111809,0.354693,0.361242,0.349916,0.529476,-0.0714261,-0.059618,0.773045,0.350215,0.0293379,0.734476,0.237991,0.502186,0.00419947,-0.134002,-0.745864,-0.336479,-0.395179,0.12204,-0.676526,-0.463287,0.603724,-0.277138,-0.103591,0.0529338,0.284977,0.761355,0.62713,0.0966149,-0.0751988,0.302799,0.60753,-0.0860152,0.355111,0.796806,0.420878,-0.392328,0.311943,0.0929592,0.293513,0.15881,-0.167338,-0.0864316,0.556999,0.139543,0.102453,-0.0843848,-0.198519,-0.548739,-0.235391,0.170088,-0.0396419,-0.0693682,0.767636,-0.0699483,-0.927968,0.0741504,0.249223,0.00232935,0.418402,-0.190716,-0.59806,-0.288916,0.391544,0.166023,0.537162,0.754772,0.160655,0.246968,0.400818,0.496958,-1.2617 +3432.78,0.932117,0.0912059,4,1.43639,0.877471,-1.11111,0.326039,0.115433,-0.156345,0.155814,-0.00788608,-0.161519,-0.338149,0.128873,-0.383183,0.356027,0.549641,0.0621277,0.791048,0.222541,0.113735,-0.0845629,0.225235,-0.206103,-0.701395,-0.452463,0.152063,-0.0628657,-0.155977,-0.138413,0.37252,0.105675,-0.418843,0.998591,-0.556267,-0.0505078,0.451493,0.250348,-0.688182,-0.359556,0.385687,0.432071,-0.307466,1.40244,0.704261,0.120032,-0.288258,0.13142,0.31505,-0.692936,0.442001,0.463078,0.441257,0.633131,0.794042,0.398941,0.2495,0.8188,0.0752888,0.0160281,-0.489917,0.685678,0.468822,0.0962045,1.19306,-0.563692,-1.0533,0.263231,0.0775572,0.146318,0.251436,0.524461,-0.465902,0.422723,0.479401,0.490593,0.0483333,0.49882,0.326523,0.390541,-0.215446,-0.322403,0.0426803,0.301543,-0.575259,0.263149,-0.293721,-0.207774,-0.0725833,0.139862,-0.305357,0.399817,-0.149619,0.0648255,-0.0324889,-0.263089,-0.41352,0.739063,-0.189286,0.0855382,0.0683335,0.0408557,-0.0630873,0.107306,-0.347745,-1.03949,-0.383307,-0.731612,-0.336886,0.237221,-0.15902,0.295667,0.480594,-0.727781,-0.672099,0.947744,0.248844,0.219033,0.209941,-0.0409381,-0.0158961,0.106323,-0.0602395,-0.624832,0.277215,0.167061,0.242851,0.000352829,-0.0277636,0.379578,0.432415,0.034595,-0.747023,0.00341194,-0.308062,0.619902,0.638898,-0.110563,-0.160845,-0.417157,-0.131148,0.268336,-0.380642,0.0732959,0.201058,0.269909,0.0691636,0.0437952,0.179661,-0.585398,0.628676,-0.161967,-0.129917,-0.226509,-0.0795304,0.0260832,0.372303,0.854256,0.449001,-0.0280627,-0.0078161,-0.00126415,-0.288452,0.348936,-0.258695,0.698137,0.245006,0.727991,-0.452332,0.0971094,-0.263071,-0.233761,-0.505975,-0.0806878,-0.160049,-0.0708099,-0.174,0.0673569,-0.0983735,-0.0885449,-0.115588,0.0455674,0.411142,-0.05076,-0.30029,0.35483,-0.00137571,0.41027,-0.251148,-0.106625,-0.49462,-0.0237918,-1.00135,0.297777,0.112832,0.204277,-0.476095,-0.344873,0.185485,-0.157228,-0.124957,-0.145857,0.626725,0.13368,0.0810621,-0.19703,0.296199,-0.351554,0.0670048,-0.181953,0.654514,0.481205,0.0698509,-0.00499926,-0.653188,0.725223,0.161538,-0.186089,0.391396,-0.543009,0.35742,0.0652249,-0.398029,0.272185,-0.596865,-0.178443,0.381776,0.0508628,0.613767,-0.207259,-0.596282,-0.532983,-0.0218679,0.815336,-0.0319707,0.499729,-0.373576,-0.0471841,-0.120276,-0.432293,-0.2057,0.507853,0.397902,-0.289957,0.145002,0.117814,0.360914,0.495275,0.0073206,0.222967,0.501338,-0.283552,-0.360274,0.445217,-0.377448,0.290467,-0.218735,-0.116391,0.159083,-0.193578,0.235682,0.15708,0.200769,0.133175,0.49765,-0.163978,-0.346733,0.299624,0.113685,-0.0662342,-0.0271143,0.595609,-0.405954,-0.799615,0.00514769,-0.121139,0.0137802,-0.0634306,-0.197722,-0.0572643,0.0819171,0.594894,-0.175889,0.0642488,0.0132783,-0.384145,0.176215,0.0378518,0.385153,-0.225193,0.496172,0.128427,0.427797,0.152034,0.109645,-0.0790826,0.140597,-0.751882,-0.6637,-0.516807,-0.105826,-0.0931013,0.260921,-0.0928961,0.131298,0.255685,0.362351,0.505653,-0.184476 +3399.72,0.928808,0.0912059,4,1.49948,0.937563,-0.912495,0.170679,0.162816,-0.167244,0.0082111,0.176685,-0.323323,-0.399772,0.0209461,-0.219757,-0.0866899,0.384251,-0.353869,0.80422,0.0868384,-0.0503928,0.246683,0.018841,-0.541265,-0.507299,-0.437663,-0.0403648,-0.177961,0.0192191,0.184069,0.315545,0.436758,-0.0794015,0.75773,-0.56901,-0.403576,0.410447,0.0398221,-0.215444,-0.343098,0.581142,0.313636,-0.167998,1.197,0.692491,0.333891,-0.536864,0.162053,-0.054141,-0.852275,0.245112,0.583415,0.438109,0.593529,0.561942,0.390317,-0.424647,0.967703,-0.485483,0.184995,-0.0645171,0.752654,0.578175,0.421601,1.42977,-0.802122,-1.54635,0.0641499,0.798761,-0.0453037,-0.244648,0.393168,-0.359954,0.519165,0.546966,0.440823,-0.0921086,0.359185,0.505223,-0.221699,-0.553755,-0.38363,-0.0809575,0.32301,-0.318549,0.0598944,-0.292383,-0.00586875,-0.302767,0.138439,-0.816366,-0.0503912,-0.398105,0.0437176,-0.0410281,-0.262948,0.160653,0.871907,-0.747408,0.272585,0.368514,0.172355,-0.0898856,0.142827,-0.447431,-0.744846,-0.511967,-0.623882,0.0650062,-0.220149,-0.380345,-0.0928613,0.140989,-0.579869,-0.35171,0.41873,0.283748,0.0504519,0.267196,-0.162658,0.154353,-0.0489319,0.122297,-0.941065,0.0997429,-0.145665,-0.00841799,-0.295009,-0.308001,0.329953,0.42638,-0.318039,-0.602483,-0.281916,0.175752,0.524976,0.585154,-0.223225,-0.12605,-0.356547,-0.0249763,0.413301,-0.452126,-0.715906,-0.197599,0.540165,0.135285,-0.304446,0.392509,-0.534503,0.958305,-0.11893,-0.529414,-0.180242,-0.191751,0.0444401,0.199041,0.826325,0.526338,-0.444669,-0.320885,0.158557,-0.250331,0.538424,0.186727,0.655446,-0.00990954,0.461075,-0.606904,0.3923,-0.649694,-0.139151,-0.129761,0.199275,-0.0353928,0.014651,-0.187833,-0.0433698,-0.29245,0.0978482,-0.0845434,0.339295,0.229164,0.104246,-0.57092,0.653622,-0.0130674,0.459346,0.114453,-0.388359,-0.580725,0.01478,-0.570848,-0.19694,-0.176888,-0.180379,-0.370033,-0.233142,0.364045,0.00962762,-0.0106329,-0.206146,0.616344,0.0211363,0.18605,-0.233478,0.365142,-0.63836,-0.585255,-0.583122,0.448821,0.382591,-0.11728,-0.309102,-0.188089,0.320812,0.341603,0.321936,0.684795,-0.500012,0.291094,0.0339145,-0.609287,0.12816,-0.356285,0.126497,0.361819,-0.0787355,0.185686,-0.310809,-0.264958,-0.81641,0.0341461,0.253398,-0.00709281,-0.0788802,-0.773348,-0.0436634,0.125047,-0.366347,-0.169413,0.344594,0.542226,-0.0721753,-0.223099,-0.320701,-0.0239073,1.0435,0.000441239,0.140906,-0.226549,-0.48219,-0.533708,0.0686887,-0.657743,0.309102,-0.0815874,-0.239452,-0.0799748,-0.145593,0.103663,0.32322,0.364765,0.0852549,0.308768,-0.00756166,-0.19541,0.261572,0.442032,-0.0485702,-0.218692,0.533,-0.462739,-0.482649,-0.240408,-0.140252,0.0307939,0.412052,0.00390152,-0.167092,0.0488984,0.663585,0.094104,-0.178598,-0.568823,-0.0807719,0.0754568,0.710779,0.322508,-0.0331532,0.237589,-0.241309,0.270107,-0.0836865,0.31417,0.0622622,-0.394595,-0.786406,-0.970793,0.153924,0.14143,-0.187566,-0.187309,-0.310639,0.138876,0.26708,0.372661,0.516798,-0.339209 +3418.7,0.851135,0.0912059,5,1.48206,0.98435,-1.07657,0.326253,0.607031,-0.153738,-0.510345,0.1392,-0.501867,-0.0801059,0.220574,-0.288477,-0.199486,0.212639,-0.484407,0.70543,0.134029,-0.00813712,0.304806,0.0872062,-0.381518,-0.516007,-0.520716,-0.0422944,0.0504699,-0.203794,0.317201,0.0707507,0.268417,0.105017,0.815628,-0.343235,0.232184,0.384782,0.0204774,-0.160273,-0.677805,0.761616,0.389309,-0.230172,1.15768,0.743913,0.66096,-0.631597,0.126605,-0.215338,-1.16185,0.317476,0.259506,0.409879,0.284854,0.789674,0.462667,-0.388257,0.782214,0.00153353,0.110954,0.218382,0.685964,0.250891,0.477639,1.10092,-1.06066,-0.809985,0.303508,0.636071,0.210074,-0.105634,0.265085,-0.615096,0.0553188,0.819224,0.41425,-0.319848,0.291972,0.305833,-0.0256311,-0.371916,-0.356272,0.0019599,0.454377,-0.481847,0.0272539,-0.416279,0.173354,-0.371564,0.0943541,-0.650867,-0.247913,-0.640828,0.101784,-0.191,-0.151026,0.0604357,0.56401,-0.661859,-0.243861,0.048705,-0.196143,-0.101171,-0.132253,-0.44256,-0.714535,-0.453767,-0.508725,-0.224993,0.155967,-0.0652099,-0.0355989,0.0950865,-0.0524119,-0.132955,0.44288,0.207556,0.128642,-0.0326835,-0.145562,0.102978,0.102018,0.120136,-0.933741,0.0623181,-0.146431,-0.111295,-0.0782745,-0.511714,0.402985,0.257261,-0.135452,-0.457793,-0.223083,0.485097,0.361568,0.326592,0.22862,-0.24924,-0.0751778,-0.0252667,0.651326,-0.253955,-0.485436,0.0417057,0.253778,0.18959,-0.515567,0.281157,-0.710243,1.00396,-0.147947,-0.383229,-0.36845,-0.0615128,-0.285292,0.464999,0.818174,0.123329,-0.157547,-0.291548,0.027803,-0.242128,0.282654,-0.291448,0.778756,-0.0868603,0.295431,-0.326797,0.147263,-0.624261,-0.223171,-0.0104053,-0.0496147,0.298346,-0.214391,0.169081,-0.0178165,-0.704564,-0.179771,-0.137239,0.0318085,0.322498,0.215271,-0.452011,0.518746,0.0548307,0.583739,0.198822,-0.371426,-0.301336,0.00261454,-0.308515,-0.0494659,-0.182679,-0.0326223,-0.560732,-0.322227,0.203908,-0.0413518,-0.182754,-0.0944054,0.261693,-0.0689589,0.292547,-0.238171,0.0295032,-0.0777682,-0.599554,-0.825304,0.767701,0.193688,0.337042,-0.202,-0.337304,0.00195246,0.253059,0.171508,0.567606,-0.78752,0.385619,-0.0556362,-0.679664,0.164112,-0.435081,-0.424171,0.287328,-0.5669,0.32497,-0.619745,-0.176125,-1.02046,0.110439,0.187124,-0.0124331,-0.150922,-0.802141,-0.11568,0.35449,-0.0344364,-0.0961892,0.420751,0.174332,-0.0187268,0.14368,-0.253965,0.278843,0.825126,0.179498,0.00203146,0.108371,-0.329096,-0.488912,0.207826,-0.391591,0.194837,-0.501453,0.227396,0.0290021,-0.133759,0.342904,0.0921181,0.209341,0.0794583,0.489688,-0.209539,0.277298,0.260016,0.119017,-0.01431,-0.256481,0.301686,-0.728168,-0.310255,-0.323897,-0.533644,0.101806,0.0590556,-0.12568,-0.139228,0.126907,0.968983,-0.161771,-0.0511477,-0.456402,-0.0212613,0.312623,0.277986,-0.0133186,-0.075261,0.330114,-0.146186,-0.067717,-0.0918713,-0.115512,-0.00190163,-0.365745,-0.361059,-0.738771,0.190245,0.281191,-0.29638,0.148801,-0.456304,0.141696,0.26035,0.376426,0.510245,-1.97876 +3429.7,0.719936,0.0912059,4,1.5596,0.824592,-1.22785,0.427423,0.323627,-0.204903,-0.0351537,0.0641038,-0.101951,0.216131,0.170531,-0.27331,0.230633,0.443542,-0.395887,0.757503,0.162044,0.446291,-0.453937,0.0476416,-0.254804,-1.26448,-0.0668066,0.328427,-0.214495,-0.14851,0.27187,0.0893523,-0.354143,-0.306486,0.746153,-0.638143,0.202419,0.6165,-0.14878,-0.263031,-0.52657,0.375507,0.193434,0.0742223,1.33927,0.79765,0.160447,-0.269532,0.267746,-0.300389,-0.917924,0.148284,0.0930473,0.175665,0.42838,0.694073,0.0350016,-0.183005,0.613036,-0.205795,0.0394734,-0.854614,0.401721,-0.113483,0.524435,1.28049,-0.83001,-0.822251,0.459252,0.472125,0.0429625,-0.187007,-0.00874461,-0.559874,0.063578,0.305883,0.288331,-0.0415755,0.207123,0.347029,-0.0673484,-0.389321,-0.286774,0.0158132,0.23654,-0.226967,0.121808,-0.314155,0.0567398,-0.00608126,0.691298,-0.853853,0.199246,-0.407815,0.136927,-0.317489,-0.0517884,-0.0196167,0.447979,-0.44302,-0.0276582,0.150995,-0.324603,-0.0975359,0.238695,-0.288246,-0.837784,-0.294697,-0.090257,-0.354859,0.122626,-0.0391534,0.171825,0.127957,0.0833264,-0.132124,0.386511,0.302779,0.0918706,-0.361655,-0.615564,-0.0780676,-0.0850837,-0.24387,-1.1517,-0.128256,0.0170792,-0.497882,0.247076,-0.629219,0.735882,-0.151864,-0.00581147,-0.409578,-0.612889,0.0240468,0.162743,0.288982,0.0486945,-0.279198,0.0416595,-0.336524,0.166153,-0.573059,-0.313793,-0.32728,-0.464874,0.191864,-0.201484,0.2487,-0.0963429,0.282893,0.119674,-0.446106,-0.174284,-0.126712,0.105845,0.559401,0.0948999,-0.0521639,-0.0538272,-0.186385,-0.0701973,-0.38354,0.592112,-0.0728269,0.182852,0.251147,0.534083,0.122057,0.55118,-0.335108,-0.446744,-0.443865,0.106135,0.445563,-0.123194,-0.472591,0.0289795,-0.834339,-0.286178,-0.366836,-0.17588,0.602028,0.310596,-0.0402264,0.165489,0.452983,0.127332,0.272298,-0.0391928,-0.682395,0.214879,0.0713345,0.04196,0.261785,-0.0242936,-0.529178,-0.383564,0.350655,-0.236095,-0.396145,0.256214,-0.18916,-0.175705,-0.2109,-0.0449565,0.15759,-0.312698,-0.13396,-0.696639,0.841002,0.574964,0.506526,-0.394998,-0.119956,0.372657,0.361199,-0.0451926,0.825379,-0.420634,-0.124357,-0.132328,-0.650444,-0.100021,-0.546458,-0.270102,0.546958,-0.231113,0.671619,-0.241045,-0.499398,-0.850485,0.0132509,-0.0336451,0.0434692,-0.389699,0.0555898,-0.143587,0.124441,0.366665,0.00882254,0.261233,-0.219513,0.239615,0.40515,-0.49576,-0.134785,0.24901,0.22131,0.246991,-0.207224,0.0544677,-0.075627,0.330319,-0.398047,0.103322,-0.345875,-0.214803,0.297344,-0.17825,-0.152848,0.428516,0.15804,0.1702,0.0255514,0.293421,-0.347326,0.360082,0.0760501,-0.36039,-0.358435,0.283127,-0.557896,-0.34113,-0.0374483,-0.72581,-0.0478366,-0.008981,0.257438,-0.0848193,-0.226504,0.974148,-0.315474,-0.0675625,-0.308913,0.0224811,0.570437,0.16778,-0.00762271,0.192862,0.700796,0.150802,-0.163213,-0.14308,0.0945479,0.037641,0.259839,-0.43597,-0.680057,0.0834148,0.124446,0.0274751,-0.477976,0.102487,0.116715,0.189824,0.341636,0.435688,-0.681606 +3416.33,0.762884,0.0912059,4,1.53787,0.896636,-1.11536,0.438789,0.286698,-0.201515,-0.215904,-0.236657,-0.131195,0.211094,0.189645,-0.278886,0.185024,0.487114,-0.339717,0.932485,0.277433,0.331054,-0.492815,0.196836,-0.289554,-1.02323,0.0782317,0.406567,-0.384781,-0.133808,0.21167,0.188474,-0.519272,-0.197406,0.851295,-0.72073,0.268498,0.65985,-0.266697,-0.27971,-0.557514,0.307969,0.203022,0.147709,1.15934,0.765145,0.411362,-0.382905,0.320591,-0.280538,-0.827621,0.030076,0.108522,0.0320998,0.392227,0.691349,0.103133,-0.552717,0.540331,-0.411229,-0.0471369,-0.882525,0.481855,-0.00671838,0.295045,1.31467,-0.866853,-0.896391,0.323164,0.48124,0.201754,-0.0711967,0.345366,-0.705053,0.117167,0.242982,0.177193,-0.0501488,0.153961,0.352769,0.000270036,-0.368927,-0.3171,0.0427607,0.26847,-0.423736,0.166526,-0.428057,-0.145295,-0.0487477,0.578954,-0.76957,0.039503,-0.365896,0.298277,-0.366443,-0.0474321,-0.105685,0.233576,-0.627147,-0.0173864,0.273753,-0.21871,-0.129846,0.360181,-0.264526,-0.708479,-0.429388,0.259998,-0.427949,0.0832065,-0.0961113,0.0247937,0.174287,-0.160835,-0.176981,0.395886,0.441067,0.0298738,-0.278128,-0.748922,-0.12793,-0.0400194,-0.252577,-1.26979,-0.129218,-0.160463,-0.433922,0.0838122,-0.66166,0.653969,-0.230242,0.0626369,-0.346106,-0.571497,0.0994424,0.0484368,0.0764303,0.1351,0.0315269,0.339623,-0.373644,0.278021,-0.560366,-0.504472,-0.156903,-0.506813,0.103417,-0.382474,0.225515,-0.135547,0.545557,-0.0557187,-0.773901,-0.0800997,-0.0726644,-0.188059,0.747555,0.170937,0.102638,0.0357713,0.0298947,-0.0593418,-0.337077,0.864217,-0.0261011,0.0868072,0.307549,0.393344,0.0666549,0.490243,-0.078569,-0.430993,-0.342919,0.223481,0.491288,-0.149862,-0.375417,0.0636511,-0.801642,-0.448395,-0.0984631,-0.314981,0.618822,0.24054,-0.115846,-0.068135,0.300965,0.19228,0.440001,-0.0485959,-0.739333,-0.0101808,0.206614,0.0994216,0.34208,0.0869521,-0.552334,-0.196531,0.206355,-0.451858,-0.453334,0.277442,-0.0745211,-0.161369,-0.0431433,0.167989,-0.208329,-0.371574,0.115526,-0.692267,0.941863,0.563386,0.293977,-0.333898,-0.117056,0.383907,0.519872,-0.0859999,0.802789,-0.429804,-0.0115835,0.0742478,-0.887644,-0.127023,-0.459027,-0.202711,0.574498,-0.0451652,0.74818,-0.238644,-0.62614,-0.483501,-0.0475154,-0.000128456,-0.00785227,-0.440934,-0.0497328,-0.363108,0.114005,0.200939,0.192219,0.228995,-0.425804,0.222738,0.171892,-0.677681,-0.140949,0.326228,0.170095,0.324911,-0.0632078,-0.158627,-0.303916,0.464291,-0.417815,0.114213,-0.340948,-0.173936,0.270539,-0.167382,0.0785476,0.237981,0.24842,0.421112,-0.00226225,0.216542,-0.301543,0.146502,0.0289409,-0.333761,-0.197165,0.43166,-0.686417,-0.582211,-0.0376555,-0.527569,-0.12615,0.135449,0.120901,-0.00826853,-0.0772997,0.863362,-0.110075,-0.0156776,-0.436261,-0.0144556,0.409029,0.290365,-0.18993,-0.170175,0.73791,0.162135,-0.148393,-0.18755,0.217917,0.101876,0.434238,-0.35819,-0.682435,0.437048,0.151171,0.101444,-0.479012,0.032902,0.115584,0.188072,0.339976,0.433672,-0.77884 +3420.28,0.879576,0.0912059,5,1.64044,0.815774,-1.29531,0.473537,0.250844,-0.0914473,-0.230154,-0.198243,-0.0722447,-0.253755,-0.0623876,-0.573046,0.14025,0.735322,-0.244226,0.722585,0.1241,0.153448,-0.430939,-0.074595,0.0891202,-0.970695,-0.2013,0.230676,-0.0804589,-0.0946575,0.194148,-0.0318928,-0.605702,-0.268404,0.756483,-0.760599,0.130566,0.638559,-0.287023,-0.521832,-0.372652,0.289937,0.155838,0.178878,1.22731,0.616392,0.286564,-0.665345,0.073651,-0.203705,-0.779452,-0.320774,-0.0606169,0.392677,0.228335,0.807857,0.0262567,-0.492071,0.581661,-0.366299,-0.131499,-0.838004,0.642854,-0.294645,0.599808,0.948633,-0.222438,-0.60387,0.115264,0.272587,0.271062,-0.460425,0.415845,-0.221802,0.0230837,0.362955,0.149585,0.286771,0.509552,0.281618,-0.2876,-0.187423,-0.145989,-0.203412,0.239441,0.0455587,-0.0385641,-0.344426,-0.493876,-0.3198,0.0380879,-0.622001,0.273453,-0.567813,-0.12674,-0.290757,-0.542427,-0.0311045,-0.0451072,-0.15125,0.544836,0.0141042,-0.309209,0.151793,0.539027,-0.348674,-0.462369,-0.700094,0.321639,-0.0102441,0.577236,0.141291,0.227986,0.601245,-0.44505,-0.405795,-0.317702,0.215451,0.0390091,-0.113362,-0.61791,-0.179016,-0.268717,-0.283466,-0.724488,-0.686024,0.192346,0.110392,0.132107,-0.497317,0.766896,-0.439764,0.00269991,-0.120452,-0.186988,0.0331504,0.121726,0.534027,-0.238951,-0.242043,0.168594,-0.465017,0.0318274,-0.285372,-0.569372,-0.257409,-0.453488,-0.189587,-0.292529,0.492817,-0.0986426,0.387386,-0.273253,-0.713547,0.0787224,-0.220882,-0.343021,0.566671,0.354059,0.445555,0.361555,-0.438539,0.0104183,-0.158874,0.319241,0.092631,0.0881065,0.582545,-0.246058,0.244256,0.391845,-0.375934,-0.678394,-0.82731,0.0163548,0.0860121,-0.0667546,-0.855369,-0.0402702,-0.546187,-0.290439,0.401707,-0.0654103,0.68927,0.0808076,-0.125673,0.264645,0.321418,0.0602514,-0.151837,-0.168501,-0.240865,-0.0109376,-0.370628,-0.148659,0.332113,0.174594,-0.579832,-0.581833,0.52548,-0.405777,-0.149343,-0.309957,-0.180975,-0.137446,-0.208802,0.316443,-0.331556,-0.315824,0.0148598,-0.279793,0.932524,0.514097,0.0143015,-0.406188,-0.254672,0.112183,0.603343,-0.103438,0.312417,-0.108268,-0.0172425,-0.119411,-0.6981,-0.266939,-0.315833,0.275333,0.384603,0.0962819,0.826424,-0.115741,-0.914709,-0.193793,-0.209611,-0.066932,-0.0377004,-0.666439,-0.211511,-0.138174,0.264857,-0.0157845,0.385485,0.202143,-0.566102,0.304475,-0.0944595,-0.329982,-0.314645,0.177728,0.181613,0.131105,0.184481,-0.197438,-0.312999,0.356297,-0.504994,0.333257,-0.105899,-0.342124,0.559325,-0.357024,-0.110109,0.0233619,0.0948702,0.411818,0.0787775,-0.270696,-0.121434,0.11104,0.377622,-0.138691,0.0664362,0.179153,-0.649344,-0.580917,0.228054,-0.10689,-0.0930709,-0.114841,-0.329917,0.0539901,0.209681,0.747061,-0.152741,-0.172148,-0.14241,0.40598,0.931871,0.260054,0.26769,0.0917032,0.98886,0.334838,-0.454753,0.17405,0.0730006,0.353533,-0.0621044,-0.320496,-0.479825,-0.0361508,0.126992,-0.267626,-0.2188,0.154237,0.156638,0.313665,0.395776,0.560058,-0.380206 +3391.31,0.98106,0.0912059,4,1.56131,0.877092,-1.15245,0.370529,0.497123,-0.245706,-0.223358,-0.588685,-0.657211,0.0716517,0.357407,-0.561168,0.0680706,0.404211,-0.261275,0.724342,0.213627,-0.094693,-0.520922,-0.0576736,-0.0883485,-0.621438,-0.474594,0.445742,-0.102683,0.183477,0.491532,-0.137769,-0.78204,-0.117756,0.735736,-0.437154,-0.250387,0.560378,0.00130636,-0.624875,-0.123729,0.514359,0.198926,-0.320248,0.791278,0.587554,0.173121,-0.524347,-0.0108558,-0.249037,-0.663638,-0.473668,-0.0132329,0.344979,0.360258,0.799161,0.162168,-0.313694,0.661471,-0.488985,0.104138,-0.454323,0.61343,-0.115473,0.313462,1.17911,-0.443744,-0.419703,0.305234,0.51805,0.325805,-0.430334,0.671409,-0.466298,-0.196529,0.423583,0.218492,0.076223,0.238468,-0.209409,-0.213839,-0.0827379,-0.352516,-0.337246,0.0539241,-0.113767,-0.320681,-0.225001,-0.408885,-0.119552,0.265914,-0.446758,0.401025,-0.16456,0.334001,-0.273234,-0.639561,0.0752219,-0.126506,-0.46727,0.204356,-0.266025,-0.817254,-0.0308267,0.0575168,-0.371798,-0.385245,-0.599822,0.225797,-0.27783,0.388112,0.282673,0.242649,0.710773,0.31222,-0.257574,-0.526259,0.362604,0.327662,-0.33141,-0.560748,-0.538959,-0.154082,-0.484414,-1.16612,-0.411266,0.0303348,0.184119,0.0460334,-0.158079,0.776445,0.187636,0.0508274,-0.114324,-0.623226,-0.28405,-0.161191,0.430382,-0.374311,0.161102,0.35689,-0.587868,-0.0799939,-0.487514,-0.752517,-0.153964,-0.78133,-0.801013,0.0161454,0.328494,-0.031032,0.562759,-0.187383,-1.19394,-0.355447,-0.092574,-0.380378,0.18166,0.0045199,0.104055,0.33473,0.187155,0.363735,0.356189,0.05645,-0.269074,0.477164,0.959807,-0.564727,0.22714,0.432343,-0.434541,-0.593944,-0.452558,-0.0716972,0.0592423,-0.0816647,-0.931247,-0.193283,-0.335099,-0.34673,-0.00316471,0.1851,0.68741,-0.289238,-0.296611,0.50743,0.628523,-0.198668,0.0136851,-0.313708,-0.22158,0.321095,-0.16943,-0.158182,0.0123448,0.112552,-0.0824278,-0.65827,0.581816,-0.257213,-0.252997,-0.54981,0.146049,-0.239251,-0.60076,0.332023,-0.431056,0.0402309,-0.265232,-0.136633,0.973503,0.0885566,0.107295,-0.273001,-0.378527,0.0830462,0.625792,-0.0286422,0.634803,-0.041682,0.209222,-0.207447,-0.399377,-0.267839,0.00177881,0.111161,0.361114,-0.102396,0.925208,-0.219714,-0.649605,-0.0343881,0.152195,-0.385851,-0.136618,-0.521314,-0.207424,-0.40493,0.198763,0.0358608,0.329154,0.521434,-0.894509,0.229365,0.263732,-0.524398,-0.654675,0.175218,-0.0956443,0.0633408,0.107763,-0.21661,-0.118824,0.227378,-0.443003,0.538381,-0.240521,-0.234701,0.419994,-0.171893,0.271144,-0.37389,0.0547676,0.23772,0.614127,-0.466497,0.231507,0.178623,0.0798469,-0.0366917,0.179653,-0.560807,-0.53314,-0.69186,-0.168827,-0.538499,-0.100092,-0.207095,-0.23958,0.431442,0.479283,0.756464,0.108538,-0.254155,-0.289768,0.179179,0.694208,0.25195,0.231455,0.0174301,0.331771,0.320423,-0.17113,-0.0116838,0.472665,0.407012,0.113528,-0.142069,-0.402211,0.0397808,-0.0111731,-0.753734,-0.276332,0.35048,0.13582,0.248979,0.368537,0.498978,-1.32414 +3391.06,0.998646,0.0912059,4,1.58757,0.668164,-1.49174,0.532264,0.623129,-0.15314,-0.282847,0.0560709,-0.0219695,0.0356669,0.325932,-0.242404,0.177782,0.581842,-0.168883,0.335188,0.329578,0.0954601,-0.486813,0.124484,0.0536264,-1.00694,-0.52022,0.549922,-0.20784,-0.215458,-0.0181307,-0.309912,0.00809482,-0.100539,0.871449,-0.482369,0.104021,0.641619,0.0466158,-0.319365,-0.164475,0.587734,0.131298,0.20144,0.896111,0.462609,0.323004,-0.477015,0.311462,0.0139313,-0.148273,-0.236469,-0.133031,0.218546,-0.0780599,0.352507,-0.0246384,0.324921,0.730914,0.316022,-0.144174,-0.497274,0.73376,0.239317,0.167992,1.06164,-0.0646475,-1.10946,-0.142014,0.416725,-0.00317198,-0.232164,0.0927955,-0.836773,0.0752453,0.164594,0.222091,0.25284,0.409422,0.361206,-0.106353,-0.25165,-0.283273,-0.18563,0.228732,-0.483753,-0.0866258,0.196565,0.148668,0.0698808,-0.00975474,-0.351424,0.113562,-0.496901,0.165931,0.165782,-0.24151,0.112352,-0.388711,-0.604084,-0.220126,0.00772532,-0.323651,0.212637,0.482184,-0.00366154,-0.211476,-0.568543,-0.185117,0.121261,0.184642,0.217444,0.0673448,0.435931,0.391353,0.00153626,0.0822054,0.353766,0.544443,0.339319,-0.305789,0.0926633,0.270099,-0.47512,-0.70151,0.113006,-0.16241,0.558699,-0.411679,-0.123495,0.906097,0.372166,0.0390459,-0.31121,-0.495743,0.0218174,-0.506951,0.690234,-0.35857,0.439817,0.159304,-0.616877,0.529234,-0.330905,-1.01177,-0.520548,-0.36025,-0.953056,0.25678,0.731407,0.122946,0.64046,-0.155591,-1.04751,-0.16099,-0.286105,0.182818,0.1961,0.0704735,-0.168017,0.220899,0.182559,0.235825,-0.137639,0.216766,-0.185819,0.206874,0.3666,-0.529731,0.293719,1.02329,-0.573399,-0.253049,-0.144147,0.724134,0.143469,-0.10277,0.0536335,-0.131213,0.0244,-0.691281,-0.0287896,0.58504,0.53756,0.145044,-0.547009,0.787833,0.689884,0.134949,0.378714,-0.153737,-0.513756,0.0961242,-0.519137,0.0523798,-0.129669,0.219237,-0.690689,-0.469294,0.677287,0.125499,-0.397141,-0.720866,0.399228,-0.380091,-0.142053,0.535929,0.253278,-0.423756,-0.43634,-0.269912,0.764645,-0.419103,0.460375,-0.327117,-0.231019,0.376261,0.249593,0.235399,0.7675,-0.340039,0.456654,-0.186499,-0.314651,0.0745129,-0.559501,0.17167,0.262069,-0.544303,0.739119,-0.385957,-0.829042,-0.213914,0.000157394,0.122492,0.182108,-0.242613,0.347373,-0.549323,0.305782,-0.745773,0.0678127,0.381167,-0.771524,-0.294272,0.338899,-0.321398,-1.00247,0.0767132,-0.330672,-0.148938,-0.0493221,-0.674864,-0.65471,-0.0199493,-0.763276,0.0661419,-0.422209,-0.482242,0.211605,-0.209858,0.676271,0.192984,-0.0612141,0.513632,0.164657,-0.326585,0.0758743,-0.157143,0.386064,-0.0751838,0.51191,-0.362461,-0.0477065,-0.89471,0.257195,-1.15048,-0.0187069,-0.522172,-0.427645,0.365217,0.115767,0.605707,0.318644,0.0402232,-0.689797,-0.169095,0.684491,0.0135649,0.254183,0.561844,0.0222792,0.39914,-0.342707,0.24486,0.00258613,-0.00603081,0.731814,-0.104618,-0.542778,-0.315696,0.0661391,-0.253598,-0.339422,0.314322,0.211427,0.245433,0.459812,0.495412,-1.34508 +3421.6,0.76599,0.0912059,4,1.53079,0.866092,-0.7395,0.193279,0.497868,0.0181137,-0.529616,0.135709,0.381781,0.291808,0.505802,-0.416753,0.0275848,0.24243,0.0908464,0.620431,0.393505,0.0381316,-0.0777099,-0.0636215,-0.200223,-1.01078,-0.631027,0.326431,-0.384494,-0.183193,-0.474069,0.285929,-0.350321,-0.291214,0.901421,-0.763951,-0.133959,0.470121,-0.190314,0.131754,0.0397588,0.452686,0.746415,-0.552754,0.798337,0.579108,0.16518,-0.42289,0.232617,-0.112685,-0.868607,0.043627,0.313447,0.513921,-0.0878782,0.891137,-0.011187,-0.518173,1.08559,-0.404888,-0.119767,-0.879195,0.530016,-0.927636,0.554722,1.01439,-0.611693,-0.580766,-0.0414848,0.842758,0.453117,-0.628262,0.051793,-0.377431,0.0515187,0.154393,0.887396,-0.029168,0.950414,0.241177,0.263356,0.797454,0.0267205,-0.197062,1.35404,-0.846436,-0.00459204,-0.0865695,-0.252864,-0.297392,0.326861,0.420975,0.199932,-0.409814,-0.586469,0.152603,-0.246667,-0.225546,0.0719018,0.304428,0.101698,-0.563119,0.233274,0.361836,-0.117762,-0.20135,-0.208135,-0.288741,0.391641,-0.178472,0.543639,0.440627,0.218408,1.25164,-0.331646,-0.0237719,0.237706,0.367669,0.189598,-0.0758965,0.179983,-0.0870794,0.529645,0.0161904,-1.02763,-0.072078,0.177251,0.114463,-0.285925,-0.115159,-0.432343,0.0571961,-0.159747,-0.268345,-0.164737,-0.0440703,-0.454588,0.475509,-0.35682,0.0214592,0.0893335,-0.224219,0.292448,-0.317215,-0.626944,-0.1848,0.229834,-0.486303,0.371658,-0.132184,0.411963,0.508518,-0.359677,9.04551e-05,0.0530124,0.0424732,0.268781,-0.0493543,-0.306771,0.438478,-0.0066059,0.268425,0.232257,-0.552176,-0.0848125,0.0414761,0.573409,-0.111224,-0.219529,0.293775,0.21393,-0.332713,0.09858,-0.913578,0.525372,-0.144993,-0.0409558,0.149988,-0.00864794,0.24768,0.0249507,-0.425641,-0.0710793,0.82057,0.0298689,0.186308,0.159896,0.108196,-0.410828,-0.543285,0.314924,-0.434588,0.308844,-0.179979,0.158977,-0.532627,0.156246,-1.31994,0.0892596,0.18272,0.126568,0.159264,-0.341327,0.0246396,-0.318254,-0.373712,0.2974,0.0698744,0.34381,0.0438908,0.335677,0.961143,0.02082,-0.510626,-0.233326,0.0980072,0.101063,0.0647865,0.074427,0.41577,-0.349626,0.462612,0.627572,-0.515181,0.073268,-0.658113,-0.371125,0.133646,0.351537,0.812948,-0.669451,0.187544,0.175806,0.519369,-0.109099,-0.119079,0.487341,-0.443729,-0.0745884,0.324369,0.19505,0.0812647,0.42059,0.282686,-0.279471,0.188081,-0.553622,-0.37285,0.244842,-0.0874911,0.154695,0.150649,-0.365694,-0.49859,0.1261,-0.404281,0.315569,-0.616957,-0.312809,0.227652,-0.365802,0.169606,-0.265012,-0.139153,-0.595164,0.380618,0.658258,0.539434,-0.00363935,0.308887,-0.175708,-0.291292,0.541431,-0.394885,-0.22601,-0.257264,-0.770234,-0.203069,-0.416141,0.040193,0.43245,-0.244279,0.710578,-0.334617,-0.388916,-0.445396,-0.751001,-0.155079,0.169399,-0.224931,0.207026,-0.128072,-0.291454,-0.863207,-0.221128,-0.0733525,0.400555,0.506349,-0.343211,0.0119105,0.0585066,-0.140959,-0.108678,0.373561,0.108906,0.140866,0.187124,0.375322,0.432578,-1.45252 +3404.22,0.952979,0.0912059,5,1.54457,0.784504,-1.5393,0.755366,0.838771,0.0549522,0.295024,0.168128,0.804764,0.0799411,0.127043,0.204581,0.0181601,0.335386,-0.0936886,0.848813,0.337513,0.16262,-0.264662,0.01805,0.153679,-0.693173,-0.368319,0.240506,0.0562084,-0.0382592,0.178761,0.215298,-0.45703,0.258936,1.28054,-0.502325,0.206702,0.526564,-0.260596,-0.221373,0.141738,0.229434,0.0801438,0.0280958,0.494233,0.313348,0.0120624,-0.379742,0.0494067,0.0316711,-0.118603,0.280899,-0.394692,-0.154658,-0.750948,0.791809,0.00335638,-0.155422,0.23924,-0.246356,-0.246844,-0.767238,-0.0280285,-0.334678,0.0386044,1.04809,-0.430522,-1.08165,0.171759,0.0474807,-0.183658,0.0265397,-0.378913,-0.716216,-0.0771308,0.226127,0.57275,0.159652,0.119145,0.34277,0.432373,0.0303516,-0.196413,0.435135,0.105938,-0.200305,0.282388,-1.02251,0.332596,0.277328,0.273511,-0.432938,0.234674,-0.719215,0.0877472,0.145521,0.306425,-0.351904,-0.171243,-0.358908,0.66462,0.362482,0.513114,0.613064,0.292999,0.655923,-0.871465,-0.65885,-0.0510934,0.0107792,-0.299235,0.138749,0.0496912,0.796908,-0.0290235,-0.301898,0.410521,0.233737,0.627663,0.285316,-0.0861789,0.669021,0.40495,0.0473801,-0.23421,-0.313818,-0.411654,-0.708784,0.264968,0.440048,0.398656,0.0300214,0.348868,-0.269541,-0.166668,0.19929,0.0712549,0.706787,-0.139789,-0.037765,0.0818727,0.54246,0.0841205,-0.242518,-0.289262,0.267763,0.310006,-0.75097,0.324965,-0.232598,0.000242109,0.509561,-0.281653,-0.141062,-0.558986,-0.304026,0.13838,-0.0654592,-0.498469,0.541868,0.124315,-0.727757,0.463489,0.0813252,0.574838,-0.601624,0.695338,-0.0213534,-0.117447,0.0634928,0.495363,-0.0947262,0.616314,0.890833,0.286626,-0.138793,-0.270672,0.0584423,-0.342217,-0.223389,0.0262071,-0.37671,0.182722,0.435775,-0.361074,-0.691563,0.596249,0.351645,0.190575,-0.391411,-0.320384,-0.135176,-0.00515478,-0.645635,0.447682,-0.292325,-0.0228311,-0.765824,-0.0109063,0.665592,-0.315354,-0.36955,-0.54115,-0.0575651,0.0321417,0.44278,0.543698,-0.133709,-0.107913,0.296422,-0.346434,0.428032,0.0509597,0.698331,-0.22158,-0.00246947,0.0290549,-0.25048,0.612826,0.700631,-0.0247426,0.212989,-0.23727,-0.130398,-0.288371,-1.05589,-0.023724,-0.0816705,-0.436021,0.990594,-0.0350677,-0.0592497,0.0469052,-0.0565936,-0.374956,-0.0184973,-0.488761,0.131469,-0.111513,0.841668,0.215685,-0.345647,0.417658,-0.599535,-0.684343,0.34325,0.0279001,0.0379357,0.156102,0.422014,0.336237,0.0442868,-0.0427411,-0.149166,-0.0283214,-0.257176,-0.253221,-0.943698,-0.143773,0.086073,-0.137432,-0.317149,0.353818,-0.111866,0.268727,-0.494655,-0.451494,-0.334397,-0.000514949,-0.0939141,-0.371491,0.409636,0.0154234,-0.537814,-0.313801,-0.443581,-0.861594,-0.134225,-0.0802015,0.0768716,0.0546563,0.153053,0.913697,-0.241526,-0.947634,-0.0406779,-0.354021,-0.342146,0.0369273,0.117874,0.245226,-0.272965,-0.215793,0.506944,-0.266712,0.105534,0.00912517,0.227508,0.004299,-0.0587659,-0.294941,-0.255673,-0.0446106,-0.0659047,0.423983,0.156928,0.303306,0.396142,0.550732,-2.54826 +3412.79,0.587259,0.0912059,4,1.54512,0.822279,-1.52757,0.760956,0.852806,0.0605007,0.266256,0.137291,0.738482,0.0534129,0.108284,0.261595,-0.079324,0.288804,-0.0573522,0.905745,0.294603,0.20157,-0.213714,0.0202252,0.228666,-0.595419,-0.342993,0.311177,0.0502841,-0.0672318,0.279273,0.183428,-0.519958,0.264183,1.2189,-0.454375,0.19096,0.601371,-0.255149,-0.200842,0.206775,0.205474,0.0767935,0.0152711,0.554211,0.277146,-0.0165981,-0.358688,0.0179414,0.070898,-0.140096,0.321229,-0.458166,-0.207285,-0.709048,0.749914,0.0355602,-0.323413,0.200753,-0.232147,-0.24426,-0.724767,0.00295183,-0.370306,0.100918,1.04512,-0.399844,-1.07083,0.121475,0.0777767,-0.145812,0.141628,-0.260055,-0.712645,-0.0830792,0.17584,0.607441,0.199224,0.20223,0.358198,0.382913,0.13771,-0.190682,0.372471,0.0610734,-0.197324,0.33795,-0.963961,0.393424,0.289854,0.229703,-0.453615,0.168233,-0.720519,0.0305353,0.117778,0.263809,-0.340087,-0.189365,-0.413133,0.692663,0.410815,0.4798,0.593542,0.246233,0.597087,-0.890137,-0.611207,-0.0590201,-0.0174127,-0.291292,0.197366,0.0671328,0.762636,0.108112,-0.346545,0.345688,0.255808,0.63064,0.331089,-0.092828,0.607225,0.496339,0.0873187,-0.28687,-0.28878,-0.528712,-0.634906,0.33231,0.408379,0.405102,0.0492644,0.365007,-0.244258,-0.0803834,0.244197,0.0146571,0.684194,-0.174359,-0.00200591,0.0973819,0.460871,0.11517,-0.32402,-0.278658,0.291753,0.336071,-0.706926,0.259972,-0.117213,0.10752,0.494626,-0.245032,-0.0399139,-0.521364,-0.221521,0.0965781,-0.0505076,-0.370696,0.566013,0.0806864,-0.663935,0.432274,0.0345887,0.547909,-0.640761,0.71718,0.00548238,-0.0561113,0.149898,0.459081,-0.101842,0.626709,0.848723,0.27947,-0.183009,-0.33601,0.0282954,-0.391876,-0.133986,-0.0303635,-0.391758,0.151261,0.450169,-0.3512,-0.744326,0.538153,0.374759,0.181033,-0.346043,-0.371148,-0.17676,-0.0042828,-0.695577,0.442042,-0.307885,-0.0377107,-0.757006,0.0164297,0.634129,-0.284549,-0.302323,-0.57155,0.0878845,0.0280308,0.436658,0.46392,-0.139628,-0.0526619,0.306232,-0.332342,0.457137,0.0804952,0.760612,-0.215373,-0.0548829,-0.0293223,-0.2534,0.61291,0.694034,-0.13853,0.235535,-0.194473,-0.0794704,-0.274477,-1.07405,0.108253,-0.0885814,-0.316312,0.955154,-0.095537,-0.0442652,0.0824427,-0.0742039,-0.332303,-0.0910407,-0.480389,0.196479,-0.122834,0.801449,0.236465,-0.338535,0.447822,-0.569993,-0.690711,0.329872,0.0626965,-0.0183811,0.17781,0.284302,0.357507,0.127426,0.0264752,-0.134952,-0.0763226,-0.34327,-0.300044,-0.898532,-0.190162,0.0943794,-0.245515,-0.335552,0.329293,-0.060547,0.261792,-0.424845,-0.385962,-0.340178,0.00675659,0.0129875,-0.256278,0.427822,-0.0122725,-0.491219,-0.301902,-0.449063,-0.852064,-0.0539464,-0.0749332,0.0165406,0.039981,0.117111,0.883087,-0.154875,-0.891909,-0.0307516,-0.328303,-0.321645,-0.00762567,0.198626,0.304005,-0.142453,-0.154727,0.587139,-0.249998,0.0827213,0.0122788,0.170904,0.100105,-0.169821,-0.302828,-0.27244,0.0862655,0.00267237,0.404624,0.154754,0.310712,0.393387,0.557416,-2.67394 +3416.43,0.501733,0.0912059,4,1.49429,0.841381,-1.19479,0.592733,0.609919,-0.0582205,-0.157525,-0.0768854,-0.00242673,0.202345,0.222961,-0.40253,0.528439,0.379429,-0.0352361,0.853688,0.529026,0.230794,-0.49952,0.176268,-0.259361,-0.116362,-0.906913,0.34223,-0.248,0.362441,-0.0278195,0.80583,-0.341598,0.57044,1.13677,-0.46109,-0.338727,0.742954,-0.355576,-0.286842,0.346392,0.36918,0.8635,0.432625,0.997148,0.821597,-0.29593,-0.728469,0.112573,-0.57603,-0.683867,-0.214908,0.109516,0.0224306,-0.473382,0.224659,0.177301,-0.909474,0.415007,-0.0166264,-0.457222,-1.24185,0.232152,-0.6258,0.669835,0.961595,-0.51345,-1.08487,-0.264283,0.569183,0.276833,0.0309749,0.142936,-0.107692,0.177973,0.556126,0.739503,0.0824654,0.476683,0.376595,0.166628,0.17998,-0.226547,0.095076,0.279901,-0.482591,0.190741,0.0612386,-0.255374,-0.25506,0.478438,0.13898,0.100184,-0.237782,0.385921,-0.107096,-0.187703,-0.0245049,-0.216373,-0.0705487,0.283173,-0.328676,-0.597996,0.0967756,0.351645,0.786941,-0.330568,-0.129524,-0.325571,-0.441719,0.0876739,0.0946757,0.321355,1.11988,-0.187261,0.0042717,0.183956,0.295507,0.315216,0.281332,-0.67364,0.0969014,0.531703,-0.0730974,-0.666907,0.0163639,-0.193188,-0.858784,0.179009,0.348973,0.365517,0.369525,0.317561,0.191042,-0.0998672,-0.040012,0.249708,0.525383,-0.0880678,-0.102061,-0.0686875,-0.246662,0.55834,-0.513773,-0.0955709,-0.301455,-0.383931,-0.828158,0.110796,-0.150936,0.483376,-0.0315503,-0.395551,0.330185,-0.334058,-0.166385,-0.0115622,0.319124,0.100756,0.47121,-0.0260078,-0.664052,0.0465263,0.231153,0.586735,-0.304124,0.539098,0.45736,0.241019,0.328631,0.350032,-0.491979,0.557229,0.328708,-0.0742025,0.151268,0.0275272,-0.128226,0.13658,-0.117277,-0.16079,0.303081,-0.125328,0.932869,0.515167,-0.33783,0.286213,-0.520617,0.0746104,-0.150495,-0.641678,0.222313,-0.102898,-0.304151,-0.235819,0.0898694,-0.0502943,-0.34314,0.106753,-0.285862,0.333984,0.00193057,-0.663343,-0.251923,0.0663419,-0.248904,0.254737,-0.0971038,0.326268,0.24421,-0.817931,0.887301,0.11664,-0.0192024,-0.0550878,-0.758466,0.394996,-0.118358,0.183699,0.544004,-0.178432,0.161454,-0.0910823,0.37142,0.112703,-0.244508,0.148268,0.542267,-0.375421,0.64742,-0.144897,-0.0155226,-0.188866,-0.376817,0.304208,0.00472439,0.231976,0.0911499,-0.0377296,0.376082,-0.0945708,0.122396,0.443003,0.244984,-0.737864,-0.0615244,-0.541575,-0.169945,-0.176954,0.416472,0.457997,0.0275896,-0.334369,0.204714,-0.250927,-0.344677,0.0278518,-0.195411,-0.228682,-0.212891,-0.245527,-0.817557,-0.0719132,0.00152814,0.186014,0.307454,-0.344205,0.144381,0.341148,-0.280055,-0.490579,-0.287399,0.198659,-0.0293331,-0.0186506,0.204685,-0.444644,0.0413732,-0.0157027,-0.159974,0.177422,0.248209,0.784575,-0.0360151,-0.818248,0.0547145,-0.111071,0.338172,0.348713,0.0323504,0.479423,-0.150147,0.147032,-0.39381,-0.0321193,0.15382,-0.237469,0.0537649,-0.0931811,0.233918,0.182785,0.157953,-0.235218,0.00664363,-0.29628,0.120276,0.209796,0.346808,0.458035,-1.93784 +3423.16,0.577903,0.0912059,4,1.54299,0.807164,-1.49215,0.626871,0.790886,-0.0739847,0.0985526,-0.0327508,0.479676,0.0175362,0.0592235,-0.165119,0.0725541,0.402875,-0.189147,0.851345,-0.156322,0.34022,0.434713,0.10192,0.0442617,-0.99552,-0.235193,0.6613,-0.230813,-0.0310542,-0.17005,0.0378845,-0.663823,-0.0123234,1.08938,-0.467883,0.442319,0.280568,-0.427099,-0.145645,0.290231,0.927005,0.312259,-0.0981847,0.990801,0.667441,0.499757,-0.918361,0.183158,0.115405,-0.605239,0.12452,0.304474,0.28008,-0.323175,0.883006,0.0996398,-0.150719,0.623147,-0.148979,-0.175273,-0.427965,0.137284,-0.517995,0.379514,0.422499,-0.747961,-0.405656,0.219977,0.246216,0.48064,0.174818,0.251579,-0.863547,-0.0894615,0.10417,0.387179,0.202976,0.230204,0.528733,-0.0104468,0.106662,-0.159768,0.210351,0.128238,0.357403,-0.0355894,-0.198617,0.0190011,0.393395,-0.122718,0.516393,-0.013756,-0.570508,-0.261408,-0.164309,0.370735,0.129268,0.0537709,0.0736182,0.267191,-0.483301,-0.176126,0.404766,-0.437557,-0.0283004,0.0279797,-0.222855,0.108581,-0.147024,0.34913,-0.26815,0.0842841,0.487323,0.202744,-0.647639,0.0019218,0.09775,-0.307809,0.172296,-0.287695,0.323663,-0.218463,-0.14259,-0.565564,-0.477567,-0.0605549,-0.555792,-0.0124292,0.261029,-0.0945924,0.353987,0.288518,-0.0260923,-0.0125721,0.0694721,0.0335704,0.588552,0.05386,0.100512,0.18145,-0.389927,0.341772,-0.101383,-0.457355,-0.248095,-0.0552281,-0.61691,-0.101931,-0.213474,0.45225,0.565537,-0.26255,-0.141899,0.0395696,-0.213891,0.322399,-0.0918611,-0.490766,0.610805,0.314603,-0.311803,-0.225937,-0.225957,0.38521,0.644599,0.171783,0.219129,-0.010864,-0.261287,-0.0572357,0.135125,0.465203,-0.144594,0.102329,-0.244603,-0.455907,0.195738,0.00233187,0.500731,-0.136217,0.32832,0.211686,1.0452,0.445053,-0.157375,0.150954,0.247762,0.198257,-0.172394,0.169278,-0.368142,0.0925527,-0.87473,0.1413,-0.384496,0.108772,-0.404159,-0.639094,0.865635,-0.337039,-0.239704,-0.260131,0.425449,-0.266732,0.00252681,0.169039,-0.542782,0.138733,-0.0213372,-0.332385,0.616777,0.210918,0.81967,0.176344,0.142951,-0.153825,-0.441756,-0.329377,0.384051,0.00413727,-0.116756,-0.252713,-0.13611,-0.512811,-0.604039,-0.375585,0.641562,-0.0672004,0.23401,-0.574302,-0.130241,-0.351403,0.085093,-0.482825,-0.29615,-0.399917,-0.249474,-0.625082,0.541271,0.675486,-0.0944002,1.22508,-0.248425,-0.177879,0.608585,0.680404,0.0746302,-0.00701426,-0.178064,0.13497,-0.0115393,-0.403497,-0.766347,-0.0481465,-0.217184,0.397424,-0.331306,-0.305134,0.60662,-0.284116,0.0433119,0.171887,-0.300531,-0.166489,-0.0430715,0.562799,0.131001,0.209033,0.0591004,0.0928555,-0.215149,-0.302603,-0.380486,-0.250484,-0.387118,-0.375854,-0.21409,0.00307254,-0.206755,0.0535019,0.154404,-0.230227,0.237615,-0.251728,-0.488744,-0.281501,0.0153851,-0.0927082,0.109609,0.229993,-0.424364,0.410311,-0.0256398,-0.320649,-0.260744,0.548352,0.306514,-0.0312561,-0.158861,-0.160007,0.311115,0.221703,0.12417,0.10369,0.140781,0.318566,0.375207,0.564417,-2.30161 +3428.65,1,0.0912059,4,1.53362,0.865751,-1.84815,0.69294,0.892124,-0.125145,-0.683468,-0.0969562,0.425342,0.133971,-0.402874,-0.197725,-0.244573,0.0685525,0.000979132,0.878685,-0.198005,0.0696783,-0.609249,-0.273091,-0.574353,-0.276696,-1.30312,-0.246631,-0.279821,0.271219,0.0553243,0.348944,-0.100323,0.0626962,0.550658,-0.294494,-0.421651,0.153763,-0.123884,-0.211373,-0.0773435,0.526474,1.16905,-0.0796568,0.804311,1.02243,0.454047,-0.117345,-0.178315,0.53868,-0.551592,0.366476,0.428772,0.00878632,0.056928,0.426388,0.253686,0.213786,0.487897,0.158532,-0.550246,-1.02493,0.494529,-0.0257377,0.183261,1.09928,-0.0642486,-1.13636,0.0488952,0.339916,-0.342161,-0.471585,-0.164842,0.275448,0.165359,0.0359453,0.468858,-0.56641,0.575967,0.294309,0.165369,-0.0553272,-0.00759981,0.239816,0.370438,-0.748028,0.50594,-0.136528,-0.211561,-0.334514,0.0336991,-0.698546,0.126738,-0.00603427,-0.0739989,-0.011898,-0.481983,-0.0490528,0.110251,-0.513591,-0.206663,0.0504577,0.185775,0.127597,0.405947,0.1588,-0.572415,-0.276118,0.198583,-0.00895078,0.0141511,-0.317541,0.544371,0.548602,-0.284868,0.071361,0.0775313,0.211112,0.0558578,0.21743,-0.298737,-0.143321,0.571722,0.199509,-0.241174,0.375549,-0.153108,0.583176,0.127172,-0.0218507,0.205997,-0.222914,0.203744,-0.329378,0.200097,-0.315347,0.0136367,0.0989701,-0.216439,-0.657996,-0.236011,0.067701,0.688059,-1.05828,0.0459535,0.317616,0.182636,-0.518288,0.214245,0.445133,-0.214214,0.157561,0.00655297,-0.301948,-0.032771,0.250541,0.065879,0.1412,0.458201,-0.0965016,-0.0166504,0.321216,0.414922,0.0381176,-0.033564,-0.686051,0.849677,-0.238045,-0.215068,0.539113,-0.211071,-0.285667,-0.525115,0.0706138,0.101093,0.136247,-0.283867,-0.287924,0.249293,-0.625147,-0.325005,-0.579385,0.158338,0.598773,-0.4914,-0.0721916,0.199126,0.0743043,-0.0793469,-0.377384,-0.338401,0.131414,0.0116328,0.225142,-0.309806,0.0916905,-0.146953,-0.319445,0.386047,-0.855978,0.578153,-0.0144556,-0.689099,-0.226167,0.27116,-0.324255,-0.0915962,0.454311,0.100817,-0.0771389,-0.126136,1.08901,-0.42372,-0.547646,-0.263663,-0.296842,0.409613,0.419318,0.0592903,-0.073847,-0.337158,0.433167,0.49859,-0.0839515,0.149694,-0.139604,0.403861,0.0421153,-0.328486,0.230461,-0.0357633,-0.196544,0.684429,-0.117233,0.130546,-0.0726334,0.00301665,0.264749,0.171883,0.256578,-0.485485,0.127442,0.0372551,-0.164686,-0.290744,-0.247911,-0.253777,-0.0195594,0.439235,0.391078,0.737109,0.231567,0.296909,0.036742,-0.0232037,-0.57746,0.344068,-0.291176,0.0157661,0.00347246,0.146866,-0.235908,-0.0513367,0.511359,0.333253,0.197683,-0.269108,0.180666,0.063706,0.285759,-0.115834,-0.250244,0.516437,0.272238,-0.00151409,0.114849,-0.216896,0.431674,0.144925,0.078326,0.182477,-0.423352,0.523142,-0.269505,0.0461127,0.374539,-0.0796821,0.115033,-0.0252662,0.0793457,-0.287823,0.879575,-0.335411,-0.255771,-0.163192,0.331474,-0.468688,-0.126073,-0.061826,-0.341727,0.284214,0.0469828,-0.439161,-0.0794089,-0.0624805,0.124233,0.180729,0.352467,0.425123,-2.61346 +3431.68,0.496704,0.0912059,4,1.54196,0.949885,-1.65685,0.600544,0.846283,-0.0939423,-0.447106,0.309861,0.396939,-0.000271797,-0.310255,-0.206719,-0.33381,0.269514,-0.342276,0.801622,-0.160915,-0.0569076,-0.423663,-0.190859,-0.687488,-0.262983,-0.932367,-0.375566,-0.327975,0.207982,0.0909038,0.256584,-0.587854,-0.0171468,0.542143,-0.774946,-0.637596,0.455255,-0.19371,-0.579381,-0.191584,0.586298,1.0685,-0.0609871,0.904628,0.581351,0.457563,-0.775751,-0.154525,0.446312,-0.176318,0.137116,0.53381,-0.101665,0.184686,0.43014,0.0909494,0.280273,0.447682,-0.174033,-0.300995,-1.22276,0.416188,-0.172516,-0.0197515,1.32202,-0.87856,-0.959863,0.00356025,0.531628,-0.450229,-0.395001,-0.279984,0.016191,-0.371632,0.0885927,0.346213,-0.614628,0.517798,0.641979,0.0098131,0.247036,-0.512961,-0.0796747,-0.0512964,-0.344375,0.381703,0.213286,0.129778,-0.309001,-0.0974885,-0.568934,0.457352,-0.157716,-0.188623,0.52373,-0.52432,-0.0746724,0.358469,-0.314351,-0.181118,-0.00925064,-0.0386588,0.196689,-0.000397199,-0.288436,-0.503602,-0.691348,0.405222,-0.711478,0.351172,-0.500129,0.739232,0.259726,-0.692841,-0.0272002,-0.214543,0.191136,0.0080727,0.389708,-0.379077,-0.0576333,-0.160892,0.206829,-0.131723,0.297235,-0.254753,0.365242,-0.415021,-0.229865,0.260863,-0.408971,0.466976,-0.688036,0.0774158,-0.202148,0.343668,0.133916,-0.475332,-0.303583,-0.261291,0.162902,0.715582,-0.974918,-0.156803,-0.0618763,0.172992,-0.314323,0.130082,0.477238,-0.172462,0.507804,-0.19317,-0.153185,0.050563,0.227372,-0.177064,0.171169,0.583555,0.242487,-0.462331,-0.0580997,0.119193,-0.254363,-0.110868,-0.250053,0.989236,-0.119072,0.0365335,-0.191231,-0.106063,-0.390344,-0.167582,0.157807,0.0188143,0.136602,-0.284409,-0.153221,-0.215329,-0.269889,0.0149842,-0.39124,0.3611,0.368959,-0.16957,-0.228741,0.10177,0.241778,-0.0608845,-0.252677,-0.386483,0.323916,-0.352023,0.258292,-0.0734339,-0.183892,-0.0312249,-0.131965,0.103554,-0.573796,0.404767,-0.0926059,-0.639018,0.165482,0.347859,0.472096,-0.0458314,-0.0749795,0.566023,0.176062,-0.564719,0.93197,0.0763956,0.306451,-0.286154,-0.187281,0.0670835,0.173015,0.160684,0.00468922,-0.0610949,0.203685,0.277101,-0.497301,0.283467,-0.43548,0.158066,-0.200061,-0.197669,0.197027,-0.147971,-0.397044,0.558768,0.0901061,0.138029,-0.14541,-0.037222,0.508158,0.43059,0.221553,-0.435426,0.0530849,-0.0231866,-0.375048,0.00117653,-0.29837,-0.20324,0.405544,0.513219,0.03615,0.643362,0.152406,-0.185361,-0.437024,-0.286441,-0.902203,0.266501,-0.129479,-0.111285,-0.26115,-0.0590372,-0.0197347,0.0200353,0.449345,0.410667,-0.0455868,-0.03181,0.000485107,-0.151998,-0.0724098,-0.237449,-0.74424,0.291968,0.187897,0.0812623,0.112342,-0.0551692,0.318188,-0.140124,-0.239607,0.329364,-0.0430008,0.555888,-0.199505,0.132259,0.465118,-0.0339533,0.351245,-0.129373,0.279797,-0.0404391,0.20257,-0.224362,0.348649,-0.19201,0.656206,-0.0553599,-0.0456962,-0.281177,-0.156712,0.38168,0.318359,-0.0346609,0.0219711,-0.030038,0.0990826,0.251968,0.314774,0.501964,-2.62237 +3438.65,0.728517,0.0912059,4,1.54407,0.924108,-1.4624,0.60746,0.747322,-0.190037,-0.0706128,0.0539791,0.516795,0.616015,0.04417,-0.00326365,0.255515,0.243953,0.0308997,0.933218,-0.232084,0.160414,0.272751,-0.12775,-0.0924607,-0.919293,-0.813174,-0.0561018,-0.766594,-0.0667684,0.0194466,0.503432,-0.17411,-0.109426,0.425147,-0.354321,0.367734,0.175588,-0.260712,-0.233672,-0.5483,1.49004,0.659949,-0.277233,0.873448,0.50411,0.399966,-0.7227,-0.353426,0.0939423,-0.490902,0.510175,0.142238,-0.0868971,-0.175533,1.2087,0.241324,-0.419699,0.330322,-0.393102,-0.193935,-0.624534,0.549993,-0.218671,0.38347,1.00201,-0.376127,-0.528761,0.582181,-0.0179112,-0.363163,0.425073,0.181337,0.0203693,0.0325069,0.118161,0.611261,-0.284872,0.267526,0.327482,0.294257,0.223023,-0.0709444,0.366819,0.400991,-0.263516,0.443303,0.206223,-0.377842,0.258332,0.0683748,0.242496,-0.171485,-0.593459,-0.0366801,-0.414684,0.126618,0.000772399,-0.0933455,-0.486746,-0.425785,-0.0849435,0.378884,0.342117,0.138879,-0.0104656,-0.482106,-0.220371,-0.125219,-0.22229,-0.0922566,-0.03281,0.402024,0.545063,0.684204,0.0480426,-0.0202525,0.138423,-0.528821,0.170383,0.0140107,-0.0959187,-0.179939,0.233881,-0.732007,-0.445271,0.0266234,-0.322192,0.862344,-0.364792,0.116015,-0.233283,-0.085547,0.175454,-0.177103,-0.0541956,-0.608025,0.347497,0.314192,-0.17408,0.013507,-0.17402,0.255483,-0.286383,-0.0510639,0.26212,0.279442,-0.313886,0.0289753,-0.357907,0.132072,0.203139,0.292256,0.322431,-0.102554,-0.114425,0.0892797,-0.123818,-0.177661,-0.158538,0.560316,0.359251,-0.0890989,0.326276,-0.00424065,0.112947,0.592481,0.172311,-0.0632512,0.581512,-0.0251962,0.0205794,-0.0207714,-0.0644012,-0.334219,-0.223484,-0.179605,0.44507,0.0818613,0.618727,-0.655184,0.0543712,-0.143971,0.50483,0.53718,-0.107161,0.0285964,0.219739,-0.116733,-0.159924,-0.527502,-0.448957,-0.0403777,-0.6059,-0.0406541,-0.188037,0.0872401,-0.447888,-0.153593,0.47438,-0.198618,-0.710576,-0.393372,-0.271767,-0.014239,-0.070708,0.274884,0.0156233,0.110065,0.0718812,0.027439,1.02623,-0.386163,0.355524,0.403733,-0.329052,0.413488,0.282547,-0.40133,0.155167,-0.653399,0.230011,0.474966,-0.685784,-0.0433851,0.323212,-0.48558,0.286595,-0.283765,0.317774,0.0452777,0.0162719,-0.196947,-0.0935323,0.0584256,-0.127476,-0.0389599,-0.792408,-0.28884,0.233809,0.429267,0.0131493,0.762471,-0.402147,-0.810402,0.607233,-0.356015,-0.254299,-0.0457562,0.124285,0.669693,-0.150007,0.334525,-0.336148,-0.0263592,-0.497678,0.575564,0.0698255,0.0695969,0.385707,0.24816,-0.165132,0.311572,0.165333,0.280588,0.353208,0.241509,-0.116476,0.495104,0.637753,0.421424,-0.112543,0.284573,0.161287,-0.124824,0.0246398,-0.315706,-0.250968,-0.134122,0.600968,-0.0830758,0.302499,0.364948,0.379149,0.161372,-0.186068,0.149183,-0.051316,-0.122978,0.17152,-0.168509,-0.0324936,0.270877,0.317137,-0.0924363,0.187147,0.20033,-0.0329216,-0.458477,-0.311635,-0.316808,-0.54683,-0.255564,-0.486839,-0.0249979,0.121643,0.277412,0.348774,0.526699,-2.33087 +3433.83,0.62231,0.0912059,4,1.52815,0.839772,-1.31232,0.570351,0.600153,-0.18153,-0.236725,0.273494,-0.0842098,-0.287188,0.186923,-0.266728,0.203989,0.365728,-0.0980562,1.24074,0.228936,-0.306538,-0.0796492,-0.111884,-0.269868,-0.832722,-0.256611,0.20747,0.0675229,-0.124125,0.010627,0.509467,-0.465734,0.162235,0.634419,-0.44554,-0.435184,0.118974,-0.314262,-0.117578,-0.417145,-0.0443039,0.632427,-0.138052,0.747775,0.95806,0.507443,-0.626413,-0.31842,-0.111019,-0.709483,-0.023234,0.376511,-0.462774,-0.162958,0.285762,0.101269,-0.538145,0.556484,0.163051,-0.125783,-0.964318,0.599566,-0.958199,-0.291769,0.917776,-0.0776365,-1.22984,-0.0923491,0.752012,0.00428575,-0.248845,0.473275,-0.249521,-0.157123,-0.162983,0.333955,-0.0382407,0.132388,0.436719,0.356815,-0.237724,-0.784239,-0.0829142,0.959087,-0.436559,0.13095,-0.139157,0.166477,0.132703,-0.202817,0.396315,-0.210185,-0.161605,-0.190349,0.535666,0.354453,-0.128452,0.377353,0.0181835,-0.170977,-0.227617,-0.212537,0.324011,-0.202819,-0.571186,0.0703551,-0.157087,-0.322533,-0.410476,0.0355619,-0.218021,0.719284,0.65049,-0.195922,-0.0165396,-0.27496,0.130274,-0.581546,0.14913,-0.0319118,-0.0989752,0.50334,-0.0329066,-1.06206,0.430044,-0.677448,-0.0456595,0.138387,0.332786,0.740548,-0.623687,0.171872,-0.546425,0.369861,-0.180537,-0.250188,-0.00829375,-0.172384,-0.0965978,-0.38781,-0.324052,0.464019,-0.16642,-0.617857,0.170105,-0.28256,-0.324179,-0.190585,0.143737,0.00446218,0.529881,0.237479,0.0781925,0.161304,0.39574,0.113302,0.047498,0.415945,0.599227,-0.163754,-0.107761,0.204119,-0.528251,0.559579,-0.04022,1.09679,0.0479872,0.415056,-0.162873,-0.240063,-0.105656,0.0727012,-0.391758,0.111487,-0.35015,-0.382573,0.238315,-0.28051,0.0765579,-0.506962,-0.344789,-0.109911,0.8139,-0.205718,-0.393461,0.767469,-0.154812,0.0891637,0.126701,-0.393466,-0.436242,0.364948,-0.26741,-0.210126,0.0536058,-0.367143,-0.415583,0.109688,0.00512931,0.345449,-0.259162,-0.0723647,-0.457423,0.0727282,-0.299406,0.525956,0.00214463,0.263519,-0.49835,-0.424636,1.17165,-0.198317,0.428979,0.023264,-0.232679,-0.0374303,-0.203001,-0.119365,-0.123691,-0.197217,0.417386,-0.148126,-0.261043,-0.581176,-0.25779,0.524565,0.555173,0.0686076,0.208319,0.0590737,-0.130099,-0.287488,-0.0780381,-0.0731969,-0.216744,0.141521,-0.151463,-0.0617679,0.0707105,0.574413,0.451112,0.636884,0.138622,-0.227056,0.373927,-0.0754281,0.015365,0.40298,0.461996,0.297577,0.359554,-0.168454,-0.0450968,0.119269,-0.914233,0.254763,0.0813532,-0.346386,0.546787,-0.534901,0.467075,-0.137827,0.154089,0.350156,0.370879,0.193612,-0.321611,-0.174235,0.181488,0.226085,0.399259,-0.080306,0.391905,-0.459649,-0.537901,-0.420849,0.422272,0.491102,0.2462,0.346206,0.323175,0.362018,-0.0420647,-0.266707,-0.165013,0.421779,0.477707,0.157595,-0.245098,0.10962,0.540851,-0.111392,0.186591,-0.125177,-0.383527,-0.13925,-0.409818,-0.142243,-0.488066,-0.364896,0.0533426,0.0476153,-0.578763,-0.217168,0.106572,0.158461,0.326454,0.398072,-1.75491 +3441.45,0.724376,0.0912059,4,1.55011,0.860853,-0.555692,0.175388,0.240154,-0.165196,-0.0471153,0.132041,0.069485,0.128769,0.109775,-0.243175,0.0952763,0.467947,-0.0746994,1.40691,0.33505,0.173973,0.322793,0.053386,0.101873,-0.760019,-0.273331,0.135315,-0.150425,-0.0647336,-0.184014,0.627608,-0.320418,0.279735,0.665933,-0.0427459,-0.175303,0.0829378,0.122413,-0.342551,-0.400829,0.372211,0.533021,-0.0331696,0.81308,0.550513,0.236947,-0.190183,-0.325288,0.115624,-0.699805,0.167405,0.5312,-0.137822,0.347285,-0.231705,-0.034939,-0.313213,1.17546,0.236168,-0.09131,-0.522878,0.546711,-0.203762,0.154672,0.923806,-0.724442,-0.214216,-0.371155,0.228441,-0.00392114,-0.171176,0.531805,-0.432995,-0.0907125,-0.188989,0.504329,-0.398372,-0.18888,0.20195,0.435291,-0.077276,-0.0715552,0.0661009,0.4697,-0.259855,0.280076,-0.565068,-0.316638,0.145801,-0.0144928,0.0040996,0.130446,-0.21155,0.0584952,0.399192,-0.00782764,-0.0971107,-0.251318,-0.219319,0.247375,-0.441819,0.0568197,0.486162,0.38119,-0.339289,-0.542664,-0.310393,0.644519,-0.407442,-0.038107,-0.140372,0.497877,0.226232,-0.424541,-0.0115117,-0.614183,0.192271,-0.314825,0.374573,-0.0190104,-0.0268499,0.662792,0.199906,-0.141192,0.00249331,-0.305061,-0.436585,0.0772287,-0.0901547,0.0273295,-0.0258021,0.365573,-0.0882956,0.442619,0.148049,-0.0207241,-0.549011,-0.127363,-0.109568,0.221959,-0.15428,0.311604,-0.149272,-0.431351,0.0205776,-0.385218,0.32037,0.11582,0.178108,-0.338244,0.305151,-0.257852,0.124559,0.154676,0.426374,-0.00338502,-0.10557,0.327602,0.66391,-0.406507,-0.0727508,0.0790288,0.277563,0.0331455,-0.438194,1.19996,0.0669128,-0.0528731,-0.0591411,-0.553162,-0.104008,0.0121656,-0.795911,0.167763,-0.188655,-0.179153,-0.188424,-0.358412,-0.136056,-0.306937,-0.176451,0.2741,0.501025,-0.1657,0.0520976,0.2312,-0.135181,-0.315089,-0.0897299,0.0329057,-0.715327,0.0167445,-0.0116171,0.366459,0.169019,-0.301295,-0.927776,-0.151237,0.25936,0.197314,-0.271735,-0.346007,-0.234382,0.0751611,-0.552874,-0.0539604,0.188815,-0.511873,0.00312581,-0.315365,1.05459,0.219114,-0.108187,0.186712,-0.480956,-0.316545,0.0767848,-0.164404,-0.448581,-0.378422,0.388458,-0.206492,-0.521956,-0.00679204,-0.336207,0.467497,0.122426,-0.574284,0.483146,0.0895897,-0.564571,-0.563004,0.110238,0.00610539,-0.0889899,0.0123485,-0.100531,-0.370546,0.310459,0.225296,0.764012,0.516205,-0.0310894,0.086187,0.436174,0.372481,0.00170024,0.393821,0.534589,0.588542,0.318384,-0.157069,-0.487917,0.421649,-0.986349,0.155729,-0.374855,-0.438258,0.323545,-0.536878,0.282823,0.0453751,0.260137,0.340212,0.387897,0.0546495,-0.251749,0.330275,0.166752,0.255182,-0.815387,0.531073,0.279956,0.0307837,-0.200126,-0.039593,-0.0284987,0.0703883,-0.320795,0.185648,0.473255,0.633265,0.0282911,0.15317,-0.034241,0.705736,0.222872,-0.0395464,0.0178388,0.0983752,0.305451,0.301153,0.0104358,-0.207628,0.163378,-0.493666,0.527965,0.146099,-0.0719279,0.0360436,0.0462401,-0.3713,-0.80733,0.0496168,0.140204,0.216591,0.374438,0.465393,-0.602161 +3433.96,0.938626,0.0912059,4,1.41668,0.719744,-1.16302,0.616767,-0.130929,-0.0692145,0.19525,0.280771,0.816726,-0.0595752,0.404146,0.389546,-0.602042,0.82064,0.0316049,1.4737,0.568766,0.0448569,-0.0597927,0.0469807,-0.0303587,-0.580187,-0.586366,0.556518,0.386849,0.2254,0.130259,0.109253,0.00524474,0.126894,1.16218,-0.210897,0.124135,0.785206,-0.320138,0.553523,-0.198743,-0.133154,0.192874,-0.20393,0.745824,0.29996,0.246502,-0.633647,-0.582077,-0.40387,-0.97135,0.704876,0.509552,-0.10131,0.367621,0.370803,-0.181535,-0.507889,0.425005,0.360633,-0.389579,-0.364686,0.225089,-0.381885,-0.0906248,0.993196,-0.406564,-0.910647,-0.22151,0.462097,0.0728535,-0.765431,-0.117523,-0.116113,0.178708,-0.00751933,0.80627,-0.0725829,0.375135,0.655791,0.360252,-0.250102,-0.219914,0.179348,0.308461,-0.757882,0.47611,0.126972,-0.0181788,-0.328399,-0.0184199,-0.27331,-0.419295,-0.203123,0.0407268,-0.0612483,-0.108596,-0.428516,-0.170257,-0.230557,0.123024,-0.0307913,-0.102887,0.247618,-0.444703,-0.110285,-0.589402,0.104853,0.110432,0.299787,-0.103341,-0.0688974,0.110474,0.325375,0.349411,0.0592793,0.405064,0.27832,-0.159272,0.26762,-0.213121,-0.132883,0.0158724,0.0341304,-0.767032,-0.394802,-0.438319,0.316661,0.394843,0.499246,0.458759,0.442976,0.195788,-0.48926,0.115707,0.0131687,-0.241701,0.0892502,-0.0511094,0.0702664,-0.0142192,0.196345,0.423685,-0.260361,-1.08037,-0.0199486,-0.0799486,-0.521642,-0.0259435,0.265503,-0.0135793,0.303591,0.169886,-0.475335,-0.0445543,-0.0754455,0.067157,-0.168683,-0.0338512,0.165862,0.286965,-0.13223,0.342478,-0.295142,0.14875,-0.462923,0.642609,0.0096445,0.00276634,0.17341,-0.0357931,0.0910482,-0.394296,0.631093,0.677749,-0.0790737,-0.178846,-0.342372,-0.0826394,-0.577482,-0.179057,-0.0252623,0.475704,0.530039,-0.349686,-0.864626,0.510342,0.199184,-0.671461,-0.497109,-0.150305,-0.427633,-0.223277,-0.11382,0.0234196,0.260631,-0.548579,-0.593896,0.0104909,0.0468988,0.674947,0.147644,-0.114366,0.154942,0.202878,-0.458559,0.441539,-0.0757849,0.162912,0.185707,-0.189025,0.955964,0.338396,0.410239,0.0638417,-0.611944,0.229132,0.212927,0.692785,0.304249,-0.193869,0.243399,-0.166302,0.107181,-0.300333,0.416371,-0.341036,0.485473,-0.291596,0.15125,-0.291498,-0.325977,-0.222604,0.11041,-0.289801,-0.0909148,-0.798193,0.0156285,-0.528726,0.428304,-0.0341594,-0.505712,0.318016,-0.121032,0.315472,0.380611,0.0261641,-0.438409,0.0904259,0.28787,0.153896,-0.0130552,-0.0616004,0.0205477,-0.184734,-0.817118,0.326638,0.0617122,-0.444666,0.70791,-0.337345,0.262036,-0.149057,0.248571,-0.0605915,-0.00924076,0.25937,0.0609486,0.165236,0.251193,0.225226,0.0649598,0.120776,-0.572031,-0.453324,-0.178326,-0.187891,0.592802,-0.00958083,-0.250683,0.288437,0.719451,-0.0539449,-0.119386,0.012167,-0.339208,-0.242122,-0.223745,0.0434482,0.210801,-0.268679,0.0612026,0.282726,0.132945,0.0328001,-0.577349,0.165402,-0.0253484,-0.227141,-0.666217,0.699133,-0.582837,-0.44977,-0.261954,-0.0154382,0.124895,0.246764,0.353405,0.496754,0.622319 +3435.16,0.79646,0.0912059,5,1.453,0.755123,-0.921472,0.530934,-0.092544,-0.00646625,-0.213524,0.28276,0.387767,0.299648,0.197684,0.204362,-0.25147,0.861168,0.242215,1.47725,0.561454,0.23663,0.113842,0.174612,0.00882117,-0.647036,-0.258853,0.307415,0.250377,0.0647498,0.24867,0.1457,0.161651,0.303637,1.05692,-0.250936,0.195102,0.799915,-0.239952,0.42313,-0.10617,-0.000477289,0.250207,-0.26511,0.841875,0.594693,0.605229,-0.601005,-0.384531,-0.241104,-1.07139,0.505062,0.564324,-0.168933,0.383068,0.494603,0.0785294,-0.412389,0.427417,0.318931,-0.481751,-0.487281,0.247909,-0.284368,0.205292,1.06781,-0.224886,-1.06687,0.0133315,0.502097,0.08447,-1.00774,-0.194027,-0.277986,-0.034765,0.0267502,0.731888,-0.245243,0.390306,0.633988,0.160557,-0.606421,0.0925579,0.272585,0.54436,-0.892394,0.358124,0.173208,-0.0934118,-0.490703,0.0276026,-0.258412,0.0124156,-0.413683,0.112806,0.0108596,0.0293512,-0.571144,-0.0543587,-0.470707,0.319148,-0.353736,-0.168739,0.380053,-0.46142,-0.246484,-0.619326,0.203365,0.00162434,0.425611,0.180411,-0.120828,-0.00867801,0.34838,0.274772,0.1219,0.380714,0.179662,-0.457883,0.203785,-0.185572,0.187788,0.216022,0.115185,-0.628233,-0.380252,-0.662642,-0.0133349,0.331752,0.270713,0.564284,0.2952,0.255288,-0.336126,0.0960458,0.433811,-0.417468,0.135706,-0.0271445,0.219665,-0.103967,0.362847,0.412007,-0.241608,-0.566019,0.00550854,-0.732252,-0.429719,0.330134,0.36437,0.246645,0.582391,0.19628,-0.6924,-0.312479,-0.0408314,0.140602,-0.302493,-0.0560059,0.0315514,0.161354,-0.217991,0.351607,0.0107804,0.178726,-0.234477,0.596058,0.0904116,-0.137307,-0.0464353,-0.184183,-0.0521,-0.190009,0.320234,0.588846,-0.200931,-0.18608,-0.514061,0.00628006,-0.629501,-0.206552,0.157868,0.444378,0.616668,-0.499213,-0.255016,0.49226,0.595129,-0.536976,-0.22868,-0.230101,-0.415789,-0.0220955,-0.150805,0.204679,0.114297,-0.477203,-0.296823,0.112875,-0.0137713,0.440083,0.371519,-0.201677,0.297846,0.224334,-0.669881,0.235348,0.319274,0.344041,-0.0939186,-0.290671,0.94046,0.0297908,0.558703,-0.101449,-0.242914,0.200681,0.344357,0.840624,0.111389,-0.0559176,0.116106,0.233409,-0.0715184,-0.311553,0.207022,-0.109403,0.140178,-0.439911,0.0059973,-0.344999,-0.204183,-0.113372,-0.0403751,-0.657317,-0.0825492,-0.657952,-0.115892,-0.37822,0.119528,-0.150099,-0.153358,0.475491,-0.15007,0.303018,0.458958,0.000384673,-0.222375,0.0837766,0.393475,0.305879,0.181806,-0.28601,0.0725009,-0.199858,-1.06089,0.278765,-0.287868,-0.249417,0.623201,-0.256864,0.384439,-0.307881,0.376803,0.183249,0.20466,0.0892777,0.0278985,0.141713,0.324388,0.172564,0.000367125,-0.123595,-0.501285,-0.315212,-0.129231,-0.410978,0.74086,-0.204618,-0.08116,0.326671,0.784501,0.14924,0.0273761,-0.0192285,-0.397812,-0.2273,-0.144344,0.0736558,0.27252,-0.315934,0.432733,0.175217,0.1825,-0.105653,-0.549843,0.170279,0.012796,0.0509943,-0.844438,0.326514,-0.25943,-0.682025,-0.320612,-0.0780771,0.117089,0.219232,0.342183,0.468222,0.407455 +3390.28,0.810602,0.0912059,4,1.55131,0.801321,-1.55065,0.582679,-0.00415616,-0.276376,0.208298,0.0323817,0.456043,0.137745,0.329091,-0.190061,-0.425814,0.416197,-0.0476306,1.02158,0.0404982,0.221415,0.0931224,-0.0393563,-0.411082,-0.503526,-0.761802,-0.0710436,-0.419663,-0.601559,-0.441401,0.354999,-0.0163094,0.00294894,0.698597,-0.326498,-0.326815,0.166717,-0.388774,0.0601531,-0.342855,0.554994,0.703221,-0.132033,1.15229,0.463943,0.362845,-0.322026,-0.0182654,0.433708,-0.380631,0.0497875,0.733347,0.0825797,-0.0494157,0.351406,0.11506,-0.39032,0.254876,0.221276,0.110618,-0.608358,-0.0273113,0.0660186,0.137947,0.946706,-0.374173,-0.346744,0.261834,-0.00117565,-0.368716,-0.506717,-0.00322477,-0.391409,0.0511155,0.720773,1.02403,0.068881,-0.146476,0.469154,-0.157438,0.196661,-0.203872,0.371118,0.182225,0.0621757,0.496388,-0.269672,0.933094,0.365712,0.00228059,-0.194748,-0.379709,-0.0992034,0.347305,0.189975,-0.113504,0.358211,-0.685688,-0.0390625,-0.116873,-0.547068,-0.0339348,-0.0928207,0.449248,-0.28063,-0.653307,-0.286416,0.0194248,-0.684415,0.339477,-0.546508,0.308461,0.818053,-0.163455,-0.327301,0.397237,0.526052,-0.20628,-0.0959339,-0.132534,0.132757,-0.466915,0.314916,-0.689581,-0.609464,-0.785936,0.0669599,0.00799973,0.281385,-0.114827,0.789568,-0.153792,-0.595398,1.07919,-0.0889394,0.426324,-0.0181358,0.060217,-0.349766,-0.252654,0.0221494,0.824798,-0.931046,0.346328,0.416595,0.787578,-0.506403,0.0872637,-0.141894,-0.650702,0.238322,-0.182451,-0.119279,-0.313772,0.0397222,-0.443872,-0.379491,0.237054,0.871397,0.107784,0.348706,0.0449776,0.0475276,0.29215,-0.289194,0.590651,1.04079,0.460924,0.248105,-0.205732,-0.104291,-0.191953,0.0429781,-0.511012,-0.416551,-0.0498284,-0.0453805,0.143449,0.0103406,-0.248491,0.094592,-0.667023,0.57269,0.140369,0.246242,0.491928,0.159804,0.477326,-0.913751,-0.224998,-0.209232,0.632912,0.454961,0.00179331,-0.246242,-0.18273,-0.66176,-0.272121,0.318046,0.08278,0.0239118,-0.415496,-0.229315,0.251864,0.801979,-0.103175,0.333806,-0.173622,0.0159559,-0.3557,1.14411,0.0119394,0.190148,0.360411,-0.00863514,-0.379383,-0.836642,-0.308514,0.155864,-0.409707,0.120614,0.781306,-0.647557,-0.239035,-0.792213,0.079489,-0.33179,-0.0921357,0.171883,-0.343473,-0.0713746,0.138017,-0.477324,-0.345113,0.105372,-0.119243,-0.587064,-0.812455,0.796549,0.483342,0.366114,0.459333,-0.380188,-0.303362,0.10717,0.0312027,0.565709,0.372629,0.0150836,0.576611,0.0176944,0.689921,-0.0809798,0.422501,-0.597251,0.837722,0.203667,0.0810203,0.690979,0.198889,0.0428457,0.587299,0.0660275,0.170354,-0.144031,0.772133,-0.0048742,-0.337335,0.320523,0.189972,-0.123157,0.00134703,0.40801,-0.0511879,-0.508819,-0.620742,0.0568372,-0.358221,-0.366281,0.112185,-0.177689,0.195438,-0.213867,-0.0837802,0.508555,-0.310697,0.908472,-0.276662,0.0543095,-0.4192,0.192938,0.36408,-0.17425,0.207036,0.160814,-0.0470724,0.759216,-0.037802,-1.25874,-0.20914,0.363398,-0.0486736,0.0492008,0.0266613,0.182163,0.22205,0.426805,0.471222,0.479648 +3389.11,0.995834,0.0912059,4,1.54468,0.746563,-1.31022,0.55479,0.296501,-0.275691,0.195804,0.165109,0.472661,0.210296,0.323656,-0.227596,-0.496614,0.349816,0.0485982,1.16927,0.221045,0.0812995,0.103832,0.0824624,-0.470345,-0.544364,-0.987558,-0.111406,-0.616742,-0.482092,-0.421394,0.0893324,-0.150232,0.0589288,0.788591,-0.533508,-0.249956,0.0369313,-0.466096,-0.00214543,-0.141665,0.4167,0.651688,-0.0225972,1.21121,0.560683,0.386478,-0.32452,-0.0832638,0.612907,-0.447887,-0.00412516,0.721644,0.0591772,0.0247037,0.270866,0.181491,-0.617006,0.262093,0.135274,0.0548979,-0.757405,0.107193,-0.0356105,0.116546,1.00269,-0.429856,-0.483037,0.406061,0.086793,-0.375457,-0.647624,0.141258,-0.380065,0.0727562,0.717357,1.02177,0.141323,-0.21836,0.400588,-0.227877,0.185819,-0.101193,0.349591,0.161397,-0.149096,0.437523,-0.132472,0.888145,0.440494,0.000137415,-0.402179,-0.29139,-0.109005,0.329315,0.161712,-0.198438,0.453173,-0.607739,-0.0817073,0.0487827,-0.510964,-0.0196917,-0.0226368,0.364816,-0.378094,-0.708308,-0.0924228,-0.101121,-0.656652,0.194217,-0.467633,0.346168,0.743372,-0.0479853,-0.311841,0.331206,0.40689,-0.15847,-0.0504845,-0.148728,0.0658745,-0.471283,0.312936,-0.586199,-0.536425,-0.847063,0.233463,0.117787,0.302065,-0.115499,0.821188,-0.160394,-0.625099,0.937645,-0.126176,0.277348,0.0605174,-0.0194858,-0.216629,-0.299229,0.0131077,0.7378,-1.02,0.208243,0.505124,0.788631,-0.42966,0.192542,-0.0711666,-0.693807,0.3161,0.00572278,-0.325474,-0.395354,-0.0175877,-0.412949,-0.239429,0.269144,0.769112,0.00278052,0.276394,0.0695364,0.0529001,0.387743,-0.326069,0.608009,0.931393,0.466718,0.277925,-0.230201,-0.0854977,-0.261911,0.00595603,-0.474876,-0.647427,-0.0579222,0.0659941,0.147469,-0.258505,-0.167615,0.275004,-0.566246,0.529808,0.25803,0.348432,0.35245,0.0719488,0.377185,-0.978585,-0.275696,-0.247594,0.527688,0.395521,0.0768233,-0.155982,-0.277599,-0.850405,-0.387043,0.272135,0.00674516,0.0338697,-0.408494,-0.136251,0.174499,0.639642,-0.063906,0.304876,-0.265028,0.234331,-0.397735,1.14783,-0.0886993,0.407129,0.283771,0.051673,-0.402156,-0.771467,-0.169749,0.146802,-0.278111,0.183303,0.918399,-0.791222,-0.39676,-0.961871,-0.047409,-0.280238,-0.0495425,0.187123,-0.438792,-0.0158148,0.169024,-0.349089,-0.262036,0.0779327,-0.154085,-0.597788,-0.733303,0.796421,0.614636,0.336567,0.426058,-0.451599,-0.24905,-0.0589975,0.0929249,0.647317,0.426275,0.168841,0.552933,0.134128,0.764456,-0.109227,0.36503,-0.631465,0.740814,0.265244,0.0763057,0.602572,0.229706,0.186475,0.512029,0.172172,-0.0925872,-0.0932956,0.69788,0.00761962,-0.254076,0.243962,0.175781,-0.184926,-0.0208529,0.416383,0.00295008,-0.595904,-0.456236,0.110143,-0.391099,-0.473473,0.185969,-0.25114,0.109066,-0.110005,0.0488699,0.643796,-0.351467,0.688361,-0.338873,-0.00835454,-0.304265,-0.0556256,0.464352,-0.282526,0.251792,0.147154,-0.0673249,0.546634,-0.136909,-1.27495,-0.249944,0.314602,0.157249,0.326489,-0.00954369,0.177746,0.195359,0.421599,0.441994,-0.528331 +3372.25,0.996315,0.0912059,4,1.53064,0.841954,-1.28844,0.530577,-0.0101709,-0.296125,0.233041,0.0645831,0.52922,-0.0671242,0.272515,0.000573355,-0.499961,0.225655,0.00311732,0.945852,0.237042,0.241655,-0.337869,-0.0110638,-0.389999,-0.437523,-0.904033,-0.0259223,-0.664975,-0.323093,-0.244389,0.475774,-0.268035,-0.0429702,0.473188,-0.564768,-0.0106559,0.246833,-0.669148,0.0947503,0.0496446,0.511435,0.603549,0.0213873,1.16067,0.534469,0.510587,-0.534307,-0.458505,0.311833,-0.547258,0.168269,0.557894,0.285583,0.193944,0.324399,0.120732,-0.917141,0.246297,0.175717,-0.0152352,-0.619996,0.131883,-0.125676,0.176162,0.853315,-0.800563,-0.873098,0.297391,0.438884,-0.187399,-0.806607,0.362193,-0.275829,0.0146066,0.74707,1.09965,0.241849,-0.201533,0.243338,-0.17973,-0.00559489,-0.287522,0.356932,-0.115724,-0.0679192,0.476573,-0.315348,1.03655,0.270942,-0.0268249,-0.647306,-0.135373,0.024766,0.347752,0.0492814,-0.355121,0.0740865,-0.4272,0.00436077,0.300118,-0.409873,-0.229902,0.26408,0.339745,-0.753958,-0.775006,-0.211672,0.0796452,-0.524337,0.303089,-0.386417,0.43639,0.836447,0.254679,-0.200352,0.391299,0.352621,-0.101215,-0.00837513,-0.361245,0.0976007,-0.594209,0.159824,-0.937235,-0.512885,-1.16081,0.115052,-0.332985,0.075019,0.287874,0.670951,-0.140879,-0.541667,1.08499,-0.0067658,0.347608,-0.201003,-0.203661,-0.37983,-0.136009,-0.27141,0.872199,-0.980776,0.110378,0.398688,0.784908,-0.399615,0.574943,0.040273,-0.598027,0.294461,0.0344651,-0.275078,-0.331698,0.0436849,-0.532744,-0.364384,0.599185,0.837104,-0.283973,0.114135,0.0753817,-0.211817,-0.0269973,-0.399926,0.753441,0.892628,0.546724,0.306064,-0.386438,-0.0583398,-0.239915,-0.430719,-0.614831,-0.544268,-0.187888,-0.130975,-0.0501974,-0.372895,-0.198494,0.237045,-0.679014,0.485011,0.331392,0.0341597,0.472072,0.148935,-0.0119433,-0.882531,-0.354066,-0.552505,0.574152,0.621754,0.103391,-0.213142,-0.269411,-0.593222,-0.508125,0.196363,-0.15669,0.0996702,-0.285055,-0.309405,0.1952,0.281656,-0.0376626,0.620882,0.0378283,0.00500163,-0.586635,1.04351,-0.316362,0.328148,0.369239,-0.0383316,-0.0899463,-0.786045,0.145123,0.361751,-0.444337,0.136558,0.777199,-0.722288,-0.54751,-0.601233,0.229157,0.104919,0.0311395,0.133705,-0.378614,0.0814551,0.138721,-0.120676,0.0297053,0.106323,0.0167888,-0.713006,-0.587488,0.972477,0.353985,0.314436,0.314411,0.0307702,-0.108192,0.0412543,0.0595467,0.484355,0.678728,0.121657,0.558268,0.0680117,0.536503,-0.208111,-0.0131489,-0.855017,0.810729,0.163193,0.013491,0.591931,0.177822,0.15239,0.470072,0.359841,0.0625633,-0.035318,0.368436,0.207442,-0.453162,0.0495488,0.297361,-0.306833,-0.138543,0.570617,-0.0141735,-0.809983,-0.497921,0.32374,-0.478114,-0.591011,0.365114,-0.476506,0.256147,0.0724096,0.126449,0.534718,-0.568289,1.04942,-0.426677,0.146384,-0.0783617,-0.170241,0.491257,-0.359169,0.118862,0.00641209,-0.261693,0.532469,0.00377001,-1.13087,-0.371698,0.383364,-0.0379874,0.184186,-0.233541,0.205356,0.188166,0.453162,0.433781,0.323687 +3368.09,0.666789,0.0912059,4,1.57028,0.853928,-1.02047,0.422507,0.0604575,-0.228263,-0.39982,-0.121569,0.81617,0.0414854,-0.147977,-0.033318,-0.72606,0.410651,0.208975,1.26814,0.272526,0.0955118,-0.139645,0.00140715,-0.174127,-0.457588,-0.857156,0.0145656,-0.46027,-0.161417,0.0356076,0.145216,-0.0986047,-0.197758,0.576815,-0.0876643,-0.0524334,0.142278,-0.381489,0.215168,-0.514339,0.316757,0.45486,-0.213148,0.77146,0.610177,0.532727,-0.475791,-0.16456,-0.295397,-0.353676,-0.157047,0.512414,-0.230206,-0.204271,0.00971679,0.213254,-0.847904,0.430259,0.145169,0.0900866,-0.372136,0.0405661,-0.671844,-0.342521,0.959061,-0.599853,-1.05809,0.364198,0.0950432,-0.4821,0.0352346,0.730516,-0.287627,-0.00865155,0.671714,0.680278,-0.605606,0.453967,0.436493,-0.00740625,0.0433698,-0.276662,-0.186219,0.0612375,-0.473599,0.355289,-0.503425,0.0750387,0.2842,-0.552069,-0.45168,0.422953,-0.403338,0.297169,-0.283582,-0.589063,0.428676,0.286512,-0.809276,0.35517,0.0790649,0.0382449,-0.0514747,-0.030479,-0.637186,-0.98119,-0.463499,0.331545,-0.384355,0.451776,-0.583537,0.238702,0.889121,-0.425392,-0.174382,0.448151,0.375531,0.118996,0.0398945,-0.469648,0.429239,0.284093,0.510794,-0.38979,0.362036,-0.840565,-0.0431439,0.245453,-0.0372096,-0.0161548,0.047626,-0.0339063,-0.170007,0.759021,0.30139,-0.32485,0.383958,-0.204109,-0.0284807,1.00809,0.0915238,0.27986,-0.934986,-0.0549598,0.355728,0.656488,0.0423557,0.246254,0.258488,-0.271217,0.778815,0.2449,-0.267148,-0.522008,0.383276,-0.399465,-0.783296,0.8446,0.852672,0.411036,-0.363464,0.248464,0.0385129,0.498705,-0.188981,1.02654,-0.33683,0.26996,0.40267,-0.0509407,-0.679274,-0.486161,-0.188621,-0.289885,-0.112444,0.0208437,0.169634,-0.116746,-0.632161,-0.258115,0.581077,-0.245231,0.611991,0.0845732,-0.00238347,0.38124,0.537402,0.264385,-0.756295,-0.598565,-0.722171,-0.197829,0.245802,0.0415964,-0.489012,-0.362603,-0.976279,0.456333,0.241659,0.514825,-0.104128,-1.10765,-0.661278,0.234751,0.279755,0.62615,-0.0266033,0.014451,0.166854,-0.253372,1.1407,-0.96739,0.158517,-0.255619,0.137369,-0.4739,-0.341642,-0.106914,0.372569,-0.15413,-0.354473,0.770942,-0.433168,-0.182186,-0.594605,-0.0619507,0.0846447,0.143954,0.667629,-0.306909,-0.0868379,-0.32038,0.021866,-0.323403,-0.0637798,-0.402537,-0.0307061,0.137599,0.60884,0.467739,0.756981,0.457197,0.124469,-0.418745,-0.0409749,-0.0917751,-0.281373,0.11187,0.523518,0.984108,-0.000772732,0.25965,-0.047805,0.416818,-0.815766,0.512048,-0.34852,-0.171463,0.471812,-0.156367,0.237156,0.855398,0.914179,-0.00474313,0.356357,-0.181741,-0.51288,-0.624138,-0.12317,0.482552,-0.0284464,-0.190013,0.233727,0.709443,-0.301458,-0.106501,0.432445,-0.150292,-0.0701701,-0.100786,0.0911382,0.586466,0.495718,0.276858,0.0589274,-0.460337,-0.0173156,-0.464426,-0.0807474,-0.355272,0.397392,0.24712,-0.469295,0.267529,0.0276308,-0.399216,0.483641,0.309999,-1.2705,0.0427723,-0.0659421,0.268128,-0.200608,-0.212098,0.186912,0.22015,0.432333,0.469202,0.0524233 +3405.26,1,0.0912059,5,1.5652,0.729395,-0.888806,0.379686,-0.279808,-0.234041,0.122458,0.500512,-0.0447998,0.255479,0.365655,-0.0829915,-0.231671,0.955276,0.0173772,0.211678,0.37034,0.236902,-0.70458,-0.0560674,-0.191122,-0.817054,-0.506263,0.414561,0.0375476,-0.306821,-0.00616539,0.342043,-0.318707,0.0058019,0.697015,-0.633651,0.369601,0.452066,-0.587004,0.304858,-0.526629,0.223033,-0.421277,-0.0503724,1.37048,0.0484394,-0.271925,-0.733326,-0.32528,0.433173,-0.628758,0.326084,0.396218,0.321773,0.228738,0.557642,-0.0154024,-0.898341,0.503138,-0.0729113,-0.361243,-0.419446,-0.00676898,-0.0886356,-0.0925984,0.620504,-0.855286,-0.39047,0.00385249,0.467199,0.255522,-0.121891,-0.240489,-0.839944,0.253731,0.879534,0.283486,-0.174852,0.937575,0.569718,0.203694,-0.384601,-0.10741,0.558446,0.913583,-0.308869,0.593835,0.276572,-0.201799,-0.0575063,0.285974,0.368979,0.147554,-0.0338571,0.277802,-0.440045,0.222217,0.133665,-0.316957,0.501971,0.391816,0.308929,-0.128175,0.19142,0.393047,-0.429252,-0.749911,0.0226277,-0.0198647,0.0409712,0.232537,0.0628204,0.208171,0.686137,-0.364074,0.302314,0.0753605,0.598237,0.306582,-0.0774196,-0.11304,0.226057,0.568571,0.576594,-0.5513,-0.0681528,-0.285102,-0.19752,0.285077,0.29535,0.0199762,0.402692,0.132105,-0.458116,0.57363,-0.377646,-0.289752,0.36917,0.106762,-0.575611,-0.0844612,-0.289017,0.61125,-0.775009,-0.185799,0.137282,-0.249758,-0.58266,-0.841255,-0.43671,-0.674509,0.522689,0.0825536,0.0407442,-0.504882,-0.0125877,0.249137,-0.505335,0.18105,0.361024,-0.174024,0.255987,-0.101637,0.400648,-0.114927,-0.100993,0.370577,0.0472542,-0.110748,0.616171,0.16904,-0.339271,0.113826,-0.454165,0.104922,0.461936,7.91437e-05,-0.435819,0.260282,-0.711731,0.304761,-0.0854267,0.510082,0.700778,0.275075,-0.449351,0.287627,-0.0267823,-0.291792,0.143648,-0.539088,-0.212324,0.026118,-0.693044,-0.170931,0.254609,0.0276494,-0.376572,-0.537445,0.142553,0.147511,0.131017,-0.518072,-0.334767,0.258684,0.0308325,0.0494877,0.10376,0.0728229,-0.316607,-0.265382,1.16644,0.885515,-0.0803171,-0.163671,-0.133882,-0.389802,-1.38069,0.319669,0.543933,-0.542537,-0.0357913,0.449407,-0.17413,0.0636935,-0.594565,-0.569336,-0.144419,-0.26735,0.330392,-0.401222,0.0204691,-0.536647,-0.178303,-0.11307,0.279258,-0.328255,-0.23566,-0.942603,0.753569,0.235108,0.211602,0.796796,-0.32455,-0.603792,-0.302699,0.276812,-0.101203,0.578715,0.0496232,0.168633,0.224399,-0.0525852,-0.898272,0.167239,-0.542955,0.512898,-0.300909,0.160167,0.803385,0.151565,-0.0663669,0.155238,0.0530107,0.303447,0.689388,0.4236,0.319494,-0.533208,0.303456,0.265954,0.224295,-0.436119,0.106857,-0.0699795,0.0143874,-0.0353257,0.175921,0.566797,0.439343,-0.373518,0.26485,0.284507,0.243618,0.428366,-0.10565,-0.269727,-0.0517834,0.119498,0.292138,0.437975,0.493747,0.425852,-0.771444,0.226819,0.119725,0.470663,-0.142451,0.396145,-0.252603,0.175268,0.591556,-0.34697,-0.301555,0.051352,0.164752,0.218519,0.405897,0.467461,1.36999 +3409.37,1,0.0912059,4,1.63823,0.749427,-0.38929,0.155144,0.00635147,-0.196655,-0.314233,-0.368024,0.649773,-0.265268,0.234388,-0.0517607,-0.207923,1.00117,-0.255333,0.896821,0.1956,0.0613811,0.338087,0.043893,-0.266097,-0.867691,-0.831281,0.348563,-0.466562,0.0972674,-0.0366638,0.24458,-0.0244642,0.0128878,0.873622,-0.379824,-0.342646,0.23363,-0.266173,0.17353,-0.740608,0.05196,0.227114,-0.658348,0.87538,0.342913,0.177548,-0.417607,-0.380187,-0.439635,-0.471684,-0.0918824,0.30855,0.0420825,0.529602,0.17363,0.157246,-0.543986,0.641962,-0.0299175,-0.0566612,-0.239141,0.212873,-0.172237,-0.0542467,0.606115,-0.545821,-1.37952,0.170585,0.0159562,-0.426461,-0.323739,0.127293,-0.396586,-0.315268,0.112834,-0.0157843,0.255396,0.461967,0.672811,-0.0120316,0.615221,-0.242391,0.443396,0.586828,-0.534576,0.146461,-0.0682434,-0.576754,0.0348884,-0.371869,-0.458378,-0.14926,-0.432636,0.126112,0.362378,-0.413035,0.160274,-0.10686,-0.48141,0.187062,-0.899858,0.270104,0.226935,0.0231297,-0.292094,-0.158038,0.0848498,-0.275849,-0.337983,0.12341,-0.238759,0.0165502,0.193043,0.518059,0.110481,-0.0732704,0.661669,-0.273794,0.684389,-0.342987,0.0805133,-0.273879,0.0581433,-0.461693,0.170941,-0.0336396,-0.00419488,0.401012,0.0354117,0.350082,0.425601,0.218034,-0.299276,-0.047507,-0.490043,0.585955,0.84917,-0.199177,0.192582,0.0121868,0.200157,0.516113,-0.114335,-0.626603,0.391615,-0.0301505,-0.718654,0.2905,0.404461,0.145669,0.518097,-0.152129,-0.468929,-0.235029,-0.0525359,0.336407,-0.0972641,-0.0367394,0.527625,0.700678,0.243961,-0.386228,0.252262,-0.116012,-0.503427,1.24905,0.0407457,0.352262,0.0266902,-0.0374758,-0.634214,-0.553523,-0.298687,-0.0772581,0.342433,0.343656,0.290134,-0.298184,-0.0399491,-0.189949,0.172531,-0.167949,0.980054,-0.41726,-0.250412,0.533413,0.518502,-0.095725,-0.943555,0.163306,-0.464811,0.313148,-0.15059,-0.418148,0.253503,0.0707633,-0.756731,0.322405,0.151448,0.318287,0.047063,-0.0926014,0.619238,-0.0128556,-0.13492,0.313248,0.252858,-0.235405,0.010632,-0.3661,0.916525,-0.604321,0.109186,0.0719353,0.0601699,0.196903,-0.262582,0.111414,0.760374,-0.43506,0.234447,0.45732,-1.11178,-0.347055,-0.121066,-0.0849153,-0.363877,-0.212659,0.645106,-0.685409,-0.821392,-0.302888,-0.115188,-0.238035,0.203957,0.11624,-0.538305,-0.39448,0.46802,-0.562498,0.513241,0.668375,-0.822607,-0.171866,-0.105556,-0.227274,0.498759,0.0870106,0.423791,0.558524,0.341405,-0.363446,-0.436021,0.237643,0.266881,0.512402,-0.430796,-0.22845,0.691012,-0.0621371,0.0592041,-0.0887745,0.484651,0.587507,0.235045,-0.361868,-0.0481857,0.738807,0.135632,0.223384,-0.568751,0.317311,-0.651923,0.134781,-0.456366,-0.190382,-0.0412867,-0.250675,-0.560351,0.474754,0.560163,0.252142,-0.0250453,0.143638,-0.0652731,-0.386539,0.227536,0.536849,-0.330708,-0.668599,0.335435,0.0292816,-0.519614,0.405575,0.206531,-0.357405,0.510336,0.0666275,-0.505465,-0.154438,0.391888,-0.217336,-0.649606,0.0586681,0.128572,0.237114,0.35857,0.486944,0.398766 +3391.38,0.978991,0.0912059,4,1.57674,0.755121,-1.2604,0.497449,-0.194284,-0.0838352,-0.372978,0.43131,0.135763,-0.329876,-0.188003,-0.239248,-0.471276,0.961959,-0.699508,0.082211,0.143782,-0.154748,-0.72627,-0.11518,0.0138872,-1.04611,-0.588259,0.342083,-0.303895,-0.642486,-0.121985,-0.0827381,-0.280529,0.188839,0.736534,-0.351237,-0.228621,0.708922,-1.15388,0.364912,-0.543833,0.588883,-0.161581,-0.723015,1.19726,0.261207,0.542262,-0.510002,-0.532966,-0.131312,-0.928602,0.629726,0.0386341,0.220029,0.45415,0.287084,-0.0461193,-0.562296,0.357846,-0.156174,-0.26421,-0.721329,0.447564,-0.360679,-0.383146,0.652748,-0.123991,-0.97813,-0.322368,0.555869,-0.0366321,-0.285884,-0.149173,-0.206113,-0.125687,-0.0497402,0.427025,-0.237913,0.56205,0.453266,0.0911116,-0.00025135,0.0956732,-0.189102,0.684701,-0.254748,0.471133,0.400207,-0.335672,-0.075889,-0.11207,-0.374762,0.345986,-0.253738,0.216607,0.0679651,-0.199422,0.78087,-0.137739,-0.116449,-0.386113,-0.441378,0.0695165,0.172862,0.342496,-0.0827404,-0.423889,-0.219697,0.657656,-0.194687,0.144943,0.295925,-0.111322,0.503404,-0.119163,0.258862,-0.182817,0.481058,0.119947,-0.240315,-0.152609,0.322477,0.871289,0.191485,-0.427988,0.165009,0.0586656,-0.209382,-0.292592,0.163216,0.269256,0.185614,0.430647,0.284441,0.495207,-0.348856,0.420085,0.0639353,0.215411,0.087298,-0.243109,-0.283262,0.453029,-0.174742,-0.516881,0.175045,0.625026,-0.768721,0.349159,0.439455,-0.460522,0.252839,0.294523,0.134919,0.142287,-0.12814,0.887992,-0.288436,0.320329,0.628153,0.504815,0.0769589,-0.375198,0.102602,0.117027,-0.0689852,0.907026,-0.0537181,-0.196266,0.582881,-0.112896,-0.557914,-0.223264,-0.674894,0.107959,-0.595697,-0.035792,0.325998,-0.591253,0.112516,-0.593065,0.49835,-0.42289,0.680499,-0.679355,-0.0548746,0.0565371,0.621427,0.236041,0.171748,-0.37776,-0.735395,-0.0758653,-0.0559864,-0.229973,0.873198,0.152784,-0.580897,-0.0457812,0.0232619,-0.0298767,-0.422412,0.0528216,-0.507696,0.23446,-0.137763,0.216606,0.332591,-0.0226935,-0.735171,-1.03581,1.12461,0.0932176,-0.148782,-0.100175,-0.172089,-0.737706,0.114753,-0.295291,0.100322,0.342383,0.080468,0.327369,0.143032,-0.63589,-0.190355,-0.487141,0.370474,-0.503667,0.888323,-0.685945,-0.489687,-0.00310804,0.0459855,-0.82228,0.230506,-0.495342,0.00913845,-0.592115,0.0915832,-0.277723,-0.04914,0.7197,-1.22472,-0.0272957,0.288376,0.0865707,0.196052,0.580983,0.731053,0.417455,0.269201,-0.397229,-0.712389,0.464154,-0.297617,0.363992,-0.110519,-0.263708,0.336452,-0.277037,-0.0678728,0.474631,-0.0290654,0.363251,0.890843,-0.0323459,0.0518546,0.232203,0.166992,0.0451184,-0.393726,0.298471,-0.298567,-0.163109,-0.0501758,-0.138024,0.496719,-0.139041,0.161809,-0.231621,0.109591,-0.185833,-0.248726,0.162816,-0.288397,-0.399218,-0.377481,0.608631,0.157925,-0.231754,-0.183096,-0.292693,-0.133861,0.0776004,0.116452,0.211782,-0.350052,-0.278191,-1.09111,0.741753,0.396209,-0.57034,-0.292185,-0.0389509,0.187363,0.297834,0.432854,0.545742,1.09813 +3403.38,0.51443,0.0912059,5,1.59872,0.812189,-1.16589,0.436968,-0.139068,-0.0860127,-0.12444,0.244875,0.0330709,-0.455994,-0.128749,-0.184195,-0.249275,0.876999,-0.516959,0.319425,0.337532,-0.447652,-0.478309,-0.0450421,0.211407,-0.987906,-0.66809,0.226991,-0.374957,-0.640908,0.0709542,-0.0330574,-0.507953,0.222781,0.710674,-0.196934,0.0212761,0.340714,-1.09036,0.136629,-0.53602,0.285143,-0.100897,-0.49612,1.12729,0.549018,0.209358,-0.919454,-0.239238,-0.0989653,-0.959669,0.594171,0.143725,0.0498686,0.407454,0.636511,0.0278802,-0.660882,0.415696,-0.232573,-0.0121743,-0.553888,0.300561,-0.479596,-0.331122,0.979847,0.028033,-0.951733,-0.0634056,0.883578,0.13815,-0.0941579,-0.0941808,-0.460736,-0.611883,0.158955,0.396688,-0.340304,0.320655,0.323774,-0.0729011,-0.192726,0.125997,-0.362162,0.496498,-0.054762,0.396114,0.333979,-0.285786,-0.42617,-0.0214253,-0.405323,0.144941,-0.287826,-0.204469,-0.0183167,-0.201543,0.614572,0.0210821,-0.329434,-0.46784,-0.231054,-0.0159192,0.239274,0.250458,0.0494443,-0.429189,0.212921,0.636839,-0.393235,0.293689,0.201546,-0.174168,0.400082,-0.419276,0.246628,0.165089,0.292568,0.107429,-0.0751001,-0.286267,0.524465,0.691396,0.330354,-0.281145,0.0713972,-0.152332,-0.181883,-0.609175,0.473622,0.60481,0.207592,0.461455,0.211373,0.668311,-0.440144,0.198219,0.281493,0.357916,0.258135,-0.0388885,-0.037927,0.444738,-0.460146,-0.404903,0.211499,0.690286,-0.758751,0.0499802,0.528399,-0.330733,0.381258,0.133097,-0.0728939,-0.159218,0.0115185,0.697865,-0.0877789,-0.226877,0.63855,0.271185,-0.0274713,-0.447523,-0.385663,0.114308,0.0598043,0.78194,0.422952,-0.471375,0.663081,-0.252418,-0.351191,-0.25078,-1.1379,-0.133672,-0.899544,0.0572499,0.184425,-0.641726,0.142721,-0.390131,0.154257,0.505213,0.577463,-0.552257,-0.151617,0.141667,0.653458,0.0256972,0.0239831,-0.162529,-0.578334,0.0141281,-0.173242,-0.0180563,1.12964,-0.215853,-0.55375,0.0672468,0.145328,0.114049,-0.792213,0.024176,-0.367947,-0.0136062,-0.103401,0.248704,0.204979,-0.0789064,-0.18866,-1.05441,1.05799,-0.302786,-0.0606068,-0.106123,-0.1914,-0.508885,0.257352,0.0528331,0.154424,-0.089509,0.0529,0.592375,0.190948,-0.297859,-0.644668,-0.374599,0.453641,-0.109811,0.686905,-0.502544,-0.234921,0.363832,-0.13237,-0.801818,0.0743212,-0.292619,-0.175261,-0.384809,0.331679,-0.0859634,-0.122,0.825414,-1.18007,-0.0782999,0.53957,0.0401186,0.230847,0.38751,0.776307,0.410483,0.281236,-0.34685,-0.683797,0.42412,-0.370993,0.518034,-0.0315781,-0.37322,0.528255,-0.384759,0.0749946,0.0921559,-0.0662923,0.105718,0.631379,0.131652,0.424278,0.315621,0.0900638,0.0424967,-0.490453,-0.0599431,-0.419356,0.0857694,-0.240721,-0.066203,0.495654,-0.182292,-0.10287,-0.195545,0.156333,-0.504282,-0.3454,-0.206897,-0.0600358,-0.0486148,-0.277782,0.342019,0.269488,-0.0339922,-0.275012,-0.188509,-0.174515,0.0238845,0.0596095,-0.147922,-0.131134,-0.251833,-1.23536,0.759113,0.144425,-0.317674,0.158299,0.068841,0.18533,0.269763,0.4305,0.519387,0.84416 +3388.74,0.993511,0.0912059,4,1.64161,0.747706,-1.14029,0.479046,-0.203867,-0.0878125,-0.0873306,0.334604,0.0372913,-0.304019,-0.0719111,-0.0251464,-0.175806,0.994577,-0.390983,0.888506,0.193287,-0.539057,-0.376943,-0.0997134,0.140338,-0.949636,-0.400771,0.316363,-0.31549,-0.314563,0.450658,-0.403644,-0.383568,0.302568,0.814903,0.0322109,-0.137505,0.455288,-0.981989,0.185167,-0.0378247,0.0220439,-0.179254,-0.450607,1.1683,0.580348,0.211125,-0.795448,-0.372284,0.504982,-0.866074,0.507696,-0.0514021,0.0685743,0.368455,0.612614,0.142511,-0.508131,0.506762,-0.080731,0.0918624,-0.477321,0.0827784,-0.682843,0.0806351,0.629654,-0.0363759,-0.595394,-0.246731,0.516605,0.16023,-0.0826385,-0.143913,-0.522845,-0.623209,0.494447,0.44339,-0.0588781,0.569548,0.435318,0.272762,0.257478,0.202863,-0.396799,0.773064,0.0965459,0.555054,0.570749,0.0888304,-0.343672,0.186387,-0.233781,-0.055751,-0.474611,-0.434523,-0.236897,0.136207,0.480096,-0.359931,-0.497038,-0.408487,-0.216307,0.47118,0.0393814,0.435678,0.101974,-0.6407,0.234994,0.820463,-0.193193,-0.212207,0.218677,-0.249377,0.0995896,-0.586888,0.200895,0.457928,0.311398,0.0368468,-0.276203,-0.0800412,0.17956,0.0560012,0.507068,-0.543223,0.348879,-0.190321,-0.260274,-0.876022,0.344047,0.769182,0.431563,0.69622,-0.112679,0.545733,-0.349468,-0.141705,0.668816,0.177093,0.0302244,-0.189399,-0.211955,0.111484,-0.408267,-0.920385,0.298879,0.801406,-0.453648,0.195154,0.375392,-0.266925,0.249135,0.042523,-0.0929338,-0.345988,-0.175736,0.801277,0.268187,-0.098645,0.834673,0.170329,-0.0912629,-0.644657,-0.105634,0.184076,-0.0981446,0.743197,0.20075,-0.422453,0.193495,0.261602,-0.44953,-0.0451903,-1.02986,-0.185387,-0.813877,-0.110184,0.00848466,-0.15627,0.0354828,-0.548108,0.159306,0.411899,0.875739,-0.661282,-0.408836,0.00819047,0.41782,-0.0473264,0.153009,-0.13246,-0.471915,-0.250699,0.137649,-0.0631316,0.542174,0.380891,-0.12006,0.336658,0.38792,0.111511,-0.204069,0.0778065,-0.260504,-0.161177,-0.0230716,0.372861,-0.0727291,-0.0198534,-0.483458,-0.836326,1.08167,-0.210711,-0.3006,-0.392726,0.00340826,-0.396792,0.951429,0.0411411,0.24267,-0.396198,-0.166379,0.521389,-0.216599,0.257799,-0.660477,-0.12942,0.682377,-0.22708,0.993919,-0.409652,-0.352582,0.00563791,0.0286636,-0.745873,-0.0699008,-0.563845,-0.174956,-0.275077,0.507654,0.0961675,-0.306518,0.949172,-1.33874,-0.208976,0.726498,0.41621,0.0447833,0.20814,0.392032,0.581484,0.542982,-0.193696,-0.877785,0.447635,-0.797843,0.36071,-0.202909,-0.412602,0.565463,-0.607108,0.294643,0.178345,-0.1718,0.00725623,0.662178,-0.215977,0.713157,0.820979,-0.0368051,-0.101857,-0.225921,0.440661,-0.158793,-0.0858515,-0.639759,-0.195464,0.254826,-0.313663,-0.137645,-0.282592,-0.0448763,-0.496706,-0.519215,-0.187767,0.281659,0.0182161,-0.104411,0.285309,0.240672,-0.0016528,0.0146404,-0.187099,-0.291825,-0.214101,0.264083,-0.335732,-0.347954,-0.20423,-0.887566,0.579856,0.221345,0.0354747,0.464009,0.139457,0.178324,0.270479,0.422284,0.520076,1.16327 +3400.1,0.849913,0.0912059,4,1.49245,0.880345,-0.569007,0.110405,0.215382,-0.0105245,0.450247,-0.753421,0.360106,0.24336,-0.0311175,0.0413865,0.178281,0.634636,0.0595249,0.76689,0.182031,-0.08139,0.295056,0.309455,-0.117973,-0.757441,-0.807645,0.468634,-0.0565445,0.087975,-0.0291193,0.908247,-0.0855078,0.409945,1.00226,-0.695801,0.167131,0.322865,-0.127134,0.177282,-0.564739,0.374099,0.515274,-0.311782,1.28412,0.276237,0.314327,-0.353365,0.183677,-0.431815,-0.0456305,0.031279,0.795794,0.0243994,0.398946,-0.135854,0.272874,-0.292329,0.720464,-0.237066,-0.0162826,-0.933488,0.332655,-0.201172,0.252712,1.06822,-1.11629,-0.803691,0.277084,-0.298944,0.103374,0.138766,0.642507,0.0313371,0.493775,0.016317,0.460026,0.0718548,0.658701,0.628368,0.255898,-0.527157,-0.845182,0.15535,0.741612,-0.426181,-0.157295,-0.134364,-0.248953,0.263075,-0.12017,-0.219307,-0.188092,-0.401579,0.390905,0.519323,-0.0978418,0.104062,0.267815,0.107211,0.237488,-0.0238905,-0.0881333,-0.253069,-0.0571501,-0.189917,-0.441497,-0.216887,-0.252322,-0.747821,0.64929,-0.187901,0.779475,0.795473,0.189579,-0.561144,0.243164,0.870668,0.265495,0.114749,-0.156664,0.130182,0.900204,-0.225879,-0.603399,-0.620963,0.0157106,0.498563,0.719565,0.711047,0.264318,0.541687,-0.156543,-0.560006,-0.323679,0.0223917,0.358205,0.545897,-0.262009,-0.248103,0.0679847,-0.178931,0.377091,-0.467023,0.186969,-0.411432,-0.611093,-0.274869,-0.34126,-0.0893961,0.407089,0.00515581,-0.428916,0.0171969,-0.0990702,0.376647,0.190799,-0.628328,0.377858,0.337901,0.349488,0.170327,0.0249207,-0.220986,0.325761,-0.31277,0.976821,-0.741153,0.259031,0.144198,-0.161377,0.100604,-0.337571,0.842088,0.448435,0.282927,0.32083,-0.394066,-0.262973,0.164722,0.267527,0.413076,0.252877,0.812748,0.871809,-0.533734,0.268351,-0.477129,0.240005,-0.451094,0.169385,0.164897,0.436764,-0.836535,-0.139991,-0.294093,-0.290812,-0.812497,-0.315568,0.094262,-0.129553,-0.667655,-0.52787,0.288508,-0.134337,-0.279762,0.329153,-0.25019,-0.0629723,0.443551,-0.659836,0.596926,0.126959,0.66751,0.331449,0.238626,0.42043,-0.87714,0.125582,0.420181,-0.16021,-0.221171,0.396964,-0.318336,-0.837869,-0.0729607,-0.019002,-0.117687,-0.567527,0.19615,-0.294985,-0.282494,0.121108,-0.0585467,0.0809304,0.421053,0.589307,-0.442009,0.0508596,0.632116,-0.0119017,0.505175,0.421625,0.208617,-0.241651,-0.381651,-0.605321,0.371987,0.314702,0.156962,0.346605,-0.41604,-0.00737912,-0.147536,-0.367876,-0.185589,0.45512,-0.265067,0.0650506,-0.46739,-0.380856,0.0930829,0.0168358,-0.00703498,0.256336,0.0086213,0.298802,-0.332803,-0.188029,-0.0776554,-0.218932,0.361035,-0.450765,0.0249266,0.23118,-0.519847,-0.231619,0.251791,0.431672,0.533689,-0.466901,0.315755,0.68455,0.157939,0.0514155,-0.519348,-0.969899,0.160058,0.151937,-0.235199,-0.504615,0.747601,0.0482894,0.184574,0.195328,-0.125516,-0.0388134,0.765561,0.0424947,0.312646,-0.186091,-0.0611484,-0.224409,-0.826232,0.0490708,0.169058,0.240046,0.411167,0.489945,-0.582085 +3392.69,0.555311,0.0912059,4,1.48141,0.712111,-0.609324,0.0631617,0.0800215,-0.00861437,0.252417,-0.618295,-0.0540144,0.0709742,0.335599,-0.331911,0.316783,0.555468,0.0633809,0.875625,0.470974,0.194178,-0.183626,0.768581,-0.123204,-0.698757,-0.547551,0.564452,-0.364527,-0.537065,0.144547,0.0637388,-0.709362,-0.0366339,0.944204,0.131533,-0.443871,0.0625841,-0.247754,0.622831,-0.382391,0.30367,-0.379576,-0.33155,1.819,0.6068,0.0394819,-0.0717899,-0.0621444,-0.595786,0.127189,0.332898,0.731732,-0.077837,0.708421,0.164865,0.528238,-0.423112,1.02027,-0.239097,0.555891,-0.572445,0.865774,-0.322754,0.193114,0.862702,-1.05396,-0.933054,0.157049,0.0176377,0.203881,0.17578,0.122012,-0.629467,-0.0472004,0.388958,0.691262,-0.485908,0.819959,0.53494,0.486833,-0.220493,-0.571013,0.282653,0.712065,-0.772229,0.269857,-0.695393,-0.448406,-0.492798,0.161789,-0.283698,0.0336322,-0.492348,0.0637499,0.204027,-0.0626311,0.110823,-0.0632047,0.0243912,0.375782,0.313477,0.0556572,-0.201251,-0.179192,0.237794,-0.343838,0.0555116,-0.103846,-0.505211,0.0372548,-0.102864,0.107203,0.0102304,-0.170158,-0.19924,0.297193,0.832221,0.335136,-0.415939,-0.064413,0.654178,0.0978474,-0.509285,-0.81742,-0.840506,0.347525,0.194498,-0.146044,0.886498,-0.482463,-0.0274646,0.104919,-0.118522,0.182666,0.0995812,-0.252732,0.0328249,-0.431094,0.262853,0.344605,-0.406846,0.604703,-0.845293,-0.33445,-0.392084,0.39884,-0.397998,-0.413918,0.376999,0.579401,0.713813,-0.341299,-0.750369,0.0690722,0.437629,0.95522,-0.00768712,0.335391,1.00821,-0.136493,0.452769,-0.103114,-0.368827,0.174611,0.239054,0.844309,0.573455,-0.720774,0.023892,-0.155946,0.315376,0.0877232,0.21451,-0.148394,0.333731,0.556916,-0.0161205,0.223094,0.513423,-0.498429,0.166385,-0.0215706,0.94641,0.486785,-0.203368,-0.229926,0.127821,0.6499,-0.221218,-0.903115,-0.27112,0.276602,-0.687894,0.235356,0.352405,0.197547,-0.688524,-0.479386,0.427613,-0.184943,-0.467745,-0.21466,0.229439,-0.29036,-0.462486,0.45231,-0.199622,-0.345503,-0.000623067,-0.575092,0.990627,-0.192153,0.235182,0.159133,0.356819,-0.678841,-0.089997,-0.0637867,0.867366,0.0755984,-0.356162,0.506803,-0.487593,0.421992,-0.938565,0.696472,-0.0397773,-0.763989,0.445824,-0.0322721,-0.127825,0.249007,0.173706,0.359134,0.607847,0.485139,-0.535323,0.278487,0.388617,-0.378453,-0.251346,0.717421,-0.117516,-0.510908,0.044514,-0.414895,0.278615,0.764205,0.264105,0.259555,-0.257873,-0.50055,-0.683387,-0.0209417,-0.841812,0.401918,-0.151237,-0.21901,-0.628756,-0.681371,-0.129021,0.0914206,-0.547862,0.172306,0.935149,0.0855565,0.180669,0.460137,0.565095,-0.216657,-0.371228,-0.511808,-0.00600352,0.105874,-0.200951,-0.237971,0.253724,0.39717,0.110516,-0.0590985,0.0419624,0.0976662,0.215819,-0.208444,0.0230099,-0.613683,-0.199973,0.200587,0.434327,-0.146811,-0.0702319,0.391488,-0.00305446,0.6441,-0.0724093,-0.371603,0.194033,-0.294777,-0.631282,0.0574979,-0.113172,0.245754,-0.501112,-0.255492,0.165732,0.334198,0.407102,0.578098,0.219183 +3363.2,0.996095,0.0912059,4,1.52466,0.812206,-1.09291,0.128191,0.682987,-0.0303067,-0.0913259,-0.457704,0.0663454,-0.157554,0.148971,-0.120819,-0.395541,0.0770584,-0.456957,0.43286,0.0924059,-0.0983319,-0.322013,-0.18525,-0.483077,-0.992936,-1.533,0.291924,-0.377878,-0.331102,-0.0148137,0.418064,-0.483765,-0.749203,0.627423,-0.85907,0.235368,0.348093,0.331127,0.256001,-0.302308,0.426914,0.597061,0.180584,1.67064,0.604667,0.0750134,-0.0613321,0.525357,0.136864,-0.154363,0.0996131,0.600874,0.445658,0.786991,0.325599,0.0491476,-0.812429,0.944792,-0.257861,0.199814,-0.654176,1.15907,-0.280952,0.351773,1.04604,-0.0482359,-0.68453,1.0981,0.241421,0.566331,0.113333,0.0730445,-0.688047,-0.215426,0.0929143,0.604354,0.268907,0.238784,0.496036,0.0349899,0.600768,-0.242832,0.0900442,0.43004,0.848588,-0.45742,0.140811,0.164797,-0.133897,-0.422958,0.364483,0.420813,-0.356295,-0.314524,-0.202286,0.0669095,0.414428,-0.43955,0.0044407,0.093502,0.0280949,0.22382,0.111158,0.16093,-0.0893825,-0.274868,-0.140098,0.17065,-0.544785,0.352415,-0.151292,0.334689,0.495168,-0.178637,0.0458115,0.465193,0.821552,0.558865,0.366778,-0.559553,-0.512025,1.00848,0.173476,-0.382863,0.54375,-0.0525198,-1.08791,-1.34394,-0.0893868,0.738898,0.427995,-0.0867885,-0.701119,-0.662229,0.00182558,0.176772,1.19722,0.114167,-0.839937,-0.16665,-0.426492,0.46242,-0.691523,-0.275325,-0.186026,0.166224,-0.382069,0.393322,-0.294136,0.15047,0.634666,-0.0977188,-0.552374,-0.279917,-0.414254,-0.0705516,-0.378699,0.572851,-0.0549711,1.19777,-0.337682,-0.0799933,0.269236,0.846368,-0.17149,0.468695,-0.933608,-0.381435,0.338571,0.132249,-0.220725,-0.900127,-0.468238,1.08433,0.137166,0.487386,-0.512365,-0.184,-0.00119583,-0.257553,0.237688,0.73325,0.800071,0.410996,-0.398996,-0.965862,-0.591583,-0.190938,0.280227,0.481644,-0.49264,0.109918,-0.684234,-0.17363,-0.0355539,-0.382611,-1.02832,0.100233,0.0653446,-0.337796,0.155011,-0.606382,0.277762,-0.333838,-0.365474,0.393663,-0.201552,0.30381,-0.23843,0.294643,0.842232,-0.233685,-0.118893,0.0107996,0.112648,0.550788,0.135773,0.0175243,0.510269,-0.330042,0.122603,0.0883927,-0.925215,0.119106,0.102838,0.134942,0.0453576,0.302491,0.61938,0.0099442,-0.764469,0.31237,0.356767,-0.394601,0.559499,-0.557412,-0.351352,-0.374313,0.664065,0.319363,0.266335,0.670776,-0.208988,-0.16239,-0.369732,0.369881,0.448098,-0.240137,-0.0315755,0.215343,0.392039,-0.315227,0.0502619,-0.557037,-0.735571,0.244246,-0.413834,-0.753086,0.528299,0.150365,-0.0488298,0.396118,-0.0637911,0.0455466,0.0260932,-0.425477,-0.489496,-0.142361,0.329748,-0.112755,-0.741724,0.093788,-0.127634,0.0856951,-0.392134,-1.47751,-0.317169,0.255502,-0.0213447,-0.329326,-0.00130252,0.216274,0.133692,0.0176416,-0.801167,-0.348848,-0.156785,0.0558186,0.670348,-0.921362,0.727685,0.289335,0.453981,0.344279,0.745378,0.405711,0.860477,0.0465833,0.101981,0.0580085,0.238954,-0.270761,-0.308282,-0.6275,0.223872,0.321191,0.473151,0.566737,-1.71841 +3356.77,0.80173,0.0912059,5,1.4874,0.897084,-1.06385,0.175022,0.778824,-0.163824,-0.470383,-0.446294,0.0673116,-0.138602,0.323718,-0.263813,-0.109298,-0.166149,-0.159761,0.466528,-0.0642638,-0.0324093,-0.0683118,-0.317342,-0.368283,-1.19495,-1.74118,0.119857,-0.505035,-0.523679,-0.185,0.408475,-0.361747,-0.829282,0.432433,-0.233995,0.330714,0.282816,-0.0631444,0.225639,-0.332312,0.336405,0.595019,0.0429169,1.35659,0.671605,-0.00357444,0.0146543,0.387762,0.387145,0.0647035,0.35954,0.588578,0.377912,0.702742,0.500272,0.202789,-0.483018,0.972657,-0.353541,-0.0154113,-0.644504,1.03241,-0.619341,0.351425,1.15477,-0.458491,-1.06974,0.879532,0.401424,0.580461,0.177128,0.278231,-0.73575,-0.0581449,0.184772,0.810801,0.341882,-0.280363,0.260863,0.107115,0.441347,-0.635277,0.113803,0.391548,0.513962,0.00287737,-0.00552918,-0.0238281,-0.333402,-0.361613,0.152365,0.322753,-0.221137,-0.528288,-0.342968,-0.0556422,0.463368,-0.209249,0.47646,-0.0199598,0.413159,0.368062,0.352255,0.141473,-0.202695,-0.396256,-0.264357,0.0886487,-0.99013,0.105664,-0.422311,0.381374,0.281477,-0.165503,-0.0720458,0.236311,0.68123,0.641395,0.0333098,-0.467848,0.0439163,0.773723,0.0448101,-0.359625,0.836855,-0.026508,-1.01285,-1.19158,0.106032,0.795575,0.275862,-0.24707,-0.937993,-0.408785,0.226774,0.268767,0.964295,-0.0763258,-0.869122,-0.228163,-0.211503,0.347228,-0.764488,-0.0845613,-0.310514,0.0700439,0.193511,0.622759,-0.0709177,0.186369,0.66873,0.0172654,-0.576075,-0.162057,-0.142134,-0.062517,-0.147135,1.11622,0.0562282,1.02121,-0.295624,-0.249179,-0.0882405,0.75183,-0.119657,0.613166,-0.490274,-0.242322,-0.2987,0.121469,0.0228858,-0.81175,-0.383798,0.931184,-0.16083,0.286427,-0.144545,-0.141214,0.0225794,-0.36067,0.341217,0.316021,0.524677,0.364642,0.00154116,-0.570283,-0.591172,-0.149899,0.368716,0.837452,-0.171855,0.219813,-0.736736,0.0204493,-0.145633,-0.105748,-1.06918,-0.0949826,0.316574,-0.188258,-0.453542,-0.821893,0.126624,-0.120125,-0.569136,0.630381,-0.0642604,0.0248235,-0.142674,0.421695,0.923122,-0.14895,0.175356,-0.0384971,-0.177397,0.421589,0.112929,0.201927,0.330939,-0.513894,0.253474,-0.634722,-1.19234,0.0808849,-0.306427,-0.32969,-0.228365,0.400947,0.511406,-0.171237,-0.524004,0.328615,0.558259,-0.372832,0.332673,-0.36642,-0.114476,-0.295932,0.174567,0.478895,0.311475,0.785519,0.00893174,0.00748747,-0.267948,0.222192,0.398881,0.0563193,0.138425,-0.175268,0.279383,-0.114146,-0.00556752,-0.709494,-0.277076,0.0383932,-0.416258,-0.670345,0.48207,0.138415,-0.100424,0.315618,-0.0525854,0.369118,0.196117,-0.1623,-0.430496,-0.318254,-0.0967357,0.235619,-0.815299,0.323698,-0.0990178,0.0883345,-0.631597,-2.04859,-0.196608,0.272589,-0.311231,-0.275338,-0.0115805,0.145803,0.177835,-0.162269,-1.0018,0.23548,-0.654285,-0.22621,0.211406,-0.820564,0.829066,0.158935,0.15098,0.560908,0.582161,0.166087,0.973709,-0.136183,-0.181755,0.237444,0.362551,-0.748308,-0.312056,-0.480527,0.209094,0.36985,0.457268,0.608153,-2.25019 +3352.28,0.752016,0.0912059,5,1.55122,0.695621,-0.49093,0.216857,-0.0432342,-0.0453193,-0.480392,0.534503,0.521013,0.505829,-0.261101,0.066713,-0.220436,0.641472,0.269376,-0.113151,0.157808,-0.121172,0.113977,-0.0539387,-0.00609824,-0.719792,-0.468638,0.446204,0.06873,-0.225403,0.111053,-0.0624951,-0.304181,0.389625,1.00994,-0.713523,0.154046,0.569013,-0.327828,-0.146479,-0.574767,-0.274576,0.513358,-0.831117,0.791926,0.0553962,-0.155104,-0.591978,-0.302615,-0.244893,-1.00344,-0.425645,0.432873,-0.0625976,-0.312298,-0.419814,0.427084,-0.302331,0.983122,-0.0218748,-0.227606,-0.374673,0.484164,0.150765,0.418226,0.738105,-0.57876,-0.520992,-0.811235,0.0329663,-0.940176,-0.0525544,0.145429,0.177513,0.144206,0.289413,0.864757,-0.677941,1.48885,0.986021,0.385211,-0.43938,0.540006,-0.178209,0.338146,-1.19845,0.440491,-0.296816,0.0132229,0.217051,0.459622,-0.553676,-0.253747,-0.109221,0.396345,0.58539,0.0162607,-0.227778,-0.116474,-1.16007,0.140417,-0.917805,-0.15475,0.319077,-0.152124,-0.373241,-0.394096,-0.13376,0.35798,0.470461,0.673392,-0.0836438,0.306723,0.89251,-0.119614,-0.115564,0.171305,0.414529,-0.188488,0.0359052,-0.108889,-0.171113,0.0832457,0.0125045,-0.863265,-1.03457,-0.28687,0.747075,0.818539,0.225485,-0.221384,0.239894,0.800835,-0.00497303,0.496622,-0.0211448,0.128164,0.255942,-0.112428,0.337715,0.198174,0.525418,0.438612,-0.277754,-0.533969,0.0834771,-0.0789553,-1.14343,-0.233954,-0.274471,-0.171795,-0.449063,0.00694245,0.473694,-0.332569,-0.0186887,0.437713,0.357529,-0.393014,0.691942,-0.2714,0.215226,0.12202,-0.216327,-0.415883,0.189981,1.02625,0.642862,0.157907,0.567326,-0.0972276,-0.119747,0.323033,-0.0312304,-0.113409,0.206952,-0.103678,0.264309,-0.679262,0.0962574,-0.238461,-0.257425,0.250509,0.715678,-0.327459,-0.28314,1.0514,0.396379,-0.367257,-0.851162,-1.26121,-0.0254739,0.0785552,-0.125789,0.346825,0.337652,0.1441,-0.114013,0.134473,0.151372,0.468107,-0.0840313,-0.289018,-0.0656417,0.196215,0.0815079,0.121368,0.022344,-0.123746,0.00335028,-1.74858,0.916021,0.0671742,0.624342,0.177113,0.487818,0.27513,0.196646,-0.4962,0.479955,0.0554941,0.212501,0.656134,0.273389,0.137261,-0.800646,0.466551,0.530865,-1.25241,0.42845,-0.601795,0.448971,-0.267616,-0.419464,0.00811775,0.0594725,0.144275,-0.0532962,-0.291654,0.206175,-0.247847,-0.250836,0.623568,-0.856042,-0.239348,0.484137,-0.889302,-0.75421,0.988365,0.317677,0.674335,0.229436,-0.191613,-0.763219,0.46551,-1.01374,0.424542,-0.149381,0.0303441,0.623935,-0.523368,0.144713,-0.188263,0.175097,-0.128046,-0.00474333,-0.243615,0.528097,0.627883,0.268955,-0.102213,0.0486956,-0.294291,0.301139,-0.565298,0.508052,0.953035,-0.184418,-0.213199,-0.0316026,-0.237524,-0.641078,0.0736631,0.267729,-0.653555,0.737672,-0.980389,-0.165817,-0.00746879,0.234929,0.172004,-0.582578,-0.0229965,-0.704899,-0.0653997,-0.554487,0.0272898,-0.166243,0.0530146,-0.515853,-0.0948623,-0.316763,0.368822,0.00397241,0.489387,0.248833,0.231943,0.498831,0.481605,0.528534 +3349.39,0.886122,0.0912059,5,1.58665,0.717365,-0.673409,0.248501,0.022629,-0.101702,0.312869,0.383561,-0.0573814,0.154297,-0.0575528,-0.221065,-0.380644,0.828576,0.107447,0.731063,0.141624,-0.265269,-0.194493,-0.330331,0.0893294,-0.731342,-0.364126,0.256813,-0.19145,-0.0920435,-0.309804,-0.353543,-0.00568625,0.535779,1.00402,-1.30864,0.142283,0.50504,-0.377136,-0.25897,-0.916791,-0.058064,0.0753853,-0.40372,1.04224,0.252881,-0.617298,-0.523443,0.136744,-0.53361,-0.643985,-0.376217,0.52423,-0.0241708,0.10038,1.31961,0.348715,-0.613564,1.03769,0.028292,-0.161248,-0.562436,0.52757,0.183274,-0.0704145,0.996233,-1.07592,-1.08394,-0.213383,0.470933,-0.452707,0.340435,0.0966862,-0.246394,0.231625,0.27272,0.400322,-0.00517895,1.02108,0.702968,0.360447,-0.261002,0.0366335,0.27093,0.61595,-0.545838,0.12882,-0.802902,0.630891,0.391034,-0.148852,-0.595493,0.187425,-0.343781,0.845807,-0.501437,-0.139223,-0.385326,0.0856331,-0.74729,-0.0104501,-0.453057,-0.0157595,0.221016,-0.1842,-1.18742,-0.269667,-0.362119,-0.181002,0.365515,0.59154,-0.329109,0.126748,0.88689,0.0603911,-0.205085,0.180486,0.360111,-0.501198,0.0717991,-0.121018,-0.118804,-0.598509,0.286124,-1.25509,-0.994195,-0.209214,-0.158499,-0.140365,-0.327211,-0.566184,0.128881,0.567547,-0.355362,1.11933,-0.058654,-0.365201,0.0252387,0.291428,0.394662,-0.513618,0.0995363,0.383096,0.231093,-0.655801,0.299414,0.212442,-0.880586,0.197621,-0.0556525,-0.2443,-0.273107,-0.585888,0.442909,0.0689755,-0.580479,0.2756,0.0827152,-0.0163969,0.170828,-0.323607,0.152725,-0.366831,0.255813,0.647341,-0.407751,0.469335,0.676799,0.573519,0.125191,-0.0739539,-0.0617954,-0.182083,-0.139803,-0.233042,0.78469,0.0656478,-0.101337,0.613842,0.240514,-0.407622,-0.315503,-0.0809569,0.566686,-0.298745,-0.222654,0.924775,0.233021,-0.383568,-0.940153,-0.536139,-0.250033,0.00862193,0.125336,-0.0746954,0.375038,-0.239901,-0.391744,0.46648,0.0525788,0.704551,-0.111223,-0.0900049,-0.186357,0.236907,-0.026928,-0.186466,-0.0902832,0.0927698,-0.400009,-2.23674,1.04942,0.521408,-0.335264,-0.514528,0.0987796,0.419068,0.178767,-0.616393,0.653418,-0.106403,0.354699,0.787531,0.589116,0.129841,-0.29576,0.274056,-0.219744,-1.14202,0.582525,-0.459119,-0.0770601,-0.218031,-0.949585,-0.652485,0.00166145,-0.160282,-0.101188,-1.0668,0.526742,-0.21033,-0.312533,0.567552,-1.22885,-0.18801,0.769092,-0.631824,-0.373936,0.929669,0.26204,0.6748,-0.130247,-0.264724,-0.136551,0.396769,-0.870978,0.782795,0.0653636,-0.544159,0.532897,-0.350307,-0.227905,0.0456271,0.521771,0.0574057,0.356801,0.834473,0.496627,0.151537,0.0488238,-0.214419,0.133697,-0.125498,-0.293879,-0.268884,0.13612,0.64708,-0.06844,0.100867,0.064198,0.42088,-0.481955,0.739721,-0.305394,-1.02792,0.159095,-1.17405,0.306027,0.188293,-0.142122,0.274635,-0.466251,-0.196493,-0.682195,0.0350121,-0.348491,0.0950924,-0.0333397,-0.301788,-0.914986,0.0629981,-0.392593,0.0359321,-0.823707,0.413569,0.232107,0.30306,0.481774,0.550509,0.386838 +3384.4,0.798895,0.0912059,4,1.51481,0.803294,-0.860569,0.440166,-0.0327754,-0.00227474,-0.260365,0.182358,0.669207,0.0299131,0.100217,0.200255,-0.485236,0.419252,0.164006,1.11825,0.49018,0.00486715,-0.582622,0.235686,0.00379596,-0.601964,-1.00561,0.192822,0.261395,-0.627033,0.12037,0.58961,0.197333,0.584582,0.881524,0.0622968,-0.344963,0.557083,-0.506889,0.114046,-0.306711,1.03534,0.620808,-0.591727,1.32238,0.615879,0.232172,-0.688357,-0.510638,-0.299121,-1.41439,0.57587,0.799281,-0.132441,0.469059,-0.802735,0.180705,-0.988691,0.575249,-0.106335,-0.150106,-1.02084,0.0998642,-0.171772,0.44579,0.567445,0.126369,-0.53598,-0.207967,0.442414,-0.504082,-0.649459,0.571668,0.0619287,-0.329457,1.03039,1.04355,-0.489147,-0.0771962,0.759843,0.509602,0.647407,-0.159509,0.233829,0.354699,-0.210338,0.838605,-0.0627541,-0.198661,-0.196415,0.0618871,-0.127495,-0.932075,-0.185884,0.142508,-0.0116584,-0.161963,0.187492,-0.0490775,0.21951,0.189376,-1.02656,0.398874,0.0768673,0.270111,0.344157,-0.717484,-0.592813,0.0609457,0.0701461,0.525754,-0.528045,0.601081,-0.0172262,-0.464988,-0.432133,0.394446,0.267677,0.196172,-0.05401,-0.00059504,0.302201,0.0970255,-0.268901,-0.896528,-0.389877,-0.159998,0.288154,-0.207311,0.11087,0.345555,-0.0659471,0.416642,-0.263653,0.0397034,0.0582667,0.16435,0.372967,0.0230924,-0.342763,0.72664,0.109358,0.712398,-1.08431,0.198552,0.137445,-0.275451,0.408913,0.472075,0.120727,-0.0528029,0.33464,0.357296,-0.0443986,-0.231764,0.201979,-0.047506,-0.212591,0.342457,0.376355,0.0971089,0.418404,-0.366337,-0.210875,0.279137,0.0111738,1.03473,0.174664,0.0414232,0.221392,-0.331849,-0.410163,-0.457792,-0.175743,0.226626,0.287808,-0.227604,0.159184,-0.42034,0.804167,-0.629982,-0.510577,-0.164172,0.913309,-0.35573,-0.574714,0.514591,-0.422998,0.231879,-0.408797,0.266438,0.0332119,-0.00799514,-0.375163,0.373391,-0.307988,-0.257504,-0.894306,-0.0333825,0.979403,-0.181703,-0.225173,-0.262549,-0.448662,0.225455,-0.567967,0.869919,-0.157236,0.223803,-0.23334,-1.06788,0.99347,0.333014,0.111562,0.00619214,-0.200304,0.124432,0.259593,-0.128337,-0.542447,-0.519194,-0.109541,0.337349,-0.808348,-0.110599,-1.03121,0.546513,1.08882,-1.14818,0.0836651,-0.495197,-0.394671,0.120797,0.456828,0.736299,0.0381509,-0.202449,-0.667138,-0.208984,0.334534,0.511865,0.803971,0.53032,-0.729829,0.0938194,-0.600127,0.402541,0.324467,-0.179172,0.436843,0.552671,0.493493,0.53978,-0.257596,-0.222225,-0.455458,0.503308,-0.127643,0.348882,0.24932,-0.606814,-0.0332609,0.743755,0.147392,0.223013,0.187118,-0.320738,-0.364311,-0.656579,-0.251241,0.298845,-0.0154761,0.488729,-0.217486,-0.108075,-0.165896,-0.58193,-0.466475,-0.301218,0.104903,-0.372007,-0.0681897,0.665558,0.0664611,0.0373002,0.0635939,-0.593288,-0.296483,-0.210923,0.319176,-0.622085,-0.226474,-0.0225719,0.0568867,0.0493827,0.0214629,0.0187322,0.199798,0.0310485,-0.865942,-0.47651,0.120979,-0.26861,-0.31399,-0.056149,0.176053,0.311108,0.419586,0.557771,0.238716 +3376.17,0.950943,0.0912059,4,1.53505,0.80832,-0.847758,0.447364,0.10457,-0.0378724,0.172725,0.120542,1.03389,0.0533296,0.00780812,0.14686,-0.316018,0.568295,0.152681,1.0772,0.247848,0.081049,-0.755626,0.19207,0.152995,-0.6888,-0.667329,0.26536,0.200165,-0.646197,0.255962,0.525182,0.0753962,0.397016,0.894674,-0.145333,-0.165538,0.451063,-0.577996,0.255995,-0.262713,0.720191,0.811932,-0.661829,1.04084,0.69549,0.619635,-0.672146,-0.611283,-0.322609,-0.965826,0.36941,0.539099,-0.131031,0.342358,-0.682925,0.00565499,-0.646637,0.388088,-0.373819,-0.0286846,-0.873478,0.303205,-0.156039,0.376018,0.692451,0.479209,-0.438398,-0.191816,0.254211,-0.126526,-0.70685,0.299125,0.0161312,-0.218037,1.18594,1.1194,-0.228669,0.196347,0.697401,0.66147,0.580614,-0.317688,0.324395,0.529614,-0.0767542,0.593815,-0.130945,-0.0729567,-0.191127,0.0970767,-0.19521,-0.938494,-0.10007,-0.11152,0.0989574,-0.367562,0.323061,0.215268,0.117987,-0.266163,-1.19723,-0.0880597,0.0687273,0.165715,0.638413,-0.390042,-0.596384,0.326615,-0.0340741,0.723387,-0.586059,0.277224,-0.0305811,-0.185457,-0.362536,0.44847,0.238993,0.305926,0.0225204,0.0629799,0.29847,-0.106928,-0.297094,-0.492104,-0.376019,-0.418389,0.279398,-0.0770451,0.280628,0.176605,0.0272603,0.437073,-0.355525,0.037295,-0.130039,0.0115289,0.0554697,0.215156,0.0246778,0.749902,0.0852506,0.501622,-1.32771,0.220595,0.0992854,-0.399497,0.253971,0.582859,0.390199,-0.0132039,0.0548953,0.024754,-0.228587,0.117349,0.163639,-0.14345,-0.317149,0.562035,0.149332,0.13147,0.321262,-0.470814,-0.113735,0.502049,-0.0433018,1.1235,-0.148524,0.208237,0.189948,-0.303796,-0.52937,-0.349849,-0.0507905,-0.106998,-0.0554278,0.000952167,0.120442,-0.588027,0.832362,-0.645872,-0.38825,0.0937179,0.955852,0.00796982,-0.727309,0.622778,-0.274533,0.312268,-0.469006,0.181092,-0.0289151,0.0787638,-0.453303,0.306734,-0.623789,-0.348177,-0.553067,-0.192011,1.07314,0.0857877,-0.317544,-0.313846,-0.505975,0.142659,-0.471479,0.893339,-0.0985953,0.280788,-0.397851,-1.33501,1.03231,0.162565,0.415642,0.180851,-0.081448,0.211703,0.0967085,-0.0400305,-0.663712,-0.477676,0.0456162,0.332353,-0.0625615,0.108667,-0.594682,0.582202,0.886299,-1.13722,0.213921,-0.461839,-0.278323,0.0639155,0.438292,0.490312,0.0925997,-0.0817675,-0.988196,-0.279196,0.645137,0.431702,0.851701,0.7139,-0.566488,-0.125718,-0.281178,0.366524,0.151424,-0.247611,0.627308,0.475086,0.268848,0.626338,-0.306674,-0.628724,-0.243163,0.488521,-0.56524,0.18939,0.25587,-0.701052,0.158902,0.572184,0.435683,-0.148415,0.36341,-0.302293,-0.0840542,-0.666013,0.0836617,0.235844,-0.0732252,0.55385,0.0447456,-0.179387,-0.57689,-0.541221,-0.39239,-0.374991,0.141462,-0.603694,-0.204136,0.66756,0.0900317,-0.153502,0.265651,-0.358078,0.00132845,-0.550778,0.11103,-0.70485,-0.156395,-0.112599,0.194411,-0.0574122,0.202288,0.0288656,0.242875,0.00992328,-0.778756,-0.333434,0.31758,-0.708389,-0.468027,0.04145,0.22542,0.395102,0.474784,0.628572,-0.210542 +3347.45,0.903747,0.0912059,4,1.47042,0.951981,-1.03151,0.477246,0.336921,0.0335001,0.155557,-0.219676,0.733555,0.363328,-0.0268638,-0.0614476,-0.223114,0.245211,-0.21855,1.37353,0.367272,0.19352,-0.83545,0.539109,-0.152169,-1.11484,-0.248436,0.282258,0.227686,-0.161201,0.0840627,0.719645,-0.297917,0.813384,1.03482,0.218513,-0.0280971,0.523256,-0.917804,-0.537672,-1.03213,0.663604,0.907168,-0.334518,1.43382,0.892866,0.133758,-0.614879,-0.188206,-0.169124,-0.439634,-0.000277708,0.688236,0.221505,0.301599,0.508977,0.0971924,-0.607846,0.315551,-0.311891,0.215367,-1.46332,0.0330761,-0.678225,0.103576,0.413456,-0.361247,0.156517,-0.0818624,0.586182,-0.0632553,-0.632477,0.208668,-0.482444,-0.643697,0.915572,0.852119,0.250028,0.01821,0.66176,0.178983,1.00893,-0.373356,-0.00722989,0.106051,-0.363365,0.419274,-0.564209,-0.234421,-0.0461205,0.184592,0.0864992,-0.66894,-0.371627,-0.420972,0.199759,-0.35805,0.598509,0.132555,-0.467391,0.0202217,-0.734714,0.328784,0.0740355,-0.590413,0.170223,-0.724326,-0.320144,1.13242,-0.14242,0.494126,-0.113383,-0.308107,0.0112088,0.240199,0.355372,0.774303,0.321852,0.400922,-0.301105,0.683612,0.251733,-0.534236,-0.500204,-0.337654,-0.0556671,0.17189,-0.151906,0.0486972,0.504479,0.267202,-0.021379,0.442438,-0.321278,-0.200213,0.338995,0.0504315,0.0527122,-0.257763,-0.238039,-0.179487,-0.444939,0.537997,-1.01297,0.206664,0.22159,-0.58156,0.383093,0.661064,-0.122662,-0.267468,0.230217,-0.324348,-0.230584,-0.16707,0.306797,0.105162,0.166712,0.667744,0.0576922,0.222539,0.215735,-0.247867,0.0251019,0.0499388,0.0757552,0.753763,0.386094,0.664633,-0.256377,-0.529867,-0.804517,-0.131178,-0.273878,-0.112885,0.854256,-0.0244556,-0.258373,-0.301158,0.542181,-0.502866,-0.490435,0.0238281,1.29911,0.11189,-1.28207,0.358383,-0.286372,0.90777,-0.715101,0.0930277,-0.182918,-0.102736,-0.258688,0.297461,-0.0430439,-0.375992,-0.4049,-0.266937,1.05695,0.184063,-0.711408,-0.118472,-0.625126,-0.00751895,-0.128494,0.207562,0.0252105,-0.180279,-0.357498,-1.75025,0.911468,0.277837,0.56933,-0.181386,0.12149,0.647222,0.309977,0.131565,-0.163211,-0.889711,-0.293416,0.25776,-0.569409,-0.516753,-0.692425,0.0896904,0.675193,-0.675627,0.3333,-0.0717788,-0.14362,0.0484062,-0.0737827,0.23732,-0.11176,-0.0312419,-0.736715,-0.025943,0.453012,0.252133,0.910516,0.725012,-0.655198,-0.263504,-0.0146862,0.760164,0.675084,0.364668,-0.277672,0.601963,0.268061,0.669628,-0.0577177,-0.364529,-0.348548,0.172898,-0.867558,0.058484,0.21549,-0.177706,-0.00464572,0.468404,-0.146022,-0.664847,1.11357,0.294994,0.0318557,-0.311786,-0.177803,-0.190134,0.210706,0.603405,-0.578431,-0.334497,-0.912569,-1.02689,-0.837705,-0.0197448,0.130147,-0.291312,-0.370886,0.689627,-0.606659,0.130566,-0.137467,-0.850305,0.126745,-0.59894,0.107429,-0.761672,0.470482,0.0159294,-0.096313,-0.201987,0.551568,0.0470588,0.365229,-0.162384,-0.255134,0.133608,0.0706494,-0.893105,-0.478099,0.734367,0.211297,0.368822,0.459671,0.607307,-1.25016 +3387.87,0.848094,0.0912059,5,1.4841,0.782165,-1.329,0.599181,0.692739,-0.287598,0.485608,0.414214,-0.26238,-0.509058,0.160482,-0.209093,0.244864,0.703661,-0.228418,0.580535,0.206542,-0.18592,0.161261,0.17648,-0.205117,-0.994577,-0.467343,0.633846,-0.385711,0.235602,0.203737,0.376364,-0.153083,0.38054,1.22558,-0.400791,0.40731,0.61875,0.034289,-0.221823,-0.329792,0.288197,0.512924,-0.0696434,1.09564,0.454554,0.597281,-0.866938,0.0820049,0.245532,-0.349051,0.286232,0.273275,0.346817,-0.150024,0.133008,0.038679,-0.0225216,0.432049,-0.111629,-0.272162,-0.210798,0.300668,-0.869408,0.53925,0.969134,-0.638379,-1.76943,0.305452,-0.281373,0.244748,0.646918,0.0534265,-0.235496,0.371914,-0.104256,0.592273,-0.511905,0.985991,0.61631,0.52576,-0.49453,-0.127264,0.221532,0.480459,-0.226143,-0.0686132,0.114244,0.191207,-0.0611926,-0.0793043,-1.01023,0.31498,-0.426871,0.486242,0.321227,0.117833,-0.714746,0.0209192,-0.115276,-0.150285,0.240337,-0.354805,0.167887,0.66005,-0.142098,-0.290249,-0.139698,-0.193768,-0.577093,0.046936,-0.424181,0.412192,0.964352,-0.54683,-0.0828803,-0.14252,0.386923,-0.145965,0.443207,-1.42775,0.224495,0.79103,0.330752,-0.809676,-0.236894,-0.645937,-0.0640186,-0.251043,0.147348,0.0715322,0.361818,0.377207,-0.492459,0.442083,-0.171058,-0.192289,0.939835,-0.147079,0.010623,0.460797,0.162079,0.449062,-0.340877,-0.920031,-0.374698,0.605356,-1.09616,-0.519572,0.475028,-0.433356,0.0221485,-0.323881,0.161232,0.0253676,-0.162489,0.0364444,-0.158586,-0.00306138,0.520102,0.307046,-0.534973,-0.108321,-0.0953797,0.292742,-0.182709,0.796816,0.066782,-0.304411,0.422678,0.24,-0.0161072,-0.476229,0.199765,0.95157,-0.913859,0.064284,0.277375,0.0680485,-0.801289,0.0418669,0.208835,0.459811,0.721185,-0.3063,0.939112,0.416604,0.0637556,-0.644455,-0.335127,-0.60665,-0.410019,0.243639,-0.614978,-0.125237,-0.144388,0.140019,-0.608296,0.392006,-0.160814,0.0327337,0.122099,-1.17141,0.487871,-0.49552,-0.436982,0.429043,-0.117989,0.357046,-0.315504,0.186215,0.661818,-0.26177,0.20557,-0.332657,-0.528194,-0.0126611,0.0179404,-0.684355,0.932792,0.0758066,0.142497,0.30726,-0.0520118,0.0901569,-0.236374,-0.0580014,0.260917,-0.160779,0.332926,-0.966895,-0.568459,0.159188,0.329722,-0.099492,-0.0665757,-0.0731431,0.361367,-0.859687,0.538851,-0.257386,-0.582982,0.723499,-0.312902,0.217227,0.464248,-0.941281,-0.350156,0.365306,0.67171,0.33653,0.092516,-0.722193,-0.315303,0.199648,-1.06027,0.623191,0.387544,-0.0744763,0.39527,-0.333088,-0.14958,-0.273385,0.179272,0.777061,-0.140128,-0.0148426,0.477988,0.0512463,-0.00366161,-0.0679415,-0.474801,-0.14032,0.301052,-0.176228,0.428346,0.482823,0.856721,0.225752,-0.288918,0.203326,0.383736,-0.0275663,0.621325,-0.21624,-0.191647,0.123016,0.0449061,0.626427,-0.0637107,0.376693,0.190473,0.640221,0.00793918,0.244786,-0.145197,-0.0817198,-0.170376,0.270042,-0.606021,-0.0062356,0.173888,0.248986,-0.252283,-0.552919,0.20821,0.289651,0.4563,0.538193,-1.99654 +3387.24,0.954927,0.0912059,5,1.48244,0.782115,-1.31895,0.599375,0.654963,-0.293997,0.480343,0.448469,-0.297144,-0.449335,0.150779,-0.216549,0.253632,0.706894,-0.206525,0.551632,0.20386,-0.213682,0.129338,0.145757,-0.190097,-0.996867,-0.508398,0.649006,-0.361887,0.250555,0.195876,0.353044,-0.212362,0.389017,1.23024,-0.421685,0.406489,0.612528,0.033284,-0.207014,-0.343293,0.257401,0.512497,-0.0897459,1.08159,0.423003,0.593917,-0.819115,0.0363851,0.272355,-0.335837,0.267781,0.252175,0.335461,-0.186582,0.120938,0.039532,-0.0311741,0.416903,-0.113419,-0.255123,-0.26552,0.266962,-0.86791,0.519811,0.951471,-0.699784,-1.78912,0.292176,-0.313154,0.206357,0.657064,0.0153823,-0.232208,0.36027,-0.162633,0.600304,-0.548583,1.01209,0.603956,0.536053,-0.526415,-0.115842,0.199647,0.497236,-0.217747,-0.0918249,0.108847,0.207113,-0.0246186,-0.0941116,-0.992982,0.325402,-0.413282,0.45025,0.313521,0.0983138,-0.716737,0.0451199,-0.104558,-0.172424,0.20437,-0.3657,0.179675,0.665358,-0.109612,-0.298606,-0.160511,-0.199735,-0.585644,0.074499,-0.484568,0.373013,0.93467,-0.518354,-0.0935687,-0.100111,0.376871,-0.166185,0.476377,-1.38667,0.247186,0.79445,0.367079,-0.799771,-0.219295,-0.657942,0.0109967,-0.291749,0.12652,0.0263943,0.32966,0.372396,-0.529289,0.432223,-0.193578,-0.196026,0.931239,-0.124284,0.0144725,0.43652,0.191502,0.451243,-0.30103,-0.939882,-0.352763,0.599864,-1.0849,-0.522286,0.48687,-0.471438,0.00910878,-0.323769,0.118135,0.0402715,-0.182741,0.0308018,-0.16397,-0.0617782,0.540808,0.390203,-0.485033,-0.101084,-0.153751,0.310781,-0.155563,0.778791,0.100964,-0.277272,0.452813,0.203669,0.0295524,-0.5083,0.208646,0.926106,-0.969819,0.0614527,0.274466,0.0955526,-0.805635,0.059371,0.216729,0.453619,0.727129,-0.34132,0.9897,0.427604,0.0678443,-0.624624,-0.359672,-0.590646,-0.37751,0.283038,-0.587953,-0.117424,-0.170659,0.0787551,-0.606205,0.360978,-0.184886,0.0414836,0.111065,-1.13638,0.478922,-0.459255,-0.44638,0.490304,-0.149039,0.405211,-0.282517,0.161137,0.668522,-0.272151,0.162354,-0.339465,-0.535425,-0.0017412,0.0283748,-0.684083,0.967918,0.0396515,0.099425,0.342831,-0.0137465,0.0952938,-0.230065,-0.107952,0.163295,-0.16457,0.353451,-0.981787,-0.60587,0.193131,0.330932,-0.074079,-0.0776309,-0.0933293,0.365888,-0.879089,0.488678,-0.289578,-0.593906,0.714668,-0.304939,0.262695,0.453641,-0.902832,-0.342394,0.332487,0.696854,0.352647,0.12734,-0.742009,-0.303297,0.229324,-1.07944,0.674374,0.419477,-0.0956668,0.403042,-0.342401,-0.138865,-0.25039,0.182641,0.760166,-0.155967,-0.0263855,0.490886,0.0633549,0.0255211,-0.0612562,-0.495575,-0.195117,0.315976,-0.219751,0.495675,0.504989,0.836312,0.212389,-0.279145,0.196439,0.407973,0.00408442,0.620535,-0.205801,-0.23391,0.16914,0.0581248,0.586199,-0.0306233,0.328292,0.165448,0.648264,-0.0588822,0.231081,-0.14513,-0.0924076,-0.168051,0.269979,-0.576104,-0.0127763,0.171652,0.212378,-0.271349,-0.58627,0.20598,0.290683,0.45385,0.53915,-1.87657 +3402.79,0.997653,0.0912059,4,1.42075,0.843592,-1.0108,0.427985,0.778392,-0.0952047,0.510923,-0.106313,0.371756,0.279575,0.700519,-0.118066,-0.221031,0.904275,0.406723,0.769645,0.097684,0.145316,0.466527,-0.0318238,-0.180445,-0.444483,-0.249767,0.641796,-0.345734,-0.165496,0.613608,0.173577,0.135342,0.20523,1.1293,-0.022073,0.275971,0.547456,0.171812,-0.175734,-0.642801,0.575228,0.0737008,-0.219765,1.00925,0.789685,-0.0543702,-0.465222,-0.131666,0.376849,-0.2898,0.0889413,0.506287,0.401141,0.0720401,0.887968,-0.131606,-0.476634,0.601605,0.0237781,-0.24294,-0.373404,0.187386,-0.650271,0.00405093,1.05939,0.295222,-0.672698,0.197672,0.0127015,0.365951,-0.0400481,0.172407,-0.968896,0.136605,-0.0807699,0.0447745,0.108223,0.680698,0.542381,0.461315,0.250959,-0.203298,0.510782,0.888697,-0.506796,0.0149393,-0.148374,-0.218059,-0.347745,0.19431,-0.01254,-0.188483,-0.390138,0.180161,0.18844,-0.369463,-0.315397,0.314507,0.0948078,0.0132012,0.0420438,-0.0799294,0.219112,0.290166,0.697721,-0.0580107,-0.550135,-0.798593,-0.0742214,0.203506,-0.0748187,0.0877103,0.793787,0.115481,-0.287895,0.0339222,0.422855,0.488315,-0.104611,-0.923996,0.467666,0.135228,0.487974,-0.360219,0.243293,-0.110118,-0.278435,-0.0242561,0.311092,0.451904,0.310947,-0.287307,0.0697193,0.0180075,-0.186231,-0.225602,0.442863,0.0831776,0.00178988,-0.172843,-0.115619,0.70271,-0.51277,-0.554446,-0.203818,0.472468,-0.150448,0.289871,-1.02049,-0.843334,0.400687,-0.256812,0.218379,-0.913331,-0.249823,-0.11168,0.562542,-0.265633,0.808613,0.254716,0.261883,0.0950417,0.0462669,0.425249,-0.0260939,1.03277,-0.407338,-0.424481,0.305484,-0.11292,-0.0611553,-0.0291554,-0.101796,0.221007,-0.406798,-0.106573,-0.292581,-0.0447302,-0.0818242,0.102494,0.873121,0.389984,0.886993,-0.0587901,0.0403348,-0.179694,-0.361942,-0.0452562,-0.136028,0.164125,-0.22047,0.297644,-1.31589,-0.366339,-0.254973,0.149383,-0.33729,0.419759,-0.761026,0.0418512,-0.36683,-0.275654,-0.030647,-0.12911,-0.486034,0.237519,-0.354616,-0.170804,0.0737588,-0.39084,0.804509,-0.405457,-0.0343946,0.438703,0.0578017,0.306995,0.0989685,-0.408533,0.440556,0.0915975,0.0762769,0.234689,0.446947,0.284496,-0.577161,-0.0524306,0.598587,0.273503,0.564722,-1.05731,-0.0562681,0.57135,0.280489,-0.313483,0.221714,-0.417002,-0.371137,-0.375632,0.978479,0.273142,0.0174926,0.369178,-1.07306,0.331898,0.216367,-0.565934,-0.353583,0.376009,0.0231987,0.432699,0.235046,0.17783,-0.42467,0.108855,-0.884896,0.384983,-0.156137,0.117982,0.347079,-0.0863057,-0.174972,0.301281,-0.280755,0.787005,0.583063,0.154611,0.792961,0.488268,0.0739899,-0.119767,-0.382872,-0.156989,0.273601,-0.247655,-0.0547887,-0.202699,0.578242,0.641472,-0.315957,-0.151227,-0.21308,0.0664723,0.153159,-0.141996,-0.315147,-0.815747,-0.465382,0.0938079,-0.0109267,0.289605,-0.134787,-0.0993921,0.866335,0.126372,0.416645,0.402811,-0.132105,0.124347,-1.19116,-0.17947,0.00602955,-0.48845,0.203856,-0.0649361,0.182255,0.213194,0.426914,0.46173,-2.50577 +3398.11,0.864716,0.0912059,5,1.39927,0.854287,-0.826761,0.369888,0.445021,0.0206539,0.460164,0.236483,0.186634,0.235959,0.299804,-0.237404,0.297656,1.02437,-0.00334207,0.836083,0.165485,0.229903,-0.0523238,-0.0278702,-0.0448063,-0.807145,-0.828274,0.865362,-0.359161,-0.0541854,0.315746,0.314657,0.204217,0.213923,1.03726,-0.782289,-0.0138718,0.520557,-0.302873,-0.166012,-0.704186,-0.130579,-0.0305452,-0.293055,0.980894,0.71834,0.531628,-0.907058,0.179254,0.646577,0.0479841,0.203043,0.267375,-4.87485e-05,-0.126776,0.0544677,0.175636,-0.120636,0.677776,-0.165982,0.0138383,-0.0977582,0.184078,-0.522274,0.224235,0.984383,-0.267072,-0.91508,0.118161,0.609653,0.320263,-0.327577,0.522288,-1.01456,0.1501,0.0401241,0.0138195,-0.0754558,0.634121,0.9151,0.440545,0.706637,0.119503,0.240847,0.519655,-0.403575,0.0131583,0.0385938,-0.0872091,-0.19286,0.822263,-0.417777,0.291324,-0.162726,0.104334,-0.0830789,-0.450908,-0.2415,0.302209,0.0365916,-0.159413,0.155756,0.194832,0.529051,0.245444,0.416352,-0.348119,-0.637187,-0.132532,-0.259449,0.0636613,-0.335853,0.174506,0.808985,-0.182675,-0.178062,-0.751704,0.498907,0.517861,0.519562,-0.288474,0.595691,0.331239,0.118276,-0.6115,0.0120936,0.467589,-0.279909,0.0971959,0.371518,0.400689,0.288652,0.0256788,-0.287236,0.399277,-0.0799073,-0.300155,0.343658,-0.0561369,0.0395131,0.301463,0.0773372,0.286771,-0.920158,-0.66327,-0.492898,0.353657,-0.37995,-0.816712,-0.39325,-0.170435,0.64869,0.122156,0.711039,-0.197063,-0.141196,0.331893,0.267983,0.383932,0.625105,0.730765,-0.386685,0.0352871,0.204318,0.683428,0.220902,0.976288,-0.466481,-0.193087,0.194733,-0.157339,-0.282264,-0.0646487,-0.435942,0.613888,-0.679243,0.118561,0.326397,0.046369,0.047246,-0.182317,0.732077,0.530612,0.612284,-0.27935,-0.437275,0.138746,-0.66939,0.200116,0.402124,-0.426685,-0.125017,0.695508,-0.696919,-0.142293,0.628684,0.593348,-0.345532,-0.145023,-0.201581,0.258036,0.182657,-0.209394,-0.610201,-0.3919,-0.251228,-0.0475261,-0.051504,-0.0596031,-0.437939,-0.200258,0.835735,0.123499,0.303709,0.325342,-0.224401,0.191126,-0.0737592,-0.293518,0.803246,0.0926862,0.404822,-0.0570565,0.342658,0.336078,-0.464227,-0.651709,-0.0726587,-0.0501356,0.722996,-0.885263,0.118548,0.194995,0.60214,-0.123692,0.0603303,-0.206218,-0.329923,-0.393743,0.808718,0.49705,-0.17267,0.629574,-1.00451,0.115795,0.218811,-0.184609,0.301355,0.484448,-0.509525,-0.0535467,0.71442,-0.19909,-0.828166,0.140807,-0.490022,0.750118,0.0159385,0.0915939,0.239332,-0.208527,0.166315,0.0637426,-0.428275,0.797071,0.927665,-0.0492591,0.115426,0.0777528,-0.0676012,-0.14378,-0.616318,0.0784647,0.0580553,-0.355053,0.0132664,0.334092,0.652695,0.409314,-0.0844506,0.160077,-0.307853,-0.197847,0.483019,0.0214344,-0.320947,-0.533898,0.0648633,0.146131,0.275442,-0.253573,0.699036,0.485561,0.376881,-0.0494738,-0.118903,0.508286,0.0944499,-0.267782,-1.57975,-0.215316,-0.136582,-0.512444,0.192939,-0.376188,0.177772,0.208367,0.42163,0.456472,-1.51001 +3435.19,0.994551,0.0912059,5,1.60709,0.980752,-0.851108,0.246505,0.193656,-0.0792311,0.174672,0.357625,0.477204,0.0295451,-0.511563,-0.150892,-0.302649,0.491098,-0.696323,0.545563,0.361748,-0.837583,-0.101091,-0.0446537,-0.242295,-0.419,-0.826985,0.213481,-0.194517,0.250171,-0.110454,0.347772,-0.0902386,-0.367939,0.698773,0.123836,-0.312752,0.0843462,-0.580249,-0.0593168,-0.12128,0.585541,0.416841,-0.141899,0.838617,0.567251,-0.174864,-0.426226,-0.0591408,-0.23083,-0.983358,0.625037,0.348532,-0.0750123,-0.16587,0.465081,0.362859,-0.392861,0.566184,-0.210622,-0.0590878,-0.878997,0.563819,-0.0418446,0.440333,0.552913,-0.625043,-0.993344,0.468232,-0.279431,-0.357518,0.373818,-0.445565,0.181256,0.219526,0.676374,0.562001,0.176402,0.776952,0.275778,0.574816,-0.462921,-0.574232,-0.061149,0.179867,-0.0849209,-0.128922,-0.231813,-0.332329,0.132402,-0.729016,-0.382195,0.449222,-0.342194,-0.0611214,0.133686,0.43923,0.443591,0.0713814,-0.159171,0.488391,-0.419622,-0.0713932,0.4433,0.212082,-0.578092,-0.207436,0.120726,0.0557411,-0.289812,0.0241611,-0.0261816,0.244767,0.409595,0.301692,0.0248524,0.537844,0.333101,-0.419903,-0.231164,-0.467019,-0.313502,0.187069,-0.0767706,-0.421378,-0.279698,-0.582263,-0.536696,-0.445587,-0.022338,0.257352,-0.0323153,0.350982,0.014753,-0.249912,-0.390482,0.776403,0.919218,-0.156627,0.173834,-0.0577733,-0.2834,0.537693,-0.305376,0.072544,-0.179641,0.0504212,-0.538238,0.79068,0.48035,-0.211933,0.579994,-0.15658,-0.584494,-0.128956,0.407431,0.278505,0.00202222,0.166482,0.291627,-0.0653106,0.3868,0.473445,-0.283769,0.169577,-0.188611,0.135632,0.0882563,-0.0135247,0.0299569,0.141722,-0.00113803,-0.0518051,0.332206,-0.0381586,0.343736,-0.0125246,-0.394339,-0.152766,0.152998,-0.208121,-0.6397,-0.0974269,1.10071,0.201959,-0.333178,-0.156649,0.368418,-0.265681,-0.938868,-0.0764084,-0.482834,0.181738,-0.414822,-0.241825,-0.0713441,-0.303572,-0.555305,0.597965,0.727229,-0.105483,-0.763389,-0.962392,0.500116,-0.131661,-0.121167,0.134441,-0.24784,0.0658068,0.0492273,-0.222957,0.895179,0.0470181,0.125669,-0.274807,0.237795,0.256163,0.376531,0.0978525,-0.231924,-0.565406,0.326505,0.814707,-0.390008,-0.36005,-0.410769,0.269547,0.349198,-0.754542,0.168391,0.17821,-0.434297,0.153542,-0.30933,0.0153991,0.051548,-0.118911,-0.0518315,-0.200726,0.238341,-0.307966,0.439135,0.782506,-0.0323217,-0.250656,-0.25112,-0.107168,-0.215639,0.259789,0.468979,0.608999,-0.126766,0.0571798,-0.304921,0.0124847,-0.650739,-0.0231072,-0.223548,-0.396398,0.0965134,-0.336172,-0.275604,0.154097,-0.13103,-0.410247,-0.38156,0.185067,0.057387,-0.0357463,0.569821,0.12716,0.526584,0.0775716,-0.152044,0.128673,-0.475078,-0.470554,-0.166661,-0.0356109,0.142795,0.273322,0.240423,0.188897,-0.372265,-0.652487,-0.144983,-0.134929,-0.167841,-0.0441574,-0.120772,0.0835579,-0.201599,-0.291226,-0.667029,-0.0847847,0.0943884,-0.38856,0.321145,-0.0108476,0.273483,0.230915,0.284956,0.0107516,-0.338054,-0.151324,0.130472,0.169898,0.36121,0.412186,-0.536514 +3432.1,0.826965,0.0912059,4,1.62312,0.967502,-0.80574,0.197787,0.206848,-0.0964308,0.229707,0.369776,0.463166,-0.0891051,-0.429481,-0.100162,-0.422055,0.366167,-0.616844,0.585291,0.334737,-0.763839,-0.0971832,0.0174589,-0.32422,-0.443134,-0.808043,0.186708,-0.165598,0.140856,-0.134243,0.513905,-0.0273096,-0.439001,0.725949,-0.0180861,-0.218873,0.133416,-0.561807,-0.0772404,-0.140868,0.513621,0.289059,-0.263659,0.813464,0.441111,-0.251149,-0.432924,-0.014971,-0.337034,-0.849432,0.561568,0.455349,-0.108358,-0.0491297,0.357103,0.408579,-0.322908,0.683588,-0.113236,-0.0489615,-0.822719,0.456595,0.0059595,0.299388,0.608217,-0.646626,-1.16791,0.532121,-0.290455,-0.409014,0.417841,-0.623386,0.202962,0.212263,0.829168,0.429542,0.276287,0.797001,0.309933,0.567404,-0.378921,-0.505968,-0.0969248,0.163668,-0.120486,-0.150133,-0.32453,-0.321307,-0.0332979,-0.767083,-0.405761,0.557356,-0.44312,-0.0742882,0.160353,0.470041,0.559341,0.190647,-0.178239,0.428287,-0.400389,-0.0622183,0.520775,0.20227,-0.412353,-0.198943,0.0745606,0.110527,-0.297659,0.0218544,-0.0609139,0.308414,0.420715,0.299586,0.0283646,0.692451,0.375353,-0.363497,-0.153657,-0.520432,-0.354345,0.459402,-0.16943,-0.430373,-0.276515,-0.526729,-0.576999,-0.562327,-0.0182424,0.28456,0.0205907,0.337519,0.0254872,-0.154222,-0.299912,0.848333,0.881852,-0.300313,0.102253,-0.0518043,-0.211626,0.495363,-0.306136,0.0813836,-0.184614,-0.0788091,-0.633446,0.80787,0.481379,-0.323134,0.502091,-0.211225,-0.671857,-0.0877758,0.486911,0.214247,-0.0586017,0.0728927,0.204494,-0.210845,0.467001,0.563937,-0.31974,0.284764,-0.221507,0.120603,0.141674,0.120993,0.00370612,0.252039,-0.0653618,0.00553289,0.437649,0.0132875,0.386434,0.048197,-0.354434,-0.149744,0.1241,-0.236257,-0.668218,-0.0131653,1.17598,0.239482,-0.394606,-0.0169021,0.42625,-0.179916,-0.99033,-0.0239903,-0.490121,0.15605,-0.412553,-0.227727,-0.105568,-0.237254,-0.6104,0.615569,0.746638,-0.295153,-0.623602,-0.854162,0.409713,-0.142687,-0.154192,0.12782,-0.133569,0.116562,-0.146808,-0.198599,0.896431,-0.0297276,0.0964978,-0.199968,0.282784,0.248882,0.372076,0.193018,-0.185169,-0.560774,0.335064,0.796602,-0.533733,-0.213093,-0.370075,0.246067,0.313482,-0.661119,0.166845,0.165964,-0.382217,0.253916,-0.438426,-0.0526311,0.0862228,-0.0566678,-0.204634,-0.149306,0.238924,-0.121852,0.20864,0.701266,0.0435172,-0.235448,-0.368409,-0.0120973,-0.139589,0.204435,0.358013,0.514205,0.0297131,0.0612138,-0.452474,-0.0602246,-0.911059,0.121583,-0.236385,-0.282147,0.109093,-0.386953,-0.447264,0.18926,-0.0964966,-0.498363,-0.23836,0.170029,0.0485634,-0.0776105,0.592321,0.137891,0.488937,0.139522,-0.225106,0.100454,-0.390445,-0.502689,-0.16077,-0.0116718,0.109508,0.223664,0.188809,0.317283,-0.449292,-0.607126,-0.247473,-0.15093,-0.199015,-0.0295513,-0.114231,0.114455,-0.0370923,-0.275491,-0.497768,0.0280621,-0.011735,-0.414219,0.255169,-0.0524977,0.293643,-0.0209393,0.221676,-0.00173889,-0.445694,-0.115137,0.128554,0.181209,0.358545,0.425687,-0.514189 +3440.22,0.960917,0.0912059,4,1.63512,1.00596,-0.984309,0.256883,0.339362,0.00703612,-0.149975,0.338714,0.244788,0.0556317,-0.489441,-0.426999,-0.320243,0.425051,-0.165874,0.555934,-0.0414033,-0.390761,-0.286339,0.120762,-0.474792,-0.696742,-0.936446,0.097698,-0.0267766,0.166916,0.207792,0.360931,0.0541044,-0.208243,0.499393,-0.303715,-0.0663884,-0.000611416,-0.506694,-0.206909,0.0468951,0.477874,0.698779,0.100034,0.525211,0.607538,0.208188,-0.229835,-0.123208,-0.298748,-0.707877,0.612572,0.597633,-0.213889,0.00702788,0.327775,0.313991,-0.224709,0.504946,0.211631,0.188002,-0.538053,0.417154,-0.187393,0.538274,0.407058,-0.531986,-0.628073,0.182599,0.12494,-0.195251,0.0245725,-0.517657,0.386943,0.161133,0.58886,0.373453,-0.00679411,0.76133,0.242947,0.474976,0.00128262,-0.522655,0.0679554,0.199162,-0.11858,0.137147,-0.19386,-0.248064,-0.201157,-0.543526,-0.181604,0.426381,-0.419479,-0.487959,0.322629,0.0580233,0.345725,0.168414,-0.29251,0.40862,-0.484692,-0.519868,0.349085,0.0882976,-0.37454,-0.695904,0.0548108,-0.1326,-0.167343,0.000427116,-0.179571,0.57974,0.571986,0.275128,0.0532466,0.529033,0.483462,-0.0396798,-0.215506,-0.448389,-0.16089,0.58552,-0.286169,-0.59303,0.296344,-0.132497,-0.250573,0.144427,-0.0459961,0.524845,0.133953,0.313343,-0.00871671,-0.217956,-0.100867,0.543298,0.590958,-0.0274365,-0.280069,0.0795434,0.103054,0.48301,0.0410548,-0.081027,-0.247692,0.213645,-0.452964,0.382333,0.278833,-0.671025,0.0470816,-0.217341,-0.882506,-0.252337,0.00903095,0.0749389,-0.0853122,0.217218,-0.0596974,0.192786,0.307718,0.659411,-0.123684,0.372489,-0.161201,0.124826,0.591235,0.388232,0.00121569,-0.102159,0.164118,0.0100841,0.319898,0.251945,0.40317,-0.0528378,-0.132426,-0.0859018,0.339878,-0.472144,-0.468277,-0.111194,1.27125,-0.0637643,-0.490707,-0.247056,0.347272,-0.0405974,-0.985329,0.236824,-0.30373,0.201618,-0.635972,-0.247743,0.0926275,-0.316421,-0.623339,0.731909,0.258972,-0.329917,-0.92398,-1.07003,0.519458,-0.0921614,-0.371977,-0.13061,-0.221462,0.08649,-0.11819,-0.106529,0.982033,0.311409,0.523973,0.100316,0.32189,0.150842,0.398065,0.438461,-0.090844,-0.586765,0.319999,0.69393,-0.306615,-0.197235,-0.418522,0.322202,0.469131,-0.196395,0.231723,0.424768,-0.424247,0.233726,-0.440582,-0.217713,0.126254,0.166814,0.120476,-0.117168,0.166185,0.121223,0.174003,0.792984,0.289137,-0.478511,-0.398271,-0.176896,-0.13778,0.437108,0.297863,0.622935,0.241451,-0.187836,-0.465598,-0.0168955,-0.462377,-0.0936939,-0.268531,-0.188265,0.19716,-0.230667,-0.0548286,0.296423,-0.0425717,-0.55359,-0.118589,0.354435,0.305012,-0.210564,0.53236,-0.0819335,0.388859,0.203342,0.021248,0.0198776,-0.399087,-0.323635,-0.24692,-0.322072,0.0458631,0.365281,-0.128825,0.523392,-0.359941,-0.604929,-0.219021,-0.313371,-0.0072457,-0.147354,-0.0514693,-0.154187,0.0342777,-0.503183,-0.251612,-0.0196632,-0.232451,-0.0517971,0.188772,-0.113279,0.0408907,0.0611541,0.107531,-0.219944,-0.431247,-0.289757,0.129786,0.159571,0.360259,0.399463,-0.998182 +3439.79,0.928735,0.0912059,4,1.51335,0.963831,-1.21406,0.38123,0.252137,-0.0646744,0.00466488,0.235334,0.47351,0.0937541,-0.132925,-0.599139,-0.0653704,0.374275,-0.541937,0.838158,0.283441,-0.226471,-0.295574,-0.0571325,-0.136932,-0.642915,-0.92024,0.0226766,-0.256367,-0.0208251,-0.353537,-0.0570146,-0.323183,-0.252069,0.544007,-0.492943,-0.309511,-0.0214419,-0.197789,0.0745903,-0.446146,0.330905,0.428505,-0.150557,0.872111,0.883241,0.866371,-0.621706,0.388058,0.0775556,-0.698739,0.195796,0.59349,-0.287724,0.276348,0.327473,0.183863,0.0297755,0.38769,-0.196041,-0.264305,-0.630518,0.385559,-0.254181,0.457965,0.653637,-0.714369,-0.819267,0.447194,0.180226,0.327437,0.050277,0.235695,-0.556928,0.305758,0.117782,0.497404,0.533838,0.551812,0.495747,0.574645,-0.222461,-0.540769,0.00831736,0.338705,0.166618,0.283985,0.0412509,-0.684343,0.222966,0.183354,-0.174814,0.453514,-0.0894705,0.049936,-0.265105,0.351226,-0.108652,-0.431451,-0.0426762,0.068842,0.0954385,0.242445,0.644132,0.00838184,-0.275149,-0.871899,-0.14383,0.635155,-0.0302052,-0.20561,-0.363987,0.0553766,0.678531,0.225906,-0.10486,0.251397,0.467547,-0.176346,-0.610984,-0.902205,0.231915,0.227031,-0.246303,-0.56112,-0.457766,-0.41557,-0.299233,-0.419047,-0.348985,0.0252998,0.168311,0.19923,-0.291853,0.223281,-0.165083,0.270359,0.145922,-0.372363,-0.234002,0.214299,0.181295,0.0133195,-0.917733,-0.234528,0.140573,0.180836,-1.05014,-0.0750797,-0.213576,-0.107647,0.614542,0.195189,-0.261678,-0.198439,-0.00921128,0.21326,-0.0243112,0.297279,0.329685,0.0243427,-0.533286,0.438052,0.180356,0.324448,0.0983289,0.446285,0.38099,-0.102281,-0.215957,-0.256374,-0.364322,0.104464,-0.749011,0.306554,-0.208228,0.199652,-0.0368513,0.0902007,-0.0325143,-0.115783,-0.2998,0.254628,1.09125,-0.184994,-0.168678,0.330036,-0.116987,-0.457961,-0.634855,0.0430018,-0.0365089,0.0173705,-0.441545,-0.0473119,0.00931553,-0.543984,-0.623308,0.0211289,0.641248,-0.773597,-0.533406,-1.02229,0.0159652,-0.16905,-0.368501,0.315931,0.102038,-0.105018,0.00661283,-0.417896,0.956518,0.213806,0.757436,0.255091,-0.357929,0.105671,-0.287269,0.801636,0.311532,0.238222,0.582248,0.0220525,-0.786876,0.0326566,-0.313479,-0.201525,0.00512622,-0.257985,0.422371,-0.448649,0.194641,0.243813,0.13618,-0.0279775,0.138678,0.28241,-0.255528,0.276036,0.530921,-0.199253,-0.129814,1.02889,-0.642559,-0.3875,-0.137985,0.244255,-0.665869,0.273118,0.261124,0.250919,0.539664,0.66693,-0.151571,0.358356,-0.808661,0.0885201,0.123214,0.10667,-0.26589,-0.49768,-0.296365,0.302143,0.238885,0.303919,0.224405,0.160683,0.269191,-0.0146568,0.448906,0.00821483,-0.00334418,0.0266291,-0.0577001,-0.41411,0.260482,-0.0709983,0.28271,0.2043,0.0333694,0.0937068,0.134488,0.210349,-0.158829,-0.65455,-0.1464,-0.372757,0.024766,-0.151659,0.547663,-0.683782,0.536152,-0.253845,-0.260273,0.125556,-0.204852,0.427227,0.0643768,-0.355666,-0.0356207,0.32536,0.063204,0.148653,0.505245,0.00412058,0.145547,0.213532,0.381507,0.462096,-0.735184 +3443.54,0.711819,0.0912059,4,1.54375,0.809396,-0.918831,0.415791,0.722343,-0.119728,0.117818,-0.178262,0.173733,-0.0820455,0.166588,0.0388634,-0.347699,0.130657,0.166461,0.567044,0.0587176,0.303236,0.446331,-0.127152,0.0745971,-0.176149,-0.0649562,0.258633,0.0164114,-0.0661419,0.0274879,0.389908,-0.149085,0.273666,0.889844,-0.300178,0.531992,0.489599,-0.246963,-0.346865,0.0255286,0.438373,0.295449,-0.13019,0.683048,0.113681,-0.0539003,-0.388813,-0.327687,0.0708945,-0.0596992,0.248031,0.209049,-0.0310626,-0.224773,0.087232,-0.261986,-0.412063,0.658423,-0.170672,-0.166621,-0.442395,0.28207,-0.459368,-0.0605791,0.875092,-0.328866,-0.722554,-0.0627862,0.108244,-0.423609,-0.184889,-0.254242,-0.0367714,-0.239495,0.700649,0.71546,-0.524683,0.0728159,0.403677,-0.0335267,-0.0750745,-0.0555894,-0.341837,-0.0593698,-0.445801,0.091807,-0.178344,0.312331,-0.382928,-0.211387,-0.393527,-0.095551,-0.56207,0.254338,0.388114,-0.250977,-0.0771814,0.560308,-0.458893,0.339758,-0.622027,-0.0479287,0.325629,0.142258,0.521989,-0.171359,-0.443659,-0.303343,-0.658591,0.572434,-0.25694,0.602347,0.52161,-0.013952,-0.0260477,-0.0122283,0.309411,0.40391,0.721052,0.315211,-0.0497341,-0.0777183,0.322393,-0.460866,0.126833,0.00894725,-0.15535,0.412897,0.75359,0.123153,-0.179422,0.133471,-0.1535,0.339791,0.218536,-0.134233,0.401542,0.229612,0.0802579,-0.426735,-0.547101,0.306483,-0.469337,-0.284855,0.00111616,0.0119062,0.301286,0.0584591,0.343036,-0.0428093,0.242126,-0.274614,0.0847207,0.0188459,0.312648,-0.124676,0.0992973,0.0122036,0.50174,0.44519,0.318672,0.0850738,-0.528359,-0.210628,-0.448017,0.876295,-0.231629,-0.0680971,0.280781,-0.0804547,0.319548,-0.220169,0.806857,0.0178608,0.0853016,0.0935677,-0.252343,-0.162348,-0.140883,-0.323077,-0.14201,0.0950027,0.579122,0.176504,-0.0496408,-0.211762,0.0972116,0.416482,0.194079,-0.576764,-0.434729,0.509535,0.0621505,0.147616,0.14932,0.272509,-0.24176,-0.000741609,-0.339264,0.608602,-0.300504,-0.440915,0.195894,0.129052,-0.183871,-0.221941,-0.265408,-0.273603,-0.221058,-0.479938,1.09617,-0.0708203,-0.196416,-0.169609,-0.0359035,0.233482,0.458212,-0.732566,-0.0268785,-0.59933,0.109598,0.356419,0.218908,-0.322644,-0.388138,0.285743,0.330449,-0.207544,0.097907,0.0477798,-0.513191,0.343204,-0.136451,-0.413281,0.0809831,-0.297686,-0.0205829,-0.689628,0.445749,0.0496957,0.144054,0.215506,0.223288,0.0741386,0.231971,-0.251262,0.670825,0.307857,-0.247077,0.602568,-0.0449133,-0.764342,-0.384854,-0.548275,-0.296746,0.762385,-0.400798,-0.444836,0.39678,-0.38472,-0.304849,-0.212126,-0.0342007,0.00907015,0.120833,-0.213725,-0.0865764,0.210891,-0.0282093,-0.0400797,-0.101252,-0.0186353,0.135335,-0.000472723,-0.508453,-0.160068,-0.0561686,0.0943472,-0.0934511,0.433068,-0.134944,-0.133457,-0.0653142,0.407998,-0.383927,0.0613929,-0.0124566,0.0136028,-0.0895548,0.539008,0.00582998,0.317361,-0.0712181,-0.084841,0.447277,-0.311895,0.0787649,0.218847,-0.781153,-0.355566,0.104766,-0.349528,-0.620066,-0.151039,0.114432,0.0933059,0.338277,0.30546,-2.16687 +3452.62,0.831667,0.0912059,4,1.59555,0.949398,-0.721672,0.323309,0.617707,-0.137244,-0.330353,0.111551,0.0918358,0.156061,0.0633274,0.0817678,-0.32372,0.116306,0.123073,0.974486,-0.0343207,0.385607,0.464111,-0.180332,0.0506189,-0.46146,-0.208012,0.316426,0.0569172,-0.0548288,0.05834,0.333426,-0.373274,0.189199,0.849988,-0.392869,0.0974738,0.456682,-0.306543,-0.139622,-0.379444,0.363706,0.303746,-0.248293,0.465316,-0.0929931,0.068681,-0.510399,-0.387971,0.302795,-0.253716,0.121099,0.42771,-0.0768378,-0.135803,0.141661,-0.114104,-0.391606,0.480027,-0.117004,-0.235953,-0.639614,0.152641,-0.195303,-0.135777,0.772349,-0.464192,-0.779275,0.21939,0.0410708,-0.218632,-0.0993632,-0.152812,-0.022341,-0.350538,0.506496,0.639473,-0.606227,0.128749,0.680518,0.10789,-0.236409,0.148508,-0.249772,0.21062,-0.324483,0.251564,-0.0723015,0.0422302,-0.221589,-0.0729575,-0.208766,0.115531,-0.508702,0.160247,-0.0134,0.023042,0.0887448,0.552072,-0.285091,0.0895449,-0.953947,0.196263,0.262383,0.228178,0.3886,0.104969,-0.558613,-0.323029,-0.58622,0.728729,-0.0869729,0.370175,0.666725,0.0133307,-0.0516573,0.351587,0.340574,0.349776,0.436348,-0.338099,-0.00176826,-0.241913,0.301986,-0.839533,0.139822,-0.120167,-0.740262,0.414472,0.295983,0.147105,0.0273216,0.230577,-0.178217,0.292573,0.344042,-0.122219,0.387369,0.151525,0.0301964,-0.608816,-0.290339,0.348543,-0.726831,-0.207846,-0.248741,0.0186746,0.0120152,0.470468,0.261473,0.180451,0.240472,-0.210706,0.303833,0.0472752,0.259161,0.0452417,0.482686,0.0893868,0.166551,0.154824,-0.0789423,0.0558742,-0.309345,-0.175538,-0.277265,0.57257,0.0762109,-0.156847,0.147935,0.00731291,0.0368421,0.088063,0.672184,0.114564,-0.11392,0.064201,0.195537,-0.517968,-0.211587,-0.40003,-0.193007,0.0521542,0.511023,0.0197984,0.0164868,-0.403129,0.154253,0.607929,0.213392,-0.509124,-0.250145,0.373657,0.0938432,0.292342,0.0199022,0.214336,-0.450303,0.0612638,0.0841714,0.506331,-0.498044,-0.406384,0.247751,-0.0611019,-0.220027,0.0844123,-0.047453,-0.324826,-0.27293,-0.488504,0.792086,0.200402,0.106887,-0.00371668,-0.130832,0.183154,0.445703,-0.814154,-0.0322368,-0.708353,0.321553,0.476636,-0.152515,-0.123623,-0.619854,-0.105739,0.27907,-0.223419,0.303714,0.0466949,-0.454338,0.116662,-0.0993874,-0.431851,0.0479004,-0.0833294,-0.378618,-1.08273,0.457144,0.256755,0.0762106,0.325382,-0.0414182,0.054487,-0.135066,-0.398426,0.632324,0.436307,-0.176265,0.513959,-0.150745,-0.733405,-0.223209,-0.463418,-0.103528,0.495921,-0.364457,-0.475547,0.277617,-0.689993,-0.390771,-0.108454,0.261735,0.156832,0.502209,-0.122082,-0.0335133,-0.131041,-0.317561,-0.0669264,-0.232732,-0.220341,0.132307,0.0819136,-0.443617,0.0588926,0.0293408,0.173955,-0.246954,0.234859,0.0928074,-0.0898374,-0.00123745,0.289033,-0.414367,-0.0603128,0.222315,0.176645,-0.126354,0.482248,-0.0405593,0.30915,-0.208767,-0.00597563,0.375417,-0.320829,-0.153002,0.100042,-0.616674,-0.310198,-0.20788,-0.40688,-0.514868,-0.166429,0.106984,0.0836034,0.327084,0.289143,-2.02672 +3425.62,0.97189,0.0912059,4,1.64473,0.580596,-1.11816,0.519346,0.443768,-0.157503,-0.394535,-0.450464,0.133573,0.315417,0.229134,-0.0754093,-0.393708,0.489098,0.31793,0.101007,0.286595,0.128833,0.0756483,0.378333,0.246201,-0.307409,-0.948175,0.378052,-0.326878,0.00460775,-0.287231,0.256918,0.121303,-0.210564,0.942752,-0.371262,-0.0864242,0.300953,-0.27526,-0.33495,0.0543979,0.369862,0.172109,-0.0507964,0.99837,0.449289,0.281812,-0.270133,0.0579084,-0.165303,-0.0440615,-0.333284,0.242247,0.0271387,-0.0352986,-0.0987324,-0.122303,-0.294931,0.584909,-0.252487,-0.186227,-0.234986,0.409882,-0.50306,0.264723,0.89781,-0.472784,-0.258559,0.304663,0.0676689,0.0129161,0.279354,-0.0793297,0.0855091,0.0124177,-0.37292,0.763994,-0.00301868,0.643435,0.615174,0.222579,0.0401536,-0.282,0.28872,0.177573,-0.0978636,0.503771,-0.0828995,-0.700947,-0.164216,0.287059,-0.468686,-0.150574,-0.0670147,-0.309589,0.292636,0.243312,-0.0969078,-0.0283052,-0.359143,-0.490048,-0.98233,0.28683,0.457049,0.43227,-0.504506,-0.43148,-0.716241,-0.261077,-0.592516,0.176428,-0.700783,-0.22237,0.508819,-0.159753,0.0802738,-0.077475,0.318652,0.0509377,-0.168877,-0.916244,0.0617716,0.834973,0.0460593,-0.578087,0.288191,0.212289,-0.373533,0.537133,0.115354,-0.273643,-0.355043,0.199805,-0.310596,0.2798,0.0984231,0.0977268,0.368138,-0.279294,-0.343134,-0.1438,-0.180246,0.206923,-0.515813,0.113027,-0.207139,0.46007,-0.296439,-0.403629,0.103017,-0.102777,0.716105,-0.238596,-0.0512273,0.0260719,-0.102525,0.367668,0.148687,0.499878,-0.0472138,-0.0474808,0.284567,0.0837213,0.407185,0.764954,-0.283452,0.469443,0.335998,-0.293145,-0.233568,-0.355413,0.102334,-0.0686925,0.405542,0.159932,-0.193164,-0.0417834,-0.22573,0.132259,0.19383,-0.0701478,-0.30104,-0.0231348,0.210504,-0.0621044,0.117537,0.0894235,-0.1002,0.315911,0.310717,-0.485459,-0.300619,0.189957,0.187581,0.0337812,-0.712719,0.126762,-0.634554,-0.211347,-0.172915,-0.256695,-0.257846,-0.867091,-0.379537,-0.112764,-0.137799,0.284151,-0.102904,-0.0394103,-0.132469,-0.0439729,1.04887,0.706313,0.330777,-0.135325,-0.289698,-0.193071,-0.0387754,-1.07144,0.498163,0.170212,-0.0492159,0.212882,-0.767368,-0.228205,-0.939502,0.336745,-0.193668,0.207035,0.211584,0.00371723,-0.0731317,0.0364704,0.618467,-0.384824,0.129263,0.059269,-0.418016,0.0838355,0.633956,0.245717,-0.393963,0.29328,-0.199009,-0.31285,-0.316147,-0.149227,0.0244673,0.241298,0.182013,0.210857,0.0143583,-0.178011,0.0152298,-0.92463,0.325173,0.411822,-0.369883,-0.109915,-0.170132,-0.552442,-0.205674,0.112286,0.538298,0.0164122,0.259914,0.114098,0.148104,0.0980848,-0.00604237,0.0133753,-0.193195,0.0193335,-0.193267,-0.186664,-0.260413,-0.156732,-0.177841,-0.424288,-0.303779,0.0797136,0.00152833,-0.0257449,-0.0167418,0.0999615,0.166044,-0.356062,0.243856,0.100662,0.35146,-0.365413,0.0213066,-0.135448,0.0938927,0.192378,0.0236884,0.0397904,0.230501,-0.110027,-0.506735,0.0700372,-0.239904,-0.86604,0.0416194,0.192515,0.126038,0.136226,0.355018,0.369087,-0.720601 +3428.62,0.985079,0.0912059,4,1.47913,0.757917,-0.828938,0.402317,0.562669,-0.177645,-0.488423,-0.129917,0.52089,0.384633,0.582444,0.325011,-0.226921,0.548393,0.151916,0.458387,0.402807,0.275854,0.382799,0.335672,0.14363,0.116781,-0.8444,0.759213,0.148933,0.174947,0.411196,0.0640798,-0.381274,0.087953,0.995949,-0.355301,-0.231837,0.475458,-0.352413,-0.0768907,-0.584995,0.797144,0.666492,-0.348182,0.885798,0.272175,0.244348,-0.361491,-0.0327609,-0.434186,-0.418434,-0.254873,0.439897,0.0441094,0.15084,0.0132963,0.0313714,-0.192694,0.91757,-0.0415232,-0.00763107,-1.00045,0.193847,-0.597365,0.271756,1.06454,-0.547088,-0.76544,0.0536146,0.244603,-0.0379048,-0.553074,0.126764,-0.393824,-0.683351,0.224011,0.605048,0.18628,1.45393,0.508238,0.246297,-0.328008,-0.394865,0.0983692,-0.0996484,-0.128091,0.114953,0.0729554,-0.427397,0.204546,0.416408,-0.121833,0.222025,-0.385562,0.422157,-0.0870657,0.320734,0.263508,0.790931,-0.0951848,-0.308107,0.0811344,0.162048,-0.435637,-0.241493,-0.216508,-0.775635,0.280172,0.293648,-0.190298,0.357709,-0.134269,-0.136884,0.591888,0.0138769,-0.32834,-0.260083,0.297527,-0.106179,0.094964,-0.190238,0.183278,0.18552,-0.205469,-0.543691,0.0914951,-0.209959,-0.974669,-0.3666,0.0864445,0.314068,-0.292862,-0.00931268,-0.93869,0.561268,0.166717,0.0585255,0.450272,-0.0883767,0.237642,-0.122499,-0.155388,0.214918,-0.719952,0.0507857,0.0683072,0.33746,-0.0961055,-0.522294,-0.599843,0.00521368,1.09459,-0.014821,-0.472098,0.0218856,0.596578,0.255743,-0.0786648,0.488016,0.185105,-0.180377,-0.223053,-0.0105076,-0.152238,0.562783,-0.331395,0.272602,-0.410663,0.0811099,-0.267551,0.119999,-0.056636,-0.401058,0.0150952,0.282295,-0.863764,-0.233928,0.172738,-0.122712,-0.0734525,0.082848,-0.506103,-0.345952,0.414235,-0.219629,0.266139,-0.13587,0.10283,0.477926,-0.531968,0.0404269,-0.386276,0.0957721,-0.00395878,0.153955,-0.280838,0.504875,-0.30522,0.410325,0.211383,0.0573444,-0.475613,-0.847725,0.126539,-0.482486,-0.293522,0.292165,-0.0741893,-0.291684,-0.403398,-0.254346,0.874744,0.0942368,0.226342,-0.00891595,-0.283306,0.505689,0.21908,-0.524939,0.430479,-0.610641,0.0482795,0.462618,0.0951807,0.0840928,-0.299894,0.269092,0.0532915,0.455658,0.749622,0.0960134,-0.241113,-0.137106,-0.405274,-0.375045,-0.0985851,-0.512389,-0.127964,-0.408572,0.325925,-0.0363406,0.150081,0.444016,-0.629806,0.0984885,0.102363,0.0526094,0.273111,0.615619,-0.363159,0.228925,0.00236982,-0.0414838,0.119343,0.20056,-0.506745,0.399839,0.117418,-0.0781129,0.00612709,0.096304,-0.0069345,0.0645343,-0.0404105,-0.521706,0.246094,0.457553,0.14486,0.384917,0.489984,-0.0828858,-0.066258,0.160146,0.121341,-0.0804468,0.110716,0.0160784,-0.132286,0.0370273,-0.0238225,0.234825,0.301196,-0.19571,-0.135045,0.198371,-0.286412,0.169507,0.0616174,0.255382,0.136379,0.105276,0.220355,0.0856809,-0.428392,-0.044753,-0.0657979,0.00422039,-0.4499,0.106537,-0.130284,0.142145,-0.227544,-0.475144,-0.169413,0.116102,0.114791,0.201483,0.338809,0.448869,-1.63036 +3412.88,0.994878,0.0912059,4,1.43422,0.701234,-0.636735,0.426138,0.271525,-0.112203,-0.276228,0.261742,0.419482,0.184613,0.344077,0.589623,-0.140459,0.884679,0.239252,0.463023,0.439038,0.30036,0.297435,0.420037,0.422243,-0.744734,-0.529427,0.922931,0.41526,0.234067,0.0240732,0.298287,0.126367,0.0973903,1.31304,-0.738859,0.431043,0.3922,-0.469964,-0.434343,-0.735398,0.212211,0.252916,-0.360292,1.20106,0.492304,-0.194854,-0.381493,-0.179389,0.0737443,-0.241549,0.27269,-0.240585,-0.20015,0.238769,-0.10155,-0.0706351,-0.249032,0.858014,-0.24738,-0.208874,-0.998162,0.592175,-0.0173615,0.369268,1.17589,-1.00439,-0.37705,0.050365,0.281092,-0.178253,-0.576062,0.0477662,-0.830719,-0.539894,0.2984,0.704581,-0.084744,0.908927,0.343993,0.157688,-0.190122,0.166979,-0.00433001,0.352967,-0.0136861,0.0955686,-0.374347,-0.155247,0.244668,0.0436889,0.0224947,0.072918,-0.471091,0.50508,-0.189741,-0.0386176,0.131639,0.582353,-0.550463,-0.115709,0.237983,0.16058,-0.0989829,-0.0824956,0.157674,-0.504579,-0.289341,0.42732,0.0978399,0.619802,-0.122585,0.34025,0.459495,0.201421,-0.343574,-0.141841,0.0687144,-0.0381828,0.0977423,-0.417194,-0.243896,-0.594449,-0.2887,-0.740112,0.0866462,-0.0111816,-0.248796,0.354985,0.535128,0.160766,0.0966735,0.43202,-0.588517,0.392363,-0.0752737,0.0555906,0.913788,-0.0799207,0.187757,0.385978,0.283417,0.481832,-0.565993,-0.413586,-0.00138772,0.312168,-0.272044,-0.571406,-0.0442252,0.0521183,1.09793,0.0325169,-0.485585,-0.369809,0.172089,0.0875479,-0.416676,0.496566,0.0131974,-0.18485,-0.0762013,-0.142825,-0.279268,0.587613,-0.32749,0.290643,0.563482,-0.0978991,-0.0562726,0.546558,-0.329349,-0.395251,0.139788,0.704086,-0.4637,-0.21413,0.233238,-0.231498,0.0168166,-0.334745,-0.740113,-0.362062,0.451754,0.348191,0.418428,-0.123423,0.190808,0.0465269,-0.267535,0.613221,0.305688,0.241592,-0.248802,-0.121961,-0.0268578,0.256493,-0.521473,-0.223175,0.696177,0.231835,-0.516493,-0.468456,0.046746,-0.426045,-0.483665,0.234832,-0.441389,-0.129343,0.13516,-0.105361,1.02672,-0.230364,-0.323649,0.285532,0.318286,0.104325,0.366994,-0.655788,0.524671,-0.389849,0.0888607,0.53295,-0.483151,-0.253211,-0.152229,0.582091,0.216896,0.21607,0.769516,-0.183337,-0.486529,-0.361788,-0.0632162,-0.94019,-0.336882,-0.313381,0.0276613,-0.537273,0.312784,-0.190397,-0.215344,-0.0194348,-0.45285,0.667284,-0.0237227,-0.159298,-0.0411868,0.197896,-0.149942,0.54302,-0.0195362,0.101954,-0.0231422,0.238272,-0.0577408,0.787046,0.00736858,-0.4471,0.354362,-0.511326,0.275613,-0.0834963,-0.0562829,0.153017,0.466095,0.470876,0.410292,0.667455,0.0690672,0.116012,-0.418078,-0.46435,0.198723,-0.189518,-0.128552,0.03289,0.375543,-0.143785,0.327319,0.18118,0.375615,-0.345181,-0.135661,0.178618,-0.0403382,-0.000398866,-0.361652,0.14759,0.00755976,-0.203995,0.304502,0.591481,-0.515816,-0.0887701,0.171377,0.596311,-0.340712,0.172689,-0.529785,0.176659,-0.126286,-0.496116,-0.110587,0.133072,0.157026,0.288486,0.396265,0.537109,-0.748471 +3429.19,0.846161,0.0912059,4,1.61832,0.661775,-0.986182,0.461101,-0.030283,-0.0269646,0.129962,-0.121173,0.639802,0.0141437,0.0989197,0.186448,0.0540996,0.991554,-0.180228,0.918357,0.316069,0.041604,-0.319798,0.180977,0.218437,-0.359276,-0.436049,0.831847,-0.465285,-0.31683,0.350646,0.300258,-0.631317,0.0630599,1.45604,-0.300209,-0.410935,0.299217,-0.331131,-0.0190343,-0.543454,0.52203,0.0716754,-0.620526,1.24253,0.603145,0.100525,-0.899403,-0.0563777,-0.610191,-1.62901,-0.658687,0.0632746,-0.188964,-0.21044,0.335886,0.0179608,-0.221198,0.802303,-0.229915,-0.721357,-0.139756,0.190255,-0.506223,0.383906,0.726421,-0.97121,-1.71372,0.253193,0.146603,0.122248,-0.187109,0.324938,0.230296,-0.584747,-0.0597933,0.374819,0.217771,0.215427,0.713575,0.354265,-0.354553,-0.341019,-0.0110476,0.721586,-0.789416,-0.0828408,-0.252151,-0.169396,-0.43817,-0.184652,-0.127295,0.407143,-0.388164,-0.29187,0.136549,0.0127386,-0.358456,-0.309142,0.0310728,0.342688,-0.544074,0.37832,0.29059,-0.00087326,-0.118518,-0.0726453,-0.416906,-0.106058,-0.478211,-0.0422768,0.0791859,0.504001,0.501717,-0.20301,0.188598,-0.0734988,0.106941,0.0961576,0.427546,-0.118846,0.23166,0.6577,-0.557473,-0.332557,0.403029,-0.186392,-0.207853,-0.222799,-0.29916,-0.193344,0.136044,0.207607,-0.201394,-0.32057,0.0393569,0.27308,0.111246,-0.0463685,-0.326185,-0.0225021,-0.321162,0.202822,-0.642104,-0.100709,-0.351269,-0.0198088,-0.69658,0.363946,0.18801,-0.369844,0.0197556,-0.318952,0.32304,-0.248275,-0.0991605,0.122261,0.0936162,-0.327757,0.0699227,0.262134,0.19581,-0.169301,-0.0333921,0.224089,0.14746,0.714954,-0.493404,0.199727,0.321096,-0.431182,0.216996,0.311337,-0.0902403,-0.14724,-0.136399,-0.222529,-0.212139,0.212427,-0.180512,-0.00427627,0.198478,0.0825161,0.460631,0.429472,-0.474187,0.217007,0.0880373,0.0253933,-0.749224,-0.941819,-0.305753,-0.31117,0.00145386,0.104821,-0.12328,-0.16913,-0.0950302,0.297856,-0.419506,0.0873988,-0.14988,-0.367949,-0.0513053,-0.0105743,2.58931e-05,0.176408,0.233323,0.0745862,-0.120977,-0.457621,0.685288,0.123943,0.617129,-0.366843,-0.724124,0.197392,0.119412,0.180222,0.0246692,-0.195542,-0.268061,-0.480591,0.29045,0.214292,-0.4605,-0.281289,0.469152,-0.202518,0.284529,-0.412662,0.332161,0.30933,0.245984,0.294765,-0.179483,-0.315153,0.194748,0.124394,0.489539,0.00060936,0.0429976,0.599087,-0.473475,-0.554621,0.0727436,0.440696,0.169733,-0.00830749,0.388301,0.593313,-0.227084,-0.18511,-0.537447,-0.0624618,-0.573323,0.230502,0.155227,0.168034,0.181106,0.0673763,-0.0886576,0.23107,-0.14729,-0.11413,0.204661,-0.359387,-0.473759,-0.0568434,0.104149,-0.158693,0.444948,0.311512,-0.0938451,-0.118215,-0.0794541,-0.390341,-0.0519278,0.221071,-0.537298,-0.394571,-0.22651,-0.0398871,0.387424,-0.342062,-0.304476,-0.138073,0.540464,0.396135,0.122477,0.239474,-0.120854,-0.484358,-0.0682169,0.0547539,0.0774436,-0.112363,-0.240904,-0.330471,0.00259854,-0.585055,-0.107065,0.319207,-0.0839151,-0.376134,0.105768,0.336023,0.32522,0.579675,0.63647 +3436.71,0.813184,0.0912059,4,1.55891,0.725909,-1.10145,0.515399,0.380658,-0.156512,-0.273311,0.374213,0.336001,0.152892,0.288426,0.0108271,0.0807874,0.583317,0.261601,0.96755,0.224965,-0.121955,-0.0760997,0.117102,0.229009,-0.987075,-1.16196,0.600627,-0.376048,0.317661,0.00338509,-0.225341,0.023219,0.234604,0.971695,-0.502209,0.106468,0.913342,-0.228733,-0.609902,-0.1896,-0.203369,0.296621,-0.362489,0.511633,0.658466,0.0921462,-1.02345,-0.182585,-0.37133,-0.505525,-0.172775,0.487305,0.0932563,0.0469875,0.17843,0.343405,-0.456768,0.719107,-0.096628,-0.0633581,-1.40306,0.211337,-0.439643,0.405174,0.837284,-1.63004,-1.18345,0.029356,0.0809014,-0.091122,0.419288,0.142653,-0.488601,0.204201,-0.286178,0.628885,-0.165687,0.216725,0.53424,0.138282,-0.11791,-0.0728193,-0.176428,0.461848,-0.145803,0.0481589,0.454859,-0.757894,0.0687909,0.159807,0.169566,-0.345333,-0.132072,0.284848,0.000764478,-0.350899,0.239617,0.257951,-0.00424718,0.0762699,0.184749,0.00130531,0.195424,0.117491,0.0557659,-0.496792,-0.405896,0.0839836,0.288944,0.700544,-0.283744,0.118449,0.608028,-0.0370524,-0.469521,0.112199,0.384923,-0.146252,0.11601,-0.0881052,0.258001,0.041663,-0.305294,-0.493544,0.0249329,-0.31636,-0.120355,0.458988,0.101998,-0.355032,-0.0209392,0.147073,-0.332845,-0.196423,-0.252185,0.05648,0.133733,0.01715,0.329114,0.39698,0.0111969,0.333506,-0.710324,0.0765256,-0.17372,0.0139744,-0.380179,-0.420098,0.136951,0.324281,0.295995,0.226623,-0.088583,-0.195895,-0.332732,-0.0203715,-0.169314,0.173026,0.365032,-0.0192309,0.195452,0.240304,-0.343403,-0.00793431,0.259777,0.418542,0.0854428,0.0213542,-0.265125,0.424621,-0.0873893,-0.282313,-0.154644,-0.162515,0.327616,-0.125892,-0.0494848,0.18734,0.243312,0.0415136,0.309167,-0.132181,0.654125,-0.0284991,0.146669,-0.0913187,0.236541,-0.538218,-0.790407,-0.566446,-0.000839346,0.461795,-0.219932,-0.103281,-0.121002,-0.10642,-0.389826,0.199256,0.590492,0.491569,-0.462192,-0.271029,-0.157032,-0.349139,0.131308,0.159674,-0.796977,-0.0959817,-0.0392988,-0.337499,1.02785,-0.335646,-0.155117,-0.151278,-0.503598,0.217412,-0.0566399,-0.213713,0.37068,-0.00498411,0.254256,0.467462,-0.373441,0.149539,-0.463406,0.0774778,0.0663143,0.367034,0.130496,-0.687371,-0.205683,0.444375,-0.17305,-0.0172279,0.0339802,0.246721,-0.150979,0.0296278,0.408178,-0.403935,-0.0430169,0.411916,0.779453,-0.405559,0.332372,-0.814867,-0.233712,-0.0561033,-0.122897,0.472986,0.0567977,-0.528163,-0.177414,-0.207962,-0.923022,0.618236,-0.106263,-0.259327,0.24338,-0.468101,-0.140007,-0.0646006,-0.158318,0.339445,-0.0480286,0.0822422,0.759754,0.0994575,0.380818,-0.0667455,-0.625498,-0.0447749,-0.0694233,-0.126332,-0.185912,-0.634908,0.0852407,-0.148906,0.331895,0.559198,0.203232,0.261447,0.312356,0.0826987,-0.495317,-0.224989,0.0563878,-0.160718,-0.590951,-0.211014,0.304569,0.0593299,0.0520946,-0.279327,-0.00624078,0.131439,0.551544,0.096588,-0.489528,-0.310212,-0.00298269,-0.215666,0.919901,0.0125674,0.0906722,0.326475,0.301118,0.57138,-0.859106 +3421.19,0.976381,0.0912059,4,1.5377,0.747488,-0.782557,0.31441,0.311853,-0.136808,-0.212553,0.508894,0.690006,0.130241,0.33345,0.330257,0.194102,0.599802,0.100535,1.1463,0.195232,-0.038415,-0.157922,-0.0760632,0.131072,-0.48394,-0.619493,0.9887,-0.416891,0.138076,0.115608,0.250125,-0.35229,0.489015,1.34382,-0.000757132,0.107088,0.392603,-0.413312,-0.288863,-0.75556,0.479134,0.250807,-0.729802,0.68329,0.0299334,0.720933,-0.698976,-0.0812493,-0.0854539,-0.411565,0.0278389,0.281662,0.0248603,0.0190456,-0.252836,0.0772031,0.226221,1.04286,-0.235988,-0.571446,-0.721792,0.134853,-0.440567,0.195981,1.22941,-0.872362,-1.79676,0.00493995,0.631195,-0.214074,-0.273672,-0.197434,-0.231779,-0.356496,0.131921,0.679255,-0.569235,0.106727,0.443834,0.683254,0.0351778,0.161889,0.287368,0.564727,0.135509,-0.324535,-0.0130065,0.105149,-0.0213374,-0.0515416,-0.34792,-0.270275,-0.449746,-0.302228,-0.0521678,0.0169441,-0.432015,0.243394,-0.0700632,-0.0405742,0.153743,0.297442,0.751963,-0.0169783,0.170547,-0.71095,-0.263148,0.217377,-0.15717,-0.252664,-0.437236,0.33779,0.454822,0.232658,-0.0992661,-0.157634,0.105476,0.0262139,0.899089,0.0375536,0.525657,0.334515,-0.440851,-0.868985,-0.242925,-0.122113,0.038605,0.247971,-0.250707,-0.294885,0.247834,0.0689842,-0.314079,0.0525614,-0.187037,-0.162153,0.381055,0.0018123,0.1163,-0.282038,-0.156617,0.276173,-0.532794,-0.199813,-0.427563,0.476174,-0.702712,0.218313,0.0342739,-0.0702587,-0.22249,-0.370111,-0.016993,-0.170792,-0.615685,0.350406,0.48293,-0.256832,0.220724,0.136896,-0.54119,0.296984,-0.0060869,-0.0351035,0.255796,0.844992,0.151475,0.125742,0.47096,-0.420762,-0.356339,0.0683282,0.376527,-0.434477,-0.63886,-0.209248,-0.104804,-0.218019,0.0155635,-0.540287,0.0345692,0.0923717,0.0907614,0.213867,-0.749557,0.237308,0.0619527,-0.2515,-0.455411,0.426975,-0.599044,-0.641109,-0.0824717,0.267166,-0.0930269,-0.256477,-0.174285,0.0601587,-0.679723,-0.17574,-0.24712,-0.490923,0.0790927,-0.306823,-0.398222,-0.06829,0.153839,0.178065,0.183044,-0.199839,0.579538,0.10669,0.336503,0.339568,0.344738,0.314769,0.420726,-0.093953,0.0350761,-0.154757,0.256655,0.132813,-0.77783,0.319675,-0.795505,0.110244,0.243308,-0.648313,0.533183,-0.0951688,-0.477368,0.415564,0.356681,-0.679211,-0.194441,-0.35286,-0.466654,-0.303416,0.819929,0.392032,0.171605,0.0258203,-0.0951177,0.235845,-0.304157,0.19686,-0.0307266,0.282751,0.13557,0.167738,-0.0322152,0.190649,0.00108374,-0.364324,-0.494448,0.353367,-0.172084,-0.343458,0.536932,-0.402729,0.222953,-0.201639,-0.165604,0.807371,0.214501,-0.090488,0.472645,-0.139866,-0.1891,-0.0338826,0.180719,-0.658067,-0.0965807,-0.280124,-0.415795,0.523881,-0.104426,0.397529,-0.0109536,0.250507,0.0892433,0.0328709,0.285664,-0.0460582,0.0596069,-0.963624,-0.0724738,0.153783,0.108377,0.0184244,0.484901,0.0465641,-0.139146,0.159201,0.0326497,-0.425083,-0.00960245,0.531908,-0.437749,0.123022,-0.0880461,0.0210569,0.225153,-0.238647,0.140408,0.352248,0.374711,0.593505,-0.671912 +3455.51,0.586501,0.0912059,4,1.64418,0.649785,-1.54553,0.64511,0.157914,-0.223304,-0.204167,0.189277,-0.00248725,-0.255358,0.150501,0.304313,-0.426922,0.506448,-0.106985,0.698695,0.214505,0.0765792,0.134637,-0.0865706,-0.0148589,-0.640156,-0.879183,0.474455,-0.191021,-0.475559,-0.236481,-0.280467,-0.230214,0.119232,1.03517,-0.515372,-0.332597,0.523931,-0.453797,-0.537127,-0.26846,0.574407,0.78627,-0.412144,0.659275,0.797256,0.114649,-0.820132,-0.241326,-0.0929045,-0.679423,0.0310206,0.66902,-0.143987,0.0429832,0.573716,0.0408373,-0.185093,0.473988,-0.421543,-0.235305,-0.670098,0.0386537,-0.637516,-0.276017,1.16922,-1.26485,-0.853889,0.198063,0.191686,-0.379741,-0.378798,0.257298,-0.693617,-0.868588,0.336145,0.369161,0.00757651,-0.0318687,0.457551,-0.176477,0.00569174,-0.263585,0.170342,0.295225,-0.418417,-0.0111437,-0.319243,-0.069322,-0.0690558,-0.0810733,0.169302,0.0038856,-0.5986,0.123991,-0.184016,-0.288042,0.122552,0.290096,-0.253512,0.0864169,-0.514319,0.108311,0.419133,0.392848,-0.020688,-0.0865106,-0.0297758,0.621179,-0.346819,0.426217,-0.0868833,0.251767,0.288319,-0.406586,-0.487823,-0.125416,0.479738,0.319638,0.176878,-0.524765,0.213531,0.429184,0.263193,-0.671642,0.11693,0.2174,-0.020357,0.00371545,-0.351512,0.00617227,0.429879,0.340098,-0.423635,0.135151,0.432328,0.103261,0.250269,0.263878,-0.0629584,0.215249,0.102228,0.121008,-0.185912,-0.302204,0.168815,0.04664,0.107019,-0.113403,0.537222,-0.17161,0.0966543,-0.167689,-0.630026,0.147842,0.341655,-0.113472,-0.145532,0.523367,0.367841,-0.201393,0.153748,-0.412429,-0.191509,-0.322904,-0.0418745,0.412078,0.167063,0.35828,-0.200895,-0.236948,-0.0517403,0.119199,-0.321019,0.340198,0.344905,-0.0939818,-0.0992716,-0.372613,0.317509,-0.381217,0.239244,0.541367,0.389229,0.0408324,-0.194716,-0.0816937,0.177183,-0.231595,-0.296766,-0.35193,-0.136778,-0.0557116,-0.0720694,-0.214361,0.14023,-0.437901,-0.339184,-0.0168997,0.314546,0.415821,-0.728195,-0.0338364,0.00486083,-0.250906,-0.190391,0.153635,-0.0355475,-0.308996,0.0750098,-0.405413,0.746568,0.0698703,-0.426922,-0.0843665,-0.0313765,0.518602,-0.0730344,-0.13145,0.0206729,-0.0232076,0.480273,0.390266,-0.196427,0.00488502,-0.182655,0.0332795,-0.14159,-0.0856631,-0.084845,-0.527122,0.0777782,0.233276,-0.0690067,-0.244562,0.173574,0.197181,0.356614,-0.304727,0.33404,-0.0830704,-0.148679,0.26447,-0.260642,-0.0965691,0.280352,-0.272461,-0.215581,0.278339,0.191111,0.521486,-0.102798,-0.427852,-0.173174,0.456699,-0.3674,0.358511,-0.0346538,-0.215185,0.703294,-0.254099,-0.712377,0.191735,-0.0928777,0.0104594,-0.311697,0.102979,0.0048325,0.204441,-0.324818,-0.182719,-0.107312,0.264063,-0.0622325,0.292513,-0.0630856,-0.409437,0.125014,-0.569399,0.433767,0.299343,-0.0471397,0.117206,-0.0918392,-0.143917,0.197201,-0.0661417,0.417121,-0.183074,0.0866435,0.0152847,-0.497032,0.203449,-0.148749,-0.000809265,0.0154065,0.371696,0.583676,0.267502,-0.313056,-0.281119,-0.547331,-0.151457,0.191493,0.437796,0.087026,0.205563,0.295002,0.453391,0.22723 +3420.25,0.999697,0.0912059,4,1.59917,0.580748,-1.73945,0.820474,-0.0670762,-0.059375,0.302378,0.0612368,0.407255,-0.0163318,0.201079,-0.146761,0.0238451,0.785414,0.0597932,0.54452,0.469463,0.1277,-0.849878,0.112307,0.0129414,-0.333341,-0.28352,0.327485,-0.438662,-0.126785,-0.0187746,-0.208401,-0.0635512,0.0998286,0.880618,-0.60304,-0.281597,0.106451,-1.10246,-0.19071,-0.592589,0.59239,0.282906,-0.812723,0.952168,0.30817,0.63457,-0.707449,-0.363994,-0.00658692,-0.326252,-0.0500391,0.155823,-0.392303,0.326814,0.346267,0.402138,-0.782605,0.366825,-0.216182,-0.58695,-0.559993,0.184059,0.135934,0.505961,1.08962,-0.487095,-0.529853,0.0390595,0.233356,-0.249946,0.0626078,0.243035,-0.0868768,-0.170889,0.305844,0.611036,-0.281388,0.823044,0.480653,0.192794,0.443524,-0.0731074,0.145346,-0.0296683,-1.02638,0.512332,-0.0473251,0.0416205,0.0999954,0.241155,-0.987025,0.0791295,0.0335014,0.00349513,0.147902,0.0364799,0.0796443,0.321332,0.0138278,0.086905,-0.12851,0.0591893,0.142271,-0.0322582,-0.405698,-0.651694,0.0198031,-0.441017,-0.494093,0.558936,-0.503911,0.590736,0.0693804,0.319279,-0.0895896,0.455112,0.125927,0.104407,0.213704,0.0631294,-0.151056,-0.230591,0.0754221,-0.344457,0.49058,-0.413292,-0.0993533,-0.220667,0.434644,-0.0485752,0.208888,0.162968,-0.138047,0.0329877,-0.216751,-0.0726313,0.374814,-0.128864,0.0313828,-0.298774,0.156212,0.564929,-1.16019,-0.219276,0.0488959,0.281268,-0.744139,0.156509,0.194937,0.103437,0.47325,-0.053528,0.295194,-0.0838658,-0.187027,0.703704,0.433305,0.0555983,0.231704,0.0485818,0.0199155,0.647398,-0.00988896,0.934323,-0.695083,0.701178,0.0912427,0.149575,0.199381,-0.03686,-0.27827,-0.310134,0.450994,-0.462814,-0.318276,-0.0934614,0.0922189,-0.175606,-0.354899,-0.126496,-0.657349,0.0839794,0.27049,0.539734,-0.160055,0.313379,-0.730161,-0.208124,0.100574,-0.411182,-0.686695,0.281479,-0.311541,0.156092,-0.0709696,0.493319,-0.557238,-0.129425,0.241516,0.266099,0.0421426,-0.575036,0.229251,0.37977,-0.150009,-0.379617,-0.0186181,0.565737,-0.344007,-0.613264,0.862703,0.214224,0.413128,0.393315,0.0704938,-0.0550779,-0.375127,-0.0500637,-0.180368,0.110011,-0.026137,0.152852,-0.240276,-0.110167,-0.330862,-0.0891235,0.124419,-0.833681,0.709768,0.325355,-0.513416,-0.17283,-0.430719,-0.109574,-0.212733,-0.00427942,-0.181716,-0.119771,0.567872,0.518612,-0.293079,0.303953,-0.371406,0.25279,0.547188,0.0902376,0.29013,-0.150407,0.245997,0.384766,0.047418,0.509013,0.0570407,-0.426987,-0.150307,0.513337,-0.278267,-0.451018,-0.109615,0.138385,-0.0555413,-0.28071,0.399417,0.225655,0.68455,-0.0155883,-0.00482756,-0.129085,0.450109,0.100168,-0.115851,-0.366474,0.198068,-0.0324615,-0.475504,-0.417391,0.555698,-0.36344,0.193662,0.229084,0.404445,-0.395694,-0.0672101,-0.250292,0.0979362,0.0249194,-0.080057,0.233751,0.163631,0.0518089,0.126433,-0.233885,0.119684,0.00792635,0.251561,-0.154663,-0.188872,-0.0721714,-0.397522,0.68451,-0.390374,-0.223356,0.351443,0.184739,0.146745,0.266915,0.383073,0.516638,0.945784 +3410.24,0.976485,0.0912059,4,1.56643,0.660985,-1.73277,0.697954,0.0184597,-0.307838,-0.414207,-0.0529477,-0.647614,-0.26377,0.202324,-0.142629,-0.209777,0.590133,0.080769,0.333528,0.441212,0.173806,-0.0455695,0.460224,-0.0117156,-0.454392,-0.877804,0.130476,-0.333254,-0.395431,0.1692,-0.37606,-0.576763,0.00415527,0.710721,-0.319811,-0.50803,-0.126357,-0.821326,-0.168384,-0.334078,0.262168,0.614964,-0.741504,0.951646,1.06499,0.459481,-0.81365,-0.431024,0.195926,-0.672713,0.765227,0.424304,-0.402605,0.279072,0.636607,0.150207,-0.822241,0.270179,-0.703094,-0.40274,-0.419446,0.207261,-0.395429,-0.00727031,1.03889,-1.29445,-1.21243,0.415704,0.33969,0.161277,0.0621692,-0.0103359,-0.530659,-0.241518,0.382518,0.58362,-0.107745,0.714416,0.487662,0.131731,0.256899,-0.297353,-0.100091,0.511002,-0.26761,0.52723,0.0140919,-0.114976,-0.441868,0.66622,0.179245,-0.135088,-0.405905,-0.367544,-0.276607,0.581217,0.133655,0.242343,-0.413723,-0.0862747,-0.653786,0.884415,0.116785,0.280914,0.0454875,-0.379631,-0.213695,0.223364,-0.540643,-0.265869,-0.0371747,0.118626,0.442948,-0.544977,-0.27019,0.0406366,0.438507,0.358106,0.254508,-0.711456,0.478336,0.298081,-0.142853,-0.917312,0.183505,0.208808,0.559921,-0.177972,-0.187933,0.0753228,-0.19172,0.183215,-0.359699,-0.0814664,0.274854,0.452618,0.0330207,-0.101534,-0.806973,0.186401,0.084954,0.240457,-0.711361,-0.546009,0.595366,0.278315,-0.341129,-0.202025,0.310055,0.379863,-0.0761138,0.05001,-0.262306,-0.278881,0.662704,0.116724,0.0409658,0.196204,0.703948,-0.30085,0.605431,-0.534778,0.0527096,-0.332381,0.313114,0.663183,0.253238,0.416226,0.0836017,0.221482,-0.221312,-0.0464998,-0.311647,0.0605054,-0.075168,-0.184515,0.460819,0.239253,0.325695,-0.453777,-0.122834,0.294375,0.294242,-0.189118,0.139016,0.0555459,0.323028,-0.645776,-0.372296,0.673107,-0.298939,0.34688,-0.648946,-0.0727823,0.261499,-0.218199,-0.69187,-0.122586,0.270125,-0.526354,-0.429388,-0.675889,-0.122203,0.0323393,0.00236751,0.363291,-0.544829,0.258367,-0.387659,-0.850843,1.01884,-0.722126,0.000765782,-0.159054,0.366731,-0.0369083,-0.135777,-0.0605285,-0.00432047,-0.0928323,0.131165,0.412506,-0.320622,-0.331183,-0.257467,-0.11166,0.224218,-0.123202,0.234158,0.263361,0.0831709,0.0932835,0.0140302,0.493601,0.120443,0.0982397,0.395978,0.0334676,0.017233,0.222318,0.124334,0.290463,-0.182825,0.537798,-0.257511,0.170961,0.0823847,0.241172,0.001674,0.298067,0.192097,-0.635263,-0.325359,0.0184123,-0.252027,0.637595,-0.186488,0.454134,0.0721571,-0.309837,-0.0141591,-0.321701,0.496974,0.574213,0.192449,-0.287033,0.213513,0.24398,0.215841,0.132016,-0.478436,0.214208,0.744239,0.27473,-0.828634,-0.598795,0.4088,-0.240469,0.31494,0.305612,-0.2506,0.735299,0.0788095,0.371572,-0.32579,-0.08327,-0.355802,0.249408,0.32321,-0.407021,0.0291403,0.00973143,-0.277182,0.0502705,0.842049,0.536337,0.120595,-0.212053,-0.563297,0.0729192,0.182698,-0.373771,-0.786094,-0.195567,0.159673,0.27026,0.399591,0.519865,0.662029 +3400.63,0.580277,0.0912059,5,1.53616,0.754735,-1.33419,0.541082,0.610747,-0.126449,-0.192995,-0.0340985,0.307559,0.220027,0.198063,-0.391756,-0.621775,0.576652,-0.0487251,0.848317,0.134701,-0.362525,-0.627592,-0.25082,-0.132816,-0.882869,-1.18792,0.259626,-0.12123,0.142591,0.0692446,0.313514,-0.604843,0.0136225,0.965551,-0.604676,0.08877,0.440817,0.0428792,0.133785,0.00364589,1.14885,0.144954,-0.286396,0.810019,0.299122,0.129878,-0.396802,-0.237937,-0.188213,-0.447298,-0.099828,0.511513,0.410766,0.494709,0.119168,0.318811,0.00777866,0.220162,0.370388,0.136153,-1.05262,0.529306,-0.387533,0.40299,0.940945,-0.311768,-0.549468,-0.0353185,0.145469,-0.39544,-0.221099,0.249499,-0.274127,0.0832454,0.377976,0.29892,-0.0697158,-0.0377312,0.486846,0.504888,-0.24334,-0.271682,0.0825383,0.388992,-0.486956,0.193667,-0.235813,-0.0797084,0.120294,-0.611124,-0.611917,0.00611519,-0.335402,0.446857,0.360169,-0.0302736,-0.137467,-0.338265,-0.486212,0.266191,0.0370127,-0.6289,0.191113,-0.173808,0.397071,-0.30865,-0.432577,0.335619,0.115645,0.803143,-0.501497,0.25385,0.235067,0.820165,-0.237637,0.263396,0.827957,-0.149817,-0.222458,0.435548,-0.703839,-0.0895168,-0.143203,-0.470474,0.141644,-0.360503,-1.14249,0.606126,0.0502895,0.141409,0.0715551,0.251537,-0.0553176,0.423773,-0.356848,-0.534579,0.543552,0.014342,0.48178,-0.141587,-0.313469,0.278669,-0.450814,-0.060531,-0.302688,-0.0845779,-0.564672,0.0558078,0.0871499,-0.679164,0.455491,-0.025085,0.0188849,-0.358504,0.0976052,0.200233,-0.328768,-0.245861,0.0293726,0.438982,-0.487174,0.513266,-0.0667402,0.521117,-0.383251,0.388809,-0.363549,-0.35478,0.125967,-0.506099,-0.222414,-0.597365,0.362856,-0.102203,0.377609,0.292681,-0.213975,-0.420846,-0.488118,-0.384922,-0.194962,0.222061,0.996107,0.685773,-0.291559,0.397979,-0.091172,0.437486,-0.0850624,-1.18807,-0.265652,0.227021,-0.294298,0.0928045,-0.284582,-0.108302,-0.0572474,0.228055,0.120111,0.734676,-0.212478,-0.481388,0.306108,0.281465,-0.2708,-0.238021,0.0965163,0.104596,0.365899,-0.213811,0.914591,0.865897,0.216626,0.604142,-0.661294,-0.0716488,-0.279182,-0.526112,0.248753,-0.434649,-0.0835118,0.105416,-0.133557,0.254673,-0.770454,0.340268,0.21381,-0.618653,0.408083,-1.05051,-0.87892,0.091902,-0.271574,-0.638129,0.39134,-0.246853,-0.833832,-0.350219,0.502454,-0.30444,0.167701,0.428185,-0.28951,-0.472139,0.69289,-0.0416443,-0.142382,0.373417,0.314348,0.510646,0.422142,0.609213,-0.201325,-0.214277,-0.974803,0.554694,-0.0556418,-0.743299,0.60481,-0.195207,0.20611,0.663168,0.156659,-0.31648,0.42611,-0.0316022,0.0356119,0.435906,-0.126381,0.131558,0.151107,-0.279853,-0.100693,-0.409967,0.155252,-0.0751107,-0.157718,0.239122,0.087738,-0.148565,0.463199,0.0550325,0.139477,-0.799804,0.0351739,-0.683102,0.458984,-0.141427,-0.0603423,7.97277e-05,0.752977,-0.0845378,0.126112,0.138339,-0.589892,-0.388448,-0.0230129,-0.173851,-0.06591,0.181618,-0.295646,0.370099,0.324956,0.606097,0.160945,0.227268,0.40118,0.476727,-1.60625 +3414.03,0.623982,0.0912059,4,1.6354,0.612535,-1.60047,0.65782,0.612921,-0.127854,-0.15521,0.117457,-0.0687111,-0.145032,-0.0341234,0.107697,-0.00256257,0.470463,-0.594313,0.786303,0.186836,-0.162646,0.149512,-0.25095,0.189165,-0.767412,-0.975829,0.0211346,0.227027,-0.153094,-0.395965,-0.354944,-0.461101,0.0889925,0.905666,-0.926277,-0.171698,0.0887175,0.0434077,-0.492361,-0.259222,0.592715,0.355887,-0.0485518,0.719496,0.676581,-0.0392064,-0.872826,0.015227,-0.267464,-0.488057,0.0498616,0.498109,0.304255,0.115445,0.117244,0.0979886,-0.215469,0.385074,-0.155079,0.126367,-0.448513,0.361605,-0.453019,0.0515771,1.26763,-1.0019,-1.08868,0.228659,0.0769718,-0.20874,0.0596645,-0.157479,-0.05585,-0.733259,-0.0554154,0.567293,0.147975,0.70844,0.267639,1.05578,0.258337,-0.0943945,-0.501334,0.693858,0.264087,0.660651,-0.420518,0.135771,-0.0833796,-0.333013,-0.223201,-0.0979641,-0.403111,0.0774831,0.000721091,-0.044546,-0.339908,-0.304658,-1.30204,-0.371723,0.218761,0.0415554,0.358002,-0.188382,-0.200414,-0.708083,-0.310094,-0.445429,-0.57656,-0.260253,-0.181452,-0.0752637,0.498636,0.63585,0.267465,-0.154006,0.473563,-0.0400582,0.199108,-0.447687,-0.19838,0.227391,-0.454015,-0.981041,0.295144,-1.22999,-0.659273,0.450691,-0.0531113,0.0104439,-0.29688,0.147193,-0.394388,-0.485664,0.0244207,0.560063,-0.0255707,-0.00416999,-0.19877,0.0907963,-0.0473453,0.304855,-0.478264,-0.0873251,0.328176,-0.350274,-0.211278,0.533835,0.262378,-0.474431,0.56013,-0.23421,-0.0195884,-0.501501,0.225495,-0.914574,0.283365,0.451685,0.345907,0.399886,-0.182318,0.22367,-0.170793,0.670681,-0.368398,0.955336,0.33359,0.262261,0.218068,-0.057151,-0.441931,-0.160915,0.0861756,0.318398,0.0200682,0.194004,-0.00336382,-0.430777,0.310657,0.0334075,0.153018,-0.0325351,0.28763,0.372387,-0.102256,0.341258,0.0649054,-0.153899,-0.277235,-0.697113,0.0863235,-0.142256,-0.268161,-0.0586546,0.223576,-0.0148467,-0.426173,-0.0014496,0.419722,0.130092,-0.0494428,-0.228135,0.611277,0.190306,-0.264816,-0.229445,-0.475079,0.112494,0.324456,-0.4104,0.851542,0.173801,0.610807,0.0928892,-0.310754,0.264218,-0.379179,-0.398223,0.684927,-0.0615716,0.608516,0.164586,-0.738104,0.272115,-0.0662622,0.880658,0.246351,0.511427,0.254814,-0.483976,-0.28171,0.411828,-0.423798,-0.115283,0.217638,-0.393814,0.00592603,-0.289149,0.482941,0.0494384,-0.580079,0.0292268,-0.33068,0.176757,-0.117206,-0.0148118,0.129086,0.0842301,0.364918,0.650157,0.0468307,-0.167731,-0.55201,-0.599757,-1.20089,0.403436,-0.347627,-0.0767048,0.745571,-0.393899,0.373598,0.155483,0.554186,-0.362794,0.429219,0.223884,0.26629,0.442771,-0.0355924,-0.105079,-0.39989,0.191907,0.136292,-0.128781,0.196347,-0.620253,-0.116694,0.00431191,0.15228,0.368597,-0.296572,0.548701,0.0610325,0.199944,0.449315,-0.0567203,-0.0974945,-0.306233,0.285194,-0.692732,0.288629,0.258565,-0.0439618,0.443613,0.405157,0.06807,0.0214358,0.343927,-0.0691425,0.135576,-0.0346652,-0.764775,-0.285322,-0.690264,0.138059,0.26713,0.371562,0.516846,-1.23327 +3408.84,0.949256,0.0912059,5,1.6848,0.555785,-1.41088,0.629331,0.651271,-0.0289017,-0.25422,-0.0450965,-0.336717,-0.332507,0.01441,0.256841,0.087353,0.347921,-0.588874,0.767713,0.50267,-0.20965,0.0481499,-0.0277909,0.129582,-0.807137,-0.84824,0.271743,-0.0595446,-0.273681,-0.185998,-0.314347,-0.258886,0.247379,0.911747,-1.16091,-0.402926,0.246808,0.165763,-0.406401,-0.485355,0.708561,0.00958576,-0.556396,0.585926,0.562192,-0.403249,-0.546535,-0.318713,-0.481253,-0.498288,-0.202245,0.263798,0.313635,0.481175,0.297119,0.117695,-0.645339,0.486533,-0.457271,0.12618,-0.346185,0.368794,-0.477235,0.202064,1.1794,-0.875794,-1.47002,-0.158643,-0.218114,-0.379413,-0.379486,-0.104054,-0.176347,-0.647817,0.242007,0.385816,0.165163,0.62448,0.544557,0.904028,0.158672,0.0526887,-0.260767,0.956632,-0.0127128,0.771724,-0.394104,0.366718,0.257887,-0.22215,-0.279185,-0.0625635,-0.260721,0.13979,-0.00939971,-0.0814052,-0.49044,-0.319617,-0.930247,-0.505395,-0.177744,-0.0224145,0.472661,-0.626337,-0.0216647,-0.684068,-0.417812,-0.604264,-0.0496115,0.0102332,-0.13438,-0.0456397,0.237363,0.189818,0.249121,0.0745274,0.544582,-0.148912,0.209832,-0.327955,-0.222594,0.260585,-0.0540134,-0.994001,0.639236,-0.711164,-0.694543,0.000506249,0.0404703,-0.00786137,-0.264294,0.315797,-0.318134,-0.812862,0.0113736,0.366258,0.20849,-0.199277,-0.269207,0.118309,0.238215,0.378997,-0.366029,-0.332597,0.301629,-0.528399,-0.151009,0.360725,0.0890385,-0.36738,0.544637,-0.19435,0.287733,-0.544038,0.529305,-0.922184,0.309256,0.690379,0.13294,0.479215,-0.20707,0.148552,0.0858496,0.719911,0.0756873,0.673231,-0.0704482,0.0589382,0.00840551,-0.0292641,-0.159316,-0.130546,-0.126619,0.0454089,0.236942,-0.104487,-0.0470994,-0.364256,-0.0487747,-0.0669365,0.190683,-0.261943,0.289669,0.0981431,-0.0503448,-0.0501752,0.0166851,-0.387022,-0.315813,-0.607235,-0.135156,-0.251175,-0.524313,-0.0131452,0.313527,0.191842,-0.764244,-0.215179,0.344251,-0.0688179,0.28225,-0.0555159,0.363769,0.0757847,-0.214916,-0.147866,-0.243184,0.11736,0.112038,-0.564939,0.955734,0.258871,0.267885,-0.0828719,-0.271311,0.246249,-0.319381,-0.191964,0.268932,0.210954,0.47705,0.717428,-0.960531,0.0837031,-0.354398,0.689559,0.380531,-0.290834,0.51562,-0.425817,-0.21584,0.404373,-0.412375,-0.208927,0.244359,-0.432853,-0.143355,-0.591071,0.347151,0.0193905,-0.738176,0.15547,-0.0822208,0.258449,0.240055,-0.139573,0.149499,0.185428,0.18796,0.707059,0.0788642,-0.433721,-0.180381,-0.446299,-1.03298,0.107617,-0.129805,0.0387477,0.491794,-0.571092,0.676813,0.334246,0.451787,-0.350689,0.121943,0.0611821,0.295732,-0.0476788,0.115345,-0.295581,-0.0800854,-0.251429,0.255047,-0.449305,0.0747064,-0.860992,0.155888,-0.269892,-0.172129,0.329247,-0.0238,0.509333,-0.234987,0.362692,0.293853,0.0784179,-0.0309636,-0.15217,0.211929,-0.756494,0.367879,-0.0445268,0.0282915,0.347082,0.354203,-0.111153,0.238679,0.254699,0.13726,0.0612372,-0.0698611,-0.827334,-0.530448,-0.568853,0.166981,0.335314,0.408634,0.579063,-1.30819 +3410.04,0.850151,0.0912059,5,1.60567,0.877399,-1.62984,0.591358,0.728983,-0.0708862,0.00837888,-0.653546,0.501155,-0.110787,0.00682891,-0.162383,-0.998126,0.215252,-0.149027,0.726802,0.148177,-0.156346,-0.158913,-0.0865253,-0.375324,-1.24034,-1.16316,0.31487,-0.329679,-0.225148,-0.266565,0.454358,0.0230833,0.0862183,0.507623,-0.0658797,0.364402,-0.187285,-0.447902,-0.110665,-0.0357339,0.307799,1.06281,-0.233075,0.712278,0.747117,0.840407,-0.768094,0.0312458,0.652695,-0.569916,0.495652,0.271566,0.19941,0.196903,0.515668,-0.00179149,-0.321959,0.243555,0.556049,-0.0596704,-1.39199,0.223815,-0.414952,0.225565,1.15176,-0.546476,-0.938631,0.200688,0.471016,0.101881,0.470976,0.323848,-0.504117,0.0557309,0.579187,0.40177,-0.0941858,0.465698,0.124444,-0.168517,-0.0167587,-0.392145,0.289686,0.820905,-0.661308,-0.415899,-0.0748593,-0.275676,-0.259434,0.183493,-0.474102,0.396104,-0.328639,-0.331269,0.146644,0.486602,-0.106604,0.446452,0.134949,0.552647,-0.374756,0.552231,0.541307,0.731277,0.0114657,-0.16601,-0.122638,0.49473,-0.354363,0.397558,-0.400704,0.247027,0.706719,-0.0488635,-0.412203,0.240831,0.46224,-0.0729141,-0.144476,-0.209421,0.610373,0.351754,-0.434025,-0.669902,-0.341419,0.116666,0.309841,-0.186764,-0.0504863,0.176443,0.511936,0.0180501,-0.630928,0.897263,-0.188295,0.0524382,0.809712,-0.312755,0.202615,-0.0298388,-0.256566,0.258944,-0.542418,-0.147632,-0.34383,0.357905,-0.741991,-0.0741314,-0.0321307,-0.172887,0.318417,-0.0617517,-0.696665,-0.0177057,0.106267,0.562874,-0.282546,-0.34825,0.672147,-0.324654,0.294906,0.408652,-0.132069,0.0549592,-0.421085,0.56555,0.0846437,-0.129387,0.164369,-0.109977,-0.238542,-0.207128,0.0576107,0.463618,0.158223,0.0588978,-0.120622,0.0787717,0.155487,-0.267787,0.0170226,0.0222774,0.438959,0.246148,0.105162,0.738167,-0.0750259,0.0924154,-0.398289,0.370351,-0.294392,0.342016,-0.0594812,-0.0578818,-0.0276141,-0.236067,-0.436622,0.408123,0.199599,0.317356,-0.885207,-0.272778,-0.593427,-0.239708,-0.475127,0.760962,0.363367,-0.109196,-0.688547,-0.18693,0.788235,-0.35424,0.074206,0.479836,-0.586543,0.100553,0.48289,-0.0125368,0.173292,-0.664852,0.193506,-0.239647,0.578623,-0.303952,-0.549167,-0.968782,0.0960279,-0.522458,0.364289,-0.434893,-0.257758,-0.228611,0.598967,0.157615,-0.0589799,-0.435897,-0.158752,0.239124,0.615659,0.21118,0.454798,0.428988,-0.30921,-0.647198,0.235981,0.0519466,-0.463922,0.279096,0.140681,0.194639,-0.0613244,0.323282,-0.476759,0.553157,-0.336887,0.392294,0.030201,-0.474896,0.18735,0.00551483,-0.13003,-0.0585835,-0.431643,0.232295,0.55804,0.275365,-0.0292115,-0.235457,0.159749,0.22668,-0.143154,-0.0978891,0.146365,-0.38298,-0.443766,0.198469,0.120153,0.221166,0.642006,0.286392,-0.0439273,0.347932,0.234933,-0.634969,-0.357326,-0.617992,0.0223644,0.21121,-0.184569,0.457458,0.143303,0.384701,-0.372467,0.34702,-0.412611,0.0898363,0.226718,-0.293978,-0.618254,-0.491862,-0.519627,0.554011,0.454699,0.553615,0.145495,0.275274,0.381439,0.524666,-2.05234 +3415.88,0.998687,0.0912059,4,1.56312,0.911998,-0.977589,0.341467,0.596229,-0.137884,0.180159,-0.427804,0.261832,-0.192785,0.190835,-0.204008,-1.02159,0.556347,-0.391856,0.404967,0.0435318,-0.153972,-0.0614337,-0.449726,-0.224132,-1.43022,-0.369041,0.405311,0.0660419,-0.794163,-0.175222,0.334662,-0.246096,-0.00108612,0.877804,-0.0988339,0.18733,-0.0761701,-0.222581,-0.362163,0.323074,-0.0267856,0.712112,-0.595824,0.519378,0.310734,0.532171,-0.397955,0.231179,0.672776,-0.865858,0.357359,0.279935,0.105999,0.0255836,0.796061,-0.0102615,-0.374635,0.449967,0.381928,0.179929,-1.60777,0.120322,-0.558365,0.18881,1.19763,-0.269916,-1.01288,-0.2067,0.380844,0.420205,0.478542,0.270531,-0.262266,-0.0403942,0.337899,0.373229,0.169318,0.162327,0.232473,0.515068,0.0487271,-0.133575,-0.232998,0.719755,-0.691009,-0.295975,-0.166637,-0.25889,-0.178022,0.357287,0.0731837,0.434206,-0.536069,0.0735218,0.098822,0.397298,-0.0982263,0.220816,-0.119777,0.622065,0.0775743,0.281051,0.507788,-0.0238648,-0.427309,-0.396413,-0.251181,-0.0519457,-0.636674,0.0251281,-0.0405635,-0.0199986,0.351427,0.0649397,-0.0415638,-0.261889,0.447513,-0.048242,0.244797,-0.179456,0.447577,-0.125222,0.0875117,-0.450295,-0.536136,-0.283387,0.140537,-0.18784,0.0564399,0.67217,0.56981,-0.151299,-0.479757,0.964286,-0.213943,0.18703,0.496021,-0.156907,-0.0189561,0.232646,0.160492,0.379314,-0.388644,-0.118867,-0.214086,-0.0959384,-0.49384,-0.23368,0.380735,-0.420945,0.198443,-0.155579,-0.325124,0.0344354,0.54946,0.500992,-0.181785,-0.293685,0.533538,-0.186846,-0.203482,0.339455,-0.0167768,0.0522692,-0.282108,0.372385,-0.0721848,0.00409173,0.249995,-0.0692492,-0.292385,-0.252262,0.0050404,0.34989,-0.286165,0.104402,0.324067,-0.454027,-0.319543,0.115241,0.153526,0.31441,0.205301,0.36163,0.0636096,0.445417,-0.313866,-0.0665688,-0.409245,0.493869,-0.450825,0.0923136,-0.157812,-0.0311568,0.0345759,-0.144798,-0.648472,0.0383816,0.0622064,0.115252,-0.849668,-0.426005,-0.678483,-0.0744723,0.110232,0.578731,-0.493169,-0.293792,-0.837432,-0.440978,0.775481,-0.271629,0.236593,0.370407,-0.49141,-0.228232,0.27721,0.395578,0.084674,-0.613802,0.570713,-0.0317821,-0.324931,-0.304596,-0.506266,-0.673195,0.329544,-0.32952,0.633704,-0.0800395,-0.501321,-0.172064,0.151289,0.0344793,0.377286,-0.522081,0.0615752,0.2458,0.677641,0.416599,0.647389,0.271672,-0.199999,-0.389722,-0.110575,0.195666,0.375988,0.437281,0.200505,0.0905334,-0.22899,-0.00738589,-0.46711,0.208337,-0.700196,0.306088,-0.0395416,-0.0141753,0.482726,-0.0121468,0.00613334,-0.393135,-0.158111,-0.096275,0.470687,0.137676,-0.142298,-0.102357,0.0533947,-0.110027,-0.531355,-0.0855009,0.210092,-0.778388,-0.399602,0.0521466,-0.167687,-0.324311,0.0568786,0.14729,-0.0782618,0.575121,0.348431,-0.504324,0.0542354,-0.579946,-0.024817,0.166627,0.0794235,0.0469238,0.0664851,0.097615,-0.615383,-0.037527,-0.763378,-0.170373,-0.13075,-0.165135,-0.639486,-0.0761283,-0.37499,0.355411,0.820329,0.506543,0.124983,0.355937,0.35353,0.596604,-1.80433 +3427.78,0.916896,0.0912059,4,1.57101,0.799803,-1.201,0.364277,0.423839,-0.164385,0.204543,-0.368811,0.0467267,-0.201282,0.269981,-0.405213,-0.546168,0.392479,-0.474041,0.897452,0.010836,-0.14544,0.0827971,-0.144381,0.0335553,-1.20487,-0.460891,0.319679,0.0390928,-0.790664,-0.134906,0.14789,0.0508428,-0.156988,0.8955,-0.267783,0.0221637,-0.356925,-0.125299,-0.0874361,0.142376,-0.0678399,0.696443,-0.154887,0.481386,0.362248,0.210089,-0.292452,0.224845,0.294888,-0.588144,-0.29657,0.634409,-0.111597,0.415876,0.416484,0.327007,-0.336128,0.693167,0.427639,-0.402905,-1.18361,0.223198,-0.602927,0.0959103,1.17763,-0.748921,-0.676513,0.0919508,0.17972,0.181974,0.273609,0.192303,-0.115263,-0.0306832,0.407848,0.307038,0.157882,0.184881,0.405086,0.248935,0.200233,-0.175897,-0.196626,0.530651,-0.74824,0.00927779,-0.322533,-0.23813,-0.370677,0.677394,-0.357261,0.241184,-0.913103,0.214005,-0.476139,0.337098,-0.176997,0.134557,-0.570717,0.159213,-0.235405,0.118125,0.703813,0.0435979,-0.251268,-0.307101,-0.447611,-0.120738,-0.271854,0.0741151,-0.0563146,-0.00512271,0.338332,-0.0785217,0.166559,-0.00990455,0.539552,-0.0110057,-0.0597881,-0.175305,0.491085,0.0883153,0.311668,-0.531645,-0.436776,-0.228394,0.174169,-0.0512313,0.190007,0.592111,0.101811,-0.397522,-0.352809,0.374314,-0.29703,-0.247217,0.459406,-0.252765,-0.297644,-0.250941,0.0245813,0.53178,-0.530498,-0.613053,-0.258984,-0.0255353,-0.651202,0.0804592,-0.0152425,-0.385763,0.0809346,-0.0782125,-0.377004,0.260985,0.787167,0.456227,-0.170903,-0.366793,0.632336,0.143785,-0.37443,0.418862,-0.162378,-0.232996,-0.131912,0.300019,-0.252988,0.128891,0.196083,0.0534017,0.0531787,-0.185751,0.159165,0.378258,0.0138261,0.0197181,-0.311874,-0.080424,-0.282435,-0.202052,0.307196,0.27396,0.387925,0.364542,-0.566828,0.0358647,-0.397246,0.049105,-0.112909,0.639519,-0.305954,0.309804,-0.129018,-0.0131285,-0.0127088,-0.1049,-0.495675,-0.0328634,0.287809,0.133822,-0.522852,-0.511178,-0.502648,-0.26821,-0.171895,0.607309,-0.552608,-0.406228,-0.509797,-0.506651,0.720824,-0.385655,0.319177,0.195977,-0.418736,0.463288,0.144194,0.30495,0.0827989,-0.817393,0.618359,0.101866,-0.587706,-0.330089,-0.779462,-0.16829,0.0180728,0.0980584,0.462898,-0.134231,-0.0239965,0.556217,-0.11217,0.0560157,-0.00427244,-0.869296,0.0587101,-0.0567656,0.801555,0.0760966,0.961709,0.49905,0.0395496,-0.114493,0.0649978,0.103167,0.545614,0.391436,0.0471469,-0.0597424,-0.0214297,-0.241539,-0.295025,-0.0307236,-0.706868,0.487358,0.47622,-0.0475466,0.501605,-0.246608,0.192854,-0.0325916,0.141507,-0.119549,0.393189,-0.257637,-0.323873,-0.00637541,-0.132885,-0.0366743,-0.516099,0.0507797,0.0516366,-0.488052,-0.647524,-0.134027,-0.105303,-0.248549,-0.00412788,0.64428,0.413933,0.454012,0.318573,-0.480087,0.0551755,-0.624042,0.1885,0.257517,-0.0136201,-0.144612,0.110464,-0.15734,-0.633143,0.119035,-0.447721,0.216651,0.0625729,-0.348503,-0.101033,-0.113183,-0.156838,0.238101,0.535525,0.392971,0.14534,0.399349,0.381234,0.631941,-0.923395 +3405.62,0.993652,0.0912059,4,1.61817,0.851769,-1.03379,0.317818,0.235164,-0.0125781,0.0634188,-0.258873,0.137391,-0.19276,0.361432,-0.562547,-0.44624,0.582669,-0.122996,0.882208,-0.0799503,-0.28274,-0.2644,-0.271988,-0.0206567,-0.930391,-0.635317,0.168041,0.0678329,-0.343952,-0.275598,0.0668541,-0.12699,-0.174846,0.838622,-0.440353,0.00145595,-0.145674,-0.190292,0.0258323,-0.443017,0.344641,0.445755,-0.298944,0.710256,0.712322,0.379708,-0.480048,0.436745,0.0400216,-0.79064,0.0275533,-0.036801,0.00651464,0.0686534,-0.0695817,0.286483,0.0969642,0.528544,0.282539,-0.197336,-0.5703,0.453224,-0.322666,0.29095,1.23254,-0.626505,-1.62166,0.114162,-0.100579,0.0105638,-0.121418,0.0440011,-0.482199,0.0977702,0.745405,0.14998,0.455826,0.376953,0.675745,0.833082,-0.150553,-0.25875,-0.20014,0.880378,-0.99578,0.413925,-0.721009,-0.0651174,-0.256493,0.0283682,-0.869529,0.497507,-0.634852,0.387476,-0.398492,0.399354,-0.0109526,0.216719,-0.242205,-0.0507588,-0.46432,0.295507,0.237633,0.18507,0.0752731,-0.201663,-0.606652,0.000726103,-0.243259,0.116726,0.21509,0.215384,0.707393,-0.644903,-0.167717,-0.0998557,0.263367,0.0895264,-0.157188,0.383385,0.376455,-0.205806,-0.41989,-0.778502,-0.106458,0.134562,0.255569,-0.538511,0.153688,0.563327,0.177128,-0.0643839,-0.0472183,0.553547,-0.349889,-0.207286,0.216615,0.0891636,-0.072973,-0.0367324,0.507417,-0.0974334,-0.343878,-1.40018,-0.118233,-0.0772164,-0.788183,-0.0653252,-0.00352738,-0.646957,0.693358,-0.408659,-0.465859,0.30257,0.470858,0.283195,-0.108089,-0.624775,0.585606,-0.0833376,0.0605566,0.403596,-0.147483,-0.142168,-0.109933,0.488263,-0.617835,0.376769,0.468716,0.05861,-0.173374,0.00398375,0.119686,0.145432,0.520435,0.101864,0.459171,-0.0754439,0.263693,-0.312085,-0.176288,0.265826,0.125385,0.749088,-0.30118,0.560677,0.227607,0.0468235,0.171225,0.767364,-0.684519,-0.184817,-0.22204,0.179866,-0.249601,-0.00409165,-0.375186,0.197524,0.264343,-0.220818,-0.493721,-0.225026,0.0751069,-0.0215931,-0.028035,1.2235,-0.0670576,-0.202361,-0.751222,-0.362386,0.918875,-0.471055,-0.0795441,0.181905,-0.18622,0.000835514,0.268162,0.49316,0.528174,-0.649681,0.834309,0.217099,-0.084634,-0.362354,-0.70617,-0.122543,0.00413922,0.0621931,0.339064,0.105628,-0.199631,0.240096,0.208398,0.212017,0.323935,-0.252915,0.0100219,0.266489,0.649656,-0.0160498,0.490367,0.436046,0.274753,0.272306,-0.0085202,0.246288,0.305573,0.582301,-0.0449074,-0.201167,0.145316,-0.0794921,-0.546676,0.212963,-0.775477,0.688705,0.0678989,0.140684,0.200704,-0.321677,0.126082,0.352903,0.0235598,-0.257413,0.570974,0.0239456,-0.657033,-0.363661,-0.054976,-0.0400744,-0.514049,0.59909,0.0201358,-0.345958,-0.168793,-0.417099,0.156471,-0.428655,-0.085246,-0.0683306,0.192401,0.179331,0.099864,-0.536123,0.0197261,-0.917244,0.2648,0.376684,0.297853,-0.0791911,0.38252,-0.100104,-0.312054,0.0694592,-0.215738,0.504744,0.552066,-0.102817,-0.370244,-0.117512,-0.448552,-0.604862,0.281281,0.19908,0.145985,0.24372,0.38208,0.49368,-0.423504 +3406.92,0.983686,0.0912059,5,1.57716,0.831802,-1.2896,0.353788,0.581326,0.00593516,-0.210912,-0.375732,-0.101588,-0.200182,0.159308,-0.571559,-0.242911,0.430441,-0.297695,1.07635,-0.130815,-0.497282,-0.129948,-0.23717,-0.026869,-1.13946,-0.738919,-0.112016,-0.205766,-0.626832,-0.520835,-0.0902192,-0.114712,-0.066439,0.759146,-0.440214,0.325382,-0.126261,-0.0733044,-0.0492775,-0.139047,0.18387,0.353414,-0.127853,0.926925,0.990225,0.100874,-0.491493,0.284937,-0.224609,-0.594164,0.115226,0.375367,0.208087,0.00729331,-0.163656,0.14161,-0.216036,0.700926,0.183098,-0.113119,-0.852944,0.514052,-0.287409,0.447059,1.33081,-0.70934,-1.08373,-0.0705676,0.00959191,-0.03637,-0.0384866,-0.0758885,-0.541126,0.399316,1.00082,0.317441,0.190622,0.409206,0.520687,0.765421,-0.366851,-0.168623,-0.110928,0.537167,-1.15121,0.237041,-0.384391,-0.738743,-0.204665,-0.351695,-0.9621,0.458205,-0.539081,0.276439,-0.279632,0.468079,0.0219459,-0.180444,-0.123003,-0.429289,-0.547612,0.235707,0.306041,0.168132,-0.0941476,-0.448076,-0.218352,0.1176,0.0605179,-0.216157,0.401122,0.46628,0.784189,-0.456671,-0.0751488,-0.227186,0.561023,-0.216014,-0.188197,0.546458,0.278774,-0.294596,-0.268914,-0.472513,0.0513172,-0.104765,0.0591389,-0.276818,0.30087,0.152404,0.137947,-0.300049,-0.171124,0.321822,-0.414033,-0.457314,0.0629902,0.0584262,-0.125182,0.205583,0.42339,0.013993,-0.693158,-1.46181,-0.216016,0.0645747,-0.643359,-0.142013,0.116436,-0.604873,0.582447,-0.157341,-0.15894,0.19153,0.734872,-0.110959,-0.270458,-0.0825059,0.571495,0.139316,0.109516,0.361519,-0.0589322,-0.222018,-0.0543805,0.532652,-0.167942,0.808311,0.691423,0.192315,-0.403579,0.152183,0.450193,0.18311,0.377255,0.0952955,0.611894,-0.217462,0.148102,-0.208089,-0.045561,-0.140178,0.236858,0.613349,-0.683801,0.441749,0.0830641,-0.0625841,0.0826549,0.217308,-0.368954,0.127016,-0.457235,-0.114014,-0.578932,-0.0859716,-0.34314,0.302046,0.157635,-0.124626,-0.377167,0.0559422,0.335868,0.0370572,0.0992856,0.79528,0.00558427,-0.1651,-0.644391,-0.203613,0.718739,-0.245161,-0.0623569,0.0647774,-0.202692,0.00566682,0.356109,0.432105,0.224958,-0.509325,0.852441,0.277387,-0.318069,-0.250612,-0.701516,-0.383109,-0.111616,0.137958,0.649134,-0.0647531,-0.0830013,0.495029,-0.114866,0.345221,0.262567,-0.417044,0.158835,0.196622,0.471536,-0.00546984,0.431203,0.263205,-0.0991333,0.411027,-0.269308,0.316338,0.188775,0.850236,-0.447724,-0.127487,0.588343,-0.155188,-0.498067,0.271238,-0.905025,0.458838,0.0715028,0.102884,0.28437,-0.357251,0.355922,0.113037,0.0384926,-0.458955,0.495145,0.402859,-0.329538,-0.300169,0.095693,0.14167,-0.145276,0.32368,0.0916585,-0.449341,-0.235918,-0.599101,-0.329229,-0.274359,-0.0643413,0.0834004,-0.0888958,-0.147777,-0.219417,-0.604054,-0.683869,-1.0628,0.443331,0.296965,0.255373,-0.116157,0.778947,0.0792822,-0.0639743,0.0239992,-0.25263,0.443095,0.0797305,-0.031367,-0.430265,-0.0831435,-0.576908,-0.221801,0.243582,0.0163263,0.173068,0.238706,0.416014,0.488575,-1.48272 +3416.56,0.767713,0.0912059,5,1.57713,0.959604,-0.825553,0.112775,-0.0564632,-0.0398651,0.355169,0.274971,0.28128,0.210935,-0.470425,-0.249919,0.0407793,-0.141723,0.287884,0.217347,0.0361722,0.282226,0.143254,-0.0832913,-0.329473,-0.749676,-0.966495,-0.0299619,-0.252988,0.0263318,0.34173,0.11913,-0.139701,-0.241094,0.570152,-0.315223,-0.724368,-0.0733231,-0.297461,-0.0264301,-0.323517,0.61401,0.0848544,-0.374791,1.11235,0.0415852,0.575609,-0.582201,0.349406,0.180237,-0.659266,-0.164003,0.799244,-0.0127817,0.332325,0.401085,0.266821,-0.557609,0.690713,-0.734062,-0.266344,-0.415004,0.518905,-0.181059,-0.21357,0.837355,-0.708208,-0.50629,0.292199,0.170053,-0.0718392,0.146924,0.497345,-0.304839,-0.237954,-0.421307,0.85569,-0.473336,0.656393,0.404091,-0.246454,-0.0334787,-0.260397,0.0155216,0.415009,0.239925,0.132406,-0.179255,0.299481,0.164841,0.549029,-0.0856072,-0.300033,-0.154432,-0.612587,-0.178304,0.0942522,0.0137227,0.218053,-0.472342,0.440498,0.0292291,0.218351,0.460234,0.128624,-0.487176,-0.259733,-0.717947,0.0270538,-0.277779,0.550496,-0.524948,0.0699622,0.436493,0.322323,0.0623446,0.425219,0.624877,0.603526,0.768045,-0.563993,0.150799,0.900792,-0.0115071,-1.01988,-0.18177,-0.239133,-0.895128,-0.167061,-0.0182635,0.127648,0.2867,0.539174,-0.606341,-0.298131,0.43813,0.340552,0.776525,-0.284789,-0.35541,-0.905655,-0.566805,0.514804,-0.34221,0.939281,0.119177,-0.115909,-0.596212,0.10023,0.325535,-0.343773,0.280394,-0.0890026,-0.154188,-0.352207,-0.0618277,0.426388,0.203717,0.239174,0.291932,0.0834822,0.203169,0.105537,0.194232,0.451907,0.023114,0.264603,-0.0520117,-0.595706,-0.17364,0.0316968,0.268986,-0.160792,-0.68708,0.0946342,-0.347746,-0.1195,-0.676433,0.466709,0.0164301,-0.369285,0.374056,0.559489,0.72482,0.16028,0.145334,-0.126892,-0.104507,-0.411194,-0.330248,-0.664987,-0.209759,0.439398,-0.458962,0.176967,0.0636569,-0.0724826,-0.586167,-0.19523,-0.241244,0.336305,-0.405042,-0.851697,0.316736,-0.171096,-0.698291,-0.269239,-0.028573,-0.134368,-0.0639943,-0.505644,0.952768,0.147405,0.379328,0.358215,0.0330203,0.159542,-0.169427,-0.849532,0.370772,-0.164997,-0.320811,0.563928,-0.799501,0.147535,-0.421364,0.428296,0.615022,-0.654882,0.454384,-0.355478,-0.227642,-0.464216,0.306554,-0.58554,0.275735,0.559767,-0.10572,-0.307938,0.637722,-0.0444143,-0.0189541,0.318423,-0.00668045,-0.523447,0.366838,-0.356395,-0.223413,0.0796362,0.685889,0.645894,-0.243179,-0.0980266,-0.153096,-0.559796,-0.0744664,0.191057,-0.579597,-0.766142,0.267781,-0.42335,-0.491142,0.214329,-0.0764122,0.424851,-0.0476296,-0.135564,0.608819,-0.00939262,0.153875,-0.341259,0.078488,-0.125881,0.315976,0.155134,-0.236787,-0.0789344,0.398858,0.337782,-0.384509,0.284886,0.190853,-0.068752,0.131764,-0.265394,0.263003,0.53468,-0.251879,-0.0935466,-0.095248,0.00171951,-0.389361,0.185822,-0.14372,-0.129609,0.27749,-0.119718,0.162001,0.0610818,-0.442305,0.233368,-0.027359,-0.0776272,-0.379354,-0.0266532,0.161628,0.21831,0.40203,0.467236,0.404816 +3422.21,0.932416,0.0912059,5,1.53944,1.07757,-0.541261,-0.0564971,0.182843,-0.0981205,-0.135418,-0.038386,0.365518,-0.130813,-0.113591,-0.167859,0.0701579,0.0246872,-0.685881,0.704693,0.361701,0.0599746,-0.162184,0.133814,-0.685004,-0.899299,-0.950674,-0.116117,-0.057168,-0.47295,-0.367332,-0.0329258,-0.432084,0.245861,0.501045,-0.592133,0.0553037,0.116772,0.209885,0.236396,-0.290227,0.0375783,0.396187,0.150535,0.994448,0.722911,-0.154308,-0.241432,-0.0262635,-0.212601,-0.375895,0.663392,0.581288,0.134498,0.44648,-0.0723441,0.691287,0.138191,0.973657,0.339482,-0.0924018,-0.241593,0.578605,-0.132163,0.345166,1.1417,-0.392305,-0.608753,-0.422395,0.00202215,-0.203574,-0.128067,0.101994,-0.537768,-0.297276,0.147203,0.692471,0.482843,0.795828,0.0122548,-0.150582,0.0982,-0.131394,0.227007,0.367215,-0.873293,0.325705,-0.337779,-0.68266,-0.115032,-0.0954162,-0.40288,0.225569,-0.485393,0.311385,0.749269,0.148917,0.216388,-0.0173222,0.049644,0.199051,-0.0723888,-0.163769,0.0570538,0.25741,0.248812,-0.515785,-0.291505,0.208224,-0.32188,0.202517,0.157694,0.255946,0.440306,-0.500939,-0.564209,0.0595897,0.48892,-0.156538,0.140216,0.120411,0.362481,-0.199328,0.0511913,-0.375465,0.148923,-0.446219,0.948635,-0.398003,0.0546545,0.434145,0.403154,-0.129658,-0.392101,0.322406,-0.130486,-0.345411,0.668391,-0.292993,-0.411186,0.538687,-0.0618036,0.494612,-0.876932,-0.904987,-0.0481125,0.0997885,-0.55236,0.00229621,-0.138063,-0.129421,0.302888,-0.106838,-0.0119753,0.020259,0.429863,0.12872,0.101512,0.519467,0.310501,0.0958659,-0.179445,-0.0843407,-0.12486,-0.117141,0.154166,0.868137,0.822387,0.0920714,0.287608,0.0390145,-0.171327,-0.168883,0.357601,-0.214228,-0.26111,0.117247,0.0359044,0.0295846,-0.176119,-0.0407201,-0.406909,0.257206,0.735798,0.115572,-0.683884,0.980093,0.382444,0.17745,-0.527277,-0.0576963,-0.322606,0.0802642,0.015974,0.256952,-0.0144763,0.241129,-0.621303,-0.252469,-0.071556,-0.330893,-0.0718579,-0.583496,0.613386,0.0803688,0.0525008,0.628144,-0.0629225,0.0430931,0.213639,-0.0815544,0.939568,0.512567,0.429302,-0.215703,-0.564074,0.137318,0.140293,0.370228,0.511573,-0.203152,0.64129,0.449349,0.274407,0.0102608,-0.601985,-0.628695,-0.00269896,-0.885086,0.513476,-0.127832,-0.193903,0.401205,-0.525321,0.0443182,-0.069169,-0.136009,0.0929994,-0.104542,0.479151,0.0777409,0.378694,0.628087,-0.625594,-0.758455,0.233682,0.154922,0.362251,0.341576,-0.0131773,0.00244645,0.354001,-0.326214,0.0725123,0.570121,-0.613294,0.0867475,-0.723913,0.102605,0.226414,0.369054,0.273452,0.303944,0.16656,-0.405005,0.503881,0.199298,-0.35313,0.486776,-0.307995,0.245731,-0.089651,0.469801,-0.248749,-0.622865,-0.789302,-0.483132,0.246856,-0.150593,-0.21532,-0.290649,0.0470561,0.37086,0.150506,0.145136,-0.885042,-0.470679,0.394557,0.217548,0.513256,-0.297788,0.562433,-0.36056,-0.698573,0.0664458,-0.282235,-0.0384446,-0.381018,0.154163,-0.497782,0.0304023,-0.341242,0.212172,-0.10994,0.399158,0.154527,0.198207,0.393099,0.445204,-0.610155 +3413.9,1,0.0912059,4,1.5756,1.05636,-0.533455,0.0160334,0.303777,-0.11129,-0.0224583,0.165625,-0.0230314,-0.0802793,0.11311,2.77543e-05,-0.145333,0.287706,-0.147945,0.607468,0.0402753,0.345225,-0.849887,-0.220602,-0.784805,-0.888258,-0.313651,-0.239871,0.253907,-0.488991,0.0768557,0.647009,-0.238817,0.0288243,0.703776,-0.623668,-0.294405,0.256895,0.000120859,0.122074,0.0378572,0.324669,0.398265,0.0597711,1.09815,0.589367,-0.0878003,-0.610433,-0.0865541,-0.215327,-0.267197,0.207993,0.369856,-0.161331,0.189946,-0.27947,0.799909,-0.117534,0.837132,0.107661,-0.29331,-0.41846,0.514123,-0.0629883,0.0758909,0.694726,-0.525344,-0.467717,-0.254759,0.308633,0.271709,0.0230532,0.55369,-0.48946,0.174958,-0.00251522,0.520355,0.484532,0.878732,0.464215,-0.020466,0.114691,-0.51807,0.0633787,0.369856,-0.5622,-0.00248126,-0.235753,-0.348118,-0.171528,-0.0904109,-0.535503,-0.0507419,-0.471536,0.0361575,0.306451,0.0395593,-0.0788143,-0.0593875,-0.112656,0.328904,0.0763183,0.154212,0.102258,0.384678,0.092552,-0.472267,-0.221563,0.0433268,-0.649119,0.520266,-0.268842,0.237912,0.0115452,0.00651437,-0.647138,-0.317422,0.380557,-0.271753,0.173047,0.0703982,0.0825441,0.596937,0.111158,-0.496567,-0.00710821,-0.0411878,0.52473,-0.158815,0.376296,0.614849,-0.195096,-0.475082,-0.567184,-0.405649,-0.00902362,-0.177011,0.86058,-0.536579,-0.471569,0.128271,-0.1885,0.605452,-0.900361,-0.677936,0.165489,-0.176597,-0.627594,-0.174796,-0.203112,-0.512082,0.253961,-0.117598,-0.0600696,-0.661998,-0.0871506,-0.0902079,0.211955,0.53796,0.519906,0.131734,-0.0801756,0.572147,0.00912841,-0.053137,0.305793,1.07773,0.877033,-0.0186021,0.137659,0.31015,0.114536,0.236873,-0.183215,-0.249811,-0.263933,-0.122106,0.0211061,0.344019,-0.562061,-0.33538,-0.0681303,0.0971464,0.231414,-0.278482,-0.0230428,0.180737,0.506218,0.404057,-0.356951,0.150574,-0.497213,0.0170542,0.0724132,0.0465797,0.127714,0.149439,-0.73918,-0.0502954,0.164811,-0.309909,-0.180443,-0.879592,0.569299,0.255173,-0.148075,0.0549733,-0.630136,0.241478,0.382264,-0.0929063,0.713539,0.21377,0.32032,-0.288197,-0.395112,0.112376,-0.207027,0.31507,0.459521,-0.442006,0.393612,0.0578551,0.127814,-0.091139,-0.138942,-0.226452,-0.00294428,0.0909963,0.372219,-0.550257,0.202985,0.33846,-0.853267,-0.0795827,0.2023,-0.00616072,-0.114763,-0.163624,0.320642,-0.105486,0.540604,0.67063,-0.85902,-0.707882,-0.143183,0.0751011,-0.158425,0.253795,-0.0768427,0.138468,0.587983,-0.0647909,-0.270908,0.0811976,-0.901861,0.154893,-0.263222,0.547831,0.00876536,-0.111421,0.414087,-0.0530614,0.149492,0.212039,0.124129,-0.0433586,-0.53838,0.354019,-0.248862,0.0981408,0.440918,0.227351,-0.200799,-0.123332,-0.654674,-0.770731,0.397435,-0.408417,-0.0808102,-0.34806,-0.272872,-0.0164564,0.496278,-0.176839,-0.864343,-0.405772,-0.279696,0.0348117,0.858286,0.0450376,0.315242,-0.323302,-1.07288,-0.0516924,-0.32669,0.0361928,-0.297416,0.0634665,-0.120376,0.309899,-0.344464,-0.182606,-0.0817044,0.471976,0.131139,0.219468,0.362131,0.468474,-1.00756 +3425.45,0.966669,0.0912059,5,1.59665,1.01809,-0.784272,0.164966,0.245365,-0.23521,-0.256493,-0.257079,-0.311691,0.0594267,-0.175047,-0.031128,-0.23885,0.056338,-0.423058,0.760768,0.277369,0.23717,-0.149846,0.23254,-0.529263,-0.954732,-1.00698,-0.0778981,0.040482,0.0488804,0.342499,0.62222,-0.195116,-0.00271376,0.516883,-0.51404,-0.161529,0.0821405,-0.203423,0.0587051,-0.229534,0.374493,0.573441,-0.0089312,0.890412,0.256394,0.0341041,-0.419248,-0.126765,-0.0213566,-0.60968,0.136303,0.457694,-0.0827884,-0.1929,0.0373417,0.582599,0.0130984,0.874948,0.0392866,-0.158182,-0.596693,0.412191,-0.631371,0.0115425,1.1544,-0.188442,-0.450473,0.18419,-0.0773838,0.713892,0.00205604,0.842485,-0.443814,-0.442223,0.180253,0.553701,-0.000957064,0.493482,-0.0102602,-0.483646,0.0488701,-0.670582,0.181978,0.623768,-0.334312,0.0621289,-0.12057,0.260419,-0.261336,-0.106579,-0.224292,-0.081509,-0.231423,-0.387863,-0.193922,0.17439,-0.0141482,-0.134354,0.0625997,-0.00753595,-0.0830613,-0.26168,0.0931586,0.0849138,-0.10768,-0.449464,-0.320163,0.0555415,-0.183267,0.0186341,-0.238723,0.497098,0.257921,-0.145738,-0.385391,-0.651615,0.192121,-0.129084,0.324404,-0.292231,0.260498,0.597151,0.0174833,-0.369988,0.145617,-0.299118,0.0872472,0.0606124,0.052468,0.882886,0.071316,-0.0643433,-0.649434,-0.305676,0.143558,0.128758,0.419136,-0.664047,-0.460092,-0.173055,-0.190982,0.251939,-0.677577,-0.507287,-0.380387,-0.386233,-0.00585934,-0.605106,-0.265881,0.0398445,0.683883,-0.206733,-0.791955,-0.361731,0.0599428,-0.141149,-0.0435037,0.428043,0.722053,0.0276625,0.354151,0.104329,0.439325,0.46289,-0.102766,0.398451,-0.0872351,0.276191,0.316637,0.124405,0.0288388,0.357135,-0.0456989,-0.68072,-0.205256,-0.399994,-0.139663,-0.216539,-0.347042,-0.159915,-0.00789414,0.86257,0.282627,0.250185,-0.400797,0.597979,0.358598,-0.0678099,-0.338437,-0.0327362,-0.281453,0.240923,-0.198967,-0.053668,0.352436,-0.220249,-0.42988,-0.258006,0.373504,-0.134342,0.250724,-0.619325,0.269495,-0.0926733,-0.589856,0.712339,-0.805587,-0.200099,-0.0940819,-0.56236,0.893049,0.10828,0.382388,-0.486483,-0.821213,-0.0688866,0.184337,0.236312,0.313896,-0.0904195,0.14403,0.0552197,0.34218,0.271103,0.0326822,-0.347684,0.482842,0.0764821,0.453717,-0.23321,0.0274272,0.191609,0.0359065,0.111567,-0.143792,-0.477862,-0.165125,-0.485861,0.185514,-0.258274,0.365049,0.359761,-1.02861,0.173728,0.0324814,-0.0462497,-0.0370765,0.333351,-0.0664619,0.187928,-0.341662,0.21336,0.074602,-0.378566,-0.729264,0.423667,-0.149078,-0.277161,0.151463,0.0705318,0.34353,-0.286475,0.364475,-0.127368,0.522701,-0.508367,0.344332,0.469249,-0.206325,0.0376003,-0.246471,0.0149899,-0.386709,-0.37933,-0.0428997,-0.3584,0.539814,0.250444,-0.671864,-0.162349,0.58262,0.529916,0.0746546,-0.18619,-0.93102,-0.0945885,0.288874,0.383398,0.225823,-0.0890242,-0.175569,-0.164478,-1.00779,0.0478191,-0.280392,0.0860348,0.365907,-0.00647035,-0.71865,-0.0478823,-0.265646,-0.0699222,-0.0653463,0.453706,0.138381,0.157921,0.371996,0.397392,-0.703414 +3431.97,0.937324,0.0912059,4,1.57274,1.08816,-1.01023,0.317736,0.664271,-0.170425,0.247904,0.319335,0.359725,-0.432841,-0.185545,0.157471,-0.47314,0.00357926,-0.248125,1.16604,-0.0676126,0.286722,-0.369469,-0.398991,-0.727561,-1.0552,-0.491517,0.0127127,-0.182202,-0.414752,0.14636,0.240077,-0.277764,0.313809,0.430462,-0.353899,0.377532,-0.0697912,0.0557917,-0.175238,-0.451478,0.138379,0.449469,-0.424117,1.1015,0.481265,0.444432,-0.951476,0.0751621,0.197228,-0.504848,0.393303,0.213889,0.0232294,0.349503,0.741792,0.173568,0.152087,0.363118,0.238427,-0.195406,-0.638618,0.159646,-0.268135,0.151034,0.889214,-0.526743,-0.304146,0.102271,0.0650748,0.505391,-0.260017,0.551398,-0.537247,-0.920845,0.107669,0.793527,0.116853,0.0582344,0.262421,-0.227742,-0.0433109,-0.716516,-0.137526,0.347457,0.136369,0.0760178,-0.547509,-0.325117,-0.472641,-0.573814,-0.274029,0.148546,-0.356013,0.0245858,0.137978,0.180073,0.0649755,-0.267021,0.0921328,0.0298236,-0.281948,0.260961,0.361544,0.296491,-0.483636,-0.465915,-0.580888,-0.0909577,-0.0568189,-0.0592334,-0.251986,0.641013,0.172463,0.347096,-0.358805,0.49401,0.309134,0.0612215,0.347113,0.0393465,0.360201,0.273716,-0.126207,-0.890098,-0.0683056,-0.670693,-0.127134,0.235501,0.145128,0.388966,0.159912,0.221458,-0.461802,0.000437954,0.22069,0.154471,0.523196,-0.317238,-0.177793,0.237799,0.118095,0.549007,-0.339895,-0.322055,-0.209948,-0.16757,-0.763058,-0.11411,0.436464,0.0701351,0.271564,-0.170552,-0.493481,-0.0384983,0.269191,-0.0195235,-0.0884206,-0.13801,0.852078,0.1586,-0.163458,-0.0342981,0.525274,0.32171,0.348031,0.775807,-0.00297704,0.330747,0.594595,0.300983,-0.183297,-0.147726,0.082554,-0.70786,-0.108458,-0.136698,-0.365613,-0.146079,0.619528,-0.128815,-0.41149,0.133281,0.71203,-0.0180241,-0.14718,0.204908,0.463159,0.0493164,0.0386241,0.576494,-0.245596,0.221206,0.393097,-0.0849864,0.0613427,-0.380696,-0.754261,-0.0191895,-0.00435146,0.0198247,0.054809,-0.521042,0.621313,-0.178445,0.0754768,0.279815,-0.244392,-0.100072,0.144785,-0.797865,0.951047,-0.405359,0.336985,-0.105531,-0.415122,0.348512,-0.0298996,-0.603453,0.381678,0.0747387,0.100737,0.492049,-0.202667,-0.135566,-0.611172,-0.117586,-0.166875,-0.0879806,0.46783,-0.405424,-0.222348,-0.0699904,0.023207,0.102347,0.000300791,-0.267632,-0.106359,-0.472267,0.670398,0.640002,0.214425,0.628097,-0.7264,0.359728,-0.677458,-0.019554,-0.235392,0.720103,-0.213931,0.272707,-0.4156,0.495587,0.190029,-0.396547,-0.49613,0.259661,-0.577081,0.331656,0.149386,-0.0614057,0.275146,0.23654,0.0707308,-0.239548,0.136152,0.0386758,0.390838,0.750673,-0.274562,0.0874104,-0.418073,0.109305,0.0272693,-0.757304,-0.109035,-0.27975,0.849499,0.47372,-0.72442,0.0375574,0.363651,0.322336,0.0434297,-0.105623,-0.166719,-0.0871249,-0.360361,-0.037753,-0.0509869,-0.316741,0.158481,-0.0872689,-0.165904,0.0499698,-0.314473,0.304623,0.459812,0.149869,0.121004,0.55599,-0.133708,0.0298109,-0.67634,-0.268505,0.127765,0.182175,0.357442,0.42682,-2.28424 +3438.31,0.60483,0.0912059,4,1.54674,1.17029,-0.321515,0.087229,1.10729,-0.105431,0.377763,0.0760491,0.34145,0.174553,0.256648,-0.345076,-0.0731165,0.0447027,-0.1688,1.30157,-0.0242069,-0.0963459,-0.630494,-0.262782,-0.487094,-0.773402,-0.471496,-0.185176,0.424209,-0.427709,0.681545,0.544579,-0.408829,0.0576369,0.665135,-0.596151,0.387989,0.0814955,-0.323332,0.106661,-0.649747,0.887503,0.231267,-0.353568,0.858378,-0.145852,0.279993,-0.207204,-0.151347,0.159473,-0.311978,0.0175772,0.36035,0.246101,0.14406,0.628165,0.487294,-0.113677,0.611328,-0.243147,-0.00816065,-1.06853,0.312236,-0.3788,0.41336,0.999946,0.120068,-0.963669,-0.139002,0.0469081,-0.309227,-0.155002,0.726921,-0.445223,0.45148,0.367993,0.430279,-0.149017,0.080484,0.332893,0.39842,-0.0106881,-0.296364,0.424589,0.504529,0.167846,0.06341,-0.34786,0.130485,0.0539863,0.0866775,-0.740876,0.28822,-0.221922,0.399372,0.169689,0.284909,-0.203508,0.320189,0.226939,-0.14147,-0.176898,0.128191,0.185332,0.316052,0.0394463,-0.588896,-0.139993,-0.0883776,-0.407465,0.462966,-0.228251,0.310092,-0.0303967,-0.0683974,-0.45613,0.189204,0.360728,-0.286496,-0.119514,0.0524936,0.0190816,0.174695,-0.562492,-0.651249,-0.190247,-0.0547826,-0.285865,-0.438115,0.397727,0.137039,0.134943,-0.42859,-0.671742,0.123025,0.143083,-0.181522,0.20405,-0.106778,-0.00819488,0.395039,0.240933,0.104522,-0.197731,-0.185718,-0.104608,-0.299212,-0.131464,0.117796,0.514756,-0.0642999,0.196078,-0.475946,-0.699551,-0.236705,0.316191,0.369876,-0.121665,0.737178,0.0859844,0.481974,0.401635,0.353738,0.740935,0.250363,0.155429,0.515842,0.595948,-0.627062,-0.498969,-0.188106,0.0585337,-0.16674,0.0225823,-0.00710378,-0.348862,-0.0366548,0.0295674,-0.106558,0.0842123,-0.0578562,0.379443,0.174778,0.818665,0.145987,0.192371,0.269667,-0.352263,-0.181321,-0.554472,0.122117,-0.417043,0.150179,0.275413,0.10296,-0.0112681,-0.560809,-0.6328,0.0601962,0.471723,0.0866928,0.0621224,-0.624476,-0.190888,-0.364194,-0.161555,0.0828772,0.0176869,0.69946,0.0871023,-0.469483,0.759974,0.0850086,0.462833,0.108262,-0.180518,-0.363103,0.0782036,-0.357236,0.274449,0.193351,-0.0639046,0.139975,-0.235152,0.221964,-0.161281,0.0530138,0.361579,-0.385037,0.345148,-0.435396,-0.243592,-0.254731,-0.257452,-0.54728,0.0478134,-0.457459,-0.340563,-0.323214,0.443446,-0.0493154,0.276311,0.298053,-0.00431876,0.298329,-0.299357,-0.219091,0.182087,0.734221,0.447893,0.0061645,0.387998,-0.394714,-0.51048,0.411609,-0.491034,0.504655,-0.00862391,0.0283897,0.777233,-0.217621,0.057051,-0.0557988,-0.00291834,-0.0432775,0.346313,0.0306105,-0.154933,0.24741,-0.189022,0.0338923,0.608926,-0.313537,0.0496422,-0.403905,-0.237348,0.0533091,0.412439,-0.20632,-0.344675,-0.369144,0.26827,-0.209172,-0.220343,-0.0137397,-0.296974,-0.333563,-0.18666,0.30671,-0.0518781,-0.134707,0.41592,-0.117048,0.235781,0.0373283,0.284067,0.0686492,0.447543,-0.284246,-0.867753,-0.19418,0.238103,-0.319562,0.436049,0.128839,0.108326,0.198002,0.329129,0.444974,-4.08567 +3435.17,0.950326,0.0912059,4,1.51612,0.89088,-0.524618,0.150828,0.0407169,-0.0306513,0.118119,-0.0496265,0.28445,0.221287,-0.14926,-0.357776,-0.0115837,0.193042,-0.0461515,0.942064,0.374469,-0.0365674,0.541347,-0.129701,0.0565227,-0.682899,-0.863162,0.22631,-0.558538,0.42268,-0.619866,0.364823,0.00637792,0.262835,1.09522,-0.0124259,-0.224381,0.673503,-0.0793859,-0.344584,0.0421004,-0.0615111,0.414278,-0.153097,0.846016,0.825854,0.11163,-0.672194,0.139976,-0.211535,-0.845212,0.260145,0.470839,-0.0476172,0.322503,0.264559,0.472403,-0.442398,0.46869,-0.306366,-0.206739,-0.503667,0.399248,-0.252951,0.163935,0.934231,-1.09251,-0.589293,0.167892,0.230128,0.273557,0.268439,-0.406139,-0.277498,-0.101938,0.0684094,0.76032,-0.0569571,0.520359,0.41068,0.0786339,0.0214655,0.0454017,-0.350861,0.328381,-0.56704,0.0880803,-0.0471731,-0.502611,-0.275574,-0.305919,0.394706,-0.527502,-0.750116,-0.164423,0.027318,-0.545445,0.0134006,-0.125931,-0.539936,0.220212,-0.219553,0.161489,0.241225,-0.214621,0.116026,-0.0372584,-0.284497,0.331314,-0.145034,0.0534163,-0.020079,0.194824,0.66894,-0.231751,-0.12079,-0.307641,0.81816,0.419118,0.0174176,-0.448488,0.119258,-0.0143429,0.542962,-0.421192,-0.125245,-0.280323,0.0627057,0.293789,0.206745,0.535041,0.393607,0.713187,0.319424,-0.00460688,-0.0947155,0.445452,0.329588,-0.197961,-0.0792978,-0.450644,-0.0913479,0.556295,-0.44247,-0.143694,-0.0852693,0.273231,-0.642535,-0.079272,-0.363583,0.0102121,0.265869,-0.161232,0.17787,-0.019146,-0.221,-0.296622,0.0591173,-0.183426,0.486589,-0.220352,-0.438572,-0.310951,-0.777297,0.0909694,-0.327684,0.511578,-0.833069,0.578086,0.27276,0.267603,-0.381057,-0.317331,-0.296669,-0.309667,0.351601,0.441208,0.109966,-0.111721,0.108082,-0.300867,-0.457384,-0.0622428,0.533731,-0.059661,-0.497047,0.120347,0.16083,0.282682,-0.0802275,-0.495118,-0.0252208,0.311859,-0.645395,0.00904172,-0.334373,0.222374,-0.271454,0.11518,0.0131149,0.250174,-0.418421,-0.317262,0.639521,0.140902,-0.206409,0.283315,0.179838,-0.778767,-0.193845,-0.239071,0.51287,0.0234224,-0.110386,-0.238807,-0.242889,0.664599,0.132922,-0.26698,0.0949515,-0.500872,0.255443,0.227582,-0.0744866,-0.642133,-0.603825,0.0693821,0.361122,-0.0912255,0.502336,-0.0055228,-0.300591,-0.0926508,-0.0259471,0.171333,0.324704,0.414217,-0.0713929,0.228002,0.407815,-0.175457,-0.496388,0.770892,-0.485484,-0.294382,0.39147,0.12101,0.00157538,-0.0185317,-0.259743,0.684924,0.29546,-0.188776,0.0560673,-0.335339,-0.354573,0.100492,-0.305653,-0.0718569,-0.0522182,-0.220113,-0.171138,0.168369,-0.0101252,0.151929,0.109913,0.311311,0.229253,0.138155,0.29732,-0.41903,-0.919213,0.112187,-0.079872,0.0202976,0.10401,-0.417006,-0.0362088,0.22212,0.0564089,0.429764,-0.167123,0.275504,0.0640594,-0.135626,0.0782434,-0.320169,0.152156,-0.122635,0.300644,-0.174876,-0.283989,-0.00955197,-0.44871,0.515262,-0.216252,-0.179585,0.198189,0.2623,0.158479,0.0770367,-0.177289,-0.00157856,-0.355883,-0.0513193,0.100275,0.349871,0.316662,0.591499,-0.0538156 +3450.58,0.786007,0.0912059,4,1.47807,0.950696,-0.54907,0.134899,0.238384,-0.0518185,0.00165515,0.116346,0.622902,0.406249,-0.159954,-0.254478,0.0629825,0.478749,0.0721048,0.949443,0.221929,-0.0525223,0.203745,0.0630161,-0.300921,-0.867124,-0.738057,0.115434,-0.240751,0.0965723,0.000260014,0.67599,-0.132807,0.150131,1.20962,-0.357866,-0.36949,0.568242,-0.0347457,-0.390345,0.167273,0.183214,0.491614,-0.944144,1.00234,0.859512,0.135956,-0.38639,0.0370142,0.136521,-0.450412,0.171327,0.517902,-0.00227429,0.260367,0.652959,0.226771,-0.622021,0.562387,0.0491767,-0.0261349,-0.592036,0.613613,-0.471896,0.587921,0.856062,-0.860378,-0.570824,0.764715,0.146597,-0.0020299,-0.238672,-0.112346,-0.450091,0.139246,0.121092,0.576926,-0.230317,0.848619,0.0731332,0.39861,0.110915,0.0573308,-0.0918701,0.215917,-0.560452,0.285531,0.228376,-0.356548,-0.00728599,-0.479383,0.018109,-0.344592,-0.408592,-0.301121,0.580193,-0.33615,0.179175,-0.116994,-0.225324,0.0113301,-0.218067,0.0278073,0.440107,-0.256208,0.125585,-0.217649,-0.0976162,0.466534,-0.355134,0.182315,-0.0223311,0.012889,0.641007,-0.00481117,-0.0243227,0.194398,0.76749,0.26231,0.0050448,-0.67013,0.152419,-0.0755658,0.0831681,-0.481856,0.178636,-0.379173,-0.194743,0.0909253,0.345063,0.60667,-0.270063,-0.0233405,0.00761175,0.119358,-0.0455131,0.174258,0.294251,-0.0809927,0.206116,-0.281596,-0.161345,0.410583,0.178415,-0.0573915,0.061651,-0.0827596,-0.648634,0.272815,-0.741851,-0.0829608,0.12243,-0.193136,-0.250202,-0.179716,-0.277084,-0.0853003,0.824864,0.309914,0.323477,0.302872,0.0575504,0.218171,0.0759818,-0.131769,-0.00241825,0.803932,-0.682909,0.0325249,-0.228742,0.224023,-0.0523233,-0.0890487,0.15932,0.524048,0.3493,0.230866,0.21852,-0.200507,0.450109,0.0819748,-0.322777,0.0586619,0.589965,0.107736,0.208339,-0.0604769,0.0455285,0.473748,-0.147626,-0.0385482,-0.142729,0.387561,-0.602662,-0.0374767,0.216756,0.181303,-0.620302,-0.203207,0.106023,0.0379872,-0.430654,-0.202776,0.576251,0.166424,-0.176388,-0.208809,0.0913857,-0.443217,-0.135128,-0.265599,0.434691,0.338043,0.169056,-0.0810983,0.193885,0.496001,-0.165317,0.108501,0.294785,-0.281097,0.388868,0.332574,-0.239235,-0.0705533,-0.275289,0.387068,0.0594765,0.192975,0.380077,0.158051,0.149587,0.0197482,0.0327064,0.130241,0.614333,0.112485,-0.109689,0.219125,0.270732,-0.281799,-0.252855,0.586175,-0.499262,-0.41814,0.15468,0.0929052,0.299335,-0.131471,-0.116744,0.254721,0.277205,-0.699008,0.31204,-0.523567,-0.556674,0.48428,-0.582414,-0.273478,0.472881,-0.189328,-0.335179,0.677546,-0.013622,0.621598,0.0972393,0.551469,0.507077,0.0999488,0.469533,-0.271254,-0.454624,-0.00988864,-0.255888,-0.596427,0.210558,-0.0426604,-0.346463,0.318347,0.153875,0.372355,-0.148875,0.283701,0.33956,-0.416816,0.0334323,-0.346386,0.176928,0.0756303,0.183136,-0.171885,0.10051,0.0328204,-0.274199,0.306702,-0.591173,-0.097485,-0.0253094,-0.0537531,0.235863,-0.0257902,0.038431,-0.274219,-0.189905,0.095495,0.113864,0.256113,0.337438,0.506076,-0.820589 +3450.98,0.977039,0.0912059,4,1.46369,0.988358,-0.524512,0.08611,0.147767,-0.0769502,0.0134179,0.106082,0.534898,0.426532,-0.0677698,-0.259613,0.0446836,0.403662,0.124647,1.06835,0.194174,-0.0672083,0.216903,0.0662746,-0.346823,-0.747976,-0.834733,0.0770345,-0.175355,0.114414,0.0169096,0.756047,-0.329628,0.204943,1.0854,-0.501507,-0.490632,0.560992,-0.111166,-0.264189,0.0698025,0.258731,0.50576,-0.934911,1.05796,0.808265,0.195151,-0.338079,0.0860217,0.172498,-0.50179,0.159823,0.512831,0.0361775,0.246641,0.452433,0.26886,-0.6934,0.599758,0.00811633,-0.0647306,-0.455877,0.520298,-0.429761,0.489448,0.966489,-0.928686,-0.620156,0.716382,0.171579,0.136919,-0.206133,-0.0509363,-0.427249,0.159597,0.0467154,0.633119,-0.211832,0.781745,0.0815508,0.469869,0.151333,0.101838,-0.132498,0.0881955,-0.502752,0.21202,0.153601,-0.312536,-0.052791,-0.661464,-0.131546,-0.269098,-0.377604,-0.134104,0.563963,-0.359574,0.101034,-0.0320293,-0.390509,-0.0438464,-0.242385,-0.0215791,0.35387,-0.216177,0.19673,-0.245038,-0.0154236,0.427619,-0.341433,0.0624361,-0.0549534,0.0530335,0.585022,0.0391093,0.167443,0.263967,0.765314,0.129348,0.0460684,-0.520086,0.192089,-0.166845,0.0864427,-0.317092,0.189923,-0.439999,-0.323323,0.0516139,0.368615,0.66536,-0.36767,-0.0804775,0.0010332,0.00762863,-0.012887,0.170323,0.287451,-0.150832,0.170578,-0.411913,-0.157769,0.407535,0.144479,0.0395722,0.0531959,-0.0818767,-0.649769,0.25936,-0.725196,-0.108815,-0.029058,-0.221254,-0.106878,-0.256882,-0.267063,0.0736547,0.975298,0.235449,0.449904,0.406636,0.0574495,0.30004,0.0325998,-0.0748743,0.0141446,0.707215,-0.664742,-0.0281346,-0.201095,0.17455,-0.153333,-0.0296623,0.0217632,0.518864,0.246528,0.246945,0.292757,-0.228124,0.313343,0.107544,-0.26445,0.114169,0.563141,0.144236,0.212652,-0.171725,0.0346678,0.449636,0.0327047,0.0065456,-0.134091,0.525276,-0.541961,-0.0423775,0.37364,0.127106,-0.638838,-0.0930045,0.0699262,-0.0132545,-0.507905,-0.287398,0.644075,-0.0100439,-0.181065,-0.40607,0.0419967,-0.475424,-0.231641,-0.281015,0.393241,0.19669,0.026109,-0.137207,0.156086,0.455948,0.0204207,0.176637,0.286572,-0.24931,0.540418,0.366594,-0.195464,-0.0782739,-0.305533,0.212324,0.0697486,0.220768,0.348396,0.283481,0.137581,-0.0132173,0.0152791,0.035829,0.567382,0.145695,-0.127696,0.169664,0.330984,-0.296236,-0.310657,0.565763,-0.45679,-0.463888,0.164458,0.0764197,0.362105,-0.150638,0.00693663,0.225874,0.292203,-0.751943,0.251761,-0.435721,-0.450417,0.534613,-0.504533,-0.172856,0.46639,-0.305733,-0.34097,0.761589,-0.0377479,0.672438,0.0345293,0.644265,0.518587,0.118453,0.382146,-0.292687,-0.305292,0.0685589,-0.201171,-0.601203,0.0677832,-0.0621507,-0.260511,0.29115,0.196432,0.327726,-0.147832,0.32798,0.279737,-0.329093,0.140928,-0.462831,0.188421,0.0778554,0.108244,-0.157213,0.0607199,0.0811379,-0.198614,0.239224,-0.478047,-0.137532,-0.0265798,-0.0413942,0.225708,-0.0295211,-0.0715635,-0.495062,-0.299891,0.0178892,0.107985,0.258746,0.32861,0.50867,-0.561069 +3451.96,0.970743,0.0912059,4,1.57321,1.02383,-0.733219,0.133922,-0.059303,-0.142287,0.223274,-0.0041714,0.199138,0.0916589,-0.0392454,-0.115905,0.230685,0.337631,-0.132484,0.76185,0.185258,-0.389052,-0.723119,-0.262503,-0.393696,-0.757492,-0.926997,0.00338957,-0.295511,0.234634,-0.029893,0.284386,0.209917,0.0476208,0.81594,-0.117155,-0.0299524,-0.00428089,-0.348506,-0.00273231,-0.335296,0.558841,0.32323,-0.350793,0.911282,0.424779,0.193445,-0.70405,0.0143816,0.0671046,0.138616,0.764676,0.602161,-0.343373,0.10124,0.222386,-0.14917,-0.763907,0.508462,-0.391938,-0.356556,-0.674716,0.541536,-0.177163,0.210465,1.17448,-0.255495,-0.62636,-0.0456367,0.0879456,-0.461375,-0.246435,0.340706,-0.566296,-0.128433,-0.0622571,0.392986,0.0120305,-0.0233024,0.308625,0.540701,-0.168545,-0.789313,0.191059,0.140433,-0.176488,0.209425,-0.668215,-0.290627,-0.283011,-0.371346,-0.144556,-0.0471634,-0.577521,0.00775642,-0.193085,-0.259011,-0.163672,-0.0098522,-0.276037,0.423607,-0.224739,0.196057,0.576843,0.633844,-0.0477077,-0.233178,-0.223597,0.208359,-0.441463,0.526615,-0.149587,0.0404966,0.661604,-0.244905,-0.223409,-0.0283481,0.57146,0.585224,0.812683,0.0998106,-0.547003,0.596903,0.00176402,-0.47173,0.246734,-0.0898496,-0.0661131,0.105095,0.216457,-0.152797,0.0606368,-0.0974352,-0.58932,0.437174,0.254603,0.0637544,0.201825,-0.367818,-0.0381212,-0.369129,-0.0866472,0.175813,-0.256255,0.0759816,-0.193435,-0.339899,0.212771,0.304248,0.0067525,-0.112098,-0.0494684,-0.33839,-0.61732,0.246117,-0.0757595,0.116145,-0.221971,-0.0292816,0.741602,-0.416712,-0.0526696,0.128653,0.562915,0.552247,-0.178292,0.353347,-0.300756,-0.113086,0.330045,0.0972426,0.224574,-0.0555504,-0.215828,0.238032,-0.0889268,0.274507,-0.414329,0.154004,0.163913,-0.330537,0.0761873,-0.0313752,0.190222,-0.0562535,-0.043687,0.197966,0.530381,-0.193042,-0.0404269,-0.405015,-0.488712,0.122108,-0.415783,0.263117,-0.212996,-0.0684542,-0.398337,-0.142082,0.38853,0.174611,-0.382717,-0.777078,0.276947,0.0296566,-0.312384,0.0446893,0.0761851,-0.0135605,-0.454468,-0.201295,0.782861,0.325637,0.180174,-0.247102,-0.378881,0.231443,0.193788,-0.110899,0.0406505,0.526818,-0.0601161,-0.114484,-0.617229,-0.100547,-0.393275,-0.461498,-0.126878,-0.348062,0.412116,0.113611,0.124804,0.409379,0.748552,-0.134984,0.10948,-0.114746,0.388448,-0.17865,0.55471,0.312867,0.0411001,0.330095,-0.411926,-0.150288,-0.0867172,0.0476826,0.48629,0.370727,0.315541,0.286052,0.221571,-0.527981,-0.250597,-0.315733,-0.239516,0.156465,-0.153959,-0.0445582,0.528229,-0.178877,0.0390046,0.375246,-0.10209,0.368921,-0.120096,0.0952513,0.206437,-0.263367,-0.299658,-0.457015,0.31323,0.0886242,0.00873775,0.350268,-0.182114,-0.623443,0.413863,0.0644212,0.208905,-0.266243,0.0233851,0.652996,0.0343871,-0.195198,-0.425592,-0.105404,0.0916398,0.0964379,-0.0580854,0.217711,0.163177,0.167128,-0.0459979,0.361823,0.111484,0.0638184,0.0948001,0.159926,-0.433875,0.526755,-0.0412915,-0.156312,0.0536399,0.116727,0.103235,0.171197,0.321302,0.413759,0.253807 +3441.32,0.944136,0.0912059,4,1.5713,1.04843,-0.696498,0.180952,0.0410412,-0.0844302,0.208923,0.134412,0.949838,0.537302,-0.273897,-0.486518,-0.171799,0.447881,0.465005,1.05213,0.218173,-0.348372,-0.0848321,-0.198517,-0.322113,-0.841271,-0.602965,-0.125679,0.364536,-0.359371,0.0541518,0.243146,-0.0490353,-0.264075,0.893043,-0.0556942,-0.144423,0.285336,-0.653024,0.127398,-0.285322,0.190799,0.657527,-0.573888,1.0736,0.428886,-0.13376,-0.338633,-0.0220543,0.393073,-0.844083,-0.111252,0.689975,-0.068419,0.393387,-0.0128468,-0.182415,-0.00603679,0.537526,0.0220125,-0.464549,-0.562419,0.546236,-0.842235,0.41508,0.976134,-0.771247,-0.745988,0.130053,-0.407866,0.42495,0.0825052,0.127178,-0.647636,0.0796993,-0.116828,0.472392,-0.37706,0.683903,0.193779,0.494912,-0.00662778,0.180588,-0.370108,0.510274,-0.347757,0.0728096,-0.127908,-0.375278,-0.782401,0.246747,-0.149483,0.0154022,-0.482188,0.15425,0.148994,0.153267,-0.0668864,-0.228055,-0.618851,-0.263819,-0.388362,-0.240669,0.196042,-0.164709,0.00255961,-0.305163,-0.590088,-0.547553,-0.242942,0.14729,-0.399157,0.277352,0.352386,-0.156644,-0.170245,-0.456965,0.433355,0.0860824,0.215574,-0.540571,-0.150976,0.317987,-0.0558149,-0.332485,0.00611242,0.283892,0.209956,-0.0493683,0.164338,-0.473536,-0.488407,0.244862,-0.0941443,-0.140294,-0.0933743,-0.181203,0.337494,-0.13909,0.159252,0.284746,-0.184402,0.0621842,-0.751379,-0.363569,0.0655617,0.462579,-0.378538,0.0253584,-0.0254031,-0.132627,0.350771,-0.137996,0.413516,0.340364,-0.0150459,0.506418,-0.121225,0.389178,0.398414,-0.187864,-0.220489,0.276607,0.709114,0.375566,-0.0783349,0.451051,0.220041,-0.315494,0.136378,-0.525261,0.0198505,-0.37487,-0.152024,0.461519,-0.465382,-0.151984,0.176491,0.189592,0.29754,-0.644201,0.739036,0.108419,0.664925,0.659549,0.0916508,0.313465,-0.0348003,-0.170499,-0.155285,0.0461662,-0.231878,0.189765,-0.242035,0.211122,-0.173628,0.0118793,-0.670749,0.798091,-0.19196,0.37248,-0.281789,-0.51348,0.212253,-0.0280749,-0.939011,0.326851,0.324914,0.0136535,0.0999312,-0.820987,0.558457,-0.122204,-0.694912,-0.407879,0.136643,-0.141302,-0.383578,-0.175413,-0.190712,-0.172984,0.0924508,0.924748,-0.340801,-0.356575,-0.567085,0.362748,0.138961,-0.334694,0.100701,-0.245506,-0.433279,-0.0564688,0.222509,0.176165,0.239949,0.146245,-0.218167,-0.234145,-0.0166699,0.274596,0.239321,0.275206,-0.209526,0.597215,0.0934095,0.0339133,-0.137476,-0.0301179,0.0546609,0.00519223,0.0684226,-0.0303689,-0.460086,-0.253911,-0.626701,0.0111804,-0.3296,-0.0365343,0.377157,-0.460725,-0.489786,0.0750268,0.121164,-0.123905,0.228915,0.426806,-0.067152,0.411199,0.20663,-0.287169,-0.280913,-0.290461,-0.319613,0.0996207,0.36773,0.0486807,-0.17057,-0.0574786,-0.190479,0.221286,-0.153333,-0.241189,-0.139992,-0.327128,-0.0466641,-0.133667,-0.134344,-0.0856691,0.320069,0.0552871,0.283642,0.71297,-0.168531,-0.0388807,-0.0231758,0.0852416,-0.0538188,-0.0872172,-0.422582,0.311623,0.229736,-0.363537,-0.00827142,0.754971,0.0975818,0.241331,0.312381,0.491255,-0.203065 +3416.11,0.981807,0.0912059,4,1.66618,0.967397,-0.469302,0.111253,0.475583,-0.131092,-0.129292,-0.139405,0.590173,0.615713,-0.225098,-0.279885,-0.309152,0.237852,-0.265859,0.697027,0.262347,-0.246625,-0.511107,0.0896629,-0.137488,-1.15964,-1.08473,0.00309964,0.0492293,0.18142,0.0493004,0.550962,-0.674783,-0.0959468,0.704332,-0.662493,0.0134019,0.0785836,-0.175288,-0.17289,-0.885098,0.714941,0.536169,-0.530405,0.923811,0.0759678,0.97493,-0.887693,0.00531888,-0.447973,-0.406591,0.744903,0.727662,-0.35582,0.341393,0.501921,0.209555,-0.632541,1.10884,-0.258303,0.0186586,-0.707493,0.330348,-0.220807,-0.226622,0.686535,-0.999763,-1.7831,0.180295,0.846827,-0.428643,-0.229618,-0.253912,-0.264111,0.293695,0.614416,0.557954,-0.253571,0.237768,0.163204,0.387269,0.201071,-0.342544,0.190069,0.421506,0.121268,0.25286,-0.362343,0.272728,0.677402,-0.279921,0.163564,0.565638,-0.482005,-0.17396,0.297808,-0.110995,0.153216,-0.052696,0.431773,0.483842,-0.395827,0.12234,0.28734,0.67138,0.0426546,-0.24124,-0.18505,0.0647159,0.0735287,-0.119055,-0.589327,0.243279,0.0158025,0.138398,-0.0929417,0.335606,-0.0181441,0.0822421,-0.0854097,-0.115851,-0.137719,0.180002,0.319557,-0.567147,0.371645,-0.292112,-0.42838,0.116444,0.235169,0.267716,-0.102408,0.0120228,-0.271739,0.308287,-0.144111,0.00589639,0.720118,-0.617,0.0176155,-0.118497,-0.0862988,0.272025,0.0292913,-0.00194498,-0.0818638,-0.85884,-0.648108,-0.0571824,0.100375,0.268376,0.291363,-0.301389,-0.374225,-0.168673,0.0707979,-0.216149,-0.00619445,0.263082,0.151501,0.0210802,0.658964,0.0402861,-0.17748,-0.489251,0.160428,0.404927,0.122742,0.11217,-0.0902708,-0.455869,0.0436886,0.0881945,-0.0288692,0.276991,0.47,-0.259404,-1.16362,-0.29568,-0.208058,0.0222379,-0.601454,0.106512,0.600886,0.228788,-0.22162,0.0697202,0.073107,0.13625,-0.403779,-0.56785,-0.1085,0.308027,0.165683,-0.118357,0.146659,0.133489,-0.654352,-0.457896,0.685838,-0.224192,-0.407607,-0.223709,0.0290155,0.0314025,-0.111527,-0.0113297,-0.233932,-0.0208018,-0.34448,-0.118982,0.936132,0.555893,0.624716,0.48351,-0.208226,0.384003,0.496828,-0.146698,0.166611,-0.346407,0.215999,-0.133764,-0.171878,0.329324,-0.157888,-0.571307,-0.264358,-0.445609,-0.0594622,-0.0178146,-0.392437,0.158841,-0.121562,-0.556119,-0.47738,-0.157032,0.228071,-0.603211,0.546102,0.361506,0.088831,0.670009,-0.393301,-0.5438,-0.240872,0.433015,0.0766732,0.0816336,-0.0794144,0.799753,0.429579,0.0638219,-0.0101024,-0.274679,-0.0429534,0.309287,-0.905043,0.15408,0.0234357,-0.676757,0.330484,0.471245,0.138466,-0.621393,0.122508,0.0670089,0.461329,0.221679,0.516355,0.0735349,0.104383,-0.281772,0.00644592,-0.495867,-0.87711,-0.0649427,0.276888,-0.267789,0.321966,0.186525,0.418038,-0.259439,0.173594,0.118461,-0.980986,0.0927063,0.00731126,-0.318648,0.131883,-0.0876218,0.140121,-0.944088,0.184329,-0.126369,0.118337,0.0112913,0.325616,-0.064564,0.00610152,-0.166682,-0.292998,0.29615,-0.50195,-0.873663,0.126512,0.386294,0.355686,0.621526,-1.44912 +3412.82,0.738471,0.0912059,4,1.47015,0.830437,-1.46734,0.609029,0.377623,-0.108441,0.416311,0.148372,0.567762,-0.176245,0.227103,0.174563,-0.265444,0.352009,-0.00710497,0.4917,0.32836,0.202809,0.0979968,0.308634,0.0684312,-0.965246,0.17568,0.23883,-0.189154,0.056465,0.338883,0.293848,-0.0238615,0.391873,1.23674,-0.25516,-0.0657875,-0.0174193,-0.379155,0.00391679,-0.0472796,0.693427,0.466454,0.064898,0.848811,0.814508,-0.103339,-0.673435,-0.203684,0.510441,-0.585648,-0.223944,0.025134,-0.0981986,0.0774394,0.706099,-0.191738,-0.144237,0.431437,-0.473566,-0.182801,-0.506115,0.334846,-0.0758074,0.972112,1.26758,-0.589487,-0.0596616,0.242546,-0.627504,0.290338,-0.0799549,0.593368,-0.285648,-0.478748,0.363137,0.55221,0.0968898,1.04559,0.208622,0.185111,-0.0931782,-0.24344,-0.208887,0.404776,-0.867944,0.202071,0.0258572,-0.522012,-0.776916,-0.179111,-0.374816,-0.281316,-0.379771,0.447293,0.308138,0.530454,-0.384274,-0.126957,-0.580576,-0.415104,-0.134924,-0.255061,0.337864,-0.219068,-0.339091,-0.384565,-0.0198371,0.224878,-0.489512,0.504913,-0.18262,0.5102,0.585533,-0.426776,0.0364034,0.149769,0.516106,0.365879,0.220484,-0.495381,0.249633,-0.0824649,-0.453633,-0.526709,0.185746,0.393197,0.177132,-0.10917,0.304588,-0.109127,0.243484,0.474193,-0.203685,0.164349,0.140043,0.123619,0.439414,-0.0196519,-0.0750461,0.495836,-0.146378,0.363453,-0.687664,-0.685203,0.238317,0.623061,-0.0795299,0.00630411,0.264166,-0.496911,0.437133,-0.17365,0.00635415,-0.00847247,0.413206,0.219501,-0.338244,0.0196972,0.295289,0.0526011,-0.820216,0.21576,0.349348,0.778777,-0.237389,0.978213,0.128299,-0.0435957,-0.0952122,-0.101162,0.240381,-0.675708,-0.0991518,0.389386,-0.580976,-0.148925,0.917305,0.0567952,0.168438,-0.473322,0.0300227,-0.180793,0.524828,0.425129,0.0691714,0.27345,-0.100593,-0.132298,-0.285044,0.27905,-0.269722,-0.249729,-0.579593,0.19259,-0.022052,0.0724582,-0.527118,0.340773,0.0670041,0.259902,-0.183246,-0.449063,-0.337777,0.00748097,-0.763953,0.0411769,0.261252,0.212154,0.106304,-0.50353,0.468837,-0.160364,0.0537981,-0.331478,-0.206573,-0.41299,-0.160997,-0.370227,0.100912,-0.178207,0.210174,0.743258,-0.329388,-0.395042,-0.341826,0.266126,0.57954,-0.145647,0.350662,-0.332566,-0.324855,-0.0951001,0.295054,0.490583,-0.146229,0.40051,-0.336351,0.0627916,0.272466,-0.475686,-0.393221,0.145692,0.149927,0.0731936,0.190061,-0.523223,-0.0406907,0.40432,0.42054,0.2097,0.0744587,-0.127863,-0.355045,0.234953,-0.758392,0.228605,0.462073,-0.0485847,0.399482,0.290557,0.0155722,-0.642314,0.305077,0.635919,0.343599,-0.17114,-0.215188,0.124266,-0.285246,-0.169266,-0.152159,0.21557,0.504003,0.194395,0.43932,-0.122536,-0.29243,0.122957,-0.386061,0.280701,-0.272511,0.49237,0.0995984,-0.148547,0.476188,-0.304143,-0.0159413,0.190987,0.635491,-0.247135,-0.144966,1.21579,-0.015568,0.0266212,0.379661,0.268119,-0.200445,-0.00427749,-0.603976,-0.125134,0.172753,-0.533642,0.0190915,0.721657,0.12675,0.241076,0.35602,0.490994,-1.03115 +3407.44,0.457537,0.0912059,4,1.46831,0.757033,-1.5007,0.679092,0.628722,-0.155203,0.462703,-0.100533,0.811863,-0.148046,0.21726,0.1697,-0.205818,0.679172,-0.335102,0.57394,0.406819,0.145086,0.101829,0.201829,0.0557271,-0.787253,-0.284203,0.5535,-0.272599,0.0495744,0.125311,0.248738,0.112969,0.483147,1.23182,-0.387885,0.0115586,0.0544972,-0.171299,0.0190259,-0.0698888,0.601931,0.532843,0.140167,0.95572,0.589079,0.150605,-0.684492,-0.357874,0.728582,-0.680537,0.115032,-0.24309,-0.107813,0.127242,0.424244,-0.537213,-0.384514,0.383066,-0.850667,-0.0159001,-0.405648,0.638178,-0.1279,0.581433,0.998613,-0.832826,-0.390986,0.240359,-0.613976,0.163985,0.0933449,0.638403,-0.0405205,-0.595907,0.424268,0.40929,0.169241,1.07033,0.315614,-0.0251883,-0.348986,-0.165856,-0.0676571,0.287728,-0.91518,0.129921,0.0193471,-0.189521,-0.613158,-0.103789,-0.251421,-0.673725,-0.462562,0.197324,0.258551,0.519634,-0.00232742,0.0624956,-0.399918,0.0656398,-0.548685,-0.224862,0.391957,-0.104673,-0.41812,-0.281404,0.0461163,0.270225,-0.557212,0.363325,-0.0977543,0.232424,0.610455,-0.398953,0.00360615,0.227021,0.495548,0.398628,0.437754,-0.641498,0.014621,-0.225303,-0.555363,-0.340642,0.043462,0.0960113,0.0541043,-0.336813,0.480079,0.146822,0.50806,0.298715,-0.28407,0.0456018,-0.0269934,0.0365163,0.38343,0.0894309,-0.29045,0.520923,0.0408987,0.21042,-0.398663,-0.125228,0.180333,0.545895,-0.1613,0.311915,0.565036,-0.542653,0.171926,-0.0873109,0.287527,-0.322665,0.366318,0.299433,-0.263629,0.0735983,0.392533,-0.0575848,-0.738329,0.0310891,0.520356,0.504458,-0.309148,0.884561,0.127269,0.241238,0.203395,-0.279266,0.359669,-0.75728,0.108813,0.62535,-0.220083,0.0304812,0.866251,-0.228231,-0.00150355,-0.38631,-0.0122382,0.262283,0.549285,0.0921552,0.540259,0.334993,-0.0852499,-0.0521631,-0.208596,0.0676335,-0.0157415,-0.464389,-0.732195,0.116494,-0.0523781,-0.083698,-0.728729,0.341243,0.0992294,0.337419,-0.0585267,-0.534297,-0.150919,0.0822331,-0.571078,-0.051581,0.619117,0.112938,0.148583,-0.289046,0.645606,0.272717,0.377138,0.0137818,0.068884,-0.184999,-0.310278,-0.346625,-0.0594432,0.0172731,0.248893,0.769385,-0.157073,-0.150196,-0.613421,0.482696,0.313941,0.216165,0.227769,-0.512182,-0.1929,0.038245,0.443266,0.471929,-0.117388,0.370631,-0.167982,0.0858157,0.00632532,-0.443248,-0.465425,0.107576,-0.0754476,-0.176259,0.265293,-0.332824,0.0273461,0.171822,0.425003,0.0931462,-0.0467312,-0.193926,-0.271402,0.115169,-0.558757,0.29947,0.432845,-0.175614,0.66624,0.268497,0.00800033,-0.548989,0.284555,0.178954,0.642805,-0.15766,-0.507818,0.135586,-0.337714,-0.130464,-0.341047,0.271591,0.412231,0.0869278,0.332582,-0.473391,0.0277325,-0.122768,-0.524278,0.282285,-0.113197,0.587214,0.0699576,-0.10231,0.306393,-0.38229,-0.0320879,0.517265,0.343317,-0.166419,-0.0900806,0.90686,0.234412,-0.0290826,0.427947,0.501729,0.338473,-0.104454,-0.268902,-0.0533202,0.0951042,-0.306879,0.0524762,0.662581,0.152961,0.187618,0.391103,0.433149,-1.77404 +3437.3,0.90968,0.0912059,4,1.52892,0.745764,-0.946294,0.474841,0.741836,-0.0974071,0.0834516,-0.0643756,0.171986,0.173548,0.0702093,0.431265,0.208625,0.48914,-0.191032,1.01433,0.45363,0.22304,0.202507,0.353575,0.133279,-0.297862,-0.599447,0.467936,0.134454,0.348943,-0.000752261,0.583186,-0.57022,0.302758,0.963846,-0.71795,0.0500484,0.661382,-0.00201268,-0.107469,-0.470541,0.206382,0.862234,0.256213,0.702512,0.65498,0.26352,-0.693742,-0.0730352,-0.89134,-0.244368,-0.157069,-0.365314,0.106634,0.0475724,0.489249,0.145759,0.118489,0.617401,0.193195,-0.476024,-0.915312,0.409298,-0.236685,0.276123,0.866271,-0.525672,-1.4782,-0.203896,0.533533,0.0309588,-0.187599,-0.371571,-0.560739,0.0248782,0.148774,0.788642,-0.173982,-0.0510444,0.327585,0.536471,0.242001,-0.192721,0.147002,0.331165,-0.121807,0.399507,-0.419189,-0.199203,0.182364,-0.273711,0.10799,0.535965,-0.15015,-0.514303,0.107816,-0.304939,0.149615,-0.0938506,-0.376808,0.206599,-0.236535,-0.286408,0.583496,0.041825,-0.0676855,-0.276014,-0.692881,0.00203705,-0.275657,0.371661,-0.113881,0.0307351,0.590139,0.445044,0.174438,-0.253832,0.406918,-0.355626,-0.220816,0.00614017,0.049464,0.346129,0.056955,-0.863269,0.214923,-0.479856,-0.229537,0.226121,0.27202,-0.0106243,-0.309129,0.363302,-0.573291,0.122064,0.0331715,-0.0345158,0.563966,-0.529108,0.332334,-0.469575,-0.0534946,0.477242,-0.394959,-0.0650073,0.00693511,-0.264362,-0.419639,0.152439,-0.131423,0.612042,0.256017,-0.102434,-0.179778,0.246237,-0.0324203,-0.0990928,0.146414,0.177215,0.353171,0.0250779,-0.00887255,0.492422,-0.435995,0.300965,0.158238,0.0111045,0.0883279,-0.395914,0.278275,0.385966,-0.554757,0.257681,-0.381727,0.210688,-0.164367,-0.102338,-0.489793,0.340931,-0.278506,-0.131292,-0.483299,-0.40995,0.527414,-0.160513,-0.924399,0.0347569,-0.0314645,0.104363,-0.418484,-0.430801,-0.172369,0.242373,-0.0251557,-0.0226342,0.156401,-0.121707,-0.277173,0.0525872,0.120058,-0.364454,-0.438944,-0.210781,-0.376732,0.0592795,0.137213,0.304801,-0.602575,-0.0876989,-0.17178,-0.88068,1.08812,0.186537,0.126825,0.0752222,-0.256026,0.26645,0.488839,0.0321277,-0.0579765,-1.02755,0.453871,-0.291052,-0.311924,0.0916291,-0.425106,-0.316909,0.0826697,-0.704945,0.563992,-0.130088,-0.0998261,0.255561,0.140665,-0.802283,0.000761396,-0.585428,0.1879,-0.575851,0.81185,0.106389,0.0977799,0.628181,-0.0264075,0.118895,0.108376,0.260499,0.314545,0.039412,0.170923,1.02174,-0.0625373,0.158904,-0.0903909,0.0735161,-0.411434,0.401683,-0.318494,-0.0424073,-0.0499782,-0.633841,-0.085897,0.610803,0.221804,0.137535,-0.260486,0.507042,0.731861,0.257638,0.378388,0.312221,-0.401738,0.00656727,-0.0321845,-0.240633,-0.691732,0.154523,0.407462,0.0221268,0.0675559,0.325102,0.0593468,0.0875173,0.0503059,-0.17275,-0.378688,0.121859,0.22347,-0.074768,-0.0781336,-0.034195,0.361886,-0.136167,-0.509439,0.111525,0.0398017,0.0557381,-0.00713646,-0.0448531,-0.640813,-0.416981,-0.137661,-0.160583,-0.141968,-0.680812,0.131926,0.262041,0.363216,0.5119,-2.18106 +3446.24,0.996679,0.0912059,4,1.56635,0.71423,-1.29764,0.596969,0.888693,-0.133725,-0.0133827,-0.0452494,-0.05014,0.559286,0.14402,0.0755905,-0.434435,0.14566,-0.159266,0.864232,0.267287,-0.351904,0.280312,-0.0603647,0.24309,-0.680041,-0.927389,0.358094,-0.335982,0.173188,-0.430317,0.935831,0.173201,0.0281087,0.986837,-0.139385,-0.254393,0.59153,-0.10671,-0.471172,-0.85306,0.320041,0.611585,-0.566918,0.641356,0.384311,0.486192,-0.768543,0.435597,0.070053,-0.488819,-0.198817,0.113499,0.155374,-0.413113,0.654513,-0.00634492,0.0263389,0.585158,-0.0884836,-0.4019,-1.04815,0.368787,-0.254323,0.203404,0.909531,-0.610567,-0.85501,0.160663,-0.0625089,-0.486076,-0.384849,-0.2826,0.116647,-0.253872,0.000815487,0.690731,0.114316,0.364176,0.267926,0.892331,-0.0800528,-0.381399,-0.115205,0.510084,0.148664,0.0780357,-0.578873,-0.567502,-0.461956,-0.129523,-0.224379,0.010025,-0.253909,0.187158,0.104539,0.176792,-0.405405,-0.216558,0.238106,0.11108,-0.0650084,0.0358908,0.328733,0.0154607,0.160083,0.200416,-0.0354633,0.224166,-0.16925,0.22728,-0.078497,0.422044,0.723776,-0.0766195,-0.304747,0.148057,0.244716,0.261278,0.459078,0.193,0.233101,-0.437009,-0.317622,-0.362039,0.281935,0.520731,-0.312049,0.108282,0.218451,0.514284,-0.423098,0.814895,-0.801492,-0.179281,0.392852,0.278232,0.243238,0.0547589,0.192155,0.311402,-0.113313,0.201869,-0.659655,-0.431992,0.133562,0.0172129,-0.679551,0.820341,-0.305471,-0.477245,0.128583,-0.0961573,-0.381117,-0.531506,0.358174,0.205079,0.167138,0.0055154,0.736084,0.134628,0.101756,-0.0572824,0.46323,-0.184491,0.170564,0.24816,-0.0325974,0.188329,0.760895,-0.0223063,0.169588,-0.670755,-0.0401543,-0.0863859,-0.0100017,-0.0328688,-0.494327,0.268707,0.0984874,-0.0949333,-0.586166,0.276465,0.519664,-0.339268,-0.414424,0.311415,-0.0701194,-0.188482,0.0140109,0.0989224,0.148657,-0.269304,-0.567585,0.269508,0.166124,-0.124555,-0.744401,-0.258299,-0.074987,0.437025,-0.384225,-0.270785,0.0459176,0.0147438,0.0187819,0.0292604,0.0236734,-0.150743,-0.494355,-0.21196,0.888878,-0.189135,0.75117,-0.0591448,-0.1933,0.00935018,0.0761927,0.144067,0.272165,-0.634362,0.0547352,0.395174,-0.392699,-0.0509487,-0.192957,0.0375995,0.0195168,-0.214045,0.593822,-0.526455,-0.21758,0.354156,-0.128656,-0.092869,0.0514237,-0.83962,0.193235,0.0364191,0.335636,-0.27311,0.0861064,0.534619,-0.130276,-0.00778908,-0.132905,-0.476798,0.207397,0.502028,-0.269807,0.438978,0.0398403,-0.0211659,-0.237387,-0.432896,-0.369242,-0.0205277,-0.108614,-0.402559,0.207593,-0.223721,0.0580692,-0.163285,0.346252,0.130212,0.314862,0.210468,-0.683259,-0.120445,0.341322,0.0187214,-0.119047,0.524784,0.0545713,-0.178548,-0.445691,-0.778805,-0.32622,-0.165081,-0.0236303,0.279743,-0.194715,-0.27274,0.470479,-0.177025,-0.213263,0.0638121,-0.0203685,0.328605,0.153462,0.302708,-0.233109,0.160416,0.0125902,-0.0373333,-0.392284,0.10621,0.49272,0.098528,-0.594184,-0.468654,0.147056,-0.297581,-0.0256969,0.105361,0.100778,0.302795,0.317456,0.550268,-2.49755 +3446.82,0.901382,0.0912059,4,1.60066,0.723821,-1.24969,0.60323,1.11026,-0.0636612,0.038504,-0.0856095,0.252184,0.422138,-0.000440719,0.247668,-0.269467,0.207945,-0.229133,0.667096,0.316666,0.12065,-0.092679,-0.00116342,0.158052,-0.889002,-0.920392,0.220666,-0.294927,0.266471,-0.162808,0.852591,0.124368,0.0797344,0.898325,-0.114876,-0.248533,0.433522,-0.32236,-0.308811,-0.265525,0.186856,0.644673,-0.384747,0.909527,0.549499,0.266495,-0.73626,-0.0717795,0.439234,-0.706877,-0.120858,0.016718,0.135162,-0.172789,0.474133,0.0545858,0.364274,0.523193,0.0832996,-0.585807,-1.11671,0.328011,-0.269756,-0.104218,0.964514,-0.583923,-0.855166,0.521321,0.178309,-0.492176,-0.322637,-0.00130861,-0.0356093,-0.164701,0.171789,0.496887,0.338984,0.219575,0.354813,0.794262,0.0782923,-0.155036,-0.125287,0.596175,-0.0361837,0.128911,-0.60272,-0.408229,-0.55312,-0.480767,-0.0151029,-0.0554388,-0.219715,0.109147,0.0232839,0.236105,-0.180438,0.0532007,0.327359,0.308652,0.165677,-0.366015,0.22279,-0.0190151,0.248464,0.276787,-0.197308,0.173364,-0.410023,0.00698787,-0.292349,0.299092,0.634888,0.0636788,-0.326478,0.391037,0.350659,-0.132187,0.522768,0.192258,-0.0336322,-0.526756,-0.477713,-0.340295,-0.00194343,0.204815,-0.338728,0.371646,0.426415,0.303767,-0.340998,0.515766,-0.698131,0.182634,0.433555,0.157891,0.0693242,-0.0380354,-0.190606,0.197061,-0.245888,0.446572,-0.687994,-0.234046,0.200658,-0.0169789,-0.293877,0.510623,-0.327416,-0.227535,0.1032,0.0106619,0.290764,-0.301216,0.610915,0.187578,0.025128,-0.419568,0.887996,0.13044,0.194556,-0.208282,-0.0785801,-0.523022,-0.0281151,0.361005,-0.135444,0.16127,0.1957,-0.0479173,0.222499,-0.349975,-0.143056,0.217555,0.191635,0.0725118,-0.541384,0.514859,0.156313,-0.255711,-0.21991,0.585777,0.668832,-0.22097,-0.0442083,0.299018,0.128996,-0.286488,-0.00498831,0.0841225,0.0560992,-0.156326,-0.76018,0.126886,0.321037,0.170817,-0.819671,0.235938,0.0342165,0.196669,-0.375985,-0.147056,0.260738,-0.186485,0.195055,0.413896,-0.105379,-0.223017,-0.2765,-0.260595,0.86004,-0.018404,0.148282,0.133926,-0.183143,-0.132175,0.510836,0.168498,0.253071,-0.446268,-0.17196,0.330328,-0.378502,0.0123698,0.0455272,0.260809,-0.537686,-0.383467,0.495093,-0.454922,0.0317004,0.398455,0.194987,-0.363758,-0.195566,-0.732115,0.163816,0.0426866,0.712281,-0.251767,0.084399,0.573849,-0.0296149,-0.0696684,-0.169384,-0.0816953,0.0703292,0.551146,0.109852,0.469578,-0.311574,-0.141021,-0.146939,-0.410551,-0.0335573,0.145289,-0.15352,-0.389955,0.0146367,-0.314835,-0.0548149,0.165498,0.416242,0.289302,0.741569,0.397565,-0.345799,-0.270553,0.173469,0.0485144,-0.29097,0.453786,-0.161464,0.215619,-0.31056,-0.62731,-0.182904,-0.282265,-0.22023,0.19933,-0.408581,-0.227144,0.525679,-0.0537499,-0.275782,-0.101417,-0.187486,0.0495675,-0.211734,0.208392,0.0483726,0.331266,-0.376801,-0.0471657,-0.398982,-0.209793,0.15493,0.108287,-0.520984,-0.429695,0.22458,-0.089376,0.106703,-0.0659556,0.118195,0.255973,0.343795,0.505938,-3.26439 +3442.61,0.981889,0.0912059,4,1.47642,0.847435,-0.896701,0.448146,0.744805,-0.0291863,-0.530203,-0.0274049,0.121117,0.167415,0.158908,0.185056,0.449171,0.382181,-0.203093,1.35053,0.540439,-0.134756,0.170631,0.0757798,0.0759886,-0.466989,-0.848922,0.645997,-0.0494649,0.0409005,-0.351627,0.381938,0.0566326,0.470721,0.976999,-0.463637,0.208449,0.441922,-0.109247,-0.351217,0.097545,0.501996,0.281309,-0.334206,1.05479,0.097186,0.435383,-0.872299,-0.168954,0.0703477,-0.335574,-0.207957,0.306367,-0.159311,0.056019,0.686103,0.157063,0.0823445,0.535338,-0.18306,-0.233854,-1.02054,0.261925,-0.373388,0.476165,0.676386,-0.314591,-0.789988,0.199264,0.409133,-0.0101018,-0.411334,0.345319,-0.635152,-0.204401,0.317182,0.742347,-0.202803,0.283495,0.292006,0.245998,0.716773,0.00233328,-0.0241442,0.490468,-0.127502,0.142638,-0.241736,-0.378682,-0.262988,0.35186,-0.11169,0.332916,-0.555649,-0.0188043,0.117195,0.21353,-0.104768,0.178167,-0.433818,-0.193105,-0.141726,0.104108,0.242061,0.257114,0.642414,-0.319002,-0.0884911,-0.442326,-0.250402,0.291307,-0.289708,0.425829,0.276681,0.0857947,-0.338566,0.221666,0.398016,-0.109531,0.301959,-0.376378,0.142435,-0.265214,-0.584973,-0.533918,-0.354018,-0.142006,-0.209565,-0.0322941,0.194294,0.400413,-0.530537,0.356725,-0.205776,-0.0119044,-0.0608635,0.217885,0.386034,-0.493099,-0.169139,-0.553561,-0.557947,0.530429,-0.261372,-0.252628,-0.153899,0.10746,-0.555003,0.261329,0.0776035,0.114759,0.629939,-0.229372,0.0407457,-0.821487,0.00331722,-0.199564,-0.126487,-0.337371,0.335255,-0.198348,-0.211085,-0.298206,0.202012,0.0505339,0.204662,0.798283,0.196972,-0.533453,-0.256321,-0.0655799,0.163802,-0.569619,0.0663168,0.160927,-0.000107874,-0.14195,-0.242956,0.32941,0.185234,-0.469025,-0.302285,0.185765,0.464412,-0.190005,0.107966,0.315583,-0.173718,0.13988,-0.128922,-0.0440562,0.383905,0.491151,0.0309863,0.257917,-0.191662,-0.268704,-0.557814,0.504447,0.262454,0.26547,-0.384093,-0.681376,-0.197149,-0.219998,0.158366,0.238986,-0.743069,-0.0932036,0.139027,-0.256297,1.06461,-0.0128451,0.766494,0.322793,0.165121,0.102185,0.391575,-0.349995,0.331366,0.0383017,0.130691,-0.0344519,-0.410579,-0.0660028,-0.420686,-0.484267,0.021729,-0.381455,0.566443,-0.461674,-0.182457,0.18665,0.129064,0.07163,0.276238,-0.672612,-0.479157,0.271989,0.6034,-0.00203898,0.181086,0.935487,0.104009,0.261081,0.205891,0.109496,-0.300388,0.310219,-0.207007,0.620175,0.12071,-0.087609,-0.243605,0.032377,-0.406645,-0.0599607,0.0527879,-0.554346,0.275538,-0.530519,-0.229216,-0.0669615,-0.15579,0.306323,0.200969,0.0800817,0.374833,-0.678499,-0.563515,0.0935588,-0.732279,-0.288978,0.147639,-0.0266991,-0.194916,0.468603,0.236102,0.23289,-0.210685,-0.208574,0.0754669,0.0234996,0.106628,-0.289639,-0.620321,-0.429053,-0.0903162,0.22424,0.291848,-0.337755,0.0107371,0.175313,-0.0933279,-0.136734,0.0764942,-0.630162,0.361232,0.100334,-0.544561,-0.577757,0.232934,-0.265808,-0.319926,-0.126695,0.105421,0.198954,0.324686,0.446042,-2.44097 +3454.29,0.955426,0.0912059,4,1.53137,0.886528,-0.501361,0.243307,0.601428,-0.172903,0.731258,0.207957,0.586461,0.219622,0.0397033,-0.104861,-0.32436,0.304622,0.0123065,1.02585,-0.00272914,0.170847,0.192694,0.0872445,-0.110883,-0.62889,-0.230144,0.537947,-0.0269443,0.106432,0.781346,0.273634,-0.212631,0.0657695,0.961959,-0.22445,0.370686,0.228153,-0.465838,-0.330111,-0.78323,0.386455,0.554269,-0.151997,1.05357,0.546104,-0.152122,-0.333891,-0.181972,-0.246659,-0.290486,0.163276,0.393032,0.379905,0.054361,0.0159409,-0.0754073,-1.08134,0.643969,-0.443396,0.151435,-0.443805,0.725166,-0.535994,0.128026,0.76001,-0.852674,-0.597578,-0.0123723,0.115082,0.0537059,0.297761,0.0472363,0.200494,0.301292,0.0460047,0.588875,0.217844,0.0843393,0.263201,0.495927,-0.539229,-0.741659,0.168233,0.352147,-0.272564,-0.0867324,-0.271579,-0.0312809,-0.0729975,-0.0206336,-0.180697,-0.0260907,-0.109894,-0.344288,-0.189846,0.217543,0.401903,0.29152,0.0727008,0.0192004,-0.339608,0.00900263,-0.0862532,0.144337,-0.196107,-0.551914,0.279301,0.481116,-0.149042,0.27615,-0.322119,-0.28467,0.490068,-0.0953429,-0.179168,0.170474,0.400103,-0.428702,-0.282448,-0.149374,-0.279616,0.591705,0.0265316,-0.446257,0.368018,-0.184929,-0.707408,0.267741,0.160069,0.185901,0.240716,0.121208,-0.6265,-0.0604401,0.193479,0.00812383,-0.0457808,-0.0581984,0.215422,0.356343,0.188605,0.163519,-0.699814,-0.09825,-0.0993777,0.0016962,-0.129688,-0.209882,0.604216,-0.121667,4.81175e-05,0.0204548,0.124392,0.479674,0.352393,0.603874,0.0659935,0.333353,0.101134,0.493331,-0.266138,-0.0214631,0.214032,-0.0140026,-0.100679,0.616112,0.0913378,0.0985949,-0.159783,-0.39701,0.0913739,-0.133715,-0.558218,0.221079,-0.676924,0.0837284,0.0256277,-0.188843,-0.392019,-0.387298,-0.109937,-0.25048,0.931921,0.073483,-0.0507577,-0.153406,-0.101772,0.184351,-0.654586,-0.49772,-0.762301,-0.212464,-0.494345,0.133337,0.00750316,-0.367849,-0.355898,-0.0643874,0.0303704,-0.186969,-0.0490139,-0.0290837,0.0598365,-0.146262,-0.167622,0.275172,0.402809,0.106298,-0.139502,-0.190864,0.748348,0.287458,-0.812244,0.261725,-0.0492626,0.400157,-0.382372,0.0480878,0.225047,-0.176127,-0.330124,0.0074893,0.152321,0.210756,-0.137379,-0.184233,0.088511,0.00827431,0.113666,-0.634759,-0.0180231,0.235242,0.125905,0.0463381,-0.123829,0.0563503,-0.172714,-0.576513,0.134678,0.389878,-0.186688,0.254182,0.109113,-0.564644,-0.383394,-0.339612,0.209552,0.341777,0.367852,0.260743,-0.10273,0.346664,-0.0268186,0.147107,-0.371989,0.462087,0.0293094,0.121687,0.209786,-0.142638,0.0721906,0.0231655,-0.251946,-0.339912,0.505024,-0.102661,-0.0494281,0.558888,-0.0217349,-0.0785979,0.0712029,0.352772,0.0865918,0.143601,0.127621,-0.198748,-0.124341,0.135109,0.404655,-0.183906,-0.172,0.389175,0.168548,0.0236794,-0.224931,0.420098,0.498815,0.000645456,-0.33622,0.043396,0.00392048,0.0735108,-0.1182,0.0834127,0.394168,0.069108,0.130064,-0.471098,-0.306537,0.226126,-0.0442365,0.264349,-0.0799707,0.015347,0.0923147,0.201079,0.303833,0.448418,-1.95667 +3464.28,0.979094,0.0912059,4,1.48771,0.847388,-0.499922,0.272608,0.2279,-0.0116756,-0.0391261,-0.198898,0.216645,0.148888,0.534816,0.211046,0.14368,0.495456,-0.194834,1.16973,0.567055,0.290778,0.0777079,0.224424,-0.218174,-0.587743,-0.884382,0.491737,0.109808,0.0304697,0.330909,0.415552,-0.497891,0.517318,1.02239,-0.627241,0.157622,0.218273,-0.366595,-0.847425,-0.0138641,0.461232,0.200786,-0.611501,1.14275,0.274348,0.0653487,-0.736693,0.076444,0.116486,-0.819782,0.0142276,0.815168,0.0526847,-0.093205,0.264134,0.0903649,0.124064,0.789681,-0.557389,0.338306,-0.972423,0.613716,-0.285588,0.0641238,1.0002,-0.974705,-0.82306,0.554422,0.144519,0.0248009,0.0554279,-0.324911,-0.496787,-0.5114,0.331349,0.667554,-0.0716194,0.497556,0.546807,-0.0312277,-0.0355573,-0.208207,0.03496,0.196345,-0.178918,0.036963,-0.21652,-0.306734,-0.582019,-0.364918,0.127413,0.0643191,-0.256699,0.108657,0.00771344,0.245742,-0.191252,0.383739,-0.359072,-0.241644,-0.150369,-0.216262,0.0749645,0.201244,0.196553,-0.0796195,-0.250538,0.123035,-0.105103,0.0915066,-0.398844,0.044957,0.366604,0.333402,-0.124494,0.0739633,0.177515,0.409137,-0.345741,-0.0147173,0.0250955,-0.190843,-0.112275,-0.307082,-0.324077,-0.103575,-0.0899291,0.230351,0.0742182,0.181443,0.270298,-0.0176022,-0.471312,0.332306,0.112737,-0.115908,0.759062,-0.319228,-0.51876,-0.0361995,0.0902331,0.829914,0.283353,-0.374601,-0.0420433,0.229203,-0.46785,-0.25666,-0.165908,-0.0437983,0.454603,-0.196363,-0.0739208,-0.11114,0.224326,0.326896,0.679603,0.0731721,0.327728,0.100643,0.23012,0.0998188,-0.374244,-0.0272405,-0.171569,0.044574,0.00532961,0.195848,0.0148944,-0.207733,0.112452,0.20314,-0.0679413,0.406404,0.0331864,-0.320061,0.191471,-0.567197,0.342794,-0.370685,-0.333367,0.163531,0.381607,0.204484,0.442961,0.00342612,-0.168449,0.236203,-0.0737702,-0.152805,0.0486407,0.148942,-0.441756,0.0826212,0.368226,0.228253,-0.490579,-0.227664,0.0271804,0.309811,0.0448683,-0.499138,0.0241873,-0.169192,0.139892,-0.296434,-0.576948,0.202225,0.387716,-0.838646,0.96369,-0.0168539,0.517004,0.123631,0.0864703,0.430027,-0.159705,0.0025331,0.292767,0.237671,0.110111,0.54103,0.250977,-0.165256,-0.266679,0.141551,0.402528,-1.09606,-0.0155091,-0.300735,0.00581604,0.110336,0.041343,-0.197633,0.0783544,-0.246901,-0.552844,0.290665,0.266519,-0.274592,0.430005,0.263242,0.160737,-0.056971,0.020964,-0.29038,0.335594,0.625451,0.119566,0.303232,0.390828,-0.207574,0.00809776,0.121329,-0.284854,0.206945,-0.243659,0.372546,0.0378895,-0.284069,-0.056744,0.37156,-0.148877,0.241947,0.0476101,-0.21579,0.384924,-0.110956,0.331507,-0.0150857,0.145853,-0.036481,0.326167,-0.0505533,-0.00690697,-0.168753,0.0330475,-0.0432322,-0.540233,-0.339265,0.371109,0.147269,-0.149391,-0.0573733,0.235774,-0.74187,-0.395573,-0.238661,-0.238551,-0.0502898,0.282975,0.0652423,-0.116897,-0.242293,-0.112661,-0.349898,0.321576,-0.145964,-0.405609,-0.129325,-0.133975,-0.39439,-0.175922,0.0901046,0.0862374,0.339024,0.293662,0.582258,-0.759959 +3457.98,0.75126,0.0912059,4,1.57676,0.874666,-1.26951,0.568627,0.7996,-0.16918,0.0557097,0.277052,0.26802,0.616198,-0.18426,-0.00854447,-0.0236144,0.0509912,-0.132612,0.814104,0.101062,0.383579,0.485805,-0.32225,0.181324,-0.977108,-0.500534,0.330275,-0.0635954,0.257746,0.344832,0.666564,-0.203437,0.158495,0.712615,0.0765976,0.228845,0.371879,-0.220607,-0.191619,-0.874747,0.538991,1.02719,0.0194681,0.917926,0.680082,0.605165,-0.347708,-0.159716,0.258216,-0.902151,-0.243527,0.0447407,0.229896,0.0191892,0.62726,-0.283457,-0.596769,0.0379214,-0.27669,-0.490249,-1.18978,0.219586,-0.13339,0.364836,0.846871,-0.743576,-1.07526,-0.233846,0.276159,0.269532,0.190852,0.445069,0.304852,0.170588,-0.519296,0.671113,0.265603,0.326255,-0.0570308,0.260775,-0.0840026,0.189935,0.181834,0.886868,-0.0483334,-0.0257431,0.00250434,0.126132,0.353697,0.288255,-0.417417,-0.13212,-0.0333704,0.229934,0.208807,0.194716,0.0508713,0.265671,0.280841,0.299415,-0.413243,-0.189215,-0.0912753,-0.097061,-0.3305,-0.684724,-0.000217454,-0.043616,-0.255126,0.432533,-0.0803788,0.141627,0.51906,-0.301479,0.0227562,-0.192406,0.61564,-0.141728,0.247003,0.101276,0.00467619,-0.00235436,-0.376681,-0.728591,0.455724,-0.145287,-0.152828,-0.0294477,0.377913,0.414114,-0.296386,0.573371,0.0177231,-0.181578,0.197353,0.133038,0.132823,0.139686,0.0213853,-0.153475,0.0524443,-0.293926,-0.710341,0.112874,-0.148426,-0.313461,-0.201127,0.306225,0.252367,-0.0408475,-0.00573827,0.152067,-0.28534,-0.18087,0.225426,0.0715757,-0.203176,0.662927,-0.0482859,-0.183545,-0.378836,-0.144018,-0.00320818,0.131057,0.0084852,0.760477,0.0526508,0.13028,0.271872,-0.128376,-0.280791,-0.59979,-0.012935,0.178546,-0.213923,0.22736,-0.0471895,0.419071,-0.188624,0.054973,-0.180282,0.039556,0.53206,-0.18337,-0.678393,-0.100936,0.0318032,-0.215691,-0.375054,-0.24858,-0.546001,-0.196488,0.102847,0.323732,0.0247088,-0.403481,-0.590641,-0.132464,0.00876705,-0.0782675,-0.29804,-0.194145,0.0264632,-0.0859525,-0.254665,0.199424,0.238393,-0.244326,-0.254599,0.0217701,0.977441,-0.316109,-0.163931,0.0818911,-0.0635403,0.0827302,0.380092,-0.247902,-0.224559,-0.311999,-0.116772,-0.258007,-0.424265,0.0206024,-0.203554,0.0825833,0.259543,0.691012,0.429833,-0.0906636,-0.090655,0.0104928,-0.00512654,-0.346111,0.0439034,0.0435689,0.00385121,-0.102604,0.353995,-0.0640411,-0.362296,0.353451,-0.251412,0.228705,0.140653,0.490112,-0.205389,0.196155,-0.157534,0.545832,-0.27919,-0.0649468,-0.290135,-0.0789691,-0.140173,0.260331,-0.135491,-0.694317,0.356259,-0.248094,0.150089,-0.535832,0.0506909,-0.236512,0.533165,0.149748,-0.0197307,0.621667,-0.186756,0.148396,-0.183468,-0.286992,-0.0706922,0.0535082,-0.142051,-0.0930531,0.132689,0.151256,0.575012,0.00898629,-0.106205,0.330796,0.0616413,-0.0728786,-0.250338,0.0578591,0.420556,0.0632963,-0.0220584,0.0279437,0.0288156,0.488392,0.362112,0.249839,0.330258,0.405616,0.289801,-0.295262,-0.221026,0.179829,-0.0912855,0.141541,0.0756392,-0.145008,0.0897566,0.251383,0.299594,0.501382,-2.45406 +3469.28,0.579462,0.0912059,4,1.56699,0.969833,-1.08584,0.408254,0.269593,-0.113002,-0.140287,0.0322958,0.767686,-0.0505546,0.111164,0.196637,-0.23543,0.0686537,-0.382866,1.019,0.394586,0.0653367,0.225103,0.0586933,-0.249022,-1.23798,-0.501815,0.16246,-0.351169,0.106256,-0.281098,0.462494,-0.354123,0.386719,0.912337,-0.318286,0.107181,0.242205,-0.547232,-0.504359,-0.424502,0.876817,0.822712,-0.0524108,1.18768,0.770636,0.826699,-1.18236,-0.264977,-0.00910067,-0.446122,-0.201376,0.263486,0.142846,0.154201,0.0434124,-0.0555545,-0.502426,-0.0613822,-0.00899703,-0.29438,-0.926732,0.232616,-0.718111,0.120365,1.10884,-0.761335,-0.989078,-0.16689,0.0226673,-0.0543179,-0.450799,-0.104931,-0.297689,-0.569118,0.276649,0.796392,-0.313621,0.499561,0.317805,0.0717688,-0.291423,-0.274159,-0.0360349,0.850292,-0.0587843,0.226371,0.014796,-0.511278,-0.582592,-0.474394,-0.15518,0.0332013,-0.583006,-0.00503288,0.0497953,-0.347216,0.0194857,-0.109946,-0.290951,-0.395841,-0.659297,-0.0105853,0.0487262,0.0277567,-0.199252,-0.150561,-0.066788,0.490136,0.128026,0.14703,-0.349939,0.0402107,0.187404,-0.0276391,-0.261748,0.249902,0.628866,0.25075,0.353298,-0.00619566,0.311814,0.432701,0.0707332,-0.190524,-0.217678,-0.0816287,0.266495,0.179297,-0.0439394,0.000938015,-0.109895,0.0816632,-0.365164,0.196973,-0.0462229,-0.162993,0.293336,-0.288232,-0.44817,0.077487,-0.158959,0.173441,-0.222443,-0.350199,0.0290877,0.264401,-0.624628,-0.236045,0.0983934,-0.243495,0.0141021,-0.302553,0.398999,-0.0866755,0.184591,-0.145409,0.491758,0.130404,0.317124,-0.22346,0.0375767,-0.112871,-0.0315711,0.00579692,0.101323,0.587666,0.367527,-0.0478596,0.257646,-0.0223197,0.133096,-0.0498179,-0.274919,0.153918,-0.0853763,0.263182,-0.0443987,0.0164134,-0.260318,-0.15776,-0.166029,0.219794,0.61796,0.170136,0.276365,-0.236984,-0.0120526,0.215926,-0.289565,0.343043,0.0404977,0.10495,-0.146922,0.195608,-0.0295556,-0.0136903,-0.406323,0.0609146,-0.0935898,0.305431,-0.0741083,-0.158805,0.266969,-0.113718,-0.253815,0.0657442,0.0511078,0.34378,-0.302178,-0.188529,0.84079,-0.112364,0.102289,0.0786712,0.0102365,0.00988616,-0.106396,-0.293264,-0.0320376,-0.416661,0.225023,0.506606,-0.234406,-0.166699,-0.239137,0.0357437,-0.380545,-0.0541045,0.286735,-0.444606,-0.270284,0.232787,0.509143,0.084661,0.524913,-0.634193,-0.126031,0.0626804,0.450425,-0.189269,0.0244012,0.473928,0.0453889,-0.2867,0.80716,-0.408023,-0.331356,-0.00437262,-0.30643,0.359809,0.319993,-0.0905787,-0.0198895,-0.0575497,-0.368162,0.129085,-0.0904025,-0.490003,0.319933,-0.0995413,-0.165561,0.456648,-0.0972047,-0.015956,-0.0165585,-0.280248,0.425852,-0.0480933,0.365791,0.0449645,-0.14853,0.247706,0.181394,-0.477465,-0.0116546,-0.126263,0.0697611,-0.703027,-0.299745,-0.132024,0.0935468,0.236151,-0.00532556,0.0570561,-0.139197,-0.0141551,-0.064192,0.148267,-0.421873,-0.645874,-0.483388,-0.165232,0.328051,0.431797,0.364265,0.184636,0.0195978,0.149484,-0.254891,-0.354008,-0.169509,0.217359,0.0168864,-0.0193083,0.0838713,0.333865,0.289605,0.577811,-0.831027 +3464.74,0.668076,0.0912059,4,1.55884,0.91698,-1.03665,0.458002,0.471906,-0.0926118,-0.0678466,0.253829,0.769298,0.0380867,0.0192261,0.151546,-0.328399,0.174746,-0.23543,1.11282,0.401879,0.0654723,0.308293,-0.0313351,-0.367185,-1.27313,-0.704135,0.12482,-0.534151,0.146943,-0.12788,0.535073,-0.255357,0.327613,0.892255,-0.105115,0.218161,0.240101,-0.598423,-0.538394,-0.276102,0.814574,0.865704,-0.0825864,1.10959,0.730283,0.845917,-1.24351,-0.392038,-0.104152,-0.308185,-0.340076,0.267987,0.00376818,0.223645,0.122496,-0.0496328,-0.403375,-0.16049,-0.124759,-0.441556,-0.908628,0.193695,-0.721974,0.0160787,1.0223,-0.796461,-1.01334,-0.00778864,0.123106,-0.0269431,-0.675437,0.00482623,-0.167132,-0.386319,0.243847,0.786609,-0.339241,0.42208,0.355452,0.0992378,-0.263346,-0.177521,-0.000170195,0.694715,-0.392225,0.199231,0.01072,-0.5848,-0.550399,-0.430287,-0.162659,-0.0411275,-0.482785,0.12934,-0.050959,-0.404173,-0.00919055,-0.30674,-0.213492,-0.366636,-0.649996,0.071147,0.00650948,-0.0628053,-0.117572,-0.144644,-0.133661,0.607604,-0.0408592,0.279685,-0.42318,0.144595,0.107044,0.0226543,-0.0351632,0.0618252,0.620898,0.282304,0.409298,-0.0797942,0.192254,0.279524,-0.0957603,-0.224152,-0.0434388,-0.216597,0.172735,0.0173211,-0.0254037,-0.0663759,-0.109701,0.302851,-0.297679,0.118925,-0.0286794,-0.269982,0.310323,-0.138233,-0.486255,-0.0483205,-0.173451,0.12933,-0.059559,-0.306215,0.161389,0.250512,-0.330819,-0.235098,0.350624,-0.38262,0.0676394,-0.23657,0.349068,-0.0176556,0.251044,-0.0397314,0.44016,0.29716,0.505718,-0.246961,-0.0741303,-0.151803,0.00810283,0.0565582,-0.019628,0.673017,0.40424,0.04692,0.244519,-0.0300007,0.14958,-0.122021,-0.138724,0.0367056,0.183436,0.298533,-0.0125489,-0.00716033,-0.452122,-0.0805186,-0.247638,0.236399,0.483107,0.300281,0.299166,0.106749,0.0830116,0.215347,-0.386493,0.336429,0.0454587,0.0716732,-0.18348,0.3924,0.0438878,0.0308939,-0.556407,-0.0699468,-0.0063461,0.465533,0.0105203,-0.22608,0.285443,-0.126113,-0.280191,0.0636034,0.150613,0.490749,-0.360304,-0.250928,0.933877,-0.0280289,0.222405,0.095084,-0.0826039,0.19081,-0.0741284,-0.202824,-0.0503655,-0.540911,0.165091,0.464184,-0.0407193,-0.152695,-0.294184,-0.110981,-0.18994,-0.176535,0.263484,-0.461832,-0.129539,0.217803,0.323005,0.0359941,0.489857,-0.617576,-0.00843517,0.0403325,0.499374,-0.252828,0.0108038,0.522256,-0.035715,-0.105279,0.666436,-0.335401,-0.257709,0.0707904,-0.156031,0.406322,0.0646657,-0.00703221,-0.199408,-0.134107,-0.352986,0.114085,-0.205735,-0.518135,0.363735,-0.163183,-0.135876,0.852551,-0.0952533,-0.0190923,-0.0996797,-0.374296,0.470442,-0.0679017,0.269383,0.053049,-0.169982,0.418802,0.172822,-0.582004,0.134998,-0.0949651,0.0840798,-0.784912,-0.340019,-0.0567181,-0.105523,0.25546,0.110198,-0.119784,-0.190649,-0.107029,-0.058217,0.122071,-0.479707,-0.690911,-0.409134,-0.00607772,0.235337,0.587606,0.422364,0.174786,0.045283,0.271552,-0.32282,-0.393482,-0.177905,0.249059,0.135457,-0.0616074,0.0838857,0.365444,0.28963,0.60452,-1.49549 +3464.88,0.897805,0.0912059,4,1.54259,0.804869,-1.45442,0.671196,0.700734,-0.192465,0.490821,0.0512789,0.109987,-0.0455222,0.182343,-0.367265,-0.162534,0.395158,-0.0973022,0.722294,0.116292,0.451029,-0.354575,-0.0153903,-0.0437183,-0.820945,-0.725002,0.325624,-0.0724722,0.706653,-0.0431796,0.715227,0.0361676,0.163008,1.08063,0.0573705,0.386035,0.426364,-0.433388,-0.426498,-0.493554,0.666766,0.960412,-0.221442,0.752168,0.59658,0.536523,-0.69274,-0.107471,0.18907,-0.258335,0.480137,0.30911,0.216791,0.217071,0.450823,-0.0704327,-0.61883,-0.139415,-0.387914,-0.477604,-0.390916,-0.0307627,0.139073,0.225438,1.07929,-1.22608,-2.00156,-0.111493,0.144698,-0.417497,-0.264455,0.0409355,-0.157844,0.0220571,0.579377,0.621105,0.0861653,0.569085,0.351973,0.0688478,-0.088011,-0.533693,0.345785,0.558117,-0.0697985,0.195888,0.266946,-0.407189,0.325835,-0.0373515,-0.0414029,-0.113414,-0.320177,-0.0650388,-0.30141,0.284632,0.185507,0.243836,-0.000281705,0.0513417,0.0559627,-0.350763,0.256463,-0.515352,-0.465386,-0.1439,-0.196825,0.279607,-0.0334698,0.222064,-0.0368681,0.160758,0.304845,-0.553644,-0.346721,-0.169215,0.861222,0.311084,-0.205136,-0.372519,0.0927237,0.366327,-0.168141,-0.553557,0.0497578,-0.104811,0.223069,0.0762075,0.209069,-0.227413,-0.22205,0.0529766,-0.236692,0.090803,0.0810152,0.144708,-0.0170288,-0.278443,-0.246718,0.0524928,-0.00452108,0.560741,-0.703549,-0.330816,0.047479,-0.0437211,-0.521114,0.299106,-0.0718202,-0.128143,0.141588,-0.353337,-0.502581,-0.223295,-0.295992,0.404308,-0.12985,0.219836,0.13239,-0.543961,0.138652,0.128021,0.129188,-0.283134,-0.327949,0.687237,0.35764,-0.138475,0.209206,0.0446579,0.0639351,-0.31572,0.0878817,0.320918,0.0454783,0.444573,-0.256617,0.372531,0.0418348,-0.17689,-0.086607,0.303939,0.125835,0.547397,0.674856,0.256829,0.130055,-0.293353,0.0355423,-0.0286709,-0.338162,0.480343,0.321238,0.0536478,-0.242615,0.211835,-0.62174,0.217562,0.34667,0.0827974,-0.0630451,-0.45321,-0.135885,0.182178,0.026263,-0.01852,-0.120628,-0.361883,-0.10719,-0.235531,0.512099,0.0621089,-0.0251777,-0.175735,0.0150946,0.238624,0.357995,-0.0933846,0.186996,-0.0535338,0.00434361,-0.103643,-0.288058,0.113904,-0.241495,0.217714,0.306222,-0.0513631,0.100452,-0.196217,-0.458126,0.096914,0.293274,-0.11254,0.289407,0.138089,-0.244096,-0.249189,0.68822,0.198482,-0.322219,0.429745,-0.0552047,-0.262635,0.00625974,-0.28429,0.0205583,-0.0483879,-0.123989,0.266898,0.312639,0.049848,-0.423128,0.245536,-0.494098,0.383499,-0.367996,0.15196,0.120826,-0.161901,0.0394898,0.640077,0.144741,0.280638,-0.295481,0.33544,-0.0536114,0.480209,-0.157551,-0.0533594,-0.760493,-0.277989,0.143375,-0.222843,0.305731,-0.454045,0.333809,-0.0358495,-0.119756,0.311713,0.0608763,0.212481,0.317036,-0.115722,0.188778,-0.039228,-0.00674412,0.0189769,-0.0670107,0.0615679,0.257424,0.000896416,0.00383059,0.415248,-0.288722,0.00268292,-0.406064,-0.0898565,-0.721285,-0.0392659,0.00254183,0.303765,-0.157989,0.212971,0.0878738,0.302286,0.296435,0.549805,-2.03091 +3427.25,0.662072,0.0912059,5,1.58402,0.592398,-1.29792,0.571376,-0.346698,-0.0318128,-0.0648679,0.101097,0.369285,0.188364,0.18233,0.0349912,-0.100715,0.563187,-0.137134,0.502431,0.538569,-0.0104163,0.184227,0.331986,-0.258939,-0.466391,-0.508287,0.648401,-0.680333,-0.873107,-0.184312,-0.246724,-0.688126,0.425115,1.08285,-1.10147,-0.551621,0.218041,-0.0203618,0.0130921,-0.383959,0.677879,-0.0245593,-0.476164,0.717907,0.857547,0.361046,-0.97277,-0.496255,-0.388843,-0.630554,0.0288205,0.313204,-0.0238192,0.588963,0.44244,-0.220555,-0.0182066,0.585407,0.017476,0.122375,-0.931737,0.181143,-0.605539,0.573524,0.860776,-0.544723,0.0731318,-0.116712,-0.290592,0.167875,0.0478072,0.28876,-0.702715,-0.0959257,0.0168962,0.733725,0.0135741,0.314119,0.243988,0.243193,-0.0819866,0.197072,0.210201,0.283447,-0.513845,0.260267,-0.0594565,0.510281,-0.310078,0.0453787,-0.313123,0.0434338,-0.578307,-0.14696,0.483081,-0.292378,-0.2113,-0.0671946,-0.439826,-0.155484,-0.386684,0.413406,0.48608,0.38724,0.161876,-0.344903,0.217604,0.0962864,-0.451821,0.121633,0.0529159,0.0212856,0.184622,0.128544,0.170467,0.281175,0.0352424,0.159569,0.167993,-0.293882,-0.0220098,-0.185611,0.132942,-0.343028,0.117879,-0.234753,-0.472246,-0.35656,-0.0738964,0.423424,0.173228,0.129384,0.0114219,-0.0324351,0.169082,0.1912,0.987245,-0.0738858,-0.0678449,0.031862,-0.336629,0.545613,-0.413035,-0.34671,-0.00258109,0.422959,-0.465381,-0.0356279,0.0876484,-0.048518,-0.348492,-0.183246,0.280522,-0.0286726,0.498724,-0.0124944,0.0232216,-0.021738,0.225209,0.667164,0.211575,0.199986,-0.150028,0.427565,0.210262,0.66306,-0.232026,-0.147245,0.131991,-0.0380955,-0.572527,-0.293718,-0.308126,0.494052,0.199894,-0.252109,0.0582981,-0.64053,0.31649,-0.12166,0.0801235,-0.354767,0.960106,0.178836,-0.876958,0.614673,-0.431699,0.136669,-0.731403,-0.11398,-0.456253,0.0237817,-0.793735,0.27238,0.238831,0.0993781,-0.286171,-0.232773,-0.0728301,-0.088528,-0.209625,-0.190116,0.0741487,-0.186852,-0.292508,-0.0487599,0.0209561,0.0785928,0.0183801,-0.658805,0.897291,0.573494,0.0607107,0.329566,-0.11348,0.259608,0.21312,-0.0804746,-0.0916716,-0.385172,0.461196,0.325166,-0.244854,-0.298222,-0.223398,-0.159209,-0.121391,-0.372402,0.880913,-0.276407,-0.310446,-0.113803,0.0176402,-0.303575,0.134105,-0.249176,0.132621,-0.373176,-0.0243938,-0.457063,-0.109666,0.414065,0.116051,0.387251,0.231579,-0.00521552,0.0657776,0.34671,0.197649,0.322523,-0.280907,-0.446973,0.227276,-0.177725,-0.115342,0.144188,-0.221761,-0.525105,0.282644,-0.0242978,0.111174,-0.311643,0.156583,0.339434,0.62901,-0.183782,0.110844,-0.0234851,0.178258,-0.214241,0.564413,-0.200943,-0.1862,0.288898,-0.117551,0.166567,-0.470406,-0.367577,0.140417,-0.0830029,-0.172965,0.061807,-0.0977773,0.115472,-0.0344992,-0.539668,-0.0527678,0.535485,0.122373,-0.553074,0.242138,0.484057,-0.179207,-0.0002601,0.322145,0.159067,0.714422,0.0918204,0.357379,0.0135466,-0.236596,-0.316346,0.0895133,0.281428,0.123036,0.297051,0.350765,0.545024,1.83568 +3411.5,0.970295,0.0912059,4,1.49474,0.701524,-1.5515,0.557779,-0.0714486,-0.0884796,0.0664935,-0.00530184,0.221738,0.45735,0.0644365,-0.0488927,0.00120693,0.41914,-0.192993,0.631105,0.412274,0.159229,-0.0302472,0.345548,-0.194862,-0.665466,-0.577538,0.437205,-0.514608,-0.792796,-0.290457,-0.237295,-0.401916,-0.0593576,0.883659,-0.187853,-0.62772,0.026811,-0.602548,-0.0344888,-0.396832,0.55075,0.210723,-0.199446,1.19022,0.707385,0.915132,-0.614344,-0.286351,-0.294767,-0.223177,-0.138048,0.248663,0.161306,0.740709,0.429592,-0.35592,-0.419396,0.720621,0.151756,0.164707,-0.799261,0.74758,-0.489685,0.262742,1.10508,-0.992433,-0.177837,-0.254921,0.202127,-0.524657,0.029255,0.0893386,-0.710298,-0.375719,-0.0309218,0.667469,0.463105,0.184731,0.285522,0.163892,0.241176,0.175294,0.0719036,0.103982,-0.450757,0.198156,0.328331,0.457708,0.168334,0.134034,-0.437291,0.189214,-0.435202,-0.161958,0.331351,-0.279247,-0.115887,0.102484,-0.103421,0.518784,-0.417262,0.204655,0.628666,0.243314,-0.0912354,-0.432848,-0.137437,0.112459,-0.521874,0.184735,-0.194236,0.190442,0.149198,0.821092,0.546699,0.312581,0.358792,-0.00181449,-0.0739434,-0.268334,-0.282891,0.0995478,-0.210967,-0.453486,0.0253604,-0.702494,-0.24142,-0.460426,-0.101126,0.417319,0.248045,0.24725,-0.233165,-0.11636,0.448436,-0.0752202,0.780909,0.408689,-0.0532023,-0.00980399,-0.271811,0.873393,-0.199825,-0.431422,-0.0599578,0.0893116,0.0849815,0.532267,0.233001,-0.0376418,-0.506698,-0.1429,0.100507,-0.238002,0.510551,-0.0242628,-0.308935,-0.322962,0.046639,0.145103,0.166214,0.160771,-0.357322,-0.100151,0.183103,0.819491,-0.345109,0.361284,0.513243,0.035054,-0.705909,-0.124266,-0.0654915,0.603255,-0.104845,-0.262662,0.0816104,-0.180053,0.168539,-0.0564996,0.0793617,-0.193081,0.688091,0.341278,-0.351734,0.424423,-0.0302568,0.0880021,-0.951047,-0.160114,-0.0789564,-0.151496,-0.909492,0.435093,0.035118,0.173841,-0.631602,-0.364473,-0.337352,-0.344667,-0.419623,-0.370469,-0.243213,-0.283743,0.0132494,0.569957,0.43496,0.52959,0.155902,-0.501754,0.930092,0.56707,0.158503,0.269415,-0.396608,0.16888,-0.383646,-0.370856,0.331093,-0.838733,0.25834,0.278025,-0.50426,-0.0816461,-0.589455,0.0570056,-0.213793,-0.706689,0.868364,-0.771419,-0.16916,0.201326,-0.0424305,0.334425,-0.123095,-0.327413,-0.358719,-0.0648631,0.311341,0.0167771,-0.0946783,0.112759,-0.245807,0.663806,0.252113,0.222291,-0.192758,-0.232521,-0.104153,0.36334,-0.198306,-0.481002,-0.0813586,0.0848246,-0.375843,0.00141132,-0.252197,-0.310228,0.152035,-0.245662,-0.323936,0.123126,0.283303,0.300247,0.512571,-0.137667,0.0629249,-0.731155,-0.063781,0.287037,0.338832,0.375726,-0.544548,0.00722199,-0.0792153,-0.269824,-0.653665,-0.135472,0.339591,0.0798144,-0.414562,-0.121247,0.104998,-0.0257736,-0.0343814,0.0762019,0.135373,0.248454,0.0743255,-0.0186718,0.48971,0.514501,-0.507662,-0.295904,0.295091,0.0750099,0.222182,-0.198316,-0.153051,0.405537,0.0612749,0.386095,-0.099529,-0.143793,0.108197,0.250628,0.328933,0.500628,0.800005 +3411.72,0.984822,0.0912059,4,1.56109,0.81313,-0.966431,0.311378,-0.175264,-0.138156,-0.444482,0.324731,0.340856,0.0229871,-0.302478,-0.108178,0.265592,0.15542,-0.0964092,0.424331,0.14585,0.116089,-0.185393,0.11276,-0.161746,-0.590004,-0.749083,0.438481,-0.116665,-0.248233,-0.495961,0.145306,-0.0943157,-0.0682599,0.757647,-0.563285,-0.347685,0.0608968,-0.247003,0.214687,-0.594465,0.833145,0.308397,-0.808669,1.21269,0.805048,0.464476,-0.595191,-0.201913,-0.413944,-0.444885,0.397825,0.783024,0.0744074,0.458246,0.114651,-0.00949758,-0.587993,0.779764,-0.437774,-0.455315,-0.983585,0.373963,0.176777,0.738727,0.965744,-0.807253,-1.03517,0.448296,0.301545,0.0639532,0.157845,-0.251994,0.13457,-0.155888,-0.101134,1.03235,-0.247149,0.627262,0.570234,0.198833,-0.691444,-0.343254,0.00813892,-0.121089,-0.407892,0.0573586,-0.188981,-0.679536,0.328969,0.182127,0.016226,0.0910184,0.00117172,-0.239447,0.195214,0.000630892,-0.000568578,0.339541,-0.181099,-0.221712,0.573972,0.24932,-0.151008,-0.00729282,-0.188731,-0.23167,-0.0384232,-0.256282,-0.537018,0.382631,-0.166676,0.450293,0.289545,-0.177298,-0.0793995,-0.309246,0.157077,0.131916,0.425174,0.436809,-0.0461572,0.573652,-0.450501,-0.677677,0.291106,-0.250372,0.199145,-5.36093e-05,0.122676,0.0759175,-0.170176,0.225911,-0.456328,-0.180201,0.616443,0.0402226,0.488466,-0.163825,-0.545156,0.474603,-0.127378,0.000893336,-0.688126,-0.267067,-0.216778,-0.0264163,-0.304674,0.306351,-0.243799,-0.357888,0.0954496,-0.0242506,-0.384561,-0.219326,0.338688,0.288504,-0.422491,0.406669,-0.0129541,0.161371,0.471007,-0.380394,-0.0608519,0.367957,-0.429202,0.459959,-0.356346,-0.320079,0.125228,0.225434,-0.0205228,-0.871652,0.749251,0.372585,0.0308514,-0.0244718,-0.109802,0.143,-0.277263,-0.299442,-0.137951,0.0715528,0.423942,0.180654,-0.693102,0.0809329,0.265366,-0.070105,-0.35596,0.0973962,-0.318873,0.714005,0.00426235,0.429107,0.105066,0.10088,-0.442691,-0.188735,0.360295,-0.143669,0.198749,-0.778456,-0.696959,-0.207911,-0.140258,-0.243697,0.637565,-0.897902,0.214912,-0.839156,0.873002,-0.0177819,0.510625,0.345747,0.437436,0.311458,-0.221644,0.553438,0.25321,0.0175281,0.222913,-0.269425,-0.540907,-0.139189,-0.418058,0.0699157,0.48816,0.180562,0.086488,-0.56245,-0.743154,0.00757604,0.652966,-0.0182631,0.0194949,0.00117855,-0.19386,0.40607,0.158114,0.160192,0.299125,0.666252,-0.746987,0.0894499,0.485988,0.413797,0.263911,0.618511,-0.214777,0.814247,-0.0147682,-0.0557754,0.355679,0.18221,-0.87513,0.55664,-0.36987,-0.273283,0.233027,0.112015,0.168378,0.324376,-0.09954,-0.261514,0.308675,0.37453,-0.0127998,0.194098,0.660022,-0.0913556,-0.5521,-0.0311485,-0.114643,-0.565638,-0.69478,0.217308,0.587706,-0.02145,0.130086,-0.61163,0.400019,0.352484,-0.0606452,0.382996,-0.26511,-0.203807,0.265424,0.0338938,-0.141741,-0.300138,0.431463,0.130574,-0.193989,0.150104,0.166142,0.497153,0.565877,-0.603408,-0.0217299,0.0758623,0.0341605,0.130773,0.137054,-0.213318,0.145761,0.30106,0.381787,0.548689,0.952369 +3427.5,0.624251,0.0912059,5,1.57011,0.86035,-0.756666,0.147073,-0.333869,-0.00948702,0.173253,-0.211378,-0.0230296,-0.391719,0.0546836,-0.256618,-0.352483,0.362359,-0.225411,0.970291,0.207174,-0.0568079,-0.566548,0.138949,-0.204343,-0.649313,-0.95068,0.39707,0.120971,-0.346743,-0.0305741,0.217679,-0.323628,0.230099,0.827892,-0.458125,-0.296948,-0.124359,-0.514142,0.00357437,-0.578347,0.221126,0.0124171,-0.212941,1.36757,0.322,-0.206364,-0.662703,-0.0894842,-0.0804603,-1.16226,0.577478,0.722046,0.0416518,0.70476,-0.0927215,0.325876,-0.642069,0.94852,-0.353487,-0.0783547,-0.6444,0.530446,-0.397378,-0.166907,0.918655,-0.851889,-0.630452,0.0876736,0.414412,-0.0296869,0.412539,0.564715,-0.41607,-0.135079,0.135497,0.793787,-0.271332,0.424049,0.434923,-0.0708092,-0.606753,-0.0898964,0.116381,0.313883,-0.210226,0.225679,0.107461,-0.311289,0.11378,0.189111,-0.0355273,-0.451133,-0.556375,0.573717,-0.149022,0.346684,0.19876,-0.0294709,-0.144476,0.0697599,-0.411108,-0.0754399,0.124621,0.279926,-0.211079,-0.110718,0.29637,0.958875,-0.430475,-0.0187073,-0.461843,0.0162844,0.449208,-0.0124293,-0.0847692,0.602349,0.480396,0.376048,0.0142522,-0.0841366,-0.363499,0.144182,0.0864727,-0.47128,-0.346566,-0.77118,-0.397222,0.413709,0.0895422,0.456168,0.190986,-0.341787,-0.557878,0.361069,0.230174,0.302006,0.416339,-0.482159,0.150652,-0.0346806,-0.262646,0.295316,-0.61357,-0.299576,-0.062782,-0.490599,0.0544052,-0.00306481,-0.0934202,0.403102,0.216882,-0.272626,-0.542093,-0.4221,0.282565,0.241507,0.351618,0.0666274,0.119909,0.0697865,-0.0584007,0.161269,0.0833342,0.0934194,0.436125,0.652965,0.435138,-0.416575,-0.455792,-0.253863,-0.0970042,0.22226,-0.0425009,0.21878,-0.529415,-0.207315,0.335874,-0.209389,-0.0837866,0.017807,-0.319473,0.314109,0.508977,0.0847638,-0.585671,-0.152249,0.356512,-0.332409,-0.158624,0.0480658,-0.452339,0.072866,-0.413908,0.299274,0.120654,0.12746,-0.474142,0.0559507,0.627475,0.365716,-0.605998,-0.724888,-0.156466,-0.235186,-0.149596,0.42709,-0.170766,-0.0264318,-0.179048,-0.939942,0.828421,0.0214871,-0.279136,-0.192075,-0.331895,-0.266614,0.0661902,-0.143911,0.484941,-0.350488,-0.2206,0.870177,0.0484728,0.0794081,-0.664143,0.325958,-0.182277,-0.918875,0.548458,-0.210713,-0.259284,-0.328692,-0.638635,0.10573,-0.0241642,-0.125933,-0.35966,-0.522403,0.555482,0.279975,0.197022,0.660526,-0.617837,0.223295,0.434016,-0.399354,-0.0681434,0.256561,0.0079299,-0.0333904,-0.407865,-0.206744,-0.357388,-0.289106,-0.411412,0.204919,-0.298142,0.642569,0.047122,-0.684889,0.00493869,-0.0368864,-0.41825,-0.0031576,0.307108,0.16372,0.161708,-0.438226,-0.0806593,0.244851,0.120818,0.145658,-0.0553092,0.0788293,0.374031,0.0681082,-0.0830832,-0.229531,-0.215591,0.129704,-0.280904,0.108858,0.08623,-0.202365,0.456875,0.128153,0.160873,-0.333909,0.29077,-0.39653,0.424909,-0.0834817,0.566906,-0.299505,0.370271,0.186957,-0.0765071,-0.284408,-0.379205,-0.33093,-0.545737,-0.298825,-0.464419,0.463451,0.102277,0.283223,0.319807,0.532187,1.41788 +3408.98,0.789644,0.0912059,4,1.49973,0.913177,-0.793686,0.193881,-0.147915,-0.115623,-0.541198,0.437903,0.264504,0.198391,-0.0579424,-0.10829,0.0572753,0.63748,-0.232554,0.476138,0.035664,-0.0834607,0.0159536,0.501744,-0.267521,-0.924945,-0.546522,0.260697,-0.228686,-0.3683,0.367909,0.0193286,0.103886,0.42217,1.04838,0.256712,-0.387424,-0.0223237,-0.395057,0.0300483,-0.37946,0.600907,0.398088,-0.0600677,0.894171,0.550888,0.576962,-0.916666,-0.251365,-0.187513,-0.415136,0.946745,0.756767,-0.0225029,0.283666,0.568088,0.223645,-0.266924,1.03999,0.20429,0.114178,-0.994648,0.727681,0.0751653,0.719373,0.779375,-0.475215,-0.684785,-0.00695622,0.00644438,-0.0864763,0.250008,0.492411,-0.315595,0.273206,0.28192,0.301302,0.588373,0.478388,0.690723,0.492297,0.31119,-0.479577,-0.271135,0.23873,-0.312007,0.281794,-0.165336,0.397385,-0.338385,-0.0117688,-0.790679,-0.0388726,-0.366256,-1.09169,0.472714,-0.0936218,0.13547,0.358052,0.0889542,0.179923,-0.391152,0.135647,0.326882,-0.0864604,0.40259,-0.087133,-0.892135,-0.0932549,0.574349,-0.546116,-0.165367,0.0948297,0.088939,0.385005,-0.31797,-0.388992,0.127419,-0.0326964,-0.294237,0.242423,0.175244,0.55151,-0.348812,-0.224417,0.186516,0.167653,0.392469,-0.215561,0.445087,0.113814,0.0138605,0.457583,0.397106,0.224246,-0.0864357,0.48523,0.657962,-0.1916,-0.261395,-0.11918,-0.336566,0.372685,-0.0961368,-0.322112,0.0731205,0.498694,-0.249954,-0.168043,0.100732,-0.00573934,-0.14261,-0.172424,0.189171,0.175718,0.108871,0.274252,-0.3155,0.0459234,-0.140688,0.182333,-0.383719,-0.10037,0.14684,0.0585224,-0.0151116,0.676686,-0.425231,0.0502897,-0.358564,-0.3373,0.0292576,-0.94141,-0.133995,0.0996056,-0.21407,-0.149395,-0.269271,0.0174131,-0.0390399,-0.413442,0.0993121,0.0931674,0.846841,-0.247905,0.00563998,0.190113,-0.0817838,0.236678,-0.712224,0.14648,0.132129,-0.0780706,0.00483511,0.110545,-0.00276251,0.145674,0.0773469,-0.132974,0.0866313,-0.371306,-0.198004,-0.526702,0.112724,0.174138,-0.448194,0.183156,-0.0479928,-0.680339,-0.00688024,-0.127717,0.811428,-0.120862,0.843794,0.35551,0.280035,0.337944,0.415235,0.26755,0.0336161,-0.514904,0.505102,0.0728632,-0.59589,0.303549,0.0734426,-0.31369,0.283762,0.0602646,-0.104109,-0.350828,-0.282479,0.0431518,0.427018,-0.0526688,-0.138322,-0.30804,-0.0664793,0.217417,0.0535056,-0.231264,-0.0490461,0.340726,0.325162,-0.316832,0.389246,0.350264,-0.0757701,0.335715,0.317192,0.00602743,0.59298,0.193108,-0.171057,0.502726,-0.205731,0.79754,-0.215828,-0.799698,-0.158432,0.182398,0.145227,0.524387,0.364156,0.226104,-0.0788517,-0.210884,0.411614,0.450539,-0.412847,-0.51033,-0.101027,-0.429833,0.0998394,0.0584568,-0.396011,-0.739107,0.0535057,0.0315246,-0.276196,0.164528,0.402402,0.517104,0.0956961,0.166383,-0.660252,-0.33121,-0.578936,0.252832,-0.0495336,-0.0652791,-0.471194,-0.123605,0.067211,-0.0740171,-0.0496516,-0.180603,0.207254,-0.475954,0.0356468,0.0258277,0.328262,0.11208,0.770123,-0.271594,0.118308,0.215337,0.34396,0.464044,0.638379 +3410.66,0.784862,0.0912059,4,1.51565,0.990968,-1.0455,0.274965,-0.137104,0.0166138,0.284628,-0.316473,0.522578,0.157994,-0.583433,-0.529647,-0.401658,0.413916,0.189296,0.559903,-0.244425,-0.036384,-0.190783,0.136069,-0.189887,-1.05903,-1.03846,-0.0314511,-0.620999,-0.219669,0.390219,0.232348,-0.0132231,0.126073,1.12015,-0.0166403,-0.120956,0.179425,-0.628598,-0.249046,0.0513734,0.242751,0.152039,0.449846,0.912478,0.920401,-0.223007,-0.309176,0.196773,0.200712,-1.09767,-0.144903,0.578255,-0.255764,0.900172,0.293692,0.0198341,-0.331584,0.706483,-0.154486,0.000415783,-0.170328,0.350994,-0.197241,0.164004,0.942847,-0.889094,-0.747166,-0.0529579,-0.376981,-0.598738,-0.129905,-0.247901,0.0588486,-0.149622,0.559633,0.648385,-0.311786,1.28575,0.79807,0.0829623,0.293865,-0.420911,0.0784653,0.678662,-0.4302,0.293189,-0.203311,-0.652273,-0.260526,0.0909835,-0.419677,-0.158197,-0.775447,0.223095,-0.00419684,0.146662,0.0188924,0.270905,-0.348704,0.403083,-0.164422,-0.174708,0.72663,-0.151529,-0.297755,-0.571942,-0.430213,0.317483,-0.652722,0.191124,-0.361387,0.124289,0.0467391,0.0271482,0.393799,0.389567,0.413413,0.129531,0.401184,-0.0460001,-0.367462,0.212436,-0.0653482,-0.826821,0.362016,-0.0467044,-0.224663,0.50124,0.153623,0.0738347,0.0527945,0.132075,-0.960915,0.007858,-0.11437,-0.596482,0.674297,0.65452,-0.219283,-0.142951,-0.0647263,0.31401,-0.0199536,0.173311,-0.00907247,0.697267,0.241337,-0.408539,0.586348,-0.401111,0.242295,-0.418486,-0.420897,-0.248536,-0.38192,0.647541,-0.00165668,0.141621,0.754291,-0.124734,-0.15069,0.661628,-0.148236,0.984458,-0.0425721,0.486921,-0.207156,-0.129609,0.417852,-0.0991165,-0.00645246,-0.0772922,-0.0352787,0.42488,0.0124233,-0.111621,-0.00584659,-0.0514265,0.260088,-0.505488,0.0414678,0.105337,0.716857,0.00882127,0.247687,0.541147,0.305952,-0.085828,0.184336,-0.205685,-0.333808,0.637996,-0.206171,-0.19277,-0.650366,-0.19913,-0.529718,0.0764793,0.184855,-0.105086,-0.207187,-0.699447,-0.416686,0.183388,0.202717,0.140309,-0.304507,0.27125,-0.0943467,-0.768072,0.495024,0.130121,0.229514,-0.0687634,0.0580909,0.525868,-0.261011,-0.00708223,0.65391,-0.537373,0.353119,0.39506,-0.235972,0.00624573,-0.51806,0.786242,0.0132721,-0.55234,0.934205,-0.468194,-0.263402,0.269523,-0.460588,0.350552,0.0596265,0.143707,-0.461502,-0.344716,0.59388,0.251405,0.376157,0.810568,-0.0774755,0.11125,-0.0593532,0.368352,-0.557331,0.0748686,0.31571,0.687495,0.17878,-0.0148655,-0.297268,-0.201108,-0.101268,0.430019,-0.297633,-0.0752518,0.225116,-0.78983,0.292658,-0.0277996,0.0271508,-0.246739,0.246273,0.0223489,-0.23994,-0.059268,-0.408688,-0.278153,-0.0867318,-0.14327,-0.0366854,-0.17745,0.181888,0.0088346,0.192874,0.192373,-0.0437213,0.316894,-0.434111,0.713239,-0.115775,-0.0513053,0.510988,-0.539682,0.256538,-0.441009,0.897812,-0.334537,0.244146,0.571549,-0.216017,-0.166581,0.430921,-0.248576,-0.222326,-0.0778933,-1.06382,-0.15043,-0.199121,-0.0765773,-0.191511,-0.215571,0.143235,0.273022,0.378464,0.522515,0.503223 +3408.78,0.906116,0.0912059,5,1.54888,0.911518,-0.801668,0.268371,0.25149,-0.114049,-0.100062,0.368043,-0.213728,0.423781,-0.195488,0.0534538,0.13045,0.671021,0.133756,0.403609,0.00966016,0.179223,-0.324412,0.179927,-0.0473536,-1.10979,-0.237255,-0.0314573,-0.0645067,-0.583511,0.00515137,-0.0874518,-0.289747,0.119938,0.76099,-0.633783,0.144537,-0.167813,-0.0410334,-0.0689625,-0.388403,0.734003,0.209197,-0.255439,1.07792,0.337636,0.472675,-0.767961,0.293189,-0.320352,-0.284333,0.352473,0.5712,-0.233438,-0.0142271,0.0909696,-0.174506,-0.46343,0.654468,-0.350026,0.215239,-0.950557,0.254813,-0.174788,0.263635,1.07362,-0.681874,-0.737468,0.142543,0.376548,0.38936,-0.510188,0.432457,-0.588165,0.131847,0.320231,0.0233842,-0.528473,0.820764,0.33505,0.44206,-0.00329131,-0.56436,-0.0503539,0.501072,-0.254777,0.369006,0.301041,-0.192343,0.292525,0.191398,0.0814298,0.338799,-0.194989,-0.342427,-0.31434,-0.0644934,0.129999,0.204897,-0.53674,-0.194868,-0.318368,-0.165051,0.161087,0.280452,0.0927954,-0.521721,-0.555956,0.523993,0.14011,0.230526,0.100665,0.877392,0.810299,0.0721137,-0.296303,0.0184654,0.455319,0.305117,-0.291265,-0.453644,0.213626,0.123606,-0.149061,-0.343423,-0.151977,0.2374,0.909442,-0.144337,0.36628,0.298483,-0.817918,0.450211,-0.00682664,0.0490421,-0.272587,-0.00685704,0.803361,-0.621942,-0.672418,0.51428,-0.798825,0.339337,-0.783494,-0.530708,0.225188,0.0958747,-0.421961,0.271246,0.256697,-0.470764,0.0786434,-0.227898,0.252521,0.180476,0.763805,0.0364375,0.309486,0.157924,0.00253494,0.350274,-0.367887,-0.243453,0.170653,0.284515,0.312689,0.460376,0.0616035,0.579621,0.205738,-0.216855,0.387601,-0.714267,0.0467373,0.39698,0.664465,0.0405882,0.41359,-0.359936,-0.121558,-0.175094,0.266308,0.383725,0.59933,0.247149,-0.489564,0.446064,-0.445811,0.245308,-0.24479,-0.464876,0.00410384,-0.186102,-0.372386,-0.128928,0.165871,0.103606,-0.450076,-0.441983,0.312482,-0.144519,-0.425291,-0.852212,-0.548804,0.0440147,-0.273722,0.906941,-0.424784,-0.184799,-0.242626,-0.277438,0.965444,0.454813,-0.0442701,0.160188,-0.373418,-0.00797018,-0.13011,-0.256322,0.580645,-0.353991,0.158575,0.139784,-0.329629,0.00069445,-0.575014,0.21683,0.840675,0.317067,-0.0122475,0.108449,-0.0192747,0.217637,0.872642,-0.10169,0.141704,0.0798743,-0.23226,-0.558644,0.226456,-0.174905,0.261709,-0.0901512,0.312737,-0.248299,-0.436546,-0.753667,0.154951,0.602212,0.209627,0.200731,0.086459,-0.320237,-0.609911,0.00314735,-1.08382,0.62983,-0.799515,-0.242119,-0.333302,-0.424634,0.600964,0.252763,0.192862,-0.0789049,0.458935,-0.370637,0.326393,0.479933,0.134261,-0.394336,-0.358131,-0.352589,0.00137916,-0.208222,-0.494941,-0.308723,0.00551419,0.343702,-0.363621,0.149299,0.598511,-0.215126,0.219111,-0.866256,-0.596149,-0.577999,0.375079,0.210574,-0.0605314,-0.0798158,0.547895,0.0799042,0.0178254,0.0822314,-0.0266783,-0.407284,0.787066,0.16536,0.0986458,-0.133098,-0.378985,-0.0466229,-0.30513,-0.306244,0.147088,0.187201,0.383521,0.432667,-0.702326 +3422.73,0.623588,0.0912059,4,1.58747,0.929929,-0.816131,0.328874,0.296208,-0.0246518,0.07321,-0.209565,-0.338558,0.412485,-0.226754,-0.020762,-0.0140652,0.597791,0.0828851,0.352213,0.162353,-0.0279198,-0.428169,0.500918,-0.148609,-1.27276,-0.730741,0.405744,-0.408371,-0.311959,0.37244,0.0271628,0.150426,0.0453562,0.636338,0.00859512,0.0173628,0.235596,-0.194317,0.0631796,-0.105662,0.541374,0.50026,-0.199502,0.798589,0.229376,0.414927,-0.517237,0.18162,0.206736,-0.956869,0.288571,0.401718,-0.287177,0.0641033,0.186302,-0.102195,-0.306955,0.502778,-0.033122,0.0117864,-0.817219,0.261717,-0.455199,-0.0751716,0.899836,-0.521784,-0.969109,-0.104782,0.361931,-0.774782,-0.571072,-0.130031,-0.0651931,0.245728,0.387554,0.423472,-0.402703,0.469934,0.639231,0.295141,0.493538,-0.565274,-0.00786772,0.93205,-0.458361,0.176145,-0.176385,-0.231544,0.0121257,0.076328,0.355547,0.448936,-0.5001,0.0110749,0.235267,0.129715,-0.385455,-0.139658,-0.193863,0.289861,-0.03676,-0.195499,0.725106,0.504788,0.271848,-0.337658,-0.319132,0.503426,-0.208469,-0.0317395,-0.402941,0.440515,0.451849,-0.202775,0.178657,-0.0350027,0.338516,-0.0936536,0.0171926,-0.424413,-0.12626,0.55236,0.139198,-0.510751,0.371563,-0.572745,0.318497,0.412199,0.522848,0.244919,-0.174464,0.670152,-0.469266,-0.299019,-0.172252,-0.137384,1.30242,-0.0160037,-0.148254,0.232715,-0.322,-0.00631075,-0.0874485,0.0884129,-0.0622124,0.36165,-1.02368,0.330649,0.427551,-0.249781,0.366298,-0.158618,-0.155316,0.315994,-0.077511,0.0393895,-0.125868,-0.256429,0.0556474,0.0461991,0.255569,0.0724323,0.358716,-0.188173,-0.205937,0.339141,0.120114,0.3239,0.0968687,-0.0726,-0.0226831,-0.202433,-0.318778,0.314124,0.331376,-0.0122932,0.347906,-0.300888,0.0267851,-0.212559,0.291866,0.619049,0.529171,0.411951,-0.984888,0.101169,-0.407984,-0.241158,-0.131105,-0.237976,0.0299492,-0.409341,-0.29183,-0.310922,-0.106602,0.658003,-0.478309,0.0985963,0.874627,-0.143281,-0.461178,-0.460977,-0.106381,-0.12069,-0.295294,0.110996,0.0661042,0.256646,-0.848021,-0.25057,1.01971,-0.0334962,-0.336555,0.151955,-0.451676,-0.249694,0.342474,0.258448,0.321983,-0.728157,-0.222505,0.199059,-0.17963,-0.344567,-0.883838,-0.888967,0.661571,-0.323281,0.272332,-0.33913,-0.489345,0.252747,-0.266796,0.565719,0.0540474,-0.344037,-0.213348,0.265427,0.902281,-0.194177,-0.379405,0.411476,-0.367603,-0.164767,-0.367069,-0.242918,-0.2609,0.29274,-0.158657,0.372731,0.0692661,-0.194172,-0.754647,-0.0416067,-0.813778,0.163251,-0.445181,-0.891881,-0.118911,-0.53682,0.194281,0.0593244,-0.290821,0.272942,-0.071614,0.0336639,0.230303,-0.142784,-0.12464,-0.204053,-0.441243,0.37766,0.349826,-0.169516,-0.371939,0.0111895,0.13369,-0.194933,0.314229,-0.00170505,0.300192,-0.253802,0.193627,-0.414423,-0.19026,-0.537456,-0.279422,-0.0750069,0.321529,-0.0154969,0.0695888,0.508469,0.061041,0.152979,-0.699887,-0.463653,-0.318434,0.280997,0.174369,-0.178539,-0.0969122,0.574992,-0.74847,0.00057928,0.151246,0.222857,0.388903,0.472078,-0.916864 +3431.33,1,0.0912059,4,1.54546,0.921208,-0.956849,0.38052,0.478408,0.0432093,-0.0309793,-0.25824,-0.13221,0.479011,-0.331039,0.0929263,0.210729,0.695743,-0.194826,0.527347,0.170068,0.175342,-0.308286,0.262014,-0.00372513,-1.28727,-0.552237,0.419308,-0.291502,-0.191505,0.248026,-0.00112606,0.272658,0.158058,0.77665,-0.0670913,-0.118422,0.334815,-0.395146,-0.0167161,-0.223768,0.515631,0.57675,-0.104961,0.685857,0.241261,0.215499,-0.410622,0.100278,0.0511513,-0.928019,0.426475,0.405398,-0.111591,-0.0164357,0.166197,-0.295425,-0.337915,0.423822,-0.19567,-0.183927,-0.859917,0.0341012,-0.596179,0.0145802,0.989947,-0.460599,-1.09301,-0.146557,0.688185,-0.842233,-0.671711,-0.0135538,-0.288525,0.228191,0.405121,0.534775,-0.0606363,0.522832,0.433742,0.260815,0.240168,-0.257038,-0.249265,0.742701,-0.35482,0.0314091,-0.179854,-0.341255,0.0943692,-0.0448208,0.0671095,0.119269,-0.371197,0.0628608,0.196061,0.138331,-0.346306,0.020389,-0.139826,0.32661,-0.245194,0.0202794,0.603025,0.482866,0.185147,-0.418143,-0.158123,0.636617,-0.348103,-0.0572814,-0.253337,0.428979,0.360214,-0.296915,0.0826498,-0.108689,0.229187,-0.368645,0.103977,-0.392982,-0.0601768,0.473867,0.249247,-0.548427,0.333513,-0.450881,0.376367,0.158272,0.555315,0.216893,-0.293898,0.65222,-0.258263,-0.010182,-0.259912,0.0172214,1.36057,-0.0967932,-0.244185,0.0284073,-0.351588,0.116152,-0.106901,-0.195559,-0.322681,0.287685,-0.88877,0.283498,0.655424,-0.31202,0.210934,-0.225563,-0.184069,0.237022,-0.15665,0.0863491,-0.127954,-0.198165,0.440115,0.105681,0.34399,0.0527065,0.473037,-0.0254132,-0.213409,0.478091,-0.021383,0.183972,0.0539349,-0.200693,0.0682132,-0.0687777,-0.256116,0.525884,-0.0671553,0.0590528,0.154766,-0.265853,-0.137825,-0.306558,0.262562,0.529658,0.517387,0.412828,-0.949524,0.0590996,-0.337946,-0.0340067,-0.0968968,-0.076497,0.100202,-0.38929,-0.0289981,-0.159056,-0.199771,0.720132,-0.493164,0.0720525,0.880833,0.0609599,-0.284885,-0.614561,-0.13527,-0.217124,-0.294549,0.151221,0.147451,0.591802,-0.788062,-0.24369,1.09812,0.0155878,-0.128426,0.258188,-0.225749,-0.21291,0.295348,0.183086,0.354276,-0.381951,-0.111055,0.292436,-0.200129,-0.451142,-0.898576,-1.05651,0.240653,-0.301312,0.393023,0.0379431,-0.368957,0.357543,-0.430549,0.55592,-0.00188625,-0.362464,-0.44883,0.118841,0.823115,0.0680498,-0.043866,0.310903,-0.235786,-0.476138,-0.488065,0.058937,-0.0789635,0.379958,-0.386463,0.47027,-0.0279907,-0.159711,-0.310577,0.162686,-0.800106,-0.0169453,-0.516139,-0.782842,-0.104856,-0.611311,0.105758,0.270663,-0.236804,0.27889,0.173036,0.17454,-0.00122481,-0.221143,-0.188859,-0.0781878,-0.302432,0.363957,0.229695,-0.19864,-0.070759,0.459383,0.116218,-0.043318,0.327201,0.0294043,0.207149,-0.160136,0.0977668,-0.506494,-0.359794,-0.676132,-0.103856,0.191959,0.302992,-0.129206,0.315475,0.326937,-0.089938,0.091988,-0.410813,-0.398112,-0.229109,0.184912,-0.132905,-0.421117,0.0942911,0.543022,-0.589454,0.134397,0.1435,0.227905,0.378814,0.477394,-1.54033 +3438.36,0.585577,0.0912059,4,1.65256,0.823609,-0.776185,0.230477,0.497249,-0.211352,-0.0468007,0.328449,0.385585,0.303269,0.0273027,-0.319322,-0.332321,0.294201,-0.00413506,0.411763,0.0184917,-0.0035068,0.0738732,-0.091033,0.0811685,-0.448462,-0.685178,0.187641,-0.293736,0.216349,-0.225646,-0.0962045,-0.131147,0.188944,0.533076,-0.587712,0.0229215,0.394926,0.138647,-0.54603,-0.345346,-0.268809,-0.149374,-0.239491,0.910298,0.12789,0.403068,-0.442941,-0.0352481,-0.0829999,-0.0581265,-0.328472,0.344218,-0.0655673,0.215884,-0.0830134,0.286385,-0.121822,0.656797,0.0572752,-0.175568,-0.36045,0.629114,-0.412235,0.117402,0.626455,-0.720064,-0.46279,0.201389,0.0739351,0.176782,0.274939,-0.678123,-0.488242,-0.761388,0.176403,0.593334,-0.205673,0.955824,0.511521,0.107072,-0.193907,-0.296077,-0.060846,0.431798,0.30027,0.218253,0.0862131,-0.318943,-0.305194,-0.229303,-0.844999,-0.399146,-0.0700957,0.424708,-0.494594,-0.523636,-0.0749308,0.220334,-0.601446,0.151942,-0.0773874,-0.693014,-0.106392,-0.05925,-0.180665,-0.712203,-0.545305,0.109457,-0.905641,0.353809,-0.155119,0.475565,0.657329,-0.619322,-0.0303047,0.128013,0.470217,0.357186,0.185555,-0.242111,0.179794,0.412265,-0.438465,-0.428688,-0.246472,0.415757,-0.325008,-0.134296,-0.468905,0.0649468,-0.0852319,0.0371188,-0.227057,-0.177623,0.248871,0.00159063,0.225726,0.031443,-0.337713,-0.00497275,-0.223125,0.0257044,-0.969046,-0.517214,0.0427968,-0.396896,-0.256248,-0.0788525,0.416419,-0.600674,0.404961,0.264805,-0.206483,-0.0197744,0.139779,-0.24467,0.467515,0.505879,0.79889,0.585795,-0.305159,-0.309673,-0.193877,-0.19816,-0.438549,0.54772,-0.0829278,0.0441435,0.024643,0.353189,-0.707211,-0.645672,-0.0187072,0.265101,-0.351858,-0.0309345,-0.149134,-0.0106957,-0.181373,-0.318837,-0.580114,-0.224839,0.638112,-0.557862,0.198204,0.542758,0.241291,0.123179,-0.306914,-0.724068,-0.0740383,0.492778,-0.52298,0.0599261,-0.135723,-0.0513927,-0.580291,-0.228604,-0.108711,-0.130962,-0.401164,-0.414559,0.501482,-0.0637852,0.154582,0.139877,-0.0920281,0.270726,-0.0622719,-0.711093,0.960751,-0.390115,0.56061,-0.29018,-0.15572,0.471033,-0.273804,-0.0272085,0.32558,-0.154251,0.206227,0.616047,-0.601591,0.226516,-0.510885,0.0968171,0.249343,-0.30736,0.437804,-0.425068,-0.254235,0.300021,0.0602045,-0.430481,0.235605,-0.134882,0.0504933,-0.362314,0.208252,0.365131,0.374608,0.492308,-0.226615,-0.35921,-0.305179,-0.344508,0.348837,0.700292,0.387544,0.615366,0.367139,-0.086592,-0.1958,-0.214025,-0.262502,0.654468,0.141656,0.0284245,0.101536,-0.301714,0.0160998,-0.455373,0.191154,0.446889,0.0437845,-0.131385,0.3727,0.0791938,-0.128046,0.22207,0.0943511,-0.0133182,-0.602456,-0.143363,0.159857,-0.461467,0.476931,0.183522,-0.219131,0.13989,0.338933,0.18322,0.144613,-0.0397839,0.165372,0.204198,0.181263,-0.0474741,0.0964199,0.136729,0.549897,-0.340993,-0.210595,0.116478,-0.690267,0.253672,0.299695,-0.0865848,-0.454786,0.0770255,-0.661035,-0.395548,0.26545,-0.821901,0.148585,0.113004,0.385467,0.33616,-1.21222 +3445.78,0.88172,0.0912059,4,1.548,1.00135,-0.561821,0.139215,0.460678,-0.174198,0.481609,-0.171507,0.132559,0.561912,-0.19064,-0.227063,0.248625,0.412244,-0.156319,0.66297,0.104492,0.167139,-0.10862,0.126884,-0.316597,-0.868417,-0.717535,0.234484,-0.07298,-0.0802649,0.578111,0.282076,-0.321281,0.242379,0.369773,-0.303103,0.0609601,0.460196,-0.000700695,-0.301511,0.0882316,0.212854,0.148543,-0.246335,1.07616,0.405617,-0.105509,-0.579493,0.0349402,0.180335,-0.498397,-0.189654,0.297131,0.0639041,-0.110681,0.375933,0.199066,-0.411266,0.551384,-0.477815,0.0838717,-0.616104,0.611541,-0.289879,-0.285841,0.6277,-0.062019,-0.801668,-0.0248406,-0.289647,-0.41637,0.0780708,-0.114499,-0.312108,0.0455782,0.220713,0.638709,0.327583,0.303051,0.401899,0.164428,-0.214948,0.0235529,-0.0758875,0.188667,0.0127215,-0.0200622,0.157173,-0.300636,0.0674407,0.0729824,-0.0792471,-0.493546,0.107985,0.477254,0.307752,-0.145097,-0.116869,0.402205,-0.133061,0.535155,-0.326945,0.685582,0.120863,0.106296,-0.478486,0.259181,-0.393037,-0.0655235,-0.337929,0.659162,-0.280184,0.253528,0.616816,0.354581,-0.271983,0.180514,0.594118,0.378689,-0.159068,-0.878321,-0.182228,0.513448,0.00829226,-0.27354,-0.137747,-0.224904,-0.43031,-0.231141,0.409473,0.126587,-0.073204,-0.244078,-0.218902,-0.429083,-0.2163,-0.186386,0.720899,0.0310494,-0.315758,-0.779803,-0.361783,0.0951757,-0.163153,0.198426,-0.384089,0.210552,-0.479715,-0.166422,0.0367723,-0.287283,0.380524,0.329353,-0.0532997,-0.464917,-0.12514,-0.276764,0.134184,0.124992,0.804568,0.67415,0.323794,-0.122529,0.00370501,0.0620065,-0.271691,0.482901,0.128855,-0.302812,0.150596,0.187073,0.187854,-0.000575177,-0.0794707,-0.133809,-0.324757,0.243903,0.346211,-0.378395,-0.193661,-0.471835,-0.0277147,0.872538,1.17052,0.313251,-0.512708,0.097252,-0.321356,-0.552655,-0.380101,-0.222125,0.298435,0.266779,-0.243543,0.00247513,0.316731,0.053795,-0.823448,-0.0478913,0.486657,0.0413937,-0.1228,-0.2136,0.4206,-0.296504,-0.592213,0.227472,0.00218648,0.00551187,0.345712,-0.394142,1.30438,-0.381991,-0.321582,-0.185806,-0.369689,0.273777,-0.353609,0.110055,0.509572,0.149195,0.15605,0.131371,-0.000637857,0.00910008,0.152463,-0.105244,0.205109,0.0398511,0.286107,-0.110552,-0.0742228,-0.194604,-0.16634,-0.664104,0.168613,0.164441,-0.193806,0.187104,0.359565,-0.146357,0.290037,0.821002,0.0368026,-0.291802,0.208187,-0.0167768,-0.00718388,0.178749,0.15241,0.315629,0.221158,-0.723518,-0.16121,0.175743,-0.393475,0.129212,-0.236634,0.300923,0.121388,-0.344685,0.252477,-0.00479687,0.363465,0.127929,-0.22126,-0.0588705,-0.141377,-0.0284363,0.114813,-0.0505245,0.225667,-0.439123,3.66653e-05,-0.474963,0.615003,-0.257759,-0.0585595,0.0259665,0.182309,0.122364,0.246115,0.0761862,0.515044,-0.0672115,0.104142,-0.140156,0.512925,0.751814,0.517837,-0.0370784,0.597423,-0.118324,-0.366735,0.427289,-0.0949744,0.158476,-0.0492043,-0.174779,-0.661815,-0.578072,0.285187,-0.0975783,0.092167,-0.0162038,0.107511,0.132981,0.327889,0.364666,-1.54498 +3440.65,0.953137,0.0912059,5,1.54857,0.978674,-0.542078,0.138016,0.463585,-0.146128,0.514151,-0.241045,0.213454,0.568479,-0.202742,-0.185027,0.394202,0.416298,-0.138236,0.630938,0.133049,0.182284,-0.174769,0.16584,-0.269015,-0.860253,-0.745696,0.239411,0.031393,-0.0797006,0.64248,0.249387,-0.294446,0.214228,0.293092,-0.266236,0.00503424,0.415963,0.0341683,-0.3888,0.0807994,0.212393,0.146865,-0.277766,1.0903,0.336721,-0.135891,-0.630564,0.0481463,0.198434,-0.453332,-0.302398,0.301881,0.0228324,-0.135329,0.462849,0.186304,-0.390178,0.536308,-0.488877,0.15317,-0.527797,0.489373,-0.209842,-0.316955,0.648958,-0.0217526,-0.651471,-0.114429,-0.363424,-0.425695,0.10641,-0.182527,-0.365564,0.0694951,0.222717,0.54678,0.384817,0.26771,0.381619,0.175354,-0.28599,0.0344626,-0.0966797,0.209351,-0.0611011,0.00312066,0.150214,-0.295084,0.0542758,0.108413,-0.140951,-0.47161,0.112489,0.531589,0.171036,-0.129713,-0.114257,0.390072,-0.17623,0.578906,-0.337784,0.60612,0.127918,0.119765,-0.431267,0.293997,-0.437251,0.00279782,-0.446791,0.630291,-0.296051,0.177113,0.582156,0.293253,-0.178745,0.19687,0.528043,0.326495,-0.176424,-0.8341,-0.124429,0.521855,0.0501804,-0.247707,-0.156172,-0.253963,-0.424462,-0.235593,0.46953,0.175046,-0.106018,-0.221809,-0.18621,-0.513624,-0.242821,-0.243488,0.760411,0.0714639,-0.243227,-0.69238,-0.386112,0.158625,-0.105674,0.162303,-0.32777,0.211847,-0.516507,-0.0845833,0.0822189,-0.313022,0.25309,0.398973,-0.0242499,-0.333958,-0.157424,-0.295967,0.219514,0.179842,0.73346,0.690807,0.383651,-0.1618,0.0716391,0.00293522,-0.266914,0.450996,0.153576,-0.398617,0.165645,0.17614,0.10949,0.0944253,-0.172204,-0.112144,-0.320754,0.272506,0.24602,-0.358495,-0.139131,-0.530598,0.0296386,0.931543,1.13452,0.289385,-0.476966,0.11059,-0.222081,-0.556615,-0.43741,-0.255438,0.331538,0.258322,-0.301769,-0.0856225,0.34956,0.108722,-0.793024,-0.0914164,0.411243,0.0432429,-0.130256,-0.179425,0.420645,-0.24669,-0.674192,0.170038,0.0129136,0.076375,0.289895,-0.416575,1.33561,-0.471862,-0.216725,-0.157965,-0.377792,0.261301,-0.337397,0.143974,0.539573,0.176089,0.162541,0.135091,0.0256301,0.0556615,0.118198,-0.100751,0.148047,0.0255651,0.208422,-0.137496,-0.1551,-0.335488,-0.0745045,-0.615514,0.152436,0.168744,-0.234766,0.121444,0.329942,-0.236276,0.294682,0.831152,0.0540966,-0.190866,0.115434,-0.141265,0.130818,0.132225,0.201116,0.333274,0.176546,-0.680555,-0.206176,0.221755,-0.381859,0.0845667,-0.168898,0.267615,0.101119,-0.277977,0.208781,-0.0439122,0.387931,0.165764,-0.145154,-0.0249942,-0.144692,-0.0263676,0.0882847,-0.0687526,0.159896,-0.445182,0.00523504,-0.461104,0.548426,-0.250049,-0.0338329,0.0253728,0.103629,0.120945,0.274992,0.0843802,0.618019,-0.109508,0.134475,-0.19761,0.529394,0.753794,0.510492,0.00613179,0.632583,-0.120789,-0.356829,0.483426,-0.181969,0.159519,-0.0727891,-0.162067,-0.661201,-0.453382,0.303188,-0.0854438,-0.0599958,-0.112966,0.106666,0.135487,0.326598,0.368085,-1.53022 +3427.94,0.611167,0.0912059,4,1.58132,0.9992,-0.135932,-0.120524,0.166492,-0.0105628,-0.235733,0.189475,0.191843,0.207568,0.137427,-0.473483,-0.204115,0.468281,-0.625157,0.665103,-0.055807,-0.381975,0.00247777,0.0590426,-0.43021,-0.931755,-0.427173,0.180975,-0.185751,-0.395928,-0.27048,0.263238,-0.366082,-0.249753,0.505099,0.107602,0.509958,-0.0251427,-0.318947,0.154624,-0.80027,0.198565,-0.0941954,-0.292668,1.03587,0.349031,0.234594,-0.333217,-0.286387,-0.231411,-0.33129,-0.284008,0.722343,-0.191607,0.504033,-0.349847,0.19783,-0.092768,0.905785,0.264463,-0.132496,-0.425423,0.774957,-0.594742,0.438824,0.60759,-0.982568,-0.655511,0.207822,0.531302,0.773054,-0.205815,0.171426,-0.487927,0.36375,0.235599,0.238743,0.293838,0.994266,0.265654,0.316484,0.0624639,-0.553783,-0.0438616,0.69404,-0.494872,0.178261,-0.209131,0.452169,-0.444126,-0.165859,-0.0883558,0.230296,-0.213716,-0.412925,-0.752777,0.071174,-0.0173206,-0.0071628,0.132378,-0.17964,0.46841,-0.459058,0.432738,0.242585,0.56019,-0.532914,0.204573,0.0322583,0.161962,-0.0276601,-0.242221,0.417859,0.587196,-0.195831,0.0683537,-0.526988,0.728691,-0.117857,0.384424,0.199409,-0.00542325,-0.0458756,0.0478076,-0.58577,-0.142131,0.258018,0.407202,0.320957,0.137902,0.112547,0.421796,0.285508,0.0555228,0.42654,-0.0808209,0.360316,0.547523,-0.543238,0.196443,0.539301,-0.0384776,0.438327,-0.761517,-0.341817,-0.0345976,-0.127128,-0.0180094,0.0515744,0.458459,-0.243236,0.422115,-0.134126,-0.393611,-0.309853,0.292194,0.0744717,0.0777741,-0.101098,0.126324,-0.393813,-0.329446,0.034554,0.328244,0.0531357,0.539723,1.04917,-0.271457,0.15238,0.615222,-0.323905,0.0933494,-0.462128,-0.397111,0.393904,0.242875,0.307117,-0.446046,0.0706626,0.054883,0.0745285,0.627953,-0.377071,0.286071,-0.206684,-0.0433457,0.263233,0.314744,0.52509,0.0626797,-0.335912,-0.669973,-0.115799,-0.294229,-0.0997597,0.0255959,0.0123384,-0.175777,-0.0247891,0.0376553,0.113223,-0.219282,-0.310961,-0.350055,-0.142823,-0.00185696,0.233753,-0.217368,-0.39386,0.137563,-0.0590442,0.911562,0.258033,0.128298,0.534747,-0.128439,0.153373,0.529179,-0.140856,0.395928,-0.27261,0.108764,-0.0983589,-0.476914,-0.116458,-0.489522,-0.151317,-0.159396,-0.332711,0.595223,-0.0929313,-0.354276,-0.0734038,0.108366,-0.0632592,0.597517,-0.277882,-0.174345,-0.489978,0.114316,0.615803,-0.0755628,0.620046,-0.334171,-0.0280478,-0.595864,-0.114444,-0.130245,0.462893,-0.238273,0.177399,0.162616,0.329675,-0.531558,0.160933,0.118079,0.33709,-0.1453,-0.535326,0.261242,-0.228264,-0.187246,0.00397451,-0.320293,-0.172888,0.630938,-0.142104,0.198248,-0.164847,0.187198,0.362495,-0.457994,-0.154795,0.00306473,-0.0160372,-0.490175,-0.28992,-0.139944,0.161516,-0.16823,0.0189818,-0.0483865,0.553547,-0.611343,-0.113516,-0.62224,-0.509706,0.0436474,-0.418112,-0.196122,0.08921,-0.0897006,0.139344,0.183282,0.101564,-0.202343,-0.21134,-0.191266,-0.407847,-0.172589,0.16706,-0.0988019,-0.484226,-0.29561,-0.221815,0.105465,0.20709,0.324753,0.455071,-0.549574 +3430.14,0.888173,0.0912059,4,1.5872,1.13339,0.0190754,-0.158979,0.161556,-0.0943183,0.211557,0.21689,0.430794,0.273296,-0.19586,-0.411295,0.0147319,0.539677,-0.134749,0.618112,0.18594,-0.0883447,-0.108579,-0.380524,-0.407438,-0.944863,-0.280038,-0.0706505,-0.156495,-0.133285,0.25899,0.736314,-0.105606,-0.223202,0.457313,0.318937,0.463207,-0.0786565,0.197342,0.136134,0.0864171,0.353646,-0.137409,-0.203356,1.05811,0.7546,0.09562,-0.179556,-0.240438,0.191396,-0.661078,-0.315441,0.599269,-0.132,0.306474,0.249143,-0.250213,-0.460553,0.625954,-0.322726,-0.153477,-0.650064,0.463699,-0.393742,-0.0931826,1.28937,-0.716892,-0.967426,-0.415321,-0.0411573,-0.496829,-0.0115337,-0.166713,-0.420046,0.0294386,-0.206154,0.303428,0.288699,0.932941,0.289908,0.564438,0.0502009,-0.157875,0.268304,0.406816,-0.607841,0.083858,0.42011,-0.183065,0.073663,-0.707502,-0.188255,0.0948706,-0.460761,-0.385814,-0.387679,0.266435,-0.256647,-0.034449,-0.155394,0.368449,-0.339999,0.182483,-0.137671,-0.454661,-0.134203,-0.309549,-0.424106,0.264835,-0.288339,0.176429,-0.311949,0.698712,0.244312,0.0634843,-0.13697,-0.364616,0.772451,0.212764,0.238832,0.0135602,0.023321,0.649432,-0.0635708,-0.330188,-0.0983605,-0.0345405,0.0502657,0.146795,0.26986,-0.191838,-0.384934,-0.318717,0.0474954,-0.00234106,-0.245489,-0.039135,0.222662,-0.0484527,-0.623967,-0.394583,-0.0857622,0.197874,-0.553359,-0.360641,-0.0481957,0.16291,-0.217457,0.239534,-0.0314402,-0.0899774,0.543027,0.0178501,0.0740936,0.0125884,0.0703134,0.441502,-0.334806,0.401216,0.505052,0.491113,-0.00752859,-0.106608,-0.382941,0.0679696,-0.629906,1.12046,0.575926,-0.336288,0.50913,-0.26137,0.103862,-0.525289,0.197904,0.508987,-0.351545,0.333714,-0.402267,-0.0271659,-0.0762774,-0.436713,-0.169746,0.129313,0.520689,-0.132807,-0.63084,-0.000887031,0.331191,-0.0206828,-0.244178,0.0192811,-0.215904,-0.0104033,-0.264078,-0.147442,0.175791,-0.55178,-0.337168,0.475519,0.104746,0.125122,-0.998808,-0.213033,-0.215308,0.116783,-0.105308,0.00123313,0.542091,-0.273362,-0.0886864,-0.351582,1.09123,-0.234251,0.0117468,0.0209804,-0.14463,0.0808779,0.191432,-0.327411,0.342165,0.0912226,0.294385,-0.179803,-0.632745,-0.165278,-0.613576,0.171958,-0.13527,-0.410363,0.0733547,-0.267241,-0.197981,0.304622,-0.087143,-0.293555,0.276542,0.333839,-0.0347763,-0.169336,0.380353,-0.15476,-0.0175037,-0.155007,-0.010801,-0.570994,0.14885,-0.175146,0.224044,1.2669,-0.0681547,0.284409,-0.0113943,-0.386035,-0.517912,0.61633,-0.237152,0.351655,0.192812,-0.204557,0.334196,0.00506419,-0.518082,0.266683,0.0370536,0.0642005,0.448491,-0.436706,-0.216606,0.729359,0.570711,-0.0554948,-0.0639011,-0.365769,0.0836055,-0.611745,-0.161602,0.123999,0.405776,0.245108,0.0328161,-0.265446,-0.0113175,-0.228929,0.183066,0.121242,-0.456811,-0.265381,0.125692,0.245175,0.522581,-0.610667,-0.410889,-0.0782946,0.0445329,0.567913,-0.417149,0.396215,-0.175141,-0.202709,-0.155422,-0.117349,-0.219461,-0.0780825,-0.208099,-0.135915,0.124989,0.219589,0.353537,0.468603,-0.788588 +3429.42,1,0.0912059,4,1.58033,1.16745,-0.187528,-0.112977,0.502075,-0.138246,0.567685,0.113623,0.1597,0.139443,-0.0328962,-0.311019,0.491317,0.45217,-0.361288,1.07493,-0.17285,-0.437021,-0.0203589,0.00804164,-0.331085,-1.18548,-0.513013,-0.370883,-0.27159,0.0856808,-0.113615,0.854263,-0.31685,0.0250147,0.611897,-0.0746224,-0.200058,0.0501787,-0.0229826,-0.011647,-0.651061,0.510749,-0.0420705,-0.279456,0.998729,0.883758,0.183303,-0.420563,-0.0782942,-0.798068,-0.616926,0.138096,0.570933,-0.407391,0.382446,0.432317,0.212434,-0.116643,0.56821,0.154002,-0.140745,-0.431863,0.984237,-0.368897,0.105534,0.97037,-0.618703,-0.845449,-0.402139,0.134522,-0.755062,-0.0271082,0.0430025,-0.54077,0.145461,0.00316726,0.0488958,0.257219,0.66779,0.308725,0.553858,0.521307,-0.481058,0.0579126,0.161021,-0.00926552,0.344271,0.233505,-0.00439774,0.109088,0.102043,-0.495414,0.147892,-0.618686,-0.14075,-0.129376,0.256713,-0.287845,0.218784,-0.135877,-0.243104,-0.489093,0.458974,0.169511,-0.323234,0.116727,-0.409477,-0.374894,-0.158051,-0.672604,-0.0732642,-0.0171738,0.431044,0.377856,0.765719,-0.581782,-0.00594338,0.645965,-0.16586,-0.0522937,-0.220462,-0.366136,0.404825,-0.78865,-0.771964,0.370146,-0.114775,-0.0981665,0.158087,0.0973126,0.120512,0.249123,-0.198411,-0.603564,-0.177164,-0.333002,0.0359353,0.608063,-0.460129,-0.186025,-0.33196,0.3341,-0.0103136,-0.258313,-0.236537,-0.31914,0.327203,-0.103149,0.0811474,0.429204,0.378167,0.817795,-0.247889,0.282283,-0.309468,-0.269924,-0.163066,0.262597,0.624621,0.34073,0.146346,-0.135667,0.376733,-0.123951,-0.0843058,-0.42064,0.582673,0.373478,-0.177122,0.617677,-0.18625,0.399565,-0.284906,-0.325146,0.644351,-0.164646,0.341172,0.0800407,-0.580152,-0.179264,-0.732898,-0.174026,0.156175,0.523086,-0.0967342,-0.233064,0.747438,0.127081,-0.425963,-0.202695,-0.217308,0.0508847,0.631633,-0.462653,-0.333314,-0.170653,-0.0154308,-0.502951,-0.032195,0.531009,0.0618201,-0.719295,-0.518454,-0.0661789,0.126177,0.0532291,0.100523,0.32584,-0.307778,-0.0347081,-0.534148,0.758164,-0.323865,0.157276,0.0617154,-0.254945,-0.16489,-0.0863265,-0.717565,0.00989065,-0.144103,0.161906,-0.260096,-0.45194,0.233437,-0.253922,0.0968905,0.0159365,-0.276682,0.0106299,0.0578911,-0.498188,0.218818,0.282259,-0.15897,0.419027,0.0287849,0.339912,0.30068,0.00312693,-0.332093,0.256207,0.361752,0.0897843,-0.518695,0.212779,0.0784826,0.297739,0.312233,-0.182349,0.137576,0.0895068,-0.601842,-0.405171,0.34279,-0.0447737,0.109325,-0.454924,-0.473907,0.0486054,-0.777803,0.00603939,0.304742,-0.253851,0.49777,0.265695,-0.0606949,-0.654121,0.51436,0.34204,-0.0922414,0.0421017,-0.189798,0.170111,-0.418258,-0.0387791,-0.32834,-0.0079007,0.240917,0.103947,-0.143137,0.0692961,0.375134,0.000953543,0.0768348,-0.908258,0.0778777,-0.0577063,0.0652602,0.385021,-0.23058,0.229974,0.408996,-0.0678839,0.307417,-0.340614,0.242317,0.0989564,0.0283338,-0.550572,-0.012362,-0.365527,-0.244837,-0.354342,0.120043,0.126944,0.25512,0.356292,0.505094,-1.91022 +3419.19,0.945571,0.0912059,4,1.61006,1.08847,0.16578,-0.286623,0.304359,-0.0543887,0.115121,0.184823,0.734759,0.252343,-0.246655,-0.287038,0.518919,0.471998,-0.489319,0.684988,0.190107,-0.0475859,-0.0198191,-0.375217,-0.163204,-1.3664,-0.596036,-0.132735,-0.317406,-0.125006,0.156016,0.423977,-0.546878,-0.376367,0.708244,0.106174,-0.133159,0.318032,0.283049,-0.207868,-0.94633,0.465754,0.442374,0.132486,0.771881,0.233137,0.131495,-0.0441862,-0.311189,-1.02617,-0.649585,-0.199854,0.488354,-0.127193,0.417786,0.634876,0.158757,-0.762791,1.28448,-0.414081,-0.101359,-0.792812,0.808047,0.0952335,-0.171289,0.994436,-0.597038,-1.04626,-0.666832,0.209476,0.0501314,0.0303188,0.637549,-0.478577,0.207474,0.0967311,0.179862,0.217189,0.522502,0.186832,0.469305,0.13532,-0.284377,-0.270594,0.575332,-0.436998,0.00172883,0.044296,0.318033,0.33328,-0.219967,-0.0914535,-0.0460394,-0.570459,-0.613997,0.536606,-0.172245,-0.115504,0.456501,-0.248689,-0.78821,0.211185,0.0722167,0.402139,-0.00700686,0.131195,-0.579544,0.266979,-0.0457157,-0.36909,0.829648,-0.173238,0.250901,0.272125,-0.31903,-0.420867,-0.314214,0.4142,-0.209356,-0.0884487,-0.25239,-0.564429,0.41686,-0.631271,-0.559675,-0.068528,0.129637,-0.115891,-0.0206556,0.12253,0.500293,0.0974812,-0.0659701,-0.525858,-0.282936,-0.164613,0.159259,0.429581,-0.114703,0.169836,-0.209993,0.0381393,-0.22378,0.152703,-0.217365,0.081664,0.110649,-0.275234,-0.0530795,0.0142184,0.557506,0.32569,-0.249542,-0.139873,0.80853,-0.219271,0.216469,-0.0801012,-0.0613805,0.382888,0.337578,0.037581,0.183617,-0.8499,0.437516,-0.274499,0.69247,-0.32472,-0.117547,-7.61901e-05,0.0262542,0.206473,-0.391939,-0.0459883,0.0216214,0.343707,0.0732258,0.261846,-0.189997,0.00292798,-0.596285,-0.452017,0.0783852,0.303266,-0.504445,-0.39419,-0.0524518,0.271256,-0.212882,-0.343727,-0.324748,-0.118428,0.0864885,-0.741576,-0.0211268,0.0467687,-0.22945,-0.448112,-0.0311196,0.386192,-0.122976,-0.760659,-0.747412,-0.398241,-0.0288215,-0.00647077,-0.0820311,-0.00351898,-0.780824,-0.327449,-0.323075,0.736224,-0.290381,0.0612656,-0.198964,-0.0603058,0.262972,0.4502,-0.247319,0.775695,-0.50311,0.40855,0.0612821,-0.743711,-0.0281553,0.27562,-0.167702,-0.00798857,0.0463546,0.375783,0.000124781,-0.357115,-0.725236,-0.0944415,0.154008,0.267302,0.146795,-0.0598849,-0.41109,0.393836,-0.178234,0.254052,0.637981,0.270097,-0.392877,0.0546806,-0.398618,0.434298,-0.225324,-0.230893,0.0948868,0.139855,-0.757269,-0.516424,0.84297,-0.340134,0.16301,-0.145757,0.006134,0.128647,-0.0372934,0.0411768,-0.0304989,0.113685,-0.440414,0.821093,0.0799708,0.0716258,0.177616,0.0254694,-0.176818,0.0843078,0.0964372,-0.30952,-0.34376,-0.232286,-0.286006,-0.145725,0.271996,-0.00961552,0.309588,-0.491536,-0.113885,-0.343225,0.182854,-0.633025,0.00578569,-0.710929,0.473282,0.392161,0.290068,-0.136185,0.228455,-0.712982,0.142195,0.013421,-0.154967,0.184052,-0.469157,-0.740923,0.215915,-0.260305,-0.667598,-0.102355,0.625152,0.115158,0.243792,0.33935,0.493753,-1.1264 +3419.96,0.995685,0.0912059,4,1.69805,1.01032,-0.0570333,-0.0990386,-0.00560845,-0.107645,0.0948533,-0.0854165,0.419564,-0.0509206,-0.391715,-0.266579,-0.135166,0.603085,-0.229094,1.20853,0.0392629,-0.451381,0.0441973,-0.139084,-0.474393,-0.498624,-0.461124,0.112334,-0.28407,-0.175071,0.131552,0.238092,-0.0702431,0.2237,0.857523,-0.0101345,0.0473398,0.16699,-0.688297,-0.0333656,-0.528548,0.411376,-0.547175,-0.882187,0.793025,0.844932,0.135455,-0.707893,-0.00628822,0.214102,-0.43609,-0.45818,0.376157,-0.307265,0.0199066,-0.451637,0.358313,0.248522,0.740212,-0.166687,-0.214225,-0.512255,0.650117,-0.582013,0.012285,0.587514,-0.586736,-0.891625,-0.108131,0.34242,0.131653,0.356018,-0.587346,-0.356505,0.606004,0.394207,0.403702,-0.0311821,0.356926,0.310637,0.150688,-0.530596,-0.423777,-0.0523273,0.298334,0.200271,0.339576,0.105075,-0.399022,-0.429479,-0.139922,-0.178661,0.258012,-0.518616,-0.079569,0.0215066,-0.219366,0.276032,-0.133211,-0.107672,-0.489088,-0.228116,0.12674,0.45422,-0.346303,-0.163062,-0.205932,-0.444866,-0.46512,-0.228958,0.0701186,0.0328585,0.444679,0.408731,0.21853,-0.736153,-0.0448531,0.681983,0.109507,0.0372706,-0.448486,0.0617502,-0.0105529,-0.140236,-0.621685,-0.139875,-0.312769,-0.123881,0.377504,-0.485295,-0.0441937,0.307369,0.317077,-0.564799,0.363889,-0.63681,-0.0237852,0.511416,-0.679581,0.183624,-0.0697572,0.22926,0.182311,-0.262994,-0.188739,-0.187433,0.0487605,-0.545181,-0.304701,0.152589,-0.222402,0.348705,-0.150215,-0.530765,-0.561213,0.0783034,-0.46543,0.0832855,0.759843,-0.0629861,0.161778,-0.262395,-0.0103726,-0.252011,-0.0178758,0.276113,0.566205,0.101247,-0.297511,0.714137,-0.0815581,-0.275164,-0.180389,0.416725,0.0119103,-0.574738,0.192314,-0.641779,-0.0705399,-0.361542,-0.386949,-0.0775316,0.72738,0.847687,0.151479,0.501566,0.0728981,-0.456221,0.0681536,-0.309916,0.0526487,-0.303778,0.184988,0.0813753,-0.713536,0.332749,-0.162723,-0.642063,0.132909,-0.10026,0.184175,-0.264701,-0.745796,-0.179465,-0.0658625,0.0553641,0.185668,-0.178842,0.287925,-0.0972133,0.0126223,0.665733,0.125428,-0.274559,-0.332662,0.225502,0.244667,0.0741674,0.0725362,0.392471,-0.382497,0.150287,-0.105222,-0.21913,-0.0631658,-0.752899,0.706641,0.0262833,-0.0972857,0.279439,-0.355392,-0.207557,-0.402517,-0.0298127,-0.015033,0.187321,0.0558519,0.350501,-0.0751846,-0.0482579,-0.113854,-0.319143,0.386751,-0.303324,-0.475734,0.156279,0.492979,-0.0488034,0.345111,0.108151,0.776838,-0.0787207,-0.288733,-0.423998,-0.280966,-0.509673,0.124029,-0.247682,-0.555874,0.649937,-0.547282,-0.565218,-0.0354604,-0.0681421,0.60745,-0.208883,0.215752,-0.0818486,0.664621,-0.0464884,-0.378239,-0.0939584,-0.147162,-0.107775,0.0264056,-0.445482,-0.371688,0.0262359,-0.855373,-0.207617,-0.0751164,-0.05043,-0.0644139,-0.386827,-0.290338,-0.0390255,-0.497738,1.02644,-0.257664,0.161759,-0.373713,-0.320389,-0.132727,0.0538214,0.201929,0.132417,-0.00607832,0.321941,-0.445502,-0.0367314,0.481442,-0.184008,0.0580216,0.184061,-0.114505,0.129591,0.188562,0.359988,0.434238,0.081268 +3434.82,0.912085,0.0912059,4,1.63412,1.068,-0.266046,-0.0205953,0.306188,-0.0953387,-0.0832829,0.102174,0.173418,0.759723,-0.431412,-0.353675,0.134383,0.244949,-0.388389,0.521096,0.238278,-0.0873749,-0.0770985,-0.279059,-0.312874,-1.01163,-0.994335,0.117113,-0.368373,0.114915,0.265227,0.189669,-0.461791,-0.389301,0.438319,-0.0401936,0.345241,0.196519,-0.397602,-0.157648,-0.351921,0.155486,0.903509,0.0300305,0.808837,0.104075,-0.315336,-0.755371,0.000767155,-0.608658,-0.704432,0.328204,0.0893215,-0.375096,0.175674,0.692708,-0.111232,-0.963883,0.902062,-0.341892,-0.280335,-0.426135,0.31383,-0.239697,-0.512406,0.600699,-0.579142,-1.13004,-0.416065,0.352367,-0.228821,0.0510318,0.418535,0.374332,0.13441,0.22309,0.311406,0.199157,0.52384,0.015264,0.0828355,0.354761,-0.0373115,-0.0924009,0.250584,-0.497794,-0.16028,-0.256692,-0.291542,-0.0728194,-0.124447,-0.0171426,-0.272528,-0.0464898,-0.0918971,-0.474094,0.197181,-0.0578236,0.456809,-0.346711,0.546654,-0.847514,-0.1523,0.146185,0.0984742,0.191295,-0.213725,-0.441329,0.2732,-0.399491,0.536763,-0.222948,0.20391,0.366965,-0.464478,0.209622,0.17526,0.339272,-0.385753,0.341274,-0.441413,-0.392996,0.554084,0.225685,-0.655133,-0.1266,0.484404,0.269241,-0.471994,0.0414789,0.64619,-0.350711,0.376439,-0.164183,0.0168133,0.00915537,0.190826,0.367167,-0.187114,0.302193,0.223858,-0.0647915,0.125618,-0.585447,0.29527,-0.123286,-0.0578207,-0.158118,-0.255719,0.348024,-0.154526,0.262999,-0.138947,0.256445,0.11441,0.035156,0.5383,-0.446174,-0.475894,0.38818,-0.101451,-0.0528219,0.0517949,0.115047,0.181565,-0.183673,0.0162407,-0.038604,-0.063129,-0.304767,0.1006,0.59436,-0.0802868,-0.0231906,0.0287707,0.0670578,-0.089297,0.219063,-0.355437,-0.414114,-0.111422,-0.201038,0.355049,0.861235,-0.0414162,0.138624,0.219859,-0.00624652,0.626059,-0.515042,0.0853864,0.0553863,0.146934,-0.338973,0.117115,0.415678,0.214172,-0.616188,0.182708,0.197224,-0.00378489,-0.119547,-0.432669,-0.142864,-0.283964,0.146057,0.183183,0.359775,-0.487405,-0.0888609,-0.368152,1.07422,-0.378124,0.33736,-0.625318,-0.0901171,-0.255241,-0.0829312,-0.320046,0.221312,-0.52048,0.492855,0.107867,-0.466975,-0.113371,-0.216831,0.131181,-0.0377392,-0.201655,0.776122,-0.0884449,-0.0468309,0.00828065,-0.0480157,-0.735675,0.130137,-0.306239,-0.732785,-0.281895,0.165375,0.382255,0.347738,0.497316,-0.233115,0.360225,-0.495222,0.165363,-0.0199698,0.554717,0.0870636,0.197508,-0.043839,0.176236,-0.339598,0.285779,-0.374268,-0.0366825,0.0241118,-0.300079,0.272198,-0.396243,0.0275383,0.31283,-0.128973,-0.0114364,0.318862,-0.1344,0.630471,0.236776,0.39209,0.330471,0.0376787,0.238614,-0.11391,0.0682091,-0.173859,-0.278729,0.169362,0.358318,-0.348509,0.375808,0.126321,0.4562,0.477182,0.0236319,0.0502919,-0.211333,-0.861996,0.435005,0.63515,0.0884823,0.132489,-0.0420448,-0.178966,-0.0531366,0.321873,0.128995,-0.260779,-0.296274,-0.573322,-0.0126476,0.484456,-0.447857,-0.00444926,0.565337,0.101538,0.192381,0.318651,0.438613,-1.08738 +3437.79,0.840368,0.0912059,4,1.65998,1.09634,-0.245068,0.0693068,-0.0291653,-0.123496,-0.336548,0.368826,0.46016,0.446578,-0.601975,-0.0850055,0.274946,0.462914,-0.41329,1.29326,0.260323,-0.0419617,-0.417812,0.0470787,-0.33635,-0.796515,-0.733872,0.176448,-0.0426686,-0.215623,0.0942116,0.0581037,-0.475352,-0.212497,0.442837,0.216531,0.402087,0.18489,-0.608527,0.223668,-0.159461,0.143883,0.307883,0.313052,0.56466,0.301484,-0.354151,-0.879861,0.0941542,-0.819644,-0.598799,0.376915,0.402996,-0.562656,0.119955,0.592961,0.178111,-1.04205,0.427793,-0.414034,-0.421367,-0.648012,0.473046,-0.718272,-0.282261,0.414314,-0.588078,-0.769722,-0.579788,0.613393,0.228777,0.251778,0.172454,0.185184,-0.136755,0.392411,0.589017,0.262731,0.606544,0.471656,-0.108576,0.23656,-0.0604197,-0.182593,0.567373,-0.199862,-0.0846698,-0.31212,-0.55834,0.287841,-0.180432,0.237133,0.105354,0.095249,0.457615,-0.250722,0.0460692,-0.0619221,0.229921,0.151194,0.0731655,-0.825398,-0.527849,0.179378,-0.331424,-0.355024,-0.0507089,-0.29296,0.124271,-0.235369,0.205811,-0.252419,0.222122,0.251928,-0.210971,0.21663,0.567449,0.285313,0.0977506,0.35751,-0.220933,-0.145136,0.664679,0.264083,-0.492293,-0.427491,-0.0557704,0.074922,-0.702762,-0.242907,0.55717,0.039716,0.622627,-0.167992,0.271765,0.030382,0.214294,0.0816761,0.0254955,-0.194232,0.277882,0.147511,0.140032,-0.339478,0.524084,-0.242097,0.405534,-0.129084,0.0633281,0.158719,-0.138413,0.378162,-0.164263,-0.0976098,-0.430093,0.282664,0.219574,-0.187093,-0.202655,-0.291188,-0.0572764,-0.159842,0.146092,0.203321,-0.0372115,0.26886,0.187703,-0.740643,0.0857089,0.158256,-0.0505649,0.0018543,-0.296857,0.171942,0.0918526,-0.0618475,-0.106313,0.37364,-0.564439,-0.0422985,-0.354438,-0.277942,0.620545,0.896142,0.00237176,0.292208,0.35508,0.0422309,0.361897,-0.237809,-0.141255,0.144523,0.173531,-0.0436435,0.159377,0.332371,0.145489,-0.438382,0.081508,0.125785,0.0991445,-0.16884,-0.416686,-0.461791,-0.0593025,-0.0969018,0.315929,0.200392,-0.170767,-0.077826,-0.517292,1.16502,0.0424561,0.239576,-0.382287,0.225123,-0.179562,-0.462386,-0.250419,-0.134447,-0.338935,0.492001,0.198038,-0.168859,0.180317,-0.371159,0.155783,0.0147536,-0.210978,0.438861,-0.211859,-0.44614,0.153513,0.0227822,-0.481712,0.0278282,-0.125438,-0.489789,-0.380899,0.0806632,0.361666,0.264599,0.521605,0.115129,0.116225,-0.362764,0.634137,0.0311302,0.403018,0.281518,0.244626,0.190883,0.0895566,-0.338327,0.328187,-0.406575,-0.102379,0.108253,0.272094,0.251405,-0.315605,-0.426659,0.200614,-0.00849916,0.369904,0.224163,0.148236,0.358578,-0.0170656,0.344787,-0.0442056,0.212664,-0.195399,0.0572978,-0.144454,-0.269601,-0.00205375,-0.0302275,0.221044,-0.0809568,0.480386,-0.199372,0.200866,0.130225,0.126071,0.165517,-0.122596,-0.690564,-0.0462868,0.416042,0.208787,0.545553,-0.293626,0.461751,0.0145372,0.221456,0.425058,-0.076321,-0.264085,-0.802528,0.107957,0.461705,-0.437516,0.57067,0.0517765,0.107452,0.173753,0.327799,0.416837,-0.0875691 +3440.62,0.668666,0.0912059,4,1.61061,1.03436,-0.382895,0.0263521,0.460623,-0.277619,0.44696,-0.098074,0.0750691,0.150293,0.156546,-0.0804363,-0.206057,0.279148,-0.360821,0.40472,0.0584114,-0.237966,0.257957,-0.180634,-0.445466,-0.819442,-0.53433,0.0122813,-0.483676,-0.413031,0.249661,0.729294,0.0801547,0.323786,0.575487,-0.825841,-0.317899,0.269466,-0.344019,-0.213387,-0.407978,0.271025,0.0563459,-0.550014,0.784278,0.473221,0.264739,-0.332842,-0.112625,0.337497,-0.850077,-0.355432,0.252172,0.285118,-0.265373,-0.416179,-0.283578,0.0241411,1.08074,-0.360755,-0.311095,-0.577899,0.630516,-0.0642651,0.324763,0.893697,-0.827269,-1.24872,0.388843,-0.255495,-0.461027,-0.304571,0.120361,-0.767746,-0.41236,-0.0698422,0.412882,0.0161297,0.277125,0.13128,0.597638,-0.490296,-0.380217,-0.226202,0.191032,-0.511343,0.0611977,0.224168,-0.156131,-0.511542,-0.0143977,-0.31499,0.189629,-0.422623,-0.749739,0.215287,-0.244949,0.0783562,-0.374929,-0.507311,0.0206597,0.127774,0.4402,0.484306,-0.0991398,0.0729584,-0.481752,-0.120642,0.300039,-0.231314,0.164264,0.0369522,0.125721,0.470131,0.126767,-0.219337,-0.326427,0.237581,-0.264239,0.0942117,-0.206289,-0.10376,-0.319952,-0.311974,-0.71275,0.053627,-0.156006,-0.0136677,0.400787,0.275763,0.0170614,0.046959,-0.260327,-0.540889,-0.252641,-0.00435342,0.402173,0.683753,-0.378287,0.0146864,-0.212396,-0.520603,0.107125,-1.05067,-0.690883,-0.181127,-0.0498693,0.186352,-0.220107,-0.0561082,-0.154136,-0.0606585,0.0718505,-0.215366,0.166525,-0.198968,0.248606,-0.166765,0.222583,0.713156,0.443879,-0.657384,0.157859,-0.277952,0.509467,-0.0989795,0.366445,0.460813,-0.0798667,-0.0860332,0.192002,-0.0134588,0.216978,-0.1661,0.00265779,0.411038,-0.258934,-0.30846,0.246269,-0.149834,-0.199416,0.266697,-0.37577,0.497309,-0.0493222,0.267853,-0.365863,-0.0920156,-0.258507,0.0369466,-0.350073,-0.301692,-0.0739442,-0.385125,-0.237868,0.129605,-0.288874,-0.576817,-0.0206947,0.317684,-0.0297561,-0.19845,-0.160942,-0.0923544,-0.357304,-0.218921,0.304849,-0.12035,0.330016,0.00915702,-0.13461,0.763541,-0.0833512,-0.0257034,0.0962666,-0.646455,0.0136658,-0.0788053,0.205884,0.302996,-0.163446,-0.146042,0.307619,0.0342196,-0.121897,-0.4718,0.469504,0.124587,-0.0564201,0.389835,-0.388533,0.0514164,0.0106146,0.222178,0.214929,-0.328611,0.146059,0.403136,-0.00606465,0.38642,-0.311246,-0.444012,0.49899,-0.228051,-0.367974,0.539595,0.0161607,0.156856,0.336776,0.175359,0.617743,0.073863,-0.398754,0.0453415,-0.086573,-0.357094,0.530966,-0.0124998,-0.402362,0.398264,0.221159,-0.0187043,0.344463,-0.161007,-0.0156007,0.568228,0.01582,-0.144932,0.203816,-0.295877,0.327762,-0.37401,0.652895,0.00873885,0.075853,-0.124296,-0.535188,0.350526,0.0787088,-0.433787,0.142412,-0.0193584,0.280543,0.234564,-0.481579,-0.19368,0.122452,0.616995,0.398834,0.143824,-0.158311,0.0160037,0.698811,-0.267708,0.0332686,0.00324953,-0.119927,0.20852,-0.2084,-0.251384,0.194349,0.0432219,0.424353,-1.03304,0.163378,0.106146,0.244737,0.3258,0.494709,-1.50167 +3424.81,0.760556,0.0912059,4,1.57741,0.788969,-1.02698,0.421459,0.40728,-0.164201,0.471815,0.191955,0.479985,0.575097,-0.0475605,-0.0878933,0.4441,0.272353,-0.513051,0.97441,-0.0393819,-0.122354,0.17888,0.0657567,-0.397629,-0.66991,-1.02254,0.462001,-0.155372,-0.473189,0.38766,0.532451,-0.106955,-0.024925,0.989369,-0.539421,0.0435228,0.566078,-0.325349,0.0547888,-0.184738,0.0982858,0.148824,-0.340979,1.15626,0.380324,0.415917,-0.787418,0.28513,-0.57359,-0.190798,0.161394,0.46297,0.0789668,-0.0719717,-0.272365,0.332398,-0.296549,0.729518,0.267559,-0.174399,-0.758749,0.249346,-0.245944,0.350068,0.825623,-1.14853,-0.984656,-0.10119,-0.330029,0.0352709,0.206107,-0.11031,-0.154009,-0.18162,-0.316961,0.677587,-0.0439198,0.849151,0.665371,0.181055,0.374813,-0.165847,0.612041,0.360663,-0.261882,-0.194424,0.0652844,0.0783919,-0.111842,-0.671714,0.231336,-0.140326,-0.179476,-0.305004,-0.162521,-0.431033,0.0293245,-0.0868941,-0.185912,-0.121503,0.215288,0.386729,-0.12379,0.0373508,0.227669,0.0344033,-0.288126,0.441859,-0.293915,0.222964,-0.532047,0.133072,0.419411,0.20972,0.107441,0.46448,0.190915,-0.258046,0.183764,-0.448762,0.333547,-0.077395,0.0962611,-0.774201,0.387299,-0.0703534,-1.20531,-0.748815,0.0593512,0.395014,0.272799,0.0315889,0.205974,-0.444393,-0.144746,-0.207957,0.431648,0.202657,0.523565,-0.542205,0.341689,0.584156,-0.819762,0.0646734,-0.365973,0.0654944,-0.0273507,0.135046,0.243845,-0.801579,0.264946,-0.3625,0.0450896,-0.659589,-0.124649,0.683597,0.0609664,0.381643,0.427223,0.106535,0.097913,-0.0622298,0.0209239,-0.102315,-0.151274,0.660145,0.0227015,0.461606,-0.267573,-0.0313478,-0.37659,-0.144098,0.461068,0.56306,0.233364,-0.202544,-0.0359227,0.083212,-0.107561,-0.329559,-0.21465,0.447541,0.804716,0.356822,-0.18625,0.606261,-0.286823,-0.13495,0.0101773,-0.112033,0.222703,0.169603,-0.318222,0.0658744,0.478613,0.050258,-0.0738272,0.224779,-0.265587,-0.299208,0.339483,-0.355528,0.275824,-0.207012,0.255188,0.353378,-0.425087,-0.387887,-0.526971,-0.373987,0.934078,0.954533,0.233903,0.128794,-0.114831,0.190588,0.426477,-0.0414415,-0.107584,0.265427,0.140062,0.275949,-0.610448,0.163621,-0.723021,-0.238934,0.280186,0.174126,0.190804,-0.410803,0.0359731,-0.220299,-0.0937631,-0.184101,0.121454,-0.524689,-0.32607,-0.0691072,0.227684,-0.0560022,-0.400708,0.38476,-0.295739,-0.230104,0.0221095,-0.100438,0.050205,0.270222,0.221912,0.320046,0.102712,-0.351748,-0.336508,0.189842,0.00757684,0.110904,-0.347063,-0.173604,0.355396,-0.163116,-0.0922507,0.00251314,-0.0708827,-0.244336,0.483383,-0.0350475,0.183471,0.203838,0.47523,-0.373045,0.00331974,-0.00641532,-0.0733717,0.330433,0.0816079,0.421459,0.0525432,-0.17413,-0.0291006,0.0575675,-0.14507,-0.194822,0.287501,-0.0733746,-0.136814,0.243591,-0.329947,0.0426268,-0.366068,0.0482398,0.0902346,-0.303631,0.176431,-0.0427221,-0.378807,0.166058,0.167565,-0.0295006,-0.414522,-0.0326766,0.36189,0.196778,-0.321369,-0.0474687,0.131704,0.296101,0.36291,0.544152,-0.988588 +3450.44,1,0.0912059,4,1.6098,0.992621,-0.562263,0.134421,0.578842,-0.0770175,0.301482,0.0411394,0.34437,0.52894,-0.0550971,-0.220849,0.332684,0.350248,-0.10302,0.883271,0.0596742,0.0605478,-0.0133541,-0.222434,-0.453219,-0.727292,-1.36791,0.118276,0.0690057,-0.0537743,0.0210496,0.650438,-0.656692,0.0320906,0.815084,-0.481685,-0.447239,0.211079,-0.500155,-0.135258,-0.797541,0.442189,0.893588,-0.643669,0.891255,0.363484,0.686259,-0.451844,-0.215463,0.104746,-1.09956,0.285292,0.525206,-0.0137001,0.0427223,0.636613,-0.397113,-0.945631,0.793878,-0.00211777,-0.362385,-1.33576,0.506909,-0.396138,-0.112893,0.915242,-0.85008,-1.40105,0.187065,0.000338458,0.116309,0.237748,-0.740487,-0.24194,-0.537237,-0.128017,0.256361,-0.259741,0.23216,0.241616,0.260744,-0.213866,-0.322458,0.0827069,0.73047,0.276252,0.0877494,-0.358609,0.0555992,-0.0934704,0.177494,-0.318966,0.410869,-0.439463,-0.00940966,0.0104316,-0.0732699,-0.144628,-0.0082214,0.145949,0.473676,-0.240737,0.261125,0.206664,0.502663,-0.379426,-0.478711,-0.0601774,0.5234,-0.162806,-0.366326,-0.683268,0.67027,0.136112,0.361313,-0.166043,-0.0933705,0.397098,-0.0630486,0.087828,-0.113483,0.2705,-0.151194,-0.0507634,-0.371376,-0.491334,-0.270174,-0.33825,0.04301,0.119764,0.637718,-0.186258,0.506518,-0.559845,-0.0904663,-0.432931,0.258771,0.0729962,-0.378946,-0.115039,0.0458693,-0.126625,0.29663,-0.769236,-0.106118,-0.222477,-0.0661713,0.0721574,-0.0130706,0.0297813,0.494861,0.588722,-0.191712,-0.675936,0.113774,0.173396,0.265815,-0.315118,0.413263,0.123492,0.339983,0.0133882,-0.11326,0.263557,-0.199681,-0.354777,0.298777,-0.167854,0.405891,0.438844,-0.0154694,0.353055,-0.116427,0.0508107,0.17034,0.153017,-0.0314862,-0.550896,0.291798,0.0511811,-0.117461,0.332324,0.308723,0.668177,0.052896,-0.0667616,-0.033635,-0.0840405,0.0389985,-0.305323,-0.79252,-0.776923,-0.1985,-0.59066,-0.256837,-0.385211,-0.230667,-0.215729,-0.0681396,0.25768,0.033142,-0.621144,-0.750758,-0.294509,-0.337287,-0.158503,-0.137594,0.297054,0.0456317,0.246207,-0.389098,0.778792,-0.178484,0.475874,-0.00981655,0.0786078,-0.167345,-0.370516,0.161408,-0.206522,0.0767394,0.0252777,0.509282,-0.307875,-0.0573416,-0.13731,-0.0683461,0.0635788,-0.675805,0.143519,-0.272127,-0.386287,-0.3743,0.37357,-0.383609,-0.175243,-0.092336,-0.252264,-0.554123,0.525376,-0.112173,-0.147951,0.439273,-0.295838,-0.0045,-0.0494712,0.307893,0.0661998,0.293565,-0.00873768,0.214598,-0.188865,-0.214281,-0.431893,-0.326444,-0.618463,0.635499,-0.441534,-0.0118612,0.181633,0.202784,-0.130419,0.366418,0.0172785,-0.586081,0.308518,0.0378894,0.355928,0.333078,-0.0625653,-0.0563029,0.16461,0.102777,0.263822,-0.0963087,-0.218752,-0.769433,0.036115,0.251781,0.27998,0.1964,0.00382679,-0.242774,0.0311347,-0.18454,0.145295,-0.406034,-0.22978,-0.0918309,0.160481,0.392645,0.532738,0.383707,-0.186662,-0.0179055,0.175616,0.118473,0.0355323,-0.211468,-0.288972,-0.426626,-0.448067,0.222053,0.108158,0.306021,0.0971382,0.372209,0.31167,0.610089,-1.87954 +3456.77,0.585394,0.0912059,4,1.63516,0.996142,-0.916518,0.20766,0.502585,-0.130952,0.061815,0.248984,0.214384,0.10554,-0.304947,-0.0675115,0.374999,0.411333,0.286575,1.16885,-0.104039,-0.13114,-0.270106,-0.241758,-0.421673,-1.03739,-0.867292,0.115683,0.115402,-0.290019,0.032276,0.657658,-0.680574,-0.0694017,0.686882,-0.118367,-0.129598,-0.0283486,-0.22978,-0.30221,-0.747746,0.624885,0.614034,-0.104492,0.962547,0.189081,0.400342,-0.316242,0.0638361,-0.398878,-0.177597,0.266335,0.714171,-0.19706,0.157138,0.579866,-0.255012,-0.829253,0.775085,0.0812935,0.0559128,-1.30822,0.237176,-0.51421,0.461044,0.896786,-0.270093,-1.79834,0.507648,0.255002,0.241014,0.0895059,-0.225682,-0.159022,0.0774425,0.163792,0.442949,-0.138945,0.144353,0.0154838,0.449336,-0.265897,-0.469453,-0.355637,0.184599,-0.053323,0.0191681,-0.467789,-0.03905,-0.215981,-0.133518,0.282662,0.0146339,-0.151308,-0.16494,0.249002,-0.0681021,0.056873,-0.394902,0.18745,0.666708,-0.144863,0.162168,0.308038,-0.150937,0.204002,-0.215128,-0.616683,0.561149,-0.258831,-0.236402,-0.409384,0.531936,0.565902,0.349409,0.362819,0.207966,0.184319,-0.0503795,0.317257,0.359351,0.0617293,-0.0903189,-0.140192,-0.676187,0.0150324,-0.707866,-0.380831,-0.143121,-0.187882,0.46981,-0.333424,0.445996,-0.282235,-0.553068,-0.0868789,0.107013,0.00693939,-0.38178,0.150981,0.116808,-0.258873,0.427227,-0.392801,-0.289412,-0.185173,-0.61572,-0.123044,0.0177218,-0.206464,0.431514,0.431074,-0.330717,-0.153491,-0.263789,-0.0922518,0.269022,-0.324566,0.703814,0.0853293,-0.0189917,0.113918,-0.148847,-0.1685,0.359825,-0.324843,0.689914,0.104404,0.322348,-0.249563,-0.147525,0.0318426,-0.396353,-0.0609443,0.458415,-0.178874,-0.216094,-0.326242,0.196148,-0.0458112,-0.256053,0.107627,0.276498,0.529943,0.327707,0.0371378,-0.143123,-0.0192304,-0.182249,-0.149455,-0.361482,-0.40675,-0.0672925,-0.775032,-0.243037,-0.469134,0.114096,-0.427257,-0.28536,0.223789,-0.0535936,-0.195932,-0.545806,0.0397323,-0.141754,-0.315074,0.00596523,-0.098399,-0.0410129,-0.0153897,-0.441877,0.615689,-0.488139,0.714321,-0.0652224,0.0853661,-0.0192,-0.184334,-0.239465,0.0336768,-0.220684,0.311964,-0.123221,-0.262322,0.1311,-0.607428,-0.0848311,0.077585,-0.192344,-0.0747674,0.121983,-0.190622,-0.205864,0.461028,-0.139027,-0.104472,0.148329,-0.627613,-0.467112,0.366839,0.421461,0.384404,0.651114,-0.189113,0.0129433,0.147298,0.201554,-0.265676,-0.111156,-0.364639,0.689905,-0.051,0.0168105,-0.388839,-0.476341,-0.0983412,0.422761,-0.293208,-0.334879,0.181985,0.159214,0.209972,0.288681,-0.0976293,0.11698,0.498809,-0.460187,0.092395,0.354575,0.0461601,-0.0846742,0.163854,0.137578,-0.289993,-0.314331,-0.136272,-0.371978,0.0430316,0.0684196,0.121798,-0.0958239,0.18977,0.0457349,0.267785,0.173326,0.180365,-0.533942,-0.0284028,0.0651831,0.190707,-0.0327494,0.214019,0.2898,-0.466936,-0.199802,0.52005,-0.0149431,0.00728552,0.253705,-0.345128,-0.299985,-0.0377474,0.195053,0.0637432,0.233048,0.0892744,0.381533,0.298788,0.617683,-1.47709 +3441.95,0.998753,0.0912059,4,1.58269,1.11931,-0.536637,0.144643,0.746514,-0.0477742,-0.0498728,0.269129,0.76632,0.310748,-0.0679545,-0.444345,-0.261487,0.112328,-0.830147,0.729056,-0.0206014,0.130956,0.354924,-0.292738,-0.53716,-0.889521,-0.838801,-0.491031,-0.233813,-0.432549,0.406197,0.64204,-0.44491,-0.313182,0.755223,-0.72905,0.117036,0.218711,-0.44134,-0.172695,-0.790249,0.331064,0.871903,-0.37549,0.976986,0.630493,0.318649,-0.890642,0.316522,-0.0175691,-0.493586,-0.273786,0.173549,-0.191135,-0.22087,0.90547,-0.129644,-0.140833,0.796205,-0.278142,0.225637,-0.81162,0.533532,-0.598619,0.0618035,0.702956,-0.690599,-1.23668,-0.327943,0.101651,-0.493403,0.391013,0.443443,-0.244455,0.0686978,0.0451726,0.444922,0.0666254,0.509518,0.42754,-0.298716,-0.104663,-0.029841,0.412824,0.542761,-0.105935,0.393202,0.0185643,-0.0717967,-0.179635,-0.295378,-0.545626,0.35087,-0.831097,0.207808,0.0210441,-0.0297884,0.312913,0.541349,-0.0596274,-0.555926,-0.192701,0.10699,0.253432,-0.319351,-0.164834,-0.436894,0.144771,-0.106174,-0.448396,0.495387,-0.106355,0.281231,0.213367,-0.382677,0.219467,0.176963,0.259701,0.201483,-0.583976,-0.537331,0.0937678,0.237194,-0.115018,-0.182614,-0.121263,0.255576,-0.42974,-0.033117,0.153503,-0.181335,0.350259,0.222984,-0.393468,0.14636,-0.0708652,-0.0489203,0.889939,-0.0837328,-0.163692,-0.096903,-0.0288979,0.219471,-0.386632,-0.262044,0.241739,0.503691,-0.149266,0.0285732,0.431943,0.217982,0.269933,-0.290341,0.0217142,0.140821,0.262007,0.337191,0.315297,0.220737,0.573479,0.133966,-0.227257,0.250314,0.0125442,-0.0826382,0.269642,-0.0381324,-0.12517,-0.689786,0.623326,-0.0198819,0.00868713,0.0494536,-0.202952,0.213205,-0.447072,-0.176248,-0.168249,-0.456299,-0.10862,-0.00666625,0.19657,-0.238857,1.01363,0.0134991,0.164208,0.368648,-0.273214,0.126199,-0.624732,0.102086,-0.176575,0.429954,0.430065,-0.0495442,0.429052,-0.249645,-0.512493,-0.0386307,0.184678,-0.369068,-0.108845,-0.0830188,0.243452,0.176716,-0.419542,0.368837,-0.409969,-0.27916,0.279447,0.325245,0.659436,-0.0103046,-0.0907624,0.146444,-0.0376545,0.248739,0.448573,0.195929,0.0623473,-0.156812,-0.0962752,0.8311,-0.231919,0.159293,-0.0663369,-0.441263,0.200611,-0.157762,0.632976,-0.0315299,-0.195569,0.298198,0.0396047,0.134401,-0.159227,-0.59474,0.0126942,0.238568,0.49926,-0.0734711,-0.289,0.485916,-0.162485,-0.119325,0.0498077,-0.226644,0.0941309,0.380432,0.240129,0.0846445,-0.309417,-0.182747,-0.489754,0.282404,-0.602793,0.0235916,-0.0827842,-0.205291,0.178954,-0.530937,-0.412824,0.13326,0.321995,-0.085462,0.398596,0.434193,0.0452145,-0.194437,0.559206,-0.303163,0.0425736,-0.166231,0.131679,0.331576,-0.0106905,0.335497,0.174599,-0.317457,-0.128245,0.0432937,0.101509,-0.160091,-0.372573,-0.591984,-0.130891,0.487113,0.252324,0.0960792,0.431513,-0.259002,-0.436913,0.111715,0.508684,-0.0571091,-0.615322,-0.531763,0.821583,-0.0909415,-0.326825,-0.0245495,0.0405577,-0.306372,-0.210229,-0.118679,0.113437,0.265804,0.336805,0.515562,-2.71774 +3431.48,0.994615,0.0912059,4,1.56137,1.13515,-0.614931,0.123605,0.805556,-0.0383026,-0.00847977,0.321562,0.652762,0.384056,-0.0157652,-0.415707,-0.286922,0.145823,-0.793335,0.666337,0.0269463,0.0770979,0.263022,-0.360327,-0.437435,-0.881467,-0.910637,-0.494649,-0.27088,-0.424706,0.498677,0.722062,-0.377679,-0.299828,0.650262,-0.828619,0.161993,0.211423,-0.463262,-0.248658,-0.712917,0.471805,0.903941,-0.356235,0.947095,0.546214,0.342986,-0.927258,0.225715,0.166171,-0.42671,-0.240564,0.177861,-0.165074,-0.109933,0.845968,-0.114721,-0.141976,0.799337,-0.304738,0.252023,-0.816352,0.325335,-0.507715,0.214702,0.573039,-0.616606,-1.17227,-0.280153,-0.0641572,-0.559604,0.240782,0.338002,-0.198678,0.0265139,-0.0532049,0.555967,0.0460956,0.618765,0.446171,-0.278382,-0.182904,0.100592,0.3843,0.523495,-0.0848625,0.382189,0.00891906,-0.0419601,-0.238394,-0.245885,-0.423555,0.466539,-0.903388,0.160276,-0.0625377,-0.0172724,0.300681,0.395424,-0.00689866,-0.667877,-0.112582,0.144391,0.276659,-0.234169,-0.148061,-0.410675,0.213399,-0.0495367,-0.358283,0.453719,-0.0547084,0.285661,0.194642,-0.355606,0.150777,0.230746,0.209838,0.13242,-0.460875,-0.479164,0.155261,0.338218,-0.0582797,-0.102416,-0.211687,0.435228,-0.425941,-0.0276361,0.305192,-0.158224,0.345871,0.248095,-0.249697,0.16963,-0.0257801,-0.0745817,0.935624,-0.0374524,-0.140093,-0.233165,-0.0691378,0.20403,-0.512657,-0.0811306,0.199746,0.373627,-0.144665,0.123275,0.41896,0.255537,0.338833,-0.269093,-0.147187,0.140991,0.232045,0.242402,0.347264,0.111885,0.597379,-0.0352536,-0.21702,0.248257,-0.108325,0.0379205,0.44119,-0.0900415,-0.338508,-0.527608,0.519021,0.0125373,-0.0272231,0.107752,-0.297033,0.244839,-0.576119,-0.147198,-0.142102,-0.453939,-0.0296708,-0.0103662,0.1572,-0.176894,1.07739,-0.0477748,0.131506,0.277658,-0.253062,0.0534025,-0.559983,-0.0729653,-0.191179,0.388637,0.485937,-0.0547755,0.41721,-0.358758,-0.510084,-0.0633546,0.207239,-0.442884,-0.113163,-0.212931,0.190504,0.168901,-0.489352,0.298101,-0.260609,-0.312858,0.253,0.49044,0.652881,0.0904624,0.0205113,0.168239,-0.161292,0.415611,0.424451,0.207648,-0.00605613,-0.176128,-0.0675159,0.868348,-0.292987,0.21304,-0.0229873,-0.539719,0.156302,-0.169397,0.682173,-0.0445177,-0.20192,0.420201,-0.0266332,0.175405,-0.173603,-0.672024,0.181058,0.141682,0.407627,-0.15454,-0.293945,0.33927,-0.171783,-0.205453,0.133282,-0.185931,0.169359,0.421533,0.273492,0.0847822,-0.402195,-0.106903,-0.483248,0.309789,-0.695378,-0.0588582,-0.0645703,-0.228739,0.113025,-0.590979,-0.340842,0.304745,0.338261,0.0261607,0.310634,0.378839,0.139382,-0.193036,0.435108,-0.366632,-0.0866078,-0.15792,0.113082,0.404455,0.0638151,0.467419,0.253834,-0.582423,-0.137371,0.0119042,0.167082,-0.229118,-0.278223,-0.60612,-0.186166,0.553903,0.19886,0.0263752,0.458452,-0.219184,-0.302955,0.207362,0.51978,0.0278204,-0.634951,-0.522806,0.82909,-0.0181488,-0.384197,0.135513,0.0415371,-0.286606,-0.192768,-0.0514395,0.105058,0.276941,0.324127,0.526252,-2.90434 +3439.96,0.802671,0.0912059,4,1.61398,0.962437,-1.48822,0.500386,0.594833,0.00013954,-0.168477,-0.3977,0.315518,-0.26822,-0.291012,-0.141471,-0.287942,0.167365,-0.0790091,0.728329,0.0746577,-0.168803,-0.357652,-0.102703,-0.309366,-1.29304,-0.766686,-0.111028,-0.0012914,-0.0393406,-0.542206,-0.0974573,-0.74742,0.158088,0.611644,-0.0150162,-0.278806,-0.0368744,-0.0425215,-0.435412,-0.598036,0.810676,0.943531,-0.563701,1.18163,0.413858,0.531683,-0.341209,-0.214064,-0.00909107,-0.370895,0.411459,0.155747,0.103727,-0.106757,0.428175,0.213918,-0.589803,0.406294,-0.0235706,-0.0442851,-1.19159,0.301586,-0.494812,0.958718,1.18689,0.0995963,-0.746071,0.414125,0.521142,-0.0871373,-0.139072,0.0187678,-0.410774,-0.0327516,0.28262,0.285148,-0.047959,0.419734,0.208893,0.261528,0.131916,-0.302268,-0.352433,0.517351,-0.407534,0.082198,-0.617981,0.0641736,0.164576,0.136822,-0.125365,0.0154982,-0.235574,-0.167871,0.0674212,0.230518,-0.429426,-0.029469,0.12924,0.474886,-0.921345,-0.163613,-0.188223,0.518963,0.278627,-0.228289,-0.397606,0.412577,-0.215981,0.0770039,-0.450137,0.224352,0.535071,0.0409268,-0.218877,0.133857,0.171366,0.368929,0.09528,0.0185715,0.11237,-0.151147,-0.624784,-0.875607,-0.0332637,-0.615666,-0.550788,0.320005,-0.0733575,0.064457,-0.197735,0.0982685,-0.280119,0.090456,-0.186529,-0.251729,0.324439,-0.161605,0.0742047,0.14241,-0.235161,0.156523,0.0846059,-0.0906225,-0.0647449,-0.327177,-0.0664459,0.0539693,0.132034,0.206108,0.00751974,-0.441648,-0.208052,-0.020252,0.10107,-0.0433448,-0.301896,0.320051,-0.0544586,-0.0704164,0.379295,-0.401722,0.215579,-0.189374,-0.44331,0.893769,0.0666092,-0.398501,-0.0396635,-0.195525,-0.095363,-0.061127,0.0780537,-0.199393,0.733645,-0.0492271,-0.105271,0.0053235,0.301788,-0.594944,0.227382,-0.0750507,0.327486,-0.350064,-0.204935,0.433356,0.371337,0.355395,-0.111175,-0.151516,-0.167969,-0.0303322,-0.734917,0.00819474,0.132479,0.196142,-0.440578,-0.331255,-0.0382756,0.420086,-0.452981,-0.586769,0.328809,-0.0587382,-0.447921,0.0571286,-0.0582076,0.287919,-0.464455,-1.1136,0.510386,-0.157881,0.508119,0.0155574,-0.0428712,0.0924373,0.250201,-0.109043,0.16045,0.356989,-0.0568768,-0.421521,-0.0218785,-0.564599,-0.604355,-0.00925731,0.201877,-0.406051,-0.0864017,-0.507036,0.250845,0.134415,0.138945,-0.057162,0.171363,0.0317027,-0.600441,-0.016896,0.478281,0.527631,-0.225565,0.779363,-0.140049,0.147091,0.339847,-0.114647,0.0504152,-0.272504,-0.223974,0.49828,-0.00565919,-0.220954,-0.162826,-0.257522,-0.473725,0.155672,-0.507767,-0.00908248,0.12544,-0.190608,0.23401,-0.079415,-0.159997,-0.153141,0.2999,-0.102762,-0.0319609,1.06333,-0.381651,-0.280557,-0.00219619,0.0636538,0.0565846,-0.557663,-0.12866,0.0890671,-0.266529,-0.380954,0.338994,-0.190896,-0.091724,-0.0542124,0.0357763,0.387505,-0.123111,-0.825801,-0.563213,0.032975,0.192137,0.130058,0.363899,-0.0222177,-0.359344,-0.202591,0.479425,-0.239495,-0.261451,-0.483308,-0.437088,-0.612136,-0.103356,-0.277803,0.0576372,0.156983,0.100884,0.279063,0.317622,0.528264,-1.75492 +3433.5,0.92867,0.0912059,4,1.61457,0.964469,-1.49319,0.556893,0.708771,-0.0718926,-0.0143351,-0.162543,0.643743,-0.223111,-0.533981,-0.254408,-0.286771,0.477814,-0.13072,0.894819,-0.123026,-0.150087,-0.146563,-0.18408,-0.176705,-1.30089,-1.23605,-0.141985,-0.00876872,-0.479297,-0.246053,0.157532,-1.10977,0.357508,0.691187,-0.107168,-0.179263,-0.0288,-0.132698,-0.29041,-0.551602,0.644966,1.16241,-0.571149,1.04578,0.634407,0.538707,-0.474793,-0.24084,-0.0295709,-0.0561229,0.660455,0.235316,-0.0222508,-0.0524045,0.615268,0.274091,-0.539933,0.21874,-0.0496644,0.0157223,-1.26038,0.322991,-0.390512,0.565999,1.11583,-0.0900895,-1.32731,0.301772,0.402444,0.00360835,0.0780948,0.123251,-0.210732,0.0195235,0.267497,0.172278,-0.173458,0.441939,-0.0708019,0.0649875,0.19284,-0.331579,-0.197623,0.361023,-0.0701934,0.403961,-0.915552,0.459344,0.193995,-0.0537766,0.0735445,-0.229671,-0.275457,-0.0793965,-0.230087,0.211866,-0.292063,-0.000373031,-0.0939714,0.740445,-0.725814,-0.041753,0.028817,0.317737,0.3175,-0.118277,-0.409147,0.24011,0.0509523,0.0935845,-0.119799,0.494769,0.467903,-0.327661,0.0456842,0.140343,0.249752,0.45787,0.164529,-0.117073,0.372511,-0.00870212,-0.160677,-0.969366,-0.433382,-0.277548,-0.725854,0.155409,0.0650194,0.430568,-0.309338,0.20186,-0.20358,-0.19436,-0.0955836,-0.504861,0.765972,-0.0877802,-0.239466,0.643591,-0.177043,0.0865767,-0.0286877,-0.244332,-0.227338,-0.0967019,0.12429,-0.108025,0.0366452,0.361956,0.170753,-0.420574,-0.209047,-0.251046,0.102778,-0.10781,0.0378767,0.289295,0.130528,-0.00701553,0.0222228,-0.303534,0.107051,-0.293702,-0.268559,0.817197,-0.0949692,-0.174171,-0.361036,-0.186138,-0.175045,0.0016553,0.264159,-0.161985,1.40391,-0.205793,-0.027687,-0.00676236,0.504466,-0.573826,0.288782,-0.110638,0.54577,-0.349252,-0.164792,0.279534,0.889826,0.244535,0.194692,-0.287907,-0.0733713,0.356412,-0.631573,-0.214339,0.00825354,-0.101025,-0.342763,-0.469292,0.165859,0.132341,-0.386456,-0.701681,0.266298,-0.00283644,-0.264345,-0.214219,-0.197606,0.487435,-0.314909,-0.796864,0.963767,-0.222512,0.452983,-0.268272,-0.214757,0.42906,0.380347,-0.326143,0.143207,0.464778,0.0813771,-0.174293,0.116438,-0.319439,-0.377611,0.0692591,0.375356,-0.49215,0.213885,0.0495156,0.24863,0.16802,0.209115,-0.178281,0.0680411,0.200315,-0.367244,0.322668,0.464076,0.528629,0.0791336,0.688676,-0.271651,-0.123707,0.03555,-0.11968,-0.201025,-0.190237,0.0592744,0.521715,-0.19779,0.169974,-0.581234,-0.0394734,-0.529022,0.36117,-0.727107,0.074646,0.233154,-0.224607,0.262402,0.139561,-0.0512811,-0.225054,0.0616501,-0.12199,0.0408156,0.915004,-0.453413,-0.270147,-0.0521602,-0.234033,0.0354051,-0.351076,-0.312489,-0.0699098,-0.25125,-0.328973,0.294403,-0.225159,-0.0781782,-0.0214225,0.108175,0.426298,-0.189955,-0.579388,-0.0467297,-0.122205,0.360138,-0.112177,0.410856,-0.0451438,-0.34323,-0.153114,0.0699613,-0.382885,-0.171562,-0.336507,-0.477862,-0.222698,0.0868854,-0.289622,-0.161364,0.185432,0.112275,0.292995,0.335075,0.54129,-2.16915 +3423.78,0.916407,0.0912059,4,1.54023,0.9817,-0.548957,0.14765,0.533243,-0.132917,-0.365174,-0.0162618,0.207174,0.0696551,-0.230195,-0.307947,-0.307103,0.262599,0.137971,0.781386,0.0149952,0.191612,-0.348905,-0.189161,-0.661664,-0.972916,-0.456156,-0.1435,0.0370069,-0.396477,-0.0153074,-0.00885347,-0.653731,0.162833,0.796688,-1.06306,0.0269785,0.623076,-0.108761,-0.25355,-0.568097,0.770949,0.522163,-1.08594,1.32509,0.730943,0.565599,-0.580938,-0.288966,-0.712808,-0.270362,0.169698,0.323117,-0.0770941,0.0745182,-0.413247,0.10803,-0.639685,0.636193,-0.602612,0.0672691,-0.875129,0.755446,-0.273646,0.316659,0.920548,-0.340059,-0.987674,0.374654,0.455303,0.351718,0.262937,0.195477,-0.101175,-0.170635,0.47512,0.551449,-0.609562,0.533674,0.64665,0.469627,-0.0587784,-0.193168,-0.25454,0.714536,0.252026,-0.0284884,0.0220007,-0.278161,0.488125,-0.286719,0.0146505,-0.420498,-0.307861,-0.0491589,0.409517,-0.255546,-0.0152853,0.122773,0.405035,0.01031,-0.159899,-0.050658,-0.0524436,0.311159,-0.690506,-0.78205,-0.0786291,0.329837,-0.248762,-0.12774,0.0723011,0.504272,0.798688,-0.292943,0.00900343,-0.481212,0.584503,-0.0175716,-0.125951,0.271824,-0.239084,0.0552,-0.0213946,-0.528657,0.0904204,0.133044,0.106127,0.29727,0.473756,-0.176762,0.122058,0.5273,-0.638414,0.354263,0.193055,0.0139553,0.313475,-0.407258,-0.114902,-0.112301,-0.214431,0.754155,0.0338827,-0.830099,0.338191,0.112237,-0.256682,0.77917,0.520457,-0.585501,0.400262,0.040458,-0.119418,-0.513022,-0.338593,0.194114,0.354402,0.775663,0.257694,0.0705988,0.208951,-0.241585,-0.267526,-0.0959971,-0.00886693,0.545726,-0.0469385,-0.307745,0.115232,0.061036,0.0946899,-0.210729,0.4919,0.241626,0.14195,0.215565,0.0699888,0.139398,0.247319,0.187032,-0.0151808,0.140423,0.65593,-0.421341,-0.0112507,-0.499425,-0.06543,-0.455126,0.0104098,0.198573,0.0536082,0.595001,-0.368831,0.171727,-0.106618,-0.285041,-0.660365,-0.217748,0.272568,-0.0545334,-0.0224189,-0.729943,0.095304,0.31054,-0.200603,0.95192,-0.0851276,0.264746,-0.373172,-0.596638,0.693503,0.470047,0.136177,-0.72547,-0.252628,0.0541423,-0.222143,0.0647836,0.361847,0.479994,0.168067,0.505251,-0.297497,0.106768,0.0675082,0.527108,-0.151729,0.104969,0.751979,-0.147793,-0.227061,0.394927,-0.191951,0.0597266,0.112856,0.173637,-0.174522,-0.453375,0.0524277,-0.0477155,0.0872662,0.286283,-0.427748,-0.00127369,0.339047,-0.0459322,-0.237683,0.292546,0.0551985,0.756922,0.401137,0.669978,-0.233008,-0.153419,-0.438013,0.509747,-0.46447,0.174328,0.396901,-0.118279,0.259267,0.235868,0.486245,0.404661,0.820539,0.44256,0.255283,0.678798,0.126514,0.0236576,-0.655766,0.666829,0.00937999,-0.507703,-0.245384,-0.22911,-0.189343,-0.0332824,0.462875,0.0878577,0.0781311,-0.435943,-0.036895,-0.0377506,0.157989,-0.748575,-0.0852636,0.0904953,-0.112081,-0.167944,1.07666,-0.0166636,-0.123263,0.301098,0.203771,-0.0664126,0.212742,-0.25693,-0.157071,-0.409988,0.100598,-0.0359421,-0.204687,-0.0483112,0.129147,0.3745,0.359371,0.611964,-1.78398 +3419.65,0.99816,0.0912059,4,1.54548,0.974936,-0.57547,0.14049,0.550261,-0.108993,-0.341223,0.0229813,0.24974,-0.0197365,-0.168544,-0.37168,-0.191796,0.352104,0.10476,0.939137,-0.0161227,0.199414,-0.327851,-0.14021,-0.674991,-1.0045,-0.38951,-0.104675,0.072636,-0.36428,0.0129848,-0.10705,-0.682356,0.159827,0.783681,-1.02476,-0.0891894,0.597695,-0.10948,-0.207812,-0.571576,0.669678,0.479258,-1.15138,1.28763,0.808849,0.558811,-0.609485,-0.289737,-0.746259,-0.358138,0.125441,0.35763,-0.0810999,0.0930777,-0.488589,0.106795,-0.709891,0.632723,-0.685438,0.0939922,-0.915593,0.682738,-0.275506,0.309136,0.937984,-0.480843,-1.06752,0.474787,0.399325,0.431154,0.263129,0.0946083,-0.120895,-0.275494,0.494013,0.528075,-0.60927,0.62802,0.662395,0.517357,0.0126102,-0.124212,-0.225864,0.726642,0.121666,-0.0392531,-0.0202189,-0.292379,0.510525,-0.2955,0.133695,-0.436495,-0.339328,-0.042633,0.392457,-0.2225,-0.0993347,0.123311,0.35673,0.103257,-0.0961563,-0.00458194,-0.0461754,0.261909,-0.65558,-0.685126,-0.0298279,0.310273,-0.286188,-0.122869,0.0994987,0.485392,0.829917,-0.316781,-0.0467535,-0.571213,0.571854,-0.0955707,-0.0955311,0.205391,-0.204936,-0.0024292,-0.100387,-0.481426,0.0636555,0.159352,0.00613305,0.399454,0.475603,-0.178271,0.179915,0.50905,-0.630748,0.225407,0.225298,0.0305301,0.261401,-0.383289,-0.0936744,-0.100576,-0.313786,0.783835,0.000652001,-0.74768,0.318424,0.0282352,-0.239421,0.771773,0.532212,-0.461181,0.420344,0.08952,-0.0365976,-0.473366,-0.333603,0.177271,0.391,0.774327,0.263869,0.169477,0.234349,-0.277864,-0.302532,-0.0957058,0.0172755,0.551222,0.0095187,-0.291095,0.17663,0.0921833,0.15669,-0.19979,0.531892,0.285008,0.206919,0.160108,0.0903022,0.126221,0.3357,0.173705,0.0467453,0.163582,0.70638,-0.393678,-0.093367,-0.353807,-0.0214749,-0.470532,-0.0704359,0.190266,0.0253878,0.5927,-0.429406,0.222646,-0.0952375,-0.215589,-0.576552,-0.306925,0.128627,-0.0706477,-0.0514033,-0.823238,0.0953208,0.320026,-0.199056,0.87116,-0.190057,0.276252,-0.334042,-0.672051,0.695191,0.496884,0.108347,-0.757008,-0.2442,0.0981654,-0.242287,0.0998095,0.389312,0.427503,0.150063,0.374057,-0.430759,0.140036,0.0462114,0.583561,-0.136969,0.180727,0.65157,-0.110652,-0.244143,0.434962,-0.134785,-0.0110455,0.084823,0.177319,-0.213279,-0.425235,-0.0090237,-0.121385,0.0756464,0.26717,-0.470679,0.0189711,0.316838,-0.0634647,-0.35245,0.286625,-0.012975,0.851907,0.399687,0.674377,-0.215016,-0.183196,-0.411064,0.484117,-0.509027,0.233877,0.435893,-0.181177,0.182016,0.222914,0.497946,0.438516,0.781234,0.436296,0.266937,0.686708,0.152583,0.025777,-0.664032,0.657672,0.0138866,-0.473515,-0.226589,-0.067088,-0.235509,-0.0272069,0.489792,0.0854427,0.112153,-0.366125,-0.0948411,0.0407648,0.211556,-0.796251,-0.127676,0.0573547,0.0287569,-0.118536,1.07094,-0.0579327,-0.121279,0.2572,0.235849,-0.0535215,0.13039,-0.18758,-0.224752,-0.437544,0.0982161,-0.0436585,-0.289925,-0.0825275,0.12632,0.387503,0.355416,0.622497,-1.80853 +3421.37,0.747968,0.0912059,4,1.53873,0.937881,-0.644013,0.181289,0.646332,-0.0909661,-0.265519,0.12993,0.379084,0.00921476,-0.119878,-0.4076,-0.163554,0.381204,0.154312,0.958431,0.0883872,0.131807,-0.233752,-0.148454,-0.61179,-1.27601,-0.258562,-0.117335,-0.0214366,-0.603508,0.123977,0.153537,-0.467905,0.214275,0.750479,-0.936956,-0.225931,0.842484,-0.196698,-0.288716,-0.754218,0.517164,0.44229,-1.18818,1.29276,0.828198,0.438405,-0.774792,-0.418504,-0.641784,-0.157838,0.187,0.317779,0.0907405,0.0916301,-0.291477,0.0837525,-0.808617,0.72674,-0.649368,-0.0746249,-0.990764,0.697194,-0.179512,0.236389,0.899419,-0.488798,-1.10898,0.367528,0.292563,0.246222,0.246801,0.287069,-0.166787,-0.402877,0.457722,0.573468,-0.553618,0.649522,0.688975,0.408336,-0.0752839,-0.258408,-0.137556,0.701542,-0.0900517,0.00403474,-0.0153469,-0.335465,0.453876,-0.331389,0.131551,-0.347471,-0.448451,0.0696655,0.631101,-0.0953027,-0.095505,0.139515,0.424498,0.183158,-0.0264849,-0.0486575,0.0569019,0.215954,-0.457554,-0.683103,0.000447298,0.196534,-0.278391,-0.207642,0.0490821,0.515846,0.732246,-0.378301,0.092215,-0.474766,0.516221,-0.0069392,-0.0812376,-0.0401762,-0.207829,-0.0260522,-0.264488,-0.371521,0.0901589,0.154719,0.117951,0.377319,0.640971,-0.0585048,0.34703,0.449635,-0.512106,0.213827,0.334343,-0.00619144,0.169114,-0.292526,-0.0501184,-0.0909297,-0.355976,0.747314,-0.0287903,-0.745213,0.282827,0.100797,-0.182197,0.739772,0.492472,-0.540728,0.373257,-0.0408312,0.0010254,-0.655323,-0.311126,0.378996,0.541423,0.861683,0.113437,0.465317,0.182319,-0.24021,-0.329822,-0.0699528,-0.121222,0.425533,0.1545,-0.397149,0.0872394,-0.0066443,0.160329,-0.166916,0.493448,0.246136,0.40406,0.186898,0.0209708,0.143961,0.203557,0.181114,0.155604,0.18488,0.693366,-0.336473,-0.103064,-0.482312,0.213474,-0.312552,0.158936,0.281361,-0.0316428,0.54448,-0.585326,0.0970792,-0.170473,-0.231531,-0.542324,-0.182188,0.283691,-0.050001,-0.0951658,-0.836715,-0.0209852,0.312597,-0.0388494,0.825743,-0.174472,0.282501,-0.432181,-0.462228,0.843423,0.621152,0.155513,-0.790484,-0.335605,-0.042304,-0.224993,0.150926,0.408449,0.361072,0.103155,0.314846,-0.438698,0.07076,0.13246,0.700193,-0.0227014,-0.0278502,0.592537,-0.25964,-0.413114,0.51174,-0.195879,0.0258518,0.113867,0.329791,-0.113663,-0.414771,0.0274609,-0.0340585,0.12566,0.345998,-0.487277,0.0193433,0.176092,-0.138961,-0.273183,0.484684,0.0216611,0.863861,0.488249,0.632857,-0.120936,-0.189612,-0.436177,0.436465,-0.481072,0.172777,0.421156,-0.0769036,0.260102,0.224314,0.436092,0.278654,0.657257,0.232589,0.562133,0.739864,0.12591,0.0203274,-0.476856,0.496345,0.0260508,-0.404588,-0.292861,-0.108627,-0.197234,-0.0448892,0.465722,0.0248193,0.0615573,-0.403841,-0.0705755,0.262999,0.103788,-0.666897,-0.0614967,0.00377003,-0.0726578,-0.131553,0.714789,-0.0902325,-0.0750274,0.184031,0.306792,-0.170481,0.225004,-0.251014,-0.309258,-0.360189,-0.0581667,-0.24125,-0.315123,-0.0809718,0.124548,0.397289,0.352913,0.630308,-2.07589 +3419.18,0.985068,0.0912059,4,1.59523,0.915967,-0.619239,0.187799,0.332902,-0.142534,-0.00514765,-0.553032,-0.228773,0.224079,-0.144699,-0.0791721,-0.104309,0.107595,0.232447,0.931693,-0.161778,-0.144684,-0.140456,0.22026,-0.592748,-0.867433,-0.578514,0.00770155,0.0965282,-0.258334,0.0647895,-0.148182,-0.397399,-0.250786,0.858324,-0.542793,0.0868047,0.513042,0.278544,-0.195446,-0.470744,0.580795,0.19141,-0.962716,1.07438,0.290627,0.760377,-0.854613,-0.299377,-0.244573,-0.19231,0.0102205,0.127995,0.256922,0.26457,-0.338371,0.171734,-0.612946,0.579343,-0.322184,0.132444,-0.661687,0.638548,-0.363528,0.313359,1.0474,-0.142628,-1.77073,0.691197,0.231205,0.242223,0.573041,0.611846,-0.217541,-0.356464,-0.00970564,0.702144,-0.426614,0.569807,0.608559,0.373333,0.131766,-0.102983,0.0213323,0.997496,-0.116185,0.262196,0.130812,0.214682,0.0928073,-0.542475,0.0162545,0.0128649,-0.265023,-0.315182,0.396331,-0.183742,-0.31123,0.00772244,-0.192998,-0.296132,0.187852,0.26456,-0.0759409,0.00317441,-0.207016,-0.414754,-0.252189,0.0022338,-0.511996,-0.0163617,-0.0433192,0.169252,0.419588,0.115671,-0.0671674,-0.276868,0.476069,-0.582147,0.263427,-0.47006,0.166325,0.145867,-0.54751,-0.531749,0.05447,0.099157,-0.261061,0.276636,0.673797,-0.137926,0.106561,0.314372,-1.12319,-0.21636,0.0368934,-0.225913,0.324924,0.245779,-0.155691,-0.175051,-0.559826,0.641512,-0.00525568,-0.469074,0.381256,0.417159,-0.115138,0.20999,0.147333,-0.200799,0.0171085,-0.126653,-0.351752,-0.109694,-0.168805,0.234852,0.0140981,0.400213,0.0760828,0.405292,0.403375,0.0503997,0.0382401,0.237039,0.32464,0.802579,0.57603,-0.250367,0.0635561,-0.203907,-0.062192,-0.390766,0.104473,0.303857,0.22866,0.139084,-0.469899,-0.0203614,0.0955338,-0.463422,0.0813959,0.28332,0.620849,-0.26599,-0.343967,-0.0561703,0.269035,-0.246275,0.0455056,0.280098,0.087575,0.32313,-0.583734,0.271522,-0.640986,-0.134878,-0.415557,0.210932,0.384945,0.1412,-0.107462,-0.794778,-0.211548,0.380681,-0.0978415,0.229994,-0.0766218,0.553208,-0.0372273,-0.359569,0.876033,1.0439,0.0488174,-0.768629,-0.203662,0.255442,0.0661624,-0.127904,0.32644,0.107382,0.0459738,-0.0777651,-0.10629,0.165987,-0.495718,0.589769,-0.317129,-0.313775,0.510215,-0.140644,-0.172407,0.825577,-0.296113,0.297107,0.239924,0.553028,-0.274262,-0.548244,0.394617,0.0357892,0.334115,0.378344,-0.79929,0.293254,-0.214858,-0.0302179,0.149266,0.471589,-0.0740976,0.535542,0.177916,0.799118,-0.126092,-0.225801,-0.469513,0.44688,-0.202831,0.0327484,0.374827,-0.082702,0.271792,-0.170202,0.272195,-0.240725,0.562307,0.215216,0.569649,0.737806,-0.0599227,0.0797789,0.290027,0.519954,-0.367312,0.0734617,-0.108255,-0.125493,0.19651,0.109154,0.359785,-0.10195,-0.23022,-0.763748,0.0724596,0.826549,-0.0154491,-0.920297,0.0383033,0.246813,0.101714,0.016503,0.654979,-0.204384,-0.159973,0.440995,0.271427,-0.12478,-0.185818,-0.35011,-0.56285,-0.277041,-0.200943,-0.364323,-0.118719,0.0217385,0.137271,0.340717,0.370501,0.58371,-0.946427 +3398.74,0.979907,0.0912059,4,1.46929,1.05111,-0.728331,0.185523,-0.0175629,-0.147708,0.346632,0.127261,0.615617,-0.153719,-0.0935143,0.0554098,-0.256015,0.428223,0.0651499,1.07193,0.0147647,0.280301,0.466734,0.100906,-0.50316,-0.952301,-0.242574,0.063426,-0.222804,-0.451661,-0.0517262,0.139874,-0.730859,0.288724,1.0015,-0.768061,0.0391286,0.233886,-0.638931,0.00925698,-0.530409,0.158137,0.511744,-0.71823,1.09324,0.951421,0.142899,-0.398281,-0.736101,0.00756622,-0.577068,0.0568487,0.484565,-0.205911,0.226872,0.695088,0.508993,-0.136715,0.260379,0.296804,-0.310068,-0.816855,0.707001,-0.358486,0.72618,1.30206,-0.762404,-1.89732,-0.0361141,0.317181,-0.210238,0.256503,0.0674046,-0.742392,0.0830611,0.530065,0.680092,-0.0263115,0.386665,0.501148,-0.110797,-0.635894,-0.730618,0.553339,-0.040255,-0.0534316,0.500688,-0.0468721,0.353434,-0.239308,-0.135243,0.0380642,0.38812,-0.491593,0.06882,0.214998,-0.0152893,0.119512,0.292814,-0.544366,-0.157708,0.420034,-0.46954,0.190476,0.0161679,-0.196937,-0.273761,-0.123376,0.581403,-0.0349217,0.0672878,-0.282491,0.0462054,0.414682,0.0164987,-0.44823,0.40132,0.779056,-1.04248,0.301053,0.509688,-0.267087,0.386863,-0.124497,-1.26457,0.25861,0.102596,-0.911515,-0.282938,0.142907,0.048814,0.196791,0.29803,-0.808589,0.313285,-0.0426429,-0.0933044,0.442083,0.00115742,0.0244304,0.153951,-0.192196,0.452515,-0.0272527,-1.05633,-0.235678,0.0330892,-0.73107,0.292794,0.36037,0.492322,0.124422,-0.457494,0.365939,0.286322,-0.341462,-0.0867399,0.183735,0.62015,0.660079,-0.40784,0.20668,-0.0798597,-0.0567758,-0.03036,-0.00120754,1.30525,-0.51872,-0.74621,0.260914,0.0118063,0.0942463,-0.0277205,-0.596698,0.00562182,-0.0180676,0.265339,0.124219,0.141743,0.455332,-0.238299,0.10298,-0.287333,0.512201,0.00731339,0.381903,0.338171,-0.0656864,0.301056,-0.214531,0.258837,-0.267084,-0.155865,-0.147585,0.03765,0.352374,-0.210876,-0.527751,-0.502669,0.135055,-0.386331,-0.264654,-0.595285,-0.542359,-0.294415,-0.208798,0.620044,0.249115,0.0580915,-0.214085,0.0100542,0.74706,0.00266482,-0.213072,0.473887,-0.132514,-0.0350219,-0.120256,0.194763,0.353209,-0.214375,0.326982,0.707144,0.031739,-0.23573,0.0119035,-0.20312,0.442217,0.212202,0.339821,0.0609992,-0.867504,0.501733,-0.0119666,-0.53718,0.381938,-0.722428,-0.166714,-0.310625,0.252515,0.495789,-0.329789,0.0235544,0.130994,0.155616,-0.117657,-0.213425,0.278627,0.481448,0.25437,0.206372,0.019311,0.309438,0.189359,0.34575,-0.621528,0.48132,-0.157351,-0.76738,-0.113689,-0.112986,-0.291424,-0.094551,0.324619,-0.0309584,0.278594,0.265161,-0.490006,0.174547,0.302757,-0.257806,0.342444,-0.0965663,0.316187,-0.2,0.290081,-0.109596,-0.489421,-0.283704,0.193487,0.0405471,0.563196,-0.238949,0.254274,0.361601,-0.146533,-0.424505,0.173761,0.369042,0.19709,0.0995258,0.664036,0.0413435,-0.0958364,0.15901,-0.755874,-0.235774,0.021016,-0.25904,0.0956233,-0.401273,-0.214792,-0.222153,-0.124107,-0.318313,0.133881,0.329876,0.365898,0.574348,-0.0870521 +3396.55,0.998036,0.0912059,4,1.48767,1.00755,-0.785113,0.192057,0.0224947,-0.147719,0.595469,0.200359,0.526681,-0.163886,-0.117518,-0.0311388,-0.321933,0.29475,-0.0276226,1.26371,0.0252537,0.254598,0.325016,0.19042,-0.448336,-0.846619,-0.341129,-0.0885442,-0.152109,-0.353354,-0.0980098,0.160551,-0.690157,0.27753,0.957899,-0.826712,0.108817,0.176917,-0.746968,-0.112312,-0.518702,0.22269,0.486022,-0.605847,1.14678,0.882501,0.259334,-0.530134,-0.700675,0.122124,-0.406277,0.199811,0.517993,-0.141593,0.29666,0.576703,0.342238,0.0178189,0.355323,0.391437,-0.440013,-0.975047,0.755825,-0.270954,0.650817,1.44553,-0.777402,-1.79412,-0.0390721,0.364431,-0.314658,0.357976,0.0534332,-0.627479,0.139922,0.510998,0.67167,-0.037939,0.319597,0.457943,-0.00869867,-0.532805,-0.717185,0.590207,-0.0458685,-0.193842,0.40951,-0.0668731,0.385006,-0.30476,-0.150041,0.0253928,0.415357,-0.363313,-0.0731679,-0.0217077,-0.0132879,0.0726298,0.140799,-0.547455,-0.190964,0.559382,-0.462476,0.16578,0.0528317,-0.253053,-0.211776,-0.0668099,0.411417,0.0506409,0.169622,-0.426988,0.0440562,0.493998,0.22345,-0.375913,0.532971,0.684851,-1.11631,0.250927,0.644108,-0.374763,0.372564,-0.0528682,-1.19842,0.202034,0.0155184,-1.01033,-0.22897,0.0832118,-0.0424321,0.341516,0.38162,-0.961462,0.172912,-0.058538,-0.0624525,0.618895,0.190059,0.0642954,0.118243,-0.108121,0.484405,0.0269231,-1.02175,-0.264814,-0.152354,-0.690426,0.317588,0.327599,0.313555,0.119354,-0.519398,0.451784,0.223284,-0.293553,-0.0449618,0.246887,0.592948,0.844786,-0.193331,0.237673,0.0217208,-0.254702,0.113175,-0.153003,1.40654,-0.351929,-0.587755,0.0721693,0.119213,0.0956783,-0.0833654,-0.577729,-0.105971,-0.175958,0.37464,0.293166,0.03504,0.407336,-0.174907,0.162566,-0.255338,0.459205,-0.0668631,0.45824,0.480754,-0.184027,0.00303036,-0.256644,0.338395,-0.273079,-0.207527,-0.0750069,0.0154777,0.523898,-0.194221,-0.51508,-0.431431,0.0311165,-0.31244,-0.25876,-0.588363,-0.515287,-0.302802,-0.248431,0.553252,0.136822,-0.037436,-0.0848878,-0.0181864,0.661788,0.0206775,-0.272663,0.416107,-0.220203,-0.0435046,0.011554,0.0661248,0.228652,-0.248896,0.329693,0.767413,0.210893,-0.0843922,-0.236568,-0.098856,0.578213,0.122383,0.275054,-0.0833163,-0.843059,0.668321,-0.106024,-0.617247,0.308604,-0.67628,-0.0228426,-0.402724,0.299666,0.569286,-0.372791,0.0626527,0.258287,0.014082,0.0770388,-0.14655,0.275569,0.440682,0.107147,0.191314,-0.0303443,0.320749,0.0655804,0.474462,-0.770966,0.64642,-0.294304,-0.679872,-0.0650279,-0.137459,-0.227773,-0.141843,0.252512,0.0115972,0.225145,0.200734,-0.436266,0.161111,0.137658,-0.244875,0.435158,-0.170979,0.185491,-0.0571219,0.190537,-0.042315,-0.476451,-0.1673,0.0523428,0.121872,0.563376,-0.172657,0.173174,0.452536,-0.118331,-0.300339,0.199164,0.228324,0.246067,0.20499,0.546805,0.0471168,0.179269,0.258858,-0.771243,-0.360751,-0.214911,-0.280459,-0.0187703,-0.179857,-0.165174,-0.374464,-0.286591,-0.38376,0.131082,0.274474,0.362053,0.523902,-0.101003 +3408.78,0.890104,0.0912059,4,1.60528,0.903462,-0.84276,0.22293,-0.0839383,-0.0741052,0.033576,0.361454,0.120002,0.238862,-0.245846,-0.452122,0.0163835,0.243757,-0.489177,0.748285,-0.0224766,-0.260685,-0.19236,0.0181621,-0.201511,-0.904125,-0.270621,0.113765,0.264577,-0.440259,0.18703,0.629151,0.0329333,-0.582336,0.852457,-0.373399,0.26505,-0.418674,-0.498706,0.104685,-0.762051,0.495738,-0.142371,-0.000313271,1.10929,0.526434,0.0178279,-0.737199,0.086734,-0.0498377,-0.532363,-0.121858,0.610285,0.17767,0.0859532,0.244928,-0.0982402,-0.832093,0.614201,-0.298637,0.315394,-0.350746,0.631827,-0.309165,-0.165991,0.887906,-0.659301,-0.38575,0.292479,-0.0776416,-0.271274,-0.184247,0.452616,-0.501392,0.218642,0.352509,0.847875,0.596213,0.595334,0.887741,0.246409,0.245821,-0.329049,-0.462476,0.578028,-0.2673,-0.128465,-0.271982,-0.0641893,-0.15724,-0.234139,0.0179863,0.562247,-0.609964,0.116288,-0.119879,0.33195,-0.221182,-0.534082,-0.0997951,-0.0324904,-0.620915,0.461534,0.257349,-0.0444314,0.389254,-0.461672,-0.143703,0.43734,-0.291103,0.722368,-0.73253,0.294952,0.773659,-0.220789,0.114103,0.00762921,0.511438,0.629423,-0.102169,-0.554836,0.0628154,0.195849,0.0548434,-0.65683,0.183401,-0.143428,-0.533074,0.0733397,0.360515,0.491597,-0.136104,0.0305369,-0.423666,0.0383137,0.299659,0.725331,0.324635,0.115187,-0.169734,-0.173876,-0.549351,0.189647,-0.446481,-0.493824,0.193008,-0.469973,-0.0418372,0.202042,-0.249161,-0.0777841,0.166075,-0.109913,-0.0841533,-0.557908,0.520692,0.0972016,-0.241016,0.633195,0.467963,0.864873,-0.463143,0.0926952,0.0353923,0.519648,0.105227,0.427902,0.533198,0.174794,0.514666,-0.114422,-0.87003,0.09418,0.280865,0.165485,-0.100425,-0.0577492,-0.324915,-0.380661,-0.039409,-0.226655,0.32591,0.834998,0.484511,0.0848215,0.233597,0.0756896,-0.278715,0.0663747,0.193988,-0.388582,-0.0548714,0.934712,-0.822472,0.433982,-0.0384678,0.0434567,-0.316386,-0.145734,0.0612942,-0.0352634,-0.553804,0.0303202,-0.258014,0.0397478,-0.177716,-0.0815672,0.0394378,-0.0800793,0.0877722,-0.361961,0.807233,-0.0541496,0.197569,0.0297891,-0.152875,0.410462,0.306318,0.458177,-0.125855,-1.02906,-0.00808465,-0.749751,-0.215154,0.135274,-0.390244,0.405079,0.0628652,-0.213006,0.376875,-0.241958,0.0280073,-0.594302,0.232708,0.4657,0.286137,0.306925,-0.653765,-0.150268,0.352397,-0.316411,0.794947,0.547594,-0.318566,-0.518514,0.476718,-0.420283,-0.253,0.289709,0.731563,0.636206,0.339191,-0.13287,-0.378369,-0.38689,-1.04323,0.432699,0.147906,0.032992,0.286881,-0.269763,-0.196446,-0.119485,-0.0295439,0.288728,0.376163,0.057153,0.728107,0.403697,0.125471,-0.00973991,0.290238,-0.176479,0.117263,-0.505739,-0.343155,-0.524722,0.512026,0.388063,0.375966,-0.188155,-0.257408,0.389296,0.157303,-0.774551,-0.114706,-0.367744,-0.0323207,-0.035868,0.120739,-0.732762,0.354757,0.369516,-0.319222,0.331047,0.60722,0.374342,0.403561,-0.106614,-1.08547,-0.483451,-0.0359391,0.0590005,0.0237289,0.536678,0.13381,0.241019,0.3658,0.490936,0.536564 +3434.51,0.955038,0.0912059,4,1.59032,1.02764,-0.414109,-0.0335793,0.0697258,-0.182666,-0.139704,0.0484015,0.147534,0.217493,-0.546024,-0.250053,0.256785,0.0187587,-0.41689,0.58924,-0.228451,-0.0943059,0.0215803,-0.111557,-0.410955,-0.997428,-0.448835,-0.0783942,-0.130848,-0.300213,-0.128478,-0.0248888,-0.540589,-0.199015,0.631219,-0.246847,0.137717,-0.027172,-0.156867,0.0764798,-0.572442,0.220992,-0.0301875,-0.234591,1.02638,0.826376,-0.289041,-0.444791,0.230012,-0.312463,-0.393877,0.0183526,0.600742,0.555985,0.190302,-0.145561,-0.0052118,-0.647854,0.8575,-0.41447,-0.0138852,-0.771944,0.36449,0.0276014,-0.121381,0.832277,-0.578804,-0.450381,0.183867,-0.312598,-0.217535,-0.00835033,0.145825,-0.448423,-0.528144,0.513318,0.795022,0.512163,0.424519,0.511147,-0.300253,0.147739,-0.0818119,-0.235426,0.430284,-0.031495,0.155601,-0.133169,-0.249155,0.183706,-0.040729,-0.0422554,0.180994,-0.0816142,-0.223374,-0.323928,0.450899,0.00107911,0.0408422,0.65766,-0.112583,-0.538194,-0.0810782,0.038379,0.0310635,-0.0587518,-0.486955,-0.505802,0.489526,-0.662433,-0.103541,-0.284768,-0.609723,0.695875,0.143749,0.259584,-0.0704653,0.522467,0.505568,-0.118324,0.0422899,0.00491213,0.36144,-0.224611,-0.849233,-0.0158224,-0.215686,-0.479224,0.0665066,0.371358,0.421043,-0.410599,0.716059,-0.300036,0.147305,0.291136,0.492787,0.506171,0.0128375,-0.0587789,-0.199041,-0.446126,0.363721,-0.386133,-0.849948,-0.14413,-0.265401,-0.843147,-0.13471,-0.536964,-0.340664,0.52839,-0.379966,-0.291657,-0.377966,0.223938,0.292451,-0.40905,0.412977,0.606611,-0.0619168,0.220118,0.280653,-0.19665,0.275435,-0.0480439,0.496184,0.285512,-0.0190153,0.401509,0.0337291,-0.51222,0.213076,-0.05455,0.387099,-0.113436,0.195933,-0.516081,0.0745848,0.219461,-0.432812,-0.125126,0.279747,0.656023,0.0217812,0.312582,0.0849715,0.331682,0.117263,0.0279094,-0.267067,0.0965833,-0.0517845,-0.151663,0.324593,0.439615,0.42552,-0.46548,0.304836,-0.24694,-0.278989,-0.358857,0.043924,-0.471822,-0.0153169,-0.370886,0.101749,-0.201689,-0.305312,0.0793457,-0.747239,0.790584,0.237012,0.0830714,0.330732,-0.21818,0.0929958,0.534829,0.59458,0.0549136,-0.781639,0.10159,0.228635,-0.773905,0.141079,-0.714139,0.320926,-0.396126,-0.0221243,0.496028,-0.471564,0.0070669,-0.238612,-0.105022,0.568389,0.114735,-0.175852,-0.436732,-0.776057,0.167792,-0.188187,-0.00550379,0.649751,-0.213352,0.164788,0.0270201,0.210176,-0.22971,0.557132,0.404709,0.465433,0.25918,-0.0206216,-0.394504,-0.208658,-0.551934,0.53972,0.281359,-0.110515,0.248974,0.144109,0.200906,0.155894,0.214302,0.0541084,0.065243,0.20756,0.327856,0.358933,0.0196583,-0.211951,-0.161854,0.137782,0.02212,-0.163073,0.177104,-0.92206,-0.00412846,1.08167,0.3731,-0.0228993,0.266754,0.0486421,-0.299119,-0.329024,-0.783415,-0.0106393,-0.0528321,0.284587,0.115585,-0.0390706,0.375042,0.503604,-0.207736,-0.116427,0.164467,0.116051,0.626074,-0.051139,-0.462205,-0.389494,0.0077987,-0.283336,-0.438667,-0.124812,0.153439,0.235134,0.391713,0.484906,-0.162893 +3417.97,0.933128,0.0912059,4,1.56829,0.965127,-0.407849,-0.0607771,0.107362,-0.0444668,-0.315528,-0.0509366,0.543734,0.266569,-0.405503,-0.0122008,-0.395029,0.172204,-0.247192,1.01729,-0.0568621,-0.420877,-0.289493,-0.146424,-0.512553,-1.01664,-0.461702,-0.163217,-0.144662,0.174332,-0.116914,0.126831,-0.458513,-0.296749,0.640509,-0.363125,0.185816,-0.39453,-0.065753,0.0597134,-0.850069,0.168701,-0.098487,0.22148,1.03218,0.360206,0.0458102,0.076312,0.224915,-0.237479,-0.353472,-0.127064,0.517889,0.280076,0.0414267,0.136486,0.0423955,-0.887601,1.23308,-0.249783,0.0289631,-0.716545,0.618113,-0.0807194,0.0511299,1.26699,-0.186314,-1.16639,0.765986,0.198616,-0.801607,-0.0291308,0.162711,-0.231204,-0.293517,0.511352,0.664275,0.219039,0.148749,0.457227,0.297942,0.0785457,-0.393342,0.294453,0.587708,-0.447612,0.573825,0.351977,-0.204373,0.0327721,0.194228,-0.202702,0.43414,-0.374827,0.349659,-0.26922,0.27958,-0.188002,-0.103531,0.748017,-0.248422,-0.291058,0.423274,0.409528,0.101499,0.311917,-0.986152,-0.814431,0.029018,-0.514015,-0.433951,0.191749,0.277444,0.593169,0.131021,0.110807,0.265198,0.450794,0.15604,0.179307,-0.298712,0.424393,0.204457,0.148236,-0.634663,-0.405658,-0.47483,-0.314327,0.164007,0.401371,0.170457,0.0445121,0.386285,-0.235189,0.0204091,-0.0962696,0.337542,0.624692,-0.026969,0.0371033,-0.238893,0.417837,0.381005,-0.972125,-0.280315,-0.180521,0.263772,-0.842023,0.152604,-0.300844,-0.104188,0.327356,0.064532,0.517994,-0.342255,0.104634,0.196661,-0.0538794,0.359435,0.33223,0.467806,-0.181323,0.115132,0.2067,0.472078,-0.230576,0.548789,0.15208,-0.192503,0.198988,-0.212462,-0.392374,0.671993,-0.183226,0.486409,-0.287332,-0.142858,-0.0936846,-0.0471665,0.0353356,-0.0176836,-0.512908,0.305974,0.270761,0.792578,0.31665,-0.122283,0.230918,-0.149298,0.114601,-0.0464886,0.0751645,-0.0533387,-0.356064,0.447038,0.195234,-0.217587,0.233703,0.0598831,0.558761,0.00445287,-0.488114,-0.650554,0.268888,0.115931,-0.401817,0.350877,-0.0253704,-0.0352358,0.114195,-0.497947,0.815908,-0.226064,0.822124,0.310494,-0.102435,0.108991,0.550388,0.0652944,-0.297187,-1.10691,0.377585,-0.0539538,-0.722168,-0.207156,-0.403291,-0.221213,0.299079,-0.0562588,0.205975,-0.556405,0.0499944,0.091455,0.124999,0.331354,0.137235,-0.719177,-0.13839,0.158333,0.660043,0.618871,0.19338,0.314637,-0.542547,-0.174249,-0.288539,0.575533,-0.108447,-0.275543,0.180949,0.414148,0.268407,0.574931,-0.308595,-0.11341,-0.266198,0.395945,0.303371,-0.250172,0.594938,-0.142192,0.329546,0.167941,0.316527,0.289479,0.277701,-0.120467,0.0284683,0.770501,0.46974,-0.0106231,0.0104683,-0.303132,-0.0817614,0.154259,-0.0468771,-0.581937,0.00392012,0.471286,-0.300865,0.0569681,0.555814,-0.0181895,0.348721,0.213302,-0.1549,-0.102829,-0.320962,0.289783,0.133212,-0.103618,0.363585,0.59032,-0.356768,0.0646877,0.31126,0.209537,0.289821,0.275482,-0.238128,-0.672373,-0.446802,0.4874,-0.0646815,-0.0143908,0.110814,0.265756,0.332887,0.515516,-0.211377 +3425.41,0.959683,0.0912059,4,1.55738,0.989607,-0.391845,-0.0892316,0.136107,-0.0702667,-0.310973,-0.0385451,0.51028,0.369503,-0.387008,-0.0317351,-0.451611,0.217477,-0.203809,1.04308,-0.0679757,-0.450071,-0.35756,-0.174019,-0.463395,-0.970854,-0.520787,-0.141012,-0.228503,0.150946,-0.0784953,0.202918,-0.420038,-0.315674,0.61839,-0.362403,0.129328,-0.306612,-0.0415599,-0.0434134,-0.863054,0.178952,-0.118379,0.133638,1.04342,0.306602,0.0874538,0.0871759,0.259686,-0.310665,-0.369577,-0.110594,0.596052,0.274154,0.0751973,0.162825,0.0542116,-0.848392,1.22089,-0.359828,-0.0335563,-0.764427,0.660802,-0.108094,0.0126129,1.2188,-0.322458,-1.2143,0.854877,0.207554,-0.775469,-0.0466197,0.240432,-0.201405,-0.320236,0.518221,0.68906,0.230516,0.123962,0.414039,0.343,0.102117,-0.387142,0.238628,0.593237,-0.441746,0.579317,0.400946,-0.241937,-0.0207226,0.156962,-0.191531,0.51526,-0.319222,0.35974,-0.255765,0.344075,-0.15578,-0.0964484,0.686109,-0.336954,-0.242773,0.524933,0.382773,0.0370934,0.277281,-0.977011,-0.81641,0.0644341,-0.69225,-0.422167,0.243959,0.270662,0.617066,0.0974239,0.0990722,0.316774,0.424449,0.0976217,0.193777,-0.228517,0.398357,0.32672,0.154279,-0.687127,-0.505596,-0.491888,-0.258267,0.197387,0.328444,0.124688,0.0592172,0.360375,-0.160914,-0.0142594,-0.146464,0.271239,0.610829,-0.0654506,-0.0497419,-0.212587,0.363207,0.268325,-0.971442,-0.281557,-0.0916972,0.166286,-0.861322,0.127994,-0.278467,-0.148424,0.401391,0.0765158,0.600961,-0.354206,0.105436,0.227107,-0.0396934,0.351071,0.29917,0.424461,-0.134338,0.111017,0.259105,0.54905,-0.327241,0.499397,0.213801,-0.180026,0.146084,-0.26905,-0.432012,0.57778,-0.154138,0.470639,-0.369623,-0.0932413,-0.0578996,-0.00263607,0.0276966,0.028576,-0.507611,0.198738,0.305547,0.78781,0.282586,-0.0693855,0.24813,-0.271317,0.106437,0.0163477,0.0432145,-0.0880738,-0.388635,0.479711,0.25428,-0.187775,0.287778,0.0864776,0.604959,-0.0349317,-0.484331,-0.685304,0.231389,0.104891,-0.309564,0.296263,-0.0209868,0.0346599,0.151653,-0.51544,0.800378,-0.385582,0.764806,0.321718,-0.151556,0.106294,0.584793,0.0802226,-0.188421,-0.995867,0.332139,-0.0157513,-0.656096,-0.217865,-0.410176,-0.284612,0.275708,-0.0831498,0.260683,-0.474689,0.000467084,0.040977,0.0766838,0.282773,0.0792315,-0.691101,-0.114378,0.136464,0.644038,0.406041,0.0626087,0.218269,-0.626786,-0.119546,-0.254636,0.58516,-0.19495,-0.208989,0.0827577,0.401167,0.222571,0.502847,-0.280012,-0.0633404,-0.226757,0.462131,0.355555,-0.260589,0.585129,-0.0645728,0.218796,0.195874,0.375041,0.294798,0.274543,-0.0501978,0.0104457,0.690209,0.564593,-0.0213873,0.0938794,-0.320772,-0.0592704,0.135833,0.0438918,-0.573848,-0.0484236,0.468848,-0.209338,0.063463,0.537645,0.0774201,0.247351,0.191378,-0.10693,-0.0663223,-0.268984,0.298988,-0.0273663,-0.0974253,0.257022,0.485656,-0.372803,0.0536638,0.290244,0.229543,0.272637,0.348716,-0.281397,-0.682563,-0.414687,0.565918,-0.0165452,0.0539394,0.125948,0.257006,0.354891,0.506958,-0.335972 +3421.02,0.972315,0.0912059,4,1.52488,0.909562,-0.328532,-0.0162729,-0.0469984,-0.168236,-0.398545,-0.258982,0.109928,0.157193,-0.0855914,0.125277,-0.0199476,0.270469,-0.35065,0.773851,-0.167251,-0.269785,-0.504853,-0.361927,-0.315312,-0.928101,-0.901169,-0.143757,-0.460493,0.0523587,0.125045,0.013905,-0.554768,-0.143052,0.521769,0.109996,0.31567,-0.230441,0.0402634,0.135587,-0.727049,0.757325,-0.187689,-0.0592565,0.978093,0.469308,0.0503563,-0.273813,0.442412,-0.672852,0.212559,0.283865,0.492743,0.399568,0.328958,-0.280923,0.163485,-1.03999,1.0961,-0.0624695,-0.364258,-0.449236,0.116221,-0.117451,0.190729,1.28388,-0.693242,-0.843224,0.661827,0.160288,-0.264948,0.641102,-0.170926,-0.425832,-0.0722026,0.431615,0.720334,0.131111,0.161464,0.748335,0.374355,-0.000171444,0.114425,0.332427,0.550751,0.167302,0.461127,0.0959894,-0.549591,0.463436,-0.247228,-0.135517,0.497832,-0.122374,-0.105215,-1.06123,0.596053,-0.546932,0.245468,0.0560283,-0.000683562,-0.343268,0.0718491,0.419386,0.0186251,0.367799,-0.415759,-0.787105,0.0210154,-0.375215,0.321058,0.0493463,0.378486,0.252189,-0.0303421,-0.177358,0.269422,0.342098,-0.0226981,0.438435,-0.196825,0.258768,0.184728,-0.0703188,-0.771494,0.0517867,-0.0751968,-0.209138,-0.124867,0.468509,0.0907893,0.117828,0.205373,-0.638947,-0.249662,0.33599,0.054266,0.618468,0.385175,0.170145,0.103094,0.237313,0.417608,-0.416264,-0.0123883,0.385164,0.128777,-0.515238,-0.0371146,-0.0706399,0.184811,0.443522,-0.0974201,-0.0974784,-0.169067,0.506052,0.206709,-0.336595,0.891356,0.476673,0.0434621,-0.526432,0.279804,0.311895,0.274025,-0.132829,0.329983,-0.262666,-0.459094,0.273024,-0.148852,-0.654542,0.140209,-0.451248,0.288737,-0.19586,0.0764791,-0.0300123,0.373465,-0.175189,-0.0942117,-0.28379,0.254624,0.696719,0.310396,0.0386188,-0.262467,-0.0200055,0.0796296,-0.411297,-0.404389,-0.38016,0.0774464,-1.1104,0.30501,0.0879861,0.283541,-0.0678541,-0.326046,0.271987,0.38889,-0.316612,-0.845313,0.170491,0.128135,0.0517964,0.163494,0.142846,0.168168,0.249615,-0.173844,1.29186,-0.475492,0.0145599,0.644221,-0.16361,0.46171,0.615674,0.214256,0.500164,-0.390798,0.334244,0.103484,-0.482457,-0.476066,-0.935445,-0.299894,-0.0524806,-0.486049,0.656125,-0.677239,0.132718,0.158544,0.155479,0.239828,0.185401,-0.472315,0.478611,-0.444173,0.564463,-0.26397,0.0119711,0.0799912,-0.243604,0.382418,-0.322381,0.89168,0.0894132,-0.360075,0.309103,0.200662,0.0594889,0.137662,-0.00646356,-0.0364637,0.124956,0.480869,0.25208,-0.353937,0.727581,-0.143161,0.450846,0.0708962,0.183797,-0.0500873,-0.187368,-0.311951,0.279357,1.25849,0.525049,0.498611,0.0280552,-0.353735,0.518552,0.0318692,-0.108962,-0.37651,0.160555,0.00498981,-0.177955,0.353049,-0.233617,-0.159814,0.0250419,-0.135572,-0.740617,0.202617,0.409916,0.379333,-0.11683,-0.0583425,0.303634,0.445477,-0.707904,0.012076,0.666203,0.0947716,-0.369457,0.225557,-0.412184,0.0209359,-0.371389,-0.00684386,-0.102493,-0.239302,0.145286,0.231307,0.381164,0.480944,0.302951 +3427.26,0.997638,0.0912059,5,1.49383,0.92765,-0.958423,0.313828,0.415439,-0.207212,0.22776,0.11752,0.0705207,0.724277,0.00869784,0.0595223,0.0582127,0.0552253,-0.00190375,0.671752,-0.321654,0.0504534,0.239359,-0.224415,-0.459508,-1.09231,-0.914661,0.214616,-0.114311,-0.234497,0.235953,0.567104,-0.969297,-0.0883596,0.503823,-0.136224,0.584696,-0.252865,0.147248,-0.179173,-0.099822,0.696296,0.101667,-0.145973,0.960469,0.589606,0.314124,-0.22637,0.192734,0.0400701,-0.507842,0.124429,0.240788,-0.0592771,0.27009,0.658034,-0.109379,-0.721958,0.686485,0.198703,-0.582333,0.00361822,0.362905,0.279772,-0.222837,1.28011,-0.592046,-0.610186,0.522113,0.320419,-0.133508,-0.187064,0.440818,-0.167209,-0.0318981,0.515649,0.895561,-0.207424,0.759975,0.980239,0.168018,-0.103901,-0.119381,0.0940146,0.778177,-0.334582,-0.0581194,0.34597,-0.445578,-0.228904,-0.118761,-0.0205282,0.145163,0.0408669,0.280918,-0.932181,0.235937,0.0337346,0.220859,-0.328443,-0.222079,-0.236135,-0.464737,0.081436,0.40133,0.282735,-0.714143,-0.253421,0.420769,-0.189356,-0.00959601,0.126194,0.234649,0.547753,-0.0102204,-0.144374,-0.148956,0.381433,-0.0931455,0.12486,-0.334482,0.137729,-0.329282,-0.0715247,-0.843287,-0.172406,-0.301427,-0.329784,-0.182447,-0.134978,0.273332,-0.277307,0.0829973,-0.338304,-0.317583,-0.0481045,0.07711,0.498826,0.311768,-0.019078,0.11943,0.303121,0.305108,-0.355556,-0.192396,-0.393726,0.449195,-0.561245,0.0720658,0.140564,0.477924,0.658862,0.161602,-0.377188,-0.500468,0.262319,-0.193037,0.254017,0.327257,-0.404693,0.800659,-0.759425,-0.19214,0.257431,0.391002,-0.312464,0.371055,0.0724616,-0.315783,0.565409,0.260082,-0.232375,0.0899232,0.0507735,0.316489,-0.584781,-0.130265,-0.588427,0.144971,-0.209787,0.164327,-0.240489,-0.0327855,0.0883173,-0.0561166,-0.051683,0.20284,0.299919,-0.182336,-0.246145,-0.261461,-0.246847,-0.112609,-0.277464,0.282794,0.309994,-0.0084111,-0.499593,-0.186083,-0.202404,0.246704,-0.341111,-0.18869,0.133313,-0.0242163,0.0543852,0.132825,0.153684,-0.179868,0.511442,-0.350134,1.10305,0.0224616,0.169338,0.335252,-0.626772,0.245373,-0.150202,-0.260989,0.671269,0.123362,0.35117,0.15823,-0.427769,-0.493388,-0.487077,-0.111376,0.144108,-0.698782,0.574005,0.150395,-0.844599,0.0269896,0.0517053,0.565571,-0.128253,-0.175643,-0.0907974,-0.497632,0.844944,-0.346167,0.633621,0.213225,-0.120525,0.111577,-0.165408,0.145695,0.081512,-0.0983635,0.0692664,0.336734,-0.130712,-0.516262,0.166139,0.441327,0.148724,1.00215,0.0826147,0.204765,0.422965,0.0740541,0.496475,0.0180519,0.0911,0.33438,-0.0513389,0.0226498,0.224822,0.613306,-0.00658964,0.230238,-0.243335,0.397897,0.235716,-0.759175,-0.478741,-0.358824,0.237191,0.487821,-0.0999017,0.226001,-0.218079,0.817745,0.19873,-0.365669,-0.679693,-0.0271261,-0.37424,0.350462,0.262547,-0.337403,0.166052,0.465963,-0.981087,0.18121,0.0350455,0.945123,-0.1663,0.217349,-0.0283092,0.625511,-0.314168,0.118085,-0.325815,-0.238069,0.157695,0.271315,0.397108,0.520879,-1.26762 +3430.94,0.729722,0.0912059,5,1.70851,0.747985,-0.881538,0.313724,0.487572,-0.0894686,0.2423,0.0929766,0.397406,-0.191377,0.160432,-0.0627215,-0.276598,0.416286,-0.069141,0.386838,0.266947,-0.0516501,-0.846165,-0.0177867,0.00948393,-0.459927,-0.282634,0.369985,-0.679893,0.293172,-0.0185283,0.0922275,0.435445,0.206501,0.821976,-0.374644,-0.220427,0.410117,-0.238499,0.337577,-0.458187,0.161934,0.575488,-0.139244,1.06131,0.286315,-0.102098,-0.812557,-0.429918,-0.187554,-0.673679,0.128409,0.778565,-0.0207636,0.152281,-0.15305,-0.231577,-0.135978,0.71599,-0.332727,0.292601,-0.637833,0.663093,-0.598242,0.321404,0.33098,-0.400119,-0.996861,-0.17677,-0.256184,-0.123985,-0.20924,-0.185085,-0.738387,-0.243301,0.0608837,0.328271,0.126847,0.256306,0.258295,0.555884,0.253,-0.126142,-0.316553,-0.0508719,-0.0412402,0.414438,-0.22036,-0.0240732,-0.110937,0.0867545,-0.390535,-0.143683,-0.558671,-0.110666,0.652916,-0.274409,-0.415563,-0.309642,-0.229507,0.195482,-0.14605,0.112649,0.0434049,-0.402976,-0.290541,-0.0200572,-0.381127,-0.545734,-0.391388,0.239303,-0.629321,0.0631932,0.187521,-0.220159,0.558535,0.110918,0.390724,-0.0483541,0.0514767,-0.403929,0.0752023,0.679263,-0.0226813,-0.624011,-0.168002,-0.161649,-0.20486,-0.239978,0.213069,-0.222458,0.229184,-0.0347515,-0.182994,0.475632,0.00459711,-0.059325,0.469729,-0.129501,0.0772707,-0.13244,-0.320388,0.053186,-0.606934,-0.410205,0.0874008,-0.307017,-0.618212,0.107629,0.0345653,-0.524575,-0.0691281,-0.154896,0.0546765,0.156182,-0.0963342,0.159708,-0.461062,0.0390811,1.02898,-0.461239,0.354374,-0.0859015,-0.429104,0.199943,0.118869,0.717397,0.0382339,-0.121751,-0.383817,-0.540126,-0.0951787,-0.595783,-0.224933,0.591444,0.538648,0.0362547,0.00129991,-0.174695,-0.13484,-0.599524,0.242037,0.141972,0.699197,-0.0504625,-0.368651,-0.117407,-0.453094,-0.0982303,-0.207577,-0.176796,-0.46735,0.459425,-0.203851,-0.1769,-0.246809,0.0547325,-0.0918417,0.383248,0.621149,0.127565,-0.588195,-0.595542,-0.162768,-0.217793,-0.206588,0.121743,-0.134286,0.191158,-0.676098,-0.316258,0.790563,-0.143706,0.0870498,-0.424888,0.135938,-0.18448,0.317565,-0.00250445,-0.260617,-0.778597,-0.39801,0.165932,0.213419,0.387702,-0.326386,0.079402,0.0707609,0.0392725,0.0431265,-1.07424,0.203869,-0.17722,0.445053,-0.731561,-0.001879,-0.230138,-0.187418,-0.353549,0.123111,0.396429,-0.518799,0.439971,-0.380306,-0.278476,0.205097,-0.160693,-0.18822,0.4404,0.428965,0.334887,0.277395,0.105894,-0.556916,-0.443254,-0.791165,0.322915,-0.17332,-0.51405,0.30432,-0.658438,-0.338715,0.21033,0.0404425,-0.0736847,0.452053,0.218905,0.127439,-0.419821,0.285773,-0.0046012,0.0778726,-0.535386,-0.170928,0.341377,-0.0516475,-0.0265619,0.00553173,-0.344444,-0.188636,-0.271954,0.208545,-0.402119,-0.122511,0.140607,0.476246,-0.253309,0.386554,-0.290566,-0.0282125,0.0587791,0.11596,0.338469,0.502388,0.0997103,-0.16253,-0.632169,0.428083,-0.184993,-0.492767,-0.71508,0.0693934,-0.537838,0.121739,0.235036,0.121705,0.15594,0.348862,0.394892,-1.04451 +3425.69,0.861877,0.0912059,4,1.71315,0.757928,-0.877575,0.322633,0.402735,-0.0957209,0.371692,0.0336455,0.426343,-0.198527,0.13884,-0.0957907,-0.313491,0.352682,-0.0920801,0.330271,0.189709,-0.0492222,-0.914167,-0.0186669,0.0143981,-0.510534,-0.337549,0.312354,-0.615198,0.252654,-0.0455173,0.118869,0.4359,0.133305,0.816908,-0.443747,-0.0824983,0.39814,-0.171092,0.32199,-0.561689,0.221341,0.609155,-0.079915,1.13504,0.366814,-0.125822,-0.784519,-0.436378,-0.200718,-0.774208,0.0776723,0.787883,-0.0272519,0.109939,-0.167641,-0.259281,-0.161734,0.715198,-0.365341,0.231105,-0.616058,0.660946,-0.648022,0.390874,0.327018,-0.358488,-1.14454,-0.228552,-0.290305,-0.0119924,-0.140575,-0.278865,-0.607747,-0.246409,0.00512347,0.326767,0.235366,0.276575,0.150221,0.665078,0.304211,-0.140798,-0.267099,-0.0604909,-0.089297,0.447747,-0.186621,0.00364342,-0.0278766,0.0988929,-0.461375,-0.0973763,-0.514073,-0.217327,0.561021,-0.317979,-0.467413,-0.371552,-0.251328,0.151261,-0.0581033,0.0980495,0.0400887,-0.39018,-0.215477,-0.0803309,-0.412708,-0.568273,-0.341384,0.197872,-0.655189,0.0540533,0.216278,-0.307402,0.525156,0.0229689,0.387305,-0.0715903,0.0686526,-0.46292,0.111216,0.74352,-0.0781223,-0.682535,-0.181047,-0.139142,-0.20734,-0.351624,0.127436,-0.220798,0.192003,-0.107037,-0.289773,0.511478,-0.0573244,-0.136403,0.444873,-0.17329,0.0489033,-0.0755298,-0.330087,-0.00111828,-0.56757,-0.426118,0.043238,-0.24912,-0.578935,0.101307,-0.00899613,-0.551723,-0.0778905,-0.0761761,-0.0603401,0.188461,-0.0864101,0.108569,-0.427311,0.0206794,1.00048,-0.609166,0.386848,-0.0585754,-0.391481,0.103891,0.0868541,0.71849,-0.0249984,-0.174844,-0.384883,-0.579579,-0.155164,-0.600714,-0.220215,0.529775,0.557675,0.099043,0.0272011,-0.164037,-0.144001,-0.637813,0.295382,0.131932,0.705904,-0.106671,-0.31773,-0.0530371,-0.342565,-0.10415,-0.153139,-0.163985,-0.461969,0.47281,-0.213512,-0.216757,-0.250306,0.0339954,-0.138307,0.454138,0.59628,0.123578,-0.576443,-0.630204,-0.100812,-0.220831,-0.281807,0.0573632,-0.0807952,0.237098,-0.646058,-0.226321,0.784275,-0.161973,0.164586,-0.415059,0.132423,-0.192161,0.21254,-0.0138476,-0.182553,-0.871303,-0.346047,0.115598,0.263323,0.428816,-0.410026,0.118857,0.184299,0.0563562,0.0268754,-0.974156,0.253365,-0.171243,0.40044,-0.744402,-0.0217268,-0.241277,-0.260017,-0.392792,0.124768,0.399004,-0.496989,0.476017,-0.328774,-0.315331,0.198085,-0.125629,-0.211377,0.512254,0.478745,0.300362,0.27676,0.0944762,-0.576858,-0.449633,-0.790898,0.367062,-0.123354,-0.544193,0.408008,-0.724033,-0.431178,0.212916,0.00522325,-0.0819243,0.382383,0.164626,0.0544824,-0.451919,0.267513,-0.0152796,0.04949,-0.508043,-0.216432,0.365893,-0.0432264,-0.114731,-0.0351171,-0.245146,-0.211031,-0.280965,0.234026,-0.439267,-0.0508526,0.0883574,0.413211,-0.240731,0.41537,-0.41009,-0.0152424,0.0970693,-0.0179169,0.339327,0.53018,0.0891879,-0.0197686,-0.632952,0.433522,-0.136544,-0.48553,-0.58361,0.00662816,-0.580362,0.244675,0.22294,0.125036,0.161373,0.353605,0.401713,-0.784778 +3418.02,0.856944,0.0912059,4,1.60173,0.743597,-1.1169,0.468335,0.554781,-0.224517,-0.157312,-0.359136,0.170089,0.189413,0.637098,-0.245092,-0.00807445,0.678829,0.0941995,0.453775,-0.0166567,-0.0669475,-0.141983,-0.104209,0.596932,-0.439459,-0.602142,0.430619,-0.41847,-0.0366431,-0.157863,-0.0691225,-0.00480723,0.259359,0.780224,-0.447113,-0.176822,0.630714,-0.471154,0.103043,-0.0279323,0.119051,0.744192,0.0606473,0.916901,0.482134,0.374466,-0.46427,-0.197361,0.48663,-0.799611,-0.319846,0.813256,-0.169576,-0.239977,0.0851758,-0.454364,-1.02816,0.599823,-0.216922,-0.110321,-0.571289,0.583574,-0.496529,0.244518,0.94722,-0.427893,0.0657521,-0.044161,-0.433134,0.210803,-0.182715,-0.142604,-0.791623,0.0811744,0.435868,0.459654,-0.113108,0.267062,0.606143,-0.280108,-0.199619,-0.601664,-0.146858,-0.098808,-0.138815,-0.00778529,0.268852,-0.131534,-0.232409,0.0322746,-0.476471,0.078029,-0.512702,0.128081,0.319915,-0.137428,0.164323,-0.399652,-0.179989,0.135691,-0.323112,-0.0385796,-0.00195833,0.128699,0.417048,-0.648988,-0.128165,-0.372049,-0.312483,0.413781,-0.806335,0.321968,0.735605,-0.207704,0.424247,0.243829,0.356317,-0.0625132,0.107422,-0.602735,-0.233282,0.471644,-0.396727,-0.37409,0.0951543,-0.405852,-0.103163,-0.292814,0.877688,0.0804302,-0.193861,-0.126134,-0.173925,-0.278995,0.0611812,-0.194168,0.476627,-0.0499397,-0.212474,0.356268,-0.215012,-0.178899,-0.607285,-0.474884,-0.321989,-0.381845,-0.239977,0.0227432,0.220756,-0.381591,-0.0510243,-0.366738,-0.36199,0.275437,0.210976,0.156278,-0.548268,-0.0150619,0.45323,0.316541,0.0991367,-0.262862,-0.0482677,-0.000348742,0.238734,0.884413,0.56593,0.890668,0.138242,-0.800103,-0.49493,0.0231182,0.22191,0.43831,-0.131725,-0.34774,-0.129129,-0.190522,0.0380443,-0.641926,-0.163986,-0.203731,0.801888,0.535206,-0.544945,0.0896866,0.670207,0.0849644,-0.174617,-0.395181,-0.611271,0.212702,-0.127426,-0.15578,-0.254555,0.337376,-0.727563,0.0533695,0.217348,0.0990818,-0.637054,-0.614335,-0.0971003,0.094533,0.416111,-0.08323,-0.395362,0.156323,-0.529927,-0.726367,0.956598,0.292768,-0.0389229,-0.328846,0.00920674,-0.293847,0.376431,0.136953,0.14919,0.141925,0.00413391,-0.043032,-0.698687,0.110836,-0.798912,-0.462421,-0.386218,-0.00320705,-0.0461055,-0.920081,0.145619,-0.505482,0.210124,0.0789382,0.0757567,-0.178861,-0.303331,-0.390957,0.208865,0.252905,-0.298013,1.04013,-0.586832,-0.42973,0.0472103,-0.158041,0.0504454,0.378631,0.154513,0.178391,0.00880025,0.009439,-0.739995,-0.2147,-0.28991,0.721314,-0.604184,-0.360405,0.638218,-0.650653,0.271716,0.142691,0.00678497,-0.131891,-0.424696,0.0703409,0.0954745,-0.629458,0.383618,0.191823,0.586361,-0.420112,-0.174813,0.173508,-0.305173,-0.669261,0.261948,-0.0354578,-0.175536,0.246489,0.0377775,-0.503894,0.192198,0.247408,0.194421,-0.298845,0.212689,-0.512084,0.121804,-0.153157,0.262553,0.144451,0.29673,-0.0316636,0.559851,-0.475413,0.437048,-0.366192,-0.350824,-0.00965942,-0.311838,-0.209445,-0.685193,-0.314999,0.14006,0.177758,0.374246,0.421614,-1.35585 +3406.58,0.929385,0.0912059,4,1.47138,0.754787,-0.528079,0.261416,0.310615,-0.0705287,0.543689,0.250815,0.142336,0.156249,0.271032,0.0125997,-0.333439,0.781387,0.100087,0.624591,0.375475,0.260772,-0.00537069,-0.101912,0.626833,-0.748065,-0.350642,0.401294,0.207279,-0.153889,-0.133305,0.298905,-0.302246,0.605908,0.946954,-0.292743,-0.101129,0.631427,-0.184195,0.101238,-0.377351,0.596125,0.0517004,-0.208353,1.06395,0.25866,0.266795,-0.241398,-0.183924,-1.07489,-0.462284,0.424728,0.516641,0.368963,0.321,0.884505,0.398381,-0.0305761,0.633399,0.0255823,-0.358262,-0.846548,0.440733,-0.292859,0.331366,0.795288,-0.797835,-1.66208,0.12336,0.338782,-0.152791,0.290485,0.122732,-0.312288,-0.0370563,0.316972,0.599046,-0.28953,0.934044,0.301423,0.57852,0.25944,0.267167,-0.343482,0.995795,-0.840428,0.46168,-0.994043,0.217391,0.193818,-0.146704,-0.0490693,-0.448359,-0.133332,-0.331992,-0.195476,-0.00651897,0.0849411,0.139951,-0.863088,-0.47458,0.0880169,-0.0180771,0.311222,0.341301,-0.640951,-0.192937,0.153911,0.511077,-0.340404,0.0244408,-0.373719,0.164251,0.454526,-0.180842,-0.510152,0.065904,0.761303,-0.0199892,0.16785,0.426546,0.19298,-0.211234,0.0455012,-0.583664,0.11323,-0.508191,-0.679683,-0.185624,-0.191925,0.360009,0.177122,0.220494,-0.170624,0.199822,-0.194852,0.0656742,0.651424,-0.179884,-0.204313,-0.355443,0.219409,0.383177,-0.138085,-0.192957,0.359979,0.362442,-0.378386,0.183324,0.161258,-0.275762,0.187637,0.109422,-0.0617772,-0.637133,-0.25165,0.344425,0.0810969,0.133906,0.345821,-0.195521,-0.514072,0.198321,-0.0332477,0.45757,-0.0017664,0.824778,-0.196255,-1.00807,-0.262682,-0.208785,0.055191,-0.300877,-0.49072,0.00962632,-0.0107385,0.386437,-0.103739,0.415631,-0.376661,-0.221485,-0.0983013,-0.0572161,0.780757,-0.314725,-0.137084,0.151245,-0.846152,-0.28832,-0.26422,-0.331154,-0.0106717,-0.00371692,-0.822394,0.13367,-0.0378595,-0.322467,-0.10834,-0.21006,0.436909,0.0525747,-0.425182,-0.56961,0.0232748,-0.1107,-0.981938,0.119192,0.778296,0.289929,0.395798,-0.332712,0.884343,-0.600441,0.75896,0.0447598,0.0524297,0.467269,-0.229457,-0.512737,0.379171,-0.74473,0.0508896,0.46724,-0.362077,-0.0677816,0.0922375,0.699822,0.720837,-0.435025,0.0114592,0.0502752,-0.310108,0.00159507,0.0207126,-0.47097,0.198791,-0.270236,0.266347,-0.168222,0.422735,-0.323607,0.19683,0.159683,-0.0518011,0.368605,0.0879503,-0.275061,-0.13546,0.138206,-0.0889086,0.322516,0.311327,-0.138882,-0.011361,-0.418114,-0.328136,0.0705617,-0.426266,-0.20812,-0.215675,-0.307858,-0.108838,-0.354478,0.250451,0.445493,1.10696,0.144725,0.300963,0.856756,-0.479251,-0.178196,-0.843038,0.659745,-0.0207415,0.10913,-0.1548,0.140562,-0.180828,-0.395993,-0.240543,-0.357093,0.0319849,-0.009579,-0.295021,-0.100707,-0.208382,0.359904,-0.18162,0.0124409,-0.00106629,0.156632,-0.203115,0.334508,-0.444101,0.168472,-0.596651,0.796144,-0.0258384,0.118427,-0.436156,-0.464775,0.573635,0.0275941,0.252035,-0.069159,0.15985,0.30341,0.399813,0.550826,-0.847044 +3416.88,0.995386,0.0912059,4,1.44846,0.696685,-1.11618,0.48856,0.484011,-0.0298922,0.23259,0.259893,0.608141,0.0825895,0.340732,0.429255,0.0664057,0.203266,-0.0433342,0.923364,0.338216,0.302999,0.0512193,0.501854,0.178668,-0.919861,-0.460401,0.497878,0.199196,-0.239465,-0.0547274,0.368008,-0.298007,0.489785,1.27887,-0.322916,-0.241459,0.585815,-0.083081,-0.292477,-0.456772,0.533941,0.0777594,-0.135577,1.20114,0.446813,0.958823,-0.406727,-0.282653,-0.0696115,-0.286954,0.240727,0.686651,-0.103621,0.0881304,0.236034,0.142319,-0.336374,0.599919,-0.442286,-0.298382,-0.712827,0.623512,-0.248334,0.0957539,1.08376,-0.350713,-1.64575,0.253803,0.298146,-0.215512,-0.165145,0.247864,-0.456426,-0.493432,0.40285,0.788902,0.208043,0.656304,0.635627,0.324208,-0.136293,-0.469174,-0.182889,0.743996,-0.860459,0.481981,-0.761271,0.341409,0.346729,0.152527,-0.263416,-0.0131377,-0.428289,-0.371962,-0.237873,-0.12761,0.055056,-0.292552,-0.2006,-0.412533,0.434559,0.0563469,0.00875014,0.389635,-0.0044263,-0.704365,-0.154609,-0.29918,-0.498995,-0.0963266,-0.0674081,0.465026,0.290145,-0.202881,-0.645289,0.338934,0.575252,0.265285,-0.334305,-0.41699,0.13823,0.580049,-0.0357252,-0.979806,-0.234798,-0.653224,-0.461421,-0.258895,0.0210944,0.308803,-0.0661336,0.690382,-0.261082,-0.169891,0.130038,0.125747,0.185069,0.287911,-0.527347,-0.116925,-0.0378506,0.269703,-0.317945,-0.572802,0.111125,-0.0860836,-0.207002,0.244011,-0.0161351,-0.42773,0.0389404,-0.0616376,-0.00478073,-0.581432,0.639707,0.184781,-0.119066,0.466129,0.406959,0.0339214,0.576184,-0.0745408,-0.066983,0.56176,0.0381708,0.565071,-0.37255,-0.262045,0.105998,0.0339327,-0.0151514,-0.323906,-0.874381,0.00108789,0.180724,0.128344,-0.12234,0.222382,-0.454654,-0.572633,0.347977,0.177762,0.748114,0.437387,-0.378221,0.2122,-0.197989,0.175037,-0.622319,-0.077663,-0.427925,0.299497,-0.16678,-0.0340483,0.274771,0.402759,-0.45983,-0.22425,-0.198742,0.021326,-0.900522,-0.202365,0.204458,0.138395,-0.525832,-0.0923944,-0.134555,0.156129,0.261561,-0.513437,1.00219,0.0561616,0.162526,-0.0946417,-0.220705,-0.154684,-0.159543,0.121034,0.842292,-0.741359,-0.0907134,0.326296,-0.872317,-0.420099,-0.03267,0.0389615,0.667392,-0.572339,-0.0114233,-0.324728,-0.175975,-0.00223626,0.133037,-0.284191,0.374119,-0.132278,0.539125,-0.432926,0.446324,-0.115538,0.14053,0.484364,-0.418265,0.457211,-0.669442,0.0218892,-0.164916,1.08367,0.0310287,0.210107,-0.0692376,-0.657664,0.223191,-0.0709121,-0.474583,0.472311,-0.359562,-0.120688,0.475404,-0.773201,-0.499548,-0.615729,-0.100126,-0.157138,0.630145,0.437178,-0.0255892,0.377471,-0.0330277,0.0114752,-0.877621,0.0761563,-0.321401,-0.354585,-0.362269,-0.175615,0.125585,0.310587,-0.445553,-0.197559,-0.148697,0.167391,-0.0316629,-0.0323312,-0.121415,-0.135452,-0.0152687,0.0354171,-0.205034,0.192276,-0.0240936,0.0794751,-0.188911,0.367722,0.317087,-0.184489,-0.0469634,-0.250869,-0.227271,0.027734,-0.345857,-0.324628,0.480766,-0.235601,0.136275,0.293187,0.369155,0.541467,-1.25945 +3418.41,0.997386,0.0912059,4,1.44618,0.66583,-1.11635,0.525346,0.603114,-0.0815818,0.0527816,0.268921,0.534947,0.10388,0.386198,0.411145,0.0513047,0.263504,-0.0184745,0.892739,0.495196,0.259698,0.0794524,0.537084,0.223445,-1.02727,-0.445039,0.569431,0.183217,-0.293183,-0.0750813,0.331146,-0.361019,0.414503,1.17033,-0.377502,-0.351208,0.669351,0.212171,-0.283894,-0.569891,0.459397,0.289669,-0.0176122,1.26214,0.406987,0.853195,-0.181586,-0.374804,-0.113552,-0.226387,0.211915,0.757086,0.0485773,0.124123,0.330731,0.0260404,-0.263213,0.456447,-0.487897,-0.160995,-0.723837,0.625091,-0.432776,0.0687601,1.13811,-0.444654,-1.5222,0.276172,0.214217,-0.168896,-0.1275,0.126989,-0.393037,-0.449652,0.493585,0.823673,0.179318,0.360599,0.42382,0.283978,-0.222829,-0.414278,-0.228843,0.635115,-0.787357,0.41619,-0.83772,0.358898,0.391207,0.26822,-0.377416,0.0155262,-0.36274,-0.271021,-0.0812483,-0.176996,0.080466,-0.138191,-0.307311,-0.291621,0.29949,0.0241653,0.00479479,0.268576,0.0559863,-0.796055,0.0814004,-0.272484,-0.296924,-0.0887153,-0.101555,0.403883,0.377815,-0.165135,-0.571052,0.48741,0.526572,0.358246,-0.309141,-0.315749,0.0989319,0.611513,0.037403,-1.12984,-0.46844,-0.688227,-0.467821,-0.204994,0.029573,0.508226,-0.0637449,0.736202,-0.183322,-0.264134,0.018759,-0.0181531,0.140575,0.373806,-0.405141,-0.107578,-0.0348744,0.396996,-0.151829,-0.544271,0.0447696,-0.125621,-0.174869,0.315474,0.0984152,-0.374572,0.232962,-0.276827,-0.0642297,-0.712711,0.556212,0.269953,-0.144747,0.449855,0.442321,-0.0841526,0.476196,-0.0899672,0.022757,0.278182,0.0488482,0.628394,-0.343508,-0.131623,0.228892,0.127869,-0.0787295,-0.299053,-0.8921,0.0407184,0.156626,0.178183,-0.251998,0.147886,-0.504576,-0.440145,0.366329,0.0368335,0.557564,0.549428,-0.387262,-0.0271014,-0.135111,-0.0189658,-0.506569,-0.0430897,-0.513717,0.111722,-0.199276,0.0176413,0.283243,0.221683,-0.542265,-0.274923,-0.136708,0.0376503,-0.808478,-0.212108,0.207736,0.0534528,-0.493424,-0.229828,0.0592278,-0.0698508,0.133638,-0.502251,0.931912,0.20082,0.0792397,0.0201372,-0.247614,-0.130091,-0.0726438,0.120997,0.84466,-0.728517,-0.121355,0.21654,-0.996873,-0.415373,0.189068,-0.0355194,0.762152,-0.650747,0.0086634,-0.353953,-0.294724,-0.00984223,0.0362717,-0.241294,0.399573,-0.38233,0.47306,-0.285689,0.404757,0.0156775,0.0938858,0.401608,-0.43102,0.376564,-0.662049,0.102612,-0.142,1.03476,0.0691713,0.232497,-0.105491,-0.670155,0.150458,0.0214777,-0.424625,0.593469,-0.461067,-0.0419851,0.543248,-0.826548,-0.450494,-0.661957,-0.120055,-0.320023,0.666631,0.25236,0.170015,0.579349,0.111729,0.0179053,-0.826494,0.0736955,-0.0992042,-0.379254,-0.15911,-0.128428,0.124227,0.529923,-0.350423,-0.325432,-0.16562,0.208144,0.00733861,-0.130359,-0.140276,-0.0531357,-0.0485931,0.0248026,-0.0403305,0.0525052,0.0997509,-0.0305706,-0.130182,0.316336,0.26669,-0.161508,-0.135262,-0.317927,-0.310527,0.0491418,-0.371033,-0.179825,0.314758,-0.230576,0.148986,0.290162,0.385987,0.538667,-1.62446 +3428.66,0.558524,0.0912059,4,1.44319,0.826523,-1.06891,0.505246,0.522111,-0.134698,-0.0150289,0.189611,-0.0656251,0.348363,0.136436,0.257695,-0.101606,0.635831,-0.279856,1.17323,0.101799,0.277744,0.290113,0.114195,0.133402,-1.05267,-0.475973,0.510051,0.306599,-0.244372,0.0576993,0.405112,-0.245777,0.5351,1.064,-0.299617,0.0728369,0.474592,-0.137814,-0.0763575,-0.481624,0.382,0.175334,-0.011199,1.33623,0.351075,0.79627,-0.365617,0.133094,0.533972,-0.565376,0.677511,0.281115,0.404492,0.0358325,0.626127,0.0871966,-0.3547,0.218094,-0.389072,-0.334118,-1.11261,0.503096,-0.546974,0.0995981,1.23383,-0.379087,-1.27216,0.0783698,0.148689,0.03262,-0.27393,0.376863,-0.650379,-0.627194,0.164497,0.646661,0.073548,0.646448,0.653563,0.534153,0.124624,-0.258033,-0.187635,0.419875,-0.767481,0.358429,-0.371741,0.665888,0.0970459,-0.147943,-0.411251,0.201147,-0.248391,-0.0788348,-0.209749,-0.230288,-0.336687,0.00437751,0.119897,-0.585829,-0.304852,-0.110053,-0.0594445,0.0572024,-0.240487,-0.912902,0.159192,0.263762,-0.254234,0.00958381,-0.390777,0.27726,0.660904,0.0985859,-0.44907,0.251593,0.594674,0.249072,0.193196,-0.220898,0.0378757,0.78264,-0.188393,-0.929836,-0.286547,-0.657129,0.0742005,-0.488234,0.148268,0.320238,-0.127938,0.467688,-0.113106,-0.0356244,0.0752385,0.515208,-0.0374422,-0.0144282,-0.521378,-0.155347,-0.2183,0.63731,0.0500328,-0.731341,0.161009,0.145856,-0.292312,0.326067,0.018984,-0.169407,0.218813,-0.0771912,0.131473,-0.37271,-0.00432869,-0.0338989,-0.262986,0.658371,0.426236,-0.126999,0.310856,-0.326814,-0.0988547,0.144549,-0.0807371,0.703816,-0.392667,-0.140974,-0.149335,0.293299,-0.0312586,-0.400495,-0.471636,0.185059,0.0730256,0.254639,-0.0608405,-0.0717341,-0.361078,-0.622804,0.60745,-0.0709366,0.359882,0.413601,0.241035,0.24444,0.0254587,0.359425,-0.436612,0.0260958,-0.65308,-0.100064,-0.645494,-0.212448,-0.0455024,-0.0675146,-0.565997,-0.291735,0.24166,-0.27113,-0.646501,-0.331631,0.648444,-0.246735,-0.222764,-0.218206,0.380621,-0.0801459,0.101569,-0.151316,0.795998,-0.0401642,0.0774549,-0.293713,-0.144307,-0.0440604,0.0205906,0.284736,0.805711,-0.367707,0.0876873,0.536372,-0.876751,-0.465616,-0.32683,0.206197,0.543836,-1.10913,0.107029,-0.257081,-0.222792,-0.0987897,0.358387,-0.394671,0.483271,0.0112943,0.247827,-0.073914,0.316514,-0.160157,0.427979,0.00858685,-0.386319,0.423947,-0.502101,0.251339,-0.113421,0.565884,-0.226533,0.0897602,-0.409692,-0.371764,0.0992404,0.0919908,-0.489006,0.709788,-0.344067,-0.350289,0.344026,-0.576978,-0.0133966,-0.542639,-0.195362,-0.0828264,0.796377,0.477689,0.463586,0.901591,-0.196444,-0.0491418,-0.428926,-0.289032,0.218202,-0.527566,0.0325955,-0.633198,0.118658,0.0499687,0.0203428,-0.182449,0.158539,0.628458,-0.058735,-0.317236,-0.214685,-0.150924,0.134182,-0.300246,-0.0953641,-0.363083,0.186822,0.054378,-0.062172,0.119442,0.214038,-0.201396,0.252934,-0.109942,-0.360504,0.10387,-0.249647,-0.181234,0.222925,-0.00732528,0.13168,0.232543,0.362877,0.482227,-1.63521 +3410.36,0.448871,0.0912059,4,1.57019,0.985244,-0.431483,0.267542,0.670714,-0.142321,0.494924,0.177561,0.535695,0.461159,0.695683,0.0683694,0.206227,0.402705,-0.28479,1.10203,-0.0409338,0.44475,-0.00281766,0.121585,0.239651,-0.407712,0.0103252,0.529982,0.261987,-0.455587,0.120477,0.293236,-0.373658,0.0378967,0.475608,-0.286854,0.549357,0.664542,-0.355666,-0.216487,-0.412556,0.834663,0.194775,-0.412539,0.845529,0.0574777,-0.232698,-0.647584,-0.56109,0.211231,-0.523979,-0.0364955,0.325776,-0.281772,0.0547137,-0.182133,-0.0224255,-0.770261,0.25789,-0.435371,-0.385843,-0.468455,0.0178315,-0.488258,-0.154138,0.8565,-1.03364,-0.63633,0.608246,0.214905,-0.182697,0.223615,-0.288001,-0.619142,0.0502854,0.123685,0.461628,0.56696,0.157429,0.571671,-0.225421,-0.362223,-0.109525,-0.289868,0.226211,-0.142047,-0.263326,-0.290757,-0.161743,-0.0840335,0.063555,-0.354192,-0.0150039,-0.488964,0.202353,0.260099,0.118309,-0.218934,-0.253049,-0.142847,-0.264711,0.46275,-0.0136617,0.00327384,0.184704,0.236102,-0.0663611,-0.22386,-0.358959,-0.261221,-3.8141e-05,-0.224685,-0.126435,0.396856,-0.175263,-0.206779,-0.00549116,0.532849,0.260781,0.0723852,-0.553695,-0.00926146,0.15331,-0.288521,-0.847226,-0.722184,-0.0726532,-0.403368,0.0307059,0.184133,0.125727,-0.0608475,-0.0869899,-0.608078,0.089149,-0.00335476,0.273477,0.305544,0.227506,0.162621,0.138217,0.0796582,0.00525172,-0.496832,-0.0034458,-0.337922,-0.388866,-0.668056,0.0729553,0.649122,0.29239,0.219415,-0.256472,0.0339011,-0.88281,-0.278495,0.0326944,0.142315,0.354164,-0.514818,-0.00504099,0.0127117,-0.476296,0.591689,0.532134,-0.028551,0.800619,-0.137253,-0.709328,0.208267,-0.586664,-0.0253855,-0.131516,0.572934,-0.0785316,-0.0191126,0.0539533,0.694166,0.166469,-0.0169097,0.0708901,-0.0996001,0.498439,0.637931,-0.437368,0.00137466,-0.24379,0.203671,0.101799,-0.00850268,-0.303039,-0.808272,0.257494,0.0254969,0.0024342,-0.183434,-0.621091,-0.192309,-0.450657,0.275378,0.338672,-0.558491,-0.258986,-0.349141,-0.348628,-0.420771,0.579461,-0.261325,0.0227312,-0.19645,-0.586155,1.20437,0.427235,-0.216378,-0.14295,-0.522275,0.171101,0.326923,-0.0530392,0.271783,-0.434175,-0.216273,0.087549,0.297084,-0.240923,-0.94734,-0.839185,0.293811,0.252246,0.558245,-0.558855,-0.710897,-0.546332,-0.261207,-0.123411,-0.0010038,-0.355324,-0.244153,-0.368885,0.703843,-0.213273,0.024824,0.560816,-0.736751,-0.106429,-0.126525,0.0255055,0.46846,0.60003,0.627379,0.233,0.0205667,-0.327725,-0.699648,0.168229,-0.0876578,0.615537,-0.0643901,-0.51943,0.0359589,-0.697813,0.333348,-0.0778592,-0.0880092,-0.0691804,0.620416,-0.191111,0.399071,0.333681,0.463239,0.565871,0.0169712,-0.527083,-0.316981,-0.0642165,-0.422583,0.259845,-0.16193,0.496108,-0.421432,0.146925,0.51378,0.644586,-0.594233,-0.400205,-0.1695,-0.333689,-0.119623,0.221461,0.317126,-0.274069,0.137081,0.396675,0.0288891,0.37215,-0.395041,0.324034,0.683308,0.000161431,-0.620044,0.596553,-0.499471,-0.0147678,0.00444508,-0.701855,0.136409,0.24253,0.369336,0.492473,-2.38974 +3414.64,0.983323,0.0912059,4,1.63619,0.959379,-0.409678,0.26019,0.631228,-0.24222,0.485887,-0.0395578,0.964882,0.246734,0.51423,0.113881,0.336921,0.168911,-0.14546,1.3236,0.00068684,0.457546,0.110782,-0.0461877,0.117129,-0.462967,-0.197698,0.495683,0.0369828,-0.453483,0.110709,0.254536,-0.223226,0.0810473,0.623488,-0.421943,0.314627,0.697869,-0.175765,-0.218751,-0.437106,0.659712,0.378494,-0.662403,0.84881,0.130797,-0.114468,-0.760056,-0.550468,0.581254,-0.572163,-0.166519,0.0675357,-0.370286,0.0201516,-0.399876,0.0609591,-0.723446,0.303112,-0.250939,-0.4618,-0.818716,-0.0775015,-0.401186,-0.32308,0.736152,-0.97091,-0.868549,0.560646,0.109918,-0.0344003,0.137605,-0.216836,-0.762608,-0.134037,0.355956,0.700343,0.312715,0.105494,0.462283,-0.225553,-0.741901,-0.341187,-0.58631,0.202752,-0.433874,-0.146735,-0.246804,0.138909,0.0565786,-0.191046,-0.609701,0.128708,-0.298914,0.117714,0.171605,-0.194177,-0.601008,-0.408719,-0.334634,-0.131061,0.565816,0.276353,0.00942331,0.164837,-0.0579718,-0.305404,-0.202726,-0.182469,-0.0885668,0.273067,-0.557805,-0.0318316,0.338157,-0.171582,-0.0792535,-0.176374,0.429961,0.246349,-0.449373,-0.539043,0.0567774,0.263925,0.0733491,-0.645846,-0.517889,-0.479086,-0.525276,-0.127676,0.209477,0.184806,-0.325575,0.0273622,-0.481984,0.314823,-0.0487443,0.367538,0.408146,0.128713,-0.00245111,0.165122,0.0237723,-0.0430833,-0.41763,-0.0766015,-0.315972,-0.708819,-0.539102,-0.041071,0.759085,0.120951,0.304559,-0.282036,-0.224665,-0.597323,-0.195925,-0.158515,-0.0495236,0.347823,-0.59714,-0.327772,0.360158,-0.25782,0.328375,0.706026,-0.152382,1.12409,-0.202663,-0.427249,0.221365,-0.519525,-0.201201,0.0350791,0.74969,-0.0601569,-0.115823,-0.000683764,0.427081,0.0811893,-0.0993654,-0.038749,0.0645605,0.456832,0.72651,-0.383992,0.0297851,-0.384725,0.218126,-0.0534865,-0.359015,-0.713527,-0.834019,0.308076,-0.0597412,-0.093729,-0.227892,-0.508547,-0.242409,-0.342635,0.183845,0.212391,-0.424767,-0.330207,-0.06524,-0.370432,-0.022718,0.556326,-0.364941,0.197233,0.279369,-0.301721,1.1543,0.769644,-0.387118,0.080939,-0.705597,0.0530956,-0.231021,-0.00130552,0.270934,-0.243773,-0.286475,-0.00761124,0.0664037,-0.324596,-0.700331,-0.655881,0.361359,-0.0590006,0.450643,-0.292332,-0.685671,-0.523011,-0.160112,-0.23737,0.0949215,-0.266346,0.0765634,-0.209804,0.577308,-0.447405,0.0375718,0.734763,-0.622722,-0.0984363,0.0367253,-0.102995,0.416548,0.689142,0.0464809,0.223057,0.135514,-0.364855,-0.693998,0.232836,0.0553546,0.615426,0.0256437,-0.216969,0.211195,-0.545085,0.00076296,-0.122601,-0.0622281,0.0292749,0.38829,-0.275861,0.197495,0.373694,0.574166,0.540433,0.321999,-0.338994,0.0707885,-0.0518494,-0.674322,-0.152666,-0.11318,0.535756,-0.176079,0.18272,0.61095,0.517114,-0.563479,-0.2809,-0.187862,-0.386843,-0.0991326,0.189451,0.767474,-0.360736,0.316672,0.0843386,-0.0108101,0.385694,0.166501,0.187476,0.824923,0.130272,-0.318113,0.43385,-0.264527,-0.105086,0.197781,-0.78724,0.140994,0.190195,0.375492,0.436113,-2.12644 +3467.85,0.965599,0.0912059,4,1.6107,0.945231,-0.154971,0.0822011,0.258094,0.00184866,-0.13327,0.434954,-0.144115,0.296192,-0.236497,-0.167433,-0.0187705,0.406018,-0.0631221,0.983919,0.328135,-0.286913,0.281251,0.0607836,-0.0342469,-0.524124,-0.764767,0.304742,-0.297204,0.35337,0.00268179,0.316893,-0.167209,0.278117,0.889943,-0.32073,0.151574,0.155901,-0.545573,-0.30087,-0.317463,-0.0832042,0.108112,-0.0732826,0.710082,0.278392,0.441835,-0.749769,0.0139537,-0.599732,-0.851464,0.129252,0.297187,0.107703,0.0276427,0.418478,-0.167266,-0.572704,0.743912,-0.11096,0.0641551,-1.03553,0.217157,-0.679704,0.0383006,0.657132,-0.881125,-1.01269,-0.545648,0.176988,-0.0601103,-0.0801378,0.394299,0.0893846,0.242249,0.198194,0.29384,-0.258002,0.762606,0.334178,0.641678,0.498248,0.00897306,0.136418,0.212804,0.115674,0.128198,-0.219325,-0.141581,-0.11104,0.155462,0.280765,-0.152353,-0.0860674,-0.0348371,-0.173451,0.148438,0.386363,0.330733,-0.0483698,0.120888,-0.781081,-0.162769,0.236771,0.190255,-0.0644363,-0.538742,-0.352484,0.0793516,-0.292801,0.0974096,-0.0672882,0.330623,0.427279,0.0570979,-0.323445,0.338091,0.382639,-0.396788,0.282239,0.156525,0.110519,0.0469108,0.0945971,-0.374718,0.24607,0.196477,0.240338,-0.083646,0.0329736,0.263803,0.458705,0.299512,-0.046519,-0.184824,-0.070024,-0.154067,0.479649,-0.266782,-0.227718,-0.213821,-0.0481439,0.135118,-0.534614,-0.43813,-0.219781,0.445442,-0.134816,0.0818405,-0.480044,-0.0053435,0.0950649,0.0508325,-0.0652691,0.21632,0.388301,0.284797,-0.0712487,0.00851911,0.900417,0.547122,-0.374391,0.132816,-0.085678,-0.482876,-0.203599,-0.0976596,-0.0226642,0.370826,0.00787914,0.229002,-0.224993,-0.428705,-0.7058,0.200045,0.0636786,0.0976205,-0.677803,-0.332005,-0.0101437,-0.299276,-0.160438,-0.0196156,0.714382,0.390189,-0.237869,0.507231,-0.160772,-0.0526341,0.148574,0.376365,0.318122,0.140143,-0.441581,0.141234,0.364617,0.390927,-0.511122,0.305109,0.0378562,0.0883554,-0.519906,-0.662862,0.226385,-0.140623,-0.421613,-0.102219,0.208278,-0.105573,-0.230924,-0.479577,0.906856,-0.611037,0.470411,-0.0931027,0.299875,0.0822071,0.300455,-0.271274,0.150487,-0.12037,0.188752,0.577597,-0.483234,-0.0461051,-0.152107,0.399086,-0.0315626,-0.373833,0.152972,-0.315848,0.102329,0.485706,0.0711975,0.154354,0.0546696,-0.0760715,-0.437794,-0.189314,0.437346,0.38553,0.217943,0.349128,-0.165743,0.0808062,-0.0631029,0.224828,-0.322082,0.148399,0.231639,0.665941,0.263234,0.205202,0.206827,-0.153677,-0.771776,0.296154,-0.319133,-0.0769816,0.439182,-0.256267,-0.230192,0.248704,-0.145544,0.0459683,0.181956,0.288418,0.108632,0.142391,-0.41598,-0.302359,-0.413368,0.160492,0.0594501,-0.20312,0.143777,-0.280283,0.103561,-0.386701,0.0065396,-0.0605438,-0.248448,-0.345625,0.313192,0.0157683,-0.0227122,-0.0638321,0.202835,-0.0785947,-0.387443,0.125241,0.037285,0.0238039,-0.0577558,0.0436368,-0.188546,-0.140897,-0.331997,-0.0287919,-0.210201,-0.18178,0.386577,-0.151483,-0.226745,0.685459,0.105537,0.255786,0.324864,0.505753,-0.914238 +3461.67,0.964061,0.0912059,4,1.5558,0.890339,-0.410189,0.0977025,0.791409,-0.107955,0.0612477,-0.0767625,0.89376,-0.0940498,-0.129448,-0.000115641,-0.299329,0.724427,-0.296489,0.748921,0.307236,0.0622888,0.210571,-0.105757,-0.157689,-0.61593,-0.32698,0.249751,0.138185,-0.0373757,0.217277,0.334051,0.143896,0.0619028,0.862369,-0.229669,0.330204,0.262725,0.166332,-0.124416,-0.288939,0.159416,0.607,-0.218947,1.12674,0.468704,0.0914051,-0.360907,0.348448,-0.0869027,-0.602676,-0.572684,0.348745,0.210501,-0.14377,-0.532473,0.304215,-0.108228,1.08896,-0.223376,0.122438,-1.26968,0.661484,-0.456093,-0.267456,0.724977,-0.449352,-0.980721,-0.486139,-0.513665,0.0581552,0.054922,0.354059,-0.229546,-0.0158845,0.533942,0.285417,-0.486562,0.167722,0.0297152,0.415642,-0.199524,-0.305335,-0.0360232,0.360693,-0.830978,0.201631,0.0772898,-0.224261,-0.000930952,0.282129,-0.342518,0.15552,-0.674265,0.0665254,0.190413,0.127037,0.11918,0.224588,0.124951,-0.239201,-0.1652,-0.01235,0.161839,-0.0232209,0.163707,-0.343581,-0.599633,-0.0256877,-0.0908134,-0.117712,0.0783659,0.20281,1.07133,0.386231,-0.0820326,-0.140287,0.484911,0.309416,-0.277742,-0.361643,0.00233205,0.227041,-0.20366,-0.15693,-0.181582,-0.739524,-0.361182,-0.320234,0.128609,-0.0762751,-0.00678897,0.527457,-0.595206,0.409077,-0.37265,0.621087,0.702893,-0.226944,-0.222066,-0.0412519,-0.10261,0.222448,-0.257436,0.341171,-0.0929515,-0.015036,-0.364896,0.532286,0.497371,0.0521389,0.124725,-0.24219,0.0622914,-0.481017,0.137099,-0.0249279,-0.287584,0.103685,0.264448,-0.107431,0.151197,-0.350273,-0.0107237,0.341765,0.37481,0.604637,0.0116932,0.10992,0.238736,0.00104704,-0.0493386,-0.318473,0.0802448,0.119633,0.131611,-0.0404146,0.088531,-0.0149689,-0.196211,-0.384837,0.37499,0.0164873,0.723981,0.271304,-0.0897023,-0.196213,0.219614,-0.143714,0.171854,-0.4715,0.0478816,0.0254536,0.388455,-0.342129,0.00786856,0.0907761,-0.330968,0.0562945,-0.0500898,0.052108,-0.166432,-0.163638,0.0149717,-0.0894614,0.0102709,-0.181088,-0.375962,-0.337076,0.244932,0.0543351,0.790818,0.324174,-0.233303,0.509308,-0.247055,-0.0528833,0.118793,-0.286695,0.535016,-0.0187003,-0.146887,0.0583775,0.144022,0.0574105,-0.703971,-0.0211402,0.26712,-0.212752,0.496536,-0.261677,-0.635136,0.164255,-0.166387,-0.508784,0.198049,0.275054,-0.0997506,-0.00319442,0.627257,-0.341535,-0.0923557,0.365497,-0.975913,0.0680804,0.161339,-0.3507,-0.0640445,0.312266,0.406669,0.563624,-0.0164864,0.273029,-0.695975,-0.191783,-0.286413,0.00524569,0.17175,-0.143699,0.225102,-0.0103404,0.0801641,-0.193952,0.0459389,0.177627,0.40452,-0.0733397,0.00392928,-0.0567799,-0.0735665,-0.115294,0.428625,0.183424,0.0259449,-0.0712849,-0.37327,-0.400742,0.0171409,-0.311698,-0.921213,0.186038,0.108216,0.116627,0.02817,-0.374665,0.352717,0.297575,0.122329,-0.00341297,-0.232598,-0.227818,0.337474,0.109824,-0.120757,-0.0361076,-0.441002,-0.0913806,0.551734,-0.142853,-0.25454,-0.142888,-0.0966981,0.330137,0.226998,0.16035,0.0816476,0.178393,0.28574,0.422366,-2.49573 +3456.5,0.988087,0.0912059,4,1.54223,1.09899,-0.254156,0.0204269,0.23959,-0.239933,0.281249,0.611527,-0.333091,0.616485,-0.0242879,-0.0891355,0.554742,0.538032,0.169747,1.1595,-0.148367,0.320288,0.301044,-0.0789108,-0.707264,-1.14313,-0.751717,0.256966,-0.200972,0.206506,0.00108262,0.383966,-0.527912,0.266389,0.551714,-0.774779,-0.144869,0.11197,0.146694,-0.256904,-0.29158,0.521515,0.326101,-0.205131,0.727245,0.373405,0.0479255,-0.639446,-0.136223,-0.298249,-0.247916,0.372701,0.406976,-0.168069,0.317585,0.0226476,-0.0493586,-0.671929,0.67445,-0.0408342,-0.0760964,-0.411264,0.677391,-0.289865,0.484941,0.889979,-0.808991,-1.30699,0.298639,0.875273,-0.0928179,0.109078,-0.383427,-0.214918,0.0786054,-0.259583,0.270011,0.127875,0.694554,0.643328,-0.247626,-0.0634946,-0.0612143,0.315719,0.390005,0.340844,-0.0371086,-0.188981,0.220037,0.0771154,-0.109509,0.384036,-0.00339824,-0.052017,0.329216,0.101476,0.187451,-0.3214,0.0323463,-0.562956,0.321261,-0.281517,0.256221,0.275815,-0.150918,-0.100157,-0.32323,-0.0468281,0.266178,-0.642979,0.4811,-0.259556,0.276421,-0.156535,-0.0513233,0.0793963,0.443269,0.507158,-0.353636,-0.0590221,0.0671703,-0.118361,-0.11619,-0.155504,-0.816466,0.189757,0.612826,0.225898,-0.117153,-2.69203e-05,0.487238,0.247803,0.0549202,-0.157127,-0.391692,-0.143492,-0.367131,0.523257,-0.166552,0.0590081,-0.108664,0.0177081,0.686976,-0.470558,-0.770976,-0.113639,0.0941508,-0.449856,-0.35264,-0.0677575,-0.31485,0.417416,-0.0919471,-0.168957,0.38724,0.248821,0.0435273,0.242092,0.0255277,0.264752,0.140701,-0.0813094,0.311995,-0.00832409,0.076246,-0.347085,0.474978,-0.0619098,-0.38947,0.253245,0.172262,0.0647779,0.101559,0.0246816,0.139435,-0.136722,0.108653,-0.356907,-0.381399,0.418928,-0.217242,-0.654567,0.197537,0.553805,-0.317113,0.26569,0.358608,-0.117707,-0.00630639,0.143581,0.460756,-0.205,0.0916474,-0.921679,-0.0974119,0.0812697,0.139736,-0.525155,-0.12152,0.0636251,0.0134055,-0.0630321,-0.535001,0.145171,-0.157087,-0.311783,0.383568,0.38231,0.286846,-0.299795,-0.78184,0.842483,0.0455175,0.585989,-0.262801,-0.160393,0.396163,-0.00914934,0.13777,-0.289693,-0.552757,0.403489,0.052433,-0.383618,-0.0576602,0.0285987,0.153107,-0.0815787,-0.370137,0.472476,-0.427022,-0.158963,0.165474,0.213917,0.131558,-0.0352864,-0.575198,-0.358304,-0.377477,-0.00303537,0.335678,0.31336,0.548637,0.130422,-0.0357901,-0.267506,0.482034,0.0664519,0.486456,-0.0569511,0.427971,0.0273692,-0.415138,-0.144349,0.0944172,-0.355579,0.625344,-0.322554,-0.231719,0.199712,-0.0479085,0.152867,0.126586,-0.0932203,-0.27119,-0.283547,0.387822,0.586214,0.0934328,0.409139,0.0709044,-0.269462,0.0887932,0.124944,-0.210169,-0.167233,0.168798,0.0770786,-0.0794058,0.204003,0.0306513,-0.120961,0.205447,0.0814101,-0.077144,-0.46703,-0.408228,0.0124778,0.505316,0.708198,0.133748,0.335578,-0.189008,-0.135517,0.0172236,0.415086,0.0383611,0.0242998,-0.0551041,-0.163889,0.134738,0.18864,-0.245472,0.0841373,-0.127507,0.0877335,0.277209,0.296198,0.526507,-1.02196 +3437.35,0.928012,0.0912059,4,1.58437,1.09478,-0.402895,-0.0711459,-0.0237615,-0.13949,-0.0378715,0.190288,0.239991,0.0478841,-0.370383,-0.343525,0.505992,0.0601081,0.142545,0.810513,-0.0864119,-0.167668,-0.212904,-0.433352,-0.822364,-0.695933,-0.437824,-0.160792,0.337963,-0.0309296,0.0366172,0.110704,-0.475184,-0.0230993,0.590034,0.0537418,-0.347896,0.0720509,-0.292804,0.0240191,-0.0539957,0.31377,0.185998,-0.280233,1.03712,0.926222,-0.0749332,-0.0157139,-0.217267,-0.100952,-0.616297,-0.0808111,0.151815,-0.131151,0.426583,0.363278,0.561335,-0.432958,0.709674,0.0259428,-0.124031,-0.352924,0.407073,-0.0845901,0.215038,0.813772,-0.364682,-0.862889,0.360154,0.123883,-0.853084,0.419204,-0.371883,-0.11525,-0.169047,0.296531,0.564217,0.131186,0.0817068,0.585122,-0.380061,0.0649268,-0.168553,0.363963,0.237825,0.0896654,0.184362,-0.303906,-0.307954,-0.352481,0.0823906,0.163236,0.103949,-0.496668,-0.157542,0.285701,-0.226976,-0.0511919,0.0135945,-0.161117,-0.141693,-0.252342,0.060161,0.635511,-0.38482,-0.0692574,-0.166655,-0.379375,0.00428658,-0.560543,0.320104,-0.0343652,0.375044,0.492319,0.209515,0.153598,0.34765,0.446149,-0.0968579,0.122445,-0.362717,0.314727,0.0158469,0.0468056,-0.384993,-0.261286,0.363822,-0.0724362,-0.471209,0.0983723,0.360607,-0.235142,-0.558526,-0.0883868,-0.0380773,0.330139,-0.588975,0.658181,0.0895842,0.0281346,-0.234638,0.279615,0.516102,-0.533229,-0.437966,-0.253379,0.0564863,-0.508668,0.203621,0.560521,0.197392,-0.0436628,-0.0881736,-0.220103,-0.0457291,-0.469182,0.162615,0.242774,0.422235,0.103658,0.441141,0.276714,0.142053,-0.475928,0.0594434,-0.140439,0.774238,0.413578,-0.0375381,0.0409182,0.18619,-0.338641,-0.459713,0.118518,0.186992,0.159844,0.0857365,-0.00228143,-0.495615,-0.165227,-0.300411,-0.58174,0.319632,0.748305,0.167582,0.27468,0.241562,-0.328794,-0.512574,0.231152,0.237802,0.0145052,0.530125,-1.18764,-0.387143,-0.0543383,-0.628126,-0.561026,-0.328692,0.210198,0.31699,0.0347674,-0.428208,-0.285957,-0.227264,-0.048256,0.0954992,-0.0290337,-0.238016,0.257081,-0.449894,0.878184,0.166488,-0.110677,0.319312,-0.224611,0.330336,-0.146029,0.148379,0.158156,-0.0227218,-0.0153149,-0.122593,-0.721291,-0.298763,-0.530467,-0.111969,-0.17271,-0.224188,0.40681,0.0276969,-0.404645,0.128152,-0.480386,-0.0975888,0.254774,-0.306896,0.504322,-0.24663,0.48171,-0.11303,0.222877,0.59703,-0.398418,0.0794392,-0.190533,-0.141395,0.176482,0.286394,0.1508,0.403918,-0.187935,-0.134613,0.0171262,-0.288646,-0.336307,0.377993,-0.52742,-0.224184,0.015294,-0.0738278,0.0285482,-0.485092,0.0152537,-0.380904,0.044875,0.177986,0.240681,0.162316,0.0802326,0.161976,0.382674,0.545365,0.14181,0.167652,-0.224053,-0.327314,0.428003,-0.00582219,-0.225654,-0.193171,0.0641658,0.159076,-0.273582,-0.46947,-0.627188,-0.462016,-0.452279,0.76358,0.611922,-0.457294,0.0185713,0.177971,0.15345,0.428651,0.213238,0.398516,-0.0801772,0.0973579,0.249121,-0.0713082,0.00303466,-0.154051,0.196343,-0.0290008,0.123547,0.136583,0.351493,0.369571,0.0417744 +3415.56,0.703173,0.0912059,4,1.62097,1.06243,-0.353163,-0.0419622,0.210516,-0.143561,-0.141536,0.315638,0.464888,-0.139687,-0.172748,-0.489145,0.623138,0.367932,0.169062,1.06578,-0.0737278,-0.239302,-0.223782,-0.365266,-0.972954,-0.62892,-0.433646,-0.142987,0.281117,0.0571004,-0.0736699,0.188405,-0.464956,-0.0979761,0.625657,0.166955,-0.481434,-0.154393,-0.249399,-0.179333,0.14882,0.0378298,0.146218,-0.248293,1.03023,0.820645,-0.0421291,-0.102868,-0.259314,-0.235541,-0.686563,0.143944,0.274198,-0.13826,0.316546,0.456001,0.38428,-0.31666,0.731068,0.00183817,-0.152604,-0.424667,0.461965,-0.100306,0.0936637,0.728348,-0.459749,-0.439839,0.165074,0.129747,-0.955889,0.235378,-0.327643,-0.159679,-0.303886,0.0857441,0.508166,-0.0486691,0.415678,0.342819,-0.46316,-0.0123559,-0.0447516,0.0208607,0.260097,0.0620586,0.333463,-0.255005,-0.258283,-0.234711,0.252327,0.234123,-0.0431502,-0.456609,-0.260975,0.211541,-0.0326667,0.183841,0.126892,-0.292817,-0.287088,-0.167266,0.258779,0.616839,-0.161313,-0.0149588,-0.579091,-0.606795,0.000992499,-0.453372,0.309636,-0.172115,0.322108,0.536328,0.0662291,0.0493355,0.474084,0.515272,-0.109353,-0.0105216,-0.332877,0.422369,-0.2339,0.0871775,-0.196841,-0.135251,0.174186,0.118623,-0.650248,0.126836,0.505448,-0.148774,-0.55821,-0.0912701,-0.0886341,0.0201718,-0.534348,0.579177,0.200605,-0.172672,-0.491911,0.288429,0.627434,-0.319287,-0.161588,-0.319173,0.0484381,-0.409462,0.245369,0.760675,0.0299724,-0.170803,-0.150663,-0.297606,0.0328725,-0.290994,0.227942,0.271579,0.182912,0.135756,0.584579,-0.0246928,0.182595,-0.525802,0.196007,-0.322204,0.801764,0.240876,-0.115121,-0.197489,-0.0815945,-0.192874,-0.0847213,-0.0621159,-0.0181773,0.183872,0.0258031,-0.101562,-0.49404,0.140744,-0.346291,-0.184456,0.285919,0.739286,-0.136939,0.12185,0.314508,-0.28676,-0.355686,0.0804099,0.441746,0.116868,0.37766,-1.26067,-0.499458,0.0238244,-0.644609,-0.622014,-0.491616,0.342379,0.449634,0.223065,-0.471197,-0.0677114,-0.229287,-0.297365,-0.215989,0.115237,0.122983,0.192319,-0.513432,0.672706,0.274199,-0.16118,0.245018,-0.161206,-0.2021,0.0280399,0.169004,0.383677,0.00755606,0.337114,0.00572164,-0.539237,-0.278347,-0.536367,0.116507,-0.289358,-0.197628,0.482859,0.215988,-0.365741,-0.133963,-0.386737,-0.0237159,0.39064,-0.411336,0.415287,-0.444099,0.567394,-0.264723,0.304298,0.629159,-0.141967,0.33831,0.105337,-0.125019,-0.0655819,0.797903,0.264014,0.43976,-0.202079,0.0504524,0.0538012,-0.349978,0.240819,0.298277,-0.472856,-0.227046,0.022013,-0.106357,0.0624754,-0.37666,0.139971,-0.139285,0.07417,0.160332,0.607917,0.283193,-0.322809,0.00862122,0.443035,0.384457,0.176425,0.181561,-0.324051,-0.583428,0.443187,0.0738631,-0.0802516,-0.151717,0.438095,-0.0261119,-0.277159,-0.346908,-0.468175,-0.627671,-0.414942,0.82097,0.591015,-0.434833,0.0683018,0.199526,0.162514,0.253418,0.266855,0.264872,-0.205169,0.16861,0.221204,-0.272076,0.0379421,-0.161688,0.386139,0.00971991,0.110869,0.13411,0.33297,0.36621,-0.69497 +3421.69,0.557872,0.0912059,4,1.56191,1.00096,-0.555694,0.155134,0.404413,-0.159832,0.499026,-0.107795,0.36022,0.922781,0.0487399,0.091005,-0.615844,0.466466,-0.647689,0.878586,0.100664,-0.0243106,0.14374,-0.223312,-0.366975,-1.46419,-0.826748,-0.224101,-0.402779,-0.27254,0.289337,0.231668,0.249766,-0.127145,0.713561,-0.782117,0.43725,0.387654,-0.655344,0.00111573,-0.844714,0.738091,0.41098,-0.179156,0.949285,0.523426,-0.139768,-0.844566,0.164386,0.176448,-0.21102,0.12207,0.183755,-0.30622,0.0867237,0.11261,-0.661283,-0.686557,0.515654,-0.25678,-0.211304,-0.854837,0.39509,-0.606519,0.129917,1.0551,-0.829173,-1.20875,-0.480818,0.111186,0.810755,-0.346635,0.415051,-0.59064,0.14993,0.337506,0.33726,0.30217,0.704721,0.273107,0.621766,-0.0756288,-0.430092,0.0662962,0.589548,-0.39542,0.0997537,-0.184372,-0.0869492,0.0488717,-0.207651,-0.69572,0.107546,-0.29773,0.475876,0.230881,0.0430858,0.098801,-0.0950346,-0.12183,0.25132,0.00828825,-0.186756,-0.0796328,0.0401517,0.406654,-0.203168,0.139476,0.330566,-0.164073,0.0339644,0.162962,0.377994,0.262808,-0.064286,-0.0985197,-0.0531848,0.508775,-0.103738,0.0857048,-0.104993,-0.141765,0.544337,-0.160912,-0.74348,-0.00639117,-0.500518,0.0895017,0.38084,-0.0537,-0.0806851,0.147618,0.706752,-0.428105,0.246142,-0.25164,0.508789,0.328247,-0.600002,-0.233738,0.299572,-0.52387,0.140846,-0.461058,-0.213994,0.380922,-0.204858,-0.187169,-0.310498,-0.393996,-0.268541,0.648388,-0.292667,0.0898721,-0.132716,0.394168,0.279938,-0.201864,0.0851681,0.379577,-0.331726,-0.145029,0.0532842,0.0898297,0.679935,-0.166635,0.27058,-0.242639,0.045473,0.309098,0.453023,-0.0341145,-0.125202,-0.022402,0.504483,0.021447,0.0604454,0.0458991,0.385315,-0.118458,-0.0101631,0.0580932,-0.0733776,0.625467,-0.0452574,-0.0444087,0.216165,0.343005,0.326967,-0.465452,-0.597582,-0.702173,-0.22077,0.36687,0.150572,0.201762,0.338128,-0.30547,0.25255,-0.00495489,-0.367632,-0.494084,-0.101781,0.230473,0.241396,-0.373618,0.336448,-0.0973628,0.182842,-0.37898,-0.401326,0.826834,-0.0339318,0.538036,-0.584148,0.206636,0.401446,0.14744,-0.196401,0.116185,-0.385196,-0.0140952,0.343398,0.333616,-0.000213399,-0.221897,-0.167836,0.325503,-0.268067,0.598038,-0.431135,-0.0587615,0.270313,0.636857,-0.145217,0.065649,0.129377,-0.814036,-0.132991,0.401034,0.282409,-0.0882023,0.491487,-0.220171,-0.590982,0.251199,0.081635,0.129715,-0.233626,-0.145923,0.256554,0.224973,-0.0467847,-0.681574,0.341313,-0.845425,0.28329,0.0110396,-0.0901854,0.462269,-0.124791,-0.100364,0.379044,0.145359,0.272283,0.545031,0.255891,-0.0504806,-0.261097,0.456076,-0.121616,-0.622229,-0.20105,-0.0849022,-0.184402,0.0873237,-0.15808,-0.14599,0.0182777,0.037606,0.487028,-0.66874,0.739392,0.0422529,0.118911,0.362272,0.130423,0.405993,-0.23338,-0.357447,0.262725,0.0838504,0.305819,-0.349584,0.219557,-0.041836,-0.383046,0.716222,0.0269618,-0.389397,0.359074,-0.048411,0.0257186,-0.344916,0.356965,0.103019,0.230513,0.320965,0.480117,-1.3655 +3413.34,1,0.0912059,4,1.60753,1.01273,-0.197253,-0.00429411,0.472035,-0.126323,-0.044496,-0.247157,0.651941,0.120786,-0.212171,-0.581109,-0.0570717,0.17602,-0.471352,1.07243,0.330662,-0.479867,-0.330079,0.248964,-0.187584,-0.723545,-0.598587,-0.0910645,0.422136,-0.296291,-0.133133,0.661311,-0.179286,-0.116597,1.07522,-0.330805,-0.0827388,0.253962,-0.180917,-0.56621,-0.672257,-0.334151,0.208436,-0.0103706,0.70407,0.401216,0.281847,-0.710355,-0.191,-0.391309,-0.507712,-0.0441067,0.0881938,0.399982,-0.390928,0.330132,-0.12231,-0.559924,0.654224,0.0807408,-0.214112,-0.909318,0.145632,-0.603777,-0.109644,0.712576,-1.23134,-0.551253,-0.691041,-0.105154,0.375673,0.244848,0.0804057,-0.279995,-0.101189,0.201468,0.777683,-0.185812,0.12816,0.0597189,0.209239,0.228383,-0.0732272,-0.113609,0.690574,-0.556356,0.128282,-0.403914,0.331718,-0.141384,0.450608,-0.375814,0.31609,-0.950675,0.00306148,0.52183,0.0327409,0.310751,-0.0657314,-0.464585,0.471178,-0.0776679,0.233189,-0.182361,0.0541618,0.218802,0.302623,-0.366323,0.367931,-0.567413,-0.138462,-0.184436,0.151253,0.972143,-0.318291,0.197345,-0.0294706,0.598782,0.0996107,-0.132394,0.203933,0.311853,0.318529,-0.373836,-0.855241,-0.0982047,-0.0851208,0.435805,0.0381663,-0.0020613,-0.195659,-0.13137,-0.11316,0.0494901,0.252542,-0.112745,-0.0831292,0.45326,-0.00428337,0.500435,-0.273025,-0.093095,0.262136,-0.755388,-0.107663,-0.0182749,-0.0585238,-0.160087,-0.13,-0.452057,-0.720332,0.21232,-0.492769,0.435161,-0.124726,-0.218013,0.16954,0.60886,0.468696,0.115821,-0.283186,-0.0475254,0.503617,-0.452418,0.236759,-0.196747,0.415925,0.283453,-0.221676,-0.107615,0.288109,0.158445,-0.237065,0.267059,0.546921,-0.490603,0.22975,-0.10206,-0.147081,0.534892,-0.199055,0.268685,0.293783,0.644099,0.413547,-0.190457,-0.262545,0.114883,0.0786163,-0.22473,-0.156604,0.117942,0.114441,-0.432417,-0.147475,0.348298,-0.0284153,-0.769285,0.701541,0.35408,-0.25267,-0.345171,-0.323888,0.141436,0.259902,-0.181653,0.420698,0.253197,0.54714,0.18878,0.0624716,0.446852,0.206561,0.104627,-0.306843,-0.212543,-0.123669,-0.360147,-0.518869,0.108004,-0.479046,0.195166,0.171226,-0.273257,0.168722,-0.811514,0.293227,0.153975,-0.691262,0.332349,-0.121208,0.0936782,0.231641,0.401921,-0.133769,0.278484,-0.254484,0.319305,-0.0662051,0.337581,0.648659,-0.34073,0.259218,-0.0617703,0.114748,0.0970474,0.482422,0.188743,0.0413184,0.299897,0.0838019,-0.205679,0.104271,-0.340704,0.814327,0.339345,0.00808779,-0.199384,-0.572146,0.234533,-0.283961,0.40279,0.560595,0.248102,0.101539,0.874075,0.0931233,0.00789618,0.458422,0.157026,0.0804216,-0.133524,0.115233,-0.283648,0.169389,0.0125133,0.0886714,0.352468,0.229962,-0.393618,-0.0516241,-0.518838,0.388579,0.163954,-0.239115,0.170024,0.00250875,0.0429471,0.320843,-0.0500678,0.117867,-0.106705,0.371913,-0.261771,0.23438,0.138336,0.277816,0.172013,0.224838,0.0282981,0.0181504,-0.041559,-0.0508455,-0.39327,0.0189733,0.130707,0.320173,0.361534,0.565838,-1.61069 +3427.45,1,0.0912059,4,1.57731,1.02832,-0.186773,-0.0474199,0.0250814,-0.244612,0.273395,0.221568,0.573588,0.434994,-0.206845,0.0522687,-0.463172,0.578303,-0.580967,0.808486,0.109067,-0.117423,-0.122815,-0.0380719,-0.324409,-1.03849,-0.913703,-0.0120173,0.147675,-0.279113,-0.16659,0.83717,0.0153329,0.299278,0.772689,-0.887971,0.115944,0.319134,-0.312847,-0.35569,-0.129584,0.289034,0.0434604,-0.47541,1.17654,0.477899,0.312299,-0.858879,-0.181334,-0.264389,-0.420143,0.317963,0.158066,-0.0480754,0.304477,0.695885,0.193001,0.284666,0.902603,-0.603569,-0.191333,-0.817555,0.550336,-0.592037,0.109677,1.16795,-1.49098,-0.56256,-0.538907,0.290642,0.26304,0.115859,-0.00515168,-0.179768,0.204266,-0.139544,0.224904,0.0124714,0.617029,0.416215,0.039151,0.162764,-0.270947,-0.284596,0.380726,-0.486192,0.255657,-0.476532,0.170048,0.0987432,-0.371691,-0.0977567,-0.038664,-0.218175,-0.228119,0.178714,-0.0439522,0.087301,0.288091,0.326433,0.264052,-0.696918,0.269288,0.118444,0.312831,-0.490915,-0.168892,-0.0178534,0.314788,-0.423653,-0.100587,0.179455,-0.11004,0.355223,-0.0376894,-0.248152,0.0620093,0.397528,0.272635,-0.395129,-0.823388,0.153386,0.433584,-0.388434,-0.676011,-0.0606052,-0.0849774,-0.181376,-0.476318,-0.267728,-0.240555,0.514007,0.251967,0.139072,0.22549,-0.486296,0.36613,0.421231,-0.236548,0.286156,-0.0345049,-0.477018,0.242772,-0.202631,-0.105417,0.244988,-0.209693,-0.418857,-0.466149,0.0364538,-0.488976,0.443057,0.0103867,-0.20353,-0.0408774,0.000436669,-0.30666,0.566009,-0.156188,0.460138,0.415751,0.0637777,-0.421949,0.0634089,0.122766,0.123096,0.781878,-0.0207921,-0.124456,-0.00588943,0.311353,-0.172774,0.08185,-0.31817,0.0926972,-0.755774,-0.0336909,-0.312657,0.00746036,0.095208,-0.531515,-0.199077,0.339769,0.258964,0.304835,-0.228966,0.562468,-0.392574,0.373272,-0.0769227,0.504556,0.2536,-0.116086,0.325226,0.12475,0.359243,-0.166165,-0.789567,0.433907,0.610901,0.376128,-0.049267,-0.607751,-0.213613,0.00930833,-0.413682,0.343955,0.329482,-0.374043,-0.138152,-0.488776,0.713421,0.0516183,-0.0490865,0.10951,-0.31521,0.108308,0.0666955,0.434204,0.390279,-0.638269,0.332494,0.42593,-0.352596,0.417025,-0.157879,0.0606074,0.0128496,-0.274677,1.03048,-0.950937,-0.451022,0.150248,-0.32785,-0.374544,0.0979754,0.324513,0.179452,-0.489114,0.628341,-0.0945175,-0.149704,0.136524,-0.456187,-0.037379,0.0616433,0.604946,-0.13058,-0.290081,0.34196,0.370724,0.357116,-0.126403,-0.278346,0.37285,-0.301864,0.516246,-0.16727,0.320323,-0.186382,-0.397582,0.251857,0.123571,-0.0324335,-0.161705,0.582464,0.604785,-0.31472,-0.176384,0.111559,-0.222483,-0.237042,0.320603,-0.0381041,0.313011,-0.674851,-0.392712,0.325204,0.458907,-0.00890444,0.029255,0.412548,0.181144,0.320476,0.2053,-0.161296,-0.299081,-0.423203,0.0845375,0.331541,-0.135463,-0.170023,-0.0644406,-0.347227,0.310641,-0.131776,0.1273,0.343938,-0.0292013,0.439897,-0.0956141,0.0783748,-0.000532254,-0.232195,0.178926,0.0982654,0.30749,0.313473,0.554518,-0.119727 +3431.45,0.625536,0.0912059,4,1.54374,0.919045,-0.316939,0.0674124,0.270739,-0.209401,0.093922,0.128684,0.548853,-0.175377,-0.305403,-0.127094,-0.335287,0.466332,-0.0534433,0.639438,0.238368,0.0122439,-0.301416,0.103294,-0.124011,-0.657905,-0.943952,0.187087,0.530808,-0.383562,-0.132327,0.807937,0.188876,0.0551974,0.915726,-0.916794,0.400634,0.141802,-0.141327,-0.28246,-0.313543,-0.230392,-0.22132,-0.854475,1.00082,0.276398,0.102427,-0.428132,-0.356865,-0.614779,-0.0269883,0.0584981,0.317561,0.109856,0.0949056,-0.276438,0.412564,-0.395905,0.993784,-0.577133,-0.000755882,-0.587256,0.476409,0.00191052,0.314621,0.96579,-1.09905,-1.21754,0.222304,0.172803,0.0622804,0.244455,-0.516059,-0.325215,0.144912,0.322186,0.621007,-0.129329,0.556115,0.361234,0.0832312,0.263926,0.0232065,-0.206357,0.228654,-0.230558,0.164884,-0.390831,0.220991,0.360908,-0.947616,-0.1285,-0.163695,-0.229158,-0.165233,-0.047976,-0.236333,0.243761,0.130911,-0.580131,-0.0356122,-0.504696,0.00900996,0.195534,0.634785,-0.165002,-0.222193,0.131602,0.351767,-0.731974,0.543631,0.217759,0.227194,0.605751,0.0741183,-0.0901453,-0.109346,0.25921,0.127482,-0.171463,-0.812872,-0.473192,0.228907,-0.00316808,-0.679554,0.0753215,0.391784,-0.110424,-0.0301895,-0.0570612,-0.071939,0.199492,-0.0169277,-0.431377,0.339987,-0.117922,-0.233717,0.557023,0.19699,0.380083,-0.131526,-0.254672,0.452047,-0.415133,-0.131706,-0.0208299,0.0646399,-0.0325916,0.160586,0.525569,-0.394246,0.128165,-0.352791,0.021399,-0.0655363,0.0896423,-0.0878251,0.349116,0.0313736,0.185983,0.717853,-0.219208,-0.110187,0.000198822,-0.323929,0.100622,0.536608,0.55631,-0.362552,-0.346011,0.0663491,-0.248185,0.0930954,-0.0323071,0.129344,-0.34376,0.0712153,0.301662,0.0689523,0.00796996,-0.225166,-0.415104,0.142264,0.698532,1.11944,0.341307,0.0562578,-0.547213,0.0675216,0.0111083,0.311547,0.463116,0.0527245,0.230765,0.0331768,0.519724,-0.216522,-0.58983,0.218511,0.422177,0.424845,-0.171987,-0.367846,-0.0664711,0.103542,-0.284688,0.173785,0.187081,-0.407496,-0.233032,-0.516747,0.824259,0.0628119,0.378658,0.336392,-0.12239,0.14191,-0.192564,0.00612892,0.393091,-0.368368,0.0679492,0.190417,-0.175229,0.43447,0.287795,-0.0413798,0.329741,0.0680536,0.443256,-0.756305,-0.409579,-0.109049,-0.221879,-0.350754,0.0270166,0.0548785,0.306035,0.0883019,0.496488,0.17947,-0.334996,0.0943414,-0.297547,-0.148376,-0.500038,-0.0218962,0.11112,0.139259,-0.00900292,0.585585,0.437157,-0.467734,-0.239548,0.113025,-0.236623,0.4984,0.0377336,-0.270238,-0.396506,-0.744901,0.516542,-0.0123216,0.175118,0.0812202,0.0974046,0.513154,-0.0619719,0.056696,0.290588,0.0952082,-0.100887,0.490225,0.0282631,0.208719,0.403107,0.0739413,0.233306,0.216426,0.130202,0.167801,0.26526,0.227661,-0.0222674,0.400348,-0.44262,-0.622909,-0.174929,0.621463,0.402713,-0.05726,0.429554,0.286583,-0.249081,0.052759,0.0274029,0.525464,0.534206,-0.210558,-0.252151,0.189276,-0.150729,0.369924,0.0959701,-0.19922,0.122749,0.286967,0.350356,0.535693,-0.824941 +3408.62,0.563019,0.0912059,5,1.50938,1.02815,-0.985712,0.319647,0.451006,-0.0758007,0.329415,0.146876,0.0477378,0.386792,0.100606,-0.294341,0.13532,0.469237,0.227713,1.40434,0.201335,0.167233,-0.0339913,0.174327,-0.694258,-1.19514,-0.7277,0.128039,-0.864568,-0.310642,0.0918282,-0.0893429,-0.333346,-0.0692634,0.487126,0.389572,-0.509338,0.478904,-0.120819,-0.0011518,-0.37555,0.877979,1.00124,-0.0301836,0.677866,0.457701,0.143135,-0.300931,0.0908442,-0.122866,-0.864393,-0.0358578,0.461337,0.172566,-0.0815136,0.231744,0.344505,-0.527976,0.0956282,-0.0486919,-0.390768,-0.485524,0.0689651,-0.541678,0.115739,1.11445,-0.602021,-0.865591,0.149919,0.115574,-0.0974662,-0.419903,0.856021,-0.345895,-0.00401363,0.186908,0.313117,0.087174,0.25926,0.493895,0.533635,-0.206234,-0.624058,0.681819,0.881995,-0.200287,0.0906331,0.239006,-0.158297,-0.276728,0.908298,-0.156464,0.180852,-0.543303,-0.0504038,0.630399,0.160635,-0.30221,0.196054,0.0720759,-0.0250634,-0.0194332,0.264035,0.447467,-0.422585,0.0470737,-0.30129,-0.493239,0.13646,0.225895,-0.353561,-0.527754,0.111061,0.542276,0.0993029,-0.432595,0.352584,0.651814,0.132386,0.611838,0.150744,0.54663,-0.00303274,-0.107351,-0.62975,0.09301,-0.533025,-0.489715,-0.0875932,0.446502,0.283906,0.0454541,0.153783,-0.184729,-0.230535,0.0301701,0.276146,0.145279,-0.515178,-0.552972,0.156514,-0.052287,0.692597,-0.28373,-0.227138,-0.0474356,0.220306,-0.258075,0.214728,-0.67672,-0.0786152,0.411527,0.0257212,-0.171295,-0.361225,0.0975275,0.409122,-0.13264,0.502054,0.397247,-0.484257,0.287954,0.366294,0.080126,0.511414,0.138259,0.824885,-0.220153,0.0747863,0.483817,-0.0197015,-0.088469,-0.227899,0.106273,-0.272227,0.455354,0.219114,-0.447683,0.115464,-0.36053,-0.267839,-0.0551192,0.197593,0.409742,-0.568032,-0.56322,0.0477105,0.486389,-0.0649325,-0.556224,-0.582332,-1.01346,0.518469,-0.945926,-0.0547782,-0.498539,0.00190023,-0.305598,-0.108471,-0.108723,-0.569332,0.0482976,-0.757284,0.541094,-0.310147,-0.0339194,0.273557,-0.015352,0.35702,0.18904,-0.381702,1.12431,-0.318714,0.00936274,-0.362114,-0.123049,0.282034,0.285814,-0.325912,0.0760331,-0.0706878,0.277645,0.51141,-0.381791,-0.101245,-1.05599,0.105726,-0.204103,-0.828277,0.540672,0.0463715,0.135851,0.677556,-0.0158609,-0.0962318,0.294546,-0.175154,-0.47636,-0.948259,0.446301,-0.316517,0.258511,0.611185,-0.16747,-0.0509544,0.388656,-0.0130596,0.101826,0.290826,0.463277,0.331046,0.0949119,0.294184,-0.426244,0.0322834,-0.987291,0.36244,-0.565169,-0.151705,0.643174,0.663827,-0.374195,0.443297,-0.227579,0.308835,0.692107,-0.116843,0.257397,0.370741,-0.123461,0.0388988,-0.0821826,-0.40795,-0.00715352,-0.508113,-0.645755,-0.339217,-0.0550046,-0.316967,-0.170687,0.162758,0.0674204,0.231103,0.44626,-0.566893,0.262098,-0.178432,0.15039,-0.332813,-0.15985,0.0565063,0.188259,-0.464273,0.0127216,0.28806,0.319487,-0.219149,-0.293618,0.127854,-0.566453,-0.163032,-0.0813487,-0.275896,-0.380524,0.0293403,0.172851,0.230641,0.415753,0.480251,-1.57186 +3409.77,0.687138,0.0912059,4,1.45539,0.735227,-1.24166,0.535539,-0.0373022,-0.0461357,-0.363932,0.272286,0.615909,-0.0846016,0.389334,0.638868,-0.583686,1.18212,-0.070483,0.903993,0.528516,-0.0299187,0.287616,0.534554,-0.121639,-0.107376,-0.333403,0.363078,0.180798,-0.139255,0.392032,0.478717,-0.0202378,0.0868678,1.27086,-0.852738,0.722795,0.307407,-0.291952,-0.277232,-0.376796,0.642504,0.457076,-0.268236,0.956274,0.447545,0.306741,-1.20265,-0.389333,-0.156506,-0.969946,0.154828,0.317664,-0.207397,-0.102793,0.364707,0.512225,0.0824965,0.464471,0.128783,-0.346249,-0.254062,0.31479,-0.259173,0.555247,0.943082,-0.491702,-0.996489,0.489715,0.52038,-0.199273,-0.157303,-0.247945,-0.792041,-0.508754,-0.0536194,0.42643,-0.132801,0.465625,0.504368,0.538162,-0.0104841,-0.475806,0.234187,0.188354,-0.520254,0.322525,-0.171649,-0.235133,0.195423,-0.309402,-0.00261634,0.319849,-0.379497,-0.120796,-0.138514,-0.108533,0.180588,0.0985595,-0.60954,-0.0171839,-0.472149,0.0124623,0.506496,0.532427,-0.42745,-0.44,0.299528,-0.435553,-0.325057,0.451322,0.260147,0.368384,0.768546,0.38808,-0.736788,0.0639009,0.51706,-0.0775054,0.338376,-0.895063,0.0337337,0.630192,-0.346714,-0.663812,0.00765556,-0.360847,0.129656,0.211371,0.175377,0.104902,0.590094,-0.081377,-0.602404,0.232565,-0.645175,-0.31553,0.123325,0.108125,-0.00866928,-0.186202,-0.338252,0.80941,-0.798823,-0.447172,0.0522625,0.428842,-0.570742,0.0959618,0.69009,-0.205778,0.680775,-0.417762,-0.202703,-0.241319,0.230208,-0.357261,-0.0821381,-0.234643,-0.00775866,-0.152968,-0.373696,0.262397,0.0274196,0.391556,0.0676411,0.719437,0.0130466,0.913721,0.0634111,0.105608,-0.317916,0.357053,-0.277052,0.12545,-0.198973,0.046192,0.0500019,0.137859,-0.638005,-0.287089,0.496661,0.161756,0.790036,0.70116,0.196693,0.236271,0.0917744,-0.199892,-0.175972,0.112276,-0.192669,-0.34436,0.233968,-0.250465,0.215585,-0.398786,-0.628354,0.0271009,0.403735,0.0737022,0.100806,-0.179044,-0.678291,0.262441,0.361598,0.566717,-0.250365,-0.000259958,0.132718,0.268688,0.509347,0.10812,-0.0840533,0.364611,-0.421205,0.198973,0.025026,-0.0226003,0.127469,-0.407121,0.303751,0.363696,0.0611676,-0.574303,-0.103902,-0.260196,0.614582,0.319575,0.130245,-0.716074,-0.227481,0.064556,-0.433626,-0.235159,-0.0252383,-0.456182,-0.168422,-0.556161,0.591291,0.11469,-0.201094,0.314354,0.0779956,-0.471049,-0.256873,-0.0407476,-0.204444,0.83522,-0.161356,0.10861,-0.483131,-0.0153138,-0.495611,-0.188124,-0.461474,0.372681,-0.130181,-0.469047,-0.587159,-0.528678,-0.657609,-0.0372477,0.112177,0.124737,0.444573,-0.185569,0.138051,-0.179058,0.131785,-0.186221,0.358477,0.151582,0.0103009,-0.131351,0.143987,-0.55633,-0.00633427,-0.326039,-0.717708,0.25645,0.48003,0.394244,-0.147804,0.274278,-0.467236,0.174415,0.342786,0.446565,0.547563,-0.313172,0.28322,0.0793592,-0.323316,0.00704041,-0.340988,0.254529,0.508606,0.008048,-0.099113,-0.0768419,-0.0196675,-0.67485,-0.360899,-0.731444,0.164573,0.325156,0.405676,0.570225,0.435418 +3416.19,0.822687,0.0912059,4,1.47623,0.868537,-0.712688,0.39366,0.04863,-0.0417279,-0.330827,0.255822,0.832043,0.111007,0.250397,0.312751,-0.482729,1.34481,0.0480143,1.1842,0.59417,-0.186362,0.300674,0.617286,-0.285744,-0.204,-1.05039,0.542362,0.105778,-0.0952163,0.543008,0.443241,0.166716,-0.113271,1.48243,-0.660478,0.19499,0.318649,-0.423362,-0.0198357,0.0148231,0.363424,0.507888,-0.246002,0.779548,0.275758,0.246222,-0.528887,-0.626473,-0.246863,-1.16141,0.247819,0.346229,0.000357908,0.0299144,0.212191,0.274861,-0.482429,0.417344,0.0271979,-0.242868,-0.543038,0.080579,-0.226032,0.370134,0.842342,-0.527882,-0.783874,-0.128421,0.878251,-0.0232616,-0.17318,-0.293577,-0.496295,-0.23767,-0.00876782,0.0627677,-0.193556,0.475719,0.36248,0.938471,-0.0876941,-0.847067,0.38873,0.318058,-0.120754,0.419117,-0.107573,0.132851,0.606475,0.217638,-0.360228,0.0702319,-0.489087,0.178916,0.317571,-0.046898,-0.0932022,-0.22655,-0.66718,0.0740022,-0.244632,0.56854,0.487515,-0.217864,-0.397519,-0.880575,-0.203132,-0.132583,-0.364596,0.173703,-0.385534,0.254091,0.475197,-0.0162752,-0.574636,-0.463944,0.109789,-0.207996,0.0593987,-0.748344,0.0158333,0.607786,-0.170245,-0.560497,-0.373794,0.0103876,0.485248,0.596471,0.168469,0.357817,0.465983,-0.387439,-0.293523,0.187802,-0.448656,0.338472,0.383184,-0.230778,-0.0337523,-0.191838,-0.53839,0.693683,-0.898927,-0.235686,0.0555369,0.248648,-0.947876,0.299008,0.240056,-0.645544,0.442404,-0.403814,-0.0614043,0.0480217,0.283393,0.0120657,0.153774,-0.145709,0.294483,-0.186902,-0.439471,0.0475806,-0.210352,0.483165,0.0659926,0.782179,-0.310871,0.614834,-0.104423,0.0861826,-0.244316,0.324792,0.0893377,0.177648,-0.057191,-0.0945948,-0.0760505,-0.0250603,-0.427265,-0.228694,0.214596,0.272715,1.07855,0.515825,0.264823,0.099756,0.0606492,-0.169151,-0.121571,-0.482391,-0.109173,0.13433,0.166771,-0.570905,-0.147389,-0.113723,-0.95974,0.105307,0.297629,0.0162704,0.151752,-0.337711,-0.210118,0.114322,-0.210462,0.752772,0.0140623,-0.0594613,-0.203326,-0.220011,0.450069,-0.0283528,0.0443428,-0.172012,-0.42778,-0.1046,0.270504,-0.345796,0.052251,-0.248809,0.409007,0.147855,0.100217,-0.473188,-0.254086,-0.447491,0.617094,-0.0200193,0.445182,-0.357152,-0.342709,0.190683,-0.0132672,-0.233109,-0.0182493,-0.0174098,-0.333083,-0.922643,0.459169,0.109579,-0.227495,0.344719,-0.00596604,-0.371867,-0.203431,-0.064617,-0.466082,0.284371,-0.278308,0.102263,-0.0360631,0.259921,-0.692929,-0.340612,-0.228369,0.315136,-0.0182722,-0.20668,-0.533498,-0.660755,-0.52448,0.141363,-0.0385851,0.0525243,0.373231,0.0868185,0.056562,-0.308538,-0.299146,-0.191694,0.0548332,0.489853,0.134804,0.205026,-0.151759,-0.833228,0.213395,-0.151053,-0.0139385,0.581307,0.127011,0.30593,-0.196238,0.229117,-0.513245,0.445383,0.442927,0.177721,0.223832,0.0496249,0.519941,-0.186824,-0.227805,0.29556,-0.0827426,0.207504,0.446361,0.187689,0.234378,-0.0030546,0.441809,-0.734726,-0.547384,-0.270742,0.135665,0.285378,0.368327,0.534208,-0.209186 +3400.13,0.751424,0.0912059,4,1.41375,0.858802,-0.636306,0.2799,0.159992,-0.235193,-0.408094,0.585646,0.998937,0.149345,0.315869,0.149148,-0.398896,0.916297,0.206571,0.737531,0.43648,-0.301755,0.105789,0.782128,-0.0130899,-0.293716,-0.343597,0.327886,0.00187078,-0.268853,0.143732,0.348476,0.267554,0.424488,1.32799,-0.0345631,0.211923,0.453775,-0.256725,-0.304993,-0.551047,0.896026,0.399563,-0.234034,0.802986,0.0909032,0.435214,-0.801224,-0.00921914,-0.351521,-1.08025,0.538684,0.69613,-0.289296,-0.0719686,-0.530421,0.281665,-0.103436,0.973084,0.194411,-0.0243798,-0.324654,0.597463,-0.400918,0.21174,0.832001,-0.693281,-1.3611,-0.214088,0.902631,0.307546,-0.140127,-0.219829,-0.229066,0.249165,0.13552,0.393674,0.0273386,0.907447,0.256,0.718958,-0.260484,-0.897181,0.437663,0.0222543,-0.0224457,0.199228,-0.495034,-0.0730029,0.0755986,0.278147,-0.103156,-0.0367596,-0.280001,-0.030499,0.274006,0.103751,-0.0168501,-0.239892,0.182446,0.0235418,-0.377326,0.551536,0.521571,-0.162831,-0.127077,-0.664431,-0.0726604,-0.491059,-0.184707,0.555024,-0.503385,0.499521,0.346958,0.091905,-0.422109,-0.170558,0.301965,-0.0595598,0.283217,-0.449544,0.0532157,0.26444,-0.093819,-0.895369,-0.220408,0.151978,0.509007,0.428981,0.273433,0.193174,0.261428,0.175829,-0.0555075,0.448238,-0.0616804,0.218684,0.2059,0.202431,0.176332,-0.643314,-0.660155,0.547518,-0.418808,-0.379121,-0.25434,0.401199,-0.830131,-0.0148081,0.648645,-0.504762,0.204529,-0.495172,-0.277483,0.0406021,0.233059,0.438566,-0.301457,-0.131236,0.448953,-0.401896,-0.127674,-0.109119,0.152562,0.679033,-0.148166,0.680893,-0.224179,0.406653,-0.190132,0.0168586,0.0719626,0.628347,-0.180432,-0.115048,-0.286668,-0.185391,-0.178516,-0.156568,-0.299485,-0.297658,-0.0162737,0.301099,0.978926,0.574658,-0.469312,0.572813,0.0820582,-0.397066,-0.139591,-0.147865,-0.247222,0.180931,0.0973308,-0.467912,-0.362414,0.196137,-0.766474,0.705024,0.251809,-0.000911345,-0.0751467,-0.570315,0.309942,0.128515,0.079427,0.307679,0.0909358,0.109769,-0.455246,-0.750103,0.540585,-0.146627,-0.290977,-0.185597,-0.729135,0.250616,0.195172,-0.752171,0.27653,-0.419804,0.415266,0.400732,0.121901,-0.310412,-0.938854,-0.449354,0.276942,-0.445866,0.278801,-0.357957,-0.340676,0.135334,0.0359279,-0.318125,-0.0213984,0.064015,-0.215874,-0.86529,0.517434,0.245652,-0.337361,0.289653,-0.608889,-0.448138,-0.20669,0.18042,0.16366,-0.0506729,-0.242788,0.556888,-0.26403,0.317008,-0.756638,-0.300016,-0.676069,0.433884,0.150846,0.0719894,-0.0801387,-0.472217,-0.198305,-0.0681986,0.0884881,-0.0666683,0.33061,0.134119,0.135556,-0.414426,-0.0185614,-0.619985,0.0720541,0.852185,0.121463,-0.0232052,-0.0453895,-0.782169,0.42932,-0.28861,-0.438261,0.578823,0.142648,-0.0982954,-0.0729032,0.282386,0.160992,0.464825,0.526565,-0.0144244,0.153315,0.508499,0.48973,-0.0793168,-0.492574,-0.258296,0.61411,0.323717,0.431462,0.0866163,0.033101,-0.242095,0.18909,-0.877777,-0.121537,-0.571551,0.152844,0.29635,0.390952,0.544381,-0.508038 +3397.85,0.99313,0.0912059,5,1.50328,0.923446,-1.53231,0.702987,0.796014,-0.155868,0.388406,-0.206778,0.158237,0.465662,0.252511,-0.468716,0.345363,0.11499,0.259231,0.912532,-0.105512,0.398417,0.196878,-0.347245,-0.120875,-0.851214,-0.641423,0.0762108,-0.102505,0.623907,0.417002,0.703028,-0.398417,-0.140697,0.766471,-0.638403,0.0605871,0.847075,-0.571196,-0.444647,-0.598982,-0.122133,0.445902,-0.0588488,0.971141,0.891802,0.244616,-0.909616,-0.0985359,0.510536,0.0635402,0.215952,-0.0365525,-0.0268285,-0.0936681,0.742982,0.143456,-0.332366,0.187516,-0.459899,-0.35086,-0.51539,-0.0662092,-0.182821,0.104738,0.901096,-0.624276,-0.63492,0.325258,-0.551524,-0.509591,-0.278568,0.340865,-0.476011,-0.323014,0.336426,0.534809,-0.494897,0.256022,0.531615,0.225083,0.135384,0.268788,-0.334522,0.65855,-0.464682,0.292446,0.388118,-0.270172,-0.422313,-0.175994,-0.357209,-0.00629757,-0.389618,-0.194581,-0.0975242,-0.337075,-0.483105,0.378414,-0.750657,0.0546335,-0.256532,-0.529075,0.0275175,0.317839,0.107344,-0.835565,-0.603084,0.883848,-0.318577,-0.069778,0.0694446,0.0403006,0.51961,-0.169288,-0.133193,0.563824,0.240971,0.0961214,0.0202777,-0.3249,0.295798,0.0557748,0.200772,-0.223888,0.187321,-0.451902,-0.770312,-0.433509,-0.032912,-0.116857,-0.134117,0.408936,-0.57514,-0.326908,-0.301888,-0.50575,0.469262,-0.615217,-0.132984,0.470707,0.231603,0.33235,-0.715474,-0.168915,0.261559,-0.159917,-0.123441,-0.102699,-0.359186,0.260967,0.2004,-0.205503,-0.00748136,-0.478978,-0.500365,-0.232211,0.180355,0.52951,0.207212,0.570708,0.116856,0.312246,-0.254414,-0.398904,-0.578711,0.479486,0.347572,-0.524875,0.497902,-0.0788058,-0.271973,-0.965464,-0.10083,0.0572335,0.135345,-0.153496,-0.00313391,0.045601,-0.204045,0.0582109,-0.0923761,0.170577,0.701892,-0.440651,0.143629,-0.2137,-0.109004,0.303779,-0.729892,-0.300876,-0.14839,0.240316,-0.814657,0.329817,0.00185901,-0.137068,-0.235022,-0.33521,-0.00109509,-0.0963405,-0.341987,-0.561511,-0.340643,-0.186793,-0.53214,-0.168284,-0.422849,0.0245759,0.215391,-0.156873,1.17511,0.125177,0.723346,-0.113136,0.220565,-0.142917,-0.0646407,0.517682,-0.0744433,0.0307763,-0.00361192,0.112799,-0.69403,-0.302967,-0.135443,0.319065,0.151381,-0.0732264,0.511473,-0.148894,-0.241915,0.142723,-0.492444,0.0559813,-0.129197,-0.691391,-0.00474489,0.0637893,0.68221,-0.146424,0.598495,0.633354,0.0435839,0.258254,0.325392,-0.0923429,-0.174372,0.510567,0.487609,0.401153,0.557079,-0.484906,0.00847917,-0.0357999,-0.339681,0.120532,-0.229145,-0.440737,0.353929,0.125768,0.143234,0.341374,0.19857,0.413615,0.18691,-0.155872,0.287719,0.657451,0.231674,0.191669,-0.344513,-0.91474,-0.356901,-0.315183,-0.269364,0.353425,-0.373871,0.12346,0.518268,-0.160695,-0.022206,0.430213,-0.386656,-0.641877,-0.56945,-0.764725,-0.284839,0.473202,0.102571,-0.597419,-0.0386316,0.052415,0.318315,-0.494224,-0.644902,0.0216463,-0.301532,0.153368,-0.783286,0.453136,-0.0223846,0.644121,-0.107999,0.60848,0.152874,0.192528,0.390991,0.43878,-2.59454 +3399.68,0.880893,0.0912059,5,1.52316,1.04532,-0.942565,0.448213,0.861747,-0.220463,0.335979,0.281646,1.0588,0.3062,0.105393,-0.2931,0.342418,0.133458,-0.0800668,0.998775,0.0884743,0.103254,-0.131926,-0.503154,-0.282183,-0.688717,-0.517608,0.0678238,-0.234242,0.00751431,-0.281913,0.195472,0.0179483,0.673922,0.467458,-0.533333,0.614561,0.557141,-0.283418,-0.230331,0.275487,0.614568,0.61856,-0.502544,0.903032,0.48407,0.555832,-0.254691,-0.37041,-0.17508,-0.120959,-0.0414624,0.153897,-0.251273,0.310082,0.298327,-0.103006,-0.196934,0.276038,0.0556848,-0.26787,-0.768719,0.0996325,-0.522097,-0.151978,0.942605,-0.384395,-0.866511,-0.0316469,-0.678804,-0.193049,-0.595151,-0.686284,-0.416955,0.366577,-0.111402,0.529672,0.266584,0.598258,0.543004,-0.305089,0.0474925,0.0832058,0.0715327,0.348568,-0.328336,-0.00839846,-0.350547,-0.110601,-0.670996,0.395816,0.295848,-0.544785,0.145509,0.374954,-0.614214,-0.16387,0.0957264,0.0678991,0.362298,0.415392,-0.0472998,0.296717,0.0677377,-0.092945,-0.492189,-0.279395,-0.803805,0.0554213,-0.725168,0.533149,-0.154313,-0.0958239,-0.024594,-0.142817,-0.269144,-0.122447,0.136798,-0.0148256,-0.374418,0.0627013,0.227586,0.147572,0.526763,-0.569685,-0.388944,0.531517,0.176711,-0.0454265,0.229703,0.00622845,0.326019,0.116727,0.4088,-0.205061,-0.117639,-0.149242,0.474031,0.0148944,-0.450481,0.636894,0.0932543,0.410875,0.0888682,-0.350008,-0.1668,-0.214996,-0.251575,-0.077089,-0.111446,-0.0139386,0.229494,0.1569,-0.344079,0.226904,0.0324928,0.311525,0.08381,-0.156263,0.337181,0.104667,0.193004,-0.185327,-0.516159,-0.0635311,0.0982221,1.03297,0.121456,-0.380628,0.135193,-0.288273,0.0170622,-0.561,0.221044,0.483833,0.283977,-0.338664,-0.303849,-0.150362,0.236872,-0.312472,-0.656034,0.352651,0.342675,0.114516,-0.126943,0.47404,-0.0968404,0.342502,-0.359966,-0.37609,-0.422727,0.482101,-0.0351654,0.0495161,-0.0998866,-0.2085,-0.398983,0.0254209,-0.103361,0.413043,-0.121986,-0.509593,-0.0630613,0.0897567,0.0866391,-0.397887,0.526285,0.108914,-0.0403989,-0.644042,0.922195,0.159391,0.170173,-0.339103,-0.368701,-0.0392396,0.371608,-0.066218,0.274887,-0.265341,-0.0391895,-0.175688,0.163582,-0.0661979,-0.552463,-0.0281273,-0.487304,-1.02121,-0.0681403,-0.933086,-0.398157,0.26249,0.298564,0.324157,-0.102019,-0.150162,-0.700379,-0.614959,0.318796,0.00108492,0.312858,0.221122,-0.181708,0.795971,0.00241351,0.26082,-0.26797,0.69092,-0.219287,0.136341,0.52117,-0.931806,-0.411521,-0.51905,-0.6231,0.718532,0.084967,0.0545123,0.937129,0.118769,0.344363,0.00079649,0.188089,0.666772,0.0743146,0.160866,0.342345,-0.262991,0.245779,0.142917,0.401949,-0.69088,-0.185524,-0.367836,-0.556958,-0.0354042,0.466232,0.0762692,0.586671,-0.29804,0.556911,0.616056,-0.0482658,-0.0425158,0.104654,-0.221702,-0.131911,0.0199232,0.49229,-0.241905,0.00810306,-0.139326,-0.542936,0.370435,0.191655,0.511931,-0.453745,0.0817035,0.167983,-0.168565,0.0848344,-0.686546,-0.384716,0.156625,0.141585,0.224428,0.376278,0.473739,-3.06044 +3391.22,0.966287,0.0912059,5,1.62185,1.05172,-0.211885,0.0754336,0.634651,-0.203066,0.596117,0.205546,0.594086,0.658012,-0.191795,-0.373404,0.517899,0.233818,0.0847117,1.08414,-0.168434,0.25006,0.0635529,-0.414322,-0.429887,-0.94472,-0.650615,-0.0564909,-0.450552,0.423124,0.369906,0.244414,-0.345194,0.304589,0.743293,-0.369888,0.487167,0.484604,-0.511382,-0.398585,-0.351521,0.519261,0.286436,-0.724378,1.00477,0.823877,0.342078,-1.03227,-0.456194,-0.578585,-0.171566,-0.269705,0.501,-0.110381,0.243645,0.25612,-0.430249,-0.391989,0.817664,-0.366632,-0.56036,-1.02025,0.278963,-0.576124,-0.0242925,1.04285,-0.646624,-1.56586,-0.408022,-0.374527,-0.0789154,-0.441299,-0.813973,-0.0659638,0.222516,-0.0280443,0.628704,0.088693,0.734658,0.515396,-0.105818,0.434261,-0.108385,0.335488,-0.198382,-0.611787,0.257138,0.0429455,-0.443096,-0.283583,-0.0496188,0.524685,-0.381138,-0.112968,0.159088,-0.777955,0.114571,0.316189,0.142067,-0.282809,0.0237357,-0.354726,0.309116,0.420626,-0.63474,0.139671,-0.283226,-0.530858,-0.140597,-0.53793,0.507119,-0.35726,0.0726906,0.290114,0.331927,0.172927,0.357686,0.291047,0.263264,-0.934891,-0.453933,0.437632,0.459265,0.131745,-0.913129,-0.215633,0.692348,-0.260846,0.0556266,0.00337359,-0.331707,0.210375,0.0145509,-0.168806,0.101405,0.175112,-0.23474,0.348464,-0.317811,-0.315445,-0.370057,0.0468345,0.355037,-0.281226,-0.527197,-0.00235515,-0.0343913,-0.36731,0.355046,-0.357457,-0.0278226,0.0991584,0.0692707,0.214985,-0.476289,-0.0766564,0.330085,0.115556,-0.173834,0.268291,-0.400905,-0.431109,0.0163755,-0.694093,0.210924,0.0144548,0.958368,0.593494,-0.286572,0.37882,-0.284486,-0.0980907,-0.451717,0.151114,0.633632,0.315692,-0.375967,0.163261,0.210784,-0.402973,-0.435463,-0.983984,0.176579,0.547673,0.0969069,-0.52614,0.236031,0.0338989,0.389116,-0.248184,-0.179297,-0.187574,0.815767,-0.897293,0.0554705,-0.301783,-0.0727247,-0.48349,-0.0143852,0.399494,0.468994,-0.343523,-0.92357,0.366147,0.00891322,0.0732869,-0.545014,-0.181872,-0.0896323,0.476336,-0.75985,0.909976,-0.0166926,-0.261136,-0.192568,-0.0823322,0.0833834,0.0120267,0.0783901,0.53113,-0.0606382,0.0126031,-0.04539,-0.114913,-0.0532703,-0.956997,0.42136,0.0893289,-0.357075,0.671696,-0.271022,-0.619738,0.733316,0.433217,0.34032,-0.140971,-0.0658101,-0.628047,-0.285779,0.805372,-0.268431,0.0491663,0.362738,-0.34636,0.659994,0.0760563,0.275991,-0.564904,0.661784,0.32237,0.382994,-0.00890985,-0.18356,0.435718,-0.761884,-1.288,0.507247,-0.089674,-0.145062,0.47224,-0.0246189,0.673407,0.14824,0.399168,0.364917,0.536348,0.234899,0.30654,-0.176307,0.333487,0.184505,0.0769002,-0.437312,-0.31679,-0.347876,-0.290654,-0.206645,0.389568,0.440652,0.738428,-0.279728,0.232206,0.50041,0.358442,0.660538,0.0222306,0.186406,0.328924,-0.171647,0.732225,-0.562274,-0.247293,0.79719,-0.125453,-0.278716,-0.216443,0.554441,-0.149738,0.110594,-0.136364,-0.213213,-0.0187072,-0.336015,0.207221,-0.00518007,0.163235,0.282367,0.404023,0.531382,-2.25389 +3380.42,0.64769,0.0912059,5,1.55094,1.15239,-0.439766,0.119639,0.391418,-0.10389,0.501161,0.39983,0.38799,0.406696,0.099165,-0.251072,0.146478,-0.0203534,0.169375,1.0096,0.299643,0.0844939,-0.144093,-0.0829111,-0.688052,-0.526047,-0.547541,-0.104341,-0.434801,0.200112,0.25058,0.277938,-0.190958,0.312322,0.412264,0.210522,0.464951,0.323189,-0.498333,-0.116363,-0.424537,0.511422,0.184418,-0.48563,0.691723,0.697207,-0.0152265,-0.842477,-0.173199,-0.393587,-0.498228,-0.0214508,0.0962045,-0.0941605,0.265891,0.204863,-0.699606,-0.32632,0.819789,-0.441812,-0.544414,-0.53275,0.160895,-0.963198,-0.0547378,0.758201,-0.505059,-1.53286,-0.182544,-0.484486,-0.287267,-0.421358,-0.711457,-0.24439,0.198995,0.0332326,0.579332,-0.22034,0.308401,0.330083,0.325862,0.434419,-0.237562,0.156413,0.400507,-0.595093,-0.11514,0.00509296,-0.236959,-0.658705,0.458746,0.382635,-0.393873,0.116325,0.365362,-0.0903215,-0.0775069,0.422677,-0.0298208,-0.177171,-0.109025,-0.20925,-0.0681064,0.360707,-0.662242,0.222483,-0.60701,-0.521999,-0.306447,-0.698218,0.206698,-0.552532,0.514092,0.0770121,0.106878,0.05534,0.496578,0.155077,0.459512,-0.539692,-0.451413,0.339035,0.53957,0.056114,-1.35174,0.356278,0.55656,-0.553351,0.201916,0.216338,-0.153014,0.0629321,-0.158397,0.00986551,0.0988979,0.0653,-0.311604,0.326895,-0.179595,-0.257815,-0.63959,0.065542,0.46513,-0.065334,-0.268828,-0.0120517,-0.168709,-0.62653,0.249101,-0.2094,-0.185119,0.184543,-0.0526354,0.162506,-0.74463,-0.0859457,0.417103,-0.144061,-0.304177,0.43214,0.346863,-0.0247215,-0.112828,-0.12178,0.164163,-0.116919,1.00464,0.433739,-0.525264,0.734053,-0.0555267,-0.118716,-0.520296,-0.0417511,0.910475,0.268712,-0.330583,0.178813,0.534192,-0.227498,0.012831,-0.762571,0.103745,0.673707,0.401568,-0.373326,0.213072,-0.170136,0.467069,-0.0645963,-0.0962881,-0.248982,0.28918,-0.574032,0.106028,0.149279,-0.149903,-0.565601,-0.520032,0.564225,0.348661,-0.278352,-1.50754,0.376682,0.0302166,-0.0741944,-0.38006,-0.253217,-0.244704,0.476257,-0.49082,0.910395,0.582684,-0.202309,-0.129552,-0.263524,0.516586,-0.0559479,0.00621128,0.43956,-0.322901,0.40828,-0.254072,0.224273,0.521379,-0.425528,0.247733,0.298779,-0.180717,0.676297,-0.0768461,-1.03863,0.485145,0.483189,-0.212346,-0.308857,-0.3491,-0.672565,-0.305307,0.308314,0.204142,-0.017216,0.272682,-0.209431,0.4695,0.174662,0.00984754,-0.767897,0.149225,0.653673,0.477421,0.292913,-0.422901,0.0106216,-0.943306,-0.890331,0.25433,0.112683,-0.589386,0.574366,0.00184413,0.341623,0.12115,0.258328,0.51922,0.34248,0.328458,0.354114,-0.165113,0.175064,0.122248,0.35297,-0.668778,-0.272423,-0.397841,-0.451552,-0.200826,0.506834,0.513496,0.781801,0.007303,0.313793,0.203134,0.374574,0.515768,0.672501,-0.00768533,0.115335,-0.182078,0.387088,-0.811777,0.36346,0.914247,0.668507,-0.187774,0.274759,0.337968,-0.0517891,0.228027,-0.0761232,-0.226704,-0.532471,-0.432955,0.291834,0.0110458,0.165568,0.33969,0.4069,0.58283,-1.64227 +3393.27,0.902099,0.0912059,4,1.60053,0.985255,-0.425422,0.225435,1.0553,-0.115418,0.0382279,0.0126672,0.494413,0.31644,0.147288,-0.4758,0.178298,0.294533,-0.167548,1.11269,0.234738,-0.0756177,0.327181,-0.247464,-0.445679,-0.735822,-0.717011,0.0903108,0.0428763,0.329991,0.469176,0.590611,-0.133271,0.308976,0.543087,-0.13899,0.795479,0.832796,-0.417698,-0.455484,-0.687393,0.249332,0.106275,-0.370469,1.03711,0.724086,0.124212,-0.509661,-0.0279698,-0.394163,-0.169174,-0.0161755,0.224545,-0.4568,0.332977,0.439619,-0.635003,-0.960556,0.853587,-0.283539,-0.397712,-0.892681,0.283249,-0.66429,0.00545976,1.13923,-0.449062,-0.996043,-0.355841,0.0279208,-0.258086,-0.0458707,-0.260816,-0.722745,0.121481,-0.037341,0.423496,0.147033,0.506532,0.269045,0.742831,0.0614715,-0.285294,0.359572,0.949041,-0.450039,0.130243,-0.167864,-0.105786,-0.384554,0.326104,-0.026723,-0.172522,0.420762,-0.197301,0.125456,0.010799,0.339063,0.215736,0.53916,0.499616,0.180922,0.267542,0.295961,-0.322267,0.299356,-0.362064,-0.586118,-0.451887,-0.826632,0.364762,-0.480567,0.586395,0.190387,0.281258,0.385964,0.129321,0.00755406,-0.0315345,-0.333641,-0.27477,0.288338,0.480753,0.0968141,-1.74073,0.393,0.329268,-0.640083,0.435116,0.0834577,-0.0583616,-0.0231213,-0.127711,0.0931768,0.0822276,0.277148,-0.489769,0.988366,-0.391059,-0.332496,-0.403221,-0.0912059,0.583301,-0.442911,-0.223462,0.05102,-0.0454379,-0.337455,0.334409,-0.0101223,0.15555,0.0459029,0.0233729,-0.331955,-0.703051,-0.282537,0.588243,-0.48549,0.155936,0.194331,0.238523,-0.0139444,-0.14443,-0.16869,-0.0606363,-0.199501,0.87447,-0.100734,-0.270292,-0.0859993,0.0108859,-0.231902,-0.639127,-0.291462,0.950261,0.399303,-0.366038,0.00140144,0.195,-0.0483954,0.0646815,-0.550049,-0.04781,0.404606,0.228869,-0.359913,0.168317,-0.183902,0.467377,0.0341018,0.0156587,-0.337454,-0.0452185,-0.239919,-0.0612888,0.155008,-0.149914,-0.886955,-0.156315,0.748144,0.0866742,0.138324,-1.36687,0.0957262,-0.017594,-0.136466,0.00255303,-0.436516,0.0699782,0.36369,-0.890065,1.28347,0.13189,-0.242203,0.00757769,-0.262679,0.34516,-0.0120721,0.299295,0.183218,-0.0353766,0.173313,0.104144,0.177771,0.195218,-0.350916,0.52999,0.813419,-0.0535266,0.518963,-0.127891,-0.866501,0.292784,0.651058,0.148098,-0.179223,-0.0962347,-0.733229,-0.537637,0.232316,0.0191689,0.143185,0.134418,-0.300502,0.314394,0.0504126,-0.035141,-0.580638,0.383245,0.290746,0.350256,0.0994297,-0.570917,-0.354142,-0.856382,-0.940422,0.104914,-0.241431,-0.822486,0.345918,0.0822578,0.534996,-0.160617,0.350232,0.0398347,0.580028,0.128818,0.295126,-0.250833,0.164104,0.0593555,0.229351,-0.675292,-0.632152,-0.37519,-0.702863,-0.144062,0.0907627,0.461984,0.967466,0.16314,0.257723,-0.0824797,0.0343067,0.242476,0.467954,0.09493,0.509396,0.0506393,0.417886,-0.661625,0.142887,0.700276,0.450731,-0.226283,0.0892292,0.0110838,0.500356,0.00470698,0.354839,0.538144,-0.617407,-0.316288,0.292173,0.196161,0.178898,0.234744,0.422963,0.484504,-3.60613 +3386.23,0.803211,0.0912059,5,1.55007,0.906558,-1.21793,0.566279,1.03769,0.00690643,-0.189701,0.0603467,-0.00103706,0.215642,0.0421241,0.267435,-0.0732422,0.0382169,-0.264846,0.414505,0.333347,0.308126,0.291713,-0.456449,-0.318878,-1.23343,-0.750947,-0.218654,-0.487216,-0.128012,0.379822,0.40407,-0.516039,0.0707325,0.461444,-0.471235,0.314348,0.647631,-0.20083,0.260875,0.470364,0.466978,0.630122,-0.182541,0.520011,0.0749325,0.546287,-0.668945,-0.389157,0.0409127,-0.706555,-0.472416,0.0992344,0.072019,-0.167307,0.742578,-0.38764,0.353933,0.656133,-0.452763,-0.11592,-1.30531,-0.0229456,-0.507715,0.207816,1.26885,-0.808748,-1.51831,0.239702,0.789629,-0.23275,-0.734932,-0.164323,-0.0983866,-0.0596764,0.696995,0.789385,0.343834,0.693647,0.375778,-0.0954881,-0.54966,-0.172268,-0.0934063,0.64957,0.120777,0.558784,0.315691,0.33731,0.143611,-0.0271771,0.080467,0.256317,-0.396976,0.329046,0.311759,-0.363521,-0.38171,-0.611073,-0.780349,-0.158923,-0.683954,0.337316,0.57805,0.368767,0.198634,-0.721472,-0.0313386,-0.02798,-0.58359,0.36489,0.0833552,0.254559,0.28001,-0.192627,0.300058,0.0839605,0.19262,0.0670161,0.441498,0.0269153,0.248131,0.225135,-0.175346,-0.655991,0.379228,-0.367185,-0.506508,0.140442,-0.135692,0.896559,0.209174,0.547911,-0.496562,-0.271047,-0.264078,0.518331,0.843521,-0.762054,0.119402,0.115023,-0.107573,0.539722,-0.277402,-0.769424,0.354442,0.269275,-0.529446,-0.995522,0.556763,-0.385473,0.637831,0.42052,-0.611256,0.120173,0.0603947,-0.237837,-0.243498,0.34863,0.895598,0.584172,-0.188119,0.47546,0.363144,0.158205,0.198812,0.764445,-0.438237,0.473998,0.0755105,-0.484947,0.147879,-0.545643,0.355299,0.539767,0.107717,-0.277061,-0.238362,-0.0845062,0.543484,-0.482203,-0.89053,0.382549,0.564153,-0.424209,-0.109461,0.0933654,0.574793,-0.165198,-0.0736598,-0.236629,0.20733,0.342111,-0.617515,-0.0307093,-0.0672914,0.337475,-0.397808,0.143895,-0.434889,0.397388,-0.54974,-0.148608,0.996212,0.330094,-0.54266,0.346245,0.0761621,0.298895,0.133911,-0.173775,1.35938,0.311272,-0.783978,-0.457992,-0.15284,-0.50161,0.162744,0.172192,0.159861,-0.918072,0.252145,0.600792,-0.332832,-0.240228,-0.347518,-0.342403,-0.254379,-0.00866934,0.228291,-0.619114,-0.196603,0.0431421,0.282826,-0.0885401,-0.266852,0.145107,-0.279736,0.352773,1.00345,-0.149608,0.0134282,0.549913,-0.0487117,0.0611103,0.233086,0.204538,1.20515,1.17806,0.0434075,0.399135,-0.154454,0.133814,-0.381726,-0.179821,-0.326977,0.228886,-0.134839,-0.244284,0.484881,-0.324675,0.0241124,0.256617,0.0361117,0.506578,-0.0515188,-0.463089,-0.035921,0.213284,0.412168,0.504158,-0.694825,0.125663,-0.110863,-0.42131,-0.543824,-0.441124,0.00666923,0.568029,-0.734557,0.37276,-0.111702,0.243186,-0.585946,-0.404521,-0.1086,-0.400725,0.587836,-0.0049724,0.692402,-0.39852,0.30286,0.19518,-0.111361,-0.373789,0.223603,0.296425,0.055538,0.0465268,-0.434957,-0.471574,-0.0593279,0.292751,-0.652109,-0.0167798,0.206498,0.285427,0.45442,0.534254,-3.39643 +3404.2,1,0.0912059,4,1.48428,0.916216,-1.51868,0.534024,0.95376,-0.0589823,0.122388,-0.144655,0.55859,0.187947,-0.0334203,0.160317,0.0211587,0.100857,-0.713339,1.13035,0.0050076,0.0114294,0.853811,-0.267074,-0.0353388,-1.10055,-0.712133,-0.219345,-0.00232118,0.105161,0.342274,0.0532244,-0.657829,-0.155782,0.217873,-0.556155,0.163116,0.536048,-0.113849,0.00216678,-0.0459787,0.320246,0.508476,0.130924,0.84943,0.790084,0.973953,-0.235109,-0.377959,0.613247,-0.938919,0.358689,0.483734,0.047161,0.273823,0.635004,-0.209085,0.159303,0.78919,0.0607914,-0.495463,-0.865066,0.00909084,-0.100604,-0.0499977,0.934931,-0.0600805,-0.432463,-0.358368,0.196701,0.142229,-0.431164,-0.0386261,0.241088,-0.676327,0.258611,0.537803,-0.529881,0.593684,0.259969,0.409741,-0.755115,-0.0013335,0.178417,0.675921,0.132473,0.292232,-0.224849,0.152676,-0.410431,-0.121886,-0.142873,0.453637,0.363194,0.652646,0.0595529,0.0192077,-0.0190961,-0.0888898,-0.2096,-0.00268578,-0.226895,-0.0599778,0.294005,0.166903,0.307958,-0.546731,0.266958,-0.418516,-0.423772,-0.0437391,-0.806496,0.0114093,0.358974,0.294368,0.199434,-0.115021,0.0475971,-0.409777,0.366354,-0.593304,0.699351,0.111563,0.245273,-0.435735,-0.0897886,-0.152749,-0.0258723,-0.166748,-0.215707,-0.113855,-0.0210598,-0.0344639,-0.920188,0.487498,-0.0159847,-0.11592,0.424823,-0.116599,-0.0283362,-0.58984,-0.469986,0.108687,-0.304468,-0.67164,0.241692,-0.0221613,-0.922922,-0.161726,0.476848,-0.211041,0.0873075,0.382092,-0.168453,0.424967,-0.20964,-0.13141,-0.402492,0.155623,0.624758,0.586599,-0.00788069,-0.0296035,0.0445483,-0.132808,-0.236456,1.42959,-0.199457,0.168634,-0.157294,-0.321834,-0.34713,-0.25447,-0.0709537,0.384513,-0.359015,-0.349677,-0.0111203,-0.268116,0.0244457,0.673779,-0.128453,0.521682,0.494689,0.215325,0.121066,-0.235269,-0.240214,0.088334,-0.404517,-0.162343,-0.50275,-0.50758,-0.462857,0.213914,0.281709,0.0362386,-1.14504,0.0815677,0.0996667,0.544086,-0.0982498,-0.222464,-0.584303,0.164458,-0.735893,0.349668,-0.356404,0.493444,0.649526,-0.0330451,1.47249,0.993949,0.0282682,-0.257535,-0.102208,0.0374237,0.444244,0.255273,0.529477,-0.420175,0.299215,0.294063,-0.362385,-0.201359,-0.345699,0.06934,1.10003,0.0829233,0.305496,0.172927,-0.122101,0.31088,0.6037,-0.76901,-0.163709,-0.0561806,-0.309177,0.152786,0.685374,-0.0979588,0.767366,0.372174,-0.288999,0.00886806,0.258416,0.0953234,-0.223763,0.217288,0.459068,0.284073,-0.36932,0.0482547,-0.501349,0.230232,-0.422182,-0.140675,-0.73703,-0.367265,0.353873,-0.554778,0.378969,0.247779,0.392471,-0.00660161,0.443169,0.209396,0.474203,0.463032,0.303593,0.244808,-0.60733,-0.275412,-0.0543684,-0.195751,-0.323782,-0.00178773,-0.160035,-0.425877,-0.197569,-0.0537122,0.303438,-0.102131,-0.274801,-0.193968,0.0142963,-0.550157,0.747119,-0.178383,0.0931167,-0.225843,0.755623,0.171714,0.160308,-0.266964,-0.0499718,0.18907,0.41036,0.337424,-0.242967,-0.0641485,0.0544744,-0.0354393,-0.477906,-0.354061,0.125963,0.254454,0.354913,0.504434,-2.99559 +3422.25,0.831044,0.0912059,4,1.52328,0.890364,-1.13723,0.435155,0.491953,-0.024443,0.069404,0.0566646,0.410711,-0.339564,0.195098,0.340092,-0.551129,0.302005,0.0895726,0.83719,0.245696,-0.0264874,0.512103,-0.0878701,-0.182471,-0.868365,-0.701586,-0.0207098,-0.342381,0.0422902,0.524778,0.344299,-0.770446,0.157383,0.333535,-0.487571,0.0074127,0.660646,-0.314584,-0.109091,-0.42234,0.543379,0.439306,0.36909,1.02473,0.602926,0.263578,-0.502851,-0.176538,1.03644,-0.869404,0.447637,0.481695,-0.0197637,0.0509065,0.316396,-0.0900386,0.092817,0.787876,0.00694907,-0.30179,-0.699198,0.153618,-0.42261,-0.191766,1.15706,-0.735972,-0.639138,-0.237684,-0.682163,-0.32904,0.0238254,0.463193,-0.234718,-0.351334,0.657479,0.586689,-0.0491214,0.282764,0.325894,0.352719,-0.273151,-0.404262,-0.0589272,0.461064,0.31098,0.757322,0.0230885,-0.421478,0.0407203,-0.296515,-0.00211726,-0.113397,0.265074,0.104111,0.206816,-0.285377,0.0314291,-0.0006129,-0.144358,0.37232,-0.123665,-0.189917,0.473809,0.556027,-0.15234,-0.269151,0.202028,-0.0871186,-0.521297,0.373705,0.0876595,0.45851,0.498791,0.655203,0.345001,0.118962,0.122486,-0.40035,0.125268,-0.769649,0.348869,0.196882,0.0256257,-0.674151,-0.500857,-0.452341,-0.37498,0.128999,0.168636,0.177292,0.191352,0.124184,-1.08489,0.439051,-0.220011,-0.493006,0.212246,-0.478797,-0.107652,-0.402961,-0.3607,0.226025,-0.107887,-0.769766,0.223686,0.308095,-0.292144,-0.440675,-0.246596,-0.0075798,0.361227,0.0665146,-0.875374,0.0566965,-0.440166,0.363208,-0.264427,0.666837,0.452332,-0.245584,0.00110456,0.0611527,-0.0538523,-0.0682602,0.223189,1.00501,-0.200759,0.149939,0.0373365,-0.166927,-0.399136,-0.562137,-0.351824,0.299292,-0.514124,-0.413939,-0.0450695,-0.0614169,-0.321405,-0.158867,0.313019,0.880232,0.72926,0.147261,0.23304,-0.0168656,-0.519445,0.267025,-0.34133,-0.00158139,-0.16754,-0.0165753,-0.860951,-0.136278,-0.102065,0.283645,-0.807677,0.116282,-0.0272217,0.160846,-0.151311,-0.0334559,-0.346256,-0.00476034,-0.613258,0.266566,-0.390501,-0.247383,0.941521,-0.0692545,1.20714,0.200309,-0.197081,-0.197639,0.25261,0.363241,0.27134,0.212461,0.224097,-0.326685,0.0471876,0.197293,-0.11052,-0.0714734,0.192221,-0.464525,0.590347,-0.113679,0.224389,-0.336679,-0.171927,0.135651,0.0637875,-0.558242,-0.0865257,-0.306486,0.149451,0.2373,0.572378,-0.191582,0.200792,0.592626,-0.223374,0.0383347,0.0474125,-0.0984121,0.0138594,0.343752,0.607229,0.489199,-0.318378,0.084601,-0.343624,-0.333924,-0.859057,0.731904,-0.649698,-0.44746,-0.0740011,-0.592251,0.472434,0.375288,0.0156558,0.202497,0.184835,-0.122175,0.442468,0.225294,0.402102,0.475426,-0.300036,-0.727088,-0.173062,-0.2737,-0.339489,0.143912,-0.447718,-0.0300874,-0.243474,0.242486,0.0170661,-0.591104,0.134633,-0.0647413,-0.390314,-0.275022,0.139364,-0.171241,-0.0519593,0.113102,0.326926,0.262398,-0.19718,-0.444281,0.127004,0.136313,0.0206846,0.258487,-0.173912,-0.463423,0.324316,-0.864572,-0.166355,-0.33855,0.171778,0.240482,0.414461,0.49039,-1.49307 +3398.95,1,0.0912059,4,1.63751,0.494735,-2.29751,0.986633,0.383594,-0.0784932,-0.183503,-0.0398003,-0.337437,-0.130128,0.359947,-0.178967,-0.0318984,0.282341,-0.330201,0.363342,0.49805,-0.0359771,-0.0236355,0.288919,0.268713,-0.576583,-0.753012,0.562749,-0.13523,-0.46725,-0.485092,-0.330573,-0.137383,-0.221913,0.339499,-0.418713,-0.0172306,0.504935,-0.615376,-0.238782,-0.177926,0.647322,0.401446,-0.132399,0.870049,0.0893185,0.7813,-0.861484,-0.0189117,-0.378363,-0.519651,-0.440623,0.209334,0.22757,-0.0667946,0.849059,0.0363497,-0.308351,0.138073,-0.0884701,-0.388048,-0.810325,-0.0649178,-0.558506,0.47244,0.648608,0.14653,-0.831774,0.539927,0.572648,0.0871297,-1.1044,0.150292,-0.213001,-0.131184,0.0909837,0.684677,-0.246079,0.516816,0.435765,0.423808,-0.648323,-0.412569,-0.208345,0.115064,-0.154561,-0.0252111,-0.586946,-0.270147,-0.130616,-0.0173336,-0.200769,0.635979,0.128466,-0.275029,-0.143261,-0.010315,0.0200964,-0.0851517,-0.350502,-0.186887,-0.0916179,-0.00120549,0.234691,0.76297,0.14681,-0.001709,-0.0433443,0.0895965,0.355327,0.152017,-0.58896,-0.244117,0.891678,-0.624134,-0.240284,-0.315678,0.36496,0.161264,0.682882,0.0151305,0.111103,0.733701,0.0714002,-0.268119,-0.325432,0.276345,0.186764,-0.201427,-0.343298,0.657676,0.398487,0.413593,-0.613635,-0.3351,0.117903,-0.0340348,0.463322,-0.16664,-0.0604298,-0.490718,-0.162219,0.262546,-0.523698,0.0655036,0.201681,-0.0220692,-0.142007,-0.0638328,0.576917,0.116723,-0.403554,0.485553,-0.262962,-0.528525,0.117357,0.165063,0.124,0.309813,0.348697,0.538851,-0.355527,0.0484025,0.0869194,0.355699,0.250728,0.265302,0.25374,-0.147645,0.2062,0.029339,0.190781,-0.0527656,0.180293,0.224048,0.310153,0.0932992,-0.151258,0.33844,-0.152729,-0.0349779,0.206413,0.00305197,1.02128,-0.14293,-0.120099,0.318313,0.212595,-0.488311,-0.46128,-0.363378,-0.809588,-0.224625,0.130244,0.454357,0.125686,-0.545202,-0.291386,0.233396,-0.423728,-0.149255,-0.320863,-0.346722,-0.350068,0.13996,0.0301877,0.480433,0.363206,-0.862851,-0.743253,-0.659342,1.56201,0.167698,0.167711,-0.427835,0.0426519,0.384698,-0.16218,-0.165369,0.0717629,-0.395489,0.248976,0.415281,-0.353369,-0.532242,-1.02116,0.0894273,0.803281,-0.113354,0.497187,0.0602055,-0.501206,0.0870432,0.184802,0.219904,-0.133322,0.109193,-0.251613,-0.0816427,0.642937,0.10124,0.0449363,0.459811,-0.720016,-0.247341,0.386325,0.201493,-0.269315,-0.158811,-0.447519,0.299977,0.27595,-0.1429,-0.113095,0.118703,-0.235423,-0.290044,-0.460688,-0.150151,0.0950423,-0.256845,-0.339775,-0.0498838,0.537355,-0.164903,0.163305,-0.575917,0.468916,-0.0737338,0.34953,0.286009,-0.517293,-0.0622363,-0.351012,-0.0404844,-0.771673,-0.689061,0.719289,0.815463,-0.0800934,-0.215044,0.216322,-0.368255,0.379684,-0.471835,0.710914,0.245266,-0.132368,0.127633,0.0671874,-0.192211,-0.032241,0.121211,0.192384,0.13151,0.316145,-0.0933789,0.380087,0.111333,-0.310658,0.637166,-0.71857,0.268388,-0.215186,-0.408712,0.170082,0.180175,0.412409,0.42447,-0.219518 +3420.08,0.935251,0.0912059,4,1.58568,0.576377,-1.73959,0.743748,0.407416,-0.13423,-0.260744,-0.271929,0.368734,0.0327836,0.392708,-0.192056,-0.568238,0.308471,-0.470363,0.700369,0.465544,-0.0272097,0.119081,0.103723,-0.0124701,-0.615115,-0.634525,0.690898,-0.270979,0.072307,0.00700104,-0.0313813,-0.532914,0.216004,0.486671,-0.759252,-0.438163,0.417578,-0.553671,-0.275939,-0.197959,0.211623,0.294625,0.199176,0.906949,0.773713,0.124016,-0.860501,-0.0823741,-0.0123819,-0.625348,0.546244,0.295589,-0.141195,0.25942,0.16863,-0.165521,-0.325168,0.561583,0.323523,-0.424557,-0.785505,0.809871,-0.383997,0.0877755,1.25625,-1.10863,-0.469855,-0.44617,-0.303074,0.239199,-0.16807,-0.278529,-0.130996,0.164707,0.245745,1.07312,-0.171705,0.391704,0.168562,0.293645,-0.1368,-0.496743,0.0268366,0.714491,-0.400213,0.346756,0.0869542,-0.278735,0.186921,-0.211193,-0.491662,0.0748192,0.106355,-0.387175,-0.277653,0.0737101,0.163223,0.237318,-0.188778,-0.356559,-0.323714,-0.196137,0.257674,-0.0678866,-0.59076,-0.152263,-0.344414,-0.268586,-0.881786,0.78416,-0.362053,-0.165012,-0.192766,0.288917,-0.151395,-0.382906,0.30046,-0.293758,0.375457,0.0282273,0.174828,0.00751713,-0.081324,-0.863154,-0.0330436,-0.465781,0.0275073,-0.131846,0.522518,0.0729619,-0.135068,-0.0660423,-1.06139,0.072498,0.347511,-0.126416,0.205062,-0.381619,-0.0157527,-0.152865,-0.270661,0.255484,-0.471638,-0.479271,-0.269175,-0.502519,-0.37934,0.0433021,-0.55923,-0.141102,0.479949,0.366309,-0.304381,0.505584,0.122266,0.0600093,0.0392375,0.188286,0.710017,-0.0844498,0.325132,-0.0303105,-0.26577,0.321064,0.00932332,0.759231,0.500083,-0.570759,0.0972635,-0.220166,-0.0209089,-0.14911,0.162935,0.172882,-0.274231,-0.204675,-0.193453,0.0395672,0.0637907,-0.676568,0.140202,0.0756961,0.45251,0.170345,-0.583315,0.478504,0.0511177,-0.169245,-0.682914,0.0225558,0.0408866,0.0407674,-0.252042,0.146728,0.162512,-0.41466,-0.641998,0.169036,0.166333,-0.152089,-0.317045,-0.499377,0.260263,-0.201281,-0.606059,-0.431958,-0.4332,0.29069,0.252971,-0.335199,1.3666,-0.14674,-0.0658494,0.475687,0.472898,0.278783,-0.180721,0.211731,0.58988,-1.36207,0.345371,0.0890237,-0.227609,0.315517,-0.273868,0.568495,0.158607,-0.577306,0.569931,-0.533369,0.068406,-0.120135,0.211011,0.129679,0.201613,-0.759941,0.0300569,-0.475665,0.290212,0.311217,-0.0380369,0.440576,-0.183396,-0.195568,-0.328739,0.148458,-0.0781313,-0.137579,0.091533,0.226422,0.532233,-0.236906,-0.268769,-0.0030728,-0.663324,0.271422,-0.928413,-0.48982,0.572783,-0.14943,0.830746,0.178348,-0.203558,-0.0943602,0.727019,0.0850409,0.297717,0.31674,-0.0926807,0.854229,-0.350684,-0.382801,-0.188396,0.0603189,-0.587744,-0.234571,0.224341,-0.178027,-0.0622667,0.404487,0.492049,-0.230621,0.22599,0.283376,-0.198889,-0.143879,0.57336,0.0272934,0.193801,-0.105237,0.277433,0.687772,-0.106223,-0.0655649,-0.531469,-0.0254894,-0.0826685,-0.457123,-0.12556,0.0533352,-0.221865,0.137895,-0.473285,-0.02246,0.139387,0.21158,0.373345,0.459978,-0.543639 +3420.08,0.403345,0.0912059,4,1.58568,0.576377,-1.73959,0.743748,0.407416,-0.13423,-0.260744,-0.271929,0.368734,0.0327836,0.392708,-0.192056,-0.568238,0.308471,-0.470363,0.700369,0.465544,-0.0272097,0.119081,0.103723,-0.0124701,-0.615115,-0.634525,0.690898,-0.270979,0.072307,0.00700104,-0.0313813,-0.532914,0.216004,0.486671,-0.759252,-0.438163,0.417578,-0.553671,-0.275939,-0.197959,0.211623,0.294625,0.199176,0.906949,0.773713,0.124016,-0.860501,-0.0823741,-0.0123819,-0.625348,0.546244,0.295589,-0.141195,0.25942,0.16863,-0.165521,-0.325168,0.561583,0.323523,-0.424557,-0.785505,0.809871,-0.383997,0.0877755,1.25625,-1.10863,-0.469855,-0.44617,-0.303074,0.239199,-0.16807,-0.278529,-0.130996,0.164707,0.245745,1.07312,-0.171705,0.391704,0.168562,0.293645,-0.1368,-0.496743,0.0268366,0.714491,-0.400213,0.346756,0.0869542,-0.278735,0.186921,-0.211193,-0.491662,0.0748192,0.106355,-0.387175,-0.277653,0.0737101,0.163223,0.237318,-0.188778,-0.356559,-0.323714,-0.196137,0.257674,-0.0678866,-0.59076,-0.152263,-0.344414,-0.268586,-0.881786,0.78416,-0.362053,-0.165012,-0.192766,0.288917,-0.151395,-0.382906,0.30046,-0.293758,0.375457,0.0282273,0.174828,0.00751713,-0.081324,-0.863154,-0.0330436,-0.465781,0.0275073,-0.131846,0.522518,0.0729619,-0.135068,-0.0660423,-1.06139,0.072498,0.347511,-0.126416,0.205062,-0.381619,-0.0157527,-0.152865,-0.270661,0.255484,-0.471638,-0.479271,-0.269175,-0.502519,-0.37934,0.0433021,-0.55923,-0.141102,0.479949,0.366309,-0.304381,0.505584,0.122266,0.0600093,0.0392375,0.188286,0.710017,-0.0844498,0.325132,-0.0303105,-0.26577,0.321064,0.00932332,0.759231,0.500083,-0.570759,0.0972635,-0.220166,-0.0209089,-0.14911,0.162935,0.172882,-0.274231,-0.204675,-0.193453,0.0395672,0.0637907,-0.676568,0.140202,0.0756961,0.45251,0.170345,-0.583315,0.478504,0.0511177,-0.169245,-0.682914,0.0225558,0.0408866,0.0407674,-0.252042,0.146728,0.162512,-0.41466,-0.641998,0.169036,0.166333,-0.152089,-0.317045,-0.499377,0.260263,-0.201281,-0.606059,-0.431958,-0.4332,0.29069,0.252971,-0.335199,1.3666,-0.14674,-0.0658494,0.475687,0.472898,0.278783,-0.180721,0.211731,0.58988,-1.36207,0.345371,0.0890237,-0.227609,0.315517,-0.273868,0.568495,0.158607,-0.577306,0.569931,-0.533369,0.068406,-0.120135,0.211011,0.129679,0.201613,-0.759941,0.0300569,-0.475665,0.290212,0.311217,-0.0380369,0.440576,-0.183396,-0.195568,-0.328739,0.148458,-0.0781313,-0.137579,0.091533,0.226422,0.532233,-0.236906,-0.268769,-0.0030728,-0.663324,0.271422,-0.928413,-0.48982,0.572783,-0.14943,0.830746,0.178348,-0.203558,-0.0943602,0.727019,0.0850409,0.297717,0.31674,-0.0926807,0.854229,-0.350684,-0.382801,-0.188396,0.0603189,-0.587744,-0.234571,0.224341,-0.178027,-0.0622667,0.404487,0.492049,-0.230621,0.22599,0.283376,-0.198889,-0.143879,0.57336,0.0272934,0.193801,-0.105237,0.277433,0.687772,-0.106223,-0.0655649,-0.531469,-0.0254894,-0.0826685,-0.457123,-0.12556,0.0533352,-0.221865,0.137895,-0.473285,-0.02246,0.139387,0.21158,0.373345,0.459978,-0.543639 +3407.38,0.997111,0.0912059,4,1.65902,0.555207,-1.8061,0.821468,0.0594368,-0.0740178,0.174635,-0.627048,-0.171968,-0.0560804,0.492369,-0.172154,0.0851117,0.438076,0.124169,0.0947046,0.39931,0.0839645,-0.255683,0.24309,-0.0215715,-1.36869,-0.786809,0.788731,0.106573,-0.0278905,-0.311271,-0.024564,-0.575579,-0.00652393,0.400439,-0.974602,0.351658,0.34334,-0.989845,-0.277702,-0.00417423,1.11097,0.368855,-0.923297,0.878784,0.847585,0.759983,-0.85938,-0.539733,-0.39642,-0.531661,-0.464763,0.252598,0.175063,-0.00314449,0.441886,-0.0827638,-0.326687,0.089358,0.0956176,-0.224189,-0.326034,0.36926,-0.387698,0.50992,0.812819,-0.261954,-0.88657,0.133186,0.029015,-0.281404,-0.347781,-0.0419693,-0.852955,-0.129154,0.397755,0.825667,0.0188998,0.781364,0.596222,0.276053,-0.324667,-0.258627,-0.0558359,0.741707,-0.634339,-0.231985,-0.0567807,0.0259654,-0.384978,-0.100563,0.151952,0.195748,-0.279236,0.211044,-0.558062,-0.0109737,0.434446,0.481965,-0.24302,0.222709,-0.00922363,0.0237724,0.0781178,-0.296026,0.0778099,-0.244971,0.210801,0.141193,-0.574137,0.66506,0.080463,0.612948,0.847089,0.0831641,0.180304,0.495034,0.585347,-0.151817,0.42876,-0.624689,-0.270464,0.498906,-0.843129,-0.466688,-0.437469,0.163805,0.0896086,-0.267708,0.157704,0.478079,0.197582,0.0333651,-0.122139,0.112037,0.320584,-0.000267354,1.02372,-0.0306769,0.000749615,-0.304013,-0.222616,0.531421,0.0512691,-0.775544,-0.0365188,-0.644291,-0.771063,0.298305,0.646699,0.295526,-0.0251843,0.626849,-0.68515,-0.916213,0.205361,0.401566,0.151997,0.0352832,0.368603,0.0382214,-0.0507885,-0.0585895,-0.0478828,0.462611,0.290133,0.915783,0.0393904,-0.53569,0.396766,0.0621714,-0.194978,-0.300256,0.551492,0.12656,-0.604632,0.208545,-0.457725,-0.41009,0.180599,-0.389769,0.266958,0.31849,0.507882,0.166871,-0.270676,0.453604,0.183557,1.17914,-0.297123,-0.405905,-0.515841,0.152729,-0.597352,0.433716,-0.32029,0.78693,-0.853675,0.106401,-0.210216,0.0620546,-0.087934,-0.27755,-0.187111,-0.151428,0.00649324,-0.38011,0.432904,-0.234825,-0.14188,-0.579483,1.66849,-0.220577,-0.2821,-0.0988442,0.01024,0.0618565,-0.229808,-1.26415,0.316818,0.13621,-0.254931,0.182104,-0.268163,-0.147231,-0.636714,-0.36382,0.226265,-0.520202,0.39365,-0.345815,-0.346811,-0.115255,0.0645678,-0.121799,-0.0147796,-0.33852,-0.0621999,-0.105485,-0.0258916,-0.257363,0.0695272,0.588816,0.0480383,-0.207234,0.903395,-0.417076,-0.184629,0.357509,0.2013,0.252673,-0.491421,-0.202327,0.0225407,0.183223,-0.454775,-0.0246608,0.0341681,-0.309884,-0.115028,-0.48702,0.177115,0.282323,0.0381228,-0.369995,-0.204295,0.226857,0.337031,0.202438,0.40571,0.368968,-0.0619641,0.333064,0.107796,0.43753,-0.227335,-0.127886,0.0112064,-0.235473,0.170553,-0.178595,-0.540123,-0.00527517,0.0959938,-0.10433,-0.0365052,-0.203144,0.0674723,0.231418,0.079649,-0.0466772,-0.047964,0.236757,0.102264,0.179742,0.126163,-0.217629,-0.591345,-0.111216,-0.199541,0.0887343,0.0819888,-0.172235,-0.270689,0.421987,0.146561,0.299901,0.382833,0.547632,0.668537 +3396.9,0.95586,0.0912059,4,1.59014,0.570458,-1.75167,0.805337,0.299491,-0.0815618,0.229712,-0.697493,0.252976,0.169377,0.541334,-0.142412,0.0198701,0.299961,-0.245331,-0.0142449,0.384831,0.10507,0.314929,0.458855,0.27757,-1.00972,-0.469968,0.655383,0.210041,-0.178907,-0.795953,0.141556,-0.732907,-0.094992,0.755057,-0.288396,0.0247781,0.394542,-0.86714,-0.689105,-0.974812,0.706073,0.674432,-0.700093,1.14278,0.90795,-0.00400469,-1.16197,-0.927964,0.0903022,-0.62604,0.0046795,-0.0854144,-0.0257517,0.0836915,0.519887,-0.267786,-0.693075,0.275171,0.390768,-0.219018,-0.175277,0.536452,-0.0658994,0.37829,0.749363,-0.640522,-1.34327,-0.203571,0.00749227,0.310005,-0.275068,-0.0470116,-1.01242,-0.210831,0.40292,0.950331,0.0494936,0.701098,0.599488,0.206582,-0.266445,-0.484756,0.43915,0.5981,-0.426521,0.268402,-0.28012,-0.122948,0.482268,0.39948,0.238197,-0.0496695,0.024778,0.00333322,-0.524353,0.133317,0.622961,0.31146,-0.412206,0.466946,-0.0455766,0.473561,0.232767,-0.248804,0.36803,0.0212953,-0.331245,0.0912854,-0.387187,0.667207,-0.0651825,0.134334,0.634637,0.0899878,-0.281454,0.155581,0.329918,0.178382,0.0213045,-0.783893,0.0430027,0.0622818,-0.353588,-0.520533,0.151915,-0.264421,-0.375747,-0.491661,0.0491882,-0.0533803,0.614271,0.397444,0.0517193,-0.152942,0.353325,-0.274074,0.703836,-0.313215,-0.0881825,-0.37422,-0.427774,0.596091,-0.0692817,-0.488493,-0.121324,-0.280733,-0.162936,0.667902,-0.132191,-0.295463,0.690353,0.164366,-0.735833,-0.528186,0.418407,0.297611,0.311089,0.0169923,-0.0341662,0.117332,0.173168,0.254383,0.0886279,0.0509284,0.187365,0.61707,0.203888,-0.417957,-0.0595993,0.265249,-0.237878,-0.19884,0.12721,0.23413,-0.518793,-0.0885079,-0.704528,-0.695855,0.0316939,-0.60045,-0.332666,0.0893363,0.707876,-0.0164951,-0.349763,0.502188,-0.206047,0.626849,-0.136517,-0.52652,-0.8254,0.101185,-0.00889884,0.179973,-0.452875,0.387845,-0.52678,-0.201461,0.0654715,0.0990424,-0.795657,-0.0935977,0.452101,-0.125363,-0.244244,-0.324518,0.482337,-0.203339,-0.0199516,0.177486,1.32537,0.232503,-0.158572,0.0888209,0.252183,0.284195,0.135251,-0.792764,0.22928,0.153387,-0.241377,0.00788324,0.146415,0.23406,-0.294276,-0.0969519,0.148402,0.664146,0.775517,-0.553748,-0.135464,-0.292233,-0.365435,-0.140796,-0.0404146,-0.0445441,-0.178342,-0.504722,0.160909,-0.213823,0.0289415,0.718002,0.132396,0.118126,0.458286,-0.353522,0.24519,0.249495,0.0640996,0.131759,-0.851202,-0.604509,-0.0407149,0.306844,-0.479915,0.465991,-0.353431,-0.568972,-0.642791,-0.485602,0.127178,0.179471,0.175113,-0.467264,-0.296446,0.657302,-0.125589,0.396634,-0.329329,0.194179,-0.451564,-0.380618,-0.201102,0.323283,-0.336736,-0.446247,-0.311982,0.0617469,-0.927267,-0.0524308,-0.271313,0.583833,0.384647,-0.0625581,-0.107901,-0.572971,0.171441,0.035121,-0.352505,-0.160392,0.177083,0.131691,-0.127525,0.132029,-0.266039,-0.862805,-0.321603,-0.315843,-0.162606,-0.173807,0.0666621,-0.302719,-0.387667,0.0904889,0.160644,0.374832,0.400805,0.612235,-0.235655 +3408.61,0.947738,0.0912059,5,1.63368,0.564238,-1.64415,0.630063,-0.149871,-0.0798773,-0.333783,-0.485242,0.0486968,-0.234162,0.0673281,-0.0479086,-0.805507,0.568239,0.0749578,0.622862,0.220947,0.024811,-0.492211,0.669242,0.148125,-0.83557,-1.59404,0.398744,-0.555296,-0.219882,-0.466037,-0.488903,-0.541004,-0.104412,1.18938,-0.915424,-0.0999277,0.0963743,-0.465407,0.0756289,0.14668,0.764095,-0.20648,-0.285847,1.11815,0.568464,0.320728,-0.900522,0.149726,0.0552852,-0.728118,0.113903,0.780117,0.166063,0.408373,-0.0557148,0.0726436,-1.18505,0.687762,-0.0960273,0.0884365,-0.244071,-0.13809,-0.112391,0.102341,0.7571,-0.956046,-0.658236,-0.00492141,0.0828795,0.664014,-0.472377,-0.277264,-0.58932,0.0158452,0.0514301,0.539163,0.0866086,0.469691,0.323916,0.494361,-0.255381,-0.309303,-0.427116,0.933114,-0.740392,0.240213,-0.394411,-0.324601,0.352498,-0.277415,-0.0104585,0.227137,-0.547941,0.234819,-0.291469,0.0163335,-0.344491,0.239355,-0.474322,-0.485052,-0.326263,0.101675,-0.166655,-0.238264,0.0642246,-0.201941,-0.0751017,-0.140866,-0.220255,0.0538614,-0.161434,0.301936,0.275496,-0.124386,0.332461,0.320021,0.366497,-0.262201,-0.0517726,-0.360396,0.224832,0.213196,-0.0340063,-0.843223,0.416492,-0.118624,0.32393,-0.553994,0.20411,0.0666259,-0.318655,0.0834614,-1.19964,0.404203,0.0443302,-0.02188,0.727677,0.09885,-0.509339,-0.142966,-0.556985,0.10705,-0.899559,-0.498878,0.386084,0.0345272,-0.628937,-0.16267,0.180426,-0.0259128,0.131663,-0.139053,-0.167253,-0.805809,0.145454,0.0238769,0.164816,0.238133,0.406574,-0.249899,0.0912161,-0.225481,-0.116756,0.349915,0.204643,0.7884,0.0225783,-0.734986,0.177088,-0.102034,-0.580696,-0.0647228,0.559858,0.295599,0.467013,-0.0684851,0.0164896,-0.295673,-0.594834,0.275343,0.115793,-0.279061,0.723129,-0.37517,-0.41694,0.769541,0.295079,0.129781,-0.565102,-0.0928957,-0.0801409,0.261722,-1.28044,0.155672,0.361487,-0.187915,-0.602197,-0.111747,0.227106,-0.385414,0.120075,0.0318218,0.335218,0.335504,-0.161072,0.26503,0.132606,0.250705,0.113504,-0.415095,0.777552,-0.150186,0.089486,0.115515,-0.266739,0.242001,-0.173216,-0.255687,0.458304,-0.413432,0.143928,0.615404,-0.555308,-0.309418,0.0303985,-0.177713,0.49549,-0.720949,0.207795,-0.476595,-0.194251,0.223781,0.630964,-0.327057,0.0748149,-0.765989,-0.144761,-0.446448,0.679327,-0.338482,0.61531,0.574878,-0.493045,0.402776,0.343881,-0.832074,0.51008,-0.517012,0.363363,0.454593,0.365237,0.276667,-0.0414206,-0.057499,-0.869349,0.351188,-0.531031,-0.120185,0.303796,0.089465,-0.0429141,-0.139925,0.108886,-0.0493952,0.705753,0.27012,0.352912,0.35933,0.622341,-0.076839,-0.104094,-0.159581,0.307035,-0.248618,0.039769,-0.0502812,0.0730752,-0.085672,0.646305,-0.104922,-0.233449,-0.0418378,0.334867,-0.121094,-0.00957455,0.117886,0.623359,0.137697,0.0418093,-0.298708,0.681474,0.0505046,0.248884,-0.424285,-0.171949,0.109833,-0.00239563,-0.0831589,-0.594778,-0.0124815,0.0402127,0.0982856,-0.182088,-0.207422,0.15589,0.247965,0.394829,0.49796,1.41999 +3421.56,0.999919,0.0912059,4,1.66626,0.503214,-1.65684,0.637424,-0.207001,-0.0513738,-0.343592,-0.324077,0.0369631,-0.356254,-0.0264528,-0.220855,-0.689151,0.765571,-0.0621193,0.68972,0.732615,0.170974,-0.462317,0.473714,-0.0781167,-1.00606,-1.72069,0.468995,-0.588792,-0.297339,-0.0691689,-0.384143,-0.875692,0.0954685,1.09678,-0.926347,-0.461938,-0.0967506,-0.203103,-0.0362002,-0.164354,0.747388,0.0362112,-0.716897,1.18689,0.548605,0.389503,-0.900153,0.0293652,0.0547884,-0.743585,0.289871,0.639595,0.197289,0.334542,0.386846,-0.121297,-0.889276,0.793043,-0.101954,0.0452428,-0.222327,0.17261,-0.207735,0.0433144,0.805118,-0.587631,-0.466975,-0.152947,0.277232,0.545541,-0.483237,-0.475169,-0.624768,0.16369,0.0814191,0.458896,0.00850265,0.586666,0.330923,0.0761591,-0.204631,-0.256679,-0.387251,0.664297,-0.586396,0.15981,-0.45094,-0.283996,0.483159,-0.0520647,-0.0620819,0.104893,-0.536177,-0.011977,0.0384587,0.0334541,-0.016593,0.19993,-0.603563,-0.597528,-0.324938,-0.124207,-0.0118723,-0.315428,0.299691,-0.197383,-0.0688916,-0.159705,-0.216199,0.264753,-0.45436,0.146574,0.495717,-0.249208,0.26757,0.48778,0.239351,-0.420632,-0.228831,-0.231569,0.221237,0.171734,-0.46721,-0.89769,0.333995,-0.140488,0.253919,-0.684806,0.250116,0.233317,-0.229315,-0.0130538,-0.99939,0.358173,0.121575,-0.248489,0.874575,-0.156713,-0.351288,0.0630858,-0.472816,0.192744,-0.848769,-0.279822,0.22621,0.352726,-0.537129,-0.245828,0.0787322,0.1421,-0.313811,-0.129321,-0.0726417,-0.718505,0.0878408,0.124386,0.180783,0.33028,0.310644,-0.2678,0.080983,-0.169242,-0.111299,0.227433,0.0554556,0.736271,-0.155229,-0.705952,0.057684,0.155797,-0.419598,-0.230952,0.397059,0.139071,0.534445,-0.102825,0.170219,-0.320175,-0.461707,-0.0353468,0.0582984,-0.311734,0.737721,-0.283423,-0.273789,0.568266,0.246236,-0.0223298,-0.735078,-0.147437,-0.15816,0.513209,-0.992967,0.117872,0.492487,-0.010939,-0.61774,-0.00850227,-0.0188733,-0.142479,0.0893955,0.0746332,0.268692,0.401457,-0.177174,0.468225,0.251047,0.406788,0.30969,-0.276921,0.79885,-0.0370096,0.333212,0.202547,-0.218337,0.216353,-0.272202,0.00824273,0.422313,-0.0780468,0.203041,0.521553,-0.400758,-0.208079,-0.457389,-0.329012,0.250152,-0.373102,0.292293,-0.55645,-0.279817,0.381378,0.553958,-0.514867,-0.131424,-0.483425,0.133647,-0.499557,0.544916,-0.479997,0.668231,0.531528,-0.575133,0.6966,0.240135,-1.04908,0.235994,-0.152358,0.30484,0.510826,0.28203,0.26593,-0.174714,-0.173106,-0.996828,0.110879,-0.443537,-0.072321,0.229927,-0.280121,0.0767873,-0.204056,0.378477,-0.0397712,0.73209,0.186098,0.325188,0.622563,0.245827,-0.185413,-0.248614,-0.00125576,0.00737333,-0.200171,0.178963,0.184671,0.111242,-0.168423,0.511892,0.0794234,-0.404233,-0.0198403,0.369291,-0.291319,0.373307,0.190083,0.664774,0.0994233,0.0922294,-0.126386,0.669705,-0.0496007,-0.211282,-0.131335,-0.143688,0.110913,0.141995,-0.0296406,-0.597465,-0.262265,0.0445844,0.264289,0.0470621,-0.0831376,0.15044,0.266993,0.387865,0.516714,1.74267 +3413.23,0.995876,0.0912059,4,1.55454,0.62446,-1.51767,0.592495,-0.222012,-0.192769,0.153779,-0.438565,0.396732,0.109519,0.333232,0.0512926,-0.379883,0.527106,-0.211734,0.532778,0.500906,0.0354619,-0.25881,0.16356,0.0577281,-1.26375,-1.16621,0.488272,-0.423173,-0.308882,-0.147532,-0.171282,-0.776255,0.104368,0.918257,-0.85642,-0.730653,0.366888,-0.591513,-0.0015268,-0.250467,0.850624,0.303024,-0.858452,1.1177,0.873001,0.615728,-0.904614,-0.0537495,0.706802,-0.487219,0.456217,0.478206,-0.172941,0.546245,-0.058296,0.135436,-0.487004,0.728507,-0.10208,0.468901,-0.343928,0.194543,0.082301,0.492908,1.07586,-0.796949,-0.501173,-0.150047,0.459309,0.203368,-0.186625,-0.446412,-0.612819,0.312013,0.549751,0.856119,-0.0984129,0.044397,0.0826266,0.381371,-0.290079,-0.1782,0.135814,0.586703,-0.459428,-0.0366484,-0.413965,-0.130227,-0.164726,-0.140032,0.0564442,0.196245,-0.374261,-0.0283607,-0.364506,0.0592675,-0.0812788,-0.228377,-0.249054,-0.279311,-0.314303,-0.247678,0.216018,-0.167017,0.379458,-0.655606,-0.391212,0.10512,-0.214179,0.388371,-0.337999,-0.394959,0.443037,0.410117,0.0260192,0.203453,0.288127,-0.416348,0.0860864,-0.151835,0.0737675,-0.259576,-0.273871,-0.601314,-0.215181,0.38572,0.0861574,-0.105983,-0.158225,0.119497,-0.0674186,0.0276785,-0.665365,0.164335,-0.49585,0.32618,0.0342594,-0.241759,-0.10592,0.213197,-0.2718,0.285289,-0.497664,-0.449,0.00794634,0.44316,-0.787528,0.0874716,0.464987,0.231445,-0.781705,-0.0568059,0.0334688,0.0334138,0.093742,-0.0994072,-0.133066,0.0327053,0.632511,-0.0748927,0.246513,-0.790677,0.0569288,0.394046,0.516231,0.315344,0.0833557,-0.302628,0.330168,-0.033141,-0.536993,-0.39952,0.256808,0.368436,0.263889,-0.185067,0.442558,-0.295249,-0.420125,0.112709,0.0291565,-0.215478,0.251715,-0.412263,-0.103132,0.525338,-0.0678265,-0.10275,-0.53372,0.134261,-0.508294,-0.185141,-0.62114,0.676063,0.0921044,-0.21623,-0.407799,-0.105839,0.00993626,-0.296786,-0.0667032,-0.0781132,0.244589,0.123331,-0.738682,-0.251825,0.553302,0.255274,-0.271667,-0.590795,0.930429,-0.095706,-0.139487,0.233611,0.163407,0.172935,0.158472,0.0768454,-0.0651701,-0.327893,-0.087855,0.616974,-0.747291,0.215171,-0.730632,-0.192082,0.681501,-0.777191,0.408303,-0.401997,-0.336602,0.157315,0.035155,-0.759775,-0.206641,0.236682,-0.423341,-0.743396,0.472758,0.0843601,0.234462,0.707613,-0.364231,-0.156418,-0.0436808,-0.828302,0.343829,-0.720402,0.323856,0.328858,0.307669,0.0413635,-0.230359,-0.195529,-0.85677,0.29433,-0.403328,0.240983,0.133143,-0.161058,-0.250703,-0.0216076,0.259203,-0.0247653,0.193828,0.0711483,-0.00494665,0.67794,0.363319,0.20764,-0.07424,-0.21271,-0.211947,0.314153,-0.17252,-0.639726,0.181709,-0.23786,0.306541,0.14234,-0.117861,-0.0943488,0.197005,-0.095501,0.321387,0.487594,0.218254,0.444955,0.30224,0.0386314,0.642103,-0.070881,0.151822,-0.297081,-0.111153,-0.164885,-0.194109,-0.0683627,-0.401513,-0.0262815,-0.474857,-0.328129,0.156257,-0.0720982,0.129431,0.324016,0.359766,0.569224,1.47125 +3421.03,0.882963,0.0912059,4,1.56499,0.746366,-1.19036,0.419974,-0.111378,-0.199104,0.331738,-0.123423,0.920724,0.19537,0.165233,0.0472265,-0.146902,0.703744,0.0732332,0.814531,0.4425,-0.211042,-0.498194,0.296768,-0.0697433,-1.65314,-1.28003,0.453486,-0.29738,-0.543487,-0.00377252,-0.32327,-0.73973,-0.062359,0.93625,-0.796804,-0.510335,0.168132,-0.564458,0.0504439,-0.255229,0.758342,0.39599,-0.757373,1.09253,0.74896,0.644238,-0.728526,0.107941,0.395744,-0.426172,0.570907,0.781625,0.0867115,-0.0234791,-0.470375,0.193734,-1.17714,0.957353,-0.314976,0.114504,0.0981271,0.368933,-0.010244,0.515979,0.988803,-0.705352,-0.337329,0.418846,0.196998,0.176466,-0.284846,-0.275337,0.0334505,0.30125,0.640141,0.573339,-0.14125,-0.031854,0.0834143,0.404512,-0.376222,-0.138928,-0.133358,0.972736,-0.814147,0.399634,-0.0208542,-0.233187,-0.0288073,-0.118271,-0.00618331,-0.101972,-0.524795,-0.380814,-0.397585,-0.101647,0.0144422,-0.00155621,-0.0804626,0.115987,-0.51709,-0.17447,0.406698,-0.127711,0.194923,-0.436799,-0.111829,-0.0262157,-0.13887,0.698322,-0.270995,-0.420866,0.739275,-0.132837,0.016702,0.242797,-0.096112,-0.103143,0.353045,-0.243947,0.0899476,0.0646294,-0.0531366,-0.62927,0.55608,-0.229573,-0.0603093,-0.294645,0.114314,0.11151,0.11163,-0.116317,-0.446158,0.17015,-0.0337495,-0.0347976,0.515622,-0.0143286,0.0492982,0.201796,-0.0939742,0.220934,-0.0572547,0.0666718,0.102554,0.150381,-0.546213,0.298827,0.00777213,-0.0126486,-0.25121,-0.0839064,0.0742213,-0.313915,0.335344,0.563458,-0.245451,-0.122149,0.404356,0.235358,-0.157843,-0.266976,-0.0510834,0.0701554,-0.110987,0.460018,-0.220363,-0.325749,0.0121501,0.149278,-0.531468,-0.859297,0.264127,0.452203,0.181269,-0.384211,0.10481,-0.269298,-0.139915,0.0279305,0.0557288,0.10554,0.569634,-0.16146,-0.250693,-0.269198,-0.611107,-0.0488751,-0.379216,-0.00369675,-0.392061,-0.252058,-0.264079,0.152502,-0.0707107,-0.345096,-0.368205,-0.112058,-0.367954,-0.132198,0.212889,0.111917,0.770809,0.00176641,-0.38116,0.145296,0.159691,0.507241,0.44882,-0.0753103,1.01064,0.2298,-0.208521,0.122317,0.406529,-0.126754,0.113421,-0.386266,-0.0330548,-0.219429,0.234088,0.596441,-1.22119,0.22725,-0.790166,-0.155017,0.413832,-0.760034,0.334431,-0.523736,-0.116114,-0.0220981,-0.353592,0.017849,-0.219636,0.139241,-0.407004,-0.535266,0.555504,-0.225734,-0.133564,0.540897,-0.169992,-0.348343,-0.340039,-0.397762,0.899927,0.393096,0.741167,0.0132325,0.0780619,0.442609,-0.270742,-0.308313,-0.581393,0.507966,-0.338451,0.340462,0.459331,-0.0746612,0.537945,0.43461,0.232051,0.363393,0.201623,-0.191918,-0.342128,0.254948,0.0188796,-0.215885,0.357966,-0.119671,-0.152534,-0.0781132,-0.19316,-0.664531,-0.196887,0.160841,-0.0994863,-0.00984902,-0.0848251,0.0274806,0.521225,0.172255,-0.165099,-0.254833,0.550261,0.23423,0.263639,-0.205146,0.279568,-0.0859419,0.283422,-0.151586,0.0657658,-0.406894,0.12335,0.304795,-0.48122,0.231873,-0.0470162,-0.0935418,-0.1143,0.221791,0.1099,0.463016,0.331512,0.680453,0.892125 +3415.17,0.739147,0.0912059,4,1.61928,1.13828,-0.627714,0.29088,0.310012,-0.0456995,0.219629,-0.0777225,0.166938,-0.0116964,-0.0397595,0.135038,-0.585649,0.385662,0.0902638,0.826309,-0.121169,-0.0217028,-0.120131,-0.0025489,-0.656874,-1.43195,-0.655065,-0.383167,-0.308309,-0.328551,0.045616,0.828538,-0.225749,0.26279,0.656467,0.122906,0.399439,0.0945111,-0.984712,0.0550957,-0.537413,0.458504,0.438274,-0.472594,1.2508,0.235347,0.192086,-1.56546,-0.520313,0.121437,-0.991981,0.43635,0.241136,0.104852,-0.0147395,0.553795,0.154849,-0.90899,0.312734,-0.0727658,-0.371706,-1.06928,0.0471653,-0.160638,0.298772,0.664858,-0.716052,-0.876013,0.535738,0.348376,-0.918557,-0.0689389,0.281411,-1.18169,-0.625338,0.262,0.445363,-0.0868506,0.942384,0.920481,0.315502,0.600878,-0.336383,0.525792,1.02193,-0.193432,0.32734,-0.160117,0.351151,0.0703165,0.160812,0.0641665,0.181149,-0.227763,0.0528765,0.223579,0.0776179,0.267786,-0.247666,0.0415926,0.220511,-0.0723627,0.452307,-0.357456,0.467759,-0.0356718,-0.250407,-0.215472,0.486847,-0.320298,-0.471739,0.0608254,-0.169201,0.563854,0.0874758,-0.461223,0.313197,0.153272,-0.351959,-0.133896,0.156231,0.227912,0.254775,-0.0600837,-0.735847,-0.442463,-0.384985,-0.408262,0.0945462,0.750561,-0.150153,0.342607,0.24401,-0.555145,0.51025,0.0160523,0.154418,0.388535,0.0981125,-0.0171996,-0.636594,0.0916719,0.614412,-0.143517,0.392577,0.280708,0.584253,-0.0895376,0.0458397,0.105758,0.123458,0.539118,-0.161476,-0.194439,0.236735,-0.0048717,0.514222,-0.195699,0.17231,0.500352,0.0634373,0.512652,-0.126252,0.0524327,0.409347,0.260496,0.865711,0.471535,0.0174129,-0.434821,-0.229686,0.0685232,0.113645,0.252144,0.0436368,0.225114,-0.415842,-0.120902,0.174221,-0.476675,-0.0773087,0.0349148,0.134027,0.735157,-0.242195,0.686526,0.210359,-0.302784,0.185255,-1.02031,0.0444174,-0.337248,0.305338,-0.338394,0.0117919,-0.0832867,0.523144,-0.409044,0.0223908,0.338296,0.0914415,-0.358282,-0.0310565,0.113413,0.352682,0.160243,0.351627,0.0338578,-0.171406,-0.314178,-0.60752,0.672458,0.10046,0.221343,-0.443409,-0.189343,0.251419,0.299906,-0.732939,0.134466,-0.33041,-0.260308,0.266977,0.295163,0.652696,-0.435359,-0.266003,0.294545,-0.124659,0.142887,-0.257372,0.309761,-0.0172418,-0.00171348,-0.00792381,-0.368015,-0.0781928,-0.102179,-0.635264,0.542498,-0.166018,0.0744916,0.656924,-0.0883866,-0.022284,-0.0713488,0.14092,-0.392424,0.152875,-0.0576803,0.458411,-0.26799,-0.610386,-0.296891,-0.474442,-0.246412,0.448405,-0.271153,-0.297986,-0.281249,-0.160717,0.530654,0.214866,0.435691,-0.0365682,1.03568,0.367159,0.456853,0.299491,-0.187584,0.216721,-0.237299,-0.0984912,0.0101528,-0.292558,-0.229957,-0.232125,-0.155625,-0.573034,0.0362773,0.125914,0.257353,-0.00263395,0.00360381,-0.542419,-0.135893,-0.383197,-0.594469,-0.150867,-0.174087,0.314853,0.184152,-0.374635,0.164932,-0.574775,-0.118432,-0.0382032,0.149923,-0.160124,-0.449897,-0.920703,0.377584,-0.249459,-0.0283533,0.133241,0.139465,0.282319,0.37345,0.531337,-1.35695 +3419.75,0.741765,0.0912059,5,1.62397,1.15957,-0.63627,0.267652,0.377101,-0.0502793,0.187588,-0.101353,0.0986382,-0.0960129,-0.0830421,0.191359,-0.515683,0.360016,0.0424255,0.794935,-0.106714,0.014568,-0.151314,-0.0378383,-0.677859,-1.42956,-0.753048,-0.396164,-0.344353,-0.292852,0.0625033,0.781485,-0.214502,0.262261,0.696173,0.0841129,0.397571,0.132874,-0.92953,-0.0390594,-0.44031,0.44329,0.463114,-0.408567,1.25132,0.28968,0.208448,-1.5157,-0.504058,0.113223,-1.01428,0.368155,0.269758,0.130784,-0.017332,0.504107,0.0869699,-0.878728,0.443761,-0.137188,-0.34566,-0.991039,0.0827809,-0.104391,0.299615,0.674247,-0.639007,-0.884267,0.412737,0.293091,-0.833601,-0.100252,0.36478,-1.17001,-0.617915,0.230367,0.492077,-0.0699815,0.899686,0.85587,0.273689,0.541006,-0.344641,0.466268,0.947586,-0.255015,0.315916,-0.138674,0.329345,0.119199,0.15048,0.0475168,0.167324,-0.235442,0.0127274,0.156011,0.0718015,0.274,-0.276332,-0.0246809,0.183445,-0.0982757,0.444256,-0.340667,0.463864,-0.0390729,-0.251438,-0.20977,0.59732,-0.378284,-0.508973,0.143599,-0.215283,0.566735,0.154064,-0.356816,0.256345,0.156744,-0.271566,-0.100613,0.182084,0.189893,0.282715,-0.0128971,-0.735213,-0.475181,-0.407098,-0.459647,0.154016,0.812296,-0.137354,0.378026,0.263112,-0.573348,0.469372,-0.0194415,0.093787,0.425479,0.0439127,-0.0338714,-0.49792,0.0685277,0.604532,-0.132095,0.434312,0.252919,0.473894,-0.151459,0.102856,0.206976,0.0819425,0.518596,-0.171146,-0.40497,0.19709,-0.0632994,0.455417,-0.129031,0.131377,0.436353,0.146939,0.525433,-0.17074,0.0450631,0.342895,0.24767,0.800961,0.515882,-0.0415708,-0.448699,-0.234725,0.066465,0.130302,0.207611,0.0194448,0.235467,-0.3707,-0.143866,0.115044,-0.429681,-0.139001,0.0232351,0.0564965,0.771291,-0.177136,0.697562,0.399133,-0.26761,0.165332,-0.951135,0.053766,-0.348155,0.240039,-0.283164,0.0350675,-0.143437,0.534109,-0.390064,-0.00720516,0.241433,0.06698,-0.438329,0.0238184,0.192221,0.357169,0.230432,0.281505,0.0167642,-0.222487,-0.281407,-0.600646,0.666988,0.0796252,0.149609,-0.423816,-0.144827,0.319442,0.287617,-0.739423,0.19933,-0.321695,-0.295184,0.2783,0.317312,0.698174,-0.490877,-0.264559,0.272428,-0.238304,0.15938,-0.306131,0.351022,0.0214862,-0.0709338,0.00810355,-0.372315,-0.0365711,-0.0288057,-0.644104,0.538345,-0.271047,0.146446,0.681941,-0.10093,-0.0117991,0.013178,0.0345771,-0.37927,0.163321,-0.0318655,0.386869,-0.313939,-0.633199,-0.35177,-0.491068,-0.216491,0.460769,-0.285165,-0.336199,-0.302188,-0.187348,0.651726,0.318866,0.468086,-0.0538287,1.0028,0.43661,0.47204,0.356452,-0.20545,0.224693,-0.158809,-0.0858894,0.0531579,-0.374459,-0.175843,-0.226093,-0.102478,-0.631865,0.0612526,0.175732,0.367169,-0.0219113,0.0327596,-0.45437,-0.104739,-0.342292,-0.640928,-0.148941,-0.175265,0.30212,0.253623,-0.322078,0.221474,-0.538555,-0.12144,-0.0809532,0.23357,-0.145239,-0.416847,-0.827274,0.289814,-0.179669,-0.106233,0.219294,0.138159,0.302126,0.371698,0.54966,-1.58494 +3420.11,0.943363,0.0912059,4,1.56944,1.13281,-0.123392,-0.0882487,0.572357,-0.115739,0.113225,0.230832,0.839971,0.407693,-0.191628,-0.139206,0.00673268,-0.191,-0.0222602,1.58511,0.392309,0.110959,-0.0180947,-0.278479,-0.383955,-0.929505,-1.3169,0.0166738,-0.186619,0.404693,0.165223,0.219559,-0.367428,0.108848,0.107892,-0.663768,-0.441949,0.300153,-0.032599,-0.378004,-0.634051,0.628059,0.221446,-1.08879,0.955141,0.835793,0.136897,-0.255524,-0.0331752,-0.821657,-0.401396,-0.0135652,0.101971,-0.158549,0.55105,0.432442,0.306647,-0.244558,0.814893,-0.51956,-0.134663,-0.50252,0.642176,-0.53949,0.0341585,1.08918,-0.959469,-1.34119,-0.553512,0.160067,0.502747,0.270201,-0.226092,0.379305,0.258901,0.550261,0.869255,-0.366089,0.218484,0.0126055,0.269225,-0.673479,-0.196046,-0.319807,0.0730293,-0.368282,0.0411496,0.151917,-0.586936,-0.0119214,-0.224357,-0.400635,-0.0902632,-0.266783,0.0251501,0.255531,-0.261174,-0.298162,0.451473,-0.175074,-0.294308,-0.110637,0.0698737,0.592703,-0.458395,0.165186,-0.458108,-0.197081,0.039188,0.105623,0.468913,-0.370585,0.465583,0.296997,-0.365651,-0.231431,0.0756978,0.673854,0.491339,0.134448,-0.672336,-0.0467085,0.228445,-0.0315286,-0.305168,0.444159,0.195233,0.18297,-0.229187,-0.557682,0.38681,-0.210623,-0.00768522,-0.181259,0.0166096,0.292622,-0.390429,0.588901,-0.42015,-0.171645,0.325404,-0.314536,0.147261,-0.497914,-1.07374,-0.0459964,-0.0937545,-0.640007,0.0988026,-0.12018,-0.165943,0.0112897,0.151862,0.174688,-0.37781,0.036141,-0.22538,0.206198,0.360687,-0.0741158,0.168461,-0.15536,0.0976159,-0.211058,0.143182,-0.374725,0.273935,-0.262923,-0.00416966,0.277345,0.224543,-0.393562,-0.511058,-0.421254,-0.117569,-0.284644,0.142359,0.0372544,-0.27709,0.16505,-0.342137,-0.268858,0.0677992,0.530018,0.432902,-0.758455,-0.191867,0.417394,-0.322033,0.587192,-0.317401,-0.1434,-0.176905,-0.184433,0.180273,-0.150539,-0.349509,-0.590587,0.129999,-0.12665,-0.0119987,0.00126611,-0.538546,-0.247759,-0.247943,-0.41312,-0.229073,0.0130879,0.115114,0.0956172,-0.187268,1.36458,0.0434482,0.454805,0.111144,-0.111034,-0.0649261,0.0982325,0.229286,0.342985,0.258702,0.406008,-0.00882536,-0.630472,-0.797857,-0.299205,0.406463,0.108235,-0.495396,0.628155,-0.236569,-0.848659,-0.135698,-0.414245,-0.22781,-0.072671,-0.229427,-0.265205,0.0553597,0.164773,0.509526,-0.147113,0.27961,-0.241371,-0.171504,0.0890261,0.184481,0.254426,0.400448,0.28916,0.330085,0.31796,0.591072,0.0338022,0.135114,-0.480524,0.0215842,-0.0625392,-0.0511898,0.647219,-0.187962,-0.271387,-0.337141,-0.0982365,0.409128,-0.657402,-0.14817,-0.33834,-0.0785215,0.376324,0.150166,0.0242248,0.328258,-0.186309,0.10548,-0.0243035,-0.0696687,0.0284238,0.725455,0.471325,-0.188418,-0.421173,0.276519,-0.162969,0.194421,-0.0432643,0.0194102,0.456155,0.366533,0.355663,-0.516936,-0.073078,0.0505467,-0.230846,0.153961,0.425775,0.153867,-0.023722,-0.0476473,-0.0951728,0.600526,-0.308432,0.0247001,0.0365227,-0.275758,0.108672,0.290542,0.329654,0.53902,-2.15596 +3436.15,0.963557,0.0912059,4,1.52091,1.16829,-0.00591885,-0.105248,0.258207,0.086174,-0.0367548,0.337014,0.846898,0.903192,-0.246049,0.0721773,0.268813,-0.0316223,0.509344,1.35657,0.135463,-0.136282,-0.102506,-0.16089,-0.453652,-0.782079,-0.592914,-0.129939,-0.064268,0.589894,0.052236,0.375653,-0.0537759,0.195281,0.507118,-0.202264,0.00591246,0.371162,-0.281009,0.0913293,-0.100333,0.356757,0.293425,-0.809018,0.589933,0.665562,-0.0944918,-0.0394489,-0.0508093,-0.481676,0.118213,-0.019657,0.246439,-0.176578,0.284067,0.494156,0.388903,-0.388196,0.734638,-0.55512,-0.31744,-0.689539,0.40013,-0.648712,-0.0954172,0.947628,-0.912733,-0.587387,-0.210232,-0.476492,0.713948,0.0895867,0.317378,-0.278353,0.294001,0.245303,1.07669,-0.576646,0.0159299,0.435089,0.508254,-0.238983,-0.054369,0.0215714,0.501571,-0.152629,0.0398343,0.0208027,-0.239207,-0.309549,0.441568,-0.0080319,0.251293,-0.00947235,0.466507,-0.0435295,-0.364815,-0.249342,-0.227269,-0.0865182,0.181372,-0.157761,0.256702,0.504703,-0.0939647,0.115186,-0.668927,-0.0835676,-0.0684705,-0.415348,0.346234,0.0238825,0.542439,0.30211,-0.132447,-0.214357,0.2735,0.557249,0.191823,0.327889,-0.600932,0.176076,-0.258156,0.183246,-0.223119,0.347628,0.0985905,-0.0724717,0.168009,-0.414152,-0.0793318,-0.122047,-0.287689,-0.734719,0.0184694,0.374229,-0.119438,0.110282,-0.53437,-0.193704,-0.204324,-0.249859,-0.04689,-0.805778,-0.181011,0.0201175,-0.479865,-0.203432,0.241029,0.150435,-0.150936,0.144589,0.235272,0.265724,0.543469,-0.0172657,-0.0687168,0.189112,0.482321,-0.36153,0.136721,-0.00222447,0.428036,-0.0195876,0.827121,-0.486651,0.389477,-0.243541,-0.110909,0.100969,0.167406,-0.192152,-0.845772,0.0134819,-0.0180261,0.274667,0.255575,0.344689,0.202089,0.278731,-0.0765782,0.115501,0.245136,0.435135,0.000774599,-0.222342,-0.0656246,0.286489,-0.329131,0.0257508,0.0216776,-0.110216,0.0907057,0.0315309,0.546652,-0.253526,-0.479138,-0.715381,-0.077473,0.481749,-0.0602524,0.10349,-0.371663,-0.246394,-0.0579796,-0.0150942,0.0668953,0.209695,0.237983,-0.027021,-0.745765,1.15777,-0.23894,0.216778,-0.204494,0.361949,-0.0680582,-0.0831412,0.0897128,0.606937,-0.12664,0.251879,-0.196546,-0.140566,-0.515639,-0.323853,-0.468143,0.298429,-0.0405503,0.692433,0.342035,0.0577322,-0.0363913,0.114802,-0.165877,0.0982724,0.355953,0.0634316,-0.282042,0.290456,0.645502,-0.00321234,0.0802215,-0.162991,-0.00995256,-0.011496,0.293391,-0.278831,-0.334889,0.0628582,0.268514,-0.0306864,-0.408389,-0.1589,0.0601861,-0.491517,0.0514252,-0.336879,-0.351952,0.0896586,-0.0979491,0.385636,0.0585763,0.0117453,0.197453,-0.412014,0.0674215,-0.00582378,0.083019,-0.0787761,-0.0894209,0.509542,-0.0885365,-0.175814,-0.137276,-0.476203,0.160168,-0.441736,0.345091,0.0151053,-0.0616248,-0.259233,0.404133,0.0817139,-0.315053,-0.799658,-0.283738,0.318792,0.421373,0.187346,-0.34877,0.203135,-0.111012,-0.481306,0.0630427,0.154584,0.258965,0.27005,-0.0367614,-0.476324,-0.306299,-0.289173,-0.365661,-0.121757,0.213247,0.118018,0.234787,0.343538,0.484548,-1.32038 +3424.75,0.823321,0.0912059,4,1.56069,0.830614,-0.728159,0.234577,0.256459,-0.0915195,0.347827,-0.132372,0.0308258,0.114012,0.27238,-0.586577,-0.422984,0.390999,-0.428941,0.680536,0.307542,0.142197,-0.0189048,-0.0731861,-0.0925201,-0.946465,-0.840557,-0.0740921,-0.330574,-0.123401,0.342508,-0.0949327,-0.3219,0.339042,0.81831,-0.601805,0.140622,0.537872,0.0324399,-0.179625,-0.618071,0.0549295,-0.00783059,-0.00635634,1.16835,0.518632,0.0884125,-0.701682,0.201055,0.38814,-1.16217,0.100837,0.665846,-0.11367,0.477406,-0.239481,0.295102,-0.79148,0.811954,-0.13884,0.379266,-0.642526,0.624555,-0.203453,0.118081,1.26275,-0.419476,-1.00772,0.081126,0.525966,-0.532414,0.0741556,-0.679644,-0.669116,0.100358,0.0405355,0.786256,0.210711,0.637449,0.115769,0.106434,0.422388,-0.244438,0.080907,0.310432,0.212112,0.726879,-0.0353523,-0.26898,-0.0557718,0.175372,-0.670658,-0.212916,-0.432678,-0.693314,-0.000647835,-0.146493,0.177929,0.251993,-0.497354,0.0145165,-0.0916893,-0.0509652,0.0540277,-0.0629283,0.298844,0.248172,-0.591383,-0.542115,-0.1141,0.279093,-0.0327853,0.385291,0.468334,0.0494112,-0.422859,-0.0792698,0.389592,-0.32075,-0.207726,-0.0850105,-0.165677,0.377892,0.280364,-1.34646,-0.0932013,-0.12984,-0.716489,-0.303044,0.741577,0.426807,-0.121618,0.35165,0.335202,0.17602,0.350152,0.19031,0.483096,-0.217814,0.0155399,-0.0767479,0.249963,0.673356,-0.509666,-0.551103,0.322291,0.251312,-0.95567,-0.329611,0.121655,-0.428314,0.125228,-0.118202,-0.0244001,-0.748216,-0.120884,0.236397,0.0424749,-0.445484,1.20295,0.266784,0.127265,-0.491826,-0.187121,-0.346399,0.609395,0.416946,0.0840838,-0.628489,-0.128707,-0.188793,0.173258,0.339981,-0.302551,0.154447,0.0853697,0.00116653,-0.0900218,-0.406197,0.0491736,-0.103089,-0.323985,0.410671,0.294124,-0.28126,-0.274704,0.72129,-0.177804,0.485654,-0.599476,-0.373672,-0.395093,0.286167,-0.504723,0.0979241,-0.0211641,0.104336,-0.483791,0.141191,-0.172702,0.144333,-0.441305,-0.778675,0.183397,0.346287,-0.348087,-0.369853,-0.777935,0.0827872,-0.0648975,-0.577632,1.06487,-0.220889,0.0825621,-0.127134,-0.48819,0.28451,0.449037,-0.34839,0.125541,-0.111446,0.0442236,0.265463,-0.0941757,0.187988,-0.405338,0.074911,0.343669,-0.215569,0.454551,-0.625204,-0.392612,0.211147,-0.18705,0.145203,0.163127,-0.0533599,-0.325921,0.0814006,0.523265,-0.305365,0.130242,0.346231,0.087779,-0.301336,0.122629,-0.477493,-0.181309,0.19224,-0.222066,0.0238218,0.139039,-0.227795,-0.154176,-0.727073,-1.17467,0.316276,-0.587917,0.109436,0.396623,-0.755587,-0.21369,-0.00372823,0.383925,0.337587,0.0826774,0.199291,0.192468,0.109153,-0.108668,0.388192,-0.149354,-0.00435115,0.0180559,-0.612035,0.238792,-0.83733,0.921844,-0.262198,0.113055,0.0579628,0.163684,0.154644,-0.146217,-0.142365,0.172268,-0.599781,-0.267065,-0.182743,0.175851,-0.161837,0.184805,-0.331249,-0.276452,0.0540241,0.250315,-0.675144,-0.010603,-0.442535,0.281461,-0.134456,-0.227643,0.128613,-0.46939,-0.170408,0.158625,0.238132,0.398277,0.487988,-0.576184 +3442.42,0.55763,0.0912059,4,1.70761,0.854445,-0.888966,0.320706,0.950967,0.00456436,-0.301317,-0.585831,0.837479,0.163799,0.264223,-0.276913,0.1109,-0.0122337,-0.504269,0.597006,0.0106621,-0.030072,-0.0508138,-0.593079,-0.09671,-0.532315,-0.723286,0.140178,-0.178034,0.133065,-0.116453,0.0455155,-0.318643,0.00757428,0.75176,-0.673714,-0.135656,0.187397,0.0941403,-0.264452,0.308562,-0.0449223,0.243905,-0.564132,0.94831,0.481323,0.463184,-0.841372,-0.0858235,-0.307252,-0.375143,-0.219123,0.258876,0.192733,-0.459824,0.412784,0.383965,0.0457806,0.561876,-0.0990591,0.366784,-0.625049,0.526052,-0.744794,-0.12142,1.11713,-0.540253,-0.735226,-0.365142,-0.046236,-0.200087,-0.38719,0.251312,-0.630048,0.131415,-0.105202,0.784925,-0.456097,0.329976,0.593379,0.0061658,-0.152134,0.172848,0.397845,0.502793,0.269943,0.0451713,-0.0900296,0.190427,0.0251486,0.39936,-0.499733,-0.0219975,-0.0684,0.181053,-0.0669298,-0.0953671,-0.132695,0.142417,-0.264364,-0.143353,0.156608,0.142502,-0.190101,0.284202,-0.249592,-0.146303,-0.311752,0.268014,-0.229814,-0.281322,-0.0599531,0.567846,0.75169,0.703229,-0.282316,-0.192271,0.501193,0.204845,-0.42471,-0.0493972,0.114449,0.869143,-0.031337,-0.320955,-0.291145,0.517516,0.507452,-0.205412,0.407128,-0.40788,0.205949,0.0311264,-0.329768,-0.026728,-0.18339,0.0581789,0.449158,-0.272194,-0.104564,-0.219643,-0.0947356,-0.312051,-0.232887,0.095551,0.12986,-0.152731,-0.394178,-0.322688,0.495222,-0.303689,0.514294,-0.331642,-0.247377,0.470612,0.413744,-0.276764,-0.0654662,0.0686038,0.271461,0.49479,0.150107,-0.170211,0.00721674,-0.0651967,0.330454,0.774062,-0.277372,-0.153822,-0.445276,-0.10419,-0.434904,-0.168738,-0.769729,-0.413527,0.0511912,0.052231,-0.160935,-0.361648,-0.602886,-0.149226,0.0412638,-0.195916,0.460301,-0.140336,-0.106596,0.06719,0.107082,-0.048936,-1.17084,0.048772,-0.275641,-0.361071,-0.399248,0.0821212,-0.152059,0.218959,-0.519217,0.0644161,0.396529,0.481611,-0.10013,-0.638788,0.189775,0.0156328,-0.00451369,-0.0903514,-0.160676,0.673011,-0.164238,-0.325871,0.801113,0.174857,0.201369,-0.218659,-0.113146,0.218343,-0.600327,-0.257292,0.289384,0.245806,0.357679,0.0467604,0.0406453,0.511773,-0.449019,0.386198,-0.111128,-0.115744,0.380686,-0.248873,0.124297,0.114868,-0.0887541,0.00311436,0.0652507,-0.2107,-0.383492,-0.101051,0.352534,-0.0830812,0.142953,0.304953,-0.307615,-0.206131,0.36603,-0.38703,0.311041,-0.00454945,0.220216,-0.0336174,0.382449,0.125502,-0.2268,0.0116958,-0.449185,0.312167,-0.306508,-0.280177,0.620672,-0.165647,-0.296041,-0.0853548,0.157388,0.115012,0.452723,-0.285842,0.591341,0.506292,-0.178062,-0.183993,-0.262095,0.25289,-0.16457,-0.428236,-0.000209819,-0.26375,-0.19141,0.233231,0.0706191,0.0587816,0.177323,0.134867,0.214251,0.081763,-0.760416,0.207352,0.214753,-0.222517,-0.081912,-0.00602359,0.0657793,0.316596,-0.47854,0.0013692,0.0338291,-0.574699,0.222661,0.067602,-0.988156,-0.133625,-0.749364,0.121142,-0.179724,0.094585,0.109658,0.206083,0.331146,0.453964,-2.79823 +3460.55,0.965545,0.0912059,4,1.60883,0.98906,-0.927761,0.250816,0.667844,-0.139755,0.225583,0.407937,-0.0793849,-0.0940097,-0.00488135,-0.268449,-0.171797,0.0504331,-0.179228,0.923618,-0.193995,0.131626,0.121027,-0.124125,-0.503756,-1.27711,-1.03592,0.156876,-0.23068,-0.17616,0.0907694,0.114055,-0.118116,0.113803,0.397641,-0.621684,0.463545,0.305061,-0.617345,-0.223935,-0.542128,0.511429,0.713855,-0.122638,1.23254,0.143252,-0.17976,-0.496542,-0.316336,-0.0784728,-0.976246,0.350494,0.371265,0.185417,0.0459784,0.315263,-0.00119273,-0.727044,0.676816,-0.508668,-0.378937,-1.10785,0.5657,-0.527036,0.0346622,0.752557,-0.356685,-0.933943,0.0471221,0.0650105,0.222009,0.245893,-0.120951,-0.154297,-0.198977,0.279837,0.180321,0.299925,0.552587,0.309384,0.0497475,-0.0167017,-0.408627,-0.24692,0.145827,-0.363464,0.127371,-0.17622,-0.383399,-0.106452,-0.140389,0.108435,0.163185,-0.426764,-0.199847,0.198935,0.105832,0.0972061,-0.14424,-0.101045,0.331818,-0.448392,-0.08702,0.311934,-0.30609,0.176944,-0.0765378,0.202897,-0.238188,0.027137,0.252727,-0.325567,-0.261987,0.16224,-0.720289,-0.0269978,0.234093,0.380184,-0.187886,0.107423,-0.227959,0.0601694,-0.446396,0.0986162,-0.653699,-0.0440394,-0.759572,-0.455422,0.0687013,0.0539144,0.42038,-0.0835183,-0.000168183,-0.035529,-0.139766,0.101662,-0.199775,0.460022,0.225566,-0.324944,0.131463,0.186003,0.90371,-0.196396,-0.211877,-0.307335,-0.0602216,-0.331003,0.371359,-0.189102,0.0831218,-0.103722,0.170538,0.155106,-0.684966,-0.24495,0.416219,-0.0289818,0.0628204,0.301231,-0.12623,-0.0932765,0.084309,-0.0010197,0.210123,-0.071599,0.536566,0.155359,0.235925,0.444507,-0.0341902,0.0100609,0.00708629,0.659486,0.446092,-0.0204498,0.0316517,0.19889,-0.190824,0.524869,-0.0839226,0.0640595,0.429141,0.345694,0.207846,-0.156661,0.180896,-0.268882,0.0695964,0.469167,-0.348363,-0.451724,0.520415,-0.227598,-0.130403,0.315829,-0.164125,-0.175883,-0.330418,-0.282307,-0.178624,-0.194997,0.0476659,0.0870128,-0.241771,-0.359883,0.252274,0.0516151,-0.445877,-0.0153161,-0.272638,0.928409,0.0659907,0.0298007,0.212654,-0.0905943,-0.128226,0.553363,0.213563,0.200773,-0.383443,-0.286692,0.355559,-0.255541,-0.296217,0.10914,-0.304604,0.462846,-0.335837,0.235013,-0.373322,-0.355295,-0.0926149,-0.0479205,-0.0897261,-0.0234736,0.0344422,-0.196161,-0.124548,0.454534,0.266801,0.0670837,0.263591,-0.0706413,-0.00698156,-0.182087,0.132007,-0.264247,0.141169,-0.116316,0.291994,-0.172979,-0.443941,-0.329682,0.0713582,-0.095723,0.380175,-0.276614,-0.0921517,-0.135631,-0.150541,0.415782,0.134806,-0.301571,-0.161635,-0.050066,0.409162,-0.207603,-0.482064,0.274359,0.142411,0.103119,-0.375676,0.105874,0.182576,-0.378596,-0.0815143,0.413378,-0.188863,0.0473992,-0.180789,-0.188815,0.254004,-0.0452121,-0.0677696,0.498405,-0.460375,-0.292714,0.203879,-0.025508,-0.1375,0.0901076,-0.455132,0.0250501,0.197054,0.0175425,0.204779,-0.105127,-0.109222,0.437687,0.0520103,0.501853,-0.275154,-0.142747,-0.118411,0.0744744,0.279387,0.2729,0.52857,-2.07234 +3462.23,0.984589,0.0912059,3,1.64802,0.971971,-0.814902,0.256645,0.887111,-0.200364,0.0434027,-0.411509,0.353454,0.285331,-0.0666125,-0.370366,-0.389742,0.145989,-0.398275,0.415439,-0.0798832,0.38833,0.111048,-0.0770679,-0.586528,-0.997058,-1.52405,0.0132877,-0.674149,-0.270761,-0.213909,0.294903,-0.232762,0.0663347,0.558616,-0.587975,0.114219,0.0339345,-0.336863,-0.452964,-0.185409,0.445614,0.854026,-0.380131,0.993647,0.35949,0.337225,-0.421955,0.0823962,-0.41522,-0.932209,0.0782864,0.429108,0.457716,0.271395,0.729582,0.00730393,-0.556745,0.658226,-0.770605,-0.12864,-1.12626,0.290663,-0.557354,-0.118787,1.17045,-0.689954,-1.16579,-0.0578116,0.124821,0.0160144,0.0458707,0.079396,-0.302133,0.0555963,0.333108,0.781404,0.193596,0.5166,0.420607,0.167411,0.0184045,-0.592031,0.0535631,0.314476,-0.449447,0.224635,0.270836,-0.620516,-0.0692818,0.0529503,-0.0684187,0.069171,-0.0384308,0.273654,0.161916,0.0285676,0.231414,0.150252,-0.0174706,-0.285308,-0.197617,-0.155881,-0.0385753,-0.405627,-0.381305,-0.0976186,-0.226451,0.273575,-0.492541,0.0644555,-0.302884,-0.210858,0.280178,-0.235438,0.11966,0.396304,0.436712,-0.171224,0.297946,0.142085,0.0977665,-0.203565,-4.23108e-05,-0.266519,-0.0944298,-0.301163,-0.547853,-0.0441128,-0.0668793,0.512574,0.20029,0.0484231,0.0633049,-0.328444,-0.202961,0.0551406,0.173864,-0.249614,-0.040412,-0.223113,-0.156121,0.381593,-0.199043,0.223024,-0.287828,-0.0333418,-0.556061,0.151285,0.309874,0.38452,0.251798,0.043028,-0.11928,-0.205513,0.172576,0.479254,-0.023528,0.0129697,0.290801,-0.263867,-0.117153,-0.243036,-0.0040523,0.0048484,0.383888,1.03991,-0.203603,-0.309517,-0.0593383,-0.0267751,-0.228281,-0.355157,-0.451988,0.385761,0.0766468,-0.0541642,0.269501,-0.705439,0.0819766,0.149223,0.125622,0.50116,0.567747,0.155278,-0.0361506,-0.183488,-0.080049,-0.261196,0.108283,-0.170042,-0.22099,0.224935,-0.0780843,-0.0733923,0.584311,0.0278768,-0.471111,-0.197264,0.111357,-0.236784,-0.157706,0.187112,-0.334728,-0.149834,0.436099,0.0229919,0.0822606,-0.732895,-0.494717,-0.159521,1.00762,0.128443,0.127268,-0.0456519,-0.198496,0.267133,-0.160547,0.166947,-0.105297,0.0482884,-0.167175,-0.0554219,-0.406137,-0.186022,-0.274555,-0.114113,0.470776,-0.254537,0.0649678,-0.192507,0.167471,-0.323643,-0.035724,0.492812,-0.0914117,-0.441718,-0.266159,0.0229985,0.369231,0.326818,0.417843,0.2789,-0.124772,-0.0724725,0.0764942,0.30388,0.0310991,0.381231,-0.153869,0.180267,-0.1509,0.30529,-0.113265,0.143549,0.137465,0.0302716,-0.380333,-0.236543,0.264371,0.195193,0.335877,0.156012,-0.0160307,0.209567,-0.000647218,0.625614,-0.310926,-0.201141,-0.284709,0.0209599,0.38818,0.0282678,0.100365,0.235583,-0.330485,-0.196291,0.424437,0.402536,0.0332301,-0.0995545,0.0803282,0.266993,0.239907,-0.170665,0.150375,-0.390035,0.231108,0.122235,-0.299873,-0.0337463,0.278329,0.0229555,0.154866,0.0768832,0.0640062,0.228708,0.0893371,-0.28773,-0.100919,0.631869,0.147357,0.273488,0.0853911,0.171162,0.0812188,0.347071,0.284989,0.589128,-2.78053 +3467.64,0.992625,0.0912059,4,1.65566,0.800166,-0.999818,0.32201,0.912599,-0.190885,-0.328894,0.3099,0.217181,0.153893,0.0404016,-0.372849,-0.00311917,-0.0354601,-0.337128,0.90732,-0.142216,-0.206821,-0.0369138,0.231782,-0.0228691,-1.04592,-0.917877,0.259345,-0.800658,0.324176,-0.214771,0.054266,-0.0435412,-0.0908727,0.865151,-0.506822,0.132603,0.373018,-0.311729,-0.246214,-0.181084,0.553009,0.353066,-0.0440807,1.22607,0.616001,0.433269,-0.644449,-0.0137544,0.225834,-1.59602,-0.133442,0.559723,0.482026,-0.0567892,-0.0689054,0.0828823,-0.461937,0.749154,-0.0825537,-0.187442,-0.895019,0.529054,-0.951574,-0.679315,0.953302,-0.475402,-1.05203,0.117674,0.561228,0.0240015,-0.269819,-0.271035,-0.295068,0.0696226,-0.152141,0.545079,-0.0781378,-0.0603463,0.476762,-0.0150017,-0.186118,-0.428104,0.0582853,0.11937,-0.32707,-0.0666153,-0.12422,0.137895,-0.21922,-0.586089,-0.2736,0.0989217,-0.261085,-0.0528514,-0.112297,0.163123,0.327164,0.0785981,-0.131801,-0.0781608,-0.310807,0.14594,0.329153,0.00198154,-0.0796228,-0.399483,-0.0936744,0.351735,-0.144802,0.250533,-0.102774,0.0317746,0.25347,0.0297778,0.0288727,0.162096,0.382457,0.348926,0.136459,-0.130299,0.151539,-0.135719,0.0913035,-0.0597691,-0.0171542,-0.246399,-0.284637,-0.0338404,-0.406548,-0.030961,-0.137507,0.240293,-0.146905,0.0626034,0.284357,-0.0911237,0.161697,0.0566163,-0.413428,-0.28776,-0.684834,0.263375,-0.541647,-0.508327,-0.151745,0.388597,-0.0381506,-0.00156556,0.0466738,-0.175546,0.0899866,-0.377366,-0.305475,-0.4337,0.138331,0.363129,-0.182283,0.249706,0.229101,0.134234,-0.175105,0.12709,0.18779,0.0755649,-0.281737,0.344717,-0.134161,-0.0150261,0.251451,-0.174555,-0.340517,-0.205198,-0.213098,-0.248426,-0.371516,0.130892,0.418461,0.0527802,-0.461617,-0.0721128,0.256926,0.520562,-0.0851679,0.169152,-0.237003,0.584012,0.24889,0.114977,-0.233882,-0.0825716,-0.24015,-0.144252,-0.10154,0.120277,0.239731,-0.162103,0.0890576,0.123636,0.165667,-0.186035,-0.391522,-0.417868,-0.307669,-0.141284,-0.287,-0.000104702,0.22541,0.0971678,-0.324809,-0.178927,0.600097,-0.180269,-0.123294,-0.257452,-0.201741,0.163984,-0.0874141,-0.196279,-0.0260635,-0.305412,-0.213735,0.017605,-0.477392,0.272087,-0.192725,0.205147,0.0328053,-0.142454,0.186408,-0.382353,-0.691078,0.716001,0.264148,-0.0518532,0.279348,-0.0159479,-0.16502,-0.649642,0.646869,0.352565,0.0144329,0.475692,0.118477,0.325812,-0.336309,-0.11616,-0.165225,-0.23511,0.249626,0.47862,0.0549465,-0.20925,0.186247,-0.0407079,-0.216737,0.380033,-0.195412,-0.31602,0.0725462,-0.401633,0.0518877,0.309159,0.137018,0.27312,0.134635,0.00315361,0.0751529,-0.512496,0.1915,0.103258,-0.251295,0.162102,0.0278126,0.288494,-0.222033,0.412732,0.123055,0.0565837,-0.430922,0.0999161,-0.0142504,0.218454,0.0742978,-0.224732,-0.00816768,0.727082,-0.0111765,0.0273776,0.210563,0.22641,0.428317,0.206666,0.443159,0.17066,0.172215,-0.305788,0.0293273,0.398376,0.145541,0.358111,-0.262153,-0.447152,-0.0968471,0.295886,0.0804609,0.284983,0.283656,0.533838,-2.52096 +3471.21,0.54578,0.0912059,4,1.58439,0.959457,-0.741187,0.343134,0.833736,-0.190395,0.456996,-0.653724,0.292616,0.152996,0.255745,-0.185413,-0.340165,0.406998,-0.355936,1.16972,0.107815,0.319122,0.00863862,-0.214499,-0.0541185,-0.360118,-0.559734,-0.0415577,-0.0653563,-0.152172,0.500245,0.684478,-0.528409,0.242246,0.674394,-0.855246,0.019519,0.102181,-0.485606,-0.184154,-0.570546,1.00506,0.633147,-0.013946,0.886842,0.484114,0.310352,-0.72316,0.0286848,-0.17652,-0.644839,-0.044146,0.283836,-0.337099,-0.300634,0.64895,-0.0653848,-0.76208,0.484111,-0.705799,-0.10538,-0.740246,0.0960727,-0.374384,0.751057,1.07141,-0.607641,-0.927416,0.157017,-0.439761,0.0898583,0.690922,0.224546,-0.533011,-0.134897,0.263529,0.576051,0.299883,0.376062,0.300472,0.190644,-0.0363574,-0.29985,-0.078791,0.114343,0.150633,0.308959,0.0693156,-0.473402,-0.0753595,0.241607,-0.0874357,0.0345993,-0.412037,0.317221,0.0213322,0.0105911,-0.308716,0.0324494,-0.277066,-0.283388,-0.0603673,-0.26615,-0.00531573,-0.327447,0.160654,-0.151018,-0.110029,-0.24456,-0.0936972,0.417128,-0.498111,0.579514,0.705964,-0.0124918,0.219378,0.00581703,0.378047,0.00682591,-0.00411203,-0.198487,0.434555,0.590882,0.0189093,-0.906047,-0.110672,0.0405033,0.0259649,-0.241702,0.367545,0.27878,-0.000790582,-0.235958,-0.224426,0.31992,-0.170415,0.0244583,0.294612,-0.0848332,-0.145007,0.0252466,0.355737,0.269881,-0.146904,0.104137,0.00838763,-0.0301427,-0.565271,-0.140313,0.312337,0.331789,0.13619,0.0128098,0.146253,0.180083,0.135084,-0.032371,0.243263,0.213937,-0.232787,0.310477,-0.0534761,-0.238402,-0.393824,-0.0161067,0.118212,0.397062,-0.0459822,0.364805,0.0877746,0.0625477,0.0870499,0.232661,-0.110391,0.322003,0.360305,-0.109578,-0.292663,-0.187619,0.541584,-0.00617625,-0.141339,-0.106432,0.782765,-0.124601,0.0236767,-0.6505,-0.261081,0.245326,0.200713,-0.227755,-0.23128,0.298025,-0.278747,-0.0162821,-0.123205,-0.186166,-0.746449,-0.193055,0.207249,-0.154511,-0.136104,-0.52684,0.564572,-0.00557509,0.0972198,-0.00988316,-0.437095,-0.222853,0.0148545,-0.369579,0.986725,0.384407,0.512722,0.437289,0.23811,-0.168448,0.244685,-0.186943,0.140777,-0.0821622,0.302604,0.287625,-0.107369,-0.312695,-0.1716,-0.232247,0.512357,-0.44115,0.151319,-0.381569,0.240721,-0.410133,-0.373176,-0.0249077,0.024186,0.00916395,-0.428541,-0.55437,0.608774,0.00602498,0.141575,0.212616,-0.656192,-0.503401,0.260609,-0.00401117,0.377496,0.365456,-0.107208,-0.181407,0.417303,0.111266,-0.420223,0.0948347,-0.485396,0.326329,-0.169971,0.00666779,0.20668,-0.199524,0.0676393,-0.516618,0.00551005,-0.13546,0.104917,-0.0686624,0.0552513,0.124385,0.0325602,-0.178352,0.121227,-0.165656,0.215366,-0.201565,-0.245003,-0.459051,-0.271766,-0.052259,-0.0752476,-0.0912981,-0.01755,0.0318129,-0.0465218,0.018704,-0.292169,-0.29411,0.0743424,-0.142062,-0.0590075,-0.335503,0.264581,0.195588,-0.14923,-0.165312,0.0877815,0.417838,-0.105143,0.232691,-0.497386,-0.645054,0.145914,0.154977,0.0578188,-0.171391,0.0912703,0.254644,0.30211,0.504623,-2.7681 +3445.9,0.997943,0.0912059,4,1.62711,0.965516,-0.80995,0.305264,0.853699,-0.13004,0.294627,-0.283523,0.470812,0.264118,0.181424,-0.0726342,0.266699,0.542166,-0.419263,0.937709,-0.106163,-0.113599,0.176937,-0.04108,-0.495094,-1.15259,-0.756371,-0.0812787,-0.128012,0.104076,-0.0925843,0.217542,-0.314795,-0.14627,0.396047,-0.472518,-0.112004,0.365154,-0.336093,-0.482387,-0.572548,0.511737,0.402795,0.207839,1.09405,0.840762,0.699046,-0.372511,-0.265185,0.0163964,-0.518256,-0.143254,0.182494,0.0557237,-0.176158,0.56157,0.265164,-0.207633,0.612537,-0.288869,-0.29971,-0.950101,0.233318,-0.371304,0.135843,0.826824,-0.20145,-0.529073,0.275146,0.0931719,0.447575,-0.594093,-0.273425,-0.541736,-0.369188,-0.0446405,0.170299,0.0865568,0.194622,0.342214,0.166876,0.149264,-0.111881,-0.0530079,0.675476,-0.399859,0.0994268,-0.842666,-0.145754,-0.0172039,0.12568,-0.185832,0.480835,-0.0842068,0.186525,0.683746,-0.0477957,-0.222924,0.222998,0.0997348,0.0124041,-0.307245,-0.547579,0.0306694,-0.0617809,-0.479243,-0.700581,-0.172226,-0.557463,0.212726,0.41922,-0.0554489,0.305708,0.490843,-0.133254,-0.430425,-0.0172675,0.267038,0.0249926,0.542506,0.118019,0.094595,-0.286893,-0.644544,-0.618136,-0.370719,-0.005462,-0.29445,0.0317864,0.766058,0.111506,0.327607,0.227114,-0.535233,0.235325,-0.0776383,0.0784181,0.443716,-0.111249,-0.139651,0.0385089,-0.540446,0.561422,-0.835981,-0.133509,-0.10437,-0.0613258,-0.471411,0.266944,0.36212,0.216099,0.549425,-0.0383279,0.179297,-0.00210664,-0.000515299,0.223052,-0.0108201,0.273558,0.207949,0.266208,-0.503415,0.114789,-0.0789585,0.381789,-0.451198,0.622533,0.0967649,-0.824263,0.279695,0.0239947,-0.296352,-0.0599785,-0.25246,-0.286672,0.0657062,-0.111581,0.0506491,-0.474216,-0.132222,0.0993571,-0.121332,0.2883,0.60907,0.454332,-0.288313,0.814707,-0.354841,0.283641,-0.0815165,-0.0766369,-0.462397,-0.0217999,-0.549421,-0.577155,0.109535,-0.443033,-0.523469,0.223559,-0.2014,-0.351194,-0.236384,-0.362387,-0.650683,-0.0592258,-0.0425867,0.440541,-0.178832,0.240926,0.484541,-0.100092,1.00011,-0.277598,0.126441,-0.102366,0.0761665,0.313638,-0.136291,-0.171262,-0.0128519,-0.259021,-0.348208,0.0972897,-0.309005,-0.432341,-0.307202,-0.0817068,0.566372,-0.220813,0.444844,-0.58957,-0.108577,-0.0277383,0.320758,-0.116509,-0.0712688,-0.473024,-0.0388162,0.0235564,0.60273,-0.123524,-0.5718,0.399431,-0.328256,0.258558,-0.131116,-0.0815645,0.668662,0.706867,0.547318,0.536563,0.224627,0.212975,-0.456007,0.491927,-0.292013,0.413158,-0.395103,-0.284706,0.476479,0.307131,-0.0597759,0.43382,0.187782,0.210315,0.227012,0.203312,-0.254827,-0.153679,-0.0575391,0.380451,-0.413317,-0.0736714,0.115719,0.166076,0.336265,0.308915,-0.16478,0.277886,-0.425271,-0.147197,-0.342051,0.182947,-0.286693,0.012694,0.206991,-1.0214,0.313533,0.358585,0.722389,0.425647,0.0292151,-0.0279425,0.1171,0.110739,-0.308752,-0.337124,0.399726,0.0357425,-0.759215,-0.38622,0.00897382,-0.627153,0.0625134,0.31842,0.136656,0.246242,0.369669,0.496228,-2.7454 +3448.24,0.749733,0.0912059,4,1.61637,0.992305,-0.774628,0.291305,0.922296,-0.133162,0.256697,-0.267329,0.557588,0.218025,0.103499,-0.102658,0.156772,0.529216,-0.302074,0.972268,-0.202871,-0.0426445,0.246404,-0.093897,-0.543981,-1.11429,-0.805585,-0.0557592,-0.163778,0.12463,0.000537698,0.286526,-0.282602,-0.158228,0.478207,-0.5408,-0.132698,0.355723,-0.321418,-0.509561,-0.586997,0.56559,0.368221,0.250872,0.966269,0.824486,0.724988,-0.291353,-0.26182,0.0819616,-0.565262,-0.135518,0.0900958,0.101432,-0.274024,0.562505,0.168676,-0.196453,0.558652,-0.186811,-0.26834,-0.854734,0.205106,-0.355558,0.147232,0.816352,-0.119493,-0.50235,0.292919,0.17691,0.431683,-0.64348,-0.273248,-0.593696,-0.386595,-0.0429567,0.117691,0.113363,0.217027,0.319299,0.107586,0.196791,-0.122741,-0.0243128,0.666193,-0.303795,0.104358,-0.766899,-0.176025,0.0378708,0.15271,-0.206883,0.412113,-0.0900531,0.193883,0.594464,-0.0308797,-0.267523,0.271478,0.0565607,-0.023502,-0.402366,-0.565762,0.070327,-0.0898838,-0.426368,-0.792125,-0.198257,-0.495486,0.155794,0.433434,-0.117249,0.408837,0.425976,-0.140398,-0.442754,0.0234117,0.28787,-0.0220333,0.549277,0.209787,0.0776428,-0.347759,-0.650631,-0.62735,-0.365927,0.107294,-0.291186,0.0511777,0.754832,0.176569,0.314009,0.106903,-0.483917,0.0833944,-0.0899995,0.08891,0.445352,-0.040131,-0.175173,0.023444,-0.613677,0.471885,-0.777371,-0.162233,-0.0844554,-0.00536073,-0.484542,0.302725,0.408891,0.181179,0.446375,-0.0853031,0.184553,0.0635477,-0.051454,0.297522,-0.0292046,0.253646,0.269726,0.35511,-0.543637,0.0650339,-0.0644667,0.349477,-0.470636,0.688589,0.100008,-0.809434,0.351287,0.0101796,-0.252652,-0.00455224,-0.237468,-0.269765,-0.0506765,-0.0803299,0.115993,-0.539984,-0.114668,0.0344944,-0.100468,0.404376,0.605652,0.406012,-0.350609,0.74241,-0.235808,0.33071,-0.1333,-0.101537,-0.550807,0.041228,-0.459279,-0.541845,0.104876,-0.489525,-0.571503,0.223947,-0.161108,-0.382065,-0.199565,-0.331571,-0.613464,0.00936696,-0.0692403,0.380065,-0.152564,0.150285,0.521355,-0.0554365,1.06119,-0.394872,0.0761775,-0.138082,0.0953675,0.293996,-0.0483371,-0.0966603,0.0120849,-0.23864,-0.318198,0.102683,-0.334521,-0.447193,-0.295721,-0.0447081,0.593129,-0.169097,0.361994,-0.575763,-0.0853563,-0.0459914,0.260504,-0.179061,-0.104027,-0.525795,-0.0651327,0.0259777,0.587813,-0.094996,-0.582351,0.515074,-0.341234,0.238036,-0.124827,-0.125514,0.623175,0.689062,0.554013,0.595584,0.211136,0.198234,-0.421328,0.334964,-0.406775,0.383798,-0.372356,-0.287988,0.535102,0.278661,-0.0626391,0.419611,0.158461,0.268575,0.152165,0.350599,-0.151476,-0.089633,-0.0314951,0.344394,-0.329045,-0.14824,0.0754991,0.2549,0.336162,0.308537,-0.112182,0.256215,-0.403254,-0.109367,-0.34147,0.174935,-0.3526,-0.0511038,0.257633,-1.04444,0.353288,0.353243,0.724497,0.412791,0.120779,-0.103808,0.0351086,0.0773069,-0.378253,-0.344995,0.340872,-0.0266207,-0.80979,-0.467501,0.00665418,-0.607406,0.061832,0.287093,0.13222,0.248573,0.363621,0.498571,-3.03578 +3457.88,0.986914,0.0912059,4,1.56518,0.928477,-0.849153,0.281169,0.622173,-0.124358,-0.147927,-0.117997,0.762577,0.0319135,0.0370045,0.0916331,-0.0501203,0.642451,-0.474894,0.745801,-0.277829,-0.0734812,-0.386603,0.0604181,-0.380058,-0.755269,-0.391942,0.0207574,-0.205407,0.00996974,-0.146339,0.553061,-0.0709182,0.149952,0.533131,-0.155143,0.307952,0.134401,-0.291671,-0.23507,-0.016129,0.450324,0.051284,-0.236195,1.25801,0.35368,-0.0953004,-0.330497,0.123813,-0.034952,-0.296262,0.0934895,0.589887,0.170178,-0.103209,0.404793,0.136431,-0.371093,0.70288,-0.589306,-0.231914,-1.10084,0.0876224,0.203198,0.715744,0.868914,-0.645202,-1.48533,-0.395518,0.242457,0.0552195,-0.476352,0.686694,-0.481094,0.057693,-0.315615,0.263468,0.0124406,0.814616,0.776674,0.532131,-0.468304,-0.330545,0.190229,0.49035,-0.38805,0.145204,0.183369,-0.47306,0.450548,-0.105244,-0.0239376,0.291065,-0.580181,-0.105442,-0.219068,0.100567,0.0768024,0.277906,0.00326297,0.232377,0.279915,0.0888606,0.0684,0.00413718,-0.133179,-0.303125,-0.336411,0.147438,-0.44789,0.277501,-0.0541808,0.0394681,1.02293,-0.818773,-0.140507,0.0262072,0.381279,0.242723,0.0404759,-0.514583,0.560536,0.102692,-0.0365226,-0.473921,-0.684383,-0.199586,-0.32944,0.0754425,0.336471,-0.122503,-0.126455,0.193435,-0.805636,0.184224,-0.489845,-0.293303,0.450412,0.081558,0.164669,0.209167,-0.110071,0.30602,-0.202707,-0.0947159,0.0867245,-0.148246,-0.916441,-0.465708,-0.0901944,-0.066287,0.203592,-0.00613444,-0.719044,0.0929837,0.191753,0.282889,-0.136143,0.150062,0.427579,0.446778,0.0488006,0.0100439,0.116701,0.436587,-0.158629,0.748124,0.09313,0.0352761,-0.31131,-0.258175,-0.159794,0.0855308,0.0170351,-0.186274,0.397001,-0.0529338,0.108667,-0.101534,0.20191,0.305309,-0.181757,-0.102864,0.912116,-0.0190342,0.138564,-0.372189,-0.031446,0.0615144,-0.407326,-0.207635,-0.325923,0.212124,-0.0688066,-0.143914,0.217897,0.714221,0.0301994,0.100681,0.25735,0.0231917,-0.117851,-0.28472,0.0892505,0.091151,0.134164,-0.212573,-0.0739422,-0.248859,-0.321096,-0.613471,0.976512,0.0378889,0.514477,0.245925,-0.343111,0.286328,0.666611,0.309605,0.458832,-0.238957,-0.144936,0.0630552,-0.0427679,-0.222616,-0.731991,0.384605,0.0918792,-0.0458186,0.274369,-0.486965,-0.176804,0.170628,0.0396166,-0.283328,0.154261,-0.363994,0.177868,-0.13592,0.700687,-0.483977,-0.179798,0.632377,0.0250105,0.0266076,0.628916,0.320357,0.129605,-0.111485,0.260053,0.241396,-0.157549,-0.49745,-0.466809,-0.166589,-0.73801,0.442365,-0.127248,-0.709497,-0.162839,-0.475081,0.0603515,-0.00213576,0.197136,0.077022,0.57288,0.0804119,0.1073,-0.183943,0.310714,0.0525101,0.299704,-0.278519,0.160086,-0.0313917,-0.0579861,-0.443278,0.545188,0.0887818,0.019232,-0.13894,0.0367671,-0.37246,-0.222157,-0.136831,-0.163548,-0.384168,-0.757521,-0.229993,-0.0671379,-0.191372,0.30377,0.497545,-0.533265,-0.0711322,0.113089,0.25054,0.127553,-0.00570125,-0.391727,-0.270764,-0.0305692,0.216484,0.0510021,0.604846,0.11196,0.178191,0.334605,0.422126,-1.93121 +3441.19,0.921084,0.0912059,5,1.54103,0.911593,-0.780705,0.265204,0.453615,-0.0722045,-0.129192,-0.450016,0.65823,0.120568,-0.0125126,0.0302261,-0.294597,0.361906,-0.173778,1.01765,-0.218569,0.10624,-0.0392094,0.254718,-0.342348,-1.0771,-0.046536,0.0268411,-0.24821,0.283293,0.235665,0.594946,-0.173825,0.175459,0.830623,-0.511765,0.1089,-0.0150253,-0.28185,-0.372193,-0.269833,0.499404,0.0124759,-0.149694,1.24138,0.463947,0.03656,-0.308189,-0.196196,-0.140236,-0.25199,0.251591,0.493001,0.203577,0.0473314,0.150005,0.148295,-0.471562,0.738957,-0.496883,-0.329684,-0.973376,0.301815,-0.0448615,0.547324,0.918545,-0.779785,-1.42338,-0.132044,0.342807,0.114403,-0.387237,0.524475,-0.541089,0.0738925,-0.116384,0.445405,0.0967276,0.309786,0.792607,0.671296,-0.569248,-0.392414,0.113093,0.539255,-0.617976,0.235016,0.0304266,-0.40698,0.311672,-0.0346114,-0.0331203,0.431886,-0.569642,-0.12452,-0.181189,0.0603371,-0.114637,0.605265,0.324742,0.23474,0.308935,0.0512421,-0.057391,-0.0913649,-0.323183,-0.198433,-0.358135,0.330438,-0.262842,0.0614082,-0.185306,0.130579,0.81121,-0.338948,-0.112866,0.102865,0.215416,0.320552,0.0758288,-0.439948,0.703555,0.477696,0.0887618,-0.577797,-0.666871,-0.0996702,-0.0260721,0.0661571,0.308358,-0.260571,-0.25668,0.162952,-0.847046,0.16703,-0.648491,-0.162144,0.468028,0.154972,-0.0514804,0.152642,-0.202422,0.678336,-0.286818,-0.373844,0.242302,0.0551071,-1.10094,-0.404644,-0.42774,0.209322,0.315446,-0.349753,-0.516261,0.391877,0.00382883,0.240635,0.044942,0.37092,0.238752,0.440329,0.0409104,-0.131595,0.0637446,0.765084,0.00304451,0.745329,0.247754,-0.24774,-0.420532,-0.354687,-0.0841785,0.14926,-0.170253,-0.36044,0.392133,0.0394694,0.105928,0.0624847,0.216778,0.171792,-0.259866,0.119561,0.91862,0.238371,0.290337,-0.168492,0.158883,0.127686,-0.19388,-0.435878,-0.413275,-0.0832182,-0.106282,-0.155863,0.36031,0.430492,0.0760135,-0.153945,0.621404,0.120515,-0.270298,-0.534807,0.206929,-0.0751374,0.0589176,-0.0144489,-0.189491,-0.377726,-0.487735,-0.628005,1.10613,0.130767,0.171171,0.312918,-0.114306,0.341927,0.172111,0.456103,0.42435,0.0834612,-0.18819,0.0216349,-0.0392497,-0.126172,-0.520005,0.451279,-0.00282437,0.123201,0.298499,-0.425459,0.0528456,0.487975,0.220916,-0.603222,0.0982465,-0.201697,0.214174,0.0457114,0.483121,-0.594907,0.0412663,0.930658,-0.0214649,0.36834,0.4929,0.391314,0.133945,0.0913731,0.460433,0.325313,-0.0045044,-0.313021,-0.402266,0.149882,-0.784453,0.40213,-0.0603196,-0.489026,-0.059475,-0.107276,0.153832,-0.225483,0.09785,0.162742,0.293788,0.242111,-0.0627312,-0.191225,0.11355,0.0224701,-0.000788143,-0.28684,0.0590959,-0.29147,0.00410325,-0.417035,0.743569,-0.369596,0.0174223,-0.0415065,0.0864755,-0.327536,-0.216585,-0.0550349,0.0975187,-0.735339,-0.429942,-0.420197,0.190135,-0.217259,0.280375,0.484271,-0.554731,0.0374249,0.205155,0.246337,0.335794,-0.0188286,-0.374443,-0.0597893,-0.0448612,0.384366,0.00749068,0.53489,0.13231,0.172385,0.363744,0.415192,-1.39979 +3425.54,0.998847,0.0912059,4,1.63204,0.598854,-0.678037,0.23814,0.162574,-0.102009,-0.335594,-0.0574432,-0.136073,0.282238,0.213063,-0.172297,-0.407978,0.921646,-0.237876,0.17441,0.217391,-0.313821,-0.106837,0.302223,-0.0133966,-0.701519,-1.43272,0.542463,0.0755986,0.252635,-0.177899,-0.0110902,-0.215465,-0.569932,1.17321,-0.61695,-0.174344,0.219799,0.191415,-0.228527,-0.394463,0.0790721,0.175727,-0.787503,0.982901,0.418715,0.363144,-0.278617,0.160554,-0.660655,-0.221369,0.0814201,0.616054,0.314454,0.578663,-0.264418,0.0518419,-0.185137,1.11467,-0.266527,0.00374618,-0.961835,0.309703,-0.63456,-0.319207,0.708462,-0.49313,-0.597338,-0.0574837,0.265903,0.452198,0.312039,-0.0974683,-0.0923672,-0.19068,0.661897,0.252492,0.0277388,0.655897,0.634648,0.432141,0.269103,-0.552552,0.270075,0.838777,0.319374,0.258746,-0.295779,-0.287336,-0.49063,-0.18891,-0.1887,0.331121,-0.0692145,-0.0847551,0.0300553,0.331788,-0.0297667,0.080502,-0.25025,-0.380429,-0.207281,0.435341,0.363633,-0.00329424,0.0381027,-0.361692,-0.0807103,0.199812,-0.706323,-0.214698,-0.321961,-0.254962,0.0132881,0.165426,-0.459826,-0.396037,0.598461,0.11674,0.0490179,0.61326,-0.0786051,0.128918,0.184369,-0.698475,-0.196089,-0.102354,-0.411796,-0.636675,-0.0238941,0.355241,-0.0812351,0.228128,0.202981,0.18217,0.0147937,0.606527,0.711581,0.24122,-0.188363,-0.108704,-0.52532,0.449974,-0.505285,-0.13852,-0.0590739,-0.200364,-0.0451061,0.342111,0.557962,0.124594,0.848267,0.236218,0.304877,-0.302207,0.0832314,-0.0832016,0.631939,0.0430193,0.137447,0.462081,-0.170323,0.286196,-0.0192612,-0.233656,0.00695783,0.673076,0.244472,-0.158981,0.542696,-0.15444,-0.411278,-0.370841,0.349404,0.827213,-0.15717,-0.0518427,0.00485621,0.0923996,-0.042163,-0.174208,0.17269,0.370868,0.63063,0.303642,0.169396,-0.147124,0.184045,0.128833,-0.205886,-0.542337,-0.307011,0.320486,-0.435611,-0.284493,-0.387346,0.0110187,-0.513511,0.0955529,-0.239061,-0.516467,-0.185925,-0.0718587,0.0346377,0.163368,-0.155348,-0.402877,0.0685284,-0.0678966,-0.43138,0.453699,0.722869,0.323587,0.221843,0.146526,-0.100628,0.247398,-0.14751,-0.119406,0.0134022,-0.221862,-0.00185939,0.635506,-0.107588,-0.207065,-0.782104,0.327101,-0.102802,-1.1114,0.244992,-0.0919169,-0.782734,0.221307,0.0763054,-0.0733049,0.0403453,-0.0549135,-0.21613,0.268462,0.850704,0.476261,-0.0275104,0.207581,0.240717,-0.00066374,-0.248692,-0.209301,0.130266,0.387744,-0.152241,0.321617,0.111496,-0.382583,-0.324839,0.0404056,-0.213095,0.757711,-0.310261,0.0431035,0.242278,-0.386337,-0.101431,-0.658855,0.192711,-0.454946,-0.498242,0.157497,0.20571,0.0258,0.100175,-0.237303,0.0691442,-0.494356,0.540742,0.155477,-0.316805,-0.125547,-0.356474,0.0579405,0.227789,0.102489,0.0336346,0.505775,-0.509474,-0.0887445,-0.766712,0.0732183,0.163777,0.265052,0.00849098,-0.270698,0.333179,-0.219059,-0.182278,-0.0671749,0.34373,-0.2747,0.708367,-0.0326491,-0.153164,-0.17459,-0.0356671,-0.428131,0.0347263,-0.480328,0.12197,0.337683,0.349242,0.581105,0.189494 +3434.17,0.696452,0.0912059,4,1.56073,0.855078,-0.727109,0.170472,0.504181,-0.0714222,0.0805838,-0.410123,-0.285723,0.199608,-0.000503269,-0.413794,-0.423911,0.363016,-0.0529012,1.16116,0.339337,0.337989,-0.266435,-0.526635,-0.159554,-1.25115,-0.642143,0.238542,-0.456369,-0.0479514,-0.157473,0.296974,-0.106475,-0.302172,0.92678,-0.530433,-0.248074,-0.144513,0.270462,-0.210224,-0.344497,0.361561,0.631295,-0.299416,0.829438,-0.127356,0.208088,-0.760855,-0.140915,-0.209303,-0.831293,0.00401876,0.953059,0.0758852,0.508595,-0.081654,0.0277498,-0.321921,1.14495,-0.920254,-0.27349,-0.8719,0.911211,-0.388137,0.05693,0.951583,-0.850642,-1.39572,0.39007,0.219676,-0.175161,0.292517,-0.0535104,-0.676246,0.3015,0.520021,0.530354,-0.154725,0.0786735,0.196435,0.267993,-0.138244,0.364197,-0.152736,0.420273,0.207052,0.178216,0.187766,-0.354299,-0.0585936,-0.0159707,-0.45595,0.982026,-0.493766,-0.0140816,-0.0647048,0.47355,0.0304221,0.174035,-0.778325,0.518822,-0.118877,0.116332,0.573673,0.270141,-0.280627,0.214546,-0.183879,0.275484,0.0239906,-0.056708,-0.599553,0.590601,0.302541,0.157487,0.62939,0.522192,0.039335,0.454571,0.454947,-0.48095,0.270056,0.0313215,0.0827203,-0.526884,0.0797658,0.0593337,-0.56447,0.677918,-0.0706347,-0.112328,0.150577,0.114802,-0.610054,0.449756,-0.462638,-0.404559,0.393616,-0.49873,-0.290225,-0.003143,0.307081,0.265044,0.194989,-0.275454,-0.026117,0.441551,-0.310713,0.361585,-0.104801,-0.532708,0.448034,-0.659499,-0.27505,-0.541938,0.458044,0.100206,-0.0109403,0.449215,0.401331,-0.330072,0.483336,0.252865,0.075816,-0.259505,0.136215,0.602058,-0.372702,-0.211361,-0.165287,-0.592185,-0.126679,-0.464631,-0.431799,-0.169985,-0.185222,-0.13006,0.892835,0.333594,0.0216092,-0.4034,-0.140439,0.125619,0.71948,0.0495808,-0.0619304,0.0560192,-0.0878652,0.38615,-0.213895,-0.684183,-0.327767,0.107857,-0.277974,0.101059,0.101533,-0.269258,-0.382916,-0.29876,0.755333,0.685633,-0.234365,-0.230974,0.337982,-0.194552,-0.741788,0.241054,-0.249541,0.154822,0.0487689,-0.355589,1.02957,-0.304342,0.0501911,0.147755,-0.195229,0.25606,0.308301,-0.572213,0.109837,0.147201,0.493634,-0.0225478,-0.50391,0.289461,0.0854359,0.181672,0.199054,0.110918,0.105599,-0.336075,-0.206766,-0.0490455,0.184016,-0.322197,-0.0685976,-0.335619,-0.431701,-0.471549,0.202072,0.155788,0.249568,0.50197,0.0251378,-0.29361,0.206464,-0.247167,0.00176723,0.127247,0.0938589,0.376078,0.143386,-0.037206,-0.391932,-0.0958774,-0.456835,-0.12511,0.111126,-0.161584,0.541191,-0.0556244,-0.071854,0.73977,0.0543935,0.225532,0.181237,0.0171428,-0.240065,0.139807,0.427848,-0.123295,-0.196594,0.131937,0.269405,-0.372897,0.295478,-0.501527,0.309625,0.0317886,0.353164,0.509623,0.25168,-0.151416,0.335285,-0.124282,0.29718,-0.150058,0.0130607,-0.523301,0.210722,-0.242537,0.294971,0.409404,-0.406943,-0.0466187,-0.206026,0.365017,0.177979,-0.276786,-0.0725947,-0.384077,-0.031401,-0.0966345,-0.511201,0.113407,0.110031,0.243063,0.33171,0.493014,-1.38656 +3424.86,0.8189,0.0912059,4,1.57284,0.993082,-0.652263,0.200855,0.874155,-0.153066,0.078846,-0.187625,0.418479,0.481037,0.101323,-0.352782,-0.076768,0.278832,-0.312291,0.927907,0.581725,0.0296665,-0.0319872,-0.506039,-0.156233,-0.711904,-0.95294,0.00834286,-0.220331,0.0474083,-0.218433,0.0203275,-0.181788,0.263106,0.625589,0.16259,0.130659,-0.0683847,0.32228,-0.354774,-0.588063,0.226733,0.364625,-0.536925,0.792709,0.845805,0.405282,-0.605865,0.0611661,0.220514,0.0473785,0.415606,0.844561,0.389313,-0.24761,0.891495,0.0235419,-0.175169,0.939942,-1.09483,-0.206777,-0.571779,0.637845,-0.779128,0.0910849,0.988482,-0.303475,-1.23104,0.573434,0.0425841,-0.560972,0.146125,0.111845,-0.50239,0.211285,0.300924,0.231039,0.0804315,0.0956824,-0.121274,0.234297,0.564593,-0.273645,-0.202225,0.608786,-0.123874,0.155506,-0.345087,-0.397554,-0.500491,0.385594,0.17801,0.0492725,-0.493257,-0.214072,0.22485,0.484297,-0.315922,0.304884,-0.736877,0.179215,-0.0697301,0.370023,0.37747,0.130082,-0.324866,0.143993,-0.215085,0.540323,-0.0791043,0.219223,-0.342757,0.0918877,0.497817,0.255681,0.159817,0.320452,0.349725,0.19544,-0.0976824,-0.32669,-0.0988158,0.343278,0.239701,-0.630739,0.242767,-0.158253,-0.021408,0.333423,0.21092,1.08831,-0.163788,0.499075,-0.629828,0.643192,-0.132713,-0.0506214,0.51941,-0.720629,-0.0882369,-0.481603,0.526232,0.277439,-0.610199,-0.701092,0.0835552,0.271877,-0.405077,0.918665,-0.279376,0.169448,0.446079,0.0297284,0.0194107,0.087915,0.445625,-0.291762,-0.0728991,0.234632,0.402916,0.323568,0.276474,0.358005,0.108913,-0.0353273,0.089853,0.93145,0.183262,-0.61032,0.263104,-0.489337,-0.0966492,0.0174236,0.0405131,0.172058,-0.175789,-0.280024,0.515051,-0.0492419,-0.243325,-0.632012,-0.240755,0.309151,0.570276,0.168557,-0.387384,-0.0805272,-0.163546,0.09994,-0.252747,-0.0307914,-0.403492,0.228415,-0.118623,0.323843,0.200405,0.117897,-1.0684,-0.240438,0.116633,0.100387,-0.0164849,-0.393673,0.352276,-0.554775,-0.168852,-0.204894,0.12465,0.00782902,-0.0223871,-0.121322,0.753523,-0.682219,0.0268986,0.355922,-0.77836,0.328023,-0.0384622,-0.343913,0.41336,-0.0382078,-0.0633729,0.137752,-0.407635,0.133409,-0.0645144,-0.376539,-0.212935,-0.667073,-0.164573,0.0874789,-0.422477,0.130571,0.286205,-0.42673,-0.135359,-0.60822,-0.431464,0.151097,0.334016,0.689484,-0.337008,0.656868,-0.0564445,-0.154569,-0.067893,0.0212875,-0.280197,-0.300768,-0.0428256,0.483262,0.416568,-0.406207,-0.317409,0.16059,-0.565444,-0.16713,-0.319417,-0.284719,0.437969,-0.510614,-0.00692881,0.508853,0.0390811,-0.140802,0.0312768,0.293753,-0.335537,0.332799,0.0111515,0.05463,-0.447937,-0.779069,0.793592,-0.730593,-0.225158,0.270541,0.232344,-0.117417,0.641307,0.117138,-0.0691398,-0.0876755,0.245191,-0.14857,0.00801172,-0.408719,-0.0527229,-0.338398,-0.0280576,-0.0106083,0.185945,0.426966,-0.261502,-0.148654,0.568014,-0.0148922,-0.0458886,-0.246962,-0.384884,0.36614,0.0148844,-0.314744,-0.235009,-0.194073,0.137248,0.375427,0.37047,0.612721,-2.89439 +3423.07,0.98404,0.0912059,4,1.47903,0.92252,-1.09484,0.415703,0.791173,-0.0564852,0.0401782,0.130048,0.254803,-0.183964,-0.117258,-0.126385,-0.424006,0.400833,-0.0628734,0.905457,0.246842,0.226294,0.362733,-0.250584,-0.11126,-1.21888,-1.11978,0.0898748,0.175976,0.362853,0.366386,0.769686,-0.444123,-0.116292,0.731237,-0.324287,0.517109,-0.0222036,-0.0525411,-0.398078,0.0513779,0.584619,0.531309,-0.796796,0.926631,0.368253,0.0368272,-0.765696,-0.0106131,0.106678,-0.447485,0.0296312,0.338306,-0.0385144,0.224132,0.594754,-0.0596367,-0.748877,0.50168,-0.305328,0.242962,-0.490016,0.569979,-0.603082,-0.3143,0.799175,-0.374405,-0.412285,0.0794292,0.355279,-0.0827728,0.184818,0.243752,-0.287391,0.101025,0.0242511,0.638305,0.276981,0.478304,0.168315,-0.194792,-0.680772,-0.201198,0.0220903,0.878348,-0.484837,0.242348,-0.172031,-0.308946,0.0496185,0.107062,-0.275829,0.15471,0.0254329,0.103231,0.307654,0.144148,-0.0327031,0.0136294,-0.166573,0.235471,0.624221,0.512574,0.412037,-0.116826,0.201967,-0.394855,-0.921582,0.220153,-0.634829,-0.344122,-0.387697,0.42405,0.791,-0.361706,-0.0475557,0.331074,0.317226,0.108619,-0.00764051,-0.0593188,-0.125053,0.39847,0.135608,-1.12347,-0.220618,0.0858479,-0.857546,-0.178284,-0.0955407,0.193151,0.0167971,0.240282,-0.676385,-0.142273,-0.274547,-0.286601,0.304492,0.0347294,-0.267201,-0.231041,0.246368,0.242292,-0.214242,0.121423,-0.00106922,-0.432583,-0.401037,-0.232317,-0.409398,0.0335924,0.352514,-0.128066,-0.0861609,-0.563788,0.0208199,0.111611,0.249373,0.700207,0.719392,0.396098,-0.038567,0.0571908,-0.294732,-0.292794,0.112019,0.366858,0.149597,-0.0817966,-0.0265684,-0.212859,-0.304803,-0.326865,-0.322983,0.198342,0.185117,0.116459,0.532851,0.055387,0.0390475,-0.638818,0.350928,0.113139,0.84606,0.408731,-0.372355,-0.0694756,-0.229218,0.578596,-0.574481,0.219313,-0.318039,0.404503,-0.488765,-0.126123,0.219299,0.395198,-0.739991,-0.000201569,0.183939,0.372619,-0.264541,-0.537301,0.345487,0.315723,-0.761184,0.183205,-0.206108,0.292669,0.558263,-0.0459293,1.01885,-0.00241019,-0.950895,0.667361,-0.186579,0.591124,-0.303016,0.276587,-0.595953,0.453583,0.486705,0.660707,-0.162575,0.223679,-0.297297,-0.0958793,0.550287,-0.11849,0.631292,0.0680647,-0.289996,0.321358,-0.221335,0.365147,0.143393,-0.605422,-0.502942,-0.372018,0.222948,0.0507621,0.0260754,0.49442,-0.514228,-0.552709,-0.028318,-0.19413,-0.00126841,0.187192,0.312784,0.494093,0.0516486,-0.0434721,-0.474979,0.243339,-0.289835,-0.112517,-0.199668,0.0390457,0.570269,0.0210283,0.179327,1.07472,0.255088,0.421566,0.284486,0.219722,0.304194,-0.193579,0.363956,0.0195392,-0.115805,-0.228893,0.0962027,-0.226064,-0.246657,-0.466905,0.580439,-0.101022,0.260767,-0.0123671,-0.557332,0.184121,0.173193,-0.477787,-0.213139,-0.320346,-0.139482,-0.0399179,0.125989,-0.140058,0.0113639,0.428564,-0.136787,0.109851,0.611144,0.0310039,0.0450307,0.0293947,-0.214661,-0.607777,0.287203,0.147337,-0.0428862,-0.590852,0.143944,0.164083,0.3794,0.405072,-2.58333 +3438.56,0.953697,0.0912059,4,1.54277,0.884113,-0.757609,0.403947,0.557936,-0.174532,0.39254,-0.100902,0.563088,0.278571,0.496034,-0.0421424,0.258055,0.306958,-0.288214,1.08204,0.36303,0.283604,0.438616,0.113885,0.0396111,-0.499133,-0.212418,0.484484,-0.159768,-0.208985,0.0560655,0.159761,0.173459,0.28118,0.700547,-0.183506,0.0166111,0.342432,-0.571799,-0.0105435,-0.464905,0.139072,0.250605,-0.781175,0.684207,1.04689,0.696276,-0.300156,0.15323,0.312507,-0.502689,0.233664,0.277612,-0.0716274,-0.458208,0.293388,0.28254,-0.254964,0.365104,-0.00506776,-0.179675,-0.613295,0.39676,-0.485146,0.407284,0.711362,-0.665304,-0.643666,0.310488,-0.29157,0.336198,-0.254144,0.711648,-0.284421,0.146455,0.791541,0.729801,-0.315222,0.534436,0.367122,0.394577,-0.556531,0.181997,0.0143486,0.407488,-0.304108,0.134317,-0.150485,0.0923913,0.0472256,0.00826933,0.243901,0.3469,-0.184585,-0.250504,0.128969,0.388893,-0.0867324,-0.0230351,-0.607625,0.19144,-0.611379,0.119309,0.228977,0.0683354,-0.0710687,-0.520106,-0.106472,0.276494,-0.252928,0.156621,0.00367049,0.403712,0.546888,0.0871327,-0.106748,0.159787,0.506526,-0.354865,-0.237717,-0.449749,-0.277632,0.00777519,0.112715,-0.237761,-0.592013,-0.193288,0.0946707,0.0959615,0.197753,-0.197254,0.240698,-0.125679,-0.104988,0.445351,0.286798,0.258419,0.266664,-0.248421,-0.0877738,-0.328068,-0.341947,0.305283,-0.349698,-0.287715,-0.0695406,0.117218,-0.637984,0.377148,0.100792,-0.28484,0.100897,0.374842,0.215871,0.185323,0.237606,0.217523,0.00169587,0.157242,0.392924,0.108043,0.182253,0.20921,-0.844346,0.28794,-0.235345,0.510997,0.145241,0.00306956,0.56238,-0.235152,-0.386191,0.231588,0.209593,-0.0550735,0.218144,-0.125322,-0.22847,-0.0802344,-0.249477,-0.16645,0.0537939,0.0345566,0.750291,-0.19243,-0.404327,0.523973,0.137077,-0.180175,0.203414,-0.175241,-0.224496,0.145181,-0.497379,0.324195,0.454821,-0.956594,-0.829243,-0.193706,0.00136259,-0.0454226,-0.354682,-0.0983322,-0.0561712,-0.581757,0.149365,0.08947,0.0656773,-0.37368,-0.203064,-0.143363,1.17366,0.187242,0.700179,0.072491,-0.37001,-0.341064,0.219332,-0.0396072,0.0800659,-0.85749,0.0834051,-0.25108,-0.976814,-0.995626,-0.578153,0.0452514,-0.0385955,0.0477994,0.260622,-0.278018,-0.15227,-0.458606,-0.533893,-0.132596,0.0165998,-0.193284,-0.359798,-0.462588,0.3161,0.145668,0.362408,0.536266,-0.191166,0.0823644,0.0835374,0.0675659,-0.21002,0.779684,0.314281,0.230474,-0.0797387,0.360189,0.0558641,0.345087,-0.754783,0.674317,-0.287814,-0.651576,0.209145,-0.379046,0.486835,-0.201134,-0.0362262,-0.00541396,0.130068,0.0632844,0.135171,0.0078211,-0.20117,0.280787,0.299038,-0.354426,0.0992623,0.0236744,-0.307449,-0.127626,-0.0420712,0.615155,-0.203986,0.084174,0.00792387,-0.384227,-0.150565,-0.306577,-0.0817702,0.376892,0.418061,0.220744,0.38626,0.23151,-0.0960011,-0.025257,-0.893201,0.0661602,-0.227046,-0.769542,-0.133553,-0.571588,-0.56889,-0.0683771,0.107365,0.277072,0.103409,0.321884,0.120433,0.222565,0.347035,0.471768,-1.81393 +3423.37,0.701548,0.0912059,4,1.52436,0.867979,-1.13494,0.538963,0.310919,-0.125357,0.19815,0.10531,0.860753,0.332636,0.403933,-0.204011,-0.0796041,0.353236,-0.152971,1.25781,0.515547,0.416795,0.493236,0.0567868,-0.215988,-0.61155,-0.188386,0.628897,-0.331121,0.156307,0.0336458,0.0388401,0.0155546,0.694649,0.793905,-0.280449,-0.0288756,0.134083,-0.442911,0.195452,-0.37404,0.417955,0.253468,-0.980548,0.96159,1.0831,0.684792,-0.323644,-0.262832,0.154588,-0.370712,0.264532,0.220019,-0.20179,-0.471034,0.658597,0.225471,-0.299797,0.260721,-0.151509,-0.426136,-0.661852,0.415449,-0.631024,0.327692,0.55401,-0.713976,-0.539754,0.0645075,-0.246601,0.471035,-0.155532,0.342735,-0.574751,-0.143596,0.402691,0.786967,-0.374821,0.436699,0.076289,0.159169,-0.423402,0.00476629,0.169434,0.441701,-0.232108,-0.063567,-0.312919,0.551895,0.264292,-0.038328,0.285919,0.245002,-0.403788,0.031504,0.474765,0.298637,-0.256207,-0.0373259,-0.519714,0.0675979,-0.414657,0.435898,0.23763,-0.134152,-0.00602079,-0.663359,-0.470815,0.230841,0.198076,0.0409667,-0.0131498,0.308505,0.653655,0.0119309,-0.139474,-0.0506231,0.221523,-0.275346,-0.508792,-0.0565993,-0.222473,-0.0172873,0.553267,-0.207463,-0.554051,-0.295232,-0.0641669,0.197455,-0.315351,0.170483,0.13883,-0.0968701,-0.0543056,0.411851,-0.016774,0.279193,0.671786,-0.145159,-0.128269,-0.263549,-0.702244,0.464522,-0.00582035,0.161087,-0.259504,0.278099,-0.873266,-0.0038476,0.145179,-0.148808,0.0112867,-0.145254,0.159001,0.326407,0.351356,-0.0693128,-0.225976,0.324096,0.174567,-0.0100324,0.0986203,0.319524,-0.517622,0.190249,0.0407749,0.673525,-0.0548179,-0.30081,0.539705,-0.362957,-0.347787,0.367653,0.209045,-0.144382,-0.0318674,-0.335344,-0.0878197,0.0232566,-0.12109,-0.15676,0.0969902,0.247958,0.947454,-0.143886,-0.139585,0.55797,0.165991,-0.357208,0.0992819,-0.73153,-0.578624,0.0433333,-0.720598,0.227039,0.0528488,-0.619033,-0.69631,-0.309456,0.13799,-0.0156113,-0.266624,0.0927313,-0.0266406,-0.540993,-0.00523521,0.1902,0.119696,-0.231686,0.229339,-0.126914,1.12918,0.131693,0.655032,0.0258753,-0.437425,-0.348596,0.0805971,-0.282505,-0.0820111,-0.439359,0.00475576,-0.705448,-1.08008,-0.6964,-0.587785,-0.0246048,-0.580328,0.217946,0.395046,-0.317965,-0.236139,-0.042285,-0.391463,-0.252101,0.0427454,-0.196743,0.00599133,-0.17192,0.289463,0.195938,0.0288393,0.238364,-0.464728,-0.0858007,-0.0245819,-0.095121,-0.382346,0.589852,0.307005,0.0540828,-0.172689,0.1225,-0.19728,0.492788,-0.731452,0.504176,-0.343512,-0.400898,0.0286915,-0.317801,-0.0581446,-0.217527,-0.0454343,0.100362,0.253527,0.0232305,0.497136,-0.0832124,-0.165072,0.0661337,-0.190698,0.187761,0.403332,0.042234,-0.0583681,-0.152566,0.171498,0.274025,-0.203634,-0.0787676,0.0895681,-0.428628,-0.17934,-0.476534,-0.677349,0.496058,-0.0938367,0.171307,0.389197,0.399167,-0.111768,0.0741463,-0.790955,0.218609,-0.368383,-0.738713,0.266761,-0.31327,-0.182363,-0.0969693,0.283134,0.214669,-0.076363,0.0968453,0.124126,0.224658,0.352315,0.473981,-0.925854 +3424.71,0.705955,0.0912059,5,1.57461,0.99182,-0.919589,0.418368,0.759147,-0.188537,0.295638,0.350036,0.0855204,0.391342,0.44505,-0.163383,0.219597,0.216871,0.11141,0.653988,0.111974,-0.0752175,0.435364,0.235751,-0.246492,-1.06959,-0.801775,0.256042,0.0841067,-0.503977,0.265701,0.838815,-0.537591,-0.264472,0.664301,-0.210804,-0.0353536,0.094896,-0.378943,-0.520233,-0.00739049,0.607686,0.575242,-0.0954667,0.748998,0.31742,0.299271,-1.03111,0.101166,0.0574335,-0.573631,-0.227742,0.598107,0.105585,-0.613806,1.35645,0.0871165,-0.125207,0.410719,0.0710394,0.0256207,-1.11019,0.325974,-0.459213,-0.812281,0.739411,-0.779506,-1.2707,-0.0965543,0.322198,0.158354,0.308921,0.488047,-0.714783,0.183371,0.324735,0.503514,0.11478,0.626842,0.353025,0.417513,-0.189975,-0.281597,0.308337,0.486433,-0.517714,-0.241925,-0.255156,0.00307689,-0.35408,-0.0686217,0.194893,0.18128,-0.140854,0.143117,0.0503807,0.400558,0.260901,-0.123376,-1.04444,-0.392412,-0.204511,0.161117,0.166756,-0.170905,-0.0788026,-0.0225659,-0.718111,0.31934,0.116513,0.618509,-0.601799,0.410175,0.978182,-0.229539,-0.358338,0.364554,0.267334,-0.0861715,-0.0148673,-0.209894,-0.0138305,-0.105999,-0.0320407,-0.336286,0.565445,-0.0920367,-0.130306,-0.0328027,0.0267191,0.0758598,-0.273097,0.160736,-0.0866109,0.00821816,0.00073889,-0.361643,0.496873,-0.289555,0.105708,-0.806673,-0.601464,0.416405,-0.149777,-0.495289,-0.330195,0.0875033,-0.179638,-0.061524,-0.423936,-0.515046,0.664774,0.27052,-0.215004,0.130573,0.357778,0.0370305,-0.118596,-0.19639,0.671521,0.319786,-0.0908553,-0.267239,-0.00425823,0.491569,0.181408,0.320182,0.114768,-0.135364,-0.0570812,-0.869846,-0.26376,0.700742,-0.408464,0.148421,-0.00361181,-0.0476465,-0.473477,-0.0419706,0.178521,-0.333248,-0.138442,0.431254,0.588427,-0.0677599,-0.237906,0.455062,-0.439294,-0.462209,-0.14352,0.121367,0.00551788,0.681481,-0.17854,-0.333495,0.136714,-0.360427,-0.393178,0.111664,-0.134657,-0.320716,-0.248112,-0.729025,0.310871,-0.328455,-0.353407,0.301229,-0.0706996,0.374279,0.240938,-1.03473,0.919141,0.107273,0.277704,-0.062234,0.157947,0.115062,0.223112,0.125471,0.261738,-0.117455,0.105315,0.172561,-0.035061,-0.300715,-0.0470296,0.120442,0.264965,-0.203503,0.0341764,-0.104804,-0.167458,-0.0101234,0.324919,-0.266176,-0.198661,-0.0527815,-0.306357,-0.330759,0.320815,0.15258,0.655355,1.06039,0.10046,0.385956,0.265977,0.103502,0.173348,-0.0688159,-0.166645,-0.0155703,0.0203105,-0.190281,0.0747789,-0.417182,0.00160348,-0.019259,-0.12462,-0.769167,0.498898,-0.0432631,-0.0125546,0.0839914,-0.401666,0.639723,0.766878,0.0255374,0.215943,0.342764,0.201373,0.0586873,-0.415452,-0.0993368,0.481079,-0.143986,-0.173863,-0.128917,-0.14943,-0.104365,0.65554,0.0626007,0.0209745,0.109369,0.0951779,0.269007,-0.592163,0.43847,0.145005,-0.594071,0.105324,0.13982,0.233321,-0.276082,0.0397772,-0.270506,0.0800682,0.297997,0.146062,-0.243071,-0.644945,0.382224,0.228206,0.0940206,-0.298023,-0.0984833,0.120825,0.2492,0.347599,0.4992,-2.56555 +3420.96,0.802324,0.0912059,4,1.59836,0.963703,-0.818667,0.364348,1.21529,-0.110163,0.0618981,0.219606,0.463751,0.447814,0.263727,-0.571016,-0.0795102,0.095446,0.108505,0.574837,0.0192385,-0.341944,0.247887,-0.00703749,-0.39831,-0.915404,-0.92959,0.444098,0.0596235,-0.107665,0.453483,0.985495,-0.817045,-0.120715,0.605085,-0.190345,0.0788048,0.307693,-0.592983,-0.358558,-0.431181,0.747549,0.693202,-0.521211,0.814071,0.664507,0.511099,-0.859979,-0.0118816,0.00027698,-0.155013,-0.226168,0.302924,0.052132,-0.73486,0.89334,0.00262962,-0.595229,0.587698,-0.165871,-0.0751314,-0.891555,0.73623,-0.509511,-0.527261,0.542958,-0.828568,-1.69181,-0.398669,0.197512,0.192469,0.10379,-0.0253187,-0.906777,-0.153824,0.330218,0.469621,-0.083201,0.629975,0.256324,0.212546,-0.117466,-0.480201,-0.0596118,0.189729,-0.340803,-0.018771,-0.677767,0.0623471,-0.547821,-0.234718,-0.0104984,0.0217615,0.0337772,-0.171457,-0.102502,0.357811,0.213237,-0.076289,-0.512918,-0.309441,-0.475221,0.450461,0.195506,-0.268131,-0.041827,0.0411884,-0.565723,0.563135,-0.253372,0.473496,-0.691478,0.552011,0.82894,-0.143959,-0.373847,0.124833,0.272394,-0.0490619,0.0375996,0.0714653,-0.137634,-0.300259,-0.107794,-0.0933495,0.289386,-0.0598891,-0.194966,-0.00717436,-0.132208,0.101153,0.14683,0.00734751,-0.33767,0.313027,0.23922,-0.350373,0.250953,-0.12846,-0.117708,-0.232912,-0.481238,0.624385,0.0676338,-0.665836,-0.334157,0.026421,-0.061463,0.302091,-0.194996,-0.281019,0.798936,-0.215371,-0.481971,0.133435,0.203618,0.139384,-0.340314,-0.396776,0.378396,0.233469,-0.0135138,-0.12858,-0.471093,0.423303,0.0118574,0.225395,0.0819842,0.102739,0.208007,-0.658706,-0.0642257,0.517097,-0.361419,0.353033,0.363271,-0.195984,-0.635413,0.0377302,0.14284,-0.607499,-0.330893,0.608734,0.530838,-0.2504,0.122084,0.495218,-0.388198,-0.535472,0.174273,-0.228829,-0.464482,0.638674,-0.481212,-0.112665,0.143359,-0.0772392,-0.205496,0.281124,0.400664,-0.479576,-0.0459016,-0.371487,0.476442,-0.115349,-0.440217,0.275969,-0.0457163,0.459059,0.206029,-0.858194,0.906344,0.200983,0.404365,-0.0267748,0.299602,0.119009,0.0884265,0.115479,-0.173987,-0.0724407,0.448755,-0.00326653,0.120074,-0.154472,0.0421348,0.116134,0.0714406,-0.00274304,0.0686683,-0.600775,0.0851937,0.0340628,-0.0401229,-0.201707,0.109983,-0.0654766,-0.433458,-0.284264,0.354118,0.536599,0.67922,0.402988,0.267843,0.591765,0.306273,-0.16411,0.121941,0.0949086,-0.52856,-0.0428461,0.720355,-0.236103,-0.149703,-0.47195,-0.359054,-0.354193,0.00431401,-0.675693,0.0988509,-0.190824,-0.0957476,-0.0841579,-0.283113,0.326369,0.55038,-0.129771,-0.190946,0.645184,0.0348437,0.0870048,-0.258346,-0.128159,0.673096,-0.193108,-0.271901,-0.382277,-0.104316,0.237863,0.721197,-0.067739,0.445665,-0.0670611,0.193401,0.0479854,-0.60296,-0.32176,0.0403287,-0.00294481,0.465704,0.402729,0.46338,0.140001,-0.301271,-0.225045,-0.235673,0.355437,-0.0832968,-0.258424,-0.901071,-0.0271755,0.173714,0.0818173,-0.25917,0.146887,0.114884,0.377085,0.338945,0.614072,-4.02777 +3446.38,0.994505,0.0912059,4,1.71086,1.05669,-0.89452,0.344384,0.726213,-0.159818,0.247884,0.413455,0.298981,-0.269236,0.149472,-0.166592,-0.372112,-0.0427419,-0.362103,1.00581,-0.244359,0.187659,-0.242706,-0.288344,-0.672972,-1.12247,-0.679577,0.0905304,-0.0941711,-0.0897197,0.138397,0.502724,-0.679986,0.181285,0.506139,-0.638548,-0.288127,-0.239276,-0.626852,-0.282513,-0.279967,0.296491,0.289151,-0.494098,0.645809,0.392754,0.0595139,-0.824713,-0.364873,0.318524,-0.799133,0.132454,0.369781,-0.394829,-0.392204,0.52186,-0.159251,-0.905719,0.372369,0.111057,-0.321901,-1.21155,0.323368,-0.299316,0.25235,0.827026,-0.876339,-1.0598,-0.10405,-0.0338306,-0.164353,0.00462025,-0.00183411,-0.320047,0.0463882,0.324122,0.709437,0.0497404,0.477877,0.278062,0.00714051,0.111108,-0.189082,0.209306,0.189334,-0.30118,0.12704,-0.328259,-0.303554,-0.483051,0.0148612,-0.10941,-0.0230495,-0.231922,-0.0805714,0.206659,0.00296905,0.29175,-0.0894876,-0.182792,-0.202111,-0.118159,-0.00562474,0.266464,-0.211718,0.392434,-0.246491,-0.515064,-0.156495,-0.409421,0.607932,-0.259681,0.377551,0.603607,-0.270464,-0.0898148,-0.189641,0.156311,-0.252486,0.0807823,-0.17456,-0.23773,0.36821,-0.261263,-0.125101,0.197506,-0.42155,0.305322,-0.398838,0.21381,0.395698,-0.198561,-0.371069,-0.420771,0.0584778,-0.198778,-0.0142256,0.718828,-0.130406,-0.123909,-0.015694,0.0563427,0.25022,-0.506662,-0.0113169,-0.186714,0.0709591,0.239476,0.0837023,-0.294802,0.255958,-0.123125,0.0723083,0.2341,0.0912233,-0.0138805,0.422767,-0.03099,0.832785,0.253346,0.192736,-0.0180933,0.107831,0.151689,0.74133,-0.0532007,0.713662,-0.0525964,-0.214356,-0.0390065,-0.131796,0.0812282,-0.112112,0.516338,0.234299,-0.122496,-0.198668,-0.197776,-0.49734,0.245438,-0.554093,-0.279486,-0.2477,0.834397,-0.12602,-0.133981,0.158044,0.161168,-0.258143,-0.331904,-0.654786,-0.821777,0.254004,0.196166,0.15663,-0.446685,0.13161,-0.297617,-0.218277,0.0167889,0.17925,-0.454046,-0.309731,-0.0739889,-0.293519,-0.05077,-0.294726,-0.0425378,-0.314204,-0.198767,-0.409415,0.834204,0.285129,0.13498,0.279366,-0.747269,0.121742,0.440922,-0.00517569,0.22466,-0.47927,-0.0358042,0.590789,-0.356301,0.101275,0.0847319,0.342464,0.00214097,-0.508236,0.176553,0.0370433,0.208128,-0.346102,-0.267965,-0.0685552,-0.375664,-0.936333,-0.682889,-0.065173,-0.020648,-0.11002,0.308254,0.532246,-0.132881,0.249682,-0.276059,0.409426,0.0206615,0.121789,0.314289,0.275007,0.135755,-0.105713,-0.577334,-0.386044,-0.530306,0.736674,-0.145313,-0.275489,0.424454,-0.00205276,-0.0398913,0.213957,-0.409764,-0.378461,0.330554,0.0907245,0.157618,0.64805,0.259629,-0.111774,0.280867,0.0756065,-0.0705614,0.256523,-0.606282,-0.381728,-0.623259,0.440324,0.0221209,0.225596,-0.57773,0.279312,0.0616489,-0.357672,-0.205148,-0.342963,-0.310146,-0.0992917,-0.179165,-0.0651919,-0.274934,0.321514,-0.248106,0.050159,0.214675,-0.199096,-0.117092,-0.382814,-0.539856,0.288343,0.176665,-0.218224,-0.480837,1.021,0.108501,0.234732,0.329395,0.484492,-2.38485 +3451.11,0.95162,0.0912059,4,1.70606,0.864305,-0.797393,0.361219,0.409185,-0.242816,0.0468422,-0.138024,0.411805,-0.0773457,0.0850145,-0.290261,0.0110988,0.257174,-0.0728273,0.396879,-0.253053,-0.0683142,-0.0640485,-0.250696,-0.268229,-0.941421,-0.784027,0.168735,-0.231677,-0.0867574,-0.04772,0.0943738,-0.951929,0.302912,0.742499,-0.18954,-0.186663,0.483005,-0.78798,-0.327904,-0.745177,0.192792,0.288581,-0.341076,0.653865,0.165755,-0.238065,-0.790914,-0.300609,0.57505,-0.388556,-0.0364959,-0.0504623,-0.0917035,-0.305306,0.266158,-0.136708,0.0791338,0.493445,0.182758,-0.307762,-0.907627,0.470947,-0.353225,0.0104367,0.164079,-0.650473,-1.06028,-0.369708,0.0951804,0.419608,0.616993,0.47818,-0.0107949,0.0476846,0.382323,0.69124,0.0142745,0.393529,0.515278,0.13615,-0.335207,-0.530064,0.128503,0.30072,-0.696113,-0.0326306,-0.360799,-0.0478421,-0.148015,0.0591816,-0.602147,0.322692,-0.27264,-0.209089,0.097588,0.167826,0.0659054,0.278204,-0.25511,0.0413206,0.0994711,0.314993,0.468855,0.032167,0.258599,-0.584673,-0.227031,-0.202059,-0.512436,0.16033,-0.218706,0.14249,0.788124,0.199683,0.14736,0.169598,0.176915,-0.049239,-0.210632,-0.329852,-0.140763,0.0746283,-0.198115,-0.116634,-0.400915,-0.580428,-0.0191337,-0.272942,0.141753,0.234967,-0.116968,-0.0604407,-0.109036,0.101322,0.000560768,0.141572,0.617632,-0.228099,-0.65407,0.051286,0.276345,0.493796,-0.290806,-0.105404,-0.058228,-0.231222,0.047306,-0.447874,-0.0177755,0.272886,-0.150097,-0.142402,0.303245,-0.117374,0.0642452,0.589947,0.102387,0.781505,-0.038631,0.123419,-0.291179,-0.17718,-0.225878,0.346851,-0.224504,0.778084,-0.0253639,-0.213428,0.309464,-0.315043,-0.526301,-0.164135,-0.168675,0.203167,-0.292927,-0.448734,-0.530467,-0.017825,0.144158,-0.47389,-0.68056,0.628247,0.728038,-0.390148,-0.251602,0.341282,0.194787,-0.279372,-0.585977,-0.107507,-0.424736,0.0263332,-0.0527917,-0.0241377,-0.0371186,0.636397,0.316429,0.082791,0.244023,-0.0159804,-0.234337,-0.309022,0.0788235,-0.125926,-0.0737782,0.059777,-0.228573,-0.0086668,-0.171301,-0.574487,0.792008,0.299468,0.38405,0.146787,-0.132564,0.460564,0.741879,-0.00744445,0.345652,-0.224758,0.224615,0.383081,0.0339803,-0.0464234,-0.524867,-0.109295,-0.073536,-0.1127,0.465707,0.212353,-0.365605,-0.527529,-0.177976,-0.077096,0.0191688,-0.538036,-0.262626,-0.142674,0.340424,0.421089,-0.0146552,0.696304,-0.400714,-0.220684,-0.37734,0.189151,0.227521,0.230036,0.0426072,0.252986,-0.164679,-0.0134207,-0.582807,-0.106052,-0.674525,0.595026,-0.57763,-0.0241357,0.535379,0.100365,0.635019,0.257279,-0.0380795,0.00426448,0.258638,-0.0683525,0.299182,0.390094,-0.0152771,0.0687458,0.088226,-0.104411,-0.0616202,0.330963,-0.480556,0.100063,-0.326881,0.0218507,-0.306523,0.1295,-0.114852,0.644569,0.558459,-0.130381,-0.471955,-0.327668,-0.0365597,0.257932,-0.105375,0.0326605,-0.141423,0.544329,-0.132533,-0.128257,-0.278339,0.412728,-0.252004,-0.000942839,-0.180944,-0.163358,0.238317,-0.196494,-0.321232,0.274393,0.106876,0.182671,0.326919,0.427401,-1.0433 +3415.28,0.983108,0.0912059,4,1.57685,0.857564,-1.51906,0.608246,0.731046,-0.123654,0.00166513,-0.226608,0.3695,0.184856,0.0862171,-0.0685222,-0.353774,0.337017,-0.721761,0.495922,-0.0337787,-0.174863,-0.0319781,-0.444258,-0.181613,-0.770187,-0.352082,0.207137,-0.438704,-0.511055,0.300621,0.547549,-0.189891,0.3553,0.687695,-1.47243,0.0650962,0.292961,-0.117306,-0.28277,-0.23623,0.646438,0.42844,-0.286264,1.04573,0.574675,0.699841,-1.13294,-0.0156642,0.419525,-0.519928,0.169383,0.072784,0.0434982,-0.152336,0.722889,-0.203758,-0.526972,0.221936,-0.161216,-0.415616,-0.617087,0.542654,-0.987401,-0.130631,1.2434,-0.874336,-1.00892,-0.224906,0.132843,-0.472281,-0.469645,-0.0814643,-0.471552,-0.34516,-0.0242577,0.14718,0.2511,0.973489,0.534148,0.755906,-0.459165,0.0829331,-0.0239746,0.629301,-0.422892,0.14646,0.412862,0.621686,-0.337735,0.10583,-0.0784063,-0.388224,-0.272466,-0.114815,-0.563719,-0.325616,-0.08959,-0.628724,-0.0448833,0.786914,-0.183743,0.14069,-0.100102,-0.0422651,0.0480219,0.216108,-0.0341993,0.194908,-0.0995637,-0.0693525,0.240497,0.0820043,0.461143,-0.0267864,0.0450553,-0.274479,0.304153,0.139296,0.21018,-0.794219,-0.0359965,0.400737,0.32117,-0.727832,0.193786,-0.012814,0.0939088,-0.0438504,0.377808,-0.402126,0.333845,0.166198,-0.394422,0.212287,-0.196455,-0.524026,0.728459,-0.0541258,0.768891,-0.241517,-0.161222,0.367467,-0.462124,-0.287658,-0.199556,-0.157289,-0.614865,0.264781,0.16517,0.0501309,0.0238179,-0.0457413,-0.454407,-0.0561584,0.0755638,0.133091,0.157929,0.210886,0.453631,0.573126,-0.0791081,0.0741551,0.55454,0.0802668,0.687512,0.427595,-0.28797,-0.464711,0.311187,0.274394,0.320136,0.174091,0.170537,0.525612,0.313561,0.146715,-0.108463,0.0958119,-0.0577725,-0.551248,0.327193,0.0478172,0.817699,0.329979,0.406336,0.85615,-0.361737,-0.066004,-0.367498,-0.372251,-0.151778,0.403509,-0.679892,-0.1103,0.395641,-0.0680084,-0.950595,-0.0426419,0.493044,0.445737,-0.0681005,-0.340402,-0.38162,-0.10496,0.251955,0.330211,-0.218459,0.0152343,0.260117,-0.572152,0.964876,0.478303,0.344321,-0.00556297,-0.463706,-0.0495913,-0.0410219,0.0208523,-0.221312,0.267621,-0.173547,0.103064,0.0883591,-0.152908,-0.0119581,-0.238843,0.189286,-0.604484,0.388383,-0.0693413,0.126833,0.811709,-0.148161,-0.18195,-0.139572,-0.317306,0.485463,-0.598879,0.26298,0.154238,0.783884,0.65224,0.920387,-0.113851,0.403809,-0.332982,0.198511,0.442664,-0.184648,0.891485,0.119966,-0.392639,-0.016058,0.458185,-0.156686,0.642152,0.126452,0.0764216,0.414184,-0.094478,-0.529476,0.0132193,0.0198277,0.0135105,-0.268803,0.408833,0.114073,0.538047,-0.131076,0.0338703,0.535753,-0.182239,0.0106999,-0.104211,-0.577728,0.25215,0.103013,-0.0156752,-0.214718,0.0931787,0.0940892,0.360476,0.139438,0.0323784,0.0365606,0.109771,0.27551,0.00950144,0.36671,-0.0365889,0.773501,0.149248,0.336852,0.159222,-0.0151298,-0.203498,0.796887,-0.0750549,-0.287548,-0.00394974,0.1902,-0.112926,-0.265861,-0.116829,0.149231,0.295043,0.386304,0.543179,-2.11398 +3404.06,0.88036,0.0912059,4,1.50143,0.925543,-1.58376,0.56918,0.898296,-0.0504868,0.169853,0.119812,0.03723,-0.17411,-0.0909585,0.143482,0.161753,0.121902,-0.803693,0.516584,-0.194214,-0.472725,0.143731,-0.0765511,-0.301416,-0.865184,-0.623924,-0.0191011,-0.441115,-0.1475,0.58682,0.269429,-0.517276,0.601207,0.485449,-1.33836,0.268543,0.268202,0.0316061,0.0747465,-0.302178,0.940151,0.312861,-0.363822,1.00285,0.459234,0.587593,-1.11064,-0.084048,-0.0269963,-0.514306,0.928934,0.164239,0.176566,-0.189348,0.483126,-0.0286696,-0.484109,0.545398,-0.0280649,-0.811417,-0.672793,0.293112,-0.310027,-0.130771,0.830612,-0.921124,-1.19599,-0.040262,-0.20498,-0.202167,-0.661106,0.396564,-0.49395,-0.243552,-0.442291,0.717998,0.0310204,0.601039,0.547993,0.279898,-0.0953635,-0.51429,0.25804,0.693904,-0.113666,0.476588,0.0247031,0.830667,-0.581438,-0.0539811,-0.328742,-0.479168,0.0689949,0.35284,-0.611195,-0.309914,-0.215847,0.176357,-0.152527,0.296283,0.117993,-0.0690118,0.117825,0.162101,0.155858,0.167702,0.0907717,0.180703,-0.207881,0.479445,-0.164331,-0.0794268,0.539135,0.314687,0.55374,0.183927,0.252929,0.559608,0.332714,-0.720542,0.242451,0.466151,0.178102,-0.831628,0.235884,0.175334,-0.0214641,-0.0995137,0.657974,-0.363656,-0.184952,0.243548,-0.490753,0.0488969,-0.35465,-0.0772953,0.955764,0.163472,0.628035,-0.0525283,-0.0921075,-0.00861382,-0.309117,-1.02683,-0.0584317,0.131664,-0.760612,0.228502,0.687976,-0.35901,0.170364,-0.0540302,-0.0572532,-0.0410403,0.0155422,-0.156524,0.171393,0.418926,0.356131,0.535748,0.636059,0.417619,0.262421,-0.116733,0.907215,0.854498,0.264157,-0.284247,-0.117161,0.0724058,0.181281,0.243128,0.193506,0.246625,0.34995,-0.187561,0.37882,0.2164,-0.173694,-0.531843,-0.0214262,0.0383163,0.989103,0.892894,-0.19932,-0.0704428,0.204555,-0.60248,-0.835166,-0.25097,-0.178006,-0.150352,-1.02734,0.00865817,0.117005,0.161478,-0.891121,-0.0675401,0.231333,0.181581,-0.229923,-0.269838,-0.436311,-0.114335,-0.174166,0.154366,-0.228342,0.380663,0.0501649,-0.526105,1.09299,0.0642723,0.238967,0.412147,-0.734087,0.19735,-0.53021,-0.0195416,0.173934,0.252537,-0.184278,0.305558,-0.213019,0.172645,-0.00753081,-0.275295,0.202772,-0.571318,0.681106,-0.704886,-0.276151,0.374181,0.449115,-0.0618102,-0.0196991,0.0156853,0.363774,-1.00227,0.604428,0.485129,0.259461,0.708022,0.502493,-0.496884,0.117531,-0.113816,-0.0579077,0.477178,0.51925,0.293779,0.243679,-0.293927,-0.527531,0.292422,-0.465415,0.392846,-0.0553402,0.21203,0.0915348,-0.00564005,-0.348847,0.171,0.022507,0.158797,0.146307,-0.458667,-0.627405,-0.336019,-0.7008,-0.128198,0.0978322,0.070159,-0.0397311,0.102249,-0.218072,-0.310549,0.168692,-0.187582,0.00249055,0.226739,0.193899,0.386654,0.347294,0.0571536,-0.659294,-0.0842001,0.0966967,-0.052542,0.537065,-0.0770687,0.597599,0.0191526,-0.0347503,-0.228916,0.0405934,0.5631,-0.0903352,-0.102729,-0.0487123,0.0216581,0.13803,-0.412601,0.0555718,-0.194862,0.132762,0.330928,0.364365,0.575264,-2.81206 +3395.21,0.937291,0.0912059,4,1.55626,0.797747,-1.76234,0.687137,0.782348,-0.0840703,-0.313135,-0.217374,0.532949,-0.279389,-0.014757,0.128377,0.497737,0.359695,-0.350872,0.582086,0.108652,-0.258447,-0.446395,-0.0184862,-0.439094,-0.820325,-0.755293,0.0770711,-0.144739,-0.673509,0.0440218,0.397814,0.0795172,0.560306,0.533983,-0.661822,0.0594356,0.140428,0.0298648,-0.340704,0.158396,0.795862,0.66211,-0.241516,0.847418,0.528407,0.940565,-1.16315,-0.0573703,0.179194,-0.392987,0.746873,0.293794,0.0676092,0.197587,0.480172,0.136319,0.0316467,0.404647,-0.789188,-0.181773,-0.787423,0.351864,-0.400602,0.600493,0.738293,-1.21498,-1.38392,0.368453,0.0272042,0.486042,-0.592421,0.085969,0.121287,-0.193961,-0.391372,0.548603,-0.371157,0.577017,0.257846,0.626945,-0.167231,-0.814968,0.16796,0.632976,0.0283042,0.362901,-0.234397,-0.0876906,-0.252442,0.527317,-0.279582,-0.114749,-0.126477,0.580476,-0.439875,0.217685,-0.174067,-0.0341779,-0.708357,-0.325253,0.303805,-0.155083,0.322489,0.220842,0.164063,-0.134103,-0.138377,0.180199,-0.396434,-0.988113,-0.120926,0.077467,0.0437913,-0.0908865,0.213168,0.190125,0.346468,0.166738,0.553924,-0.160054,0.342158,0.123544,0.0755025,-0.729285,0.184039,0.153607,0.756463,-0.15731,0.319632,0.314929,-0.111999,0.283443,-0.70582,0.0952094,-0.22871,-0.254879,0.732773,-0.207271,0.034216,0.485056,-0.169013,0.349425,-0.675176,-0.888082,-0.0898436,0.0525351,-0.875236,0.0475279,0.407584,-0.117524,-0.0973292,-0.00336089,0.186388,-0.656333,0.400817,-0.55509,0.153265,0.129516,0.621294,0.101733,0.187956,0.538644,0.278939,0.068542,0.693121,0.844696,-0.0361055,-0.580057,-0.0499763,0.0933647,0.598673,-0.0297407,-0.0689442,0.305427,0.240656,-0.149356,0.126117,-0.360079,0.0440169,-0.146966,-0.0697781,0.969701,1.1455,0.650268,-0.0213625,-0.227707,-0.0464872,-0.548336,-0.506423,0.217104,-0.334599,-0.246859,-0.889102,-0.169317,0.112017,-0.0574042,-0.389686,0.173552,0.319211,-0.116882,0.166215,0.00478578,-0.391901,-0.0968145,-0.443312,0.201494,-0.0692339,0.104858,0.414442,-0.493809,1.10082,-0.501606,-0.0978018,0.148046,-0.765596,0.0576227,-0.314566,0.0863414,0.237324,-0.0783129,-0.22169,0.475857,-0.000833762,0.691795,-0.2398,-0.515143,0.70943,-0.776186,0.179048,-0.452841,-0.333847,0.0634614,0.236204,0.420055,0.153005,-0.179982,0.591096,-0.641231,0.311203,0.405936,0.106033,0.912931,-0.0854222,-0.424397,-0.0135413,0.0493477,-0.631956,0.889413,0.292846,0.84682,-0.408621,-0.479773,-0.477172,0.265789,-0.409095,0.509081,-0.0122111,0.350849,-0.141141,-0.336077,-0.257377,0.387172,0.353214,0.348373,0.381273,-0.14917,-0.0218602,-0.336,-0.478379,0.308172,-0.254305,0.0217478,-0.0854971,-0.255993,-0.439688,0.468014,0.427021,-0.0372728,0.270106,0.0290979,-0.119551,0.724829,0.0502326,0.211436,-0.479718,0.0107859,-0.276156,0.183545,0.249145,-0.532665,0.699957,0.379227,-0.240589,-0.0757011,-0.777074,0.456705,-0.14373,0.0262399,-0.494849,-0.366049,0.376182,-0.543216,-0.359511,-0.373077,0.184734,0.266805,0.429807,0.516531,-2.15601 +3390.2,0.989231,0.0912059,4,1.4943,0.830215,-1.74895,0.752609,1.07628,-0.0767089,-0.522699,-0.000331524,0.407533,-0.237646,-0.0946247,-0.000903462,0.351046,0.267038,-0.128804,0.672982,0.00459467,-0.560952,-0.47747,0.0772041,-0.135281,-0.676734,-0.427525,0.229488,-0.243152,-0.577886,0.059807,0.408571,-0.243366,0.49718,0.750241,-0.0994486,-0.0306229,0.405206,0.44911,-0.43689,0.268381,0.511515,1.19381,-0.312322,0.744857,0.445233,0.393382,-0.897291,-0.131574,-0.00771033,-0.520918,0.702349,0.34376,-0.0474513,0.0219084,0.238595,-0.0129333,-0.236672,0.217073,-0.57694,-0.516083,-0.886391,0.0853046,-0.596738,0.0799586,0.869221,-0.63836,-0.961733,0.548385,-0.0497786,0.467566,-0.380208,0.0649219,0.0651547,-0.306134,0.0133497,0.570807,-0.34267,0.468661,0.471591,0.546409,-0.239071,-0.805697,0.0549273,0.884794,0.206671,0.513371,-0.374755,0.0415881,0.26623,0.79043,0.26578,-0.00330753,-0.353366,-0.0256991,-0.931496,0.298814,-0.218222,0.0318261,-0.65285,0.0423459,0.0557554,0.0468253,0.186298,-0.324698,-0.0417058,-0.240664,0.0583705,0.384909,-0.2542,-0.343869,-0.217098,-0.063628,0.312384,0.0279515,0.220445,0.211717,0.402859,0.108222,0.772821,0.044577,0.180948,0.519383,-0.268632,-1.00281,0.329328,0.231852,0.354486,-0.202494,0.351709,0.258371,0.193381,0.441344,-0.788051,-0.1484,-0.260533,-0.0073358,0.852146,-0.267501,0.202161,0.613709,-0.240032,0.475346,-0.701008,-0.858765,0.0281552,-0.264234,-0.761197,0.144115,0.207058,-0.130923,-0.171263,0.0275845,0.0373006,-0.698006,0.419972,-0.555394,0.087476,-0.0353687,0.454915,-0.188913,-0.379621,0.685146,-0.0265955,0.18377,0.560985,0.761872,-0.230069,-1.07274,-0.258099,-0.293435,0.540643,-0.359143,0.43897,0.525864,0.0115817,-0.0670024,0.276664,-0.147026,0.169975,-0.172591,0.125996,0.555885,0.852966,1.30459,0.0096584,-0.453493,-0.113039,-0.342962,-0.72647,-0.220699,-0.527373,-0.119195,-0.928941,-0.198441,0.0344851,0.00532039,-0.339838,0.228042,0.582514,-0.368825,0.0253819,-0.141442,-0.179325,-0.136543,-0.583034,0.449827,0.0307535,-0.304215,0.188841,-0.923472,1.08063,-0.522308,0.116497,0.103814,-1.03748,-0.22298,-0.0292946,0.429097,0.26756,-0.375188,-0.0350136,0.723904,0.0326931,0.542531,-0.337531,-0.598423,0.567107,-0.397018,0.18071,-0.345893,-0.200954,0.947561,0.372366,0.244092,-0.113877,-0.19533,0.0451508,-0.609848,0.587929,0.317028,0.542508,0.807535,-0.382257,-0.499157,-0.0127628,0.0488152,-0.138315,0.635638,0.785213,1.04346,-0.498136,-0.428059,-0.468144,0.336815,-0.590668,0.470196,0.128921,0.190783,0.0561471,0.087896,-0.0194835,0.520093,-0.0113445,-0.0104515,0.696389,-0.0120394,0.387958,-0.312247,-0.811008,0.122804,0.0743485,-0.147857,-0.398239,-0.610208,-0.101993,0.236,0.0994079,-0.188797,-0.209343,0.0799309,-0.0193136,0.964599,-0.0259557,0.120465,-0.412472,-0.245775,-0.212851,0.1154,0.502612,-0.383523,0.770272,0.502835,-0.294897,0.0679045,-0.678356,0.340327,0.0660034,-0.010413,-0.724382,-0.449663,0.389478,-0.321187,-0.262504,0.223726,0.182493,0.294906,0.427192,0.543052,-3.32215 +3387.88,0.894833,0.0912059,4,1.58588,0.866812,-1.56994,0.613184,0.878197,-0.237172,0.359062,-0.240411,0.146148,-0.211189,-0.092472,-0.0505108,0.291604,-0.26613,-0.712715,0.779734,0.00464154,0.303348,0.173824,-0.242677,-0.142758,-1.17445,-0.841011,-0.0384587,0.178681,-0.160719,-0.330233,0.074984,-1.0801,0.377056,0.563949,-0.837839,0.208763,0.241639,-0.139199,-0.100854,-0.6691,0.215965,0.670884,-0.451207,1.08722,0.650049,0.214771,-1.01504,-0.24556,0.294003,0.0431387,0.160535,-0.00603714,0.384978,0.0270151,0.124902,-0.0816695,-0.386149,0.561066,-0.62098,0.0924743,-0.619191,0.344314,-0.560185,0.222614,0.428866,-0.496684,-0.828054,-0.00234661,-0.188714,-0.141391,0.0598047,0.511213,-0.253509,0.0619067,-0.420211,0.80127,0.508343,0.326549,0.395223,0.698524,-0.306903,-0.855231,-0.0514464,0.675482,-0.0616095,0.0972646,-0.100018,0.452478,-0.10687,0.353362,0.427673,-0.544466,-0.10521,0.508601,-0.0927587,0.190686,-0.362506,0.207922,-0.39808,0.525767,-0.271301,0.562372,0.246822,0.865168,0.113141,-0.0674476,0.0889283,0.907282,-0.368251,0.0332768,-0.158076,-0.0562719,0.367562,0.273232,-0.0460855,0.168777,0.0431881,0.541768,-0.316568,-0.058321,0.4251,-0.0252276,-0.486226,-0.628924,0.105913,-0.277146,-0.293517,0.0588824,0.668324,0.504752,-0.161741,0.120113,-0.440208,-0.355997,0.567981,-0.176592,0.192646,-0.0130388,-0.571294,0.376797,-0.111593,0.441444,-0.997121,-0.301179,0.03196,-0.187313,-0.941365,0.357181,-0.0402281,0.271511,0.155627,-0.193134,-0.616657,-0.655455,0.0183137,-0.155878,-0.276877,0.131176,0.916527,0.138295,-0.676802,-0.423119,-0.344299,0.562953,0.43509,1.12685,-0.483924,-0.839402,0.05149,-0.258252,0.0302353,-0.21099,0.728667,-0.558765,0.292368,-0.345723,0.419134,-0.208835,-0.501189,-0.37182,-0.0424588,0.232303,0.98984,0.443847,-0.224949,-0.171543,-0.666345,-0.237141,-0.271032,-0.162026,-0.407417,-0.296307,-1.62951,0.405875,0.0889454,-0.0339009,-0.447498,-0.525469,-0.324774,-0.0397298,-0.516226,-0.491336,-0.00935693,-0.0842157,-0.990029,0.596329,0.304717,-0.328483,0.0327026,-0.38548,0.801236,-0.467308,-0.507996,-0.123309,0.0472428,0.0355723,0.632043,-0.836786,-0.0199605,-0.169653,0.131373,0.369666,0.816681,0.367031,-1.03262,-0.0453254,-0.159556,0.14384,0.619089,-0.674672,-0.35958,0.92353,-0.0595929,0.545476,-0.114369,0.20252,-0.162171,-0.766029,0.586762,-0.204027,0.289451,1.27147,-0.186465,-0.195908,-0.050576,0.167171,-0.523833,0.42421,-0.527969,0.675724,-0.120586,-0.506491,-0.206386,0.203422,-1.10282,0.459988,0.133414,-0.279372,0.748849,-0.430433,0.313855,-0.00488973,0.240907,0.148045,0.669484,-0.280704,0.267509,0.277773,0.0397051,0.00257501,0.0724804,0.253246,0.198027,-0.151385,0.223514,0.53491,0.574188,-0.197445,0.0686103,0.189011,-0.460283,0.341646,0.355262,-0.402341,0.24129,-0.101327,0.529175,0.137244,0.235536,-0.0883609,0.247215,0.476096,-0.864952,-0.166987,0.307897,-0.219038,-0.461279,-0.0177685,-0.479095,-0.263663,0.479877,-0.595737,-0.297574,-0.0981928,0.224236,0.192684,0.473536,0.438958,-2.55938 +3390.87,0.899422,0.0912059,4,1.5767,0.876992,-1.58015,0.698022,1.1154,-0.275532,0.307702,-0.559889,0.260721,-0.069923,0.0778845,-0.364466,0.363572,-0.118125,-0.469274,0.872655,-0.0199388,-0.106877,0.162187,-0.111412,-0.0834334,-0.864727,-0.717465,0.103986,0.0903113,-0.170659,0.0602975,0.337008,-0.250995,0.0758917,0.58712,-0.639889,0.569222,0.431654,-0.391876,0.0690153,-0.867615,0.537098,0.603935,-0.0499291,0.5385,0.410632,0.318817,-0.971893,-0.285961,0.641435,-0.337046,-0.103372,0.0408277,0.367242,-0.184837,0.000718776,-0.115075,-0.184472,0.261779,-0.578447,0.196935,-0.711773,0.256006,-0.352372,0.428895,0.462572,-0.34722,-1.54674,0.0819398,-0.434917,-0.101956,-0.245823,0.105394,-0.433922,-0.172689,-0.569707,0.816979,0.204905,0.340436,0.271398,0.807384,-0.320751,-0.991087,-0.170594,0.552753,-0.154549,0.0528283,-0.295457,0.226317,0.187021,0.254184,0.367241,-0.329128,-0.232342,0.829319,-0.495881,-0.0594017,-0.257762,-0.28049,-0.159298,0.659596,-0.278404,0.330381,0.419662,1.08009,0.0349668,-0.0927902,-0.116568,0.490561,-0.528377,-0.450036,0.128949,0.00541335,0.503287,-0.206363,0.462964,0.187588,0.137972,0.753735,-0.348609,-0.439035,-0.0256274,0.194821,-0.341251,-0.454214,-0.0430213,-0.0562171,-0.709797,-0.0356499,0.283686,0.615262,-0.029675,0.06043,-0.275626,-0.219594,0.267556,0.015445,0.235817,-0.0475726,-0.695055,0.205443,-0.190262,0.131951,-0.912017,-0.399556,0.0882635,0.00267356,-0.885057,0.223678,0.260982,0.374108,0.815888,-0.066019,-0.140233,-0.518784,-0.025208,0.135853,-0.115135,0.177526,0.241626,0.244954,-0.811185,-0.275336,-0.02841,0.481601,0.586592,0.505479,-0.0986805,-0.364937,0.172784,-0.233475,0.0602528,-0.111248,0.85852,-0.22951,-0.116446,-0.258096,0.288026,-0.137049,-1.01572,-0.128002,-0.643276,0.174613,1.45776,-0.0856966,0.0273957,-0.158581,-0.639785,0.469968,-0.302102,-0.0953172,-0.294972,-0.131731,-1.27598,0.156663,-0.180751,0.323187,-0.286058,-0.238605,-0.222118,-0.21357,-0.563618,-0.728977,0.165319,0.109448,-0.946145,0.556876,0.599752,-0.170277,0.166188,-0.511396,1.22834,0.0884185,-0.588414,0.124233,-0.224635,0.0831919,0.594429,-0.244727,0.101272,-0.306215,0.395651,0.168216,0.262797,0.116682,-0.729045,0.220685,-0.14416,0.11545,0.422715,-0.838452,-0.457735,0.802799,0.0484704,0.339698,-0.16205,0.268354,-0.278925,-0.617982,0.336744,-0.238015,0.464463,1.11357,0.053273,0.107622,-0.198251,-0.115419,-0.281067,0.0282661,-0.501899,1.02125,-0.215041,-0.636866,-0.266422,0.2501,-1.05141,0.152474,0.309055,-0.0837708,0.498129,-0.43035,0.51809,0.267315,0.184867,0.35076,0.388788,-0.530603,0.369452,0.249284,0.0705615,0.102785,0.206853,0.162649,0.00334333,-0.220072,-0.381808,0.250002,0.523597,-0.0393153,0.0951408,0.126941,-0.615809,0.318189,0.214842,-0.332313,-0.00360619,-0.0287386,-0.0161174,0.278815,0.512259,0.0179759,0.107091,0.447965,-0.737405,-0.0456053,0.240254,-0.470468,-0.302709,-0.216005,-0.533907,-0.205085,0.579621,-0.822969,-0.146818,-0.0173557,0.20587,0.301597,0.453729,0.549179,-3.43951 +3410.27,1,0.0912059,5,1.494,0.645148,-1.6863,0.779077,-0.0549376,-0.0824178,-0.254636,0.159033,0.311147,-0.0960758,0.319041,-0.0514901,-0.753139,0.823201,0.277702,0.65767,0.552399,-0.00691696,0.0518673,0.193264,-0.0213488,-0.575055,-0.64656,0.680996,0.0661588,-0.127316,-0.21539,0.110899,-0.0342313,0.0681709,0.908965,-0.195992,-0.56632,0.311312,-0.750001,-0.000850253,0.259786,0.187529,0.168051,-0.220717,1.03248,0.684763,0.232451,-0.493772,-0.399429,-0.305199,-0.525683,0.362942,0.582703,0.18872,0.126437,0.91554,0.0943626,-0.691129,0.118461,0.0418694,-0.748929,-1.00568,-0.0295307,-0.112568,0.15658,1.33081,-0.215834,-0.0137262,0.12301,0.552179,-0.158963,0.159145,-0.0452542,-0.44295,-0.101134,0.614337,0.726069,-0.345206,0.626149,0.635599,0.0749782,0.142557,0.406946,0.250975,0.356939,-0.551426,0.21579,-0.158192,-0.466407,-0.116845,-0.121532,-0.90411,0.476563,-0.346259,-0.712217,0.454651,0.106726,0.321141,0.373669,-0.468231,-0.182271,-0.270745,-0.148356,-0.211794,-0.914688,-0.0301326,-0.648913,-0.478127,-0.178162,-0.0807292,0.663958,-0.577475,0.229546,0.66359,0.322601,-0.577154,0.141265,0.462988,-0.645117,0.550808,-0.279965,0.0665921,0.249014,0.280996,-0.615966,0.12177,-0.190252,0.0478734,-0.264359,-0.0961736,-0.189722,0.0554035,0.387052,-0.564518,0.0822927,-0.103216,0.0653191,0.56155,-0.214589,0.622445,-0.347917,-0.136539,0.618929,-0.169787,-0.235793,0.226341,0.168342,-0.188799,0.0807747,0.1364,-0.678962,-0.0630816,0.0574228,-0.0581843,-0.0385776,0.34456,0.322977,0.00840991,0.112152,0.872366,8.54897e-06,0.701019,0.341073,-5.20542e-05,0.168001,-0.607473,0.656916,0.0523712,0.214302,-0.119127,-0.0441108,-0.631283,-0.11688,-0.80473,0.584682,0.242784,0.0171865,-0.258806,0.0571824,0.755475,-0.5141,0.451278,0.184347,0.361884,0.301602,-0.167229,0.138278,0.36611,-0.70726,-0.347935,-0.527097,-0.0512737,0.422962,0.309849,0.193122,0.129773,-0.649235,-0.881479,0.555507,0.445233,0.251657,0.124145,-0.268788,-0.103868,-0.202353,0.413569,-0.200252,-0.578925,0.304712,-0.418328,-0.367272,1.13009,-0.060619,0.62343,0.0198216,0.0143709,0.255221,-0.431441,0.209862,0.310989,-0.228727,-0.0283612,0.528516,-0.687688,-0.184962,-0.265898,-0.132694,0.576268,-0.908893,0.302713,-0.12904,0.0162772,-0.668955,0.22825,-0.349995,0.142463,-0.630376,0.108232,-0.0940677,0.690221,0.223809,-0.528766,0.396492,-0.68076,-0.342721,0.0385622,-0.0811907,0.109233,0.654735,0.457505,0.044647,0.257927,0.202561,-0.195481,-0.274037,-0.236914,0.411174,-0.502955,-0.579704,-0.00683143,-0.152079,-0.515872,-0.141056,-0.385125,-0.0604068,0.168737,0.742965,0.0715819,0.0117733,0.21553,0.179127,-0.366366,-0.344989,0.14339,-0.279396,-0.119798,-0.805992,0.0850865,-0.00010037,-0.170357,0.0886321,0.724577,0.596523,-0.189854,0.0139707,-0.42571,-0.625447,-0.0234679,-0.346877,-0.497157,-0.0810014,0.535008,-0.111005,0.287161,0.0211258,0.0359708,0.692443,0.371144,0.15177,-0.447872,0.172827,-0.285618,0.410977,-0.0722353,-0.319233,0.168341,0.227004,0.410294,0.476449,0.70356 +3411.53,0.533994,0.0912059,4,1.51278,0.596987,-1.77361,0.717463,-0.183331,-0.0590622,-0.441467,0.293728,-0.021258,-0.0902897,0.0791263,-0.00290573,-0.331739,0.89956,0.00166409,0.472503,0.344442,-0.367998,-0.771933,-0.00253849,0.0545869,-0.74052,-0.537817,0.763799,-0.0827938,-0.313507,-0.0884283,0.158358,-0.0531256,0.232545,1.10245,0.119048,-0.649305,0.197034,-0.841874,-0.066227,-0.00415407,0.806707,0.966362,-0.0715428,1.21163,1.14739,0.124183,-0.447849,-0.250082,0.00482539,-1.16838,0.381846,0.555981,0.29403,-0.262093,0.708596,0.287913,-0.548587,0.194773,0.0149302,-0.555491,-0.62845,0.472421,-0.141757,0.482727,0.951424,-0.921284,-0.931753,0.258431,0.44249,-0.0236485,0.0767156,0.506405,-0.50067,0.0928443,0.290602,0.477059,-0.103142,0.203655,0.686627,0.516181,-0.0743544,-0.0601943,-0.165556,0.401991,-0.562631,0.150655,-0.490184,-0.35167,0.109444,0.242983,-0.448833,0.18063,-0.59591,-0.190915,0.576831,0.31746,0.441432,0.200365,0.0321249,-0.609778,-0.0229417,-0.172941,0.12295,-0.877028,-0.058771,-0.354251,-0.406108,0.160553,-0.134121,-0.199891,0.0750223,-0.241956,1.1503,0.802428,-0.0894056,0.239733,0.586627,-0.5504,0.263618,-0.321154,-0.265108,-0.131375,-0.0488046,-0.743481,0.38223,-0.168255,0.158279,0.158323,0.436345,-0.0491006,0.06778,0.0837511,-0.537185,0.169212,-0.154084,0.120803,0.702234,-0.10729,-0.107149,-0.144494,0.596414,0.559365,-0.718314,-0.519443,0.116586,0.31591,-0.194139,-0.232458,-0.254104,-0.88021,0.17253,-0.191014,-0.0601747,-0.368395,-0.0849179,0.397249,0.180784,-0.386053,0.437669,-0.267469,0.773346,0.0911131,0.177966,0.463593,-0.264512,0.899523,0.144178,-0.517573,0.219238,-0.0213764,-0.478375,-0.153922,-0.303416,0.245937,0.0890379,0.225582,0.0944441,0.0545241,0.403609,-0.598777,0.169609,0.5724,0.584679,0.3526,0.373477,0.16625,0.735997,-0.361268,-0.0481206,-0.255125,-0.494065,0.427964,-0.546966,0.00267514,0.39811,-0.834149,-0.531428,0.0474426,-0.0528379,0.311169,-0.265932,-0.778485,-0.668045,-0.0396852,-0.190992,0.259176,-0.33655,-0.258146,-0.645602,-0.586961,0.825898,-0.209352,0.125415,0.094035,0.502187,-0.476101,-0.618536,0.338019,0.165491,-0.62823,0.00939996,0.643221,-0.401136,-0.1247,-0.482075,-0.143855,0.632816,-0.326412,0.534232,-0.0336242,0.202708,-0.500745,0.0659239,0.294853,0.332967,-0.262009,-0.21926,-0.828774,0.543507,0.413855,-0.381895,0.372641,0.025499,-0.394781,0.155926,0.775665,-0.0400801,0.227421,0.813156,0.805787,0.130836,-0.0577416,-0.431294,-0.0954969,0.149429,0.350326,-0.385668,-0.186434,0.454034,-0.138412,0.1242,-0.16912,0.272756,-0.0320024,-0.209451,0.417447,-0.034964,0.233667,0.126996,-0.246685,-0.297362,-0.118621,0.0452904,-0.025829,-0.445172,-0.352897,-0.221833,-0.38084,-0.271054,0.0904045,-0.0139496,0.362813,-0.261123,-0.0421142,-0.655001,-0.47697,0.540252,-0.309237,-0.563451,-0.0163773,0.428909,-0.111616,0.498826,0.261595,0.276366,0.647982,0.15522,-0.119656,-0.542821,0.0453371,0.0621898,-0.158056,-0.488094,-0.333295,0.153665,0.26114,0.392002,0.511019,1.3322 +3422.51,0.841862,0.0912059,4,1.51672,0.583627,-1.74004,0.747628,-0.345613,-0.226328,-0.485669,-0.0551704,0.232042,-0.168121,0.126352,-0.466894,-0.269651,0.953704,0.0958928,0.699246,0.411724,-0.0356026,0.0211235,0.0537776,0.183363,-0.62305,-0.359061,0.636917,-0.457405,-0.155922,-0.100723,-0.0622108,-0.114772,-0.0823865,1.29471,-0.260464,-0.71529,0.19836,-0.786833,0.274756,0.230732,0.549766,0.151797,-0.0775574,1.41383,0.384684,0.423429,-0.899663,-0.165411,0.445709,-0.714806,0.0661005,0.574173,0.305968,-0.0219365,0.26892,0.291887,-0.129776,0.305559,-0.261275,-0.523179,-0.54044,0.462048,-0.383177,0.355847,1.00196,-0.580708,-0.413865,0.543112,0.333597,-0.280825,-0.252124,0.30187,-0.668395,-0.0553343,0.312274,0.382763,-0.168633,0.112098,0.737642,0.274651,-0.0702355,0.0306643,-0.150996,0.513041,0.008586,-0.201108,0.137633,-0.121563,-0.642534,0.0125808,-0.469329,-0.0882966,-0.722758,-0.528073,0.232947,0.184376,0.194658,-0.523448,-0.118098,0.0187972,-0.118991,-0.381975,-0.0752224,-0.0361993,0.0172266,0.00921427,-0.409242,0.24744,-0.171273,0.0111605,-0.0448757,-0.0783948,0.951112,0.619167,-0.233494,0.314583,0.370111,-0.27626,0.545948,-0.211129,0.0323857,0.342611,-0.12144,-0.803651,0.136402,0.491455,0.258852,0.303792,-0.034351,-0.127081,0.00767809,0.314122,-0.54878,0.289757,-0.156545,0.207523,0.49601,-0.24937,0.39406,0.0681777,0.227697,0.473296,-0.790615,-0.31038,0.155823,-0.0437402,-0.397985,-0.0355819,-0.100255,0.215923,0.151522,0.0263556,0.0672506,-0.37966,0.165309,-0.0827653,0.182134,-0.243117,0.363272,-0.0891244,0.0705263,-0.206889,0.106746,0.888581,0.212849,0.992616,0.0752138,-0.754965,0.141886,0.212835,-0.247439,-0.18046,-0.191834,-0.0250209,-0.371801,-0.0295916,-0.278628,0.0469928,-0.0373823,-0.345231,0.449182,-0.097507,0.869151,-0.086088,-0.371731,0.10809,0.425338,0.136469,-0.408784,-0.0643662,-0.196301,0.357247,-1.04316,0.0237201,-0.253518,-0.239127,-0.373525,0.0181968,0.288546,0.282909,-0.0183812,-0.237232,-0.591017,-0.219044,-0.453904,0.385487,-0.342549,-0.130293,0.242117,0.0645933,0.843027,0.27142,0.0964475,0.228763,0.113211,-0.507037,0.141452,0.628489,-0.00435348,-0.535215,-0.138548,0.401817,-0.271723,-0.242527,-0.440318,0.606581,0.515723,-0.045529,0.27333,-0.889483,0.14776,-0.201997,-0.0309939,0.0730712,0.0182166,-0.220121,0.31009,-0.314082,-0.0842921,0.212113,-0.134372,0.715644,-0.210181,0.40903,-0.344902,0.622163,-0.388952,-0.0410418,0.114873,0.477627,0.396202,-0.0903947,-0.290792,0.131851,-0.041958,0.733906,-0.50513,0.166998,0.172041,-0.74468,-0.135783,-0.144822,0.587792,0.334197,0.0828933,-0.00372058,0.076374,0.0295518,0.195383,-0.145575,0.126199,-0.414403,-0.372413,0.248392,-0.279897,-0.470142,-0.465353,-0.333188,-0.245412,-0.187402,-0.100618,0.483032,-0.236332,-0.50042,-0.739051,0.277052,0.065627,-0.0618221,-0.0270674,0.615246,0.061283,0.245256,-0.502249,0.0400232,0.708209,0.246342,0.54978,-0.453906,0.00415729,0.398973,0.380565,-0.603366,-0.968388,0.0109877,0.133662,0.252393,0.365598,0.502387,1.89406 +3411.93,0.938641,0.0912059,4,1.48394,0.571486,-1.76807,0.77601,0.00782764,-0.131925,-0.420793,-0.233495,0.315508,-0.0438208,0.118725,-0.384517,-0.580364,0.831056,0.123981,0.977634,0.475502,0.0829407,0.0518383,0.335694,0.21823,-0.358379,-0.436848,0.839901,-0.427897,-0.449141,0.0725186,0.059499,-0.404494,-0.0705494,1.12873,-0.510501,-0.8268,0.341996,-0.780267,-0.167708,-0.0969701,0.18841,0.104302,0.151335,1.41189,0.419978,0.110926,-1.11198,-0.157183,0.102583,-0.770062,-0.0467692,0.708966,-0.0112551,-0.130719,0.489386,0.117906,0.129494,0.436106,0.0113165,-0.392015,-1.27648,0.635121,-0.628027,-0.109956,0.841764,-0.511391,-0.495635,0.533321,0.322841,0.0242254,-0.343386,0.826559,-0.500305,0.171112,0.453645,0.728234,-0.276001,0.178085,0.47493,0.513281,-0.10148,-0.0349977,-0.124432,0.0441973,0.0744307,0.103708,-0.0545106,-0.0202803,-0.32463,-0.0430258,-0.529486,-0.351641,-0.782826,-0.440197,0.0514554,0.0913298,0.133238,-0.395466,-0.328804,0.307801,-0.0184665,-0.1465,0.0377589,0.334123,0.333741,0.125025,-0.468406,0.480056,-0.102144,-0.275692,-0.0333816,-0.033012,0.793464,0.645825,-0.390194,0.0366055,0.347706,-0.362059,0.58615,-0.0204534,0.155507,0.254203,-0.172252,-0.634044,0.378444,0.362978,0.352152,0.000778532,0.486999,-0.529145,0.284154,0.0743409,-0.0357447,0.314873,-0.136765,0.1398,0.461745,-0.353746,-0.0184302,0.420951,0.0949579,0.378411,-0.452148,-0.0899501,0.158222,0.268812,-0.602047,-0.379712,-0.259081,0.286778,0.104343,-0.20882,0.294773,-0.41634,0.22502,0.234584,0.0623227,0.418483,0.542193,-0.267358,-0.223633,-0.359186,0.154615,0.406618,0.303354,1.02835,0.0135876,-0.827086,0.308406,0.0129892,-0.14059,-0.0251502,-0.133222,0.228906,-0.132955,-0.0417783,-0.182377,0.228857,-0.095034,-0.234847,0.56465,0.0200284,1.03813,-0.0558289,-0.55197,0.251092,-0.0118028,-0.0289523,-0.570968,0.274078,-0.332753,0.197841,-1.1862,0.146257,-0.320431,0.0911463,-0.363388,0.0589665,-0.25043,0.166282,-0.347889,-0.451948,-0.49406,-0.451984,-0.487596,0.559732,-0.867913,-0.130337,0.299664,-0.107311,0.830643,0.216896,-0.1531,0.105643,0.321485,0.0425539,0.399489,0.552659,0.0147638,-0.564438,-0.276295,0.309057,0.0882129,0.220119,-0.103091,0.393894,1.00755,-0.0397613,0.0921526,-0.721715,0.172661,0.226964,-0.104342,-0.0507179,-0.0513111,-0.0961775,-0.278948,-0.124344,0.110473,0.451619,0.099278,0.371888,-0.165762,-0.0877244,-0.088787,0.6665,-0.0935855,0.118685,0.206897,0.491979,0.092269,0.00386073,-0.216692,0.165819,0.183402,0.526446,-0.5139,-0.287673,0.387502,-0.523381,0.0319283,-0.243328,0.239494,0.202881,0.0936645,0.279082,0.12001,-0.0998364,0.189222,-0.215375,0.280173,-0.247091,-0.214832,0.0937418,-0.309859,-0.397176,-0.402481,0.0247994,-0.73343,-0.368835,-0.126702,0.420951,-0.00647037,-0.172478,-0.371034,0.238644,0.489055,-0.509769,-0.163758,0.531012,0.203227,-0.0454372,-0.765761,0.152796,0.506285,0.285924,0.616257,-0.283749,-0.125644,0.218482,0.297834,-0.614323,-0.745626,-0.0493129,0.121059,0.225904,0.347935,0.475294,0.673602 +3416.43,0.999344,0.0912059,4,1.73577,0.61321,-1.49531,0.719946,0.169242,-0.177072,-0.0821451,-0.325911,-0.0978836,-0.0552171,0.28977,0.0756152,-0.14064,0.301892,0.221852,0.188897,0.275451,-0.676142,-0.118927,-0.0273587,0.166573,-0.588462,-0.719253,0.722903,-0.460164,-0.494571,0.197303,0.0335224,-0.710697,-0.264198,1.08685,-0.976286,0.00251651,0.29576,-0.804106,-0.329379,-0.677465,0.370465,0.307336,0.111415,1.07031,0.574528,0.284836,-1.23573,-0.639048,-0.539387,-1.05884,0.00186967,0.148879,0.214195,-0.433603,0.533112,0.151142,-0.0161474,0.38352,-0.221201,-0.310003,-1.32964,0.0342942,-0.28469,-0.0318193,0.539569,-1.19027,-0.676934,0.643762,0.010067,0.504163,-0.104382,-0.193844,0.0160076,-0.391631,0.861972,0.866979,-0.569739,0.45468,0.463773,0.971247,-0.336639,0.0797985,-0.359884,0.100705,-0.680249,-0.00712394,-0.0120683,-0.112742,-0.0214144,-0.48279,-0.30574,0.326938,-0.321621,-0.0950052,0.174804,0.00827013,0.176217,-0.119745,-0.740018,0.00330899,0.0401832,-0.261615,-0.323616,0.161481,0.0627042,-0.509691,-0.302584,0.470301,0.327592,0.524938,-0.332924,-0.148516,1.20125,0.140913,-0.251021,0.217714,0.162436,-0.141943,-0.125345,-0.48355,-0.24277,-0.122223,0.466473,-1.26519,-0.378466,-0.546002,-0.506107,-0.732123,0.433802,-0.120724,-0.225982,0.0306088,-0.151736,-0.26735,0.418142,-0.384141,0.496277,-0.0325885,0.197566,0.03658,0.0780915,0.56867,-0.405619,-0.0085982,-0.0525681,-0.108308,-0.262627,-0.195276,0.49092,0.149273,0.608792,-0.406185,-0.237208,-0.0848041,-0.079511,0.0615608,-0.249367,0.0107682,0.480498,0.47111,0.0114702,-0.0476809,0.307934,0.249931,0.33752,0.878155,0.327733,-0.464188,0.0156385,0.00855039,-0.371815,-0.604952,-0.122247,0.00413756,-0.18822,-0.238438,-0.297816,0.202533,-0.0164295,-0.462602,0.331888,-0.135612,0.772854,0.827943,0.0318847,-0.190314,0.535584,-0.719231,-0.0734989,-0.111732,-0.412714,-0.0761752,-0.693189,0.188345,-0.312326,0.322911,0.0922834,0.667125,-0.369817,-0.241005,-0.546706,-0.236586,-0.249037,-0.36041,-0.819628,0.33933,-0.482126,-0.0041382,-0.304519,-0.427675,0.709416,0.408356,-0.0283414,0.410541,0.0206423,0.241253,0.32337,0.137561,0.338062,-0.255576,-0.11405,0.577078,-0.473224,-0.0764729,-0.386661,0.407848,0.205761,-0.0899431,0.241836,-0.533319,0.13046,0.381897,0.0826067,0.00157823,-0.286653,-0.941003,-0.305272,-0.56755,0.160964,0.218167,0.0131824,0.345347,-0.253398,0.20136,0.484778,-0.287394,-0.148706,0.552593,-0.00850503,0.373047,0.107561,-0.0670331,-0.0153758,0.112609,-0.448357,0.186643,0.18605,0.0428347,0.297855,-0.375621,0.236811,-0.160962,-0.110808,0.652948,0.275847,-0.185175,-0.154116,0.171608,0.442465,-0.0386376,0.889441,-0.276501,0.19137,0.123232,0.377432,-0.429835,0.00540809,0.0504896,-0.367988,-0.0503125,0.151712,0.110353,0.292413,-0.536582,-0.0522846,-0.265887,-0.0459281,0.214395,-0.0631403,0.189397,0.316562,0.102648,-0.386785,-0.138819,0.188973,0.263005,1.06042,-0.28412,-0.388095,0.435065,0.348355,-0.559801,-0.400569,0.249628,0.158038,0.364456,0.39754,0.603702,0.236951 +3419.17,0.851757,0.0912059,4,1.68452,0.782261,-1.32915,0.61802,0.724425,-0.0385059,0.00495286,-0.218624,-0.324928,-0.16108,0.0439323,-0.116066,-1.11485,0.246634,0.0419164,0.525484,0.177782,-0.233078,0.00143002,-0.02402,0.24435,-0.971305,-0.934803,0.545535,-0.092922,-0.179339,-0.304927,0.559739,0.230587,0.211889,1.05342,-0.910095,-0.488946,0.217953,-0.838177,-0.547943,-0.314854,-0.185801,0.150533,-0.42051,1.02528,0.312049,0.0180543,-1.11115,-0.0801013,0.207819,-0.857092,0.143543,0.282948,-0.282045,0.00993192,0.560426,-0.260064,-0.591584,0.585646,-0.27886,0.064038,-1.06572,0.161279,-0.441294,0.28092,0.792682,-0.739726,-1.19601,-0.23398,0.23407,-0.280801,0.153194,0.44107,-0.508742,-0.252269,0.336232,0.696996,0.0325129,0.944138,0.629042,0.389344,0.320436,-0.256333,-0.194726,0.287233,-0.145965,-0.137454,-0.0437774,0.02717,0.102226,0.340051,-0.540352,-0.0207943,-0.623322,0.734871,0.199258,0.182418,0.432555,0.242555,0.520507,0.224061,-0.166735,0.265754,0.376174,-0.0425495,-0.221489,0.0168986,-0.0522414,0.109652,0.0221002,0.382159,-0.404303,0.495007,0.016251,-0.670416,-0.233588,0.395249,-0.124466,-0.108474,-0.435347,0.0422881,0.0690668,0.124124,-0.135108,-0.585502,0.395063,0.107697,0.0971822,-0.0683094,0.069415,0.227403,0.205264,0.212769,-0.881561,0.179834,0.0604178,-0.139234,0.670471,-0.23346,0.313695,-0.252583,-0.111887,0.0609008,-0.114627,-0.564707,-0.530009,0.0315022,0.326961,-0.11902,-0.707782,-0.562412,0.180232,-0.245442,0.359979,0.0733126,0.424277,0.621273,0.463856,0.105249,0.544541,-0.168332,-0.490825,-0.584855,-0.00860849,0.367547,0.0822395,0.340288,-0.078174,0.27546,0.37692,-0.147146,-0.575207,0.158115,-0.14509,0.449806,-0.176135,-0.455274,0.0188734,-0.570295,-0.165667,-0.256779,-0.318809,0.226946,0.96498,-0.101861,-0.228342,0.292917,-0.426524,0.344563,0.36103,-0.0967446,-0.77811,0.137802,0.120045,0.227059,-0.155071,0.168762,-0.958839,-0.215712,0.0742224,-0.0891717,-0.397489,-0.152181,0.445335,-0.194087,-0.0476934,0.0974914,-0.113567,-0.500064,-0.0851626,-0.651301,0.654937,-0.0721395,-0.102483,-0.32733,-0.106475,0.101202,-0.239737,-0.204444,0.166154,-0.228282,0.266178,-0.0221771,0.235078,0.536124,-0.2497,0.0883773,-0.134667,-0.573442,0.50285,-0.557913,-0.642832,-0.188281,-0.241195,-0.628104,-0.335112,0.52528,-0.691135,0.151663,0.20672,-0.218928,0.0772419,0.815883,-0.176638,-0.259735,-0.765964,0.0517053,-0.140248,0.17472,0.141234,0.642775,-0.200044,0.792552,-0.327728,-0.612471,-0.556649,0.644729,0.312247,-0.440709,0.193909,-0.12915,0.00239797,0.263665,-0.171043,-0.173139,0.156653,0.456322,-0.30737,0.13268,-0.126422,-0.480245,-0.450236,0.378857,-0.283451,-0.182656,-0.239585,-0.394893,0.0771208,-0.0967175,-0.245153,0.117431,-0.605169,-0.0591621,0.00807088,0.154135,-0.461641,0.0195878,0.292346,0.0402805,0.248728,-0.235416,-0.136215,-0.170394,0.0289917,-0.351814,-0.00682277,-0.420524,0.123369,-0.0982995,-0.446797,-0.619953,-0.241532,0.219238,0.295741,0.0622873,0.116439,0.247725,0.341232,0.49772,-1.98154 +3418.37,0.506874,0.0912059,4,1.65783,0.656815,-1.27914,0.616351,0.589416,-0.0695271,-0.262223,-0.000107128,0.392763,0.15211,0.116291,0.178102,-0.726073,0.189171,-0.133442,0.637939,0.198665,-0.119023,-0.163033,-0.0563265,0.000822858,-0.570446,-0.828096,0.707943,-0.385467,-0.337845,0.00911351,0.367653,-0.0905616,-0.131333,1.08546,-0.499686,0.269143,0.281235,-0.614655,-0.125344,0.395799,0.148292,0.0930233,-0.562435,0.497512,0.446258,0.44515,-1.15831,-0.571222,-0.156246,-1.18172,0.105529,0.115385,-0.157091,0.0230987,0.708949,-0.0833067,-0.556858,0.748928,-0.65574,0.012968,-0.795982,0.292768,-0.754205,0.558697,0.598075,-1.19136,-0.492779,-0.170031,-0.0844765,-0.346593,-0.149731,0.385124,-0.0978457,-0.309458,0.50182,0.966962,0.538276,0.455693,0.187198,0.581028,0.711403,-0.153822,-0.197004,0.174179,0.0968385,-0.0347716,-0.298608,0.0897606,-0.205773,-0.221861,-0.204359,-0.0707969,-0.204363,0.340163,-0.0345095,0.191889,0.296239,0.130742,-0.0666067,0.876021,-0.577003,-0.207496,-0.151066,0.153958,-0.419525,-0.412338,-0.0580306,0.17852,-0.00205524,0.224963,0.0679745,0.505662,0.361729,-0.14021,-0.0918045,0.0338784,0.11983,0.137415,-0.13618,-0.270941,0.219625,-0.165446,-0.319682,-0.513245,0.564725,-0.0425499,-0.0468491,0.0793772,0.391394,0.197614,0.11337,0.575317,-0.943967,0.531931,0.232369,0.0266604,0.176196,-0.470405,-0.267273,0.554068,0.261896,0.352699,-0.326471,-0.157245,0.178772,-0.508437,0.0113076,-0.0711205,-0.798793,-0.148149,0.158628,-0.435997,0.0294141,0.442261,0.397001,0.427222,0.240819,0.104763,0.538289,-0.230947,0.611235,0.233496,0.00825251,-0.15443,-0.0969508,0.570634,0.0765633,-0.0778285,-0.107472,-0.505762,-0.417528,-0.150359,0.287281,0.304799,0.299216,-0.412522,0.116994,-0.264567,-0.134921,-0.173568,0.149384,0.0618484,0.832901,0.346245,-0.251063,0.454617,-0.199315,0.104738,-0.269533,-0.255663,-0.367235,0.303077,0.0539535,0.119778,-0.118633,-0.0632442,-0.603379,0.128006,0.238084,0.393953,-0.424741,-0.0444318,0.292216,-0.430973,-0.0646791,0.0121,0.0456704,-0.268224,-0.284649,-0.285066,0.750993,-0.0572472,0.316578,-0.0569798,0.153574,0.178053,0.133098,0.0590791,0.29077,-0.283666,0.0741091,0.334628,0.0533299,-0.233492,-0.14959,-0.14085,-0.337979,-0.352228,0.331794,-0.00984302,-0.173071,-0.0611071,-0.0413403,-0.406589,-0.283792,0.187798,-0.805049,0.427745,0.427673,-0.022629,-0.534638,0.698163,-0.521915,-0.210213,-0.266943,0.0774276,-0.0419915,0.519209,0.0754746,0.415952,-0.185054,0.399984,0.178741,-0.728178,-1.31201,0.195978,0.219771,-0.309333,0.160693,-0.195233,0.197635,0.329128,-0.34979,-0.427192,0.485979,0.0350669,0.270386,-0.198548,0.204634,-0.213198,-0.184818,-0.145961,0.313319,-0.231423,-0.749907,-0.153701,0.168824,-0.0265719,-0.792056,0.390195,-0.512186,0.42081,0.602643,0.492681,-0.557454,0.496886,0.0900313,-0.164642,0.720124,0.0719437,-0.133416,-0.10478,-0.0382595,-0.328783,-0.320672,-0.0474966,0.116248,-0.0881241,0.1009,-0.0951506,-0.13943,-0.418456,0.348681,-0.209884,0.143659,0.274723,0.379024,0.52414,-1.35518 +3423.54,0.718721,0.0912059,4,1.66183,0.707395,-1.11986,0.605219,0.68457,-0.0679571,-0.0692151,0.00873278,0.377826,0.201914,0.205103,0.257603,-0.698991,0.113548,0.0245234,0.450462,0.437399,-0.262182,-0.259075,-0.00546019,-0.134327,-0.59171,-1.00622,0.758001,-0.296116,-0.435877,-0.126478,0.543759,-0.133304,-0.143551,1.07673,-0.739828,0.233873,0.391665,-0.646141,-0.117041,0.167099,0.159843,-0.0189602,-0.460446,0.73379,0.420491,0.324291,-1.157,-0.41006,-0.173608,-1.27406,0.0366288,0.0665339,-0.159489,-0.159605,0.757387,0.127076,-0.861044,0.432818,-0.476878,-0.172302,-0.810954,0.159636,-0.672588,0.504649,0.688249,-0.918135,-0.73496,-0.298001,-0.20074,-0.351181,-0.0884783,0.499576,-0.0481496,-0.14235,0.965615,0.798476,0.593946,0.531889,0.196507,0.679908,0.682356,-0.265429,-0.108981,0.401801,-0.0771161,0.0058894,0.0442458,-0.0254379,-0.324217,-0.111332,-0.056102,0.0487117,-0.421579,0.257397,-0.0602819,0.133601,0.2907,-0.158693,-0.222414,0.593214,-0.531612,-0.110699,-0.00969185,0.375408,-0.219351,-0.582021,0.018383,0.00570242,-0.163565,0.203035,0.221459,0.623917,0.239569,-0.184004,-0.244723,0.00272325,0.0649712,-0.00454762,-0.347283,-0.255029,0.0923408,0.0159361,-0.539309,-0.538787,0.376616,-0.265813,0.00827942,0.00140799,0.318901,0.212544,0.236036,0.511699,-0.68706,0.423477,0.303511,-0.155291,0.101648,-0.491921,-0.108314,0.372943,0.199795,0.36089,-0.45035,0.17331,0.12515,-0.614343,-0.150366,-0.308544,-0.820045,0.114598,0.300814,-0.494127,-0.205719,0.315813,-0.0732775,0.333232,0.085145,0.129944,0.87828,-0.104203,0.531073,0.0743532,0.0110142,-0.0755194,-0.108948,0.535391,0.0566842,-0.570719,-0.146625,-0.41809,-0.118375,-0.392738,-0.0164311,0.237201,0.189289,-0.170724,-0.047745,-0.475397,-0.283531,-0.41981,0.440456,0.146662,0.838591,0.464809,-0.255322,0.567069,0.145385,0.014628,-0.451101,0.132427,-0.067851,0.351775,0.290488,0.306341,0.146203,0.220243,-0.488461,0.215982,0.145609,0.396848,-0.433178,-0.0727665,0.193665,-0.628093,-0.0579008,0.118567,0.255525,-0.19134,-0.671119,-0.557233,0.834546,0.0297037,0.0458003,0.00591608,0.218863,0.25049,0.0331658,0.11842,0.189835,-0.247538,0.28384,0.353903,-0.0582524,0.0225632,-0.183979,-0.276574,-0.362715,-0.149277,0.549637,0.0521397,-0.154262,-0.371905,-0.0794108,-0.31516,-0.184693,0.032544,-0.878802,0.229961,0.390238,0.249579,-0.538831,0.849662,-0.415812,-0.314574,-0.356221,0.0654064,0.17331,0.451461,0.146535,0.437411,-0.199877,0.141007,0.100051,-0.554341,-1.29514,0.167025,-0.0535205,-0.341168,0.116486,-0.140227,0.292663,0.387611,-0.279891,-0.355849,0.612675,0.247731,0.422887,-0.147909,0.190336,-0.177698,-0.030842,-0.264655,0.375818,-0.00618207,-0.540504,-0.445426,0.535411,0.0604621,-0.482745,0.15722,-0.368114,0.260958,0.623022,0.180664,-0.666496,0.23086,-0.0146678,-0.308023,0.6186,0.000264786,-0.209048,-0.103586,-0.36396,-0.198236,-0.0897795,-0.0482321,0.228045,-0.0133675,0.0898727,-0.137524,-0.1505,-0.480418,0.339358,-0.269607,0.138218,0.326387,0.371777,0.571303,-1.83002 +3423.86,0.958031,0.0912059,4,1.57837,0.639513,-1.37735,0.704803,0.223347,-0.017389,0.172483,-0.0132106,0.400816,-0.478192,0.0991938,0.295198,-1.03675,0.363193,-0.237628,1.24016,0.598549,0.0279264,0.0750098,0.164771,0.122401,-0.362666,-0.951401,0.704327,-0.0854565,-0.575066,0.0356052,0.577589,0.00901856,0.177272,1.1572,-0.901706,-0.143502,0.46985,-0.759115,-0.0610222,0.0140797,0.641039,0.510137,-0.408663,0.843855,0.561671,0.319863,-1.03999,-0.585221,-0.336235,-0.72664,0.0486714,0.205994,-0.23775,-0.330944,0.546127,0.239087,-0.590373,0.510505,-0.356547,-0.236358,-1.05308,0.285742,-0.0839226,0.107323,0.420695,-0.933054,-1.05599,-0.038604,-0.00446241,-0.30668,-0.33653,0.600713,-0.1651,-0.412381,0.877765,0.828457,0.178524,0.180487,0.167033,0.597045,0.126148,-0.323321,-0.158421,0.498234,-0.0933268,0.0432514,0.0661595,-0.144915,-0.557756,-0.207317,-0.134917,-0.286272,-0.195706,0.216695,-0.100078,0.358521,0.0524164,0.0460324,-0.853795,0.725345,-0.480757,0.0996128,0.372396,0.415472,-0.293835,-0.704782,-0.148152,-0.0981721,-0.104181,0.0142328,0.0679776,0.236155,0.286418,-0.140112,-0.193124,-0.0748984,0.129451,0.135463,-0.591327,0.26005,0.0327331,-0.136646,-0.109558,-0.819092,0.099468,-0.40117,0.13891,0.275146,0.567414,-0.00983191,0.016915,0.330978,-0.194187,0.547225,0.266292,-0.110135,0.333533,-0.40267,0.111561,0.339136,0.450459,0.406279,-0.591785,-0.487498,-0.0710149,-0.569301,-0.276539,-0.664309,-0.452201,-0.100896,0.615061,-0.408537,-0.0891123,0.0568826,0.153623,0.293574,0.144298,0.157586,0.553466,-0.201293,0.375938,0.111912,-0.205076,0.193261,-0.267046,0.705222,0.464901,-0.523737,-0.206285,-0.238043,-0.0183746,-0.0498986,0.109854,-0.123335,-0.257053,-0.328701,-0.0690669,-0.187188,-0.111768,-0.278913,0.0400998,0.210322,1.05542,0.475713,-0.0660873,0.195787,-0.410386,0.103721,-0.437921,-0.207605,-0.320276,-0.0905004,0.154446,0.594592,0.0856877,0.389591,-0.42474,-0.020876,0.711055,0.324806,-0.0520616,-0.670044,-0.115404,-0.454167,-0.0279571,0.232505,0.101051,-0.480748,-0.21294,-0.765466,0.842257,-0.11412,0.360145,-0.214959,0.123131,-0.0326439,0.143102,0.130029,0.227598,-0.0058738,0.410984,0.0671039,-0.124327,0.363076,-0.939464,-0.220768,0.0737577,-0.392105,0.356181,0.27237,-0.05481,-0.335742,-0.0308078,-0.188432,-0.242975,0.0526855,-0.899749,-0.196166,0.480015,0.0823885,-0.576224,0.777136,-0.567053,-0.519987,-0.299406,-0.0559407,0.38706,-0.0779334,-0.00869735,0.369195,-0.371156,0.345312,0.114556,-0.266643,-1.30814,0.196143,-0.495258,-0.522379,-0.121615,-0.3785,0.497785,0.438793,-0.0697715,-0.31774,0.760663,0.512277,-0.0695569,-0.0905845,0.031473,-0.0654996,0.102046,0.0384384,0.0703688,-0.318051,-0.635882,-0.569034,0.219349,-0.379927,-0.614208,0.144492,-0.38744,0.573182,0.301157,0.0763225,-0.0740684,-0.244514,0.228077,-0.177625,0.314417,0.0130406,-0.75657,-0.452344,0.221633,-0.307901,-0.319628,-0.0134648,0.189756,-0.102251,-0.205418,0.00954208,-0.138242,0.00664255,0.433059,0.231732,0.139328,0.243788,0.373267,0.493749,-0.2341 +3421.3,0.973973,0.0912059,4,1.58804,0.704281,-1.37012,0.645978,0.205273,-0.0112278,0.231278,-0.0803318,0.41659,-0.4075,0.103253,0.263144,-1.08088,0.320386,-0.250517,1.17229,0.729588,0.0195597,0.120785,0.172275,0.120521,-0.244816,-0.932128,0.537296,0.0794755,-0.613821,-0.0109611,0.517121,-0.135723,0.140224,1.13311,-0.984949,-0.274383,0.411835,-0.682619,-0.0459424,-0.0610612,0.485718,0.433395,-0.345747,0.852641,0.614089,0.335169,-0.974194,-0.59851,-0.411237,-0.932747,0.228769,0.326168,-0.162061,-0.232786,0.651028,0.258496,-0.812296,0.610394,-0.498117,-0.218247,-1.20781,0.191957,0.0448354,0.111425,0.47784,-1.08618,-0.874803,-0.0337101,-0.129955,-0.355104,-0.432121,0.574481,-0.169119,-0.504021,0.897986,0.909039,0.176285,0.202836,0.115299,0.617295,0.0416063,-0.180833,-0.0406992,0.410291,0.0727339,0.0316025,0.111597,-0.0249329,-0.59091,-0.273588,-0.0754455,-0.164796,-0.312443,0.175276,-0.195756,0.381621,0.0250416,0.138201,-0.700513,0.560409,-0.380063,0.165189,0.374873,0.337244,-0.216313,-0.708217,-0.0991593,-0.118532,-0.153655,-0.0835292,0.089052,0.228901,0.436723,-0.0260548,-0.183377,-0.0990255,0.0907426,0.227928,-0.541623,0.409128,0.0367571,-0.279112,-0.133738,-0.779849,-0.0493312,-0.268313,0.18546,0.185317,0.588477,0.0664217,0.040793,0.368006,-0.214806,0.555082,0.342891,-0.0361045,0.315166,-0.362349,0.115875,0.286273,0.480959,0.48618,-0.56122,-0.599171,-0.127256,-0.379399,-0.346344,-0.714325,-0.641813,-0.114455,0.708912,-0.386603,-0.0580587,0.0420222,0.110467,0.236219,0.0635514,0.283062,0.659465,-0.280347,0.489642,0.115226,-0.0823553,0.112874,-0.310651,0.791735,0.308823,-0.514822,-0.104986,-0.203123,-0.00462523,-0.0582803,0.04664,-0.0723602,-0.148699,-0.360662,-0.0290935,-0.211687,0.0306475,-0.376486,0.0530544,0.096064,1.11336,0.521394,-0.140796,0.15306,-0.239635,0.0457133,-0.464399,-0.142951,-0.320588,-0.118751,0.0240576,0.621031,0.0845552,0.404246,-0.362184,-0.043279,0.683203,0.388776,0.0240737,-0.711122,-0.161746,-0.426157,0.0454189,0.203378,0.166621,-0.388468,-0.239324,-0.799133,0.881522,-0.130384,0.334736,-0.29182,0.130103,-0.053427,0.0486418,0.104577,0.323679,-0.049225,0.531142,0.148092,-0.180528,0.490128,-0.933064,-0.15333,0.0257769,-0.323997,0.3505,0.289202,0.000923366,-0.420584,-0.0731128,-0.118921,-0.218789,0.0870907,-0.896663,-0.220669,0.481232,0.108656,-0.460087,0.774408,-0.750114,-0.452991,-0.306162,0.103741,0.291452,-0.0899451,-0.0158703,0.463948,-0.161321,0.384587,0.0907857,-0.196272,-1.27274,0.214293,-0.388613,-0.478493,-0.0566147,-0.290349,0.354104,0.445878,-0.0466909,-0.327781,0.729608,0.433576,-0.132581,0.0129097,0.0543664,-0.114138,0.0718484,-0.0557691,-0.00476846,-0.312833,-0.573997,-0.617577,0.183081,-0.284365,-0.505671,0.0939215,-0.563896,0.579988,0.287587,0.0579126,-0.0433912,-0.217849,0.137476,-0.197782,0.418116,0.00421853,-0.722873,-0.444244,0.05609,-0.246208,-0.312568,-0.0385165,0.150157,-0.106126,-0.280711,0.117996,-0.20279,0.0631754,0.493046,0.230877,0.148288,0.245223,0.385082,0.4952,-0.228492 +3423.61,0.932596,0.0912059,4,1.70497,0.639952,-1.09397,0.56691,0.491715,-0.137966,-0.0340073,0.0948951,0.454318,-0.0873234,0.377443,0.416277,0.203574,0.655846,-0.301962,0.435319,0.353191,-0.0648371,-0.429235,-0.0549876,0.26408,-0.560677,-0.719498,0.499598,0.00870623,-0.276236,-0.0036593,0.272094,-0.148685,0.147024,1.0915,-0.536956,0.169525,0.329652,-0.604093,-0.479684,-0.529755,0.0973024,0.355172,-0.304258,0.432512,0.353397,-0.453601,-0.648274,-0.286626,-0.134896,-0.567287,-0.227605,0.272336,-0.325401,0.129531,0.512023,-0.00021035,0.274587,0.58153,-0.207991,0.17836,-0.290761,-0.244871,-0.750765,0.0986132,0.781894,-0.503789,-0.937149,0.203778,-0.187128,0.419129,0.424924,0.423308,-0.329758,-0.223554,0.329829,0.566997,0.283605,0.914015,0.570725,0.483053,-0.104073,-0.210334,0.335424,-0.328082,-0.26809,-0.0271782,-0.196498,-0.374982,0.0603209,-0.443506,-0.260512,0.0847117,-0.232122,0.317778,-0.143015,0.0108183,0.0784509,-0.246468,-0.690038,-0.355369,-0.492294,-0.452017,0.452262,0.171481,0.0715175,-0.48576,0.23776,0.473234,-0.511938,0.114553,-0.0641754,0.256724,0.140439,-0.717545,-0.536691,0.34317,0.214178,-0.106256,-0.0994607,-0.439465,0.283004,0.755595,-0.286355,-0.556779,0.0864975,0.348902,-0.911333,0.0602748,-0.16168,-0.4003,0.312478,0.0823891,-0.459573,-0.0326035,0.0197909,0.408117,0.284363,-0.202015,0.0798293,0.302167,0.000511047,0.376175,-0.755347,-0.292247,-0.114249,0.239544,-0.469465,0.730766,0.320174,-0.185469,0.135305,-0.114135,0.011755,-0.0402066,0.262672,0.252893,-0.132623,0.0820601,0.428924,0.265575,-0.61316,0.333427,-0.394417,0.151381,0.195507,0.699543,0.263988,-0.532731,0.215225,-0.126325,-0.12247,-0.0236963,-0.547687,0.000247121,-0.487285,-0.114904,-0.207427,-0.258968,-0.136896,0.0357752,-0.637385,-0.0104298,0.635899,-0.0454104,-0.0776897,0.118498,0.604973,-0.0158624,-0.698297,0.185024,-0.230042,-0.391385,-0.383287,-0.34184,0.444579,-0.456146,-0.603036,-0.233318,-0.197176,0.142949,-0.695981,-0.384316,0.683328,-0.015551,-0.323481,-0.0891878,-0.188159,-0.248353,0.300811,-0.489102,0.859166,-0.110677,-0.133463,0.0781837,-0.24802,0.343896,-0.504578,-0.301918,0.115607,-0.237684,0.194087,0.24439,0.297607,-0.577221,-0.0991827,0.2279,0.451883,0.233307,0.325626,-0.703151,0.0311301,0.668362,-0.205266,-0.510435,-0.0708053,-0.297751,-0.57364,-0.830867,0.755031,-0.212447,0.344427,0.17976,-0.173595,0.0576359,-0.586856,-0.507751,-0.0628114,0.290981,0.500282,0.336517,-0.261097,0.132543,-0.335258,0.620724,-0.380157,0.264209,0.0352951,0.0389215,0.730843,-0.146682,-0.36078,0.252267,-0.0648633,-0.173928,0.601141,0.0185223,0.577983,-0.2623,0.230116,-0.16295,0.268144,0.281862,0.0477236,0.25986,0.224037,-0.140338,-0.0567915,-0.219033,0.190913,0.308566,-0.0791943,0.946331,-0.29373,-0.28684,0.477549,0.598776,0.258642,0.00571155,-0.0776758,-0.163453,-0.563099,0.211,-0.211194,-0.0859403,0.0865441,-0.166636,0.196684,0.388868,-0.341938,0.285079,0.325812,0.16895,-0.439403,0.0723329,0.145608,0.251386,0.381586,0.501384,-0.987181 +3432.65,0.74766,0.0912059,5,1.71915,0.754854,-1.52026,0.664517,0.466915,-0.129758,0.00470069,-0.504079,-0.00905612,-0.339408,0.220043,-0.197517,-0.26178,0.829944,-0.561023,0.58268,0.394613,0.0112407,0.230387,0.191994,-0.52796,-0.313222,-0.830229,0.0754159,-0.268079,-0.0695165,-0.217775,-0.20515,-0.919568,0.377329,1.01852,-0.285173,-0.0654013,0.365509,-0.276279,0.0172302,-0.0589993,0.585353,0.238926,-0.415121,0.850678,0.529928,0.261263,-0.728515,-0.403379,-0.209553,-0.589498,-0.170877,0.737045,0.160033,-0.0575126,0.198895,-0.0903474,-1.0046,0.213583,0.0210636,-0.584836,-1.00907,0.084765,-0.336958,0.325901,0.892413,-0.931908,-0.840902,0.287333,0.487503,0.115463,-0.345236,0.0515589,-0.483596,-0.138204,-0.511663,-0.151836,-0.163112,0.308291,-0.0187571,0.371051,0.200047,-0.223612,-0.0499327,0.475576,-0.124438,0.335751,-0.22085,0.418134,-0.116761,0.157164,-0.0295544,-0.182829,-0.654502,-0.713122,0.112261,-0.328234,-0.264908,0.0541996,0.263293,0.44706,-0.308699,0.131123,0.142759,-0.172811,0.113445,-0.23928,-0.593419,-0.0390917,0.179952,0.422093,-0.720593,-0.0933437,0.660723,0.788147,0.22116,-0.319282,0.253157,-0.0883105,0.171092,-0.156518,0.313775,-0.166001,-0.0491495,-0.593349,0.0132973,-0.055543,-0.00349386,-0.394715,0.076753,0.15382,0.355202,0.174885,-0.221723,0.0415067,-0.649499,-0.155867,0.569889,-0.342017,-0.345043,-0.243835,-0.33922,0.561434,-0.709111,0.16349,0.0564767,-0.210076,-0.278744,-0.745577,0.241231,0.173413,-0.0596544,-0.378997,-0.405467,-0.235078,-0.0518908,-0.116264,0.269314,0.163503,0.249932,0.0185466,0.372007,-0.246358,0.149301,0.421261,-0.00747285,0.737735,-0.52501,0.257993,0.247531,-0.284175,0.0436438,-0.285525,0.295881,0.224405,0.362836,-0.21981,-0.354948,-0.0420132,-0.20833,-0.0320736,0.600948,-0.299937,0.634835,0.455645,-0.149001,-0.2583,-0.724047,0.216955,0.125556,0.0379485,-0.372815,0.0730368,-0.298119,-0.375342,0.198962,0.407709,-0.353704,0.243065,0.485953,0.0365356,0.470042,-0.573771,-0.220292,-0.229706,-0.0464171,0.255099,-0.0928038,0.599533,0.265163,-0.217183,0.690206,-0.170801,0.031211,0.0514681,-0.367713,-0.140289,0.489987,-0.0800017,0.553979,-0.176921,-0.0228633,0.232097,-0.152478,0.510977,-0.439876,0.189449,-0.196773,-0.173453,-0.0153373,-0.231239,-0.722851,-0.27919,0.153238,0.13396,-0.0369307,-0.367637,0.158428,0.279263,0.606831,0.212931,-0.0690087,0.520285,-0.305527,-0.0177689,0.588283,0.475896,0.394842,0.208591,-0.164667,0.151998,-0.032393,-0.370788,-0.76,-0.19419,-0.25677,0.213738,-0.169684,-0.568359,-0.0010148,0.0539761,0.134025,0.0443916,0.250516,0.177225,0.177303,0.503569,-0.277763,0.774962,-0.0770163,-0.00298758,-0.135885,-0.401118,0.0726424,-0.575174,-0.614881,-0.324309,0.13588,-0.0113898,0.0600292,-0.0851628,0.190762,-0.45679,0.0192337,-0.147072,-0.24046,-0.953818,0.284504,-0.384294,0.482532,-0.37169,0.583747,0.229451,-0.205324,-0.0248111,0.0398768,0.0106803,-0.210132,0.052399,-0.33236,-0.518487,-0.330357,-0.244415,-0.161231,-0.309866,0.104096,0.260576,0.322639,0.510467,-0.964443 +3426.59,0.965198,0.0912059,5,1.53238,0.690848,-1.23397,0.541986,0.874208,-0.149559,-0.101096,0.226901,0.244137,0.144334,0.628707,-0.040289,0.576295,0.724851,0.126629,0.852131,0.530567,0.191601,-0.320921,-0.529907,0.107208,-0.865667,-0.895853,0.201489,-0.240897,-0.309931,-0.161918,0.449778,-0.37005,0.240937,0.705757,-0.686361,0.247488,0.380466,-0.561569,-0.351587,-0.566701,0.0975564,0.607112,-0.147319,0.700264,0.336014,-0.2621,-0.500469,0.321802,0.370874,-0.427488,-0.464942,0.110911,-0.414805,0.0235633,0.71804,0.250624,0.394779,1.00125,-0.204396,0.107467,-0.596347,0.472508,-0.32877,0.177579,0.86629,-0.331038,-0.709253,-0.127887,-0.36794,0.0721049,-0.0666772,0.231658,-0.29414,-0.113331,0.473544,0.346208,-0.0398698,0.752173,0.467963,0.435382,-0.356373,-0.0845697,0.25852,0.290584,-0.483368,0.422053,-0.00585702,-0.93231,0.463142,-0.0209737,-0.114021,-0.105776,-0.0531761,0.512699,-0.0730619,0.281683,0.333763,0.131593,-0.808881,-0.288973,-0.326711,0.242323,0.166236,0.327032,-0.206338,-0.271782,0.0637454,-0.342323,-0.379274,0.535715,0.213781,0.915682,0.388002,-0.989139,-0.322136,-0.217807,0.0985355,-0.187634,0.0094696,-0.570033,-0.200334,0.582264,-0.119761,-0.359535,0.0990527,-0.223966,0.105303,0.388368,0.299633,0.356103,0.0225261,0.0948877,-0.347438,-0.985005,-0.272539,0.0901279,0.286648,-0.388437,-0.142369,0.342346,0.31659,0.33772,-0.181918,-0.380828,0.342949,0.218564,0.0873917,0.585792,0.172664,0.232526,0.374986,0.0699111,-0.0611654,-0.0163124,0.271795,0.46456,-0.181274,0.235747,0.639117,0.158883,-0.159657,0.289963,-0.422706,0.24217,0.0760897,0.491046,0.618668,-0.0504612,0.88877,-0.0146602,-0.326234,0.0480386,-0.410499,-0.132784,-0.288646,-0.424745,0.314806,-0.21216,0.264344,-0.354988,-0.734589,0.253402,0.61977,-0.160917,-0.144636,-0.119702,0.455982,-0.352214,-0.191756,-0.519439,-0.263353,0.257213,-0.572338,-0.518493,-0.0133131,-0.403864,-0.833121,-0.219165,-0.407709,0.481629,-0.627947,-0.316401,0.745108,0.54195,-0.172997,0.10336,-0.0472533,-0.416634,-0.0672374,-0.672959,1.08828,0.25223,-0.0140785,-0.037367,0.0904347,0.543348,-0.317194,0.092191,0.232595,-0.356044,0.0806719,0.313576,-0.108713,-0.684649,-0.399101,-0.296061,0.458397,-0.159438,0.533836,0.0528217,0.357979,0.212578,0.010182,0.0573824,-0.132827,-0.19438,-0.398419,-0.482352,0.263602,-0.337211,0.0660611,0.264709,-0.0518723,-0.190419,-0.409912,-0.396415,-0.150132,0.227757,0.452707,0.416758,0.258933,-0.372004,-0.535344,0.247585,-0.714675,0.111399,-0.0230825,0.0303151,0.869706,-0.173212,-0.0898307,0.453061,0.31499,0.238571,0.737765,-0.259376,0.534696,0.0871196,-0.0545865,-0.0813831,-0.0705248,0.225313,0.122237,0.226714,-0.241662,0.292502,0.215655,0.1635,-0.524454,0.16213,-0.06534,0.138217,0.261771,-0.255219,0.267381,0.15184,0.0588666,0.151847,0.174806,-0.0387151,-0.152219,-0.223611,0.103783,-0.262506,-0.0983883,0.0555324,0.538248,0.0234347,-0.899848,0.363567,0.0921438,-0.0530869,-0.264558,0.224771,0.124554,0.237939,0.352923,0.48779,-2.41945 +3412.08,0.822745,0.0912059,4,1.64844,0.836807,-1.00364,0.413922,0.864332,-0.0271038,0.0315482,0.118889,-0.181646,-0.0290715,0.158125,-0.449967,-0.414332,0.489197,-0.543497,0.64894,-0.171088,-0.125409,0.416764,-0.612229,0.190721,-0.875145,-0.518669,0.376393,-0.130061,-0.174475,-0.259056,-0.0504392,-0.364096,-0.0783125,0.273578,-0.304494,0.00755896,0.609842,-0.455545,-0.0963695,0.386047,0.145544,0.126706,-0.542599,0.809431,0.214878,0.391386,-0.579246,-0.276671,0.178697,-0.949759,-0.325469,-0.181418,0.0290447,-0.108054,0.158661,-0.000682563,-0.743833,0.550629,0.147708,-0.363882,-1.02855,0.470185,-0.406252,0.0132024,1.03811,-0.449909,-1.1926,0.00224068,0.456606,-0.414573,-0.120932,-0.140515,-0.500881,-0.277356,-0.406686,0.180511,-0.228035,0.404157,0.481869,0.634875,0.425988,0.6222,-0.141606,1.21136,-0.421257,0.0560332,-0.19952,0.27487,0.21715,-0.0932601,-0.0145696,0.0379142,-0.183765,-0.762137,0.378309,-0.336088,0.113784,-0.134635,-0.19089,0.486416,0.252407,-0.33994,0.303691,0.0388334,0.0951746,-0.509566,-0.531134,0.180197,0.133193,0.0396691,-0.560415,0.479454,0.289494,-0.101244,-0.265435,0.209936,0.401177,-0.293731,0.379535,-0.787404,-0.0137268,-0.642121,-0.375746,-0.785142,-0.436652,0.383543,-0.414487,0.326473,0.093062,0.19019,-0.284502,0.162627,0.133226,-0.077146,-0.369228,0.0723873,0.0375488,-0.300387,-0.340368,-0.125966,0.734063,0.158351,-0.257658,0.403565,-0.200347,-0.138909,0.0327903,-0.35236,0.371025,-0.162087,0.651208,0.189052,0.189439,-0.835251,-0.182113,0.211884,0.0458964,-0.246821,0.583822,0.533711,0.0749358,0.169497,0.267003,0.0857389,-0.131718,0.531597,-0.290718,-0.0981054,0.236938,0.609013,-0.562761,-0.457443,-0.0596824,0.334784,-0.467683,0.0503441,-0.456783,-0.171991,-0.822068,-0.401727,0.3134,-0.228852,0.6146,-0.0350095,0.414544,0.200214,-0.981637,-0.398887,-0.29008,-0.464302,-0.600003,0.304457,-0.555071,0.0129137,0.234326,0.119955,-0.749927,-0.0550273,0.39332,0.113753,-0.625968,-0.791814,-0.29508,-0.290473,-0.258944,0.617928,0.304047,0.525115,0.162844,0.0765279,1.2776,-0.393071,0.202654,-0.522307,0.222231,-0.463063,-0.0560855,0.171303,0.220107,0.360905,0.219108,0.536819,0.157594,0.235596,-0.396125,0.636399,0.201737,-0.0877141,0.481382,-0.57363,-0.85534,0.317062,0.0686575,-0.10565,-0.0591044,-0.291199,-0.266603,0.353395,0.0627668,0.027811,0.136973,0.47834,-0.389916,0.0707178,0.45046,-0.301159,-0.506855,0.378618,0.137971,0.153654,0.363689,0.162897,-0.422309,-0.62539,-0.6043,0.560747,0.0459498,-0.429368,0.695895,-0.582569,0.0973372,-0.131312,-0.253611,-0.192205,0.327327,0.452151,0.21488,0.0260368,0.0373803,0.659103,-0.29885,-0.245932,-0.225688,-0.462585,-0.164545,-0.365453,0.073659,0.306979,0.0850614,-0.0804956,0.26908,0.600692,-0.226459,-0.546028,-0.540239,-0.322073,0.0622615,0.105179,0.179927,-0.221711,0.601542,-0.115062,0.204814,-0.0888589,0.0510955,-0.256872,0.290539,-0.4573,-0.10299,0.0243219,-0.588284,-0.352423,0.0317214,0.0126045,0.140681,0.180442,0.375074,0.424785,-2.55884 +3434.49,0.967434,0.0912059,5,1.6603,0.721745,-1.46998,0.581538,0.504543,-0.0463982,0.0533937,-0.342494,0.0679864,-0.0353559,0.0873591,0.142742,-0.342516,0.149563,0.0933336,0.826648,-0.0847665,0.047945,-0.133775,-0.718846,0.196836,-0.749502,-0.461446,0.31095,-0.608923,-0.0820267,-0.0542445,0.237952,-0.185656,-0.230744,0.457226,0.0524738,0.099439,0.594206,-0.299882,-0.0675055,-0.0344745,-0.047589,0.143655,-0.427545,0.869171,-0.00639195,-0.150576,-0.450934,-0.352798,0.131497,-0.615757,0.0298398,0.131902,-0.204506,0.234345,0.319006,-0.075725,-0.0671032,0.421038,-0.0489477,0.104082,-0.574067,0.510202,-0.47225,0.448534,0.835548,-0.939853,-0.833025,0.0580889,0.472469,-0.864832,-0.133907,0.176089,-0.244587,-0.383524,0.020187,0.499089,-0.239926,0.283559,0.551989,0.366151,0.360692,-0.113376,-0.513506,0.750976,-0.906516,0.115126,-0.177371,-0.264338,0.354829,-0.191085,0.161455,-0.301644,-0.150085,-0.141468,0.406022,-0.00614911,-0.0685628,0.0805097,0.0642195,0.652653,-0.06842,0.165829,0.384304,0.137948,-0.796606,-0.440563,-0.176386,0.0313017,0.0795396,0.0183215,-0.0249095,0.374757,0.446506,-0.0112002,0.0452522,0.137168,0.466462,-0.0347198,0.229114,-0.377249,0.0975133,-0.201378,-0.12916,-0.445416,-0.599018,0.239989,-0.479139,0.328933,0.0990706,0.312245,0.00856224,0.204662,-0.448879,-0.12831,-0.27054,-0.0912506,-0.195964,-0.181389,-0.175456,-0.07464,0.437424,0.210722,-0.816288,-0.00336338,-0.0744257,0.293807,-0.282759,0.0475378,0.0375304,-0.282395,0.455914,0.102097,-0.0984487,-0.514606,-0.14284,0.321887,0.124503,-0.122888,0.768998,0.853166,-0.0988916,0.319851,0.0620076,0.203133,-0.201768,0.861422,-0.135937,-0.00914826,0.0412133,0.51525,-0.752062,-0.217439,0.103729,0.408851,-0.353698,-0.134122,0.00578357,-0.0295843,-0.469518,-0.0745391,0.285961,0.0606046,0.881181,0.460061,0.729147,0.658001,-0.281084,-0.00265896,-0.0358745,-0.354953,-0.356137,0.170923,-0.411119,-0.0420545,-0.185993,-0.214737,-0.00655965,-0.38955,0.518554,0.305142,-0.505252,-1.02687,-0.0227639,-0.0688112,0.0152609,0.601813,-0.280536,0.333309,-0.197615,-0.0155712,1.30625,-0.592692,0.0600193,-0.572375,0.146083,-0.0331652,-0.0722202,0.477606,0.38298,0.24752,0.119549,0.545824,0.156783,-0.113494,-0.368371,0.423535,0.479012,-0.264665,0.337829,-0.882857,-0.246952,-0.258838,0.0210204,0.0450266,0.262405,-0.142178,-0.0613216,0.236206,0.0600331,0.00377609,0.00404052,0.407443,-0.304408,-0.120592,0.481931,-0.588467,-0.209476,0.190434,0.0280407,0.240969,0.0190247,0.163835,-0.0121584,-0.428972,-0.450324,0.728074,-0.113536,-0.693441,0.592972,-0.709061,-0.2038,-0.109209,-0.405945,0.25359,0.101156,0.0922801,0.232577,0.0469807,0.0144979,0.0717113,-0.416319,-0.120766,-0.286407,-0.261896,0.297302,-0.576141,-0.246933,0.238759,-0.328225,-0.15797,0.66208,0.179419,0.292999,-0.403347,0.00829315,-0.00988142,-0.201737,0.152344,-0.110123,-0.0606061,0.0701425,-0.066988,0.232527,-0.0842604,0.0753666,-0.222351,0.12513,-0.164303,-0.0243432,0.112796,-0.421285,0.0872806,0.275133,0.305709,0.145562,0.143515,0.381526,0.378833,-1.05825 +3454.09,0.997809,0.0912059,4,1.58011,0.905871,-1.09807,0.411745,0.600798,-0.228118,-0.189277,0.59935,0.638411,0.30893,-0.230327,-0.130932,-0.215844,-0.133149,-0.52181,1.19992,-0.0557213,-0.106146,-0.479098,-0.0983634,-0.133013,-0.656546,-0.611483,0.193116,0.0308568,-0.302345,-0.0845608,0.110936,-0.385296,-0.0225851,0.679905,-0.643347,0.026416,0.408339,-0.482969,-0.284539,-0.109534,0.603787,0.166271,0.216172,0.94384,0.555954,0.542782,-0.691637,-0.0257508,0.249681,-0.406516,0.304822,0.106836,0.465052,0.0239949,0.698738,0.148296,-0.42238,0.712611,-0.356815,-0.133889,-1.13484,0.489672,-0.0169569,0.228387,0.620108,0.156719,-1.12608,0.000397262,0.188315,0.0956558,-0.181665,-0.345742,-0.317241,0.178632,0.54899,0.659397,-0.0143249,0.0232168,0.435212,0.028152,-0.209163,-0.0508934,0.335428,0.152065,0.0812938,0.013957,-0.217453,-0.323898,-0.273462,0.23689,-0.549777,0.124437,-0.233243,0.391406,-0.302402,-0.261512,0.0425659,0.110762,-0.555714,0.351301,-0.434754,0.129058,0.0643751,0.131743,0.53133,-0.39202,0.194375,0.158222,-0.0656385,0.338378,-0.0330219,0.242962,0.0120602,-0.422279,0.0895885,-0.0739803,0.207813,0.354149,-0.265214,0.227594,-0.0850018,0.0926787,0.033771,-0.266945,0.183948,-0.188578,0.159025,0.17628,0.119999,0.207754,-0.0668643,0.384486,-0.490357,-0.458188,0.169092,-0.0168525,0.103888,0.11719,0.0967986,-0.112066,0.191198,0.00194506,-0.271636,-0.51958,-0.235428,0.084076,0.371276,0.167253,0.265613,0.173586,0.55127,0.137358,-0.495645,-0.461483,0.0263476,0.203479,-0.379649,0.587167,0.113715,0.371927,0.0169794,0.0536751,0.00351031,0.607445,-0.0540582,0.625591,0.250411,-0.084743,0.0720732,-0.186692,-0.0372319,-0.104534,0.414529,-0.464308,0.173024,-0.0878482,0.0166457,-0.39911,0.308693,-0.600333,-0.750868,-0.088173,0.993585,0.00673012,-0.0188101,0.0179345,0.18046,-0.250253,-0.455632,-0.325586,-0.00491652,-0.0638039,-0.838166,0.31505,0.51868,-0.150687,-0.453595,0.0875674,0.526933,0.144527,-0.182086,-0.504631,-0.35696,-0.0673858,-0.426716,-0.219898,0.407336,-0.104357,-0.324715,-0.039345,0.761449,-0.141346,0.258432,-0.169109,0.079236,0.262936,0.37657,-0.0650807,0.395328,-1.16573,-0.0174898,0.111205,-0.0173656,0.0853452,-0.261704,0.0279236,0.0341634,-0.189669,0.576912,-0.4595,-0.0976553,-0.203723,0.113168,0.366934,-0.358175,-0.295095,-0.216053,-0.103555,0.182128,0.204014,0.0190995,0.889568,0.0472212,-0.213705,0.107119,0.24703,0.0160919,-0.00328812,0.0424648,0.752009,-0.514243,0.163883,-0.123229,0.160467,-0.130669,0.306055,0.398569,0.426569,0.541349,-0.0573101,0.258235,0.468537,0.20311,0.165573,0.325206,0.340755,0.25348,0.613165,0.261673,0.221,-0.257698,0.00151531,0.100214,0.0440234,-0.423508,-0.19378,0.0410885,0.584495,0.103688,0.203875,-0.130029,0.0525965,-0.0114568,0.0411094,-0.401418,-0.229844,0.18526,0.319488,0.358461,-0.0411769,0.425383,0.200728,-0.364074,0.0115123,0.297211,-0.138187,0.104951,-0.0307639,-0.920717,-0.318888,-0.0149609,-0.274894,-0.0755643,-0.0713945,0.116954,0.218574,0.341985,0.467519,-1.77245 +3439.53,0.848454,0.0912059,4,1.49975,0.902279,-1.22519,0.474059,0.409322,-0.17127,-0.293342,-0.142618,0.524552,0.133636,0.270464,0.175265,-0.0881874,0.400006,0.13932,1.00915,0.192126,0.400104,0.196805,-0.476298,-0.464418,-0.894577,-1.07075,0.219415,-0.210913,-0.415069,0.0313887,0.537636,-0.162113,0.23509,0.884073,-0.444545,0.472796,0.209367,-0.291374,0.0743236,-0.450381,0.811727,0.57379,-0.426636,0.993375,0.914859,0.264206,-0.824007,-0.546146,-0.119035,-0.336361,-0.381498,0.253269,0.02896,0.195822,0.919886,-0.0930325,-0.285472,0.277159,-0.198079,0.0859594,-0.567078,0.678527,-0.245355,0.470374,0.734754,-0.485607,-1.08762,0.150184,0.585647,-0.253105,0.369712,0.354974,-0.33419,-0.174917,0.212428,0.488712,-0.211569,0.430676,0.354534,0.0161263,-0.171494,-0.48403,-0.0213026,0.452284,-0.612496,0.167002,-0.0424162,0.165954,0.152633,-0.148564,0.0203477,-0.157118,-0.334696,0.0562724,-0.185059,-0.14144,-0.0356547,0.20518,0.0343244,0.0475119,-0.330275,-0.204547,0.197858,-0.0883519,-0.287461,-0.0458276,-0.00647117,0.451185,-0.754177,0.321329,-0.347776,-0.22936,0.54883,-0.141286,0.295973,0.267393,0.494187,0.230607,-0.105791,-0.565861,-0.102413,-0.0772116,0.0873984,-0.121274,-0.543167,-0.0934348,-0.561568,-0.392335,0.347798,0.0546887,0.169517,0.200613,-0.576025,0.411301,0.0406206,0.345409,0.153947,-0.238495,-0.599794,0.361069,-0.407675,0.721223,-0.103459,-0.499863,0.113969,0.534612,-0.358273,-0.161721,-0.274757,-0.351802,0.0656196,-0.278262,-0.630357,-0.142568,0.372012,0.148019,-0.0237366,-0.0362504,0.076894,0.302225,-0.151688,0.155433,0.238693,-0.00101947,0.357549,0.72807,0.0776496,0.626983,-0.211855,-0.249063,-0.36099,-0.472696,-0.412277,0.390905,-0.331116,-0.0401759,-0.0621896,-0.227571,-0.585381,-0.171244,-0.462909,-0.053233,0.901004,-0.0636652,0.167079,0.199463,0.674279,-0.44122,-0.0418401,-0.0181813,-0.582227,0.4191,-0.395966,-0.22745,-0.0275883,-0.186582,-0.310735,-0.157106,0.32814,0.165003,-0.0102849,-0.34329,0.285056,-0.135306,-0.0923841,-0.251511,-0.054685,0.278163,-0.525784,-0.523022,1.01349,0.424189,-0.0724718,0.00705599,-0.105184,-0.20066,-0.0387952,-0.597364,0.389877,-0.47483,0.0619646,-0.268114,-0.175219,0.138983,-0.295699,-0.334346,0.00788346,-0.485612,0.204619,-0.149806,-0.221165,0.279914,-0.311723,-0.82563,0.353968,0.467498,-0.340092,-0.560034,0.26163,-0.0548344,-0.388656,0.618321,-0.630597,-0.464342,0.429407,-0.314299,0.226435,-0.00354625,0.379345,0.270142,0.476957,0.0852328,-0.044326,-0.440297,-0.171675,0.448249,-0.136123,-0.43396,0.798328,-0.19014,0.166625,0.380675,-0.188965,-0.263914,0.656843,-0.0944096,0.218717,0.0374765,0.196305,-0.0738782,0.0801191,-0.273782,0.0118349,-0.310796,-0.32878,-0.380045,-0.232705,0.284673,-0.0659695,-0.183113,0.159581,0.649737,-0.354346,0.632169,-0.0146934,-0.257572,0.206915,0.0670408,-0.168151,-0.110672,-0.0304445,-0.0522213,0.320261,0.096208,-0.232725,-0.196002,-0.323802,-0.136908,-0.320768,0.772142,0.0846108,0.10714,-0.37751,-0.685814,0.104391,0.331432,0.323096,0.575701,-1.21732 +3440.96,0.983142,0.0912059,4,1.52163,0.893584,-1.17483,0.486905,0.407561,-0.17174,-0.151017,0.0289912,0.448085,0.14648,0.188699,0.165463,-0.0781304,0.423765,0.154898,1.01196,0.243433,0.329478,0.156098,-0.37875,-0.492398,-0.939782,-0.992695,0.20007,-0.172944,-0.380768,0.0478476,0.445506,-0.1048,0.272583,0.874681,-0.325015,0.548032,0.222494,-0.324562,0.103231,-0.427586,0.840036,0.536069,-0.495642,1.05803,0.762107,0.279771,-0.93757,-0.524722,-0.00442114,-0.423395,-0.296764,0.338025,0.0813868,0.148343,0.928956,-0.185057,-0.554974,0.251832,-0.249769,0.168115,-0.547452,0.650544,-0.386794,0.444734,0.679705,-0.350406,-1.08663,0.0957577,0.532972,-0.292102,0.360732,0.414211,-0.200273,-0.1665,0.230267,0.495414,-0.21795,0.486016,0.507038,0.0457371,-0.12475,-0.534857,-0.0636825,0.429319,-0.655423,0.0635335,0.0490402,0.12056,0.214692,-0.117094,-0.0616233,-0.200616,-0.321296,-0.0393797,-0.159647,-0.0940684,-0.1698,0.156451,0.0526123,0.00973831,-0.446944,-0.189234,0.174251,-0.0654093,-0.229259,-0.130131,-0.119095,0.244038,-0.761739,0.378226,-0.281958,-0.164868,0.428745,-0.143272,0.306736,0.125036,0.464694,0.177127,-0.0956749,-0.653339,0.0134703,0.00758652,0.104349,-0.26198,-0.264104,-0.241839,-0.488132,-0.399874,0.336357,-0.00551345,0.142797,0.254302,-0.632115,0.379636,0.0938939,0.268952,0.14391,-0.237076,-0.581675,0.344163,-0.309731,0.689029,-0.117811,-0.609381,0.104494,0.512682,-0.421757,-0.115197,-0.195948,-0.324694,-0.0442351,-0.3315,-0.579685,-0.22943,0.339642,0.100407,-0.049875,-0.0946688,0.0534982,0.434331,-0.119329,0.217509,0.191535,0.0523265,0.438579,0.832208,0.0342991,0.560267,-0.290996,-0.218931,-0.432823,-0.440307,-0.370874,0.279425,-0.160631,-0.049034,-0.0667661,-0.175118,-0.550446,-0.15247,-0.526489,-0.0290714,0.960993,-0.266456,0.149485,0.163454,0.68571,-0.59794,-0.0412094,0.0175115,-0.55157,0.427745,-0.280644,-0.257149,-0.00885555,-0.0184582,-0.404378,-0.195961,0.376267,0.195578,-0.0848864,-0.407355,0.261764,-0.10197,-0.0865311,-0.249283,-0.111563,0.224474,-0.437007,-0.487274,1.00123,0.268059,-0.165242,-0.00992805,-0.187083,-0.165597,-0.0289581,-0.487773,0.44815,-0.353842,0.123832,-0.300858,-0.188743,0.16693,-0.357824,-0.420827,0.107942,-0.440762,0.233094,-0.140016,-0.261092,0.21691,-0.245694,-0.749663,0.349917,0.512987,-0.429881,-0.564439,0.29074,-0.109745,-0.383686,0.654201,-0.454555,-0.403176,0.530316,-0.159844,0.228702,-0.00705487,0.394533,0.355943,0.431084,0.222767,0.00516135,-0.380629,-0.0723306,0.583649,-0.211686,-0.407191,0.9697,-0.289054,0.178079,0.452075,-0.179648,-0.331267,0.647783,-0.00405385,0.16864,-0.170119,0.178296,-0.119671,0.179419,-0.303788,-0.159359,-0.305245,-0.279292,-0.515197,-0.254514,0.294523,-0.295461,-0.142749,0.263008,0.638744,-0.334978,0.83222,-0.188671,-0.251327,0.151532,0.0620471,-0.288802,-0.0884019,0.0742296,0.0466839,0.237764,0.144834,-0.213863,-0.182775,-0.445176,-0.220503,-0.173325,0.753767,0.065861,0.089268,-0.341646,-0.52434,0.104019,0.317518,0.32252,0.563487,-1.21275 +3438.41,0.969427,0.0912059,4,1.51713,0.903967,-1.24999,0.495878,0.452513,-0.163209,-0.204856,0.079455,0.46372,0.223808,0.16983,0.157125,-0.0460433,0.430623,0.143257,1.06943,0.229035,0.406956,0.123108,-0.458708,-0.456049,-0.874147,-1.00157,0.234147,-0.189561,-0.34779,0.0448692,0.276623,-0.18217,0.2601,0.853043,-0.354022,0.477049,0.193145,-0.318441,0.115454,-0.408228,0.819906,0.539637,-0.469844,1.08428,0.782532,0.294925,-0.945991,-0.580134,-0.0768294,-0.461889,-0.326096,0.267085,0.0269469,0.145684,0.930162,-0.215187,-0.492495,0.236488,-0.222791,0.193568,-0.577794,0.670191,-0.475927,0.435226,0.708831,-0.436408,-1.20162,0.0429958,0.498401,-0.344035,0.341101,0.377203,-0.295743,-0.20691,0.26039,0.533375,-0.234978,0.438391,0.430454,0.00858213,-0.0975085,-0.450624,-0.16064,0.459612,-0.693748,0.115244,0.0808024,0.0585775,0.271273,-0.194912,-0.0803937,-0.194431,-0.248824,0.0760554,-0.133572,-0.134344,-0.181828,0.116558,0.0955849,0.019178,-0.469319,-0.12462,0.125769,-0.0357141,-0.247536,-0.125875,-0.0143066,0.18076,-0.797016,0.388961,-0.299516,-0.125079,0.362483,-0.11494,0.295953,0.214106,0.442746,0.194772,-0.0901301,-0.663758,-0.0532878,-0.0259052,0.156478,-0.276685,-0.332141,-0.18122,-0.503219,-0.281386,0.324493,-0.0814843,0.103315,0.198483,-0.610089,0.287339,0.0774197,0.24735,0.100431,-0.136243,-0.554196,0.395107,-0.329608,0.654572,-0.0765138,-0.698075,0.0623739,0.497921,-0.357248,-0.0909017,-0.269633,-0.345098,-0.0494592,-0.346896,-0.545297,-0.226146,0.320462,0.0932923,-0.0589224,-0.128267,0.00602676,0.446654,-0.134005,0.145123,0.225534,0.0271196,0.498625,0.828257,-0.0507049,0.59365,-0.287558,-0.192413,-0.466653,-0.460327,-0.363188,0.252422,-0.222906,-0.124741,0.00944667,-0.171677,-0.499403,-0.144831,-0.484896,-0.0182161,0.976353,-0.320909,0.191371,0.194495,0.763089,-0.59517,0.0459873,-0.000592318,-0.542097,0.352669,-0.308321,-0.227901,0.0448965,0.016255,-0.451081,-0.184255,0.331602,0.179569,0.0113438,-0.369935,0.263981,-0.100378,-0.0942185,-0.240775,-0.0414634,0.249279,-0.496442,-0.560266,0.958815,0.271201,-0.177323,-0.0297939,-0.237585,-0.155503,-0.07276,-0.527753,0.526856,-0.295711,0.125845,-0.317658,-0.139044,0.239658,-0.28131,-0.353716,-0.011322,-0.490388,0.152382,-0.138333,-0.332809,0.258378,-0.19922,-0.741501,0.382141,0.476732,-0.426254,-0.547347,0.297039,-0.103348,-0.38299,0.635959,-0.539849,-0.339933,0.488439,-0.138145,0.244312,0.0668134,0.381335,0.33386,0.391628,0.12633,0.00919916,-0.373264,-0.105217,0.582264,-0.135444,-0.4923,0.995587,-0.283919,0.13436,0.491855,-0.168042,-0.242722,0.599543,-0.0470647,0.0890394,-0.182599,0.186508,-0.0745902,0.124958,-0.233714,-0.172828,-0.318174,-0.325075,-0.51628,-0.275163,0.318419,-0.308177,-0.156978,0.181251,0.501265,-0.329379,0.784649,-0.113193,-0.317992,0.103726,0.0446445,-0.318782,-0.0814714,0.113902,-0.0246219,0.205661,0.112349,-0.270652,-0.176308,-0.479741,-0.22267,-0.161132,0.748267,0.0650348,0.068963,-0.307079,-0.467511,0.107462,0.293203,0.327814,0.541482,-1.35599 +3428.92,0.873448,0.0912059,4,1.59984,0.767109,-1.12311,0.476184,0.550396,-0.0187957,0.140725,0.215201,0.270246,0.0555402,0.158828,-0.0146969,-0.216959,0.456817,-0.220169,0.781515,-0.0135282,0.309574,-0.297589,-0.0116548,0.131431,-0.890489,-0.149406,0.162872,-0.136648,-0.365682,0.505559,0.523762,-0.714168,0.484241,0.728686,-0.954292,0.0760641,0.672295,-0.217849,-0.302872,-0.335768,0.746993,0.553595,-0.0391862,0.841034,0.888941,0.159868,-0.921099,0.176911,-0.0860283,-0.572914,0.232894,0.563641,0.537616,-0.0752399,0.779754,0.0902204,0.330365,0.780018,-0.475595,-0.330101,-0.211813,-0.0887753,-0.336031,-0.0337803,0.920602,-0.09925,-1.18305,0.345276,-0.156317,-0.2015,-0.0228206,-0.184628,-0.27823,0.0813793,0.368653,0.525014,-0.11723,0.45915,0.469018,-0.0341458,-0.280443,-0.216729,0.124498,0.481518,-0.701002,0.0954969,0.0683575,0.17127,-0.166575,-0.0354831,-0.259969,-0.0503202,-0.164855,-0.0764563,0.418385,-0.116768,0.160864,-0.45395,-0.157182,-0.36429,-0.985388,0.0277229,0.455485,-0.105608,0.388226,-0.0118646,0.044786,0.337898,-0.149856,0.0106131,-0.136384,-0.0917193,0.564033,0.0633986,0.190228,-0.0220421,0.241724,0.00947072,0.00152397,-0.541157,0.35009,0.168744,-0.223135,-0.297741,-0.429123,-0.774482,0.0281925,-0.719246,-0.062139,-0.124297,-0.202692,0.0152818,-0.174661,0.496168,-0.249735,-0.329958,0.113734,-0.0816271,-0.146319,0.314938,0.048878,0.355648,-0.505426,-0.240346,0.0471281,-0.0425048,0.53479,-0.34616,0.363713,0.119147,0.395578,-0.0369429,0.371787,0.188726,-0.262945,-0.428377,0.247181,0.0820769,0.427906,-0.160994,0.155238,0.180794,-0.0679108,0.165378,0.0655402,0.191461,0.0396327,0.100625,0.191849,-0.00775134,0.184931,-0.210761,0.160306,0.112543,-0.0311723,0.00167813,-0.252836,0.122084,-0.128147,-0.409414,0.272582,0.129632,0.428485,-0.163626,-0.171534,-0.257711,-0.300698,-0.0625293,-0.18054,0.0797663,-0.0875086,-0.143963,-0.251385,-0.038516,0.281422,-0.327347,-0.584399,-0.36425,0.325761,0.265293,-0.426917,-0.793499,-0.222603,0.193733,-0.864992,-0.00368441,-0.0711425,-0.0527401,-0.368921,-0.220903,0.982437,-0.103161,0.0225249,0.0276107,-0.0776421,0.325159,0.249228,-0.132751,0.0255291,0.143452,-0.163994,-0.220369,0.0406167,0.136143,-0.3345,0.0719138,-0.262447,0.129924,0.181097,-0.832383,-0.18507,-0.0488219,0.295973,0.124563,-0.369934,0.281562,0.0689774,-0.495419,0.678643,0.281862,-0.00184703,0.720979,-0.766612,-1.24409,-0.368845,0.196547,0.0986547,0.0421025,-0.208939,0.260486,-0.690813,-0.423599,-0.370843,0.103594,-0.613413,0.2986,-0.347373,-0.268536,0.511482,-0.124186,-0.111652,0.206243,0.1276,-0.162564,0.398502,0.0780408,-0.109171,0.694756,-0.487063,0.250031,-0.614095,-0.510019,-0.0898697,-0.471985,-0.32601,-0.530898,-0.215426,-0.384881,0.127908,-0.0374124,0.0757044,0.200637,-0.0116971,-0.384493,0.0431046,-0.600806,-0.413698,-0.0412434,-0.266811,0.341659,0.165173,-0.12328,0.324818,-0.165555,-0.0497626,0.0147002,0.0954004,-0.35575,-0.284695,-0.21393,-0.0519433,-0.356248,0.0413134,0.845649,0.111504,0.324941,0.333922,0.570036,-1.44036 +3424.93,0.77229,0.0912059,4,1.54227,0.789387,-1.31465,0.437706,0.952861,-0.124004,0.288247,0.0582403,0.442574,0.0670902,0.178608,-0.122592,-0.656542,0.186956,-0.196258,1.03335,-0.158241,0.245561,-0.399267,-0.42433,-0.397716,-0.652971,-0.518003,-0.0526073,-0.105856,-0.442607,0.101802,0.438619,-0.135799,-0.0738487,0.760913,-0.403038,-0.105815,0.374346,0.160017,-0.222794,-0.592148,-0.00944231,0.110289,0.0524413,0.936753,0.469065,-0.0370093,-0.694267,0.280385,-0.135323,-0.349623,0.334126,0.279651,0.132052,-0.0789486,0.26915,-0.146741,-0.381861,0.782417,-0.590623,0.0661041,-0.606256,0.697233,-0.410436,0.507254,0.849064,0.133666,-0.651519,-0.0623869,-0.326807,-0.0603942,-0.43109,-0.299302,-0.545734,0.136624,0.324411,0.561135,0.0281109,0.209757,0.581,0.0185551,-0.196594,-0.549749,0.320238,0.478831,-0.571205,0.429549,-0.369504,0.445451,-0.276792,-0.334129,-0.263604,0.0201303,-0.397049,-0.290507,-0.0583599,0.127324,-0.137338,0.324817,-0.364534,-0.394851,0.250564,-0.111253,0.501149,0.212024,0.709347,-0.344865,-0.462114,-0.446478,-0.084333,-0.0709632,-0.19262,0.334483,0.637935,-0.23872,0.280379,0.420763,0.399008,-0.377579,0.125067,-0.304201,0.21699,0.175125,-0.284325,-0.501417,-0.295254,-0.280107,0.601282,0.266168,-0.115575,-0.152093,-0.280375,0.434889,-0.374911,-0.217463,0.136451,0.22921,0.440849,-0.162329,-0.0394677,0.0331906,-0.195936,0.528669,0.152182,-0.356111,0.0211524,-0.0345291,0.0734518,-0.160653,-0.496364,-0.403339,0.186983,-0.137704,-0.0475413,-0.512069,0.0688579,0.304787,0.316817,0.274243,0.267325,0.182568,-0.254051,0.0982502,0.303559,0.481975,0.279568,0.562278,-0.329211,0.0336631,-0.0563691,-0.214209,0.456889,-0.267968,0.0360031,0.402393,-0.293356,-0.133536,0.00941156,-0.59917,0.278135,-0.189033,0.0105691,0.16138,1.0736,-0.120521,0.273181,-0.244869,-0.159608,-0.180815,-0.135214,0.219851,-0.442701,0.0972907,0.181551,0.0936976,-0.0922552,-0.150063,-0.173289,-0.115837,0.0999756,0.203132,-1.05153,-0.354206,-0.470609,0.342666,-0.18716,0.0652808,-0.197861,-0.0632425,0.0997458,-0.605739,0.980542,-0.29719,0.507866,-0.328625,-0.27845,0.126505,-0.250717,0.388569,0.327518,-0.000470757,0.301699,-0.226147,-0.459634,0.231558,-0.444114,-0.233767,0.223705,-0.380639,0.0813912,-0.117021,0.167371,-0.0964695,0.299082,0.0296532,0.232048,0.115549,-0.158567,-0.302459,0.78299,-0.302378,0.0366268,0.507215,-0.5703,-0.290934,-0.295937,0.385302,0.0230142,-0.0708741,-0.198813,0.426426,-0.250709,-0.121604,-0.295486,0.0129559,-0.836795,0.770197,-0.0909184,-0.410309,0.281137,-0.0976527,0.267657,-0.599188,0.220293,0.479585,0.695288,0.187756,-0.43867,0.77998,-0.0805346,-0.0900924,0.0917357,-0.251592,0.12336,-0.308515,-0.415822,-0.577495,-0.0630987,-0.240636,-0.0246853,-0.190005,0.336094,0.391137,0.604596,-0.402908,0.32565,-0.248599,-0.0995511,0.166296,-0.812994,-0.156106,0.368781,0.0568881,-0.192474,0.114216,0.297933,0.706188,-0.407982,0.0885388,-0.949428,0.257901,-0.082233,-0.267051,0.80843,-0.14986,0.118929,0.206236,0.344861,0.454132,-2.70999 +3416.73,0.981917,0.0912059,4,1.59911,0.792397,-1.35168,0.577688,1.06082,-0.0752677,-0.0983719,-0.1189,0.293245,-0.0705315,0.169707,-0.231179,-0.463144,0.0842196,-0.574914,0.972445,-0.152544,0.439462,-0.129961,-0.0714341,-0.0995493,-0.848988,0.0100214,0.0914274,-0.42936,-0.182181,0.0302035,0.413643,-0.568273,-0.111751,0.665934,-0.178793,-0.199733,0.646882,-0.0794538,-0.321589,0.095535,0.61324,0.631325,-0.343206,0.878329,0.389091,0.209995,-0.651908,0.467391,-0.200569,-0.491177,0.284862,0.209759,0.206703,-0.223268,0.164805,-0.144374,-0.232334,0.396507,-0.0900826,-0.409069,-0.954026,-0.0389614,-0.408344,0.0900592,0.696308,0.0748567,-1.65409,-0.163514,-0.190841,0.13612,-0.626548,-0.455463,-0.0220948,0.121916,0.444728,0.452213,0.0448203,0.212234,0.419968,-0.111374,-0.39594,-0.537785,0.249866,0.41908,-0.445996,0.531523,-0.599969,-0.0560625,-0.144316,-0.294173,0.192043,-0.132086,-0.202214,-0.169761,-0.121747,0.239723,-0.205127,0.178032,-0.130712,-0.344631,0.436518,-0.186199,0.487123,0.49168,0.334633,-0.0966279,-0.452942,-0.61618,-0.280453,0.622323,-0.363278,0.102492,0.811358,0.0270836,-0.443031,0.138265,0.308401,-0.146742,-0.174313,0.121688,0.397885,0.101072,-0.651732,-0.276384,-0.723792,0.217907,-0.0454714,-0.296591,0.234442,0.0785516,0.19282,0.108496,-0.589366,-0.157145,0.474331,-0.538755,0.281967,-0.495901,-0.243801,0.0243718,0.165971,0.596532,-0.117456,0.0275424,0.119817,0.158991,-0.524023,-0.479848,0.00877465,0.153504,0.0909407,0.129943,0.324804,-0.307684,0.135857,0.180141,0.541575,0.433287,0.97189,-0.257973,-0.33643,0.144352,0.147108,0.124558,0.125574,0.162873,-0.363006,-0.0191234,-0.219416,-0.260583,0.263,0.190567,0.0383114,0.189715,-0.287813,0.0222213,0.232138,-0.431383,0.349526,-0.148151,0.0833699,0.153103,0.881854,-0.356409,0.515961,0.317158,-0.336318,-0.288596,-0.143515,0.199631,-0.216872,0.348909,-0.0167212,-0.0941873,0.0444949,-0.35746,-0.0909707,-0.286899,0.256885,-0.0842477,-0.619228,-0.0545735,-0.0198142,0.22762,-0.172129,0.00638294,0.119273,-0.424046,0.156844,-0.651468,0.979377,-0.44149,0.0733874,-0.0949694,-0.20191,-0.0485242,0.150773,0.196312,-0.0609279,0.282871,0.243621,0.0219702,-0.665917,0.248971,-0.609052,-0.479536,0.00163326,-0.17017,0.640931,0.376222,0.126411,-0.0225221,0.432177,-0.244352,0.185911,-0.0070745,-0.39629,-0.35448,0.671707,-0.503376,0.0321669,0.492615,-0.503203,-0.380407,-0.108983,-0.164221,0.428404,-0.695484,0.115966,0.156359,0.341528,0.410759,-0.394768,-0.349239,-0.606905,0.461425,-0.0990207,0.0324214,0.166053,-0.146622,0.269988,-0.50379,0.152223,0.0308787,0.359373,0.586493,-0.0230568,0.358022,-0.0607982,-0.169628,0.196535,-0.268813,0.303931,-0.124563,-0.417196,-0.102055,-0.283102,-0.0446129,0.314318,0.149299,0.62552,0.330477,0.040558,-0.276112,-0.0146092,-0.18334,-0.648556,0.171099,-0.341853,-0.254767,0.271536,0.056063,0.239397,-0.0361361,-0.00428444,0.676549,-0.181154,0.127455,-0.555927,0.634711,0.514334,-0.15231,0.3701,-0.235004,0.123601,0.14638,0.351569,0.382596,-3.14235 +3427.03,0.682797,0.0912059,4,1.58987,0.738977,-1.52309,0.63697,0.932415,-0.0743899,-0.0509494,-0.082545,0.253367,0.0675397,0.319233,-0.366329,-0.471854,0.0738454,-0.441007,0.986227,-0.0771974,0.396727,-0.321173,-0.14334,0.0147102,-0.906237,0.170927,0.126716,-0.399099,-0.154435,-0.00437408,0.375364,-0.526751,-0.00294534,0.690879,-0.137637,-0.185439,0.665198,-0.0806332,-0.236294,-0.119844,0.661662,0.589034,-0.234243,0.851155,0.318384,0.23371,-0.632854,0.42365,-0.212503,-0.534582,0.268985,-0.0134971,0.100335,-0.0766806,0.34251,-0.29657,-0.448147,0.484906,-0.19164,-0.335564,-0.965069,-0.00942202,-0.393271,-0.026846,0.669003,-0.0955358,-1.55765,-0.126656,0.0667109,0.138067,-0.521386,-0.345369,0.0163283,0.163567,0.553645,0.449225,-0.0560152,0.395804,0.392108,-0.0237352,-0.402481,-0.41919,0.282673,0.463474,-0.383127,0.576407,-0.577927,-0.176154,-0.00461866,-0.133243,0.237277,0.0613441,-0.173056,-0.19106,-0.0255352,0.257918,-0.284019,0.306904,-0.167683,-0.190193,0.21702,-0.16688,0.474223,0.531614,0.281393,-0.294123,-0.254695,-0.47596,-0.197437,0.638511,-0.433474,0.138703,0.702644,0.00696833,-0.311343,0.23342,0.252627,-0.21875,-0.0884689,0.200501,0.334779,0.0998592,-0.489253,-0.475142,-0.735308,0.0169721,0.0370142,-0.316433,0.275663,0.192137,0.152246,0.229608,-0.491455,-0.214049,0.470569,-0.442439,0.378314,-0.48216,-0.179415,-0.141269,0.217803,0.30304,-0.166404,-0.0777844,0.0716787,0.270424,-0.544882,-0.399454,0.0912137,0.221824,0.168776,0.00409685,0.315784,-0.426287,-0.0142382,0.0482458,0.510643,0.453826,0.909006,-0.205715,-0.404473,0.134053,0.202258,-0.0407513,-0.0453247,0.184549,-0.423944,-0.110745,-0.278507,-0.305665,0.206074,0.169905,-0.160657,0.178598,-0.481668,0.0710062,0.228761,-0.459651,0.209282,-0.182548,0.0232705,0.183844,1.01386,-0.329555,0.490626,0.247336,-0.213396,-0.416995,0.12962,0.290172,-0.211356,0.474677,-0.0656941,-0.0390402,-0.0214385,-0.368324,-0.229735,-0.279351,0.295502,-0.0858953,-0.614177,-0.0414374,-0.0862759,0.315473,-0.149525,0.0349675,0.0726592,-0.467686,0.0938905,-0.811583,0.896905,-0.346111,0.0140929,-0.209311,-0.275393,-0.130465,0.00664729,0.215958,0.0526324,0.204307,0.319862,0.0902769,-0.470276,0.27245,-0.516394,-0.436284,0.0507242,-0.141649,0.637514,0.363524,-0.0141713,-0.145231,0.46095,-0.112052,0.184321,0.035683,-0.145714,-0.347217,0.643766,-0.451706,-0.0490937,0.514918,-0.523235,-0.267988,-0.0682238,-0.166731,0.383265,-0.839798,0.277365,0.336385,0.251507,0.324575,-0.475992,-0.328327,-0.75395,0.449279,-0.0459326,0.00516318,0.21983,-0.0807896,0.208428,-0.583535,0.210656,-0.0928485,0.487678,0.495775,0.129047,0.289719,-0.0259729,-0.158563,0.184508,0.029493,0.144061,-0.0724636,-0.319336,0.0306427,-0.582855,0.0721571,0.242811,0.0750519,0.403754,0.321124,0.0136974,-0.338038,-0.0850639,-0.0751028,-0.579762,0.000708478,-0.254072,-0.214664,0.300262,-0.0187355,0.0838849,-0.0179253,-0.148145,0.522069,-0.243471,0.295202,-0.520336,0.452063,0.505585,-0.00229878,0.483089,-0.155901,0.130273,0.146621,0.360933,0.382911,-2.59725 +3415.9,0.759131,0.0912059,4,1.65451,0.830233,-0.893284,0.31487,0.810712,-0.0349968,0.238922,0.442082,0.194394,-0.294161,0.0701326,0.203899,-0.402434,0.265244,-0.38366,0.759094,-0.0122615,-0.0337903,0.445399,-0.241963,-0.217758,-0.339501,-0.991608,-0.0234483,-0.516142,0.0832993,-0.0640028,0.265646,-0.398883,0.321975,0.836285,-0.928347,0.520755,0.229614,-0.284369,-0.282652,-0.375978,0.0739512,0.543653,-0.153887,0.486699,-0.0825922,0.389188,-0.288969,0.111521,0.616437,0.0623958,-0.140585,0.408571,0.242443,-0.311758,0.249883,-0.00027034,0.188939,0.526248,-0.483681,-0.182736,-0.822739,0.299957,-0.257741,-0.00121025,0.504769,-0.575777,-0.376317,-0.159992,-0.010715,-0.502888,-0.643974,-0.104281,-0.296954,-0.0705833,0.299949,0.477626,0.0166087,0.351053,0.637204,0.388301,-0.642483,-0.317498,0.43621,0.185117,-0.310516,0.477839,0.095631,-0.113473,0.255097,0.387435,-0.333466,-0.292652,-0.433831,-0.0961801,0.440885,-0.207912,0.0531047,0.162536,-0.253448,0.336478,-0.375819,0.189147,0.300391,0.5248,-0.372986,-0.334166,-0.354065,-0.227981,-0.132593,0.030014,0.0822082,0.248816,0.504994,0.00944915,-0.248499,0.210612,0.833027,0.098001,0.409038,-0.668545,0.223329,0.00621045,0.161682,-0.415123,0.465174,0.269836,0.099401,-0.122498,0.164679,0.810999,-0.177795,0.116388,-0.267389,-0.0377113,-0.245647,0.434649,-0.0179029,-0.283126,-0.323197,-0.345843,-0.0276221,0.11837,-0.893197,-0.710633,0.281642,-0.323852,0.37038,-0.188363,0.582629,-0.541786,0.230022,-0.0930435,0.268133,-0.775495,0.384659,0.47726,-0.00334941,0.235357,0.318043,0.00921993,-0.205052,0.458694,0.470799,0.0241585,-0.344376,0.484344,-0.25925,-0.0975089,-0.0383106,0.138898,0.00476867,0.0133409,0.196831,0.550164,-0.113545,-0.0417198,0.106697,0.415705,0.340723,0.180325,-0.226112,0.51229,0.357118,-0.199561,-0.0227604,-0.038772,-0.117879,0.0642409,0.120057,0.569763,-0.381839,-0.0472002,-0.135802,0.253087,0.420769,0.0245381,-0.620798,-0.0106268,-0.167384,0.202133,-0.167757,-1.28853,-0.292223,-0.138809,-0.158643,0.0221969,-0.146294,-0.46003,-0.804925,-0.610449,0.894806,0.0878208,0.22596,-0.377148,-0.0825274,-0.44612,0.353113,0.24357,0.559245,-0.677655,-0.0621499,0.425223,-0.447056,-0.0950864,-0.568414,-0.244048,0.420416,-0.469118,0.15946,-0.701334,-0.0971478,0.392727,-0.510454,0.20627,0.265504,-0.139741,-0.0148455,-0.383341,0.291488,-0.132585,-0.653312,0.885333,-0.0172388,-0.634708,0.562802,-0.435704,-0.462632,0.318736,-0.248846,0.358444,-0.0045623,0.0389133,-0.478571,0.606514,-0.318445,0.414913,-0.0663362,-0.0562266,0.539787,-0.351492,-0.0250732,-0.416774,-0.0396082,0.102135,0.188195,0.225027,-0.384741,0.331022,-0.438534,-0.0210404,-0.211642,-0.159936,-0.12017,-0.108008,-0.679416,0.25323,-0.444654,-0.0510879,0.0585914,0.271512,-0.169848,-0.0585373,-0.328141,-0.415962,0.130395,-0.328025,0.420232,-0.309447,-0.224454,-0.401174,0.287517,0.268956,-0.389242,0.292599,0.205007,0.0659122,0.0875908,0.41213,-0.218408,-0.25597,0.469993,-0.0972034,-0.802497,0.0867463,0.109987,0.169096,0.331644,0.411213,-2.32521 +3428.91,0.522799,0.0912059,4,1.65978,0.840577,-0.943928,0.360686,0.684803,-0.0482815,0.576792,-0.0601611,0.442206,-0.221731,0.151484,-0.104319,-0.271293,0.434459,-0.524765,0.434205,0.142696,-0.19899,-0.00930749,-0.168597,0.10148,-0.311853,-0.794911,0.288693,-0.650138,-0.154005,0.0282388,0.0531999,-0.497583,0.613659,0.750929,-0.159813,0.0628993,0.103143,-0.303844,-0.243498,-0.663778,-0.264113,0.523874,-0.221159,0.763989,0.40689,0.0908858,-0.35456,0.153632,0.0935929,-0.668192,0.0121359,0.339824,0.189145,-0.0546594,0.146227,-0.412262,-0.180142,0.407719,-0.485182,-0.291758,-0.765841,0.229697,-0.52829,0.0801552,0.351389,-0.416671,-0.344586,-0.244527,-0.36118,-0.283655,-0.183666,-0.280122,-0.564252,0.107385,0.0437877,0.395917,0.450172,0.507759,0.24279,0.198404,-0.771791,-0.175255,0.236313,0.0506899,-0.095116,0.296843,0.0485772,0.0306352,0.0763788,0.0197799,-0.323285,-0.445056,-0.696951,0.384855,-0.176438,-0.254219,0.292917,0.340097,0.116202,0.126985,-0.348716,-0.199764,0.285969,0.0797288,-0.408262,-0.513478,0.0231591,-0.2494,-0.101342,0.253609,-0.0195132,0.463406,0.597126,-0.364196,0.0581852,0.18248,0.66271,0.01048,0.344126,-0.86998,0.253218,-0.142549,0.0963733,-0.564883,-0.0971139,-0.0356479,-0.159925,-0.496617,-0.0651608,0.735261,-0.0362989,0.360868,-0.352109,0.211432,-0.262122,0.636291,0.0138454,-0.246812,-0.356181,-0.218188,0.388212,0.464591,-0.879611,-0.464671,-0.224709,0.332567,0.0733187,-0.202493,0.574827,-0.220251,0.3913,-0.236461,-0.106492,-0.517364,0.379697,0.450106,0.157971,0.362828,-0.0273784,0.106853,0.260146,0.606076,0.262156,0.250899,-0.565545,0.393371,-0.431022,-0.0295232,-0.0853801,-0.0958051,0.334412,-0.0580406,-0.130015,0.598126,-0.345531,0.00449499,0.130771,0.134687,0.0893639,0.198955,-0.485835,0.237984,0.794947,0.336207,-0.350727,-0.0890555,-0.286781,0.108911,0.110246,0.3592,-0.385104,0.00576517,0.225842,0.0326581,0.265219,0.459721,-0.579496,0.146055,0.0504883,-0.069807,-0.57637,-1.02842,-0.260269,0.155893,-0.216914,0.00797842,-0.0211942,-0.20918,-0.279343,-0.439451,0.942622,-0.0556182,0.347386,-0.325106,-0.359306,-0.477617,0.430576,0.428379,0.589751,-0.794223,0.258431,0.25397,-0.00480126,0.0541252,-0.61015,-0.0891924,-0.0354508,-0.460887,0.193392,-0.849616,0.051877,0.217903,-0.333214,0.209995,0.3425,0.131301,-0.107496,-0.323517,0.312393,0.294834,-0.154098,0.739082,0.287431,-0.245593,0.357249,-0.0454937,-0.730076,0.406229,0.19824,-0.0725584,-0.258738,-0.0228416,-0.195879,0.168884,-0.556751,0.397193,0.206642,-0.37847,0.00296347,-0.32855,0.00371188,-0.172859,-0.0379745,-0.00507125,0.554389,0.0617004,-0.443903,-0.0278612,-0.431797,-0.134442,0.0492526,-0.159483,-0.117337,-0.231961,-0.814226,-0.25456,-0.112203,0.186796,-0.328047,0.110126,0.262579,0.0944884,-0.0839782,0.162605,-0.121432,-0.539444,0.242224,-0.196863,-0.163544,-0.120839,0.495711,0.142576,-0.36587,0.276094,0.20509,-0.0292108,-0.123187,0.39161,-0.370478,-0.418807,0.122312,0.169575,-0.421687,-0.0884635,0.140535,0.151089,0.37488,0.388702,-1.93376 +3420.61,0.757305,0.0912059,4,1.70613,0.83394,-0.90393,0.304219,0.512544,-0.064266,0.407754,-0.0641139,0.108135,0.11503,0.235785,-0.0278603,-0.341783,0.324764,-0.423047,0.938742,-0.0700938,-0.213345,-0.0303249,-0.0695594,-0.357023,-0.00911681,-0.864822,0.160533,-0.328661,-0.247385,-0.012017,0.0296323,-0.384925,0.111992,0.623348,-0.507607,-0.143773,0.0442443,-0.384571,-0.1068,-0.617096,0.102963,0.166873,-0.0763017,0.609787,0.279194,-0.0610864,-0.47948,0.000926493,0.448824,-0.258,0.0401211,0.278336,0.361363,-0.0406578,0.369586,-0.213784,-0.199983,0.469622,-0.746507,-0.314196,-0.731551,0.0475944,-0.503756,-0.252074,0.770542,-0.474952,-0.560065,0.0969921,-0.0338943,0.110836,-0.318197,-0.558121,-0.386836,0.22941,0.258395,0.495141,0.163918,0.829428,0.47324,0.250581,-0.983082,-0.291549,0.287619,0.355358,0.0929135,0.244141,-0.107374,-0.159801,-0.154153,0.144251,-0.369525,-0.23904,-0.799867,0.467158,0.00468694,-0.139023,0.29717,0.146946,0.145692,0.191704,-0.356576,-0.136536,0.432676,0.213446,-0.397731,-0.765404,0.0290694,-0.346567,-0.297448,0.235107,-0.0312381,0.548703,0.36744,0.0280521,0.305712,0.401215,0.699836,-0.0399261,0.023262,-0.819745,0.424839,-0.0027497,-0.0157975,-0.769039,0.0640308,-0.190502,-0.125733,-0.362377,-0.040961,0.379786,0.0890608,0.189583,-0.521998,0.372396,-0.299027,0.610247,-0.0242975,-0.106599,-0.103184,-0.179373,0.393458,0.366964,-0.800482,-0.445433,-0.0418771,-0.0313905,-0.0363561,-0.00465606,0.738631,-0.2374,0.61152,-0.405803,-0.0730899,-0.310792,-0.0292989,0.321124,0.410458,0.576903,0.0192984,0.575963,-0.248676,0.421459,0.319245,0.231856,-0.446515,0.603639,-0.411839,-0.119256,0.0123808,-0.0921445,0.197454,-0.299606,-0.0927053,0.688008,-0.224717,0.127881,-0.0034401,-0.276596,0.29541,0.188621,-0.145112,0.934416,0.752532,0.462858,-0.196981,-0.246166,-0.651743,0.442885,-0.0225337,-0.240616,-0.64762,0.0141592,-0.234823,-0.137746,0.359036,0.311682,-0.643222,0.179652,-0.246147,-0.138626,-0.822605,-0.728059,-0.298317,0.002193,-0.475843,0.234341,-0.00327165,-0.110028,-0.155742,-0.429446,0.980391,0.167475,0.581141,-0.156148,-0.381534,-0.291843,0.161224,0.352794,0.692054,-0.896678,0.0930499,0.526096,-0.177006,-0.0153926,-0.358067,-0.402805,0.307355,-0.534465,0.242634,-0.650762,0.643506,0.286179,-0.726366,0.381904,0.215185,0.257546,0.3203,-0.287399,0.486968,0.286666,0.139568,0.590745,0.223536,-0.394981,0.288335,-0.0137518,-0.913952,0.246538,-0.111396,-0.166252,-0.196693,-0.282878,-0.375426,0.0982026,-0.681952,0.36498,0.185488,-0.226306,-0.0944918,-0.546553,0.0768668,0.054106,-0.037805,0.147279,0.107415,-0.148355,-0.0973721,-0.422938,-0.096298,-0.0280729,-0.354175,0.0366252,-0.258312,-0.040952,-0.41139,-0.272208,0.0992537,-0.0540414,-0.430633,-0.0973335,0.333926,0.310125,-0.0294567,-0.115179,-0.608355,-0.349168,0.370889,-0.41841,-0.251619,-0.0256168,0.642749,0.0289994,-0.245736,0.22486,0.450673,0.0326257,-0.133275,0.185128,-0.611306,-0.526775,-0.211583,-0.217152,-0.409492,-0.0245244,0.132457,0.119995,0.363946,0.346403,-1.26728 +3388.58,0.807199,0.0912059,4,1.58907,0.962769,-0.715934,0.247479,0.792664,0.0403945,-0.0958855,-0.140662,0.113862,0.0781532,0.0833917,-0.111605,-0.308461,0.0328622,-0.422866,0.227679,0.297444,0.250909,0.432926,-0.116154,-0.112844,-1.21348,-0.295584,-0.221235,0.0988406,0.24064,0.35893,0.368573,-0.144997,-0.40332,1.00997,0.147945,-0.0777745,0.728097,-0.321345,-0.230684,-0.134291,0.318546,0.400179,-0.0416155,1.07706,0.331403,0.233019,-0.535474,-0.0793034,0.306559,-0.390871,-0.178183,0.386029,-0.716717,-0.0711543,-0.135868,-0.180292,-0.343021,0.672375,0.0787424,-0.125064,-0.586307,0.198715,-0.207091,0.275999,0.785508,-0.636843,-0.716688,-0.311134,0.194495,0.361796,-0.168039,-0.0219721,-0.561453,-0.124635,0.81433,0.575249,0.429851,0.764889,0.0716897,-0.217558,-0.157069,-0.76141,-0.442866,-0.32225,0.118006,0.41113,-0.686607,-0.35219,-0.425913,0.370846,-0.0473807,0.500957,-0.259246,0.2411,-0.0815639,-0.141064,0.170904,-0.0294205,-0.429359,-0.410384,-0.710528,0.385844,0.0250641,-0.194069,-0.529709,0.405922,-0.29789,0.285511,-0.508547,0.235708,-0.296701,0.565394,0.712777,0.286645,0.699173,0.0911501,0.33657,0.264985,0.285517,-0.229384,0.140721,-0.196631,0.166063,-0.848243,0.291249,0.100011,0.194067,-0.169893,0.563112,0.957761,0.198666,-0.179996,-0.747142,0.0335659,0.236843,-0.114858,0.825528,-0.00080523,-0.320987,-0.0267302,0.0188097,0.44973,-0.651581,0.184142,-0.144413,0.0934035,-0.366782,0.0309832,0.164439,0.728694,0.676694,-0.320938,-0.782752,-0.953049,-0.354626,0.32097,-0.646859,0.332127,-0.00892654,0.34121,-0.245496,-0.303992,-0.572353,-0.0719235,0.192368,0.547598,-0.38349,-0.991844,0.0889891,-0.283377,0.162726,-0.549617,0.163483,0.22388,-0.0532804,0.0829886,0.310312,0.0125575,-0.87905,0.282689,0.389819,-0.177593,0.590918,0.0371961,-0.04989,-0.696525,-0.104008,-0.0799394,-0.386839,-0.0833761,-0.550793,0.133742,-0.469237,0.250756,0.221586,0.36714,-0.739366,0.0403138,0.0622872,0.276349,0.0546137,-0.749869,-0.505577,0.00364703,0.0668158,0.363943,0.171504,0.12452,-0.145618,-0.519123,0.518916,-0.221357,0.624509,-0.293445,-0.347762,0.42547,-0.103778,-0.446181,0.250794,-0.603926,-0.0285231,0.566049,0.516252,-0.320941,-0.403001,-0.523911,-0.323692,-0.250878,0.211487,0.116874,-0.764039,0.151607,0.5857,-0.319965,0.105389,-0.574778,-0.313172,0.47965,0.704497,-0.134796,0.247451,0.527734,-0.364755,-0.413808,0.278846,0.0421242,-0.146298,0.459279,-0.232332,0.536727,0.0763709,-0.319795,-0.799895,0.285142,-0.976967,0.150457,-0.0543158,-0.794349,-0.130183,0.0188352,0.227173,-0.168363,0.0457027,0.0620909,0.139922,0.370559,0.149509,0.314317,0.500498,-0.358781,-0.316326,-0.346625,0.191552,-0.123191,-0.347185,-0.0109011,0.0766855,-0.0421963,-0.349963,0.120384,0.207742,0.404849,-0.465335,-0.591449,-0.626,-0.430633,0.0901367,0.143138,-0.194639,-0.154908,0.207165,-0.177401,-0.0452755,-0.0896784,-0.129643,-0.309982,0.215475,0.292662,-0.174841,0.124646,0.210206,-0.663654,-0.0164927,-0.066501,0.14832,0.166426,0.385123,0.407953,-2.61317 +3408.94,0.953825,0.0912059,4,1.5709,0.952084,-0.628252,0.255533,0.780432,-0.0970314,-0.166506,-0.338892,0.0396419,0.188402,0.143636,-0.191473,-0.268111,0.0937272,-0.437558,0.438684,0.285305,0.433366,-0.171502,-0.0444808,-0.289944,-0.723612,-0.271275,0.187211,-0.129796,0.293989,-0.492529,0.752876,-0.509754,-0.116474,0.849685,-0.404362,0.434028,0.329768,-0.159069,-0.296975,-0.0502246,0.523354,0.548651,-0.0503531,1.08792,0.172366,-0.0995672,-0.335589,-0.0700841,0.326456,-0.276194,-0.0788235,0.225192,-0.672647,0.0855676,0.0594318,-0.288142,-0.260618,0.64648,-0.0465029,-0.368998,-0.677805,0.199147,-0.244127,0.160919,0.636584,0.132967,-0.893318,-0.160897,0.261264,-0.0446131,0.410649,-0.0328112,-0.505287,-0.541123,0.506451,0.739424,0.559171,1.03428,0.275628,0.16583,-0.502329,-0.267331,-0.23889,0.120927,0.0254865,0.324008,-0.178815,0.0451894,-0.589538,0.678971,-0.222922,0.71956,-0.33522,0.53037,0.444899,-0.527737,-0.18106,0.298314,-0.259434,-0.495235,-0.609776,0.574371,0.0983263,0.25389,-0.350477,-0.223333,-0.393052,0.339514,-0.441562,0.667425,-0.284717,0.819876,0.605332,0.437302,0.309852,0.436944,0.319752,0.411395,0.348203,-0.046933,0.111214,0.330212,-0.0451615,-1.18487,-0.0290344,-0.0523006,0.697204,-0.192691,0.402639,0.958651,-0.0202255,0.106359,-0.742169,0.500832,-0.0879828,-0.0218686,0.84741,-0.374559,-0.642434,-0.0479144,0.000481098,0.190768,-1.03025,-0.30989,-0.0893371,0.277194,-0.584283,0.0413099,0.29733,0.402833,0.80642,0.0528323,-0.563986,-0.760296,-0.482583,0.419346,-0.498487,0.256426,0.0961978,0.182943,0.0357592,-0.235148,-0.179096,-0.187394,0.182063,0.412069,-0.586758,-0.676333,0.0384447,-0.191265,0.280302,-0.783911,-0.0555132,0.471079,-0.0441193,0.0270956,0.135508,0.0858259,-0.706205,-0.282407,0.331512,-0.0709635,0.601746,0.0685155,0.486818,-0.403804,-0.234299,0.21811,-0.329153,0.184915,-0.378746,0.253395,-0.0262684,0.245111,-0.0103426,0.695823,-0.831825,-0.0398994,-0.244119,0.252772,0.120035,-0.666209,-0.437395,0.031427,-0.268991,0.240959,0.180853,0.285208,0.0774838,-0.57426,0.68421,-0.131715,0.46185,0.0152235,-0.0448992,-0.0396398,-0.0101344,-0.109833,0.185436,-0.748992,0.141308,0.157529,0.289289,-0.354418,-0.425919,-0.281197,0.24357,-0.0115189,0.246623,-0.0234837,-0.401596,0.154887,0.391772,-0.258742,0.0125407,-0.346739,-0.083392,0.107468,0.741964,0.20286,0.120742,0.550479,-0.513257,-0.852515,-0.0326418,0.188198,-0.0447011,0.374387,-0.412415,0.626037,-0.0485211,-0.560585,-0.737387,0.0352371,-0.773127,-0.300121,-0.424804,-0.271784,0.104854,-0.0747219,-0.130405,-0.341295,0.211537,-0.296963,0.502855,0.18415,-0.25556,0.223542,0.467288,-0.268953,0.369165,-0.716419,-0.000572649,0.181668,-0.048876,0.554516,-0.0131716,-0.273311,-0.158533,-0.108367,0.245233,0.69141,-0.411889,-0.312029,-0.296154,-0.158608,0.407325,0.212044,0.145198,-0.263977,0.575755,0.356469,-0.0211782,-0.0400871,-0.0892204,0.0384722,-0.231362,-8.34308e-05,-0.254971,0.107997,-0.276539,-0.43584,0.298286,-0.14029,0.176725,0.143892,0.420387,0.379331,-2.59119 +3387.92,0.969493,0.0912059,4,1.53612,0.996847,-0.895508,0.400355,0.658767,-0.119478,0.142686,0.223211,-0.364697,0.553483,0.047977,0.216932,-0.194184,0.249704,-0.214778,0.838432,0.322739,-0.0803055,0.34641,-0.177266,0.00988084,-0.53462,-0.650065,0.125707,-0.229729,-0.038239,0.0630251,0.184123,-0.698734,-0.23481,0.652593,-0.374652,-0.20852,0.294916,-0.608085,-0.0432153,-0.486754,0.965965,0.731935,-0.494632,0.892339,0.532451,0.363926,-0.65334,0.212647,-0.144647,-0.651237,-0.126174,0.163124,-0.461835,-0.0973792,-0.0891825,-0.464673,-0.638617,0.229637,-0.263051,-0.508754,-1.07753,-0.0177687,-0.807453,-0.0840012,0.889148,-0.507292,-0.676835,-0.124635,0.170748,0.00241741,0.128949,-0.646,-0.784407,-0.497691,0.328343,0.474451,0.0657267,0.723598,0.0970186,-0.0323472,0.0653982,-0.238493,-0.401808,0.0734336,-0.0599079,0.154277,-0.172147,0.187973,0.33996,0.10114,0.450444,0.376104,-0.0907103,-0.340637,-0.0534945,0.497436,-0.00547091,-0.0281777,-0.538143,0.0437921,-0.0106249,0.666329,-0.105193,0.231083,-0.431335,-0.248367,-0.251187,0.220675,-0.48467,0.383091,0.0186013,1.08628,0.551213,0.713824,0.497782,0.442451,0.522539,-0.305691,-0.326855,0.316942,0.640317,-0.177834,0.0220728,-0.418621,-0.553472,0.245504,-0.59953,0.377934,0.537832,1.69731,0.546251,0.638918,-0.077826,0.125254,0.374776,0.787461,0.475267,-0.542894,0.0803333,-0.404609,-0.367215,0.0723278,-1.27394,-0.455437,0.2558,-0.045852,-0.575385,-0.305928,0.170353,0.374083,0.761989,-0.571167,0.247674,-0.0732839,0.349817,0.425198,0.0916169,0.325278,0.200806,0.220214,-0.299124,-0.0227738,-0.34325,0.596562,-0.878624,0.506771,-0.864745,-0.61793,0.480943,0.150438,0.267752,-0.107958,0.0591604,0.522968,0.0965634,-0.0572841,0.375957,0.312716,-0.0923647,-0.227488,-0.0177834,0.0644812,0.617932,0.053173,0.417794,-0.244197,0.0695146,0.470852,-0.219315,-0.71048,-0.858439,0.33835,0.0350113,-0.137861,0.254274,0.0111432,-0.449665,-0.048121,0.284354,0.162172,-0.37034,-0.370718,-0.356055,-0.177569,-0.306407,-0.230063,-0.00880101,0.344795,0.0354838,-0.0121314,1.05667,-0.0415376,0.224742,-0.0981477,-0.131833,0.136353,0.630057,-0.565193,0.00788495,-0.0876063,-0.296994,0.307835,-0.573545,-0.21083,-0.651575,0.696102,0.306582,-0.836591,0.228988,0.0331229,-0.288733,-0.281616,0.223891,-0.368676,0.165579,-0.871195,0.283232,-0.0250409,0.737792,0.191603,-0.10419,0.606935,-0.576626,-0.495902,0.198851,0.0352982,0.502283,0.237636,0.212375,0.0813164,0.441024,-0.0226348,-0.677827,0.142556,-0.374371,0.335027,-0.564076,-0.122025,0.457557,-0.454732,0.264664,-0.742253,0.0103311,0.725497,0.422634,-0.39001,-0.0588783,0.687096,0.503593,0.351484,0.0191847,-0.429831,0.423262,-0.531241,-0.246288,-0.229758,-0.263657,0.198374,0.127484,-0.180991,-0.213743,1.08201,0.366665,-0.653637,0.284256,0.517201,0.149283,0.0696478,0.678297,-0.249626,0.202688,0.424751,-0.171556,0.219384,0.0852239,0.607231,0.246005,0.199221,-0.349551,0.509683,0.149983,-0.589697,-0.28106,0.348353,0.16103,0.209496,0.401285,0.457707,-2.29253 +3395.84,0.7527,0.0912059,4,1.61984,1.02265,-0.995095,0.388687,0.737811,-0.138972,0.255308,-0.0635883,0.62132,-0.118505,0.374216,-0.396408,0.0471869,0.187809,-0.766146,0.546166,-0.12997,0.376799,-0.36328,-0.281258,-0.284168,-0.597743,-0.0597798,-0.151418,-0.398396,0.276493,0.662845,-0.0469178,-0.735586,-0.232124,0.372094,-0.240637,0.642678,-0.0835222,-0.2697,-0.508474,-0.132149,0.571064,0.443146,-0.524302,1.04088,0.220951,0.10691,-0.630946,-0.111604,0.3638,-0.49882,0.0635986,0.0681735,-0.386444,-0.445907,1.17527,-0.140968,0.286444,0.0449322,-0.481773,-0.429919,-0.774113,0.160185,-0.306985,0.548752,0.714262,-0.265521,-1.35457,0.295624,-0.321272,-0.161474,0.559151,0.504318,-0.381296,-0.625224,0.446353,0.611525,-0.120594,0.80341,0.218852,0.356353,0.0984491,0.0188803,0.0578111,0.603618,0.0372625,0.216181,0.0984407,0.320199,-0.553297,-0.0108306,-0.213728,0.360816,-0.148064,-0.350288,0.220233,0.109733,-0.135137,0.493615,-0.374155,-0.47236,0.108731,0.3843,0.246279,0.0630242,0.440886,-0.538907,-0.291509,-0.0174954,-0.372225,0.630662,-0.173505,0.590297,0.829218,-0.227906,0.183542,0.795324,0.579672,-0.472364,-0.210795,-0.330654,0.176448,0.0286293,0.315579,-0.368732,-1.18605,0.000461294,-0.964252,-0.0672042,0.205309,0.247239,0.604304,-0.281085,-0.620302,-0.262419,-0.130589,0.485151,0.69678,-0.357761,-0.145727,-0.214038,0.124353,0.3345,-1.08409,-1.33619,0.00223703,-0.128902,-0.544737,-0.27154,-0.255606,0.0887384,0.786572,0.144441,-0.265012,0.361199,0.250837,0.0123695,-0.352882,0.281664,0.574744,-0.0541505,0.0358667,-0.603083,-0.00330651,-0.0602386,-0.0731721,0.401106,-0.59912,-0.145211,0.401257,-0.0168279,0.56271,0.199775,-0.208815,-0.105552,-0.231695,0.355207,0.0738746,0.323747,0.342507,-0.321901,-0.148277,-0.080071,0.666416,0.547904,0.0575967,0.141018,-0.478112,0.171214,-0.58116,-0.325726,-0.0858484,-0.16258,-0.278584,0.101925,-0.0134187,0.353315,-0.661192,-0.601546,0.362394,0.241267,-0.587305,-0.600791,-0.366367,-0.0506712,0.268237,0.248157,-0.624395,0.133381,0.231101,-0.455343,1.12174,0.139265,0.560217,0.0547241,0.0907289,-0.118437,-0.182819,-0.501224,-0.156133,-0.163005,0.288433,0.0418153,-0.596897,0.00276216,-0.834633,-0.717882,0.000745395,-0.2824,0.331177,-0.514387,0.270914,0.122332,0.208835,-0.839696,0.247595,0.161923,-0.702861,0.119537,0.494338,-0.12735,-0.299501,0.279429,-0.793706,-0.173028,0.197004,-0.0425362,-0.415518,1.14392,0.412553,-0.0302551,0.285613,-0.535951,0.0239028,0.237454,-0.389313,0.541373,-0.207175,-0.118366,0.1489,-0.170571,-0.293849,-0.299837,-0.0641266,0.19235,0.236097,0.0015847,0.374977,0.741813,0.325475,0.277586,-0.400159,0.0450762,-0.00312012,0.0458985,-0.16669,0.0799391,-0.166404,-0.618982,0.544834,-0.220798,0.850314,0.328171,-0.00113263,-0.3843,0.295646,0.0164532,-0.384418,-0.351974,0.295107,-0.238845,0.279187,0.47332,0.222129,0.231947,0.448283,0.256387,0.130468,-0.219143,-0.0181585,-0.273238,0.355045,-0.0771778,-0.982075,0.262614,0.189614,0.208472,0.435447,0.456587,-2.44857 +3396.41,0.912774,0.0912059,4,1.59521,1.04734,-0.926853,0.365271,0.8643,-0.109298,0.0986834,0.0872208,0.545,-0.197292,0.376092,-0.334474,-0.089222,0.0845803,-0.834356,0.576203,-0.204876,0.149962,-0.422782,-0.402103,-0.279781,-0.450928,-0.211051,-0.125216,-0.468277,0.22151,0.639702,0.136559,-0.780397,-0.415791,0.407392,0.0395473,0.650106,0.0134436,-0.285584,-0.533107,-0.208098,0.499414,0.463535,-0.429678,1.17043,0.113001,-0.130296,-0.714026,-0.0852338,0.569894,-0.311446,-0.00413919,0.231644,-0.286536,-0.209787,0.645025,-0.140005,0.215552,0.0443993,-0.714395,-0.683118,-0.796641,0.178473,-0.465725,0.268422,0.786065,-0.500322,-1.31376,0.182603,-0.259004,-0.075485,0.557752,0.57831,-0.316911,-0.721632,0.592391,0.553376,0.104576,0.983544,0.224755,0.0765803,-0.0165014,0.0145846,0.0321158,0.290698,0.114825,0.27813,-0.198991,0.361335,-0.780422,0.128328,-0.0033962,0.290189,-0.120625,-0.132765,0.194508,0.292605,0.0179233,0.362834,-0.326595,-0.428327,-0.0958072,0.438726,0.106039,0.186918,0.451068,-0.468536,-0.293291,0.176652,-0.243148,0.962038,-0.130505,0.638702,0.957598,-0.141289,0.200005,0.5704,0.702215,-0.25416,-0.476436,-0.642364,0.171812,0.228865,0.253591,-0.451691,-1.22172,-0.214331,-1.06227,-0.164056,0.0648331,0.129804,0.519137,-0.139026,-0.5063,-0.0406088,-0.16544,0.232844,0.568514,-0.171862,-0.115305,-0.221818,-0.0945644,0.478432,-1.09499,-1.36273,0.0772232,-0.180665,-0.564868,0.0285413,-0.0398365,-0.334793,0.639753,0.278794,-0.306757,0.525604,0.19997,0.34007,-0.243345,0.435415,0.422898,0.11444,-0.0979791,-0.568278,-0.177698,-0.079379,0.110457,0.541399,-0.42589,0.170108,0.177916,0.0873951,0.279334,0.0500809,-0.036267,0.00917642,-0.175967,0.257057,0.0102182,0.542692,0.113347,-0.137688,-0.00433277,-0.315994,0.786945,0.593675,-0.174386,0.457069,-0.487395,0.0232786,-0.496336,-0.60072,-0.383038,-0.203318,-0.240529,-0.0643438,0.0656364,0.566158,-0.737343,-0.445854,0.281166,0.173555,-0.474017,-0.546102,-0.106406,-0.0288959,0.260764,0.292446,-0.491353,0.0907173,0.389638,-0.258361,1.13206,0.185224,0.611893,0.0815069,-0.107483,0.0261089,-0.113475,-0.512637,-0.113643,-0.441937,0.176044,-0.112166,-0.453817,0.173048,-1.01151,-0.392801,-0.0410603,-0.466162,0.501032,-0.468373,0.308605,-0.166716,0.118499,-0.849732,0.218846,0.142799,-0.714069,0.0289382,0.610566,-0.249096,-0.380551,0.134106,-0.631589,-0.16905,0.174923,0.0260275,-0.35963,1.14598,0.344534,-0.066756,0.250557,-0.385764,0.0584721,0.224237,-0.339827,0.485707,-0.0711016,-0.19605,0.315893,-0.270811,-0.0126593,-0.234103,0.0391848,0.320375,0.190045,-0.316969,0.340431,0.956489,0.154377,0.260725,-0.660836,-0.00937599,-0.0124045,-0.0782341,-0.194308,0.0232105,-0.317403,-0.682125,0.524059,-0.303829,1.0985,0.244033,0.0610433,-0.380699,0.220426,0.181043,-0.167843,-0.364247,0.140766,-0.264715,0.0256394,0.174976,0.209645,0.176276,0.130829,0.120851,-0.0340707,-0.14328,-0.0332506,-0.267619,0.330779,-0.0366681,-0.624884,0.442615,0.178377,0.183991,0.422347,0.428942,-2.95782 +3416.22,0.964087,0.0912059,4,1.52307,1.0057,-0.829419,0.42268,1.03954,-0.133715,0.0771866,-0.0966822,0.161384,-0.12671,-0.103166,0.178759,0.00523669,0.126469,0.180298,0.689524,0.224142,0.354353,0.607406,-0.462826,-0.150854,-0.703419,-0.872897,-0.0986889,-0.00226587,-0.521036,-0.117042,0.809244,-0.335052,0.568036,0.470681,-0.72425,-0.31073,0.244778,-0.430157,-0.461768,-0.192144,0.637389,0.435308,-0.28406,0.676026,0.156507,0.389443,-1.12956,-0.24224,-0.355359,-0.970728,-0.262179,-0.0991615,0.360906,-0.464356,0.623472,-0.29402,-0.408778,0.37293,-0.0227218,-0.192627,-1.06201,0.152504,-1.12594,0.126551,0.624612,-0.920263,-0.23725,-0.310644,0.512251,0.19646,-0.192758,0.0141772,-0.66471,0.437351,-0.0552505,0.666571,-0.555551,0.524342,0.451135,0.00299261,0.217589,-0.111865,0.253028,0.0190048,-0.449957,0.230642,-0.397084,-0.0155536,0.00119311,-0.260608,0.0120645,-0.283206,0.0399241,0.185966,0.0792107,0.207653,-0.0129398,0.089261,-0.0566255,0.217547,-0.316074,0.26007,-0.0897042,0.497555,0.309802,-0.0370399,-0.103121,0.582267,0.0264618,-0.381277,-0.332594,-0.00933872,0.0758349,-0.192222,0.0341899,-0.610885,0.238813,0.231781,0.579085,-0.0835195,0.294669,0.719832,-0.033328,-0.219237,0.34488,0.217125,0.53889,0.0256058,0.237581,0.159712,0.290923,0.234763,-0.194336,0.00460807,-0.0446833,0.0532901,0.359874,-0.303977,-0.34983,-0.106887,-0.0657702,0.456953,-0.127825,0.231605,0.047881,0.3384,0.111764,0.131182,0.276004,0.529089,0.239234,0.126708,-0.342614,-0.590164,0.45177,0.196817,0.26974,-0.0049496,0.45633,0.559202,0.0378381,0.371505,0.156009,0.771568,0.0138143,0.776965,-0.411945,0.0839431,0.136254,-0.172258,-0.404148,-0.346459,0.150287,0.396875,0.112285,-0.109849,-0.169452,0.131677,0.28011,-0.00181481,-0.151035,0.429212,0.744063,0.329781,-0.592517,0.448256,0.302381,-0.0148944,-0.319025,0.260307,-0.25045,0.174098,-0.320307,0.244416,-0.138906,0.0819361,-0.429264,-0.0615783,0.0528483,0.441344,-0.568967,-1.19599,0.116744,0.105949,-0.19872,-0.188869,-0.198362,0.338463,0.178078,0.0285716,1.33114,-0.209846,-0.337843,0.174864,0.142053,0.140535,-0.00508647,0.158001,0.840872,0.097506,-0.1205,0.44313,0.0476878,-0.182458,-0.453707,-0.00255229,-0.0990515,-0.747289,0.156214,-0.921399,-0.331708,-0.409101,0.18611,0.118696,0.0994944,0.117824,0.260939,-0.355616,0.527177,0.377741,0.120889,0.891372,0.0876831,-0.11542,-0.0928489,0.162642,0.739986,-0.209692,0.565767,1.0335,-0.0972431,-0.131675,-0.629375,-0.0381828,-0.0787493,0.195641,-0.53687,-0.364419,0.572545,-0.0158402,0.168442,0.125307,0.261526,-0.243205,0.885617,0.212003,0.0524338,-0.25036,-0.197388,0.188588,-0.0632524,-0.200031,0.442533,-0.293771,0.361397,0.135857,-0.0198617,0.625183,-0.260166,0.208487,-0.169992,0.399379,0.137355,0.386654,-0.225494,-0.194878,0.476453,0.342695,0.187397,0.329494,0.241565,0.117933,-0.365828,0.0752304,0.12218,0.137807,0.0436484,-0.0927954,-0.257248,-0.314495,-0.129841,-0.067431,0.162532,-0.721277,0.131402,0.224223,0.362494,0.473522,-3.63764 +3427.01,0.993493,0.0912059,4,1.59183,0.924741,-0.662627,0.231175,0.811516,-0.10879,-0.0236576,0.168806,0.241522,0.144498,0.0439625,-0.404201,-0.366315,0.299131,-0.231799,0.65259,-0.0882622,0.0351641,-0.607349,-0.186837,-0.102184,-0.851286,-0.330797,-0.304578,-0.350115,0.294949,0.397497,0.119238,-0.234079,-0.0558357,1.08302,-0.178039,0.664682,0.364082,0.0487551,-0.270533,-0.0649577,-0.0134934,0.0938397,-0.403063,1.12265,0.401286,-0.446255,-0.65226,0.111064,0.578281,-0.0558263,0.555063,0.0375238,0.0352729,-0.22184,-0.20327,0.00448893,-0.204642,0.692668,-0.787786,-0.247833,-0.74293,0.57217,-0.54639,0.29778,1.10403,-0.560952,-1.44737,0.129689,-0.221973,-0.273762,0.501211,0.229051,-0.0435405,-0.482726,0.730876,0.411724,0.0295129,0.181455,0.407516,0.132492,-0.320769,0.025205,-0.0490892,0.594562,-0.558992,0.587758,-0.0477309,0.0381938,-0.201683,0.310526,-0.2396,0.334452,-0.490776,-0.387777,0.100892,0.119855,0.0512218,0.149921,-0.514965,0.120485,0.250155,0.215723,0.44461,0.00127834,0.0645273,-0.497353,-0.257633,-0.154388,-0.397138,0.124131,0.0890754,0.290432,1.05109,-0.023195,-0.0458328,0.754081,0.523575,-0.0209556,-0.230596,-0.115601,0.0393267,-0.185153,0.160081,-1.02764,-0.0518468,-0.583867,-0.512582,-0.250349,0.132346,0.61479,0.321678,0.268213,-0.595731,-0.0396361,0.0106171,-0.291066,0.254157,0.0252538,-0.0400979,-0.110531,0.179505,0.426214,-0.656132,-0.568183,0.415364,-0.196683,-0.368239,-0.410805,-0.0645887,-0.618446,0.292668,-0.186442,0.175817,0.404356,0.0468938,0.180536,-0.407929,0.10449,0.608597,0.339697,0.0274958,-0.337418,0.0643861,-0.348457,0.162073,0.743851,0.252287,0.297667,0.0869875,0.0776489,-0.154962,0.307518,-0.148755,0.229164,-0.36128,0.0064213,0.0158033,-0.468767,-0.0771085,-0.238355,0.295053,-0.44399,0.492929,0.13631,0.361108,0.226649,-0.220948,0.0446033,-0.338773,-0.647022,-0.0130018,0.176815,-0.149767,-0.18383,-0.157961,-0.338809,-0.458327,-0.24597,0.220918,0.100695,0.066699,-0.273046,-0.0592183,0.303128,-0.254388,0.331617,-0.061531,-0.347845,-0.245062,-0.676655,0.579144,0.11368,0.556701,-0.0169469,-0.638096,0.186263,0.326141,-0.399576,0.478041,-0.222983,0.206514,0.260934,-0.329058,-0.122289,0.032537,0.117402,0.230689,0.0654254,0.672231,0.160344,0.173607,0.504866,0.0134776,-0.484123,-0.0100533,-0.168472,-0.333467,-0.0124525,0.513028,-0.0493205,0.0524189,-0.0423504,-0.123821,-0.513778,-0.00835897,-0.277134,-1.00651,0.736799,-0.32913,-0.267457,0.24472,-0.191462,0.0108338,-0.379374,-0.904094,0.515019,-0.216143,0.123487,0.289203,-0.224123,-0.178687,0.14041,0.33075,0.132894,0.0288062,-0.24913,0.129179,0.516763,0.408794,-0.0700499,-0.224852,-0.151686,-0.129517,-0.0462395,-0.426921,-0.356964,0.356582,-0.290901,0.422052,-0.278469,0.314641,0.335433,0.166363,-0.538837,0.0318171,-0.563504,-0.48993,-0.168391,-0.231774,-0.329706,0.218967,0.261933,0.276086,-0.0130073,0.38332,0.299851,0.275099,0.155798,-0.0163586,0.242007,0.0974236,-0.0379005,-0.467251,0.688008,0.119022,0.26778,0.344996,0.517475,-2.58101 +3442.82,0.718309,0.0912059,4,1.63834,0.847781,-0.985975,0.387417,0.736923,-0.0845542,-0.0555772,0.627719,0.215583,-0.287279,0.213445,-0.563461,-0.349187,0.188118,-0.20848,0.641752,0.0124634,0.0947101,-0.394134,-0.155031,-0.486467,-1.13649,-0.376042,-0.162972,-0.221831,0.0475458,0.566654,0.0583634,-0.254303,0.159799,0.794293,-0.00509224,0.451972,0.279409,-0.294825,-0.27129,-0.0538437,0.295391,0.135788,-0.332365,0.805986,0.207809,-0.252308,-0.533194,0.0960692,0.490675,-0.467372,0.234883,0.191002,0.056689,-0.351065,0.142647,0.0839579,-0.396598,0.655312,-0.515179,-0.284345,-0.940381,0.190227,-0.777326,0.28617,1.12936,-0.334913,-1.63714,0.201549,-0.0565699,-0.233216,0.268474,0.231243,-0.337106,-0.108231,0.640213,0.51181,-0.138228,0.15435,0.238768,0.363996,0.0787256,-0.086753,0.0351051,0.537659,-0.465046,0.3749,-0.203276,0.195212,-0.177024,0.601259,0.118894,0.11652,-0.452595,-0.269985,-0.0725268,-0.0249511,-0.0274751,0.245332,-0.365638,-0.26481,-0.0196816,0.461101,0.1594,0.0863277,0.114081,-0.204556,-0.207071,-0.0555122,-0.283536,0.0686486,-0.0645945,0.132552,1.23038,-0.0204272,-0.274568,0.431858,0.345313,0.12887,-0.00679368,0.259761,0.309271,0.0821617,0.223991,-0.632133,0.0115825,-0.500993,-0.43686,-0.364941,0.0108393,0.161195,0.125572,0.0562081,-0.347978,-0.403012,0.0196867,-0.159108,0.320314,0.0573325,-0.347637,-0.191643,-0.0864,0.514122,-0.299788,-0.645598,0.371768,-0.162324,-0.285556,-0.160392,0.271659,-0.901533,0.638855,-0.454615,0.117178,0.364304,-0.0115676,0.0663798,-0.0844031,0.294976,0.681741,0.521841,-0.0269803,-0.075706,-0.0569806,-0.202807,0.243108,0.873175,-0.0738861,0.670417,-0.198886,0.206093,-0.242801,0.285366,-0.215776,0.0261249,-0.679016,0.0797725,0.0679937,-0.204413,0.00706459,0.0552227,0.422452,-0.245905,0.677738,-0.0818538,0.669487,-0.103843,0.0258244,-0.143881,-0.609422,-0.69434,-0.029218,0.785261,-0.544621,-0.192008,-0.186992,-0.249536,-0.620794,0.182805,0.0388076,-0.0708112,0.193718,-0.488421,-0.161542,0.440563,0.00534041,0.44242,-0.474856,-0.144655,-0.371194,-0.71467,0.706006,-0.222851,0.695847,0.222299,-0.546124,-0.0716815,-0.105345,-0.577665,0.240118,-0.322826,0.0136435,0.239114,-0.0586783,-0.270533,-0.031299,0.355517,0.264946,-0.35767,0.365664,0.0188772,0.0530137,0.478554,0.117843,-0.727621,0.109086,-0.312324,-0.345631,-0.219542,0.69192,-0.0739843,-0.162644,0.113376,-0.0769831,-0.240381,0.214042,-0.241691,-0.64498,0.666168,-0.25373,0.0160159,0.10443,-0.0108315,-0.247161,0.050811,-0.866476,0.418093,-0.326057,0.00671475,0.303901,-0.182821,-0.0139503,0.0829896,0.459468,0.742597,-0.237782,-0.500566,0.310891,0.119571,0.00810756,-0.0992323,-0.386488,-0.0431075,-0.0896098,-0.33989,-0.52701,-0.24726,0.257685,-0.246419,0.267652,-0.00490152,0.226291,0.172582,0.117233,-0.775246,0.082825,-0.592655,0.0864618,-0.0662397,-0.157642,-0.0246102,0.282735,-0.233005,0.00464736,0.0555384,0.193283,0.435879,0.199318,-0.230236,0.142127,-0.0394566,0.264162,0.095603,-0.520611,0.171596,0.117742,0.286624,0.343136,0.535372,-2.13515 +3426.33,0.756089,0.0912059,4,1.6416,0.975225,-0.881714,0.394265,0.727481,-0.0448547,0.353411,0.637065,0.246798,-0.0286152,0.131497,-0.31256,-0.449185,0.364735,-0.400888,0.855299,-0.0757096,-0.196134,-0.20096,0.0581931,-0.449316,-0.994135,-0.817956,-0.213731,-0.238108,-0.128473,0.436259,-0.156558,-0.315728,-0.00695872,0.75923,-0.15469,0.392073,0.133625,-0.0284271,-0.205464,-0.303733,0.410473,-0.136545,-0.632193,0.885281,0.378832,0.409039,-0.594854,-0.0597699,0.592856,-0.503328,0.584758,0.0415851,0.144042,-0.563197,0.148099,-0.152399,-0.278347,0.316624,-0.32965,-0.240815,-1.27348,0.318617,-0.940541,0.21507,0.996674,-0.475211,-1.22253,-0.31869,-0.245101,-0.472194,0.499406,-0.254754,-0.455724,-0.417341,0.553091,0.31065,-0.144445,0.682012,0.507114,0.500034,-0.175669,-0.185885,0.420194,0.0345788,0.00293602,0.0979189,-0.310524,0.259899,-0.310829,0.26188,0.107898,0.12389,-0.581225,-0.340541,0.0116596,0.00988806,-0.384221,0.0402492,-0.398866,-0.0610804,-0.341079,0.272615,0.447763,0.0736678,0.500055,-0.170274,0.208862,0.0844459,-0.313451,0.542949,-0.25214,0.128135,1.25413,0.482362,-0.497106,0.024352,0.414619,0.2686,-0.100305,-0.168315,-0.0358546,-0.0215296,-0.0931924,-0.777436,-0.210009,-0.26515,-0.348065,-0.00553556,-0.0499147,-0.272134,0.492025,-0.0195731,-0.466407,0.0352039,0.0423021,-0.207839,0.798752,0.106197,-0.379429,-0.328499,-0.0878723,0.485622,0.0731683,-0.799742,0.218404,-0.225282,-0.226915,-0.479753,-0.0882157,-0.353325,0.598647,-0.370802,0.394991,0.352963,0.10467,-0.232405,-0.61212,0.0251642,0.821176,0.274938,-0.379888,-0.00314092,0.30035,0.20596,0.028708,0.832909,0.0672479,0.250273,0.207566,0.334369,-0.092939,0.15894,0.185657,-0.0136767,-0.439612,-0.0546716,-0.300175,-0.119297,-0.506591,0.299878,0.105052,-0.20909,0.710997,-0.0901175,0.419335,0.340266,-0.190665,-0.151279,-0.433228,-0.671235,-0.122116,0.573899,0.317477,-0.0522382,0.0472008,-0.0773106,-0.539778,0.135686,-0.0847555,-0.338008,0.0924504,-0.617521,0.123031,0.324346,-0.0844237,0.749281,-0.591883,0.0186509,-0.132058,-0.787188,0.989104,-0.416525,0.0508948,0.0256171,-0.190581,-0.00470025,-0.166832,-0.635121,0.380781,-0.187354,-0.165996,0.265066,-0.0786747,-0.549987,-0.361479,0.190701,0.0152061,-0.0975712,0.234349,0.0281567,-0.0879592,0.577993,0.276046,-0.541197,0.0473533,-0.309221,-0.172246,0.133625,0.381385,0.0361218,0.15471,0.0351136,-0.00676766,-0.196413,0.393185,-0.508959,-0.641054,0.341695,-0.176708,-0.14547,0.397966,-0.00784406,-0.35524,0.0280356,-0.624363,0.52248,0.0573276,0.252635,0.169495,0.116751,0.0616487,-0.10031,0.38868,0.425107,0.503908,-0.285234,0.442446,-0.05459,-0.118565,-0.0100967,-0.500174,0.253949,0.176258,-0.193334,-0.524989,-0.285061,0.58375,0.13797,-0.170228,0.047923,0.398911,0.138735,0.195053,-0.69551,0.0160959,-0.456824,0.133136,0.102166,-0.342954,-0.230589,-0.0707466,-0.0577296,-0.21625,-0.0805376,-0.519756,0.651636,0.367651,-0.392469,-0.138145,0.0919838,0.0568148,-0.195867,-0.0986326,0.372591,0.123099,0.171599,0.350854,0.414245,-2.39706 +3426.65,0.548748,0.0912059,4,1.62335,0.952533,-0.897156,0.371025,0.815488,-0.0336318,0.334281,0.61193,0.253613,0.0336835,0.132042,-0.319799,-0.471361,0.399821,-0.397908,0.885444,-0.0411423,-0.137936,-0.194886,0.0451826,-0.522601,-1.01104,-0.865557,-0.273316,-0.173088,-0.175647,0.467727,-0.0709567,-0.2384,0.0165055,0.754319,-0.063973,0.390675,0.0729254,-0.0826072,-0.201589,-0.297409,0.404677,-0.0791055,-0.600251,0.931005,0.364088,0.420337,-0.662095,-0.102719,0.550585,-0.510833,0.592332,0.0674963,0.0384343,-0.542664,0.174967,-0.160414,-0.253025,0.277097,-0.315588,-0.281777,-1.15044,0.391833,-0.967608,0.144758,1.03903,-0.494668,-1.2775,-0.243539,-0.246349,-0.448962,0.532951,-0.233126,-0.452457,-0.378853,0.501827,0.270216,-0.0885701,0.719907,0.530027,0.508518,-0.0833772,-0.207656,0.433271,0.0887863,-0.0466908,0.104562,-0.304793,0.306561,-0.352529,0.390268,0.116606,0.0727362,-0.632122,-0.36824,-0.0671674,0.0289266,-0.268207,-0.042287,-0.366401,-0.0364418,-0.275165,0.275956,0.429579,0.125609,0.5542,-0.264061,0.19618,0.048858,-0.305816,0.497553,-0.275388,0.0752514,1.25545,0.376245,-0.536929,-0.0166939,0.396471,0.225095,-0.0603364,-0.268246,-0.0205922,-0.0134316,-0.100002,-0.908652,-0.205085,-0.252369,-0.291879,0.0299723,-0.0706037,-0.339907,0.468358,-0.00732921,-0.42253,0.190615,0.0299533,-0.193649,0.846326,0.186373,-0.303235,-0.409423,-0.010839,0.489831,0.00318138,-0.691895,0.22814,-0.231562,-0.244734,-0.495959,-0.103019,-0.332942,0.566067,-0.267567,0.30421,0.453278,0.118729,-0.214116,-0.704323,0.0572837,0.90159,0.210068,-0.322077,-0.00235288,0.309878,0.226146,0.045293,0.79364,0.0374826,0.221892,0.146864,0.313078,-0.0777286,0.21337,0.099255,0.0171357,-0.380159,0.00811127,-0.251649,-0.0322636,-0.60828,0.266774,0.01934,-0.246608,0.660864,-0.120004,0.500686,0.226972,-0.261503,-0.125731,-0.410296,-0.661919,-0.148753,0.471085,0.278717,-0.0601992,0.0499174,-0.099153,-0.480552,0.18003,-0.0728233,-0.342945,0.143864,-0.540812,0.11403,0.286383,-0.00208629,0.694538,-0.594403,0.00807541,-0.217501,-0.80113,0.970198,-0.396636,0.0956618,-0.00277499,-0.15692,-0.0582041,-0.103547,-0.643206,0.38912,-0.170766,-0.123065,0.154686,0.020212,-0.54296,-0.312838,0.1143,0.0429074,-0.0446906,0.211575,0.00550605,-0.156487,0.503234,0.419739,-0.497024,-0.00447379,-0.275149,-0.0912509,0.15692,0.397578,0.0829429,0.153261,0.00525325,0.047888,-0.24462,0.379121,-0.563441,-0.664243,0.399382,-0.151939,-0.135803,0.454307,0.00294341,-0.35956,0.0719864,-0.587417,0.481476,0.111155,0.267227,0.219696,0.17225,0.0361715,0.00951738,0.353834,0.395511,0.480956,-0.286562,0.430324,-0.0200488,-0.162151,0.0225687,-0.483931,0.249742,0.178802,-0.233246,-0.525239,-0.332593,0.553905,0.281406,-0.116703,0.0171621,0.464874,0.173397,0.131595,-0.680325,0.0116911,-0.513478,0.0715671,0.193726,-0.274209,-0.26759,-0.0928319,-0.0233856,-0.217911,-0.00476996,-0.550795,0.620987,0.284508,-0.322272,-0.156884,0.148221,0.0413468,-0.227632,-0.142312,0.366762,0.126579,0.171126,0.355779,0.413674,-2.64001 +3406,0.948615,0.0912059,4,1.65091,1.09399,-0.567234,0.197459,0.567454,-0.209952,0.085141,-0.0386445,0.417222,0.0259446,0.308721,-0.281357,0.210925,0.076052,0.0977774,0.286964,0.0942666,-0.312043,0.0364151,-0.187289,-0.32986,-0.571031,-0.823115,-0.233438,-0.476291,-0.378402,0.0774134,0.604718,-0.437346,-0.264391,0.688441,-0.519311,-0.0871197,0.275699,-0.613245,-0.322733,-0.292992,0.573584,0.466784,-0.133351,0.650863,0.129819,-0.0832547,-0.589036,-0.0477957,-0.296873,-0.397814,-0.0549215,0.358383,0.132304,0.0769511,0.845801,0.543577,0.280239,0.32599,-0.00836263,-0.567076,-0.394953,0.125357,-0.276143,0.257492,0.781818,-0.675288,-1.23282,-0.226069,-0.357988,0.431272,-0.00718687,0.724419,-0.764969,-0.188113,-0.0243628,0.882788,-0.157255,0.555953,0.374142,0.588995,-0.0445929,-0.0200419,-0.0342317,0.393042,0.210524,0.344376,-0.0895489,0.212911,0.144317,-0.230762,0.156534,0.318707,-0.155693,0.473153,-0.591179,0.292025,0.389663,0.369697,0.0278473,-0.339211,-0.323588,0.176399,0.32056,-0.133878,0.158221,-0.206911,-0.784879,0.100685,-0.214138,-0.579106,-0.388329,-0.0675059,0.230247,-0.477928,-0.384829,-0.270734,0.579083,-0.157668,0.0791162,-0.820031,0.216744,0.161667,0.0918929,-0.116529,0.29776,-0.230719,-0.11144,0.244086,-0.16866,0.17728,0.613567,-0.0693074,0.264984,-0.222609,-0.131543,-0.172819,0.679622,-0.331877,-0.198023,0.550886,0.0771174,0.312189,-0.332008,-0.320678,-0.241615,0.852853,-0.286302,-0.285323,0.259232,-0.44105,0.507464,-0.0767077,-0.449959,-0.434763,0.149265,0.103215,0.572404,-0.16454,0.0980181,0.432096,-0.0336309,-0.019475,0.176467,-0.0980573,-0.520615,0.283625,-0.247976,0.00966675,0.0390829,-0.45492,-0.565607,-0.0682689,-0.595646,0.111177,-0.0478431,-0.0169428,0.197037,0.245554,0.119802,-0.38761,-0.280391,0.14426,0.645228,-0.347038,-0.255419,0.372802,0.260911,-0.348478,-0.170596,0.635005,-0.602772,0.065984,-0.248431,0.161646,0.150032,0.136698,-0.238054,0.445732,0.331981,0.130913,-0.155805,-0.533606,0.224098,-0.189945,-0.210373,-0.0838086,0.260734,0.109875,0.385798,-0.0884252,0.73743,-0.325494,0.298249,-0.282114,0.209974,-0.0381866,0.172576,0.118034,0.132166,-0.00934196,0.377838,0.588491,-0.241368,-0.511666,-0.330051,-0.69115,-0.188982,-1.14944,0.508789,-0.301682,-0.106359,0.278526,-0.927206,0.0165114,0.234372,-0.462199,0.223781,-0.144923,0.407598,0.246053,-0.236182,0.782351,-0.135439,-0.347052,0.0710219,0.28625,0.547784,0.84056,-0.27162,0.376016,0.128973,-0.0345636,-0.664245,0.00630373,0.181139,0.361106,-0.0344196,-0.239587,0.00637347,-0.287,-0.287379,0.241817,-0.0320202,-0.0643781,0.22754,0.5234,0.170728,0.552024,0.919725,-0.0517063,0.33373,-0.0237099,-0.485044,0.0880691,0.21614,0.421462,-0.847598,0.409038,-0.223801,0.171613,0.0588157,0.220563,-0.411794,-0.0877159,-0.078792,-0.00324294,-0.356821,0.15811,0.392402,0.0553989,0.0803214,0.053674,-0.235921,0.201029,0.136783,-0.152468,0.176704,0.264731,0.112488,-0.353686,-0.0332074,0.33182,0.752055,0.0667871,0.127121,0.321911,0.356541,0.567372,-2.00378 +3398.56,0.824988,0.0912059,5,1.56015,0.884249,-1.19398,0.466169,0.454592,0.0560489,0.227066,0.113441,0.368034,0.596833,0.0387629,-0.265082,-0.255302,0.389781,-0.127779,0.76753,0.0998819,0.209251,0.401761,-0.311934,-0.0590981,-0.430565,-0.0951648,0.0582855,0.0475884,0.103203,0.0104974,-0.127914,-0.183949,0.495984,0.921851,0.00108281,-0.0707775,-0.111574,-0.0862467,0.10537,0.0111943,-0.243985,0.638809,-0.326999,0.789149,0.689546,0.305403,-1.22335,-0.549503,0.0447368,-0.4851,-0.0568322,0.199015,0.0343618,0.135908,-0.306219,-0.460111,-0.12781,0.41618,-0.330371,-0.175204,-0.611475,0.684591,-0.0105423,0.117502,1.12512,-0.395169,-0.388596,-0.0233736,0.614433,-0.392515,0.112483,-0.561007,-0.542944,0.176087,0.419521,0.683652,0.0420767,0.591817,0.465447,0.0684567,0.174059,-0.206331,-0.230728,0.151566,-0.827192,0.132908,-0.0605559,-0.357514,-0.0377461,0.249681,-0.448936,-0.134096,-0.322432,-0.534963,0.779013,-0.0844432,-0.427779,-0.0643147,-0.441412,0.400118,-0.0902626,-0.172266,0.437574,0.246561,-0.154711,-0.606951,0.399681,0.138244,-0.25067,0.952187,-0.0978414,0.56475,0.749523,0.495106,0.211567,0.584946,0.333364,0.210574,-0.0694208,0.398862,-0.11055,0.439096,-0.120879,-1.10075,-0.381518,-0.176269,-0.270822,-0.241389,0.483991,0.365709,-0.342042,0.0015389,-0.893197,0.408441,0.0504532,0.245116,0.199114,-0.148083,-0.00332814,-0.431486,0.0652697,0.129803,-0.855006,-0.218503,0.0675139,-0.654781,-0.415293,0.115229,0.114344,0.443866,0.262912,-0.206719,0.293987,0.0984297,0.466195,0.111134,-0.470341,0.550617,0.474993,-0.0984446,-0.0680005,0.254846,-0.0355325,0.472374,0.401136,1.01119,0.216822,0.0400855,0.0437155,0.295045,0.335237,-0.544874,0.719948,0.333704,0.0922421,-0.189471,-0.535586,-0.331548,-0.406312,-0.532061,0.139724,0.214754,0.570199,0.488918,-0.0461515,-0.393015,-0.229649,0.222451,-0.284287,-1.0192,-0.207953,0.479692,-0.657503,-0.32603,-0.177406,0.0569232,-0.798884,-0.249074,0.231007,0.331224,-0.440089,-0.664046,-0.096202,0.339864,-0.0951533,0.505194,-0.190832,-0.0642812,-0.521062,-0.760145,0.884094,0.323851,-0.22715,0.323436,-0.70663,0.0975192,0.0809657,-0.421043,0.39501,-0.549143,-0.158033,-0.322997,-0.267386,0.0150601,-0.4219,0.721852,0.460876,0.222142,0.153774,-0.26402,-0.4069,-0.080672,0.98319,-0.32115,0.0842366,0.0438784,-0.620178,-0.401807,0.124057,-0.265861,0.446257,0.444622,-0.388353,0.0640362,0.0744652,-0.299172,-0.580854,-0.261953,0.579315,0.358251,-0.0831563,-0.422982,-0.250937,-0.0376462,-1.41303,0.194788,-0.584767,-0.126699,0.485889,-0.320996,0.0660068,-0.092562,0.306232,-0.161451,0.126136,-0.123276,0.146383,-0.183007,-0.699446,-0.142993,-0.724944,-0.0186395,0.135808,-0.644024,-0.618035,-0.882954,0.993814,-0.338402,0.0882286,0.0283919,-0.147214,0.242318,0.388117,-0.439583,-0.191668,-0.444326,0.453581,-0.634952,-0.211184,-0.561209,0.402604,0.212158,0.0271427,-0.323079,-0.0165787,0.282745,-0.00585215,-0.797152,-0.91984,0.256321,-0.494884,-1.11157,-1.16591,-0.216853,0.185223,0.300314,0.430375,0.548009,-1.34109 +3391.15,1,0.0912059,4,1.5636,0.87105,-1.17217,0.469165,0.497178,0.10796,0.240179,0.263871,0.180755,0.53597,0.15976,-0.321353,-0.365377,0.364077,-0.103194,0.707369,0.161964,0.10407,0.216279,-0.0961264,-0.0651294,-0.482668,-0.208969,0.026269,0.0663769,0.15864,0.351188,-0.387402,0.0795258,0.281509,0.89309,-0.525627,-0.358476,0.0518143,-0.126504,0.120957,-0.173827,-0.223497,0.5767,-0.185604,0.960003,0.778351,0.343239,-1.3941,-0.564586,0.0135967,-0.385475,0.0206544,0.530934,-0.110199,-0.0244436,0.0570943,-0.349082,-0.422822,0.625194,-0.337788,-0.222119,-0.455651,0.562888,-0.0593438,0.20914,1.31658,-0.434501,-0.647737,-0.107042,0.467094,-0.323251,0.17529,-0.399324,-0.00695195,0.307477,0.327955,0.687592,0.258854,0.601074,0.463743,0.106102,0.417427,-0.226208,-0.204132,0.212638,-1.0792,0.229773,0.0090429,-0.377051,0.0473381,0.850703,-0.33881,-0.121879,-0.231179,-0.623358,0.600439,0.108014,-0.463379,-0.00636399,-0.683876,0.322229,-0.209209,-0.0782387,0.359834,0.0270327,0.0759529,-0.449814,0.373198,0.0636616,-0.555206,0.98003,-0.0772379,0.468312,0.732426,0.33119,0.403993,0.772899,0.353638,0.367834,-0.160622,0.164476,-0.173654,0.39654,-0.139563,-1.33291,-0.341244,0.0998896,-0.19841,-0.269708,0.369015,0.424225,-0.113849,0.19928,-0.904143,0.372149,-0.132193,0.00970216,0.320793,-0.371903,-0.131382,-0.432974,-0.0734802,0.146969,-0.780146,-0.172973,0.107966,-0.782629,-0.59549,0.206025,-0.0668525,0.345582,0.276688,-0.510207,0.176569,0.0683929,0.339315,0.206664,-0.12073,0.504617,0.847729,-0.111903,0.0710542,0.124761,-0.267924,0.214586,0.364252,0.867597,-0.131764,0.281259,0.166138,0.252108,0.561912,-0.732022,0.94142,0.510836,0.619886,-0.10347,-0.407735,-0.108801,-0.321908,-0.377644,0.259945,0.334305,0.534033,0.313057,0.127281,-0.211154,-0.477718,0.169989,-0.106668,-1.04871,-0.383402,0.474178,-0.440134,-0.274412,-0.302099,0.160536,-0.967774,-0.251877,0.163619,0.365984,-0.644096,-0.518569,-0.22877,0.345318,-0.238904,0.389215,0.071238,0.0355534,-0.525317,-0.846404,0.855574,0.160098,0.235784,0.376759,-0.597046,-0.0490629,0.19515,-0.705933,0.384033,-0.617981,0.181043,-0.37822,-0.598571,0.301301,-0.158356,0.678203,0.474601,0.367654,0.127305,-0.682612,-0.342143,0.00544379,1.11031,-0.224493,0.100605,0.198889,-0.546631,-0.273154,0.304112,0.0885085,0.287391,0.27184,-0.907224,0.0556742,0.0854406,-0.559008,-0.742123,0.150216,0.421243,0.284147,-0.241478,-0.223828,-0.374136,0.0984311,-1.15179,0.152087,-0.546552,-0.291386,0.51417,-0.0815546,0.167087,-0.342823,0.123397,-0.143016,0.13089,-0.270619,0.193752,-0.267365,-0.546323,-0.0877108,-0.318224,-0.0155905,0.159271,-0.767782,-0.774948,-0.670649,0.670233,-0.210514,-0.041942,0.270859,0.280761,0.194029,0.352396,-0.513373,-0.098449,-0.419409,0.436778,-0.540553,-0.255173,-0.222857,0.502172,0.43241,0.195791,-0.507046,-0.328882,0.284357,-0.072033,-0.788447,-0.983827,0.229132,-0.684857,-1.49087,-1.00322,-0.145223,0.20765,0.262996,0.455686,0.512831,-1.48296 +3390.81,0.649058,0.0912059,5,1.60007,0.830566,-0.925223,0.270371,0.638803,-0.121134,-0.373609,-0.108516,0.390153,-0.453504,0.122027,0.0194853,-0.023652,0.190622,0.0213521,0.594516,-0.127495,0.0235262,-0.351462,0.144875,0.0678131,-0.766713,-1.05986,-0.121749,-0.341319,-0.425465,-0.342282,0.118597,-0.97398,0.0112421,0.807327,-0.281195,-0.0766085,0.0848868,-0.0750318,-0.0168072,-0.291926,0.81379,-0.0280844,-0.390456,0.940955,-0.10121,0.27603,-0.401281,0.076606,-0.152065,-0.42529,-0.211073,0.0700443,0.405174,-0.0483008,0.349662,0.0940034,-0.491693,1.07406,0.140991,-0.0416502,-0.660326,0.576229,-0.626631,0.0673621,0.95431,-0.513917,-0.87748,0.267759,-0.123202,0.245409,-0.603547,0.3015,-0.698124,-0.373515,0.189974,0.39732,-0.438299,0.431173,0.33004,0.380255,-0.678986,-0.590699,-0.168854,0.25012,0.350688,0.461679,-0.653294,0.173302,-0.145403,-0.293409,0.211982,0.137896,-0.634649,0.518647,-0.292465,0.218956,0.152101,0.0152874,-0.144814,-0.249684,-0.0413409,0.722096,0.505266,0.0180338,-0.278301,-0.424757,-0.64126,0.616416,-0.199143,-0.115057,-0.0239783,0.165296,0.393884,-0.373213,-0.0304974,0.512367,0.145222,-0.100956,0.209913,-0.661268,0.136367,0.102806,-0.019439,-0.572631,0.369174,-0.12437,-0.0646571,-0.0829813,-0.530764,-0.242831,0.397298,0.355468,0.0511101,-0.180298,-0.0974608,-0.0536041,0.594569,0.0160054,-0.329792,0.379173,-0.0185595,0.176825,-0.701194,-0.263483,0.264822,0.795293,-0.410003,0.158253,0.39712,-0.196616,0.228582,-0.0446497,-0.271046,-0.561239,0.332748,-0.199381,-0.318233,0.0887156,0.0559476,0.767214,-0.0624712,0.304738,0.801861,0.466295,-0.16183,0.734761,0.516922,-0.180304,0.869442,0.00777456,-0.976938,0.347172,-0.852593,0.679582,-0.830912,-0.0744751,0.369684,0.0303071,0.184124,-0.276664,-0.24383,0.292049,0.484586,-0.0369013,-0.249411,0.73878,0.411985,-0.494612,-0.873259,0.537246,-0.0487439,-0.0413741,-0.0663029,0.104951,0.199318,-0.24691,-0.151199,0.213865,0.412823,-0.10419,-0.448931,-0.946549,0.387475,0.0746337,-0.536584,-0.406727,0.16566,0.575139,0.514886,-0.06378,0.852469,-0.37933,0.332245,0.125863,0.0312975,0.201168,0.0765941,0.38151,0.572913,-0.108333,0.443735,1.35727,-0.229533,-0.147037,-0.559081,-0.444116,-0.0128248,-0.403333,1.11481,0.141413,-0.092342,0.191172,-0.495786,-0.278499,-0.0510769,-0.576263,0.334968,-0.236488,0.517367,0.0785056,0.282268,0.467181,0.264739,-0.870506,-0.174236,0.30038,0.455699,-0.0105535,0.102303,0.420373,0.284243,-0.0985555,-0.681305,-0.58904,-0.331169,0.377604,-0.191866,-0.371862,-0.256713,-1.13476,-0.909007,0.0835752,0.168064,0.158935,0.844327,0.0691373,0.109942,0.99525,0.435731,-0.420867,-0.398926,0.324749,0.109408,0.0210852,0.0934156,-0.149021,-0.0145546,0.645692,0.225782,-0.108832,-0.270827,0.471448,-0.269565,0.0473765,-0.521582,0.138387,0.0136327,0.755205,0.172857,-0.232793,0.395505,0.192339,-0.324741,-0.292589,0.221875,-0.235018,0.681596,0.0410686,-0.0744224,-0.381976,-0.151746,1.08242,0.789466,-0.292346,0.172109,0.200386,0.41486,0.447645,-1.72901 +3395.67,0.70608,0.0912059,4,1.60002,0.886462,-1.14638,0.356931,0.37547,0.00199734,0.350078,0.158396,0.342681,-0.760713,-0.352708,-0.0466543,-0.0338048,0.484743,-0.178073,0.966332,0.0679956,0.0860791,-0.174298,-0.0322076,0.0529228,-0.716317,-1.07295,0.112291,-0.661342,-0.223193,-0.195233,-0.306382,-1.19794,-0.107475,0.844325,-0.880716,0.319817,0.455429,0.0665162,-0.0752447,-0.357617,0.256131,0.287912,-0.288977,0.950358,-0.153041,-0.206593,-0.10618,0.247977,-0.135188,-0.143978,-0.039316,-0.087976,0.474357,-0.00309012,0.809593,0.389465,-0.724176,0.831256,0.0748953,-0.356974,-0.337096,0.470919,-0.768648,0.196765,1.06275,-1.02182,-0.582013,0.085097,0.0250063,0.0373513,-0.230601,0.202322,-0.610658,-0.381499,0.0442602,0.40445,-0.61689,0.640676,0.437122,0.107737,-0.0060408,-0.383463,-0.401624,0.369148,-0.47682,0.335983,-0.731314,-0.134633,0.121978,-0.228345,-0.0913687,0.171042,0.00154803,-0.0797211,0.0949848,-0.160007,-0.105103,-0.0404269,-0.0647031,0.252628,-0.301691,0.401553,0.389604,0.511501,-0.370885,-0.557478,-0.524689,0.791033,-0.628721,0.289933,-0.0278129,-0.038725,0.80199,-0.370017,0.153173,0.395548,0.202159,-0.467524,0.400955,-0.320992,-0.0858568,-0.396146,-0.204119,-0.770356,-0.0934562,-0.0748325,0.124493,-0.173268,0.206298,-0.004719,0.319919,0.309578,-0.640681,-0.339203,-0.310482,-0.3422,0.0249528,0.0396576,-0.6433,-0.357429,-0.307752,0.250365,-1.01666,0.218368,0.283913,0.72309,-0.862093,0.449253,0.274836,-0.178498,0.359178,-0.58684,-0.300439,-0.641417,-0.208953,-0.24776,0.223346,0.476112,0.103334,0.303195,-0.0241531,0.0546009,0.548505,0.0538206,-0.435785,0.576942,0.15636,-0.314061,0.10931,0.333409,-0.243833,0.159874,-0.652408,0.120006,0.528703,-0.254717,-0.00462539,-0.0650395,-0.217903,-0.617945,-0.403399,0.278502,0.334599,-0.110281,-0.467487,0.787673,0.168422,0.304501,-0.688631,0.659499,-0.150849,0.111422,-0.530701,0.0449367,0.359443,-0.131163,-0.582799,-0.0813863,0.838792,0.215785,-0.529691,-0.844111,0.228583,-0.125577,-0.2108,-0.155521,0.09683,0.120676,0.222644,0.260008,0.768678,-0.0746668,0.404756,-0.0606749,-0.45269,0.234739,0.424362,-0.743393,0.27473,-0.344082,-0.127888,0.735377,-0.227219,-0.563118,-0.791726,-1.05924,0.182437,-0.213162,0.786176,-0.674044,0.0211632,0.244876,0.103518,-0.431819,-0.26609,-0.200142,-0.406764,-0.229857,0.511583,0.103011,0.369495,1.02342,-0.266918,-1.05277,-0.241001,0.00525632,0.166622,0.0133727,0.202539,0.425557,0.216505,0.102394,-0.896401,-0.384329,-0.697424,0.532442,-0.6726,-0.00680168,-0.0577954,-1.25074,-0.740563,0.191137,0.136383,-0.101767,0.889103,0.233876,0.259192,0.672758,0.0282196,-0.188785,-0.417558,-0.237945,-0.283467,-0.201366,-0.136549,0.28203,-0.27829,0.421995,0.061126,-0.171792,-0.14127,0.437772,-0.377109,-0.219841,-0.681377,-0.0694269,0.260151,0.357433,-0.111056,-0.498996,0.540894,-0.211477,-0.192256,-0.0860018,-0.219511,0.0620757,-0.33531,-0.0366119,0.0816139,0.158665,-0.399226,0.725446,0.663061,-0.443143,0.195805,0.34408,0.442499,0.586583,-0.950361 +3418.84,0.765029,0.0912059,4,1.57316,0.80938,-0.83196,0.336535,0.685785,0.0213459,-0.402441,-0.393634,0.355044,-3.2364e-06,-0.00531501,-0.00887493,-0.199999,0.560403,-0.273337,0.651539,0.0706859,0.452038,-0.319376,-0.141177,0.168665,-0.748424,-0.639998,0.407917,0.175276,-0.671917,-0.522179,0.624028,-0.440719,-0.00888597,1.02524,-0.0869208,-0.0362662,0.38,0.353089,-0.38046,-0.519153,0.790459,0.43352,-0.330069,1.05797,0.274507,0.200932,-0.653896,0.190911,-0.134263,-0.410237,-0.0520555,0.43526,-0.180744,0.209886,0.143075,0.215134,-0.382556,0.672268,0.0582694,0.197276,-0.962752,0.586331,-0.0292655,-0.00664203,0.981235,-0.430024,-1.12431,-0.278252,0.0601636,-0.731845,0.289057,0.645911,-0.137732,-0.147793,0.0272463,0.332776,0.217088,0.408058,0.431093,0.209212,-0.244446,0.2209,0.179825,0.752177,0.257898,0.0785118,-0.0400376,0.438535,0.256235,-0.0639989,-0.0308872,0.157207,-0.761249,0.234424,-0.229089,0.0273812,-0.355892,-0.148256,-0.171964,-0.382245,0.227842,-0.0876263,0.140655,0.668097,0.125228,-0.429796,0.0339604,0.474525,-0.750809,0.770725,0.177274,0.364714,0.319154,-0.556907,-0.34411,-0.0850941,0.552257,-0.232851,-0.187848,-0.464958,0.24355,0.459754,-0.4884,-0.447764,0.257732,0.260089,0.0362445,0.530372,0.322906,-0.0578094,0.541513,0.385895,-0.118753,0.617587,-0.340709,0.00575121,0.627583,0.0568102,-0.12913,0.637479,-0.140954,0.155387,-0.823632,-0.371896,-0.24115,-0.1271,-0.712674,0.811212,-0.353198,-0.455847,0.349326,-0.0835444,0.0899392,-0.491815,0.103604,-0.133387,0.10146,-0.340688,0.585441,0.317287,0.535482,-0.0896237,0.213534,0.176291,0.0531251,0.250719,-0.193758,-0.152189,0.0819489,0.145399,-0.0996017,-0.601619,0.114364,-0.0408221,0.273514,0.194114,-0.399641,-0.279435,-0.227013,-0.00172157,0.151272,0.0528582,0.58704,0.111796,0.0330044,0.347864,-0.273015,0.197907,-0.416603,0.0191737,0.257738,-0.364136,0.128957,-0.590171,0.0789724,-0.053153,-0.0994864,-0.45465,0.0236606,-0.0143773,-0.211394,-0.813044,0.0990253,-0.0633995,-0.395471,-0.0121492,0.115297,0.0182575,0.625358,-0.269571,0.777208,-0.282116,-0.0109195,-0.12819,-0.443684,0.243948,0.495995,0.122707,0.505154,-0.327775,0.425304,0.381762,-0.262463,0.223019,-0.719133,-0.112095,-0.101904,-0.341507,0.185336,0.00436443,-0.167083,-0.358418,-0.450466,-0.452094,0.296009,0.0317263,-0.334863,-0.184438,0.0317563,-0.0194402,-0.0666542,0.0696696,0.241342,-0.51663,-0.133103,-0.526339,-0.756066,0.247349,0.594886,0.270818,-0.0919227,-0.0588422,-0.248818,0.0761671,-1.00003,-0.0859983,-0.666234,-0.214849,-0.0474296,-0.209851,-0.170646,-0.102164,0.15018,-0.212074,0.619061,-0.0971326,0.447016,0.456203,-0.0574472,-0.326116,-0.897679,-0.432957,0.0168471,-0.801722,0.0843821,-0.37177,0.0527352,-0.283645,-0.18232,-0.190731,0.35884,0.177929,0.1713,-0.465446,-0.230608,0.210747,0.254832,-0.0793973,0.460769,-0.484948,0.0661266,-0.326995,-0.59125,-0.0579962,-0.222295,0.0672341,0.384652,0.00855568,-0.322389,-0.243327,-0.357236,-0.343145,-0.255518,-0.61823,0.15753,0.170962,0.396901,0.413475,-2.02182 +3402.22,0.887802,0.0912059,4,1.59192,0.711046,-1.0738,0.393075,0.543328,0.156829,-0.369618,-0.404496,0.539935,-0.328207,-0.262338,0.167127,-0.407428,0.570684,-0.098634,0.695225,0.0193831,0.240852,0.0291582,-0.163598,-0.212548,-0.86439,-0.858477,0.4855,0.20165,-0.363974,-0.488785,0.300406,-0.462506,0.0189999,1.09265,-0.430997,-0.0781689,0.393127,0.267131,-0.16092,-0.264228,0.580694,0.487785,-0.554068,1.02179,0.0628392,0.0893987,-0.580928,0.304108,-0.162144,-0.480095,0.130063,0.384312,0.124603,0.374888,-0.0731326,-0.0163551,-0.11188,0.842608,0.409215,0.0426088,-1.01177,0.58531,-0.565631,0.417453,1.09734,-0.238293,-0.75176,-0.105303,0.423398,-0.627009,0.499768,-0.00635167,-0.169858,-0.269237,-0.0425164,0.555055,0.149144,0.316264,0.589084,0.358976,-0.0563951,0.0217492,0.153117,0.432779,0.332978,-0.0273497,-0.322803,0.302166,0.00834848,0.0167284,-0.295641,0.0968091,-0.716938,0.000318798,0.0128791,0.0735083,-0.575668,0.186797,-0.126114,-0.0127928,0.221465,-0.150054,0.0941727,0.548281,-0.154381,-0.476291,0.140107,0.396818,-0.584597,0.8588,-0.0225425,0.367071,0.260573,-0.354331,-0.110349,-0.259959,0.601386,-0.0993065,0.0115601,-0.488491,0.265342,0.719218,-0.422035,-0.502492,0.123003,0.0919308,0.00242654,0.48517,0.373341,0.155788,0.282321,0.522356,0.0541321,0.467133,-0.190171,-0.310765,0.956819,-0.1868,0.00984436,0.42471,0.00527907,0.274253,-0.908931,0.159625,-0.207128,-0.146279,-0.645139,0.875757,-0.830924,-0.429492,0.328242,-0.296255,0.241199,-0.589279,0.209526,0.0372382,0.247476,-0.427248,0.620346,0.597386,0.27179,0.0178326,0.180416,0.152088,-0.233039,0.32058,-0.373362,-0.109907,-0.318903,0.45534,-0.0329504,-0.460785,0.161827,0.0965912,-0.0841699,0.0428648,-0.500219,-0.0832818,-0.235761,0.030363,0.083886,0.0378844,0.634154,-0.298565,0.0248203,0.414619,0.529558,0.477442,-0.318312,-0.085481,0.167362,-0.239645,0.603837,-0.537222,-0.124269,-0.26661,-0.0607317,-0.461844,0.0130631,0.0990028,-0.339189,-0.858471,-0.0246803,-0.320306,-0.701631,0.138003,0.12512,0.444376,0.43047,-0.16825,0.64184,-0.490991,0.461149,0.0353397,-0.384745,0.109205,0.380061,0.313583,0.486537,-0.12774,0.373913,0.00937724,-0.213144,0.173801,-0.360155,0.0361059,0.0302853,-0.187116,0.493897,0.198977,-0.439647,-0.151291,-0.4917,-0.646238,0.220532,0.219927,-0.541081,-0.349868,0.147978,-0.249757,0.000440778,0.199916,0.195076,-0.497575,-0.152752,-0.867157,-0.752012,0.00314946,0.538608,0.241663,-0.0760145,0.0226706,-0.298441,0.330215,-0.858433,0.088977,-0.792897,-0.151148,-0.136113,-0.247902,0.00516194,-0.151774,0.26654,-0.242695,0.85245,0.325915,0.249032,0.0120008,-0.338487,-0.261474,-0.700351,0.171152,0.192897,-0.594622,-0.404581,-0.552092,-0.137501,-0.581266,-0.113061,-0.0246313,0.556047,0.0393653,0.0246725,-0.439266,-0.263513,0.421273,0.0531693,-0.104815,0.495302,-0.132248,0.0788651,-0.216372,-0.380036,-0.0785095,-0.232884,0.0977857,0.596694,0.0786241,-0.503475,-0.358426,-0.20134,-0.104795,-0.109982,-0.612013,0.123792,0.253617,0.351841,0.503604,-1.3167 +3401.78,0.970696,0.0912059,4,1.60693,0.905202,-0.766731,0.18043,0.856091,0.165125,-0.303842,-0.486245,0.306773,-0.393168,-0.145924,0.165562,-0.254007,0.321018,-0.204551,0.61252,-0.214867,0.19176,-0.126907,-0.109716,-0.230263,-0.630738,-0.568867,0.0743053,-0.0540433,-0.532603,-0.439773,-0.0236587,-0.0773696,-0.160659,1.03616,-0.482277,0.0209741,0.149925,0.177264,-0.363957,-0.144035,0.318152,0.386219,-0.480377,1.22829,-0.0689836,-0.208619,-0.0568511,0.348283,-0.156232,0.0252223,0.158112,0.27988,0.149844,0.534384,0.372329,0.1114,-0.272656,0.861369,-0.272375,0.111267,-0.331804,0.411387,-1.11194,0.160404,1.32377,-0.18078,-0.919129,-0.0771223,0.508691,-0.136047,0.274458,0.280759,-0.201047,-0.60867,-0.0758853,0.417642,-0.0546428,0.51422,0.612841,0.317342,-0.0601421,0.0920885,0.107123,0.458767,0.201619,0.22152,-0.089016,0.290802,-0.0549715,0.116172,-0.347115,-0.359294,-0.701111,0.640205,-0.0237771,-0.414295,-0.453656,0.0637798,0.525377,0.117366,0.415381,0.170742,0.105576,0.0281857,-0.497136,-0.493853,-0.109532,0.446178,-0.863355,0.471513,0.0329631,0.34859,0.286233,-0.373229,-0.303431,0.11932,0.330142,-0.233868,0.0947628,-0.588447,0.408365,0.33594,-0.229987,-0.697011,-0.182727,0.147217,0.0875236,-0.0993623,-0.450207,0.238358,0.343145,0.460723,-0.0169433,0.380716,-0.248653,-0.275496,0.806317,0.0900841,0.0436784,0.131932,-0.0687964,0.652527,-0.738046,0.353338,-0.128103,-0.181882,-0.230066,0.528899,-0.344074,-0.385326,0.356005,-0.232677,-0.508526,-0.491703,-0.206554,-0.265514,-0.0153081,-0.450812,0.596639,0.527019,0.00804363,-0.328473,0.506993,0.0622677,-0.555109,0.231356,-0.310858,0.175901,0.000739352,0.23806,-0.0960208,-0.350574,0.431996,0.383181,0.0553183,0.174876,-0.13226,-0.320619,-0.418182,-0.162311,0.393316,-0.198471,0.530034,-0.0157211,0.0154123,0.227868,-0.129462,0.55663,-0.173618,0.419648,-0.120762,-0.0647557,-0.131381,-0.35668,-0.261931,-0.524061,-0.746511,-0.256001,-0.0675389,0.234592,-0.0904544,-0.441664,0.0298618,-0.298313,-0.709127,0.426398,-0.455465,0.12629,0.472975,0.112954,0.604009,-0.471825,0.360341,0.369303,-0.0503875,0.527429,-0.471898,-0.0955902,-0.00382719,-0.518513,0.0327597,-0.210465,-0.289819,0.190005,0.0254798,-0.107817,0.0711985,-0.420178,0.282863,0.245747,-0.767986,-0.192984,0.113752,-0.146366,0.0929384,-0.325691,-0.238981,-0.134374,0.435152,0.113054,0.0156267,0.264279,0.101137,-0.397475,0.259346,-0.335854,-0.788654,-0.0705438,0.25043,0.20391,-0.16072,0.239444,-0.336201,0.345846,-0.763303,0.22321,-0.696335,-0.408848,-0.0361095,-0.279966,-0.277287,0.113316,0.0612236,-0.614829,0.483904,0.8567,-0.335025,-0.0629166,-0.49833,-0.479145,-0.769077,-0.0684524,-0.122955,-0.0230766,-0.740126,-0.960949,-0.113029,-0.457985,-0.161248,-0.0584436,0.286789,-0.260604,0.0575702,-0.657139,0.224544,0.109929,0.0664878,0.164538,0.250402,-0.38871,-0.111039,0.201297,-0.139825,-0.354109,-0.153249,0.191386,0.0505111,0.152639,0.0550334,-0.135092,-0.0810882,-0.166636,-0.477355,-0.209525,0.144227,0.256424,0.379772,0.506383,-2.645 +3410.63,1,0.0912059,4,1.62455,0.828452,-0.915385,0.240264,0.591131,0.131455,-0.308853,-0.379519,0.282165,-0.395188,-0.0821868,0.086176,-0.215394,0.422002,-0.189164,0.631966,-0.135055,0.254448,-0.0841254,-0.0647349,-0.186506,-0.741787,-0.54375,0.214173,-0.0441259,-0.280495,-0.489519,-0.0874166,-0.121377,-0.0924496,0.970931,-0.408094,0.0154054,0.153241,0.153771,-0.300568,-0.117168,0.602657,0.389849,-0.541036,1.03688,0.0566036,-0.360382,0.158752,0.347313,-0.216404,-0.122651,0.401184,0.171432,0.0134515,0.556073,0.238147,-0.0194759,-0.272177,0.909715,-0.188661,-0.0173493,-0.342431,0.359331,-1.15684,0.09537,1.21425,-0.209391,-0.82391,-0.0478166,0.6222,0.0216762,0.156759,0.318771,-0.190427,-0.699508,0.0447238,0.481633,-0.281617,0.602596,0.536262,0.397164,-0.0964644,0.0814478,0.101644,0.594968,0.21648,0.259216,-0.113879,0.218441,-0.000510595,0.162565,-0.177956,-0.559866,-0.767405,0.447176,-0.0690927,-0.443532,-0.502449,0.059238,0.550367,0.216378,0.155757,0.158082,0.121661,0.173096,-0.526367,-0.633518,0.0211886,0.591693,-0.721298,0.471888,0.123612,0.250958,0.207521,-0.234803,-0.263619,0.142503,0.362886,-0.207656,-0.0484873,-0.686042,0.44447,0.193619,-0.279889,-0.735564,-0.342708,0.106553,0.259654,-0.0559804,-0.588453,0.314821,0.41554,0.378784,-0.433132,0.243293,-0.239247,-0.316012,0.825919,0.119855,0.0497528,0.0840191,-0.132208,0.63644,-0.738576,0.0256551,-0.0193448,-0.0123969,-0.229992,0.531128,-0.199539,-0.577901,0.373843,-0.179715,-0.407192,-0.333371,-0.101613,-0.285908,-0.0378222,-0.51962,0.614246,0.357526,-0.00259007,-0.395097,0.437637,0.11589,-0.642114,0.335645,-0.230583,0.190621,0.0287649,0.224645,-0.0334617,-0.40565,0.506031,0.48702,0.13621,0.0893837,0.0394412,-0.276437,-0.454671,-0.234003,0.173845,-0.0154788,0.463619,-0.04434,-0.10443,0.248002,0.12072,0.493691,-0.308996,0.333741,-0.205121,-0.04855,-0.127355,-0.188271,-0.29106,-0.529791,-0.766132,-0.319653,0.00203051,0.32438,-0.0596693,-0.483318,0.095771,-0.193717,-0.508426,0.402898,-0.475725,0.0798319,0.3813,-0.0573706,0.634607,-0.544209,0.408414,0.190364,-0.0934084,0.297177,-0.323382,0.113213,0.0968902,-0.498222,0.0804086,-0.365634,-0.199179,0.121352,-0.0700748,0.0253356,0.0489683,-0.607936,0.294189,0.11988,-0.621077,-0.207667,0.132626,-0.243596,0.113576,-0.465946,-0.370727,-0.144541,0.370375,-0.0868413,0.180746,0.176666,-0.0451029,-0.39495,0.1518,-0.093338,-0.895402,0.00925922,0.289791,0.205527,-0.199406,0.201612,-0.478483,0.203245,-0.675696,0.272992,-0.61767,-0.389301,-0.104785,-0.18725,-0.280772,0.223641,0.0346105,-0.583614,0.499376,1.12057,-0.368675,-0.0369862,-0.531781,-0.475249,-0.463285,-0.0135243,-0.0127078,-0.110427,-0.580187,-1.09042,-0.158666,-0.446273,-0.0316267,-0.146323,0.0633981,-0.327497,0.165226,-0.289215,0.325391,0.0904973,0.153629,0.263545,0.1983,-0.487117,-0.124585,0.256232,-0.324459,-0.262692,-0.120139,0.113799,0.139072,0.0828075,0.122888,-0.0963814,-0.0913092,-0.304914,-0.464546,-0.1242,0.1591,0.235777,0.398873,0.485569,-1.5823 +3385.97,0.66926,0.0912059,5,1.59456,0.83341,-1.57171,0.652219,0.648438,-0.0858059,-0.0527547,0.0627971,0.129027,0.233806,-0.0777052,-0.385027,-0.342109,-0.38264,-0.46541,1.2618,-0.150324,-0.315513,0.157621,-0.369239,0.0240767,-1.21351,-1.57275,0.34263,-0.759289,-0.13835,0.0137886,0.357145,-0.956003,0.0588654,0.866766,-1.10731,-0.207172,-0.133369,-0.475482,-0.351701,-0.604375,0.239322,1.01387,-0.105305,1.1899,1.05736,0.851761,-0.351187,-0.0622059,0.370528,-1.20061,-0.3013,0.115134,0.122268,-0.0358671,0.613404,-0.0349152,-0.189071,0.386508,-0.458524,-0.24703,-1.48114,0.319372,0.359372,0.19358,0.990702,-1.20208,-1.47005,0.150781,-0.480389,0.0131563,-0.226288,0.0602277,-0.292257,0.555037,0.478009,0.738463,0.204146,0.23194,0.403513,0.409743,-0.171681,-0.297533,0.0483553,0.577124,-0.519629,0.0567755,-0.169194,-0.147783,0.0286649,-0.375933,0.16544,0.369622,-0.149162,-0.337012,0.218861,0.526172,0.330523,0.203305,-0.830115,-0.176255,-0.618319,-0.0916199,-0.14638,-0.135913,0.360899,0.00705371,-0.474616,-0.507316,0.279309,-0.11333,-0.371225,0.52506,0.518263,0.144257,0.285003,-0.0194895,0.258724,0.566081,0.230963,0.365237,-0.188777,0.13026,-0.0799358,-0.398454,0.284292,-0.319376,-0.524546,-0.0326883,0.832788,-0.132142,0.0439183,0.118642,-0.0536177,-0.0309982,0.263394,0.347674,-0.119937,-0.297456,-0.0263146,-0.352806,0.184163,0.207477,0.234985,-0.145238,-0.302149,0.016922,-0.483462,-0.3625,0.155726,0.877525,-0.0808332,-0.495228,0.331627,0.222371,0.328841,0.344855,0.167675,1.06521,-0.220602,-0.13546,-0.130999,0.0480697,-0.553313,0.184523,0.43402,0.866037,0.175499,-0.127859,0.12411,-0.0512699,0.0424729,-0.0697005,-0.78148,0.0224747,-0.248566,-0.13584,0.174504,0.204936,0.478226,-0.220554,-0.313639,0.141885,0.682169,0.447153,0.0900582,0.0490216,-0.255703,-0.486797,-0.161058,-0.590741,-0.147649,0.479148,-0.353518,0.317724,0.336863,0.361323,-0.0399864,0.609397,0.0267484,0.0291187,-0.320522,-0.247169,0.353306,-0.223165,0.0988923,0.00603965,0.467649,-0.288787,-0.340327,-0.849573,0.775948,0.838902,0.00154258,-0.11622,-0.395891,-0.0837081,0.665994,-0.520833,0.186128,0.0276739,-0.326239,0.603315,-0.230157,-0.219921,-0.667988,-0.00928251,0.357213,0.186305,0.681444,-0.526511,0.056003,0.253734,0.115883,-0.234241,0.00953185,0.22608,0.155144,-0.199694,0.128363,0.049341,-0.179215,0.579968,-0.171832,0.230102,-0.0287161,-0.0216404,0.846102,0.363956,0.0104791,0.673015,0.477956,-0.354708,-0.108299,-0.3725,-0.335073,0.436217,0.187726,-0.167265,0.681267,-0.327873,0.557607,0.152736,-0.317163,0.605235,0.0508315,-1.10148,0.279761,0.234014,0.351321,-0.0534862,0.398413,0.16357,-0.0990438,-0.427068,0.286786,0.761723,0.208675,0.200433,-0.0960949,-0.223184,-0.190523,0.628568,-0.365564,-0.00240517,-0.525008,-0.343633,-0.083471,-0.0253887,0.244963,0.0609897,0.36379,-0.0167069,-0.120436,-0.052952,0.461048,-0.0722326,0.162356,-0.349378,-0.70688,-0.0879166,-0.252188,0.274897,0.304012,0.0835246,0.130069,0.555792,0.36065,0.745515,-1.80282 +3407.21,0.812747,0.0912059,5,1.72361,0.944018,-1.14355,0.456098,0.506756,-0.165188,-0.389036,-0.348356,0.503812,0.317915,-0.09786,-0.625781,-0.635168,0.0460578,-0.545143,0.478739,-0.328044,-0.32925,-0.235194,-0.167021,-0.35873,-1.31783,-0.678072,0.246274,-0.47004,-0.250424,0.265011,0.174179,-0.268045,0.302256,0.581794,-0.620945,-0.0407097,0.210163,-0.362634,-0.221234,-0.547089,0.816936,0.301513,-0.0405011,0.696415,-0.119723,-0.138055,-0.871286,-0.758269,-0.291764,-0.266407,-0.109661,0.0323167,-0.316717,0.21487,0.559355,-0.233361,-0.684053,0.308513,-0.719905,-0.539542,-1.09226,0.027975,-0.658515,-0.0248178,1.07987,-0.901654,-1.66918,-0.0948757,0.648777,0.182643,0.0703168,-0.205415,-0.368736,-0.405275,0.340786,0.667783,-0.316343,0.916326,0.49468,0.74932,-0.22579,-0.164606,0.0131048,0.861987,0.147605,-0.0470365,0.07253,0.107034,-0.508685,0.37301,-0.239327,-0.464191,-0.624194,0.546968,-0.295872,-0.426197,-0.425508,0.0934855,0.252458,-0.132218,0.094396,-0.117634,0.26679,0.371019,-0.680409,-0.70529,0.0993958,0.661323,-0.64537,0.854697,-0.0756934,0.289649,0.418511,-0.418028,-0.36749,0.242297,0.226759,-0.294366,0.186799,-0.530933,-0.0138487,-0.0257305,0.120729,-1.00396,0.170587,0.213785,0.104812,-0.222805,-0.500643,0.200848,-0.353212,0.287133,-0.184157,0.404381,-0.0807231,-0.264664,1.15686,0.0813807,0.250116,0.109231,-0.264255,0.478499,-0.919467,-0.518172,-0.28767,0.375552,-0.362202,-0.0157515,-0.106542,-0.690842,0.40164,-0.0516554,-0.580493,-0.639009,-0.195072,-0.082253,-0.00588475,-0.402416,0.39037,0.255951,-0.229832,-0.281324,0.531749,0.108493,-0.484417,0.463895,-0.17991,0.19128,0.286187,-0.10128,0.0260035,-0.370612,0.478557,0.354514,0.280269,-0.211499,0.12103,0.0104458,-0.0720083,-0.611713,-0.0505692,0.168952,0.321906,0.0773206,-0.169103,0.200041,0.129992,0.538069,-0.554914,-0.0962114,-0.325946,0.103583,-0.404119,0.0183652,-0.197342,-0.456022,-0.805618,-0.138504,0.0572845,0.215661,-0.193386,-0.651736,-0.11248,-0.405405,-0.220136,0.329137,-0.998027,0.241711,0.448438,-0.136075,0.891105,-0.84343,0.211902,0.123599,-0.00122338,0.474146,-0.0963803,-0.259524,-0.00548026,-0.711636,0.21287,-0.23073,-0.360733,0.216073,0.0339569,0.0573418,0.0287132,-0.574909,0.024084,-0.0783685,-0.517281,-0.207797,0.0722899,-0.0954892,0.00962042,-0.45256,-0.187134,-0.0982741,0.375759,-0.365816,0.316473,0.0724574,-0.202057,-0.403359,-0.142939,-0.029057,-1.08905,0.0760711,-0.196353,0.267017,0.261891,0.112582,-0.358636,0.435511,-0.70967,0.320772,-0.316518,-0.340814,-0.107127,-0.147583,-0.163443,0.0112032,0.00287542,-0.0591494,0.456052,0.79715,-0.249001,0.214633,-0.34203,-0.048111,-0.596966,-0.170786,0.173961,0.137429,-0.587446,-1.22376,-0.394891,-0.348437,-0.571546,-0.0204505,0.254245,-0.185838,0.540458,-0.121839,0.430895,0.0773367,0.415843,0.142401,0.404259,-0.253787,-0.158446,0.404369,-0.12522,-0.0905326,-0.152049,0.432142,0.795823,-0.0926391,-0.226542,0.169961,-0.0713286,-0.128953,-0.263437,-0.109957,0.150157,0.288333,0.387501,0.536967,-1.4181 +3399.55,0.997786,0.0912059,4,1.66457,0.983443,-1.10028,0.338795,0.650585,-0.253321,0.254058,0.414965,0.35251,0.122659,0.00100194,-0.236739,-0.184109,0.0968112,-0.317202,0.85988,-0.102899,-0.343846,0.0996941,-0.409281,-0.6612,-1.1615,-0.840477,-0.0330732,-0.387403,-0.203968,-0.107606,0.405895,-0.838463,0.195969,0.533908,-0.729326,0.0792367,0.0660319,-0.290432,-0.398266,-0.608945,0.408174,0.443916,-0.132143,0.799242,0.340279,0.675712,-0.723149,0.0855876,-0.0994973,-0.524342,0.0517661,0.214692,-0.487598,0.158635,0.460456,-0.285774,-0.0327457,0.789427,-0.0772402,-0.433478,-1.26815,0.771932,-0.311727,0.133303,1.10355,-0.847787,-0.668605,0.221309,-0.0340588,-0.218234,-0.0859523,-0.212526,-0.331504,0.084569,0.023017,0.419222,-0.324061,0.231094,0.111042,0.53613,-0.0871501,-0.11928,0.253029,0.455979,-0.607359,-0.084029,-0.262247,-0.466858,-0.386033,-0.152623,-0.000185927,0.204001,-0.198143,0.0938432,-0.563749,0.143871,0.107351,-0.16594,0.309249,-0.0158705,0.388965,-0.140646,0.323281,0.704239,-0.564374,-0.0538794,-0.344011,0.784104,-0.685738,-0.0975925,-0.442353,0.414786,-0.121348,-0.0775252,0.462211,-0.0861604,0.0866439,0.226954,0.497666,-0.41837,-0.17585,0.173067,0.0598017,-0.975168,0.112641,0.276373,-0.625841,0.0428542,0.18812,-0.0950983,-0.324387,-0.0410255,-0.197215,0.280282,-0.330349,0.498135,-0.0713791,-0.433181,-0.216075,-0.0698708,-0.503187,0.387235,0.183827,0.0147569,-0.113413,0.109233,-0.608982,-0.00288678,-0.0739093,-0.916386,-0.420295,-0.372338,-0.68483,-0.214748,0.257685,-0.151982,-0.0899346,-0.0072644,0.0659748,0.217729,0.105861,0.32552,0.161446,0.226793,0.0818311,0.743315,0.0449249,-0.414581,0.203701,-0.194278,0.469968,-0.570164,0.114664,0.298827,0.436047,-0.347644,-0.141511,0.403023,0.517602,-0.405081,-0.499714,0.039643,0.591509,0.200702,0.13613,0.30735,-0.00410741,-0.989453,-0.239499,-0.0599565,-0.234403,0.495729,-0.167134,-0.390201,0.360305,-0.214663,-0.371496,0.442005,0.228766,-0.201825,-0.345263,-0.744169,-0.106945,-0.129343,-0.478232,0.598542,-0.291375,-0.378049,-0.936627,-0.979093,0.888276,-0.194945,0.381583,-0.391141,-0.398305,0.0225079,-0.0224401,-0.172478,-0.0806189,-0.232928,-0.275653,0.745512,0.187713,-0.107505,-0.342922,0.456762,-0.125628,-0.249506,0.469894,-0.172774,-1.17029,0.176201,0.234198,0.0251064,-0.360638,-0.359016,-0.680712,0.207677,-0.145078,-0.398875,0.254418,-0.0670915,0.235947,-0.521179,-0.37017,-0.230972,0.550982,0.185964,0.150114,0.110947,0.599401,0.563132,0.0871298,0.364274,-0.578734,0.492314,-0.312245,0.009062,0.6682,-0.383376,0.789334,-0.0630833,0.100617,0.100548,0.399506,-0.0983017,0.982826,0.426267,-0.385088,0.0120905,-0.286121,-0.536609,0.0426038,-0.217944,-0.928166,0.0329514,-0.111981,0.323517,-0.349097,0.0175269,0.245364,-0.158983,-0.0993381,0.492222,-0.210113,0.200132,0.14154,0.244691,0.352035,-0.395327,-0.428346,0.270247,-0.57129,-0.114122,0.140761,-0.202066,0.802068,-0.420247,-0.481103,-0.0204045,-0.490335,0.147444,-0.987444,0.136569,0.14214,0.259788,0.377015,0.509694,-1.91377 +3414.46,0.868622,0.0912059,4,1.65391,1.03882,-0.889783,0.323862,0.749605,-0.201574,-0.195742,0.292129,0.412881,0.349113,-0.0380075,-0.284429,-0.130201,0.362347,-0.236334,0.995216,-0.0977513,-0.391215,-0.0895498,0.02662,-0.407957,-1.26125,-0.948473,0.0298728,-0.0218293,-0.292755,-0.186575,0.275912,-0.826359,-0.0990828,0.608016,-0.866993,0.352975,0.474393,-0.357182,-0.238631,-0.37991,0.178749,0.671612,0.110889,0.728184,0.413329,0.502683,-0.722127,-0.292969,-0.482814,-0.106641,-0.0753969,0.0454656,-0.489939,0.250295,0.468204,-0.242729,-0.0572383,0.5907,0.0679275,-0.127156,-0.96635,0.339718,-0.465279,0.158312,1.26985,-0.895334,-0.728204,0.562995,0.34653,-0.297702,0.0276386,-0.518281,-0.363628,0.173129,-0.133166,0.39952,0.0649103,0.445128,0.346946,0.547003,-0.460565,-0.404559,0.427485,0.807202,-0.662542,0.0371438,-0.242972,-0.257996,-0.319243,-0.209401,0.0162171,-0.264022,-0.136334,-0.042731,-0.564106,-0.338434,0.0251355,0.0141185,0.0509646,0.000546826,-0.233964,-0.0662243,0.406542,0.257419,-0.225922,-0.000178785,-0.512812,0.841561,-1.01052,0.192731,-0.524784,0.558771,0.127445,0.011332,0.0320676,-0.0752923,0.0402941,0.102673,0.0738117,-0.859635,0.103894,0.501964,0.113697,-1.15063,0.273413,0.0869395,-0.645218,-0.0998451,0.133631,-0.0299964,-0.433283,-0.133559,-0.312063,0.219066,-0.32589,-0.0163381,0.324327,-0.393632,-0.226458,-0.10365,-0.403999,0.264086,-0.00149859,-0.190716,-0.0674145,0.191056,-0.664548,-0.261885,0.13402,-0.955538,-0.130922,-0.338095,-0.47611,0.170011,-0.0701376,0.228679,-0.534751,-0.0173629,-0.00188161,-0.148551,-0.267753,0.568657,0.0203907,-0.0367146,0.187584,0.802839,-0.115543,-0.465619,0.0860203,0.0341286,0.132314,-0.698691,0.266041,0.196225,0.640264,-0.537202,0.00838746,0.13837,0.19844,-0.568801,-0.312667,0.0717323,0.698314,0.0405902,0.255971,0.182983,0.0194667,-0.618855,-0.278775,-0.0759285,-0.0666259,0.225211,-0.337785,-0.418378,0.283632,-0.00870358,-0.408095,0.382616,0.0843018,-0.474208,0.0337106,-0.369652,-0.255086,-0.0989868,0.10257,0.605223,-0.398563,-0.23983,-0.825197,-0.769197,0.934018,0.109482,0.183178,-0.147853,-0.142778,0.147051,0.268434,0.351076,0.0477285,-0.616789,-0.119172,0.651561,-0.0223103,-0.169147,-0.307924,0.335323,-0.00466287,-0.101684,0.551766,-0.425955,-0.935289,0.370086,0.42635,-0.0123309,-0.187297,-0.971658,-0.177676,-0.366722,0.129325,0.021572,0.130718,-0.0310993,-0.0609548,-0.0635833,-0.308528,-0.0203568,0.153905,0.104192,0.264957,0.462315,-0.00507713,0.298323,-0.248411,0.120251,-0.448592,0.488802,-0.207103,-0.149378,0.711518,-0.228077,0.907786,-0.132301,-0.0626878,-0.412426,0.377335,0.138409,0.986656,0.141186,-0.349804,-0.236394,-0.712861,-0.455246,-0.100897,-0.153793,-0.757707,0.0120591,-0.0881254,0.051477,-0.52955,0.172259,0.161713,-0.251074,0.183549,0.033227,0.210722,0.499137,-0.270599,0.380233,0.246654,-0.175628,0.093004,-0.113471,-0.830697,-0.174628,0.184187,-0.33363,0.499686,-0.371238,-0.685063,0.0370678,-0.344547,0.357503,-0.772664,-0.336664,0.14512,0.316551,0.380947,0.562629,-2.46043 +3408.88,0.525998,0.0912059,4,1.67802,1.20426,-0.297713,0.0280011,0.181542,-0.184283,0.203407,0.0684057,0.718042,0.316082,-0.212184,-0.682129,-0.116413,0.214346,-0.467805,0.204501,-0.500284,-0.148802,-0.364983,-0.245531,-0.460076,-0.753432,-0.221697,-0.291892,-0.608549,0.0415358,0.141508,0.363848,-0.0462641,0.384002,0.364322,0.325645,0.262858,-0.0838637,-0.653863,-0.0140517,-0.631684,0.667957,0.0956809,-0.50794,0.655574,0.0233778,0.063797,-0.644876,-0.218673,0.134294,-1.38646,0.214662,0.513067,-0.123505,0.0603507,0.131407,0.254639,-1.09808,0.76244,-0.539998,-0.484726,-0.677629,0.0598469,0.0283448,-0.205798,0.820212,-0.866919,-1.13676,-0.292151,0.341425,0.0972169,-0.24443,0.623571,-0.714345,0.388652,0.62608,0.291593,0.225422,0.953614,0.492977,0.0914112,0.122444,-0.784837,-0.311103,0.0839819,-0.407478,0.147557,0.291636,-0.307407,0.536697,0.402418,0.20418,-0.0474263,-0.503772,0.114188,0.086397,0.0859531,0.174169,-0.243119,-0.541632,-0.099099,-0.255075,-0.170577,0.291553,0.382208,0.17723,-0.441454,-0.0975309,-0.352034,0.525367,0.302207,-0.169196,-0.150502,0.464679,-0.576422,-0.168275,0.368447,0.15413,-0.458096,0.050798,0.0732351,-0.347987,-0.884148,-0.354398,-0.458113,0.430632,-0.297624,-0.0632247,0.165574,-0.273294,0.333802,0.408483,0.117943,-0.0644676,0.274645,-0.10032,-0.100491,0.583098,0.101587,0.136136,0.52647,-0.214956,0.462669,-0.751778,-0.321317,-0.156833,0.260287,-0.579081,0.322804,0.0377328,0.364897,0.386959,-0.00728826,-0.407063,-0.644199,-0.0104361,0.481699,-0.0583228,0.495019,0.511618,0.440008,0.0341956,-0.187898,-0.130169,0.128624,-0.0495669,0.85834,0.201009,0.0599985,-0.0628398,-0.500575,-0.0386821,0.183771,-0.0779665,0.0746548,0.0540516,-0.369876,-0.0657904,-0.230138,-0.353431,-0.193541,-0.215822,0.468214,0.213142,0.24266,-0.720773,0.146096,-0.145597,0.470312,-0.0891982,-0.33853,-0.741879,0.300043,-0.54851,-0.0917818,-0.0339051,0.332907,-0.463066,-0.260048,0.503551,0.559669,-0.39581,-0.995051,0.20019,-0.187695,-0.169453,-0.0810941,0.402458,0.328935,0.674539,-0.358372,0.900111,-0.712206,-0.0572528,-0.0683031,0.102911,-0.271806,0.323669,-0.462214,0.102065,-0.224881,0.564535,0.0868061,-0.609407,-0.0472971,-0.540542,-0.479207,0.561523,-0.764893,-0.116301,0.159961,0.124021,-0.172404,-0.537004,0.181121,-0.315582,0.488865,-0.172041,-0.210087,0.359104,-0.1803,0.351516,0.679201,-0.67966,-0.0222565,0.166257,0.372879,0.331278,0.117563,0.139345,0.244666,0.0944809,-0.226152,-0.456359,0.133496,-0.653293,0.417519,-0.00236485,0.358994,-0.17371,-0.0898483,-0.432836,0.0922412,0.147582,0.500137,0.502933,0.358027,-0.611529,0.458921,0.205407,0.409187,0.426782,-0.100328,0.158984,0.270119,-0.0808561,-0.378691,-0.0273,0.225881,0.516931,0.376822,0.002165,0.301153,0.40787,0.278549,-0.317462,-0.129115,0.278152,-0.541464,0.542721,-0.105185,0.464168,0.278647,0.224333,-0.203575,-0.00279099,0.403963,0.138938,0.00828407,-0.697652,-0.209324,0.242033,-0.642943,0.577416,-0.0723858,0.133993,0.222029,0.36605,0.4712,-0.877795 +3405.89,0.659007,0.0912059,4,1.56348,1.18313,-0.446556,0.0217592,0.490476,-0.169953,-0.407513,-0.268735,0.550673,0.539987,-0.12629,-0.511549,0.348205,-0.00926657,-0.0982813,1.08835,-0.0983923,-0.0241535,-0.452263,-0.0891352,-0.612005,-0.698959,-0.681775,-0.209487,-0.594756,0.480571,-0.137199,0.771529,-0.889763,0.0615155,0.324057,-0.240007,0.765578,0.251766,-0.360949,-0.277843,-0.540317,0.590133,0.308402,-0.326821,0.753094,0.519343,0.650959,-0.784619,-0.126285,0.786138,-0.545109,-0.116734,0.692506,-0.143537,-0.204978,-0.0270528,0.125313,-0.0502832,1.09812,-0.337468,-0.174377,-0.757777,0.791276,-0.164883,0.137485,0.682889,-0.755645,-0.776193,0.246969,0.133612,-0.18136,-0.309951,0.289555,-0.233489,0.168281,0.0669622,0.434189,0.0867809,0.687447,0.570725,0.583752,-0.124437,-0.166617,-0.655451,0.12535,-0.0380442,0.106911,0.441879,-0.227714,0.0885289,-0.0460852,0.629197,-0.0278443,-0.400154,-0.10209,0.100742,-0.124214,-0.193867,-0.146976,-0.224995,-0.253566,0.189318,0.317475,0.412045,0.159476,-0.231352,0.0821019,-0.272441,-0.315279,-0.502841,0.618635,-0.48231,-0.0157725,0.495169,-0.756438,0.360944,0.0203496,0.000990461,0.00748311,0.211993,-0.797181,0.256278,-0.573656,-0.143312,0.0335711,0.0970029,-0.453547,0.433876,0.00493834,0.251569,0.263653,0.011751,0.159819,-0.0897312,0.317021,0.157619,-0.495835,0.393549,-0.178347,-0.385177,0.115597,0.102417,0.256298,-0.570328,-0.374345,-0.203812,0.556258,-0.220596,0.190577,-0.183975,-0.0154945,-0.355878,0.121538,-0.339566,-0.953857,0.00385845,0.540234,0.439948,0.364931,0.349464,0.0306328,-0.491765,0.256848,0.346137,0.403717,-0.0820558,0.527674,-0.301742,0.538666,0.29223,-0.418268,-0.00659182,-0.0314448,0.500022,-0.245875,-0.635738,-0.302489,-0.132499,0.0880224,0.347399,-0.0275204,-0.265271,0.606634,0.808509,0.436232,-0.17115,0.264158,0.177817,-0.0221908,-0.305271,-0.462588,0.0615277,0.42167,0.00643199,-0.385209,0.340529,0.189654,-0.583577,0.072275,-0.0313928,-0.189916,-0.405787,-0.908375,0.191386,-0.223446,-0.488857,-0.152064,0.188788,-0.368701,0.183157,-1.01529,1.11726,-0.0254483,0.0119787,-0.160576,-0.350492,0.655822,0.09949,-0.278707,0.00289254,-0.254697,-0.328769,0.457274,0.421406,0.291397,-0.512493,-0.218254,-0.189137,-1.02373,0.149734,-0.0103184,-0.378596,0.3592,0.311043,0.318727,-0.236399,-0.185479,-0.440511,-0.491095,0.00694599,0.0605665,-0.11018,0.378483,-0.208844,0.18596,-0.136467,0.306615,0.948122,0.414473,-0.221547,0.00062321,0.522138,-0.390525,-0.280519,-0.24525,-0.506192,0.609092,-0.0273543,-0.527568,-0.19472,-0.2627,0.192067,-0.0749187,-0.0763239,0.321352,-0.0424516,0.138863,-0.0964432,0.0649113,-0.374753,0.264019,-0.431009,-0.00171631,-0.00603782,0.249437,-0.211877,-0.616377,0.223146,0.153483,0.280896,0.506933,-0.182109,0.571536,-0.0354741,-0.0160934,-0.114926,-0.601984,0.0214824,-0.109823,0.450861,-0.331425,0.421982,-0.396878,-0.409907,-0.254481,0.487396,-0.0470291,-0.0215646,-0.110197,-0.996663,-0.450175,0.32715,-0.243727,0.262008,0.320011,0.140805,0.233632,0.37524,0.483355,-1.90003 +3415.41,0.523464,0.0912059,5,1.60609,0.919087,-0.923749,0.242889,0.72109,-0.035964,0.0271316,-0.0275787,0.595708,0.425546,-0.0398463,-0.751579,-0.573909,0.0626841,-0.51716,0.420038,-0.219842,-0.480937,0.00773191,-0.381296,-0.36211,-0.689778,-0.216685,0.0333986,-0.470575,-0.12994,0.0728871,0.266429,-0.528826,0.812741,0.366147,-0.67739,0.0709281,0.258429,-0.137652,-0.173824,0.0374392,0.581381,0.267978,-0.0333284,0.867145,0.43093,-0.229365,0.0254559,0.281691,0.0520745,-0.0601042,0.0931454,0.743278,0.215837,-0.218048,0.326206,0.00660622,-0.163552,1.03785,-0.320718,0.0398814,-0.446158,0.596257,-0.258841,0.214521,0.890349,-0.913233,-1.31627,-0.436323,0.338593,-0.475592,-0.0976369,-0.128684,-0.667639,-0.30166,0.800424,0.439931,-0.0855368,0.48571,0.434842,0.361173,0.352785,-0.133896,0.230402,0.198539,-0.792403,0.15889,0.11076,-0.3252,0.0337094,0.504439,-0.0625963,-0.216167,0.024237,0.14873,0.0873139,-0.135724,0.345081,0.171677,-0.247554,0.367403,-0.305051,-0.116274,0.315409,0.0399999,0.203708,-0.456304,-0.537348,0.000462317,0.262766,0.263781,-0.631574,0.220384,1.04718,0.410073,0.0814713,0.047656,0.25929,0.462584,-0.322237,-0.283327,-0.429107,0.401306,-0.100541,-0.665405,0.0798116,0.30857,-0.104562,0.576968,0.286749,-0.346317,-0.537323,0.0947583,-0.408644,0.0989791,-0.303337,0.257415,0.797167,-0.308216,0.149678,0.143573,-0.455476,0.212214,-1.03862,-0.733655,0.0819888,-0.128707,-0.811321,0.220679,0.422692,0.348166,0.0875797,0.222071,0.0948733,0.552228,-0.0509358,0.3455,-0.324024,0.0153153,0.26075,0.633727,-0.158209,0.207389,-0.362265,0.386628,-0.922642,0.579085,0.209751,-0.384289,0.352557,-0.202874,0.185344,-0.0247338,-0.485695,0.389645,-0.32183,-0.346449,0.361531,-0.443652,-0.172508,-0.434585,-0.00808368,-0.0682125,0.938971,0.194191,-0.830933,-0.417728,0.476728,0.0148341,-0.379735,-0.0074711,-0.38528,0.855271,-0.182582,-0.209587,0.193028,0.370263,-0.80432,0.436305,0.621768,0.162631,-0.091346,-0.693484,-0.176542,-0.289489,-0.454372,0.126629,-0.342314,0.0955781,-0.128704,-0.443443,1.18273,-0.039553,0.00738845,0.1524,-0.0254682,-0.249263,0.117934,-0.790333,-0.0133796,-0.240062,0.678563,-0.203525,-0.942431,-0.589191,-0.387889,0.2366,-0.156179,-0.383448,0.148949,-0.396367,0.380532,0.112394,-0.0938354,-0.530227,-0.154597,-0.425096,0.214545,-0.315109,0.275085,0.0927427,0.198965,0.521161,0.0922253,-0.214484,0.0846014,-0.0325995,-0.119167,0.409004,-0.165096,0.33461,0.196406,-0.4324,-0.399684,0.169336,-1.04133,0.210833,-0.167313,0.709697,0.502523,-0.495381,-0.168207,0.0897182,0.0928218,0.258789,0.212446,0.368053,0.421281,0.448338,-0.816056,0.19111,0.224207,-0.507195,-0.0225363,-0.227575,0.0946485,-0.758203,-0.427526,0.535502,0.37829,-0.00177144,-0.128458,-0.306615,0.038965,0.0631661,-0.215829,-0.0336435,0.366761,-0.230439,0.359558,0.391064,-0.406434,0.291208,0.473889,-0.219399,-0.172639,0.0204918,0.261324,-0.160173,-0.94409,0.660182,-0.118106,-0.178333,0.212517,-0.0809282,0.164741,0.245647,0.405883,0.495628,-2.14868 +3392.29,0.757548,0.0912059,4,1.46617,0.964061,-0.327786,-0.0210638,0.790802,-0.0698974,-0.0450577,0.599632,0.547686,0.481448,0.0727268,-0.241575,-0.188622,0.533977,-0.364769,0.75058,0.0612206,-0.0248525,-0.675362,-0.14816,-0.0570026,-0.397211,-0.702537,0.0804075,0.0403005,0.462733,-0.271738,0.887528,-0.687,0.0625918,0.408356,-0.692208,0.542046,0.0501139,-0.210856,0.236667,-0.381554,0.380045,0.159697,-0.211894,0.723589,0.686237,0.922385,0.0337875,0.160304,-0.0627777,-0.365025,0.100234,0.455373,-0.247056,-0.468267,0.36287,0.18964,-0.396417,1.57616,-0.707652,0.0450519,-0.500711,0.936898,-0.291597,-0.0494048,0.765853,-0.560121,-0.597489,-0.110453,0.175206,-0.355396,0.459034,-0.272601,-0.732991,-0.0607031,0.0958812,0.316761,-0.333065,0.484063,0.433473,0.584825,-0.109299,0.000771806,0.0641014,-0.0600334,-0.435979,0.501688,0.0830355,0.0409974,-0.326448,-0.386516,0.0112666,-0.0645502,0.123062,-0.348513,0.0675169,0.792483,0.414095,0.395078,-0.577057,0.0894553,-0.18427,0.0135134,0.542257,-0.239627,-0.398519,-0.614651,-0.428417,-0.126749,-0.415786,-0.0866278,0.365893,0.473428,1.12575,-0.161481,-0.145652,0.324672,0.0370571,0.71428,-0.178796,-0.160477,0.147093,0.428201,-0.25328,-0.628773,0.305178,-0.535098,-1.00121,-0.163663,-0.0816081,-0.0463498,-0.341427,0.343823,-0.202477,0.129717,0.120701,-0.0937885,1.055,-0.421737,0.0591678,0.967668,-0.278045,0.206919,-0.602575,-0.871256,-0.248922,-0.283167,-0.694681,-0.0383167,-0.227615,0.104999,0.180494,0.203673,0.0095837,-0.29408,0.379921,0.719817,0.146323,0.547984,0.628862,0.603657,-0.134699,0.411109,-0.23207,0.518168,-0.522502,0.580787,-0.291787,0.0469346,0.135883,-0.156713,0.25245,0.667001,0.121616,0.438597,-0.607991,-0.291498,0.480028,-0.134644,-0.478081,-0.207642,-0.381833,-0.20767,1.00581,-0.470892,-0.132559,0.0837311,0.42175,-0.695177,0.197134,-0.709306,0.0681,0.565268,0.796289,-0.314149,0.405988,0.0101461,0.160008,0.436917,0.569621,0.0510452,-0.221046,-0.777508,-0.416497,0.0447217,-0.18571,0.47844,0.04771,-0.374116,-0.567864,-0.482801,1.23433,0.389164,-0.26493,-0.0795386,-0.237299,-0.184078,-0.0260141,-0.848601,0.752291,-0.0848123,0.351052,-0.251549,-0.816783,-0.191397,-0.471834,0.00811556,-0.25931,0.0639417,0.402879,-0.541046,0.0279938,-0.254759,-0.0838009,-0.467024,-0.0885111,-0.0987987,-0.18968,-0.21335,0.491413,-0.214322,0.708975,0.764819,0.0798463,0.148529,-0.078893,-0.0310801,0.220347,0.593469,-0.0716007,0.705303,0.017922,-0.380927,-0.428176,0.226736,-0.86302,0.779357,-0.0137133,-0.28536,0.427164,-0.599905,-0.373343,0.421566,0.0235163,-0.109544,0.394005,0.412121,0.0974488,0.268814,-0.264467,0.100405,-0.733227,-0.217176,0.336691,0.187434,-0.119848,-0.000635396,-0.0745124,0.444939,0.236073,0.0165534,0.104006,-0.440826,0.205402,-0.175752,-0.483257,-0.0214339,-0.415526,-0.433832,0.429179,0.279046,0.154353,0.0442161,0.0684926,-0.419298,0.845001,0.505166,0.0417564,0.0465663,-0.340842,0.655307,-0.104616,0.138154,-0.274309,0.73356,0.162364,0.20946,0.402944,0.457668,-2.65386 +3386.62,0.947521,0.0912059,4,1.49642,0.861028,-1.19038,0.438467,1.05534,-0.136089,0.0371925,-0.261456,0.131943,0.0433919,0.0992078,-0.430301,-0.0795207,0.653435,0.112699,0.483896,0.0457252,-0.0487854,0.292945,-0.0243562,0.00303638,-0.859022,-0.287628,0.250743,-0.444612,-0.130594,0.373898,0.175022,-0.0137926,0.582934,0.323342,-0.356724,-9.56771e-05,0.137799,0.0974741,-0.336323,-0.166442,0.585567,0.943059,0.0963671,0.864868,0.531803,-0.313379,-0.58987,-0.385766,0.166798,-0.374517,-0.123179,0.591907,0.195267,-0.351122,0.520094,0.00284635,-0.420097,1.08389,-0.168124,-0.214773,-0.37583,0.892747,0.0974482,0.307744,0.969552,-0.311701,-1.15185,-0.122355,0.109322,0.147687,0.0740213,0.177773,-0.157326,0.0268655,0.73602,0.215542,-0.0476433,0.939633,0.688407,0.329705,0.138109,-0.70573,-0.12305,0.517723,0.0809307,-0.253605,0.0852935,0.0964815,0.121743,0.298006,-0.209295,0.149053,-0.253836,-0.470905,-0.0730808,-0.165941,-0.124381,-0.513621,-0.480245,0.259124,-0.0771974,-0.111465,0.466703,-0.429408,-0.062567,0.0540171,0.129017,0.551997,-0.344435,0.00444421,-0.991464,0.433133,0.610998,-0.210731,-0.0218988,0.38639,0.170165,-0.0928487,0.41543,-1.05431,-0.0846118,-0.654014,0.0852435,-0.720081,-0.280723,0.6512,0.34995,0.151145,-0.0306899,0.363857,0.236307,0.389629,-0.0243098,-0.790363,-0.747314,-0.598474,-0.0901611,0.282993,-0.555541,-0.204585,0.00393449,0.405832,-0.0594952,-0.255705,0.0860227,0.139588,-0.615889,0.186633,0.129957,0.0432755,0.247923,0.228598,-0.133117,-0.376127,0.357474,-0.0710628,-0.304414,0.429159,-0.03358,-0.140829,0.0372885,0.109586,-0.572626,-0.738462,0.0614141,1.0053,0.0758266,0.11972,0.366206,-0.13891,-0.138637,-0.0717473,-0.499232,-0.0303488,0.63615,-0.624223,-0.0529855,0.152375,-0.436046,-0.165462,-0.455608,0.308969,0.699635,0.456073,-0.787665,-0.041874,-0.258789,0.624633,-0.584067,-0.0639161,-0.148284,0.197257,-1.05883,-0.261273,-0.259624,0.333212,-0.956641,0.0318196,0.328567,-0.0939126,-0.353212,-0.390906,-0.160971,-0.232264,-0.0398979,-0.426134,-0.311587,0.17985,-0.716684,-0.933604,1.38077,0.131478,0.665665,0.544697,0.304574,0.336794,0.234346,0.293821,-0.139087,-0.385823,0.238845,0.654776,-0.2234,0.403175,-0.118316,0.40923,0.793486,-0.913298,0.0736167,0.209491,0.0404366,0.0542066,0.138588,0.121397,-0.416123,-0.11273,-0.0843727,-0.715075,0.379958,-0.567094,-0.706429,0.479508,0.0893578,-0.417031,0.426426,0.0616871,-0.390063,0.0030527,0.14276,0.377217,0.311793,0.106145,-0.826336,-0.353827,0.29136,0.157867,-0.739763,0.242258,-0.715292,-0.0491876,0.249582,-0.359746,-0.0741043,0.070395,-0.24613,-0.0395143,0.350981,0.482966,0.32071,0.553672,0.185961,0.373208,0.0701171,-0.296848,-0.533324,-0.308236,-0.268362,0.0676438,-0.484193,0.468352,-0.0972763,1.02496,0.0622155,0.0959698,-0.10676,-0.362166,0.510656,0.277274,0.418217,0.0881092,0.576902,0.383618,0.269425,-0.260299,-0.285695,0.218944,-0.301927,-0.545696,-0.760575,-0.324065,0.355919,-0.474864,0.0162997,-0.485082,0.162828,0.187292,0.40352,0.432773,-3.28569 +3383.87,0.980023,0.0912059,4,1.50169,0.88373,-1.13807,0.401316,0.809431,-0.0858002,-0.161457,-0.112424,0.149542,0.200461,0.0342439,-0.351164,0.0594555,0.8545,0.0726285,0.507616,0.0242791,-0.0205174,0.185153,-0.12578,-0.102937,-0.866417,-0.357949,0.267865,-0.481329,0.0126113,0.12423,0.360963,-0.0743208,0.37044,0.358276,-0.291579,0.221315,0.0905102,-0.0802202,-0.282123,-0.0391225,0.551977,1.10081,0.215328,0.943706,0.55814,-0.219548,-0.483635,-0.126954,-0.285757,-0.59005,-0.105791,0.713149,0.301525,-0.226995,0.371917,0.00282489,-0.474195,1.03229,-0.379117,-0.316572,-0.259521,0.54766,0.122682,0.41648,1.16667,-0.185669,-0.819881,0.0101219,0.514906,0.420533,-0.0211715,0.0620527,-0.0864908,-0.0600083,0.672612,0.283156,-0.131508,0.966847,0.624055,0.580738,0.329427,-0.550453,-0.228297,0.755118,0.0841151,-0.0970429,-0.155771,-0.144922,-0.214271,0.129898,-0.224131,0.110414,-0.131829,-0.112968,-0.149526,0.00308637,0.0687613,-0.528202,-0.399711,0.241758,-0.268917,-0.0160881,0.540611,-0.570393,0.281308,-0.149762,0.0784316,0.315415,-0.140756,0.0214427,-1.18777,0.259602,0.408164,0.0669532,0.117633,0.154987,0.0414899,-0.213491,0.309352,-1.08549,-0.0856682,-0.284712,-0.148617,-0.892941,-0.0887146,1.14284,0.074012,-0.0447856,-0.0672836,0.392668,0.224747,0.333036,-0.124047,-0.82203,-0.742719,-0.676831,-0.167117,0.170521,-0.507419,-0.126706,-0.0378525,0.314609,-0.0469731,-0.0699762,-0.136203,0.226186,-0.559277,0.105252,-0.0901839,0.155244,0.2728,0.263979,0.0550506,-0.359378,0.173329,-0.0789922,-0.295339,0.768507,0.0225801,0.242533,0.0832946,0.0330252,-0.485839,-0.797975,0.444283,0.878147,0.167332,0.269957,0.360335,-0.231554,-0.186452,-0.184273,-0.179238,-0.14698,0.562321,-0.453277,-0.170711,0.09345,-0.435712,-0.213343,-0.67975,0.285983,0.78215,0.260792,-0.834699,-0.0501325,-0.0910436,0.562916,-0.925571,-0.196,-0.181235,0.491829,-1.07942,-0.205608,-0.222609,0.624451,-0.994932,0.0957458,0.284092,-0.0314641,-0.513496,-0.474402,0.0116252,-0.312115,0.172712,-0.280014,-0.107557,-0.0599976,-0.487466,-0.971266,1.31339,0.15627,0.665627,0.315092,0.350989,0.194378,0.145498,0.0132741,-0.117849,-0.354966,0.434575,0.746584,-0.328984,0.390078,-0.2408,0.631036,1.04344,-0.725349,0.290901,0.38311,0.0630719,-0.10829,0.297556,0.14115,-0.345642,-0.213789,-0.124438,-0.446222,0.549846,-0.663524,-0.717177,0.373618,0.152801,-0.522628,0.614027,0.211908,-0.477671,0.235846,0.162298,0.451648,0.451374,-0.00509013,-0.939785,-0.485586,0.407739,0.0325062,-0.652722,0.0580531,-0.384498,0.00289933,0.389308,-0.370174,-0.0627838,0.267603,-0.345703,-0.0408989,0.442986,0.512997,0.144108,0.504818,-0.181151,0.623196,0.200497,-0.26039,-0.424075,-0.445751,-0.27801,0.131654,-0.595991,0.610292,-0.124922,0.898526,-0.257126,0.0485755,0.0650901,-0.365606,0.349863,0.259446,0.13968,0.23187,0.576182,0.330089,-0.0138008,-0.295191,-0.299309,0.262131,-0.360371,-0.565157,-0.47364,-0.275318,-0.00473901,-0.413392,-0.20852,-0.498449,0.186256,0.233159,0.431574,0.482865,-2.50901 +3369.04,0.902737,0.0912059,4,1.44941,0.801339,-1.44049,0.556845,0.835534,-0.0959699,0.0911831,-0.0512849,-0.094454,-0.174293,-0.00456231,-0.301839,0.17513,0.58506,-0.469327,0.453055,0.233249,0.0244984,-0.142015,0.328819,-0.146778,-1.09429,-0.469785,0.500484,-0.228159,-0.145465,0.176135,0.517542,0.12885,0.108769,0.385021,-0.528211,-0.0434675,0.422039,-0.131128,0.223677,-0.191086,0.500765,0.61318,0.0598125,0.827515,0.917986,1.00872,-0.755755,-0.0966373,-0.389679,-0.641788,0.181885,0.302197,-0.132814,0.189042,0.837653,0.313779,-0.180915,0.712226,0.646187,-0.0352729,-0.126933,0.616772,-0.228346,0.664914,0.737865,-0.406841,-1.41204,0.63362,0.567898,0.09975,0.529858,0.752223,-0.388366,0.503017,0.166599,0.0253088,0.122961,1.23402,0.159399,0.764448,-0.548408,-0.251054,-0.189261,0.813404,-0.753434,0.0508462,-0.375246,-0.408701,0.197329,0.0689904,-0.892072,0.0533553,0.361836,0.427384,0.0730619,-0.228518,0.361822,-1.06656,-0.364774,-0.188397,-0.691866,-0.0663902,0.445003,0.4129,0.435045,-0.105221,0.0737026,0.559125,0.00192555,0.347378,-0.982207,0.747638,0.903375,-0.416292,-0.16092,-0.068615,0.332079,-0.513235,0.0941683,-0.855423,-0.113011,0.236691,-0.498429,-0.53353,0.255947,0.774177,0.146992,0.00518497,0.504474,0.669168,0.308554,0.549518,-0.303884,-0.681388,0.141371,-0.442736,0.551218,0.0572729,-0.579598,0.0243411,-0.400085,0.623488,-0.228321,-0.757539,-0.491999,0.0309064,-0.0904454,-0.643577,0.0216529,-0.374731,0.10531,0.264967,0.00258022,-0.0203165,0.289947,0.162895,-0.234089,0.0203979,0.93219,-0.0899017,0.249435,0.368538,-0.470855,-0.584356,-0.392777,1.08423,1.17407,0.18547,1.0562,0.220004,0.0974757,0.00516102,-0.110461,0.75794,0.57097,-0.0492945,-0.482561,-0.238843,0.0553511,-0.0951934,-0.414108,-0.417267,1.15104,0.298373,0.202969,0.140098,-0.331459,0.094773,-0.435037,-0.241612,-0.83975,-0.0528294,-0.260763,-0.567196,-0.0702747,0.0461353,-0.161038,0.138427,0.164068,-0.266799,-0.119568,-0.422851,-0.235797,-0.157113,-0.0517541,0.350002,-0.243925,0.592597,-0.559409,-0.707282,1.18494,0.0601423,-0.0733533,0.387174,-0.637601,0.131155,0.0291707,0.354011,0.398733,-0.0799767,0.241841,0.197667,-0.796169,0.16624,-0.00873965,0.513048,0.581622,-0.608161,0.32674,-0.558456,-0.0126275,-0.974776,0.0248835,-0.267212,0.0898496,0.096874,-0.147595,-0.617259,0.576577,-0.107733,0.0837998,0.960145,-0.403081,-0.778434,0.299404,-0.40156,-0.321469,0.328435,-0.28038,0.831781,0.693809,0.065342,-0.665737,0.152375,-0.533112,0.1878,0.0193268,-0.659438,0.512639,-0.289412,0.161557,-0.344587,0.236119,0.0039656,0.391635,0.168953,0.0232471,-0.265274,-0.146012,0.343925,-0.588348,0.531251,0.206409,-0.0553548,-0.555115,-0.376714,0.524336,-0.328663,-0.287957,-0.361784,0.00956604,0.643581,-0.111597,-0.445167,-0.115811,-0.518569,-0.0945831,0.0390602,0.372922,-0.333414,0.607006,0.134168,0.161144,-0.0871986,-0.215937,0.465119,-0.558828,-0.25885,0.00633764,0.411493,-0.390807,-0.596079,0.382394,-0.288848,0.197743,0.290877,0.444683,0.53933,-2.48835 +3385.04,0.99436,0.0912059,4,1.40332,0.918229,-1.21406,0.412594,0.352159,-0.0959411,-0.0354667,0.123979,0.0464102,-0.159502,0.0665506,-0.250093,0.0225245,0.809498,-0.00598063,0.380469,0.30671,0.113927,0.105465,-0.268932,-0.270122,-1.05336,-1.00758,0.269296,0.311053,0.117218,0.111187,0.663356,0.0795725,0.0773326,0.515913,-0.578078,0.19487,0.184145,-0.051771,0.440458,0.212158,1.1861,0.421515,-0.00769213,1.28338,0.880321,0.999689,-0.542151,-0.150691,-0.290039,-1.00102,0.272908,0.556715,0.038999,-0.150874,0.952613,0.0182336,-0.676849,0.610509,0.160588,0.0259026,-0.380425,0.62381,-0.606878,0.908259,0.942904,-0.603082,-0.874261,0.427534,0.278032,0.234147,-0.283994,0.72883,-0.19909,0.330251,-0.0599644,0.281114,0.0758417,0.720598,0.225124,0.651522,-0.303091,-0.22964,-0.0646663,0.482338,-0.61417,0.123929,-0.0789221,-0.638545,0.165782,0.591673,-0.789106,0.0555421,0.250169,0.216261,0.308961,-0.158183,0.21516,-0.976123,-0.578203,-0.234986,-0.727256,-0.217999,0.279038,0.0125306,0.102813,-0.0742776,-0.664007,0.872495,0.201331,0.403189,-0.895114,1.00381,0.736636,-0.365778,-0.435762,-0.144133,0.234254,-0.549048,-0.102162,-0.923384,-0.247959,0.323368,-0.604954,-0.544807,0.280818,0.516964,-0.146554,-0.183849,0.370405,0.322026,0.43135,0.327673,-0.0914315,0.013628,-0.0496191,0.179114,0.702751,-0.216608,-0.338641,-0.265554,-0.490233,0.36435,-0.383523,-0.578813,-0.331865,-0.517219,-0.0888742,-0.239954,-0.100423,-0.0834912,0.414459,-0.101454,-0.0197221,0.0474656,0.031564,0.0516809,-0.137628,-0.323257,0.155826,-0.0629785,0.23009,0.317962,-0.404422,-0.704293,-0.402963,0.897702,0.611502,0.0735096,0.748198,0.142143,-0.190174,-0.0713042,-0.141927,0.724398,0.649893,-0.0167799,-0.315712,-0.27067,0.16459,-0.291542,0.0946857,-0.141901,0.908357,0.345991,-0.0406929,-0.138472,-0.0181729,-0.0360368,-0.438201,0.0768374,-0.854326,0.448821,-0.230583,-0.359254,-0.353848,-0.0716039,-0.162902,0.331275,0.255344,-0.343119,-0.36949,-1.11973,-0.186273,-0.208705,0.255994,0.45959,-0.111734,0.219296,-0.357747,-0.261338,1.42464,-0.0876344,-0.172272,0.265753,0.037587,-0.18924,0.259783,-0.0778591,0.0403325,0.00255194,0.252686,0.210028,-0.841337,0.618072,-0.0446335,0.937241,1.23032,-0.902464,0.337216,-0.22872,0.0570897,-0.886097,-0.0350359,-0.087118,-0.0420549,-0.102328,-0.0492816,-1.12974,0.30028,-0.285335,-0.226651,0.872544,0.0608197,-0.615885,0.411823,0.00863334,-0.64832,0.575156,-0.0830546,0.652766,0.225413,0.00207137,-0.744439,-0.00719314,-0.459951,0.387245,-0.134194,-0.415564,0.244982,-0.0592287,0.0158744,0.0965213,-0.0699106,-0.38347,0.0260401,-0.272208,0.0583082,-0.0226644,-0.0512588,0.409936,-0.787003,0.305729,0.455509,-0.249058,-0.864331,-0.575468,0.239703,0.147481,0.140114,-0.0759713,-0.290204,0.751136,0.266302,-0.324553,-0.0509612,-0.296762,0.0919755,-0.400776,-0.0699148,-0.0560565,0.501644,0.0490897,-0.0458967,0.0128609,-0.206097,0.212763,-0.235031,-0.108453,-0.00516043,0.0668878,-0.145514,-0.514656,0.349515,-0.018902,0.208285,0.27312,0.456383,0.522608,-1.11857 +3388,0.992199,0.0912059,4,1.44167,0.862788,-1.13246,0.369503,0.616237,-0.0192388,0.0166365,0.197379,0.156517,-0.450048,-0.0419007,-0.421325,0.235206,0.486209,-0.0314206,0.651176,0.23795,-0.0253093,-0.182119,-0.0435034,-0.208758,-0.921457,-1.13817,0.371185,0.486302,0.215878,0.0319495,0.595091,0.00255367,0.152911,0.35523,-0.370053,-0.228061,-0.00144286,0.0827688,0.0950262,0.0810667,1.14921,0.703448,-0.381827,1.1204,0.947596,0.598848,-0.592183,-0.0249137,-0.363506,-1.12815,0.223528,0.732065,0.148155,0.152137,0.732471,0.105861,-0.483604,0.80253,0.396135,-0.146911,-0.169467,0.740071,-0.646305,0.812368,0.84988,-0.356062,-1.30887,0.268721,0.479149,0.390826,-0.359867,1.1962,-0.258369,0.150479,-0.255284,0.302893,-0.0741405,0.697921,0.569844,0.652062,-0.606231,-0.361323,-0.0823679,0.375248,-0.152452,0.19411,-0.242793,-0.503185,-0.253409,0.355593,-0.607205,0.122035,0.00344774,0.405738,0.212721,0.106961,-0.211204,-0.469631,-0.561823,-0.493937,-0.829586,-0.515926,0.520839,0.0635234,-0.157772,-0.586506,-0.322713,0.463316,0.367593,0.758294,-0.798095,0.60425,0.872999,-0.560963,-0.293467,-0.0416979,0.529434,-0.641467,-0.0603068,-0.742625,-0.130363,0.443819,-0.589039,-0.285152,0.667602,0.401555,0.265323,-0.0867639,0.362774,0.572346,0.0530197,0.537628,0.0516923,0.145779,0.105977,0.337883,0.517517,-0.393527,-0.00551294,-0.281961,-0.306976,0.554042,-0.593613,-0.163865,-0.0091617,-0.382527,-0.178122,-0.453015,-0.207207,0.0319507,0.481102,0.0537872,0.284665,-0.341591,0.0830018,-0.540152,-0.269036,-0.515543,0.506165,0.0445302,-0.0544445,0.491145,-0.071125,-0.108322,-0.522183,0.685164,0.611072,0.664874,0.691738,-0.34543,-0.495556,-0.27408,-0.19842,0.768413,0.335472,-0.0311112,-0.0567635,-0.411013,0.135855,-0.438212,0.324437,0.132734,0.91509,-0.0186167,-0.00747423,0.124017,-0.153133,0.321595,-0.128574,0.178305,-0.903252,0.312125,-0.31796,-0.363853,0.368525,-0.141111,-0.15386,0.416496,0.29595,-0.386948,-0.150192,-0.76909,-0.0328159,-0.0122305,0.158113,0.239073,-0.340601,0.267457,-0.24586,-0.222818,1.35382,0.19791,0.0811356,0.495067,0.0170474,0.18848,0.098456,-0.463004,0.0269463,0.0624332,0.00698179,0.223779,-0.407657,0.355172,0.0811239,0.760733,0.729013,-0.669584,0.532708,-0.354795,0.103192,-0.933786,-0.0799915,-0.216247,-0.0920699,0.277395,-0.0889268,-0.652471,0.528078,0.111645,-0.300189,0.626303,-0.339935,-0.247195,0.755981,-0.212295,-0.577622,0.706217,0.215965,0.580604,-0.0747299,0.531023,-0.766622,-0.153226,-0.589013,0.23713,-0.0744974,-0.191577,-0.0343289,0.0743505,-0.217418,-0.0733144,-0.0315642,-0.800224,-0.0998061,-0.0271144,-0.00550812,-0.0600582,-0.0102095,0.276875,-0.51446,0.201302,0.600042,-0.47893,-0.681088,-0.504142,0.713596,-0.0815136,0.0256194,-0.180731,-0.388279,0.443356,-0.120795,-0.123828,-0.318478,-0.402381,0.562228,-0.0880935,0.213316,-0.113929,0.773237,0.2227,-0.124829,-0.0770526,0.295118,0.293361,-0.198722,0.118251,-0.0637366,0.11552,-0.135478,-0.186971,0.315228,-0.217942,0.15256,0.326443,0.390589,0.571352,-1.88007 +3408.26,0.997034,0.0912059,4,1.49199,0.974628,-1.46711,0.565321,0.731324,0.00114273,0.0357636,0.136553,0.571936,-0.439814,0.328062,0.105873,-0.277061,0.445039,-0.165464,0.661181,-0.261136,-0.211555,0.234123,0.249072,-0.277284,-0.626434,-0.476206,0.127187,-0.29185,-0.473791,0.299657,0.557991,-0.280528,0.139882,0.552928,-0.519319,0.254011,0.135433,-0.233029,0.0912789,0.405717,0.935628,1.01617,-0.229906,0.767734,0.850887,0.654894,-0.472791,-0.522753,0.144668,-0.140472,-0.332257,0.796144,-0.073553,-0.469377,1.08479,0.0685826,-1.16124,0.426612,0.00399485,-0.000560589,-0.582425,0.310458,-0.369867,0.698616,1.43379,-0.486704,-0.931616,0.224598,0.436597,-0.0804045,-0.139702,0.608655,-0.936827,-0.126663,0.511124,0.613503,0.0590993,0.975231,0.788106,0.664607,-0.00498717,-0.43738,-0.0436853,0.740551,0.0605877,0.0538033,-0.513228,-0.803741,-0.0453246,-0.325895,-0.406459,-0.250067,-0.148042,-0.277415,0.309835,-0.118211,-0.0539939,-0.402287,-0.684831,-0.125775,-0.621991,-0.0266997,0.483722,-0.154486,-0.183559,-0.565003,-0.31554,1.20927,0.17126,0.0450788,-0.29666,0.640086,0.787784,0.0823561,0.295461,0.410845,0.0898685,-0.151087,-0.0904056,-0.239555,0.220198,0.437308,-0.545249,-0.507609,0.348183,0.133154,-0.152924,-0.0591404,0.115499,0.240311,0.647089,-0.122434,-0.0296097,-0.103727,-0.572181,-0.104668,0.832834,-0.598008,-0.303243,-0.172489,-0.0902133,0.238257,-0.484434,-0.533409,-0.125997,0.367023,0.0758546,-0.384784,-0.00813622,0.531791,0.315059,-0.165809,-0.467849,-0.315954,0.435803,0.097209,0.242751,-0.178907,0.116278,-0.257004,-0.291671,0.0696002,-0.220955,-0.258863,-0.163752,1.40796,0.347957,0.00485111,0.388103,-0.494206,-0.0656795,0.300559,-0.6242,-0.144392,0.073567,-0.174779,0.013591,0.167135,-0.249995,-0.19717,0.407691,-0.266062,0.516041,0.14363,0.79667,0.704412,-0.177526,-0.190561,-0.375508,0.202281,-0.697264,-0.233589,-0.683058,-0.124527,-0.333251,0.516397,-0.508528,-0.205737,-0.0709924,-0.211704,-0.150028,-0.625975,-0.00814885,-0.461444,-0.640695,0.210416,-0.285299,-0.0314359,0.179092,-0.143979,1.23622,-0.51411,0.540115,0.0198459,-0.130011,0.368335,-0.338275,-0.793655,0.684543,-0.35933,0.19739,0.105152,-0.599016,0.130309,-0.532427,0.770388,0.338413,-0.42935,-0.457647,-0.190069,0.396473,-0.545459,0.274931,-0.77762,0.00990666,-0.275555,-0.363977,-0.237237,0.140619,0.148944,0.20833,0.405846,-0.637619,0.564801,0.0331509,-0.317603,0.121384,0.17434,0.101387,0.000337992,0.0424332,-0.332701,-0.355843,-0.0616904,-0.83429,0.283716,-0.375294,-0.225661,0.146205,-0.733382,0.162262,0.233293,-0.001259,0.21247,0.524016,0.183551,-0.303161,-0.133539,-0.210018,-0.00837572,-0.578608,0.51306,0.0277049,-0.908511,-0.190278,-0.52752,0.0262926,0.12311,0.240758,0.476094,-0.106025,0.419264,-0.0972367,-0.00495028,-0.271831,-0.118787,0.23298,-0.569715,0.45338,0.0339711,-0.569878,0.0672756,-0.331326,-0.218656,0.248581,-0.0563634,0.19684,-0.39644,-0.492385,-0.0285312,-0.072604,-0.257489,0.183542,-0.14475,0.186978,0.313829,0.43241,0.560204,-2.42452 +3429.59,0.814838,0.0912059,5,1.54789,0.908319,-0.828834,0.175584,0.290184,-0.0413375,0.083487,0.0688581,0.130709,0.146277,-0.253037,-0.0379479,-0.387422,0.324894,0.022188,0.391184,-0.160815,0.107187,-0.306915,-0.0388622,-0.288061,-1.04962,-1.21736,0.318616,-0.425705,-0.590267,0.0968853,0.312844,-0.351394,0.0365118,0.472122,-0.10428,0.211088,0.278276,-0.141954,-0.0201599,0.227362,0.845018,0.841006,0.189159,0.958645,0.598574,0.514703,-0.117016,0.488826,-0.413998,-0.588405,0.810835,0.511809,0.236402,-0.106364,0.254548,-0.106276,0.427075,0.898353,-0.0468511,0.313964,-0.390876,0.542213,-0.34775,0.230515,1.10158,-0.53448,-1.17553,0.171473,-0.273943,0.0722099,-0.15448,-0.106337,-0.164029,-0.383816,0.398618,0.456054,-0.604322,0.779105,0.242534,0.258624,0.0758123,-0.207408,0.223984,0.299444,-0.395117,-0.0182739,-0.0142118,0.976803,-0.481385,0.100761,-0.21323,0.192161,-0.171975,-0.19436,-0.176478,0.15579,-0.0968252,0.223397,-0.894324,0.282611,-0.214438,0.192751,0.311529,0.170576,-0.0879945,-0.143586,-0.181841,0.215168,-0.316153,-0.2628,-0.627688,0.474155,1.03147,-0.197652,0.0270184,0.275641,0.49361,0.0508206,-0.286314,-0.332038,-0.100784,0.380752,0.106427,-0.787635,-0.0795765,-0.068087,0.228756,0.117682,0.115913,0.255267,0.0077485,0.224313,-1.04088,0.42186,0.304225,-0.181986,0.347813,0.394631,0.381675,-0.00658515,-0.324245,0.440717,-0.383893,0.114944,-0.250107,-0.0133595,-0.39542,0.0153877,0.0293636,-0.450113,0.481674,0.353346,-0.165666,-0.352045,-0.372849,0.414759,-0.198577,0.0139428,-0.473273,0.355803,0.312313,0.303265,-0.384315,0.312344,-0.243056,0.302008,-0.0118731,0.0390215,-0.0643458,-0.16335,-0.110082,-0.415453,0.11184,0.412535,-0.157579,-0.0768522,-0.448409,-0.375777,-0.235681,-0.378977,-0.648764,0.226396,0.542006,0.0570904,-0.530089,-0.24939,0.2003,0.00934638,0.16123,-0.442787,-0.148266,0.182329,0.170828,0.0684302,0.141717,0.00633571,-0.335693,0.233065,0.331506,0.173486,-0.400905,-0.973198,0.0677125,-0.0142669,0.0676728,0.536694,0.0159757,-0.0540884,-0.164966,-0.752687,1.12999,0.0564712,-0.712662,0.00448024,0.130277,-0.00809757,-0.484331,-0.171167,-0.442111,-0.038102,0.382994,0.398479,0.0670378,0.0635139,-0.162721,0.132318,-0.0497222,-0.489147,0.656571,-0.331237,-0.0721223,0.345406,0.285631,-0.251439,0.0574434,0.0660648,-0.109938,-0.914123,0.664731,-0.0059938,-0.0754254,0.312086,-0.635552,-0.424963,0.126336,0.0162961,-0.293434,0.283859,0.120926,0.342152,-0.15234,0.441291,-0.456631,-0.709249,-0.314465,0.434531,-0.871998,-0.161593,-0.0553493,-0.0273351,-0.168039,0.405282,-0.362217,0.460848,0.779949,-0.175039,-0.00251858,0.079789,0.387979,0.292011,0.195396,-0.467254,-0.219857,0.322162,-0.753281,-0.333739,0.0422397,-0.611885,-1.06293,-0.177437,0.0738706,-0.377198,-0.0596644,-0.2466,-0.2635,-0.241841,-0.208086,-0.00344929,-0.00789556,0.242681,0.166754,0.43688,-0.670234,-0.00708029,-0.0447341,-0.163981,-0.0447213,0.00219878,-0.492479,-0.639223,-0.615661,-0.499368,0.549498,-0.293595,0.145095,0.263677,0.380914,0.513495,-0.74202 +3414.06,0.839181,0.0912059,4,1.57974,0.945693,-1.10933,0.297934,0.477642,-0.0325815,-0.032127,0.308083,0.275512,0.73138,-0.184201,-0.0428123,-0.456688,0.212436,-0.090102,0.87669,0.0959729,-0.000264732,-0.265275,0.142387,-0.49519,-0.88209,-0.800158,0.222574,-0.398619,-0.844936,0.289706,-0.0184216,-0.0502978,-0.0195048,0.467206,-0.178251,0.369371,0.316008,-0.623515,-0.10117,0.0660273,0.632164,0.567358,-0.120365,0.98561,0.347732,0.635743,-0.765555,0.270239,-0.178974,-0.785132,0.688804,0.549417,-0.300999,0.155918,0.108682,-0.00540907,0.0361741,0.811402,0.310326,0.124254,-0.364146,0.197332,-0.089692,0.0394864,1.38587,-0.960019,-1.75343,0.306189,0.088981,0.280629,-0.256006,-0.0564064,-0.00119333,-0.194351,0.0206809,0.457151,-0.186702,0.542871,0.0397222,0.188685,0.351559,-0.3908,-0.0992079,0.492971,-0.00676421,-0.0925836,-0.214042,0.729672,-0.519388,-0.139135,0.243033,-0.148738,-0.30166,-0.68618,-0.425975,-0.197922,0.564992,0.0183714,-0.2386,-0.314668,-0.618499,0.336242,0.145763,0.0343767,0.0174232,-0.574302,-0.220716,0.632491,0.218694,0.0176211,-0.45944,0.661095,0.732935,-0.500145,-0.0290046,0.395454,0.171346,0.286744,-0.275778,-0.254435,0.118186,0.210118,0.0505857,-0.71559,-0.121887,0.285353,-0.237358,-0.099293,-0.0733545,0.341061,-0.375726,0.12178,-0.62681,0.552175,-0.00828967,-0.163311,0.764232,-0.152372,-0.0996472,-0.193533,-0.531301,0.603442,-0.390596,0.0641219,-0.127109,0.144757,-0.35334,0.147466,0.113774,-0.586949,0.579188,-0.337117,-0.492186,-0.646144,-0.340462,0.406156,-0.116889,0.701024,0.14498,0.306992,-0.124584,0.186137,0.135944,0.214988,-0.0466409,0.707393,-0.167446,0.109158,0.172719,0.000546348,0.0454839,-0.207154,0.481072,0.0758813,-0.0811419,-0.0822152,-0.0344189,-0.672058,-0.988883,-0.293145,-0.510196,-0.110136,0.380074,0.00854254,0.191365,-0.263359,0.216117,-0.592808,0.0220851,-0.435097,-0.251793,-0.1428,-0.611108,0.00031975,-0.183645,0.0548062,-0.142492,-0.429832,0.389297,0.122708,0.0246501,-0.993653,0.361229,-0.464553,0.175828,0.41917,-0.0346552,-0.416363,-0.477459,-0.98431,1.14502,0.0726774,-0.0770348,-0.0736584,0.121791,0.0277265,-0.477083,-0.407591,0.306844,-0.317391,-0.248439,0.241597,-0.0939304,0.166408,-0.232413,0.279284,0.273767,-0.62543,0.44156,-1.04114,-0.106781,0.26537,0.464397,-0.0589825,0.196572,-0.0606824,-0.584628,-0.347172,1.05394,-0.0119069,-0.340981,0.478113,-0.855639,-0.110611,-0.239851,-0.0792905,0.186334,0.01666,-0.327021,0.111631,0.113592,0.287747,-0.470361,-0.34133,-0.323534,0.510075,-0.441913,-0.187809,-0.131595,-0.785193,-0.177874,0.73653,0.0152499,0.479928,0.46725,-0.057431,0.422041,0.245558,0.414315,0.155824,0.0553331,-0.257115,-0.135808,0.779398,-0.497047,-0.425424,-0.00516022,0.205097,-0.670861,0.029576,0.0357001,-0.357449,-0.203774,-0.565126,-0.52475,-0.152116,-0.655116,-0.146407,0.132281,0.031956,0.053972,0.188315,-0.479466,0.013894,-0.628984,0.307373,-0.0680116,-0.0706884,-0.277555,-0.460787,-0.358347,-0.238051,0.184917,-0.390167,0.141898,0.210064,0.376694,0.458327,-1.36942 +3430.73,0.886681,0.0912059,4,1.63672,0.990087,-0.585268,0.132376,-0.258697,-0.215474,0.327424,0.134621,0.532942,0.185998,-0.0775464,-0.255087,0.298848,0.561975,0.345749,0.622455,0.164566,-0.107315,-0.394889,0.00933372,-0.555967,-0.979365,-0.637883,0.34009,-0.871292,0.0148154,-0.025515,0.773375,-0.712298,-0.0498557,0.696665,-0.505401,-0.38948,0.219636,-1.03429,-0.12882,-0.730594,0.5925,-0.14871,-0.320693,0.968686,0.683443,-0.201624,-0.228077,-0.299135,0.246693,-0.633998,0.0544351,0.697035,-0.188172,0.479215,0.382345,-0.0970364,-0.996237,0.418906,-0.352644,0.00349152,-0.442701,0.231892,-0.381647,0.513137,0.829578,-0.538398,-0.112873,-0.0841587,0.18439,-0.321632,-0.520392,0.199738,-1.0979,0.104221,0.529268,0.454757,-0.27328,0.719705,0.790182,0.272098,-0.177678,0.171204,0.0929542,0.611706,-0.438043,0.0205039,0.353186,-0.323709,0.177636,-0.219248,-0.160238,0.268197,-0.267498,0.149541,0.239566,-0.215117,-0.121412,0.110847,-0.258558,0.165031,0.292778,-0.151103,0.139294,0.223082,-0.104514,-0.291968,-0.300485,-0.385507,-0.468249,0.282761,-0.0790948,0.393038,0.0190055,0.409246,-0.00350233,0.0278588,0.431964,-0.713125,-0.0410668,-0.260707,0.321889,-0.194203,-0.0611515,-0.519965,0.34824,-0.581858,0.162377,-0.281968,-0.104329,0.215136,-0.128384,-0.0933758,-0.084874,-0.292958,-0.166867,-0.150037,0.372044,-0.269009,-0.455433,0.623899,0.169952,0.0436318,-0.583218,-0.833526,-0.331865,0.714726,-0.781091,-0.0615664,-0.0186047,0.40059,0.312523,0.071321,0.425691,-0.0370741,0.0752144,0.468109,-0.0290868,-0.492211,0.153873,-0.130739,-0.144186,-0.175689,-0.138652,0.0916775,-0.355223,0.294066,0.10193,-0.0380933,-0.0152307,-0.269046,-0.0763944,-0.172816,-0.742147,0.304537,0.207142,0.125434,0.143685,-0.0791795,0.0718392,-0.0401967,0.0254321,0.221783,0.774493,0.128161,-0.235789,0.676184,-0.1255,0.296526,-0.294093,-0.413263,-0.531283,0.0641614,-0.397728,-0.259712,-0.174239,-0.127568,-0.769587,0.357591,0.202768,-0.140185,-0.392979,-0.464875,-0.293755,-0.0644603,-0.423529,0.245775,-0.0874682,0.0594475,0.615641,-0.112594,0.675312,0.0394172,0.212184,-0.34074,0.171033,0.142316,0.425151,0.27512,0.13097,-0.414298,0.300711,0.311919,-0.781835,-0.506655,-0.574113,-0.458796,0.181493,-0.146789,0.165736,0.155883,-0.469899,-0.0136283,-0.460268,-0.103327,0.185785,-0.689618,-0.214351,-0.479043,0.225852,-0.139425,-0.0788458,0.388638,-0.301354,-0.48144,0.144663,-0.179058,-0.364498,0.012303,0.359988,0.352361,0.138344,-0.311614,-0.118668,0.20367,-0.341451,0.25362,-0.089218,-0.100184,0.477872,0.049191,0.0580186,-0.504443,-0.214781,0.646837,0.107096,0.0392083,-0.703762,0.0586277,0.0856115,0.00850761,0.0135364,0.0629298,-0.134167,-0.699636,0.239839,-0.212625,-0.00501529,-0.256537,0.429266,0.0488125,-0.0179413,0.595874,0.21625,0.0901883,0.162174,0.0589524,0.385177,0.107385,0.287164,-0.350479,0.320048,0.311032,0.110016,0.293511,0.522914,-0.689923,0.120993,0.427501,-0.316464,0.566016,-0.250555,0.0945643,-0.376933,0.618376,0.108565,0.252088,0.329491,0.502084,0.980942 +3410.41,0.553198,0.0912059,4,1.59887,0.795077,-1.14027,0.432075,0.20306,-0.147141,0.18277,-0.0158656,0.103899,0.0613264,-0.160805,0.131486,-0.115726,0.452207,-0.331991,0.684542,0.477131,-0.336249,-0.15324,0.0740733,-0.0759937,-0.638691,-0.477571,0.462918,0.316984,-0.343565,-0.000995783,-0.353436,-0.000180458,0.266721,0.827845,-0.302213,0.0773301,0.156243,-0.710897,0.104906,-0.317853,-0.15598,0.332457,-0.300023,-0.0221539,0.467169,0.400639,-0.531468,-0.35869,-0.202561,-0.300216,0.496798,0.423952,0.193295,-0.403057,-0.0740867,-0.0941595,0.173575,0.72606,0.0458616,-0.129999,-0.366837,0.253017,-0.0480507,-0.132625,0.695405,-0.701061,-0.972246,0.181651,-0.415361,0.0508473,0.132388,-0.0458963,0.203072,-0.319262,-0.234481,0.382004,0.179723,0.363993,-0.20781,0.353742,0.059222,-0.712227,-0.280822,0.170262,-0.0774054,0.049023,-0.100977,0.0911366,-0.0574041,0.227847,0.086347,-0.407082,-0.601859,0.16766,-0.156148,0.308542,0.0454199,-0.0310626,-0.1499,0.13816,-0.646625,0.199071,1.16341,-0.101486,0.308928,-0.448286,-0.111656,0.526199,-0.17945,0.164793,-0.469352,-0.162241,0.984483,-0.358349,-0.063803,0.140014,0.164742,0.610539,0.121828,-0.21871,0.0649691,0.531387,0.0798828,-0.420774,-0.34903,0.376905,-0.336185,-0.33651,0.0638216,0.0442024,0.255609,0.209663,-0.717798,0.16003,-0.0671189,0.18858,0.657207,-0.190509,0.253666,-0.354945,-0.294642,0.363098,-0.338823,0.273438,-0.0200207,-0.556428,-0.00116251,0.288104,0.184446,-0.560097,-0.132268,-0.583474,-0.502448,-0.16499,0.134431,-0.223155,-0.0895757,0.670499,0.505579,0.472671,-0.0567633,1.06528,0.0744545,0.165221,0.322884,1.02685,-0.20112,-0.127886,0.130862,0.0604636,-0.313107,-0.329015,0.712875,-0.101939,-0.17167,-0.14297,-0.136595,-0.818341,-0.534231,-0.125067,0.167176,0.246918,0.90842,0.0604958,0.172711,-0.172879,-0.049732,-0.499474,-0.319722,-0.22743,-0.182366,-0.0105073,-0.542055,0.0981484,0.109115,0.207684,-0.361163,-0.342225,0.414005,0.320513,-0.340404,-0.353233,0.479159,-0.372188,0.0540508,-0.147916,0.283262,-0.177686,-0.286873,-0.892258,0.932532,0.117943,0.0669842,0.328396,-0.431662,0.145036,-0.561796,-0.502052,0.546039,0.0984348,0.631963,0.0453724,0.0418039,0.34732,-0.129859,0.240113,-0.169345,-0.289586,0.479427,-1.13013,0.0723286,0.0767942,0.51097,0.0122733,-0.0500779,0.2274,-0.327646,-0.262155,0.893607,0.0828808,0.128828,0.913185,-0.262363,0.137069,0.0011245,0.0613881,0.358591,0.423211,0.119497,0.296248,0.129753,0.0610044,-0.465352,-0.512731,-0.457888,0.474613,0.0856053,0.0506388,-0.0442978,-0.59709,-0.254702,0.166002,0.147148,-0.0899773,0.553971,0.310569,0.84635,0.703727,0.0458945,-0.0698129,-0.516541,0.0655123,0.130423,0.484371,-0.729866,-0.310607,0.203758,0.553436,-0.00245718,0.993023,0.0665858,0.156677,-0.182302,-0.0462888,-0.919076,-0.269984,-0.525188,0.0283606,-0.01642,0.327948,0.309067,-0.10287,-0.147661,-0.169425,-0.20977,0.763369,0.138794,-0.209973,-0.612924,-0.618501,0.512871,-0.236082,0.202159,-0.558875,0.145345,0.157619,0.381242,0.397012,-0.25476 +3413.11,0.993913,0.0912059,4,1.57132,0.833584,-1.08653,0.42482,0.350265,-0.191078,0.292629,-0.124242,0.230667,-0.397914,-0.00144618,0.132749,-0.320256,0.289901,-0.0908344,0.644563,0.244209,-0.0914687,-0.30683,-0.0420352,0.0264731,-0.696606,-0.805473,0.40796,0.108822,-0.287269,-0.160315,-0.251172,-0.0883757,0.43171,0.764778,-0.459645,-0.618226,0.106219,-0.279171,0.24291,-0.0182504,-0.133784,0.357749,-0.300673,0.0223405,0.526004,0.302557,-0.791719,-0.468777,0.107281,-0.421163,0.650149,0.373178,0.0912121,0.156551,-0.192922,-0.0995835,0.112242,0.615363,0.092009,-0.29323,-0.6632,0.261307,-0.264437,0.115325,0.662673,-0.346836,-0.66849,0.588764,0.146661,-0.139042,0.209648,-0.310178,0.0776805,-0.643831,-0.177851,0.726298,0.447475,0.215948,0.0882538,0.715946,0.358603,-0.926393,-0.112168,0.407232,-0.227452,-0.0729834,-0.00270913,-0.196661,-0.171819,0.171902,-0.0410787,-0.327739,-0.534833,0.307788,0.264901,0.303179,-0.0329048,-0.0577336,0.0212739,0.131525,-0.702592,0.182127,1.01758,-0.497054,0.574173,-0.362664,-0.0113613,0.184738,0.00130745,0.247016,-0.349567,-0.483518,0.701431,-0.142571,0.120045,0.0920557,0.234132,0.486651,0.128486,-0.404358,-0.185878,0.59606,-0.0381437,-0.188902,-0.596538,-0.00509666,-0.348806,-0.476839,0.17038,-0.0290872,0.266889,0.159215,-0.515403,0.507728,0.265132,-0.173354,0.652778,-0.217732,0.373683,0.0521865,-0.436691,0.283316,-0.349482,-0.301969,-0.115361,-0.603342,0.296003,0.296003,0.11214,-0.18486,0.0906197,-0.214136,-0.694723,-0.419552,0.172663,0.0618652,-0.0660871,0.655225,1.03836,0.252485,-0.482124,0.957356,0.12515,0.303196,0.395568,0.946868,0.120913,-0.35719,-0.121312,0.238483,-0.205513,-0.215106,0.564784,0.169203,-0.419006,-0.0719303,-0.188657,-0.469412,-0.746859,-0.0632874,-0.190088,-0.00752707,0.868303,0.145689,0.0981884,0.0161721,-0.154705,-0.426921,-0.165461,-0.376734,-0.195735,0.104482,-0.34667,0.0899121,0.0263576,-0.121651,-0.204808,-0.219889,0.567401,0.370583,-0.536054,-0.58388,0.295328,-0.357738,0.0995975,-0.0173007,-0.103599,-0.146409,-0.257953,-0.976389,0.813229,0.334538,0.365939,0.513391,-0.333836,-0.13741,-0.625241,-0.671008,0.317085,-0.153325,0.772316,-0.263642,-0.0614793,0.374564,-0.356666,0.473819,0.109701,-0.373541,0.41933,-1.21928,-0.0107891,0.385591,0.250806,-0.129651,-0.145705,-0.0773329,-0.131334,-0.0572354,0.657277,-0.130033,-0.0117145,0.758418,-0.301615,-0.271494,0.332068,0.531516,0.490474,0.509998,0.318201,0.472312,0.134595,-0.0606248,-0.459125,-0.385931,-0.183481,0.548412,0.060673,-0.227886,0.103833,-0.52108,-0.120001,0.273569,0.199658,0.256452,0.251664,-0.0609192,0.593649,0.803953,0.126749,0.144864,-0.437579,0.235703,0.0941872,0.258276,-0.607001,-0.227963,0.200222,0.680071,-0.190268,1.10081,-0.167668,0.0381277,-0.198716,0.0654106,-0.687921,-0.2259,-0.613185,0.379086,0.00651027,0.347547,0.748464,-0.208924,-0.0736697,0.037608,-0.209204,0.611596,-0.241873,-0.197112,-0.785818,-0.593483,0.485808,-0.618639,-0.0518866,-0.325442,0.147058,0.162244,0.383481,0.402795,-0.849454 +3409.31,0.993803,0.0912059,4,1.5762,0.840505,-1.33531,0.517151,0.596139,0.0480573,-0.200713,0.203341,0.25936,0.442015,-0.194239,-0.4564,0.119138,0.209815,-0.0620133,0.832088,-0.054232,-0.00654381,-0.0199714,0.173017,-0.20849,-0.749401,-0.496512,-0.15943,-0.722581,0.0128024,0.257486,0.313547,-0.387991,-0.290598,0.610762,-0.445734,0.138652,0.502777,-0.795928,-0.244395,-0.479613,0.182114,0.0650353,-0.256109,1.14411,0.617427,0.187702,-0.585595,0.168886,-0.111867,-0.541137,-0.936965,0.628569,-0.163271,0.323876,0.458921,0.0337159,-0.82315,0.0595418,0.0183795,0.198453,-0.739293,0.310712,-0.514532,-0.216705,0.760461,-0.64659,-0.597604,-0.449973,0.175182,-0.0681159,-0.839124,0.198908,-0.448819,-0.0187802,0.445723,0.68456,-0.773066,0.73482,0.874035,-0.0501358,-0.0945983,-0.199072,0.147649,0.401736,-0.817159,0.524085,-0.405796,-0.0823641,-0.10517,-0.030141,-0.366564,0.524325,-0.0479161,-0.66534,0.0359548,-0.225846,0.486654,0.247961,-0.370044,0.507282,0.737529,-0.0363427,0.10138,0.166804,-0.244671,-0.043335,-0.30283,0.283414,-0.492311,0.358245,-0.20349,0.793435,0.435281,0.570176,-0.221464,0.143696,0.748666,-0.889698,-0.0599048,0.0517873,0.387649,0.281563,0.258898,-0.649291,-0.366699,-0.257259,0.15478,0.19348,0.259162,0.383726,-0.121624,0.695972,-0.499167,-0.276471,-0.141544,0.0966229,0.345542,-0.0171754,-0.287507,0.076663,-0.184966,0.353344,-1.17772,-0.343514,0.156869,0.579267,-0.615,-0.118911,0.0871951,-0.101174,0.630964,0.0498434,0.118523,0.205511,0.179567,0.709274,-0.175422,-0.152868,-0.0194618,0.39325,0.167132,-0.296557,-0.1779,0.0420516,-0.266816,0.611842,-0.178898,-0.0605502,1.10589,-0.324913,0.119791,-0.0552893,-0.363254,0.181471,0.575893,0.52138,-0.175618,0.212916,0.714455,-0.474167,0.210478,0.727139,0.82943,0.196681,-0.179714,0.318523,0.205396,0.306348,0.0192318,-0.392034,0.00156727,0.008594,-0.222112,0.104902,-0.186898,0.249817,-0.707429,0.324803,-0.000337542,-0.717066,-0.227518,-0.0710008,-0.394794,0.375314,-0.303867,0.0224425,-0.231779,0.328373,0.255638,0.134602,0.994966,-0.00192698,0.209568,-0.335171,0.480121,0.39914,0.511834,0.394181,0.448676,-0.487901,0.0454942,0.51858,-0.452143,-0.310035,-0.550501,-0.0739206,0.647548,0.0761238,0.350327,0.464544,-0.326497,0.205262,-0.193497,0.185693,0.455378,-0.290387,-0.401152,-0.487023,0.246351,0.327658,0.410231,0.524493,-0.684261,-0.462579,-0.224166,-0.654607,-0.31033,0.0346534,-0.173574,0.769109,-0.0161092,-0.186683,-0.00724976,0.240472,-0.8317,0.247313,-0.390007,0.080364,-0.327365,-0.0603125,0.403925,-0.0848877,0.0409866,0.0534077,0.44445,0.082193,-0.110155,-0.508699,-0.0349084,-0.126345,0.365043,0.223343,-0.0659477,-0.0267113,-0.21918,-0.231286,0.249157,-0.521878,0.452318,-0.409119,0.119523,0.18423,0.294479,-0.0188421,0.0370342,-0.512937,1.04612,-0.308446,0.298516,-0.586326,0.114441,0.315664,0.0788502,0.205819,-0.159031,-0.514652,0.352026,-0.0193365,0.187602,0.812747,-0.301824,0.491514,-0.414837,0.404826,0.147893,0.157935,0.384568,0.397411,-1.6897 +3374.59,0.759191,0.0912059,5,1.61094,0.919122,-0.765402,0.162539,0.408779,0.0676619,0.166702,0.563179,-0.153912,0.153681,-0.0830365,-0.447444,-0.139808,0.219557,0.147881,0.688442,-0.0211507,-0.162451,0.162721,0.109584,-0.444423,-0.993047,-0.428938,-0.0232789,-0.55879,0.0539398,-0.0748919,-0.0565266,-0.575608,-0.14156,0.601809,-0.50525,-0.433198,-0.0206652,-0.349851,-0.305602,-0.00850316,0.677726,0.0315749,-0.394674,1.14847,0.621793,0.20317,-0.936951,-0.224339,0.333641,-0.863754,-0.68794,0.48254,-0.555795,0.0513811,0.346791,-0.184236,-1.14787,0.533929,0.610403,0.0752879,-0.600505,0.488072,-0.682423,0.123039,0.83922,-0.183024,-1.14821,-0.248482,0.342947,-0.36577,-0.306831,-0.169833,-0.750495,-0.553977,0.00895978,0.634574,-0.561609,0.67387,0.645773,0.664401,0.354544,-0.368527,0.161949,0.263603,-1.07564,0.229483,-0.0715714,0.22161,0.245734,0.00316624,-0.328155,0.39129,-0.00428152,-0.397746,-0.137201,-0.0845571,0.386599,0.759798,-0.204945,-0.0473353,0.305198,0.0929124,0.0759324,0.335276,0.0781021,-0.480035,-0.481309,0.397276,-0.664701,0.276659,-0.529825,0.842437,0.643512,0.357707,0.209968,-0.565239,0.822347,-0.671051,0.0367626,-0.169549,-0.0712054,0.00871146,-0.0768926,-0.671011,-0.932273,0.280008,-0.427697,0.541822,0.159294,0.473903,-0.110145,-0.00266207,-0.411733,-0.0778088,0.178169,0.134434,0.386977,-0.274623,-0.361086,-0.472651,-0.463393,0.203477,-0.780067,-0.0167009,0.266135,0.277109,-0.700185,0.124569,-0.0189958,-0.122466,0.156476,0.0334774,0.197104,0.305343,0.0990146,0.762464,0.15577,0.283613,-0.340372,0.882581,0.481822,-0.220053,0.44157,-0.0917914,-0.137968,0.832445,0.150297,-0.510197,0.850944,-0.648651,-0.0935598,-0.759406,-0.00213431,0.719546,0.123491,0.205501,-0.228747,0.0284375,0.494499,-0.615646,0.390564,0.676766,0.82332,0.716935,0.2301,0.185923,0.0289516,-0.135782,0.430229,-0.032061,0.144811,0.487693,-0.106505,0.0993628,-0.318216,0.260337,-0.442818,0.0399724,0.187631,-0.206296,-0.274381,-0.145405,-0.40204,0.272023,0.216528,0.31452,0.205841,0.12017,0.178305,-0.278744,1.06424,0.808115,0.0734106,0.107311,0.106891,0.00478407,-0.290616,0.260644,0.690589,-0.16254,-0.0571633,-0.0364341,-0.238882,0.062117,-0.339566,-0.381431,0.611668,0.276548,0.262147,0.0782192,-0.510245,0.449981,-0.240574,-0.124521,0.519413,-0.225554,-0.346391,-0.795279,0.665416,-0.570719,0.0618423,0.77025,-0.572312,-0.933555,0.14779,-0.99857,-0.242921,0.044346,-0.305565,0.442358,-0.269503,0.083068,-0.355535,-0.650029,-0.877143,0.201143,0.106586,-0.517495,-0.000591857,-0.00137673,-0.245845,-0.239849,0.0497571,-0.124009,0.165605,-0.183046,-0.384388,-0.721766,0.307083,-0.17603,0.286872,0.0755428,0.0422145,-0.384053,-0.460676,0.225824,-0.418497,-0.676973,0.14609,0.0778734,-0.359884,0.577181,0.389676,-0.0991923,-0.271381,0.560263,0.716754,0.201643,0.836227,-0.84843,0.334638,0.765833,-0.359554,0.273273,-0.824995,-0.471873,0.390965,0.113921,-0.0588343,0.316283,-0.0924554,0.674316,-0.621307,0.108018,0.199911,0.270533,0.447114,0.520128,-1.13999 +3385.93,0.835217,0.0912059,4,1.6638,0.815801,-1.25107,0.445017,0.83997,0.0175834,-0.222072,-0.271951,0.0250857,-0.0769747,0.328945,0.0185586,-0.582401,0.0726517,-0.470424,0.622746,-0.0339358,-0.0746123,-0.947131,-0.0243467,-0.147479,-0.556314,-0.991532,-0.367725,-0.323208,-0.641362,0.179081,0.497462,-0.797307,0.0468758,0.580862,-0.935281,-0.329706,0.0544552,-0.345113,-0.472074,-0.858047,0.746312,0.289926,-0.336725,0.666335,0.560035,-0.0939637,-0.232958,0.322585,0.379176,-0.494214,-0.0117509,0.363891,0.0151388,0.345767,-0.0279308,-0.094528,0.124007,0.637583,-0.269416,-0.00259489,-1.0073,0.462681,-0.279275,0.0522384,0.349344,-1.51147,-0.904237,-0.271074,0.292096,0.074549,-0.784479,0.372386,-0.485487,-0.205535,0.783459,0.590738,0.155354,0.539941,0.272278,-0.00622653,0.356645,-0.188257,0.0746626,0.144975,0.0226616,0.910232,-0.236497,0.0530818,-0.943604,0.547725,0.143396,-0.029073,-0.543512,-0.178852,1.06263,0.213343,0.0816514,0.0416803,-0.124508,-0.435893,-0.656248,-0.0289391,0.690394,-0.046288,0.319476,-1.13494,-1.01721,0.279412,-0.388847,0.882005,-0.349619,0.232688,0.365406,-0.104238,0.107464,0.17925,0.259363,-1.04443,-0.312467,-0.166191,0.328077,0.726901,-0.400237,-0.601512,-0.647541,-0.484222,0.0174357,-0.405164,-0.284962,0.0304633,-0.300498,-0.0757028,-0.719197,0.0992123,0.0601387,0.323065,0.38144,0.168465,-0.0422701,0.027742,-0.190904,0.44672,-0.961467,-0.135034,0.38676,0.299995,-0.814127,0.26952,0.129427,0.685008,0.233397,-0.16972,-0.348089,0.259047,0.384593,0.0380998,0.0666281,0.497448,0.313924,0.288461,0.338386,0.362205,-0.587296,-0.137733,-0.119545,0.479668,-0.404823,0.750509,0.403037,0.0177035,0.410314,-0.253561,0.841888,0.320185,-0.215808,-0.0322396,-0.226376,0.126092,-0.220582,-0.016891,0.0495308,0.14403,1.34525,0.425282,-0.356578,0.61954,0.023845,-0.109881,-0.311215,0.0509082,-0.693621,0.246099,-0.157837,0.156936,-0.463181,-0.382008,-0.799103,-0.2275,-0.135399,-0.476809,-0.804609,-0.319294,0.0301312,0.305667,-0.255786,0.0234911,-0.512437,-0.106374,-0.0874839,-0.548384,0.978826,0.400577,0.468388,0.400551,-0.124739,0.737466,0.0100306,-0.841324,0.561755,-0.423571,0.0905713,0.298727,-0.607538,0.084622,-0.725518,-0.121755,0.100857,-0.127537,0.447036,0.106541,-0.267779,0.109815,0.35407,-0.360189,-0.180187,-0.344767,-0.511479,-0.699956,0.48182,-0.230524,0.115883,0.443929,-0.3548,-0.124087,0.103041,0.259089,-0.511663,0.901201,-0.0207217,-0.280791,-0.405373,-0.479543,-0.627183,-0.251728,0.133642,0.259695,-0.162957,-0.164765,-0.17046,-0.794659,0.146197,0.0116383,0.387589,-0.12405,0.737989,-0.119109,0.0170936,0.69427,0.055736,0.0235504,-0.334126,0.492639,-0.11829,-0.324299,-0.144001,-0.894795,0.324724,0.75543,-0.500929,-0.230109,-0.733268,1.04062,-0.0389959,-0.15265,-0.546899,-0.0661374,0.164226,-0.431917,-0.0908528,0.0867558,0.673431,-0.162739,-0.172285,-0.176901,0.0125391,-0.346163,0.217928,-0.110532,-0.952745,-0.289578,0.530065,-0.0557749,-0.334512,0.261634,0.166084,0.236583,0.407534,0.486398,-2.33612 +3396.81,0.665217,0.0912059,4,1.71679,0.711153,-1.00658,0.421876,0.583239,-0.0278353,-0.0568222,-0.126321,0.0562569,-0.105628,0.531244,-0.161761,-0.625376,0.195934,-0.31967,0.332631,-0.0236242,-0.385335,-0.733759,0.0690283,-0.108609,-0.665477,-0.710945,-0.371605,0.07982,-0.503817,-0.0445488,0.144695,-0.783957,0.0236488,0.614813,-1.19303,-0.892517,0.111252,-0.115912,-0.275719,-0.893692,0.586821,0.0529709,-0.293814,0.703458,0.916986,0.118882,-0.301989,0.0530375,-0.120125,-0.603059,-0.375453,0.436023,0.106262,0.0431052,-0.0907735,0.011583,-0.188562,0.738198,-0.101668,-0.0587231,-0.899931,0.0987147,-0.54119,0.121347,0.257683,-1.32703,-0.789478,0.0267304,0.336592,-0.0899825,-0.557952,-0.037945,-0.41972,0.000408005,0.935472,0.590291,0.124885,0.838818,0.375496,0.0572738,0.37764,-0.390177,0.193612,0.19667,0.00813896,0.863039,-0.137292,0.150013,-0.619902,0.274762,-0.0394772,-0.138868,-0.455454,-0.31888,1.20292,0.368101,0.077028,-0.265593,-0.44164,-0.21634,-0.523376,0.117055,0.505422,-0.367218,0.0946343,-0.789548,-1.27497,0.267536,-0.520279,0.606928,-0.143993,0.0122486,0.0607919,-0.131033,-0.118574,0.179935,0.44325,-0.563892,-0.392612,-0.427464,0.126131,0.437522,-0.63143,-0.552278,-0.665766,-0.825561,0.292172,-0.835225,-0.131026,0.150015,-0.241395,0.0465782,-0.515758,0.144924,0.314073,0.157883,0.208245,0.176042,-0.0939183,-0.0803474,-0.312631,0.51204,-0.715319,-0.240451,0.448167,-0.0796265,-0.361931,0.256431,0.181778,0.518294,0.246348,-0.118956,-0.607727,0.11567,0.358719,0.0723963,-0.110346,0.599295,0.0826179,0.0402684,-0.0976752,0.493739,0.0857948,-0.188681,-0.36058,0.419795,-0.264326,0.27664,0.716658,-0.211182,0.0729538,-0.133946,0.492095,0.17873,-0.492343,-0.231957,-0.13913,-0.0415966,-0.357917,0.0651659,0.222756,-0.372087,1.61494,0.581777,0.0859611,0.500485,-0.24637,-0.305984,-0.536292,0.13832,-0.300304,0.136084,-0.543336,0.0881871,-0.495081,-0.174793,-0.499721,0.140443,-0.0966444,-0.0500383,-0.926973,-0.219846,0.274015,0.338049,-0.190247,0.135931,-0.334446,-0.181767,0.317579,-0.473822,1.17065,0.653482,0.00213457,0.479821,-0.02861,0.181947,0.327494,-0.6031,0.933976,-0.197018,0.0528348,0.060985,-0.737477,-0.075644,-0.815409,-0.190459,-0.02586,-0.324164,0.396728,0.217132,-0.277646,-0.149995,0.357687,0.0022881,0.0693513,-0.254519,-0.248198,-0.376694,0.631485,-0.297033,0.0783986,0.342359,0.0946603,-0.485107,0.00813548,0.0228013,-0.180381,0.709016,-0.104313,0.214561,-0.208649,-0.424997,-0.202525,-0.305001,0.237651,0.0779404,-0.167798,-0.151498,0.0945894,-0.808734,-0.351009,0.132303,0.519351,-0.36987,0.784715,-0.171746,-0.460319,0.767746,-0.112983,-0.13345,-0.225721,0.648987,-0.0201794,-0.18706,0.259218,-0.564663,0.0100602,0.108622,-0.178044,-0.243822,-0.477748,0.846376,-0.0888117,-0.0375664,-0.79371,-0.383461,0.183994,-0.373241,0.0855223,-0.391392,0.625559,-0.10274,0.0849723,-0.188264,0.112411,-0.236353,0.12017,0.0616791,-0.460374,-0.0931997,0.46618,-0.281105,0.0920479,0.468464,0.16293,0.243999,0.403646,0.493963,-1.34099 +3415.36,0.641333,0.0912059,4,1.71,0.794689,-0.969444,0.321528,0.722231,0.00995533,-0.107291,0.147154,0.610055,-0.470657,0.0717766,-0.105238,-0.584815,0.0220783,-0.308716,0.296045,0.263297,0.110276,-0.723277,-0.243792,-0.215432,-0.518737,-0.652991,-0.317012,-0.23013,-0.208202,0.227566,-0.162619,-0.888469,0.229322,0.49974,-0.624777,-0.229076,0.131818,-0.0239917,0.0799453,-0.66953,0.51329,0.460212,-0.391229,0.789142,0.436008,0.339793,-0.372902,-0.266563,-0.432929,-0.485933,-0.418702,0.32274,-0.0157694,0.405946,0.0167653,0.0882598,-0.157953,1.19976,0.13161,-0.212642,-1.06155,0.443027,-0.699762,0.224475,0.493453,-0.763465,-0.977152,-0.208532,0.489602,0.0158083,-0.600237,0.218713,-0.51315,0.13917,0.563732,0.742499,0.10187,1.27102,0.110068,0.262595,0.498497,-0.29222,0.351279,0.54468,-0.0784285,0.803121,-0.807788,0.0301424,-0.457237,-0.479824,0.257975,0.0382262,-0.404524,0.259818,0.409707,0.167905,-0.304973,0.132731,-0.0420159,-0.102324,-0.246465,-0.146281,0.419087,-0.150817,-0.280893,-0.28159,-0.712772,0.165206,-0.332604,0.392144,-0.0756549,-0.0731309,0.244497,0.137055,0.0593272,0.270533,-0.00613259,0.161275,0.191407,0.238381,0.14786,0.484307,-0.507892,-0.628294,-0.282653,0.211263,0.100534,-0.130482,-0.172621,-0.0703429,0.550015,0.124918,-0.249756,0.0502032,-0.082612,-0.126134,0.374362,-0.181371,0.0869745,0.257603,-0.0586834,0.425039,-0.95205,-0.0977173,0.575293,-0.241913,-0.508754,-0.186547,-0.171688,-0.112318,0.17624,-0.122263,-0.33938,-0.100659,0.135959,-0.0576989,0.442028,0.10958,0.341664,0.465354,0.20198,-0.0621221,-0.243568,0.0119272,-0.153432,1.02745,0.308742,-0.210212,0.449957,-0.251288,0.158258,-0.163342,-0.000680031,0.0355878,-0.628186,-0.163825,0.0380159,-0.119556,-0.875924,-0.0158727,-0.133098,-0.257555,1.22411,0.864658,-0.375205,0.183754,-0.393351,-0.185852,-0.859352,-0.362149,-1.11612,0.662774,-0.534761,0.379859,-0.553237,-0.11604,-0.520573,0.538388,0.0782353,0.123426,-0.702771,-0.882491,0.0551446,0.487161,-0.331474,-0.0417056,-0.448048,-0.672749,0.393933,-0.586357,1.15345,-0.011022,0.18752,0.0556387,-0.0724925,-0.312407,0.456506,-0.490029,-0.0531266,-0.291291,0.115461,0.228483,-0.590972,-0.147647,-0.287751,-0.355816,0.00490369,-0.0648713,0.574959,-0.0785119,-0.743297,-0.322316,0.364246,-0.0538825,-0.232145,-0.133268,0.154632,-0.445526,0.657114,0.0221487,0.518059,0.470488,0.0775221,0.035563,0.223349,-0.286981,-0.507893,-0.0362283,0.106028,-0.377217,-0.188224,0.0554313,-0.362647,-0.253631,-0.371375,0.106337,0.0686008,0.195697,0.010056,-0.583887,0.0881996,0.13424,0.560151,0.0252787,0.599729,-0.705174,-0.23022,0.561018,-0.0806819,0.116078,-0.230115,0.425509,-0.167897,-0.16029,-0.432341,-1.11651,-0.0918715,-0.0902407,0.293784,0.103874,-0.18791,0.247999,-0.025471,-0.225948,-0.0630749,-0.279405,-0.203746,-0.226275,0.0298596,-0.0577911,0.062406,0.253738,-0.175939,-0.245082,-0.00568813,-0.583322,0.329924,-0.201228,-0.134017,-0.704778,0.451145,0.0445159,0.181157,-0.296943,0.151398,0.265787,0.389099,0.515546,-1.89067 +3423.86,0.623145,0.0912059,4,1.72396,0.792747,-0.478639,0.126962,0.397686,0.0212898,0.106626,0.348458,0.769614,-0.107232,0.255902,-0.00994003,-0.15339,0.18488,-0.466097,0.286671,0.30677,-0.41168,-0.397547,-0.150959,-0.0721364,-0.600469,-1.20577,-0.461817,-0.198847,-0.777222,0.0223411,0.0139235,-0.821171,-0.0177537,0.555693,-0.233544,-0.524799,0.437076,-0.0608299,-0.249081,-0.439265,0.438711,0.184,-0.270286,0.884642,0.540151,0.133371,-0.478194,-0.131122,-0.49125,-0.630913,-0.0765685,0.32567,0.0480383,0.0715356,0.17715,-0.0924081,-0.581356,1.08176,-0.235004,0.210041,-0.320839,0.511588,-0.729005,0.0648196,0.440294,-0.739064,-1.51898,0.071023,0.331635,0.0989112,-0.449401,0.211641,-0.281578,-0.124246,0.574883,0.893425,0.118662,0.485393,0.146218,0.707822,0.186338,-0.562202,0.238556,0.286777,-0.109856,0.684468,-0.667266,-0.0666599,-0.37746,-0.431652,-0.29897,0.132048,0.0779954,0.299857,0.131419,-0.112632,-0.0192337,0.0905819,-0.0522931,-0.0480788,-0.361933,0.398009,0.332214,-0.152278,-0.134468,-0.0699733,-0.484157,-0.201971,0.530551,0.281209,-0.164393,0.094246,0.116585,0.226664,0.123784,0.238369,0.280066,-0.0922781,-0.249438,0.120821,0.250538,-0.0163146,-0.587927,-0.486786,0.0333615,0.537492,-0.415281,-0.144226,-0.623749,-0.42683,0.143746,-0.0268408,-0.207583,0.800772,-0.244035,0.0419206,0.728352,-0.618259,-0.00446357,-0.0178524,0.0864171,0.199353,-0.643799,-0.564144,0.680078,-0.0769117,-0.170522,-0.272472,0.377152,-0.037086,0.35857,-0.0165422,-0.0946074,0.181884,-0.164058,-0.202899,-0.0704198,0.0696206,0.633706,0.617178,-0.0541286,-0.102487,0.00463234,-0.240008,-0.272971,1.13023,0.222065,0.12623,0.382874,-0.201416,0.21876,-0.0626512,-0.221301,-0.125755,-0.447042,0.0900274,0.0887387,-0.0373813,-0.66096,-0.280886,0.0882526,0.0691351,0.505949,0.194912,-0.670465,0.0103108,-0.118483,-0.324603,-0.761173,-1.1378,-0.403871,0.0490695,0.160251,0.370166,-0.45563,-0.220566,-0.644192,0.0910926,0.329433,0.100533,-0.866176,-0.635098,-0.200236,0.485191,-0.330493,0.311456,-0.065222,-0.803367,0.0930942,-0.497846,1.14479,-0.508968,0.389924,0.100917,-0.0950093,0.235072,-0.116294,-0.477863,0.071879,-0.421231,0.324206,0.484911,-0.0541487,0.10676,-0.234222,-0.135768,0.0499671,-0.220088,0.480202,-0.170133,-0.457382,-0.0249147,0.0770256,-0.0347318,0.0726408,-0.105789,-0.0658208,-0.389139,0.24669,0.274936,0.288757,1.06389,0.722698,-0.259035,-0.351902,-0.0882351,-0.670766,-0.39806,0.001982,0.122395,-0.177282,-0.149047,-0.277612,-0.0946098,-0.22018,0.272174,-0.261339,0.202478,0.284929,-0.676162,-0.173974,-0.387124,0.492473,-0.0489652,0.645955,-0.315143,-0.331526,0.283524,-0.0725268,-0.18124,0.0371133,0.275089,0.0877341,-0.0523369,-0.217089,-1.06271,-0.382018,-0.328626,0.352355,0.100203,-0.464039,0.460347,-0.171021,-0.0695538,0.027458,0.0686775,-0.15531,-0.00635364,0.0789469,-0.247554,0.14134,0.462148,-0.215026,-0.0866825,0.172951,-0.168065,0.16126,-0.205691,-0.180125,-0.571049,0.130916,0.0639983,-0.0346665,-0.515671,0.149551,0.338588,0.386718,0.581883,-0.872053 +3425.93,0.681685,0.0912059,4,1.6066,0.827837,-0.680567,0.195295,0.0791868,-0.129126,-0.0441253,0.458044,0.482642,-0.0491933,-0.220835,0.0348267,-0.725618,0.8013,0.0879516,0.558964,-0.111129,-0.237433,-0.444453,0.0984745,-0.491717,-0.867192,-0.781465,-0.233945,0.0136831,-0.337425,-0.151579,0.765485,-0.583361,0.096025,0.631882,-0.59705,-0.119479,-0.318217,-0.0274586,-0.204174,-0.285847,0.0203484,0.13204,-0.450597,0.991503,0.243369,-0.256073,-0.58992,-0.353111,-0.13193,-0.975504,0.048996,0.548974,-0.0620116,0.386217,-0.519468,0.192682,0.0350525,1.07166,-0.365415,-0.127951,-0.522048,0.927358,-0.121914,0.346657,1.08306,-1.16945,-1.06823,-0.186484,0.0102335,-0.239147,-0.0969682,0.177964,-0.451405,-0.464525,0.411395,0.369364,-0.0538966,1.04754,0.73112,0.551175,0.602246,-0.0840889,0.00670985,0.480895,0.0300121,0.762261,-0.460308,0.139522,-0.138681,-0.391667,0.00173891,-0.113367,-0.366159,-0.407316,-0.30674,0.0149979,0.0877708,0.342521,-0.15698,0.143097,0.0109472,0.0692218,0.217721,0.18971,-0.106884,-0.640092,-0.222919,0.763857,-0.734151,0.391456,-0.307367,0.00452253,0.70518,0.34443,0.0120199,-0.149904,0.355005,0.233725,0.145845,-0.574481,-0.422045,0.702055,0.0817403,-0.676147,-0.24678,-1.41265,-0.089354,-0.0460256,-0.253078,0.417301,0.0705646,0.287094,-0.271989,0.0345032,0.154673,-0.0797359,0.697164,-0.00376523,-0.123317,0.012611,-0.363219,0.708314,-0.339536,0.222408,0.300756,-0.20993,0.146474,0.535523,-0.57601,0.0237497,-0.0694513,0.0531659,-0.713563,-0.136838,0.588692,-0.00666574,-0.0234592,0.375886,0.305648,-0.101195,0.259214,0.0259568,-0.190131,0.467246,0.239229,0.563374,-0.133256,0.200437,0.153923,-0.23945,0.166462,-0.20178,0.483833,0.111243,-0.19542,-0.296935,-0.297293,-0.61768,-0.190142,-0.575954,-0.149755,0.168212,0.876563,-0.169024,-0.108825,-0.11755,0.0263028,-0.565192,-0.495615,-0.0352216,-0.0490028,-0.50068,-0.120117,-0.496565,0.286621,-0.0929548,-0.455402,0.303376,0.328752,-0.0399088,-0.0235681,-0.861455,0.231613,0.269356,-0.745746,-0.0634997,-0.698156,-0.0908379,0.386869,0.0461438,1.005,-0.0246355,0.469004,0.250557,-0.642002,0.18297,-0.20432,0.0268002,0.472381,-0.597723,-0.150746,0.172854,-0.014136,0.341348,-0.213566,-0.0790121,-0.0832102,-0.484843,0.474762,-0.363261,-0.434076,0.447225,0.168389,-0.39341,-0.0582918,-0.284082,-0.270046,-0.575569,0.303402,-0.272788,-0.308376,0.115245,-0.0533196,0.0662617,0.102956,-0.153578,-0.395437,-0.254444,0.469191,0.416417,-0.51898,-0.598178,-0.68535,-0.0416476,-0.510169,0.444437,-0.14095,-0.600672,0.0536422,0.0140352,-0.00901771,-0.151249,0.514471,0.0669224,0.190397,0.524471,-0.157231,0.220397,0.0717212,0.316707,-0.15964,-0.37519,0.0080757,-0.0235915,0.226498,0.541688,0.217402,0.200832,-0.426013,0.0814058,0.232418,-0.0234293,0.234666,0.383391,0.270957,-0.220863,0.0539669,0.154229,0.261135,0.091656,0.0689346,-0.04513,-0.681374,-0.126926,-0.202621,0.0818966,0.0943207,-0.320136,-0.42775,0.161435,-0.270065,0.240929,-0.954422,-0.283414,0.127123,0.224425,0.356543,0.473736,0.0847944 +3395.7,1,0.0912059,4,1.70167,0.926983,-0.57674,0.0412607,0.0182032,-0.212611,-0.121955,0.221847,0.34931,-0.0267745,-0.448224,0.0386431,-0.78598,0.301313,-0.396304,0.13264,0.257709,-0.415404,-0.41823,0.0164207,-0.554129,-0.815478,-0.941465,-0.378901,-0.0292821,-0.48242,-0.329926,0.569218,-0.368083,0.0516171,0.413406,-0.303174,-0.343559,0.240979,0.0680361,-0.464497,-0.260548,-0.0933828,0.0132529,-0.643201,0.972503,0.45239,0.280519,-0.730534,0.0526827,-0.272896,-0.806578,0.321721,0.639772,-0.275985,0.211573,0.367307,0.397006,-0.271012,1.06352,0.428558,0.0815033,-0.37185,0.481666,-0.649867,0.267476,1.03557,-0.891764,-0.47,0.353934,-0.575187,0.036883,-0.216801,0.578948,-0.023614,0.145002,0.0138852,0.382463,-0.327859,1.19517,0.187594,0.185362,0.0313675,0.0570108,0.332397,0.600664,-0.911307,0.44139,-0.42361,0.191622,-0.258424,0.149444,-0.31569,-0.101418,-0.429057,-0.304056,0.0434593,0.0870683,-0.329919,0.734155,0.112826,0.115668,0.417407,-0.439141,0.349188,0.358861,-0.141909,-0.357034,-0.768539,0.173133,-0.427071,0.386822,-0.162647,0.26059,0.504464,-0.790067,-0.458182,-0.155667,0.164431,-0.499758,0.121665,-0.928633,-0.401333,0.410824,-0.317766,-0.585998,0.214016,-0.774982,0.257114,0.204165,0.116918,0.0237793,0.401586,0.679462,-0.110438,0.856417,-0.102118,0.306417,0.401371,-0.0520992,-0.0524297,-0.193119,-0.214141,0.483292,-0.656433,0.0786113,0.46631,-0.057683,-0.233896,-0.040638,0.0102301,-0.158436,0.09635,0.120741,-0.0421959,-0.56915,-0.0471466,-0.489034,0.288186,-0.131878,0.750015,-0.0428937,-0.561301,0.123402,-0.529153,0.481768,0.16605,0.783655,-0.178986,0.0775577,-0.0975844,-0.341638,-0.0226539,-0.371319,0.0738984,-0.363496,0.392922,0.00868656,-0.294036,-0.594381,-0.609319,-0.420673,-0.0133476,-0.506609,0.216617,-0.380058,0.440206,0.182596,0.0372144,-0.51149,-0.494478,-0.228823,-0.490285,-0.472214,0.169353,0.143108,0.628269,0.288515,-0.720124,-0.096425,0.00231755,-0.0578169,-0.183456,-0.94868,0.412708,0.0898809,-0.998085,0.0482493,-0.472974,-0.720045,0.22323,-0.44231,1.25716,0.275924,0.280837,0.0319542,-0.475574,0.198566,0.134059,0.0748094,0.0409673,0.085909,0.118341,0.00990192,0.226514,0.0581852,-0.703427,0.253176,-0.176625,-0.0477801,0.320569,-0.450962,-0.805972,-0.0810137,-0.3511,-0.372178,-0.102935,-0.377884,-0.339221,-0.431066,0.0663512,-0.770324,0.000690195,-0.160941,-0.146948,0.137679,0.484054,-0.0888808,-0.0186652,0.100725,0.169411,0.505863,0.10022,-0.674531,-0.509668,-0.0945152,-1.2617,0.405852,-0.199773,-0.524575,0.0118729,-0.262987,0.242756,-0.144669,0.520999,0.113505,0.093267,0.159741,-0.156434,0.264358,0.270166,0.349447,0.204792,-0.576852,-0.0499943,-0.363023,0.346345,-0.0465324,0.452126,-0.506023,0.209908,0.221724,-0.0697306,-0.371574,0.0412701,0.221511,0.588735,-0.335871,-0.24172,-0.00457942,0.398859,0.0743996,0.306485,-0.181082,0.444884,0.0452389,-0.557019,0.177193,0.274923,-0.0491848,-0.544974,0.687586,-0.399913,-0.359206,-0.462175,-0.228978,0.183698,0.298839,0.4286,0.546662,0.319429 +3405.54,1,0.0912059,4,1.51275,1.02001,-0.864927,0.243968,0.787884,-0.211028,0.336168,-0.0113942,0.632798,0.118568,0.136284,-0.589691,0.24328,0.0328438,0.0454244,0.842852,0.248131,-0.164845,0.683341,-0.210837,-0.363933,-1.02415,-0.382261,-0.481812,-0.0243728,-0.183396,0.646152,0.0793034,-0.532128,-0.0875536,0.488583,-0.647592,0.431857,0.0939754,-0.171303,-0.156674,-0.616475,0.659768,0.686497,-0.556848,0.647423,0.534519,0.115781,0.0433697,-0.511217,-0.43556,-0.227378,-0.29955,0.549159,0.0118147,-0.0706234,0.177005,0.210056,-0.468505,0.647198,-0.128396,-0.0451415,-0.761794,0.146833,-0.216486,0.490199,1.47883,-0.184992,-0.971058,-0.799656,0.540827,-0.160631,-0.14782,0.270108,-0.313299,0.0819093,0.261929,0.680905,-0.0156522,0.585464,0.232021,0.528072,-0.315222,-0.543087,-0.0602894,0.320282,-0.17632,0.584465,-0.204433,-0.499076,-0.0973497,0.271069,-0.439697,0.0140915,0.0729652,-0.317125,0.202139,-0.341685,-0.105225,-0.162148,-0.783262,0.325029,-0.401415,0.363164,0.418357,0.153587,-0.132351,-0.429559,0.280672,0.102796,-0.0838279,0.592758,-0.499653,0.312005,0.916148,0.128982,-0.185499,0.305518,0.426006,0.175565,-0.126383,0.0582318,0.324018,0.591822,-0.372818,-0.913394,-0.0360031,0.099468,-0.0747242,0.0177273,-0.210567,-0.36306,-0.216444,-0.219552,-0.279114,-0.112697,-0.0754647,-0.406565,0.800261,-0.72889,-0.244185,-0.326774,-0.158667,0.354737,-0.234158,-0.647177,0.128345,-0.0634836,-0.781963,0.115536,-0.0694214,0.383861,0.777344,0.0738298,0.168979,-0.0455253,-0.127187,0.326821,-0.0178725,0.651935,0.218847,0.383913,0.740732,0.218307,0.289137,0.440039,-0.476689,1.03377,0.138588,-0.311165,0.22563,-0.252992,0.0332919,-0.153078,-0.0957546,0.244696,-0.206016,-0.337786,-0.106986,-0.259962,0.547487,-0.312202,-0.473264,0.331462,0.377511,-0.0723912,-0.185804,-0.239267,-0.50816,0.530032,-0.336249,0.101086,-0.356864,0.347892,-0.954316,-0.0570799,-0.347822,-0.043993,-0.786008,0.220233,-0.23954,0.165043,0.0829606,-0.635858,-0.564058,0.415077,-0.192107,0.795831,-0.199638,0.320637,-0.148382,-0.53319,1.10074,0.23303,-0.34541,-0.28185,0.143355,0.268357,0.38169,-0.542891,0.131877,-0.487665,0.421009,0.0892414,-1.09455,-0.33984,-0.528096,-0.0352469,0.632762,-0.388501,0.486667,-0.00757733,0.236542,0.235563,-0.107871,0.0233708,0.12485,-0.794458,-0.16229,-0.185732,0.530657,0.575431,-0.192977,0.652157,-1.0818,-0.974341,0.463664,-0.251297,0.132677,0.748431,-0.152619,0.614404,0.214949,0.387442,-0.0549455,0.0780644,0.336886,0.207582,-0.218519,-0.345303,0.315098,0.0583893,0.0314367,0.41611,0.485733,-0.0217399,0.850116,-0.151922,0.103231,0.647494,-0.110648,0.323638,-0.0990114,0.415344,-0.154962,0.2868,-0.0760323,-0.635218,0.11452,0.107192,0.977707,0.335645,-0.013986,0.209892,0.0657122,0.273589,-0.0426044,0.0149899,0.0854612,0.330497,0.631203,0.0839566,-0.0255699,0.232707,-1.18585,0.06952,0.33763,-0.196732,0.203647,-0.369919,0.0196284,-0.772817,-0.517784,-0.0280739,-0.203855,0.332929,0.166635,0.190754,0.408209,0.436754,-2.63035 +3394.27,0.826325,0.0912059,4,1.635,0.954919,-0.545015,0.166827,0.379969,-0.214356,0.365577,-0.200972,0.460411,0.295259,0.0448574,-0.168949,0.101743,0.303517,0.045712,0.793218,0.357792,0.066861,-0.0358613,0.00300639,-0.589467,-0.90377,-0.517534,-0.127463,0.0555118,-0.501759,0.122305,-0.075258,-0.175979,-0.249049,0.504839,-0.41992,-0.0668889,0.811546,-0.54399,-0.0197795,-0.373544,0.506149,-0.077684,-0.71547,0.639347,0.228235,0.599789,-0.665599,-0.122399,0.23986,-0.3109,-0.13172,0.242356,0.150239,-0.107159,0.627088,-0.116463,-0.597981,0.88207,-0.00685991,0.176638,-0.909516,0.723925,-0.381785,0.115867,0.770668,-0.534729,-1.37377,-0.0134221,-0.655571,0.104725,0.292745,0.126654,-0.466252,0.609576,-0.635742,0.544459,-0.0737383,0.532259,-0.020878,0.233809,-0.294195,-0.275153,0.264403,0.14719,-1.22737,0.222152,-0.607299,0.384952,-0.316959,-0.22211,0.112025,0.420119,-0.321832,-0.253377,0.0421071,-0.0488802,-0.167375,-0.0112879,-0.535555,0.167681,-0.673409,0.261742,0.486209,-0.0586591,-0.272652,-0.364136,-0.291889,0.232105,-0.692789,0.685965,0.285121,-0.0742745,0.417008,0.431057,-0.359193,0.372636,0.076731,-0.0648865,-0.0324298,-0.424527,-0.229813,-0.161459,-0.559857,-0.806036,0.0308651,0.372163,-0.38432,-0.526781,0.469418,-0.00596482,0.0601459,0.161965,-0.467292,0.094271,0.261298,-0.209716,0.3868,0.0766225,-0.423374,-0.339679,-0.583715,0.663867,-0.921334,-0.696253,0.0405938,-0.532704,0.183015,-0.163848,0.439943,0.51056,0.355258,-0.0338169,-0.855594,0.105838,-0.214737,0.510418,0.395811,0.423231,0.162018,0.577067,0.106003,0.506123,-0.177174,0.257602,-0.306944,0.911774,-0.308236,-0.157882,-0.0679788,-0.39067,-0.0821159,0.227357,-0.830594,-0.268814,-0.0451928,0.00453748,-0.158309,-0.35292,-0.125581,-0.431676,-0.552944,0.184342,0.672439,0.116305,-0.552784,0.36894,-0.528214,0.344752,-0.461161,-0.19441,-0.757586,0.217603,-0.206314,0.218881,-0.309899,-0.14404,-0.859355,0.0490247,-0.344287,0.420739,-0.194694,-0.890554,-0.387132,0.328757,-0.677561,0.082877,0.25276,0.588611,-0.0292832,-0.161698,0.965612,0.349825,0.452857,-0.315741,-0.115523,0.319029,0.450681,-0.171108,0.651151,-0.667149,0.574745,0.115206,-0.553292,-0.564448,-0.956909,-0.27656,-0.182643,0.237906,0.417047,-0.552913,-0.110632,0.306902,0.189359,0.573871,-0.243171,-0.144141,-0.618676,-0.344045,0.216259,0.090851,0.312706,0.100485,-0.444763,-0.847977,0.293419,-0.512113,0.012798,0.292831,0.341103,0.122255,0.448126,-0.308195,-0.95854,0.0863369,-0.521136,0.199337,-0.112073,-0.819941,0.176273,-0.190594,0.239061,0.264713,0.312046,-0.126286,0.751748,-0.067804,0.738447,0.225196,0.40415,0.173707,0.338559,0.438149,-0.381224,0.0795582,-0.742024,-0.342745,-0.49862,-0.0830311,0.683733,0.509618,-0.00501639,-0.307393,-0.097684,0.227996,-0.422932,0.460956,-0.0471478,-0.0938339,0.110724,0.116828,0.545125,0.483421,-0.698876,-0.000927265,0.0695786,0.357251,-0.82435,0.160863,-0.80771,0.041476,-0.0474288,0.370754,0.170428,0.345118,0.162366,0.318036,0.402946,0.563947,-1.13292 +3388.17,0.759685,0.0912059,5,1.64214,0.834046,-0.928692,0.337811,0.429357,-0.222976,0.155939,-0.0302782,0.456176,-0.171413,0.219002,-0.55452,-0.0376468,0.309102,-0.398609,0.806032,0.398615,-0.145605,-0.0506288,0.0312055,-0.342084,-0.910152,-0.416848,0.0203077,0.0382905,-0.208846,0.197967,0.10353,-0.371555,-0.298792,0.797945,-0.559022,0.162666,0.199186,-0.610884,-0.0258733,-0.23714,0.0914793,-0.0903444,-0.608953,0.28887,0.808468,0.682656,-0.536857,-0.347345,-0.30919,-0.330819,-0.118518,0.216563,-0.0450808,-0.0455574,0.222831,0.419025,-0.863782,0.812101,-0.134682,0.0485608,-0.312219,0.31185,0.0577381,-0.298865,0.867461,-0.717787,-1.01414,-0.156855,-0.346434,0.35738,0.314622,0.27039,-0.355255,0.282956,-0.226957,0.496533,-0.270882,0.266082,-0.248129,0.513129,0.144687,-0.280745,0.424136,0.568501,-1.10662,0.425719,-0.548932,0.224245,-0.0200751,-0.0656529,-0.166726,0.62987,-0.826538,-0.17645,0.0251415,-0.277503,0.156063,0.27451,-0.688605,0.359624,-1.00691,0.343786,0.62121,0.231197,-0.0573103,-0.484811,0.0452689,0.453314,-0.33758,0.492933,-0.365169,-0.171759,0.480476,0.790774,-0.499081,-0.022853,0.284931,0.303756,-0.373077,-0.940903,-0.440614,-0.322649,0.0558357,-0.958635,0.358616,-0.173667,-0.476185,-0.301489,0.548128,-0.140338,0.102661,-0.127318,0.162803,0.0738994,-0.316248,0.30203,0.540061,-0.677458,-0.626906,0.280702,-0.727825,0.695756,-0.436108,-0.800677,0.0981314,-0.621525,-0.452456,-0.0703337,0.0373998,0.625321,0.662652,-0.133463,-0.308916,-0.0560435,-0.214804,0.852972,-0.348175,0.191461,0.532135,0.631764,-0.205543,0.514239,0.12017,0.0681795,0.200393,0.982395,-0.606715,-0.519967,0.133243,-0.110825,-0.167593,-0.0267771,-0.44162,-0.445115,-0.43974,-0.571928,-0.408897,-0.323756,-0.126232,-0.565491,-0.503331,0.418296,0.737115,0.234999,-0.182587,0.322867,-0.0460458,0.468222,-0.188464,-0.464114,-0.030858,0.337412,-0.44792,0.308364,0.0750733,-0.423152,-1.03543,0.106157,-0.498518,-0.316016,-0.345356,-0.639807,-0.513728,0.0350436,-0.227127,0.401856,-0.360931,0.296649,-0.162308,0.0536725,0.988388,0.533782,-0.207483,-0.195591,0.291549,-0.0922718,-0.058304,-0.505244,0.335654,-0.0335137,0.297886,0.00948417,-0.775574,-0.2188,-0.808236,0.0366555,0.50597,-0.123485,0.595378,-0.841645,-0.512143,0.778975,-0.158729,0.775241,-0.231682,-0.165266,-0.282381,-0.115015,0.307807,-0.0872149,-0.498823,0.516545,-0.341129,-0.68545,0.817397,0.0109792,0.285953,0.224134,0.0382,0.314233,0.5261,-0.461435,-1.03521,0.0278952,-0.663106,0.467469,0.376946,-0.697886,0.371644,-0.291942,0.133809,0.659691,0.306269,0.121077,0.128256,-0.351198,0.580658,0.189584,0.615217,0.258631,0.0106765,0.101223,-0.273305,-0.17369,-0.678141,-0.132588,-0.192598,0.511895,0.254049,0.38624,-0.16458,-0.196342,-0.0285445,0.460154,-1.59064,-0.233724,0.138779,0.543674,-0.231397,0.0221345,-0.128723,0.544535,-0.635304,-0.237583,0.130643,-0.132939,-0.261218,-0.183711,-1.01232,-0.01069,0.0242276,-0.508756,0.103883,-0.414295,0.223667,0.197415,0.472935,0.444314,-1.03445 +3391.63,0.976749,0.0912059,5,1.56388,0.935787,-1.12815,0.290405,0.508668,-0.0932923,0.156087,-0.603129,0.0568663,0.490637,-0.435301,-0.493646,0.164792,0.333696,-0.272422,0.571525,0.152787,-0.363068,0.142894,-0.126942,-0.654934,-0.562401,-0.73771,-0.13132,0.127575,0.0269788,0.0964902,0.11176,-0.513847,-0.700204,0.824218,-0.495501,-0.369526,0.423857,-0.30387,0.17743,0.0844625,0.441224,0.370922,0.129401,1.22429,0.483413,-0.0642937,-0.566723,-0.333246,0.0327257,-0.446936,0.28073,0.227988,0.642355,0.187691,-0.384097,0.401559,-0.286475,1.11086,-0.0778814,0.155156,-0.586232,0.248297,0.155284,0.406222,1.08882,-0.406991,-0.989464,0.095777,0.00816462,-0.0480038,0.352258,0.272962,-0.134692,0.784255,0.0981621,0.356602,-0.545724,0.798491,0.240308,0.572011,-0.251177,-0.222334,0.229658,-0.033174,-0.799229,0.344247,-0.934527,-0.19447,0.127208,-0.306316,-0.412515,0.825324,-0.323313,0.713889,-0.0897536,-0.109751,-0.379947,-0.463273,-0.295462,-3.00536e-05,-0.121962,-0.19398,0.555548,-0.230752,0.400302,-0.967391,0.183249,0.42037,-0.57954,0.581066,-0.056597,-0.082975,0.6754,0.591172,-0.711988,0.240607,-0.138108,-0.0401104,0.202554,-0.840577,0.393397,-0.0365478,0.0656249,-1.26276,-0.10613,-0.0884751,-0.0473155,-0.281775,0.1636,0.42256,0.0801591,-0.0579776,-0.387784,-0.431578,-0.229403,0.0822454,0.74654,-0.634752,-0.512176,-0.330572,0.192604,0.561019,-0.676759,-0.884796,0.139001,0.245321,-1.30978,-0.194835,0.156632,-0.190589,1.0739,-0.243635,-0.203314,-0.0240019,-0.155318,0.0320014,-0.120913,-0.0506495,0.805426,1.07574,-0.640835,0.17066,-0.377765,0.890234,-0.229381,0.932718,-0.12709,-0.141811,0.517981,-0.0212363,-0.508234,-0.0609158,-0.193453,-0.340442,0.370326,-0.211208,-0.611628,-0.138595,-0.340534,0.2707,-0.425135,-0.411055,0.831361,0.0450213,0.563345,0.636729,0.265613,0.0284487,-0.168237,-0.926898,-0.274703,0.175754,-0.0880041,-0.573725,0.300878,-0.385284,-0.587137,0.491517,0.00471035,-0.00229948,-0.0185087,-0.547182,0.150393,-0.0164233,-1.06416,0.138189,-0.035213,-0.201594,-0.246851,-0.922953,0.828179,0.265248,0.477596,0.0551499,0.213612,0.196712,0.326229,-0.0414967,0.185332,-0.616649,0.20888,0.248367,-0.313723,-0.452532,-0.247774,-0.354119,0.273301,-0.258744,0.575561,-0.509898,-0.205128,0.830315,-0.524409,0.684519,-0.295433,0.0534642,-0.3411,-0.102686,0.533102,-0.540526,-0.141855,0.177423,-0.819874,0.15637,-0.00150854,-0.00215792,-0.35823,0.0319092,-0.426566,0.678173,0.316422,-0.331437,-0.492939,-0.515787,-0.439021,-0.204688,-0.320144,-0.408583,-0.124708,-0.335369,-0.683883,0.237615,0.388837,-0.127027,0.51871,-0.529505,-0.203106,0.312682,0.0980948,-0.519569,0.200176,-0.27139,-0.0908901,0.276044,-0.479382,-0.18685,0.414954,0.465806,-0.19778,-0.324964,-0.0519874,0.340325,0.502781,0.29942,-0.905828,-0.185852,0.280356,0.226304,0.443494,-0.329952,0.537646,-0.164763,-0.754184,-0.181228,-0.0633215,-0.588536,0.167255,0.243986,-0.334963,-0.107258,-0.241317,-0.261435,0.321761,-0.0883915,0.171829,0.211175,0.414523,0.459538,-1.43855 +3394.3,0.77684,0.0912059,4,1.57215,1.00567,-0.858051,0.138479,0.585825,-0.0224577,0.0221862,-0.505136,-0.0604262,0.101609,-0.222259,-0.562272,-0.0272084,0.467302,-0.25883,0.594568,0.394399,-0.190177,0.262596,0.0776793,-0.561003,-0.207959,-0.341983,-0.376008,0.158403,-0.0756574,0.515912,0.223981,-0.603108,-0.437469,0.655137,-0.452125,-0.119282,0.567658,-0.242868,0.0349446,0.345622,0.362327,0.271578,0.365129,1.02987,0.62316,0.291365,-0.409413,-0.00984618,-0.0766513,-0.235808,0.389188,0.495169,0.296367,0.267981,-0.537441,0.633646,-0.554781,1.31148,-0.0828292,0.208195,-0.423289,0.240485,0.238249,0.435825,1.32023,-0.0598397,-0.757507,-0.00520374,0.12145,0.146251,0.425328,0.115718,0.0181862,0.531465,0.105769,0.338026,-0.453385,0.93319,-0.0015261,0.361898,-0.554276,-0.423519,0.299073,0.149536,-0.61905,0.379693,-0.714655,-0.149003,0.170538,-0.504144,-0.000197021,0.707621,-0.404218,0.48783,-0.3847,-0.214392,-0.0951439,-0.198658,-0.263124,0.269608,-0.00647914,-0.254485,0.535766,-0.32129,0.576455,-0.640309,0.0415137,0.409008,-0.387717,0.697157,-0.210918,0.181817,0.706862,0.864692,-0.754308,0.505266,-0.138785,-0.0458197,-0.0753506,-1.02093,0.525284,0.0222414,0.206962,-1.70279,-0.0845649,-0.326473,-0.281934,-0.576446,0.258457,0.437356,0.274823,0.162895,-0.258148,-0.259029,-0.32589,-0.119037,0.713586,-0.666542,-0.126898,-0.425999,0.166181,0.64653,-0.560574,-1.11335,0.0781651,0.307736,-1.01001,-0.309835,0.121005,-0.398576,0.997024,-0.357981,-0.536334,0.137885,-0.218288,-0.0359178,-0.00542365,-0.27159,0.679823,0.826554,-0.179208,0.109077,-0.477461,0.811348,0.194248,1.11064,-0.337158,-0.586182,0.572537,0.00327065,-0.222209,0.305458,-0.221471,-0.303616,0.360435,-0.334834,-0.429944,-0.252466,-0.309712,0.0773662,-0.43026,-0.407936,0.713088,0.261638,0.268439,0.403581,0.291796,0.0357052,0.284581,-0.821,-0.332597,0.159399,-0.348728,-0.389601,0.00665182,-0.037014,-0.679294,0.526276,0.121737,-0.28924,-0.252823,-0.652901,-0.229376,0.0960121,-0.779608,0.000827635,-0.0774427,-0.294641,-0.410308,-1.03724,0.643048,-0.168623,0.649753,-0.0386288,0.0856516,0.412832,0.341676,-0.318968,0.53789,-0.568456,0.133289,0.0817882,-0.253159,-0.222357,-0.435838,0.0517972,0.465412,-0.33587,0.490561,-0.495037,-0.245246,0.669757,-0.299907,0.832445,-0.228042,-0.0869246,-0.261396,-0.00861072,0.729659,-0.302667,-0.0947962,0.117512,-0.327532,-0.109616,-0.177876,0.681648,-0.0733571,-0.0130458,-0.623006,0.67704,0.132807,-0.819602,-0.542046,-0.534356,-0.648759,-0.118265,-0.335777,-0.418946,-0.198569,-0.325457,-0.917173,0.249852,0.283661,-0.271307,0.237305,-0.281096,0.140685,0.266901,0.340212,-0.374559,0.161914,-0.204354,-0.25829,0.37685,-0.436279,-0.583225,0.676169,0.478073,-0.184304,-0.41891,-0.0213667,0.306899,0.378695,0.102108,-0.572166,-0.0357166,-0.153204,0.195924,0.300307,-0.493791,0.119448,0.0165447,-0.77941,-0.245521,-0.0545233,-0.702179,0.0982867,0.259449,-0.515732,0.122186,-0.472495,-0.445971,0.343836,-0.0857627,0.192927,0.186402,0.439234,0.431743,-1.82553 +3384.91,0.766589,0.0912059,4,1.64272,1.10586,-0.812958,0.301956,0.0586013,-0.222146,0.0312493,-0.0200378,0.568467,0.77999,-0.380561,-0.348867,0.344338,0.179169,0.04669,1.05425,0.416957,-0.151313,0.078361,0.408786,-0.39056,-0.910227,-0.664639,-0.0322158,-0.16304,-0.199859,-0.311785,0.664598,-0.248731,-0.0874872,0.94799,0.141529,-0.266318,-0.00614699,-0.741864,-0.20441,-0.867982,0.249079,-0.0732715,-0.380808,0.711905,0.600259,-0.25192,-0.591776,-0.0797351,0.172592,-0.506809,0.0743296,0.316504,-0.179877,-0.20024,1.31861,0.133581,-0.507739,0.231641,-0.2434,-0.0726438,-1.23041,-0.343971,-0.560525,0.160803,1.20736,-0.869506,-0.623904,0.434762,0.646403,0.775049,-0.0157991,-0.149489,-0.855689,-0.0106305,0.266866,0.761483,0.0455215,0.230335,0.326258,0.272499,0.446597,-0.843492,-0.175438,0.0579463,0.0712126,0.0758336,-0.28673,-0.120119,0.146154,-0.550985,0.0639118,0.22966,-0.930284,-0.529812,-0.152348,0.0210514,-0.152402,0.0724335,-0.531984,0.179595,-0.181946,-0.770084,0.281821,0.174627,-0.127984,-0.000931138,-0.76051,-0.230357,-0.870863,0.163995,-0.269653,-0.209878,0.597449,-0.155978,-0.366752,-0.000755021,0.161621,0.647123,-0.304983,0.105367,0.280501,0.284826,-0.189732,-0.336207,0.0455387,-0.408629,-0.155383,-0.363773,0.112027,-0.174564,-0.440677,0.287467,-0.487317,-0.635472,0.14441,-0.0471711,0.0258781,-0.492007,0.326327,-0.790833,-1.10806,0.19241,-0.680971,-0.0876738,-0.00313202,-0.104213,-0.513806,-0.0348198,0.0357541,0.422417,-0.125738,-0.662927,0.025761,0.026985,0.305768,0.608419,0.425374,0.527873,0.878265,0.189335,-0.256327,-0.112943,0.390829,0.046449,-0.301891,0.449431,0.0760764,-0.404605,-0.673798,-0.0377817,-0.098717,-0.326439,-0.274782,0.393061,0.0211504,-0.323341,0.387081,-0.537854,0.264042,0.20436,0.128738,0.0812661,0.440395,-0.0164725,-0.533883,0.0470392,-0.375437,0.637913,-0.160114,-0.28682,0.174921,0.309034,-0.525786,0.35369,0.102466,0.25778,-0.759693,-0.53768,-0.352127,-0.132004,-0.514659,-0.997852,0.0547543,-0.168961,-0.372315,0.0492599,-0.422815,-0.350694,0.00283475,0.0928521,0.394637,-0.0188064,0.806194,-0.550855,-0.149979,-0.244799,-0.175567,-0.224787,0.739263,0.135921,0.146913,0.141875,0.543605,0.0237707,-0.534757,0.609273,0.158228,0.0623284,0.324916,0.325547,-0.228635,-0.328935,-0.28697,0.0142926,-0.117823,-0.464279,0.117487,0.479932,0.853814,0.177785,0.23731,0.274612,-0.0249634,-0.905291,0.196744,-0.220555,0.828766,1.07738,0.438403,0.634213,0.750929,-0.0248129,-0.0413568,0.41509,-0.551201,0.189535,-0.381364,-0.26459,-0.157325,-0.157279,-0.527736,-0.477893,-0.0831854,0.0185526,0.631018,0.236654,0.398072,0.786315,0.529798,-0.478872,-0.485728,-0.0669598,-0.0159906,-0.332271,-0.131031,-0.11692,-0.0821654,0.0534786,0.389028,0.775785,0.0495082,0.821983,-0.873941,-0.630476,0.217639,-0.109409,0.0164822,-0.178928,-0.051136,0.343166,-0.0861205,-0.301095,0.465457,-0.294881,0.32357,-0.0331142,0.93434,0.399434,-0.436758,0.170573,-0.363227,-0.325098,-0.0172579,0.289646,0.165119,0.230337,0.406348,0.479934,-0.310625 +3410.51,0.812263,0.0912059,5,1.60099,1.08038,-0.700232,0.245077,0.580113,-0.108308,0.197802,-0.166097,-0.0101908,0.324887,-0.422262,-0.22136,0.370188,0.0621631,-0.229576,1.17351,0.33357,-0.190616,0.348822,0.193732,-0.5298,-0.87875,-0.954512,-0.338692,0.0665484,-0.153809,-0.483726,0.614833,-0.622188,0.0677922,0.808351,-0.501392,-0.121327,0.180088,-0.534672,-0.196933,-0.271632,0.723014,-0.0090372,-0.0828389,0.80245,0.330986,-0.611069,-1.355,0.0236284,0.207616,-0.494382,-0.0675576,0.406389,0.12791,0.221851,0.445173,0.176197,-0.295491,0.555405,0.0990578,-0.243793,-1.0172,0.00631346,-0.193574,0.0666185,0.750827,-1.04309,-1.05189,0.355198,0.259953,0.0293234,0.61959,-0.267197,-0.111018,0.0546842,0.0485339,0.676811,-0.138334,0.145341,-0.329133,0.511491,0.0217801,-0.472741,-0.165269,0.815809,0.195147,0.39852,-0.11297,0.214007,0.237278,-0.267234,-0.526841,-0.35546,-0.317809,0.150808,0.477532,0.0316371,0.389696,-0.320775,0.157869,0.734064,0.501387,-0.292399,0.148805,0.353885,-0.351864,0.129346,-0.261356,-0.250573,-0.293834,0.380981,-0.279495,0.413459,0.693099,-0.173514,-0.033492,0.199143,0.266248,-0.0619221,0.134426,-0.049795,0.238801,0.589058,0.177115,-0.413373,0.27832,-0.216688,-0.0250961,0.0518502,-0.0322043,0.317728,-0.438732,0.284492,-0.04229,-0.270448,0.363961,-0.226925,-0.0503454,-0.937316,0.291551,-0.260225,-0.365019,0.617936,0.0586898,0.237009,0.344466,-0.232512,0.00504511,0.535473,0.395012,0.220948,0.309306,-0.229464,-0.0944233,-0.543179,-0.165818,0.101274,0.0609971,0.301232,0.370131,-0.220029,-0.707888,0.0405607,0.350798,0.788251,0.22227,0.405616,-0.024861,0.126669,-0.262448,-0.147439,-0.809163,-0.277843,-0.500866,0.182653,-0.0361442,-0.0806163,-0.0107,-0.041426,0.399883,0.279726,-0.0101189,0.104359,0.417937,0.228224,0.0154071,-0.242235,-0.419969,0.314034,0.192919,-0.637002,-0.125487,-0.328083,-0.100192,0.0905172,-0.124042,0.117935,-0.541236,-0.134222,0.0873003,-0.40257,-0.41705,-0.817571,-0.0346081,-0.149352,-0.364846,0.117869,0.50765,-0.033147,0.107893,-0.142706,0.896743,-0.0881196,-0.113037,0.151559,-0.441618,-0.0984995,0.0633804,-0.0959662,-0.0370736,0.0108339,0.340578,0.490538,0.297762,0.749442,-0.0950997,0.00183578,-0.353563,-0.192083,0.500963,-0.310214,-0.940243,0.501613,-0.0161756,-0.179798,-0.174735,-0.44298,-0.402586,0.70056,0.686374,0.244988,0.108205,0.413883,-0.96644,-0.166789,0.0532683,0.273974,-0.232336,0.7971,0.340054,0.589939,0.119248,-0.470771,-0.0310913,0.0909002,-0.273497,0.148514,0.253933,-0.667524,-0.0498275,-0.0271799,-0.48528,-0.794356,0.275739,0.143388,-0.355862,-0.000101505,0.601288,-0.0630999,-0.0771241,-0.326928,0.226285,0.232167,0.209133,-0.389847,-0.29534,0.164095,0.127309,0.775836,0.137804,0.172168,-0.0682845,0.433888,-0.0879113,-0.19753,-0.119013,-0.259292,0.0543667,-0.213291,-0.0832544,-0.62389,0.356773,-0.309257,-0.198917,0.139962,0.604381,0.0374395,0.513906,0.231756,-0.449553,0.123637,0.186485,0.294996,0.106223,-0.039733,0.120586,0.260762,0.347255,0.510648,-2.07236 +3421.16,0.990236,0.0912059,4,1.52984,1.11651,-0.691789,0.178425,0.0520363,-0.102442,0.378652,0.301462,-0.0047134,0.275239,-0.307294,-0.460638,-0.145076,0.200496,-0.16596,1.00803,0.482976,-0.315138,0.406137,0.241816,-0.312784,-0.953876,-0.897107,-0.267246,-0.0847162,-0.28783,-0.171195,0.587897,-0.3728,0.342438,0.567576,-0.648139,0.000748798,0.273703,-0.521597,-0.170219,-0.545337,0.322428,0.24418,0.186981,1.10622,0.547967,-0.406847,-0.917663,-0.143627,-0.0827313,-0.519122,0.13402,0.483252,0.0807892,0.425837,0.391346,-0.0161166,-0.559389,0.668112,-0.198956,-0.0760298,-0.953068,0.0103934,-0.0829857,0.113349,1.21304,-0.965462,-1.02753,0.0378191,0.524531,-0.131392,0.488604,0.0221547,-0.298938,0.113463,0.345308,0.509583,-0.115433,0.669043,-0.277809,0.750005,-0.129666,-0.442759,-0.135542,0.532529,0.134874,0.48614,-0.199679,0.426573,0.360603,-0.170407,-0.187257,-0.338069,-0.156387,0.350743,0.364454,0.0734359,0.294886,-0.353417,-0.359854,0.547096,0.52445,-0.0258474,0.259535,0.237258,-0.137287,0.106595,-0.125676,0.118304,-0.295869,0.41336,-0.573402,0.552466,0.393991,0.230202,-0.00269909,0.0577035,0.109637,0.0210226,0.136445,-0.481471,0.288449,0.434056,-0.26444,-0.714673,-0.0121405,-0.535094,-0.0141845,-0.032421,0.034141,0.0463481,-0.0655127,0.246083,-0.299297,-0.18337,0.249255,-0.168609,-0.0879115,-0.89121,0.16772,0.184701,0.0803684,0.703059,-8.24241e-05,0.436434,0.2877,-0.64547,-0.224153,0.311566,0.312712,0.189256,0.426398,-0.197208,-0.328699,-0.534314,-0.189071,0.196501,-0.367757,0.491137,0.357075,-0.250313,-0.428022,-0.00372937,0.378965,0.69102,0.476441,0.441747,-0.10134,-0.280201,-0.470183,-0.243299,-0.491372,-0.427865,-0.554712,0.0236272,0.594195,-0.134505,-0.0550374,0.211444,0.357534,-0.182872,-0.112143,-0.265794,0.395525,0.461411,-0.190386,-0.368017,-0.212011,-0.30717,0.40994,-0.678986,-0.0620305,0.0877885,0.0209186,-0.0688694,-0.406961,0.225488,-1.00452,0.0344369,0.0102986,-0.158807,-0.73834,-0.612639,-0.0562691,-0.186538,-0.529194,0.170762,0.09534,-0.0471253,0.105379,-0.22287,0.840195,-1.90289e-05,0.0630977,-0.214672,-0.165452,0.159775,-0.04974,-0.399152,-0.176122,0.0188959,0.192927,0.350126,-0.0523238,0.588591,-0.0309822,-0.0918308,-0.0170759,-0.770152,0.586328,-0.0289056,-0.593719,-0.129327,0.185188,0.0199667,-0.165306,-0.286882,-0.241988,0.633659,0.695245,0.087582,0.129054,0.362715,-0.718635,-0.297122,-0.0215155,0.537821,0.0760972,0.654288,0.240107,0.274696,0.296572,-0.70512,0.0145844,-0.109983,-0.000897829,0.384412,0.516971,-0.537882,-0.0740886,-0.21982,-0.149819,-0.587743,0.0628404,0.298828,-0.375278,-0.132415,0.262828,-0.105867,0.10468,0.0275683,-0.306191,-0.108585,0.320495,-0.355723,-0.074336,-0.185742,0.195511,0.358115,0.370435,0.0388301,0.0246114,0.74225,0.024133,-0.321192,-0.0421491,-0.394687,-0.227065,0.0318416,-0.0384597,-0.175874,0.532665,-0.0704482,-0.015979,-0.170483,0.598373,-0.210768,0.229328,0.0030277,-0.400915,0.0528389,-0.0155016,0.259934,-0.00520193,0.281173,0.127098,0.313527,0.356508,0.559935,-0.396974 +3406.77,0.85163,0.0912059,4,1.56624,1.02684,-0.739585,0.276695,0.410967,-0.0960762,-0.14003,0.304221,0.3375,0.119345,0.170877,-0.229475,0.448683,0.124177,0.199774,0.605862,0.195498,-0.315585,0.117379,-0.215513,-0.404757,-1.03073,-0.605147,-0.180338,0.0172182,-0.434675,0.0439345,0.115123,0.0951752,-0.135778,0.787961,0.233646,0.158828,0.43162,-0.481485,0.140233,-0.62685,0.801623,0.620235,-0.808661,0.931668,0.258723,0.127961,-1.01182,-0.121546,0.12121,-0.200418,0.366224,0.0625142,0.0882732,-0.0688476,0.362764,-0.225861,-0.773691,0.610277,-0.00849116,-0.250896,-0.388235,0.0452373,-0.146251,0.406915,0.988976,-0.0202901,-0.388012,0.416996,-0.35349,-0.00370799,0.0260341,0.204536,-0.342662,0.179758,0.157703,0.869511,-0.0880937,0.420811,0.624121,0.373745,-0.43106,0.0851453,0.349037,0.657272,-0.314206,0.371246,-0.0970071,0.317048,0.0537812,0.607089,-0.356217,0.271093,-0.659716,-0.148849,-0.26415,-0.073555,0.105581,0.103197,-0.0545985,-0.314921,-0.756772,0.863677,0.135491,0.0274698,0.341501,-0.162427,-0.0617135,-0.21512,0.151974,-0.0400266,0.412519,-0.154948,0.350956,-0.117171,0.251115,0.391903,0.0840718,-0.17135,0.0689995,0.168848,0.24369,-0.473023,0.203606,-0.939178,-0.389167,-0.138198,-0.250665,0.108678,0.00053174,0.341192,0.0869507,-0.0430709,-0.168087,-0.0374393,-0.109474,-0.0615173,1.09748,-0.439879,-0.200367,-0.657493,-0.123027,0.0689531,-0.757558,-0.266232,0.133838,0.455082,0.0799484,0.104267,-0.353368,0.143051,-0.0572126,-0.289501,-0.672496,0.356896,-0.0591591,0.228939,0.163535,0.457337,0.115612,0.402153,0.0672325,-0.256505,-0.0700597,0.1387,0.272777,0.94201,-0.0165048,0.00772956,-0.173099,0.40396,-0.236522,0.170368,0.466029,0.615841,-0.879645,-0.514705,-0.487453,-0.0836158,-0.75716,0.132899,-0.213642,0.235155,0.404761,-0.329186,0.507543,0.366231,0.195211,-0.118392,-0.344129,0.326633,-0.290013,0.337458,-0.61628,0.432223,-0.114679,-0.30945,-0.768583,0.115334,-0.124704,0.115836,0.364676,-0.281493,0.0713651,0.554118,-0.268128,0.428045,0.289431,0.189303,-0.753831,-0.784946,0.741156,0.140592,0.447651,0.0364589,-0.0534094,-0.0700597,0.430749,0.2589,-0.0435771,-0.664876,-0.0574603,-0.108469,-0.336224,0.223178,-0.371122,0.112777,0.132568,0.26332,0.331876,-0.357762,-0.234916,0.198322,0.293839,0.389811,-0.294719,-0.39189,-0.2796,-1.11822,0.635375,-0.658651,-0.0703342,0.21704,0.162512,-0.544229,0.133355,-0.458269,-0.271319,0.502671,0.491182,0.334724,0.455095,-0.479875,-0.361725,0.118628,-1.41564,-0.0740132,-0.515492,-0.360868,0.393914,-0.158034,0.304569,0.201352,0.214399,-0.0793088,1.01762,0.0418593,-0.138241,-0.0878473,0.259914,-0.0645001,0.179307,-0.158646,-0.162757,0.757047,-0.160051,0.0580231,-0.336828,0.0420823,-0.541686,-0.14734,0.489727,0.468004,0.368358,-0.432284,-0.564825,-0.529591,0.135596,0.0506364,0.187918,-0.0665177,0.0874344,0.568715,-0.238645,-0.258142,-0.0481429,0.251169,0.282348,0.028972,-0.229585,-0.0794512,-0.162623,-0.556644,0.0219436,-0.330123,0.172614,0.19924,0.415469,0.446364,-1.46328 +3425.93,0.998486,0.0912059,5,1.60283,1.06651,-0.443025,0.102238,0.17805,-0.104155,0.395694,0.110936,0.533252,0.412188,-0.328009,-0.189141,-0.389177,0.225307,-0.324678,0.927285,0.0703751,0.163219,-0.330817,-0.0924138,-0.370277,-0.588787,-0.62173,-0.153172,-0.327855,-0.33087,-0.0955111,0.38461,-0.128867,-0.0352069,0.411298,-0.502004,-0.185404,-0.0351187,-0.267484,-0.41873,-0.0473772,0.172229,0.0171737,-0.106698,0.709431,0.583421,0.00439179,-0.551703,-0.22098,0.225584,-1.04227,-0.113377,0.0617639,-0.59727,0.242896,0.269426,-0.143225,0.220798,0.6566,-0.15951,-0.0852188,-0.337466,0.132843,-0.29121,-0.334985,0.999421,-0.834142,-1.17518,-0.412246,0.571131,0.138112,-0.491034,0.0378191,-0.400813,-0.170768,0.615758,0.598081,0.105049,0.621024,0.0440495,0.254712,0.537946,-0.389403,-0.225708,0.128551,-0.335164,0.18101,-0.679269,-0.152997,0.246061,-0.304688,-0.304689,0.238213,-0.145173,-0.187147,-0.070201,-0.187071,-0.0710008,0.0803117,-0.90158,0.254396,0.420396,-0.336079,0.413894,0.251842,-0.421927,-0.490313,-0.345529,-0.0668344,-0.562608,0.377733,-0.423743,0.824805,0.541411,-0.460482,-0.202121,-0.439925,0.426571,0.159449,-0.373168,-0.904158,0.0617825,0.7891,-0.340386,-0.504004,-0.358475,0.0126661,0.151764,-0.0714305,0.117827,-0.207983,-0.950659,0.467073,-0.248575,-0.238182,0.402397,0.0214281,-0.151672,0.11819,-0.0251346,0.602711,0.0852947,0.568438,-0.264606,-0.213291,0.00343073,-0.35915,-0.102562,0.352609,0.3934,-0.559753,0.692388,-0.164107,0.241482,-0.432782,0.0561986,-0.0301066,-0.148852,-0.129284,0.506317,-0.0659106,0.150594,0.384027,-0.132187,0.0891817,-0.158115,0.356044,-0.442393,0.530867,0.432341,0.0428142,0.128797,-0.296817,-0.587004,-0.141199,0.342746,-0.107193,-0.105149,0.0751949,0.141555,-0.279246,0.0617891,0.251353,0.500888,-0.176317,-0.431414,0.0371183,-0.335681,0.0703184,-0.162133,-0.494533,-0.28343,0.223448,-0.0618673,-0.0541122,-0.00850899,0.27119,-0.448455,0.186239,0.325229,-0.0311835,-0.822979,-0.385083,0.0830364,-0.463779,-0.0191407,0.449883,-0.26545,-0.165505,0.516165,-0.0876718,0.991253,-0.101671,0.118194,-0.348108,-0.0375885,0.315044,0.0588061,-0.793927,0.331002,0.315573,0.337089,0.594446,-0.150604,-0.123138,-0.0845898,-0.335831,0.419975,-0.787371,0.81735,0.143445,-0.248063,-0.23683,0.110143,-0.50263,0.116389,0.0292256,-0.363596,-0.298713,0.416071,0.454175,0.204445,0.399716,-0.432512,-0.139969,0.0630032,0.375804,-0.205818,0.233966,0.108506,0.428941,-0.265467,0.028992,0.0839633,-0.506317,0.0251284,0.547263,-0.112718,0.153959,0.277435,-0.32838,-0.112864,0.329746,0.0632988,0.261567,-0.189661,0.158172,0.603001,0.176826,0.206337,-0.13871,-0.459375,0.0606692,-0.011341,-0.825488,0.0159974,-0.367632,0.0740799,-0.580517,0.32039,0.228493,-0.330201,0.757422,-0.1501,0.161711,-0.375528,-0.170603,-0.162624,0.482313,0.3398,-0.150553,0.127416,0.0446749,-0.247255,0.00476733,0.0187649,-0.22878,-0.317322,-0.138992,-0.160346,0.091217,-0.217081,0.126308,-0.197086,0.435511,0.133409,0.241355,0.365252,0.491279,-0.711947 +3425.15,0.996945,0.0912059,4,1.605,1.06717,-0.396432,0.0649083,0.176983,-0.111774,0.453123,0.103689,0.620945,0.403085,-0.37731,-0.163625,-0.27295,0.219537,-0.210416,0.914476,0.117174,0.249771,-0.34085,-0.0587674,-0.379557,-0.590055,-0.631677,-0.12278,-0.41356,-0.282127,-0.121461,0.348606,-0.209927,-0.0250595,0.474949,-0.469195,-0.230751,-0.022994,-0.333403,-0.428106,-0.11715,0.126204,-0.0083914,-0.125283,0.704997,0.567305,0.0028573,-0.613546,-0.223309,0.311033,-1.01357,-0.0938031,0.116427,-0.591346,0.234463,0.305929,-0.114703,0.236067,0.604366,-0.264984,-0.111751,-0.304406,0.166683,-0.20196,-0.182085,0.970098,-0.951376,-1.20567,-0.358054,0.651349,0.204623,-0.459355,0.115434,-0.381824,-0.0772702,0.568014,0.564125,0.121521,0.614742,0.0604134,0.364599,0.489703,-0.397459,-0.246462,0.170237,-0.353968,0.112729,-0.646868,-0.0750556,0.2915,-0.328432,-0.236438,0.216797,-0.194231,-0.156306,0.0176893,-0.213196,-0.105259,0.123283,-0.912199,0.131119,0.484771,-0.334522,0.404497,0.364326,-0.314653,-0.563508,-0.351679,-0.0952569,-0.628451,0.425556,-0.406767,0.806143,0.566876,-0.33954,-0.159403,-0.421871,0.386796,0.187482,-0.387289,-0.80632,0.0742011,0.783505,-0.335433,-0.542489,-0.383206,-0.00574733,0.191438,0.00466094,0.114351,-0.116943,-0.907618,0.440127,-0.180089,-0.337842,0.402227,0.0265719,-0.138925,0.0614859,0.131279,0.63972,0.0427921,0.528046,-0.286915,-0.128054,-0.0110358,-0.264151,-0.106471,0.379536,0.515964,-0.54602,0.782239,-0.124448,0.391055,-0.432443,0.0105428,-0.0229953,-0.191175,-0.0333931,0.514843,-0.0717022,0.112241,0.330239,-0.184269,0.170405,-0.0925782,0.339634,-0.418719,0.570134,0.374655,-0.00720768,0.171399,-0.302257,-0.578522,-0.0737384,0.311551,-0.122896,-0.0975133,0.160073,0.249956,-0.273026,0.0840657,0.294773,0.383932,-0.156831,-0.411603,0.0129957,-0.296518,0.0455048,-0.154916,-0.419974,-0.36289,0.295018,-0.0852698,-0.0135498,0.0608951,0.387446,-0.4846,0.277207,0.368205,-0.0230903,-0.840892,-0.50472,0.0894848,-0.489579,-0.0883799,0.372367,-0.172798,-0.273769,0.468678,0.0296436,1.05211,-0.16843,0.11742,-0.277625,-0.0143204,0.300106,0.0896281,-0.799502,0.383231,0.375516,0.371341,0.597107,-0.173596,-0.141846,-0.0439304,-0.33472,0.394588,-0.708332,0.750709,0.160756,-0.227301,-0.255606,0.0851954,-0.437302,0.110685,0.0996288,-0.433149,-0.256557,0.41534,0.395903,0.192382,0.435789,-0.436883,-0.164504,0.0195997,0.391862,-0.187301,0.218138,0.152886,0.46918,-0.261698,0.0690026,0.174412,-0.524974,-0.0274414,0.491446,-0.0889794,0.147372,0.243197,-0.325575,-0.0186084,0.310741,0.0308447,0.218144,-0.124987,0.121724,0.628859,0.125807,0.236756,-0.15282,-0.405883,0.0281234,-0.0347091,-0.818903,-0.000714539,-0.309668,0.00743964,-0.519704,0.241216,0.236231,-0.330797,0.756228,-0.129058,0.134064,-0.4291,-0.185485,-0.0273464,0.520824,0.304168,-0.216438,0.0642757,0.0132874,-0.196171,0.0496095,0.0260809,-0.228322,-0.311816,-0.125047,-0.18719,0.116208,-0.242474,0.131544,-0.178411,0.413975,0.136277,0.245009,0.369157,0.494984,-0.694579 +3410.2,0.999205,0.0912059,4,1.65109,1.0359,-0.202371,-0.0911721,-0.492955,-0.0974781,0.402388,0.00270552,0.421456,0.300442,-0.44887,-0.22482,-0.58867,0.224927,-0.389612,0.799411,0.300751,-0.322133,-0.137493,0.150261,-0.53609,-0.677621,-0.448012,0.235626,-0.287585,-0.595572,-0.439006,-0.0549933,-0.32162,-0.367396,0.556586,-0.22126,0.187495,-0.0979014,-0.255563,0.229588,-0.313922,0.164617,-0.0796334,-0.544308,1.00726,0.563111,-0.305074,-0.235559,-0.691648,0.43602,-0.968196,0.444344,0.720733,-0.333688,0.425829,0.0270607,-0.109191,-0.138942,0.696676,-0.337636,-0.236129,-0.31849,0.396395,-0.229584,0.0788663,0.844828,-0.870892,-0.227523,-0.418087,0.184368,0.374137,-0.370133,-0.595388,-0.346981,0.222314,0.907673,0.940025,-0.223942,1.03379,0.309361,0.194427,0.166702,-0.216415,-0.143206,-0.0534293,-0.190491,-0.0593698,-0.969007,-0.0955426,-0.146769,-0.292842,-0.0839469,0.00310361,-0.538874,-0.120547,0.146141,-0.0836962,0.000281748,0.110158,-0.327163,-0.172073,0.242994,-0.536314,0.295139,-0.353585,-0.324693,-0.719364,0.0555877,-0.120269,-0.318541,-0.200889,-0.693843,0.295037,0.359539,-0.232142,-0.28779,-0.156019,0.530324,0.0935531,0.0686864,-0.640798,0.221281,0.442901,-0.200759,-0.708082,-0.192674,-0.465634,0.206112,-0.274154,0.0497102,-0.0543936,-0.549225,0.00975348,-0.382565,-0.425429,-0.0853938,0.00221531,-0.0404041,-0.115461,-0.36854,0.497461,0.205214,0.464222,-0.533736,-0.203445,-0.1273,-0.231761,-0.194905,0.0985409,0.418636,-0.271119,0.491639,-0.186245,0.216008,-0.52414,-0.0846065,-0.0378146,-0.155199,-0.169923,0.471948,-0.0923543,0.132281,0.237769,-0.616406,-0.215958,0.106116,0.524771,-0.317795,0.822781,0.221574,-0.01065,0.0303314,-0.429897,0.0513642,0.249048,0.175269,0.00401136,0.0401722,0.132822,0.433425,-0.446436,-0.33851,0.317093,0.237708,-0.113787,-0.448353,0.0332061,-0.0518936,0.00393981,0.222076,-0.00188156,-0.161804,0.506392,-0.103819,0.132245,0.0773956,-0.0465335,-0.69724,0.0951479,0.522548,-0.363297,-0.504286,-0.1639,0.222825,-0.3533,0.0241677,0.181623,0.0100559,-0.507933,0.0456294,-0.0480088,1.08451,0.154821,0.335059,0.0994335,-0.0994892,0.157517,-0.106209,-0.981274,0.114179,0.668201,0.0610103,0.746359,-0.0509831,-0.0211448,0.0341275,-0.19907,-0.326567,-0.323304,0.291858,0.397267,-0.51779,0.105315,0.27802,0.0761995,-0.0765019,-0.104949,-0.195906,0.225283,0.44468,-0.436378,0.610516,0.38403,-0.200332,-0.388118,0.147643,-0.105968,0.292725,0.693575,0.376104,0.313421,-0.167693,0.11467,-0.0719203,-0.254705,-0.451689,-0.115063,-0.78542,0.102442,0.566996,-0.747826,-0.394928,0.712273,-0.14377,-0.0320315,0.256373,0.2257,0.252195,-0.151943,0.329108,-0.0819911,0.136416,-0.28755,0.216401,-0.258823,0.327098,0.247063,-0.502334,-0.384636,-0.0116899,0.090937,-0.220264,0.387772,-0.228347,-0.15096,-0.277801,-0.0570561,-0.166011,0.540411,0.365575,0.0246288,-0.05808,0.621656,0.285419,-0.0306907,-0.0599726,-0.328276,-0.0235638,0.156105,-0.279927,0.0625334,-0.135065,-0.0919252,0.0022488,0.495467,0.116301,0.167998,0.341029,0.409876,1.67333 +3426.11,0.948106,0.0912059,5,1.60688,0.944504,-0.659295,0.151864,-0.0518158,-0.0586246,0.251857,0.236019,0.114164,0.748498,-0.299086,-0.335511,-0.387118,0.243063,-0.0107899,0.680363,0.293293,-0.177517,-0.440458,0.0418981,-0.216993,-0.801865,-1.34726,0.370745,-0.10414,-0.180668,0.0587368,0.310544,-0.118477,-0.074982,0.383155,-0.577917,-0.840959,-0.0190503,-0.420249,-0.176479,-0.162375,0.849648,0.089621,-0.515978,1.18464,0.655168,0.39156,-1.02149,-0.237767,0.0506747,-0.412488,0.869492,0.535358,-0.450626,0.456291,0.237813,-0.0753138,-0.550898,0.828115,-0.119175,0.283407,-0.591803,0.363818,-0.391979,0.249126,1.70521,-0.188563,-0.930387,-0.111982,-0.30678,0.310153,-0.369255,-0.572899,-0.344724,-0.240619,0.581093,0.677318,0.247117,0.77566,0.235801,0.47007,-0.00442621,-0.537759,0.146599,0.577162,-0.464186,-0.114994,-0.145276,0.295724,0.28472,0.0116369,-0.156576,0.0760501,-0.0224191,-0.663063,0.298628,0.110685,0.0658465,0.10406,-0.216659,-0.142607,0.100942,0.033997,-0.0732904,-0.118468,-0.128069,-0.106358,0.163413,0.103745,-0.596432,0.176848,0.0970501,0.276954,0.323265,0.123925,-0.612678,0.23823,0.208279,0.0403187,-0.397386,-0.466067,-0.0827696,0.436983,-0.0844275,-1.10959,0.183506,-0.195505,-0.220452,-0.639347,-0.05297,0.0764442,0.0814145,0.357138,-0.158444,-0.101786,0.15778,-0.0805385,-0.108653,0.143072,0.0626912,0.465445,-0.578966,0.366398,-0.578443,-0.369421,-0.341278,0.0260756,-0.282602,0.125261,0.1344,0.196699,0.703566,0.146623,-0.166112,-0.529241,-0.111847,0.238088,-0.453401,-0.00402697,-0.018772,-0.0329212,1.00575,-0.245323,-0.473192,-0.193312,0.00561363,1.08691,-0.487576,0.293586,0.207422,-0.250898,0.422444,0.0251624,0.499326,0.00539538,-0.184347,-0.0778496,0.086725,0.125031,-0.0377496,-0.238764,-0.472786,0.0737242,0.0448412,-0.0226938,0.0225149,0.161968,0.225809,-0.193244,-0.130597,-0.49968,0.0990773,0.184342,-0.0933896,0.224423,0.674102,-0.216979,-0.634924,-0.0175767,-0.153286,-0.160926,-0.285617,-0.581888,0.664637,-0.411972,-0.333856,0.209496,0.121348,-0.28283,0.0269451,-0.230706,1.18545,-0.197063,0.0286339,-0.170417,-0.114332,-0.221884,-0.258845,-0.628354,0.399358,-0.203573,-0.02011,0.0963378,-0.283571,-0.116679,-0.955655,-0.0448648,0.137759,-0.348606,0.352446,0.324627,-0.195261,-0.295311,-0.177488,-0.355694,0.126746,-0.130057,-0.49739,-0.222309,0.258472,-0.593234,0.0627807,0.111144,-0.610091,-0.385709,0.139809,-0.380339,0.0747018,0.878709,-0.248757,0.344743,0.0656337,0.168273,0.131056,0.339674,-0.260328,-0.12555,-0.0933645,0.119246,0.148354,-0.359759,-0.908922,0.704983,0.135778,0.465804,-0.345532,-0.00581526,0.286927,0.425819,0.101521,0.377744,-0.243298,-0.523785,0.260658,-0.271183,-0.267463,-0.294548,0.239785,0.0713426,0.0295506,0.342214,-0.277063,0.273936,0.0917175,0.027885,-0.0822312,-0.414224,-0.467596,0.0177624,0.243183,-0.166818,0.236242,-0.00218168,-0.0412479,0.0493793,0.227315,-0.531712,0.0336989,-0.113767,0.0183356,-0.395079,-0.683202,0.0558992,0.296046,-0.00837416,0.132017,0.283082,0.363341,0.532054,0.3261 +3414.11,0.963061,0.0912059,4,1.6803,0.931204,-0.612425,0.130819,-0.145018,-0.189755,0.0527593,0.0941839,-0.0243657,0.530276,-0.554121,-0.0930333,-0.0931045,0.372147,-0.331871,0.932809,0.22288,-0.14935,-0.452893,-0.00811378,-0.396084,-1.22383,-1.3075,0.43323,-0.0352366,-0.201471,-0.14426,0.42633,-0.174363,-0.177142,0.498272,-0.332314,-0.302752,-0.0885974,0.0503001,0.043548,-0.224161,0.249764,-0.13361,-0.423067,1.05975,0.660848,0.61319,-0.724648,-0.338291,0.220529,-0.640644,0.627049,0.856751,-0.481476,0.569354,0.0527985,0.105583,-0.193174,0.600977,0.106097,0.294454,-0.684488,0.702676,-0.481076,0.0236298,1.1522,-0.456275,-1.28429,-0.503372,-0.0856945,-0.0344912,-0.539182,-0.218978,-0.402352,-0.203292,-0.379972,0.673463,0.0981737,0.651745,0.522457,-0.0381952,-0.308383,-0.526841,-0.380369,0.195507,-0.170548,-0.30074,0.0432086,-0.0578384,0.428716,0.00290716,-0.311773,0.448221,-0.0936821,-0.600284,0.539804,-0.034108,-0.34067,0.055558,-0.341039,-0.252525,0.0442272,-0.190385,-0.0796305,-0.481728,-0.0420455,-0.0406199,0.321238,-0.0698576,0.0190922,-0.346532,-0.136786,0.484517,0.108721,-0.0131893,-0.526312,0.59467,0.400157,0.00214465,-0.425273,-0.226035,-0.26329,0.835098,0.169209,-1.02989,0.0897975,-0.590509,-0.361918,-0.564488,-0.0273358,-0.275725,-0.28178,0.084115,-0.181801,-0.0450036,0.176129,-0.348639,-0.018391,-0.0236653,0.120863,0.14793,-0.318028,0.395287,-0.47811,0.131412,-0.0862184,0.186069,-0.382509,-0.206169,0.0525898,0.000357057,0.702075,0.119872,0.206451,-0.145429,-0.068771,0.15907,-0.636371,0.0570615,0.0503007,-0.200518,0.311346,-0.187218,-0.726023,0.533994,0.382044,0.79386,-0.506538,0.236198,0.0400151,-0.248523,0.096762,-0.365498,-0.0871427,-0.135848,-0.181756,0.0651474,-0.118766,-0.0782991,-0.298154,-0.374467,0.482801,0.225684,0.166341,0.306176,0.260389,0.207886,0.214086,0.19204,-0.380706,-0.282687,0.238293,0.125816,-0.33334,0.366546,0.476827,-0.104561,-0.761294,0.0843433,0.163869,-0.264464,-0.341964,-0.680954,0.0813654,-0.30531,-0.617063,0.0129845,0.0114183,-0.424304,0.101255,-0.559147,1.13917,-0.028507,0.0152633,0.0555433,-0.587628,0.00588214,-0.437449,-0.334194,0.993583,-0.56288,0.242671,-0.0565294,-0.353097,0.118043,-0.486516,0.2765,0.210425,-0.835897,-0.0551422,0.431612,-0.0340915,0.183106,0.0598171,-0.112033,0.134641,-0.41751,-0.630053,-0.0889405,0.203503,-0.659244,-0.269433,0.109458,-0.201817,-0.632914,0.262574,-0.0250357,-0.129361,0.739518,0.132187,0.64815,-0.291339,0.27159,-0.156283,0.0336303,-0.487978,0.186268,-0.109003,0.3004,0.585478,-0.16047,-0.945178,0.657817,-0.419138,0.128395,-0.0739778,0.601203,-0.229161,0.611709,-0.162623,-0.216691,0.140242,-0.266472,-0.131606,-0.507195,-0.144538,-0.407679,0.15291,-0.044743,0.126997,0.0657649,-0.472325,0.0584157,0.328893,-0.19977,-0.665418,-0.274541,-0.755578,-0.447282,-0.0991001,-0.303311,0.150772,0.119825,-0.202484,0.14547,0.617527,-0.41488,-0.093704,-0.495687,0.077255,-0.251627,-0.517378,-0.236411,-0.230251,-0.141691,0.117835,0.299769,0.343271,0.547512,0.76056 +3419.49,0.917637,0.0912059,4,1.65479,0.815591,-1.0889,0.27352,-0.0460824,0.0245189,0.163849,-0.422498,0.60313,0.129247,-0.140001,-0.240561,-0.811728,0.39147,-0.454946,0.558098,-0.00724508,-0.281403,0.158204,-0.127346,-0.540986,-0.702632,-0.813319,0.123698,-0.495111,-0.475695,-0.740572,-0.0679408,-1.03595,-0.0455207,0.535349,-0.631851,-0.611659,-0.191191,0.00905264,0.382444,-0.672304,1.05305,0.142185,-0.428361,1.09626,0.436574,-0.252093,-0.572488,0.159107,-0.490465,-1.34843,-0.356539,0.935259,0.285194,0.0753399,0.37305,0.0022857,-1.16472,0.963311,-0.543224,0.0479078,-0.457246,0.742196,-0.434771,0.594302,0.636668,-0.627999,-0.403778,0.303943,0.0603317,0.112672,0.0126699,0.198644,-0.352062,-0.305386,0.873922,0.623801,0.0133519,0.197322,0.331209,0.444894,-0.385563,-0.234161,0.526856,0.68515,-0.0643473,0.3363,-0.624867,-0.308181,0.0926606,-0.203252,-0.0639083,-0.284874,-0.341769,0.229634,0.475433,0.0593096,0.0898011,-0.368051,-0.468076,-0.179084,-0.325736,0.0809522,0.258889,0.72524,-0.0327418,-0.547876,-0.724029,0.40905,-0.275546,0.296421,-0.894076,0.292859,0.713832,-0.38469,0.450972,-0.302314,0.365351,-0.133251,-0.00606704,-0.101313,0.0391374,0.222082,-0.200768,-0.248057,-0.39658,-0.0530933,0.139748,0.302812,0.510859,-0.0432165,0.308636,0.253009,-0.69242,0.651311,0.00529219,0.488372,0.761003,-0.123023,0.0927651,-0.0829373,-0.0672506,0.388183,-0.26179,0.0946389,-0.307502,-0.112484,0.107769,0.173322,-0.215345,0.144752,-0.0403832,-0.12208,-0.511648,-0.566499,0.346701,-0.291501,0.0976333,0.439527,0.104131,0.725921,0.0352256,0.0808494,0.587755,-0.172183,-0.208254,0.72118,-0.0256787,0.0248857,0.458447,-0.530827,-0.454963,-0.158565,0.023116,0.441327,-0.281476,-0.0758869,-0.252756,-0.391941,-0.201272,-0.406465,-0.273299,-0.077647,0.549597,-0.346543,-0.152564,0.57709,-0.51532,-0.271349,-0.155701,-0.217886,-0.679894,-0.168875,-0.0622737,-0.158658,0.0107242,-0.169845,-0.156202,-0.0606405,-0.194541,0.087722,-0.255451,-0.443037,0.414057,-0.145665,0.230092,-0.00908036,0.185494,0.510961,0.358071,-0.293557,0.94438,0.437128,0.50814,-0.0137067,0.0161874,-0.0723056,0.378904,-0.301225,-0.222611,0.0310981,-0.325851,0.433372,-0.528169,-0.19204,-0.327159,-0.196321,0.524835,0.227932,0.0512067,-0.841985,-0.593539,-0.405881,-0.114559,-0.0455454,-0.027803,0.144076,-0.121739,-0.388883,0.354455,0.337073,-0.0446072,0.454675,-0.701831,0.316148,0.22456,-0.180709,-0.0456379,-0.04124,-0.59198,0.0586729,0.228403,0.186277,-0.174738,0.21013,-0.66555,0.453887,-0.20354,-0.621191,-0.207912,-0.226706,0.332003,-0.801073,0.154075,0.228392,0.338798,0.124233,0.197405,0.077359,0.26355,0.355268,0.0334787,0.102175,0.213329,-0.405295,-0.444354,-0.205931,-0.0694126,0.405089,0.239365,-0.309958,0.35888,0.273036,-0.271897,-0.348116,0.461572,0.597165,0.889483,-0.221692,0.245929,-0.0275293,0.54389,0.09853,0.0423855,-0.167029,-0.0688352,-0.00547806,0.470468,-0.367057,-0.509536,-0.111794,0.130894,-0.366469,-0.241988,-0.27678,0.111458,0.326892,0.333853,0.571745,0.672446 +3399.44,0.960606,0.0912059,4,1.6851,0.856244,-0.832794,0.231469,0.250465,-0.0692433,-0.103553,-0.81603,0.373948,-0.569475,0.133793,0.226449,-0.767744,0.185636,-0.445689,0.71919,0.0111897,-0.217123,-0.388467,0.189547,-0.296102,-1.13492,-0.790364,0.247645,-0.00647995,-0.224435,-0.174841,-0.232048,-0.209024,0.109404,0.811006,-0.358258,-0.131362,-0.0215951,-0.303439,-0.278108,-0.207401,0.553412,-0.209675,-0.529511,1.12047,-0.294379,0.156078,-0.403334,-0.131593,0.32728,-0.927993,-0.173034,0.715296,-0.103345,0.148256,0.0653751,-0.252345,-1.15214,0.682137,-0.701696,-0.348893,-0.690555,0.195574,-0.751603,0.0334893,0.920025,-0.214089,-1.05246,0.290963,-0.282148,0.407903,0.0291915,0.0172908,-0.161636,-0.622325,0.676163,0.245427,-0.0686692,0.408796,0.488016,0.0314557,-0.137602,-0.676092,-0.275999,0.278772,-0.327293,-0.135295,-0.0226786,-0.40004,-0.391583,0.590179,0.0235185,-0.476766,-0.477877,0.0978683,0.209913,0.137679,-0.152227,-0.345133,-0.221876,-0.422828,-0.328702,-0.108215,0.0913041,0.450266,-0.457258,-0.647579,-0.959905,0.327414,-0.208985,0.385131,-0.392983,0.297529,0.695744,-0.545636,0.615489,-0.0231384,0.469172,-0.188229,0.308566,-0.293339,-0.08886,0.294715,-0.155036,0.10888,-0.0537483,-0.124601,-0.965455,0.308571,0.605013,-0.41829,0.201336,-0.340724,-0.44795,0.688968,0.354384,0.742237,0.647325,0.0212848,0.0283944,0.154581,-0.210244,0.312464,-0.470331,-0.343561,-0.356172,0.20423,0.124042,0.0852439,-0.227551,0.445621,0.420979,0.256765,-0.365452,0.145946,0.408123,0.163685,-0.0365681,0.446731,0.227516,0.559913,0.577808,-0.0330755,-0.0899679,0.277604,-0.111329,0.66259,-0.28747,0.706145,0.815739,-0.56419,-0.385544,-0.358518,0.154649,0.0865644,0.553221,0.121731,0.123946,0.0830448,0.188551,-0.171968,-0.356129,0.0600663,0.676811,0.370603,0.0451515,0.06781,-0.114093,0.122116,-0.381175,-0.422274,-0.495879,0.194462,0.279758,0.245719,-4.8103e-05,0.413265,-0.373253,-0.0634936,0.396422,-0.0436068,0.0177302,-0.332754,0.373429,0.00396532,-0.12282,0.354119,-0.123247,0.353645,-0.0470572,-0.118054,0.86403,-0.111301,-0.0675287,0.359503,-0.387404,-0.0987686,-0.55904,-0.21136,-0.330426,0.0991857,-0.0326522,0.115206,-0.0705378,-0.00771395,-0.941192,-0.179379,0.533353,-0.536139,-0.00248241,-0.123864,-0.475155,-0.159381,0.574034,0.313029,0.196239,-0.0114063,-0.298205,-0.253409,0.355605,-0.0420229,-0.467221,0.689783,-0.567652,0.468622,0.291568,-0.431983,0.266859,-0.299543,0.44552,0.260831,0.0798445,0.239985,-0.650968,0.168266,-0.66977,0.0986942,-0.243026,-0.122801,0.174827,-0.0240597,-0.0667287,-0.228534,-0.244189,0.112943,0.0244818,0.119652,0.66115,0.330909,0.180227,-0.517961,-0.15483,0.203211,-0.112892,-0.487629,-0.0362655,0.0850359,0.110908,0.235733,-0.40212,0.0688272,0.0670193,-0.156965,-0.130706,-0.666597,-0.233969,0.0150786,0.149809,-0.171662,0.291814,0.169507,0.489324,0.289154,-0.637771,0.00700531,-0.217628,-0.245746,-0.160866,-0.463142,-0.744681,-0.315883,-0.158883,-0.415962,-0.591926,-0.333459,0.161944,0.303175,0.402422,0.550613,-0.42483 +3399.7,0.989839,0.0912059,5,1.67813,0.849863,-0.836106,0.24003,0.278314,-0.0708685,-0.136759,-0.839425,0.348111,-0.572157,0.149998,0.197144,-0.790384,0.185104,-0.425705,0.689598,0.0347942,-0.197707,-0.389173,0.181571,-0.296878,-1.14573,-0.797308,0.271598,-0.0185659,-0.216724,-0.196694,-0.243476,-0.235161,0.134743,0.840837,-0.344899,-0.0829396,0.000923559,-0.279988,-0.29178,-0.182434,0.564833,-0.231848,-0.551909,1.09471,-0.262214,0.13733,-0.453697,-0.114269,0.301239,-0.906855,-0.174548,0.696475,-0.0866436,0.148508,0.0198925,-0.275921,-1.21582,0.673416,-0.707888,-0.31609,-0.671184,0.216896,-0.803503,-0.00490338,0.895947,-0.185498,-0.98964,0.282079,-0.30944,0.384195,0.0434544,0.0150461,-0.151878,-0.609315,0.646183,0.246226,-0.0646271,0.392362,0.479137,0.0563076,-0.139192,-0.63049,-0.270505,0.242949,-0.346751,-0.124999,-0.0829844,-0.383983,-0.415906,0.595841,0.0159097,-0.442881,-0.49702,0.151378,0.235821,0.126335,-0.131889,-0.330382,-0.219484,-0.422059,-0.397417,-0.103387,0.0809393,0.398667,-0.46848,-0.650845,-0.927475,0.336732,-0.237021,0.406129,-0.398758,0.292402,0.681524,-0.527537,0.60136,0.0277275,0.494533,-0.196971,0.33506,-0.28313,-0.0920344,0.321325,-0.166811,0.113569,-0.063125,-0.130393,-0.959756,0.338596,0.648054,-0.429684,0.178809,-0.323677,-0.484959,0.703683,0.341281,0.714316,0.682268,0.00164439,0.0259438,0.129012,-0.236346,0.32011,-0.459386,-0.343627,-0.343632,0.150106,0.112411,0.0814659,-0.230625,0.44314,0.460319,0.281427,-0.341877,0.137771,0.412897,0.145828,0.0036989,0.45041,0.243583,0.586727,0.55882,-0.0235319,-0.113609,0.279013,-0.0779719,0.635322,-0.298186,0.69308,0.832388,-0.570001,-0.349408,-0.378658,0.118769,0.104288,0.55335,0.128085,0.151328,0.0123205,0.181172,-0.169184,-0.353643,0.0863262,0.695516,0.385698,0.0247103,0.107912,-0.0820699,0.119732,-0.402886,-0.425753,-0.494203,0.162603,0.321101,0.236533,-0.0257347,0.422495,-0.354509,-0.0617449,0.327994,-0.0384472,0.0503603,-0.331323,0.422467,-0.0178633,-0.145659,0.361579,-0.081519,0.375442,-0.0524667,-0.147386,0.878577,-0.154063,-0.116526,0.333582,-0.382322,-0.0395649,-0.58945,-0.221602,-0.367476,0.0689896,-0.0536362,0.0970539,-0.0851831,0.0219501,-0.992604,-0.174329,0.526251,-0.533562,-0.00592307,-0.137079,-0.48095,-0.144891,0.556156,0.332395,0.195783,-0.0340362,-0.303398,-0.267342,0.393458,-0.042777,-0.445929,0.682023,-0.61327,0.488368,0.288426,-0.406413,0.305094,-0.244015,0.486809,0.232354,0.0572758,0.185632,-0.668305,0.145358,-0.664349,0.122539,-0.285564,-0.177773,0.195117,-0.0100004,-0.0827581,-0.173971,-0.243748,0.153268,0.011031,0.121573,0.677972,0.313559,0.173802,-0.502315,-0.123705,0.216088,-0.0963365,-0.503406,-0.0755161,0.0949205,0.158553,0.279921,-0.430799,0.0656484,0.0501521,-0.13083,-0.158437,-0.665523,-0.167898,0.0287346,0.186526,-0.195282,0.285635,0.199142,0.467806,0.309075,-0.637776,0.0309891,-0.196549,-0.256674,-0.123295,-0.470341,-0.772538,-0.345285,-0.206088,-0.469196,-0.626734,-0.307939,0.161324,0.304542,0.401652,0.551854,-0.518936 +3424.91,1,0.0912059,4,1.67026,0.869761,-0.886208,0.310077,0.191447,-0.0467376,-0.0264649,-0.501598,0.722631,-0.0482947,0.267332,-0.229802,-0.771143,0.647161,-0.329985,0.974363,0.0648699,0.19691,-0.306037,-0.211519,-0.215418,-0.826245,-0.786278,0.415688,-0.238471,-0.574565,-0.00699395,-0.254588,-0.0752787,0.118393,0.612226,-0.310784,-0.259325,0.100156,-0.363088,0.00492904,0.193455,0.621159,-0.00920652,-0.383764,1.08811,0.223073,0.51545,-0.652071,0.0563666,-0.157655,-0.49015,-0.19873,0.780444,-0.0890063,0.234657,0.431797,-0.254905,-1.02983,0.38603,-0.897894,-0.176893,-0.897433,0.488191,-0.678301,0.200973,1.02145,-0.509464,-1.17997,0.347737,0.344345,0.336588,0.141122,-0.36248,-0.470529,-0.435477,0.563899,0.602815,0.0192192,0.0154227,0.476143,0.28498,-0.00543818,-0.40974,-0.20175,0.309067,-0.531657,0.202695,-0.330702,-0.567393,0.0814694,0.0514279,-0.0322099,-0.434297,-0.46986,0.399634,0.335717,-0.155339,-0.129279,-0.145349,0.194543,-0.00373849,0.00341761,-0.35366,0.0119755,0.191684,-0.690119,-0.440486,-0.835606,0.0516154,-0.388699,0.468011,-0.590009,0.327561,0.329784,-0.325942,0.356641,-0.479236,0.579094,-0.260298,-0.0514304,-0.0820016,0.20129,0.620511,0.0506332,-0.616301,-0.120064,-0.57361,-0.225963,0.101614,0.550878,-0.169135,-0.0348765,-0.306169,-0.590285,0.354953,0.000498029,0.502445,0.573844,0.153751,0.336139,0.0271537,-0.0286556,0.416514,-0.0892663,0.0367797,-0.284233,0.0539502,-0.42993,-0.0688621,-0.17539,0.187626,0.371964,0.238714,-0.0829324,0.128597,-0.113382,0.17536,-0.109015,-0.0560488,0.164494,0.366467,0.507969,-0.171656,-0.00932413,0.145842,-0.247514,0.888984,-0.481894,0.402341,0.635185,-0.362842,-0.437044,-0.355421,-0.111687,0.282311,0.503219,0.137411,0.538932,0.28099,-0.0103361,-0.232608,-0.395138,0.0371871,0.420725,0.307181,0.0762731,-0.0141114,0.0361921,0.0362059,-0.495835,-0.580202,-0.657317,0.137366,0.202679,0.0363532,0.0808833,-0.362847,-0.244531,0.0330931,0.401784,0.0559684,0.165286,-0.465472,-0.0591813,-0.195883,-0.276159,0.681301,-0.0463145,0.0890794,0.0857775,-0.418249,0.846299,-0.0971748,0.255465,0.0818478,-0.421464,0.0432062,-0.838619,-0.402166,-0.352769,0.169193,0.198285,0.205237,-0.101181,-0.270261,-0.893792,-0.307565,0.535142,-0.776639,0.0161831,-0.25604,-0.505628,0.11876,0.41167,0.189089,0.303249,0.0726473,-0.0416877,-0.163062,0.6293,0.262409,-0.0592183,0.505408,-0.0613931,0.517327,0.209345,-0.840179,0.066385,-0.221953,0.330549,-0.0715172,-0.0126285,0.15223,-0.455662,0.255404,-0.708218,0.130429,-0.138156,0.236912,0.485284,-0.348623,0.250278,-0.126991,-0.193553,-0.30638,-0.585051,-0.49958,0.171259,0.221318,-0.204328,-0.34378,-0.26443,0.198733,-0.177341,0.0375691,-0.298092,-0.359853,-0.0831071,0.672036,-0.446481,0.0966129,0.0850426,-0.129263,-0.156271,-0.361009,0.224433,-0.436376,0.244534,-0.0609093,0.458527,-0.0157417,0.201287,0.145237,-0.545291,0.136158,-0.00826631,-0.0273351,-0.0390845,-0.0954971,-0.906047,-0.363306,-0.444053,-0.522356,-0.243315,0.152127,0.112658,0.337905,0.335645,0.581296,-0.319746 +3427.33,0.718101,0.0912059,4,1.67597,0.808989,-0.819232,0.341643,0.608673,0.0600482,-0.109433,-0.411816,0.194803,0.4912,0.40302,-0.228077,-0.0279493,0.383449,0.00942443,0.521212,0.0340228,-0.241836,-0.271479,-0.279155,0.214968,-1.23786,-1.10964,0.363055,-0.0257175,-0.147742,0.0480087,0.159028,-0.100912,0.461292,0.617706,-0.561766,-0.150758,0.649448,-0.100629,-0.059494,-0.644775,0.498977,0.515871,-0.609407,1.01298,0.667494,0.517346,-0.147223,-0.1759,0.626876,-0.583263,-0.153579,0.634175,-0.235764,0.0612854,-0.0320638,-0.0311938,-0.0546366,0.525923,-0.340843,-0.384168,-0.433372,0.237243,-0.0245428,0.425791,0.751626,-0.858471,-1.74597,-0.046633,-0.264879,0.262791,-0.0452929,0.40918,-0.759957,-0.408275,0.441434,0.233819,-0.242132,0.30795,0.619218,0.173609,0.265669,-0.911332,-0.612756,0.611736,0.0232523,0.00637028,-0.240213,-0.670226,-0.180827,0.146471,-0.312493,-0.584786,-0.00214503,0.354843,-0.237111,-0.887434,0.0526406,-0.138134,0.376947,-0.248931,0.057054,0.543539,0.544413,-0.044997,-0.13111,-0.486186,-0.271909,-0.296629,0.0151603,0.465879,-0.455397,0.301881,0.352135,-0.108757,0.337226,-0.342188,0.472213,0.189415,-0.28299,0.0863132,-0.180785,0.0609529,-0.211812,-0.578566,0.292854,-0.285805,-0.45411,-0.228731,0.382737,0.500778,-0.277754,0.0408993,-0.354167,0.35066,-0.162934,-0.152789,0.443936,0.191788,-0.246395,0.0512432,0.0791662,0.0966304,-0.428897,-0.372701,-0.0198273,0.300123,-0.425225,0.028201,0.677234,-0.396306,-0.135934,-0.212903,-0.202308,-0.100572,0.195472,-0.129807,0.143545,-0.252108,-0.0793978,-0.0411452,0.108565,-0.291474,0.05228,-0.0555351,-0.0229229,0.532727,-0.0434861,-0.179176,0.0996649,-0.222583,0.328902,-0.112149,0.100502,0.197881,-0.793837,0.144385,-0.173757,0.15296,-0.353572,-0.341705,-0.402722,-0.403484,0.712628,0.447344,0.473239,-0.136969,-0.216752,0.327847,-0.591996,-0.352268,-0.300112,0.290564,-0.214076,0.185101,-0.11131,-0.0713004,-0.513988,0.284857,0.322448,0.466604,-0.3287,-0.225718,0.195941,-0.0903848,-0.0529275,0.143635,0.238247,0.228339,-0.616581,-0.577395,1.19962,0.29854,0.0186306,0.0316613,0.216546,0.131013,0.129695,-0.195971,0.397425,-0.338239,-0.286414,0.256041,-0.581124,-0.050659,-0.0117876,0.436307,-0.333279,0.191479,-0.0110373,-0.66051,-0.34306,0.238244,0.194986,0.671565,0.0486364,-0.829912,0.16647,-0.00933459,0.741575,-0.426179,0.114189,0.736421,0.285907,0.256618,0.396044,-0.437029,0.206974,0.23895,0.524964,0.139713,0.0769472,0.257449,-0.682134,-0.457341,-0.232941,0.254463,-0.280151,-0.244983,0.481115,-0.808313,-0.101944,-0.0189078,-0.103905,-0.261961,0.12402,0.0272549,0.124095,-0.521634,0.205462,0.1641,0.0809006,0.0957581,-0.211917,-0.0782132,-0.323425,-0.259792,-0.270297,-0.111697,0.146202,-0.167997,-0.218399,-0.29123,-0.289547,-0.0399774,-0.130848,-0.198152,-0.167877,-0.294991,0.133184,0.276435,0.180892,-0.278837,-0.301796,-0.0142366,0.0564231,0.455859,-0.0980876,-0.109829,-0.428337,-0.299901,-0.30602,-0.323593,0.258249,-0.475663,0.132499,0.22791,0.364004,0.477399,-1.68352 +3427.68,0.635446,0.0912059,4,1.6379,0.741899,-1.08743,0.442398,0.782919,-0.0667305,0.13359,-0.264887,-0.0505057,-0.354142,0.20857,-0.193808,-0.464276,0.394347,-0.0863543,0.523763,0.217455,0.382958,0.21482,-0.218613,0.289069,-0.815824,-0.47686,0.523411,-0.386443,-0.190128,-0.190424,-0.339248,-0.651896,0.0324994,0.748587,-0.343339,-0.326011,0.548316,-0.380869,-0.19859,-0.182113,0.321346,0.143895,-0.654749,1.10691,0.600484,0.0253172,-0.177046,0.0781602,-0.253829,-0.610077,-0.560924,0.456336,0.158935,-0.0859459,0.852445,-0.0130031,-0.685893,0.594765,-0.399583,-0.367059,-0.816982,0.575847,-0.0965499,0.314813,0.848054,-1.26538,-1.18041,-0.504018,-0.177652,0.358144,0.61899,-0.00844804,-0.275988,-0.424178,0.608408,0.549491,0.00747242,0.853772,0.521044,0.451997,-0.183113,-0.327557,-0.31236,0.733695,-0.567032,-0.0829125,0.065609,-0.00782914,0.018496,0.640206,0.364794,0.0676634,-0.210533,-0.103204,0.493231,-0.352303,0.0968024,-0.330255,0.536389,-0.444628,0.221867,0.404185,0.0176338,-0.0554768,-0.108511,-0.542883,-0.0835023,-0.4816,-0.121154,0.597394,-0.389088,0.238968,0.299475,-0.270191,0.242207,-0.510977,0.499723,0.180497,-0.18329,-0.475016,0.417163,-0.16872,-0.786388,-0.0429167,0.525305,-0.0740226,-0.421529,0.147309,0.467709,0.344558,-0.450039,0.483022,0.0696204,0.487335,-0.0187498,-0.523036,0.834266,-0.673361,-0.0938914,-0.476936,0.116165,0.288021,-0.341666,-0.433995,-0.307499,0.0883775,-0.115822,-0.148928,0.200095,-0.305002,0.46835,0.422053,0.0212578,0.3333,-0.0529741,0.449024,-0.0992214,-0.399417,0.424006,0.533651,-0.0262174,-0.109773,-0.118583,0.00550128,-0.481231,0.504883,-0.0731175,0.0110534,-0.0132862,-0.378134,0.314984,-0.0375398,0.0723115,0.312185,-0.585162,0.0901362,0.313995,-0.175997,0.0203034,-0.714218,-0.555588,-0.360594,0.694066,0.479066,-0.350943,0.514271,0.0286176,0.250845,-0.601996,-0.275807,-0.508439,-0.106819,-0.499171,-0.104263,-0.248034,-0.0169372,-0.684209,-0.0196805,-0.178701,0.575609,-0.60646,-0.133399,0.0892955,-0.203791,-0.160504,0.417362,0.00783127,0.227149,-0.0766374,-0.275653,0.983257,0.205366,-0.0122335,-0.173934,0.0486,-0.134401,0.274323,0.479333,0.652572,0.0392645,-0.189222,0.0404901,-0.333982,-0.42249,-0.239988,0.397389,-0.360043,-0.221601,0.222819,-0.435503,-0.205242,-0.0819074,0.0586046,0.297019,0.131795,-0.689793,-0.333223,0.185648,0.646937,-0.227338,0.315914,0.740133,0.0953371,0.223541,-0.0811115,0.251494,0.549529,0.0814586,-0.000924226,0.18622,-0.307469,0.280827,-0.535073,-0.185763,-0.44076,0.0728902,-0.68338,-0.118403,0.174792,-0.477107,0.298958,0.0699985,-0.237912,-0.183867,0.39568,0.146616,0.866724,0.259993,-0.28608,0.180201,-0.400314,-0.114619,-0.0368395,0.30132,-0.209973,-0.590964,-0.50858,-0.164624,-0.560964,-0.146769,-0.459896,0.391194,-0.585092,-0.378775,-0.216547,0.102939,-0.26922,-0.101956,0.109253,-0.349397,-0.114747,-0.176006,-0.247691,0.0949037,0.291628,-0.304449,-0.505514,-0.12978,-0.434203,-0.202712,-0.218197,-0.0615637,0.414609,-0.476084,0.125956,0.216981,0.354903,0.465813,-2.10438 +3417.4,0.741038,0.0912059,4,1.5775,0.744437,-1.25133,0.493437,0.345833,0.0259798,0.0135141,-0.251083,0.385519,0.299508,0.268056,0.0754798,-0.111075,0.514537,0.105774,0.524953,0.126422,-0.115825,0.240992,-0.330545,-0.00939705,-0.868884,-0.690418,0.692199,-0.178304,-0.128141,-0.136997,0.0150899,-0.492157,0.330947,0.685955,-0.449351,-0.389671,0.573295,-0.699694,0.140593,-0.607163,0.617357,0.274742,-0.000240203,0.90181,0.530597,0.073589,-0.20189,-0.0241636,0.744099,-0.32069,0.0775827,0.355186,-0.101014,-0.17876,0.090499,0.0297317,-0.599011,0.444474,-0.0841399,0.354177,-1.19078,0.254638,-0.263703,0.607519,0.888026,-1.01375,-0.573014,-0.479168,0.0634089,0.248804,-0.0404896,0.151688,-0.00829937,-0.331119,0.251433,0.296979,0.0851188,0.688184,0.535228,0.248719,-0.333284,0.173549,-0.243244,0.825083,-0.15898,-0.117517,0.0943999,-0.563235,0.469206,0.186473,-0.190844,0.405086,-0.148016,0.0668813,0.234735,0.0124454,0.480254,-0.00243434,-0.510363,0.174219,-0.592267,-0.0743008,0.0994128,-0.179312,0.514769,-0.681242,-0.362981,-0.0673315,0.105528,0.518688,-0.61946,0.48706,0.715304,-0.527442,-0.452365,0.0815557,0.488295,-0.134428,0.0745559,-0.731084,-0.161404,0.0984966,-0.27072,-0.778168,0.258693,-0.361415,-0.818625,-0.166843,0.142007,0.295053,-0.08394,-0.000636454,-0.201506,0.34946,-0.0465745,-0.646233,0.499964,-0.567229,-0.130141,-0.658615,0.0750279,0.307378,-0.256557,-0.186373,-0.252349,0.169498,-0.722011,0.39503,-0.226285,-0.250312,0.206849,0.0285572,0.0299511,-0.304716,0.066248,0.328412,0.235178,0.115929,0.250362,0.317814,-0.103422,0.0819426,-0.288318,-0.273536,-0.673214,0.265824,0.340072,-0.267482,0.753811,-0.133801,0.0198418,0.365386,-0.245997,0.38331,0.0782654,-0.0570297,0.247085,-0.492829,0.517517,-0.730542,-0.453948,0.22648,0.357789,0.177515,-0.0332664,0.27424,-0.367481,-0.754026,-0.911321,-0.515535,-0.146505,-0.103479,-0.438307,-0.149405,0.31182,0.423895,0.0186683,0.0564584,0.105949,0.169255,-0.684195,-0.55492,0.20139,-0.210305,-0.0654415,0.270176,-0.151056,-0.179769,0.0852043,-0.0538199,1.01856,-0.431546,0.126736,0.0791255,0.52826,-0.153465,0.214793,-0.270717,0.930809,-0.435518,0.270364,0.102281,-0.476078,-0.538729,0.122414,-0.216949,0.0999184,0.0776934,0.413124,-0.270465,0.192268,-0.312913,0.476171,-0.0775364,0.193733,0.503298,0.0941799,-0.150313,0.357397,-0.324493,-0.189057,0.399674,-0.402732,0.379611,-0.250423,-0.127558,0.0250119,0.153635,0.21322,0.303281,-0.193807,0.213803,-0.936144,0.00285605,-0.39784,0.5068,-0.355857,-0.416374,0.722406,0.268036,0.238825,0.021976,-0.143163,0.192137,0.266362,0.0878277,0.289183,-0.0451559,-0.142715,-0.0226281,-0.175958,0.128892,-0.232659,0.127405,-0.0520215,0.526354,-0.269585,0.513652,0.444568,-0.397843,0.222278,-0.271003,-0.130312,-0.341895,-0.27136,-0.555599,0.268012,-0.122013,0.0232381,-0.275037,-0.602142,0.0199721,-0.512206,0.0719637,0.364874,0.064916,0.045867,0.015094,-0.749685,0.177657,-0.306257,-0.157169,0.268245,0.000244417,0.135214,0.214789,0.367715,0.463454,-0.70371 +3424.96,0.999782,0.0912059,4,1.53348,0.797388,-1.11706,0.443393,0.0543414,0.0131592,0.403434,-0.278421,0.00546281,-0.335559,0.183074,-0.0260478,-0.0946504,0.720971,-0.207377,0.662382,0.200522,0.0877727,0.375108,0.0771091,0.226756,-0.563266,-1.13748,0.645857,-0.314547,-0.0484542,-0.0911434,-0.0131864,-0.346421,0.0727538,0.851364,-0.225617,0.676425,0.165204,-0.528518,-0.134142,-0.872069,0.625898,0.309111,-0.351232,0.951654,0.688653,0.503142,-0.220189,-0.0327034,-0.119941,-0.476121,0.0281863,0.619046,-0.102757,0.0574413,0.596661,0.153245,0.25069,0.466063,-0.473021,-0.167076,-0.673527,0.635586,-0.150506,-0.0278247,1.15011,-0.485535,-1.56011,-0.231229,0.12954,0.142905,-0.224833,-0.203052,-0.547179,-0.739185,0.195211,0.420938,-0.307185,0.859473,0.483359,0.177027,0.0874095,-0.00649447,0.108938,0.157422,0.500966,0.194589,-0.0925226,0.0879921,-0.0214081,-0.365659,0.269135,-0.028018,-0.145767,0.207971,0.350675,0.0737521,0.407333,0.0254807,0.0543548,0.0378116,-0.952678,-0.0629517,0.244342,0.223576,-0.354183,-0.963436,-0.0628849,0.130401,-0.181248,0.452782,-0.726804,0.152588,0.439396,-0.490855,-0.571585,-0.306094,0.363843,-0.441226,-0.140775,-0.554907,-4.91009e-05,0.22183,-0.117343,-1.01033,-0.278737,-0.484175,-0.432682,-0.443808,0.375599,-0.153004,0.49602,0.0629276,-0.00267054,0.399455,0.0111547,-0.292783,0.0141448,0.432024,-0.226832,-0.00466005,0.320406,0.479378,-0.559581,-0.0257347,-0.354042,-0.26578,-0.562391,0.190645,0.387838,-0.0976616,0.29234,-0.028062,-0.743137,-0.482556,0.269892,0.0589293,-0.153431,0.44904,0.40133,-0.424912,0.0128541,0.0255999,-0.17925,0.671361,-0.133072,0.340133,0.38517,-0.21581,-0.127366,-0.308551,-0.0834448,0.229475,0.0164425,0.170363,0.123669,0.0901347,0.135195,-0.48331,0.0954133,-0.0886197,0.0403958,-0.508712,0.836203,-0.27547,0.0224361,0.319372,-0.152093,-0.0187462,-0.314187,-0.249918,0.0485253,0.0430082,0.380387,-0.150917,0.433235,0.110291,-0.546498,-0.0137037,-0.0415712,0.169299,-0.447464,-0.621066,-0.22326,-0.327888,-0.115684,0.301418,0.181381,0.425953,0.41491,-0.204759,1.01165,0.587498,0.31964,0.318123,-0.118364,-0.248441,0.278229,-0.295456,-0.177661,-0.220389,0.277847,0.253676,0.416068,-0.52311,-0.0595918,0.0401115,-0.348186,-0.375511,0.230356,0.00535133,-0.531621,0.311052,0.00690381,0.325962,0.110003,-0.659158,-0.557492,0.0413678,0.464443,-0.156039,0.0595823,0.464032,-0.131691,-0.310137,-0.131841,-0.143948,0.139393,0.186682,-0.358494,0.302393,0.0305152,0.0397128,0.0957361,-0.0284419,-0.578033,0.300554,-0.24277,-0.399946,-0.0901181,-0.732767,-0.00233804,0.159538,0.0233761,0.109509,-0.36137,0.132563,0.22178,-0.0573531,0.214887,-0.0511731,-0.0465708,-0.27074,-0.180383,0.22909,-0.660425,-0.338076,0.107182,-0.248389,-0.217398,-0.0736967,-0.277237,0.143006,-0.285283,-0.0929641,-0.176133,-0.0614477,0.193896,-0.320988,0.210712,-0.264293,0.113962,-0.0720043,-0.426069,-0.157759,-0.0180703,-0.295036,0.342134,-0.217026,-0.900305,-0.128627,-0.768915,-0.745151,-0.276844,0.425375,0.11781,0.248473,0.343235,0.498471,0.106469 +3412.39,0.969528,0.0912059,4,1.60973,0.828966,-0.901932,0.298221,0.00894348,0.0518946,0.253542,0.11686,0.498778,0.0891273,0.18988,-0.0900244,-0.216203,0.347984,0.620387,0.770008,0.134599,0.246342,0.00537132,-0.0800818,0.171166,-0.716959,-0.958757,0.478421,0.177081,0.0716269,-0.143984,0.38859,-0.528389,0.0338564,0.576059,-0.805107,-0.465203,0.0868337,-0.511598,0.071485,-0.434924,0.645355,0.280637,-0.0376654,0.714136,0.178918,-0.261849,-0.359562,0.0777423,0.429787,-0.278047,0.245412,0.70262,-0.33962,0.113496,0.213305,0.103422,-0.312295,0.597498,-0.0915115,0.4598,-0.996345,0.0726971,-0.516004,0.0762466,0.878555,-0.958387,-1.60677,-0.165105,-0.0915656,-0.190278,0.369697,0.0619808,-0.462528,0.0319735,0.348519,0.780236,-0.680188,0.452897,0.484974,-0.289644,-0.498738,-0.523017,-0.114661,0.502681,0.19893,-0.172234,-0.373434,-0.702728,0.0730565,0.371148,0.21232,0.321809,-0.23998,-0.0521616,0.0944409,0.423945,-0.136314,0.049082,-0.415821,-0.0110603,-0.822503,-0.112572,0.436004,-0.0219807,-0.271397,-0.418347,-0.663099,0.140137,-0.194808,0.498664,-0.328829,0.52693,0.486794,-0.0881746,-0.370147,0.160723,0.557954,0.697294,-0.379948,-0.40263,-0.0693,0.263446,-0.41084,-0.64948,-0.253144,0.457278,-0.383474,-0.305924,0.0450481,0.0944258,0.542731,0.428749,-0.348057,0.0636865,0.0840174,-0.322959,0.558066,0.0396309,0.300508,-0.114622,0.275519,-0.0796934,-0.56458,0.149167,0.0163811,0.221681,0.239501,0.190982,0.16391,0.118332,0.425484,0.162297,0.0662061,-0.497533,0.482579,0.094984,0.0942961,0.527053,-0.0471604,-0.0480613,0.140327,0.0976639,-0.0476848,-0.385796,-0.258081,0.648632,0.175805,0.203604,0.500719,-0.0494702,-0.160632,0.291231,0.322513,0.457939,0.0765572,0.0146562,-0.0221471,-0.494537,-0.00517765,-0.542764,-0.208649,0.474513,0.336059,0.294766,-0.247173,0.170242,0.469289,-0.0387154,-0.21167,-0.0329318,-0.166092,0.175792,0.401798,0.211961,-0.140904,0.153783,-0.332304,-0.103252,-0.357175,0.286135,-0.345348,-0.96597,0.754983,0.00115884,-0.153854,-0.376704,0.0598842,-0.0105447,0.152681,-0.118719,1.3258,0.112314,0.423875,0.221201,0.520475,0.0922902,0.0114216,-0.730392,0.715034,-0.31314,0.450551,0.616438,0.0880774,-0.530255,-0.906731,-0.196819,0.0301855,-0.641972,-0.00445899,-0.0543051,-0.280645,0.318162,0.0297575,-0.0671658,0.112994,-0.00745292,-0.039726,-0.284382,0.618617,0.332724,-0.348966,0.416025,-0.164584,-0.751527,-0.772336,0.186823,-0.078135,0.196885,0.125885,0.119876,0.588323,0.231523,-0.553209,-0.157629,-0.452945,0.571662,-0.386843,-0.217708,0.382502,-0.5833,0.277093,0.117705,-0.491201,0.20832,-0.726667,0.259971,0.107652,-0.0245938,0.257211,0.144113,-0.396158,-1.05194,0.210335,0.176241,-0.155248,0.0800458,0.157963,-0.439351,0.154191,0.0707166,0.178251,0.239611,-0.276173,-0.125115,-0.0952471,-0.382018,0.140621,-0.34166,0.153349,-0.164182,0.568449,-0.210717,0.0299134,0.0772979,0.512281,-0.0589525,0.829301,-0.087224,-1.2316,0.130741,-0.206265,-0.329151,-0.360605,0.302713,0.147977,0.259637,0.384677,0.509546,0.292563 +3409.48,0.989302,0.0912059,5,1.6707,0.627521,-1.89725,0.867981,0.375256,0.00298956,-0.156984,-0.0736316,-0.672401,0.122515,0.246698,-0.253691,-0.207563,0.440509,-0.282321,0.238236,0.0868883,-0.303414,-0.17861,0.030039,0.237456,-0.52543,-0.83538,0.478001,-0.484316,-0.283263,0.165893,-0.0856593,-0.11049,0.27411,0.853962,-0.0580017,0.187782,0.425875,-0.844742,-0.0184439,-0.635154,0.460279,-0.0438843,-0.756908,0.87792,0.63921,0.763456,-0.811451,-0.191694,-0.12507,-1.00596,-0.358358,0.244629,-0.342668,0.136994,0.416824,0.154659,-0.631851,0.0911313,-0.712867,-0.790063,-0.81818,-0.547265,-0.107009,0.3077,0.784764,-0.556929,-0.189832,0.630597,0.364757,0.331525,-0.173409,0.274639,-0.148364,0.135433,0.265945,0.639413,0.566301,0.773656,0.797621,0.911096,-0.0663182,-0.0229269,-0.342063,0.359727,-0.683134,0.510167,0.469527,0.122331,0.0907727,-0.425454,-0.180509,-0.237283,0.0324793,0.0107962,-0.206981,-0.0589801,0.448527,-0.39591,0.0543509,-0.250555,0.546088,0.34655,0.366594,0.403413,-0.0222488,-0.602481,-0.236443,-0.156332,-0.367299,0.554545,-0.175759,0.237927,0.564241,0.0790399,0.0559338,-0.0139843,0.239395,-0.647371,0.00527447,0.102536,0.58973,0.399293,0.257526,-0.452557,0.207814,-0.418837,0.101715,-0.103813,-0.0944655,0.639281,-0.213258,-0.0524854,0.172263,0.564056,0.197537,-0.216151,0.692503,0.0859062,-0.970243,0.181715,-0.0211221,0.364157,-0.347142,-0.484715,-0.107185,0.130322,-0.866177,-0.151214,0.161994,0.0902914,0.137092,0.0721724,0.03764,0.143567,0.00240144,0.393817,-0.44705,0.156615,0.615127,0.330892,-0.296756,0.175048,0.20738,0.647774,0.147789,0.521701,-0.0818733,0.0988012,0.279647,-0.266694,0.151638,-0.429112,-0.785187,-0.171721,0.314994,-0.094422,0.121294,0.264449,0.446333,0.446035,0.197984,-0.00665536,0.770214,0.241025,-0.11771,0.0260238,-0.391092,0.162996,0.0400457,-0.177156,-0.397461,0.330663,-1.14782,0.215964,0.119314,0.242309,-0.198086,0.235145,0.513462,0.0726596,-0.450926,-0.0652311,0.037801,-0.167345,-0.780936,0.313833,-0.221375,-0.0283382,0.0296496,-0.659933,1.04526,0.0213207,0.00684642,0.0231507,-0.382341,-0.150031,-0.155404,0.565895,-0.077487,-0.554461,0.0193702,0.249503,-1.18155,0.0880944,0.032999,-0.462002,0.197551,0.230259,0.624823,-0.610351,-0.1251,-0.297535,-0.0375586,0.0462413,0.247975,0.43786,-0.434541,0.122629,0.669345,-0.0380123,0.276176,0.534666,-0.49858,0.0983028,0.192595,-0.018826,-0.240701,0.71064,0.0385561,0.45942,-0.495497,-0.43858,0.115722,-0.277445,-0.675116,0.442808,-0.108065,-0.451914,0.314453,-0.45816,-0.18468,0.509452,0.29412,-0.319244,0.95536,-0.232811,-0.0792883,0.0878286,-0.179712,0.0691898,-0.0172279,-0.0191659,-0.0444544,-0.284858,-0.803767,-0.224648,-0.211612,0.499984,0.0744811,0.135286,0.1952,0.374232,-0.132497,-0.38339,-0.270781,-0.369445,-0.00790221,-0.0131536,0.311508,-0.161405,-0.435803,0.0784727,-0.773761,-0.0637446,-0.383087,-0.0563733,-0.108961,0.162843,-0.185708,-0.188186,-0.0738606,-0.275303,-0.125714,-0.175355,0.150147,0.28759,0.387489,0.536274,-0.51156 +3416.74,1,0.0912059,4,1.57933,0.881639,-1.65285,0.705116,0.984117,-0.148465,-0.0711858,-0.312037,0.240218,0.129461,0.206695,-0.306379,0.0884865,0.250872,-0.632172,0.707877,0.257428,0.18656,-0.327474,-0.258198,0.0542893,-0.630568,-1.0382,-0.0727752,0.096685,-0.251723,0.170886,0.311302,-0.482377,0.480745,0.563795,-0.643131,-0.359654,0.111334,-0.293509,0.094001,-0.679966,0.716802,0.35809,-0.0477456,0.501927,0.515636,0.174131,-0.969458,-0.261307,0.109039,-0.219071,0.643548,0.436706,0.324043,-0.257049,1.08545,-0.0884041,-0.754422,0.421774,0.278523,-0.208303,-1.35398,0.272968,-0.600561,0.108511,0.731034,-0.799159,-0.381844,0.325582,-0.00224459,0.361247,0.361279,0.298986,-0.434346,0.590778,0.250241,0.521713,0.0696835,0.620907,0.43045,0.435705,-0.393223,0.0323397,-0.0892674,0.164583,-0.0323558,0.369675,-0.0533473,-0.235722,0.201156,-0.307934,-0.0891855,-0.101734,-0.525264,-0.271713,0.237757,0.106333,-0.592147,-0.234724,0.0185349,0.292512,0.00698097,0.122577,0.708449,-0.27946,0.208626,-0.632005,-0.432701,0.0110718,-0.0599623,0.632016,-0.618272,-0.439789,0.440162,0.299117,-0.24643,0.433874,0.263229,0.0826564,0.307585,0.318329,0.341903,0.0173298,-0.086464,-0.841942,0.534657,-0.513095,-0.613376,-0.589727,0.224557,0.362592,-0.709415,0.261757,-0.389995,0.0297951,0.367596,0.286252,0.707475,-0.248291,-0.186817,0.25961,0.280563,0.0378566,-0.316991,-0.228664,0.140489,-0.218696,-0.335601,0.152122,-0.00318656,-0.553235,0.0153583,0.201566,-0.498234,0.180882,0.302022,-0.432224,-0.172554,0.393224,0.713866,0.669405,0.551894,0.199441,0.431152,-0.119346,-0.264681,0.834925,-0.333121,0.101671,0.244961,-0.069665,-0.185368,-0.0610585,0.117203,0.0787104,0.590316,-0.313274,0.152853,0.353814,0.10855,0.0394996,0.149713,0.248436,0.963591,-0.434655,-0.29396,-0.0904827,-0.246645,0.32989,-0.237503,-0.0602268,-0.333083,-0.124347,-0.946988,0.0463966,0.460497,-0.311268,-0.437078,-0.587182,0.208461,-0.0429489,-0.0449841,-0.902439,0.115042,0.35177,-0.464713,0.0829854,-0.69723,0.334334,-0.151238,-0.687944,1.16272,-0.0629571,0.682683,0.245117,0.0617459,-0.259036,-0.0357434,0.0733318,0.634956,-0.360954,-0.0782187,0.454843,-0.20499,-0.0102675,-0.569693,-0.547306,0.0357862,-0.218157,-0.0900736,-0.660552,-0.595573,0.183438,-0.451939,0.166667,-0.408431,-0.019578,0.187429,-0.0268032,0.417562,-0.331764,-0.126898,0.798578,-0.122974,-0.389505,-0.497024,-0.248379,-0.109362,0.299811,-0.0358224,0.0833304,0.367853,-0.770793,-0.331658,0.192776,-0.215848,0.269799,-0.339774,-0.226434,0.495309,-0.676287,0.0395026,0.170781,-0.0227642,-0.0208275,0.184846,0.0645,0.307966,0.439454,-0.202451,0.114487,0.122866,0.130678,-0.115531,0.170393,-0.372218,-0.0227312,0.12877,0.194334,0.228928,0.145745,0.139142,-0.0350068,0.313891,0.0195268,0.042211,0.354126,0.164098,-0.110128,0.158956,0.392865,0.940507,0.342816,-0.555392,-0.194274,-0.107399,0.220169,0.52242,-0.180186,-0.432467,-0.0900004,-0.00851722,0.191095,-0.370738,-0.327338,0.123438,0.176524,0.351337,0.420147,-3.00957 +3420.09,0.939175,0.0912059,4,1.5853,0.89027,-1.47623,0.558355,0.440998,-0.030574,0.603751,-0.239985,0.166185,0.419134,-0.0807405,-0.497768,-0.176648,0.306984,-0.569035,0.780741,-0.0645652,0.288486,-0.334906,-0.259852,-0.171597,-0.539962,-0.64788,0.124939,-0.471374,0.00969114,-0.502819,0.539986,-0.400395,0.294451,0.582807,-0.26581,-0.0212025,0.290014,-0.584577,-0.167539,-0.135398,0.865688,0.481659,-0.221652,0.933711,0.486726,0.582803,-0.770996,-0.0573753,-0.188434,-0.82249,0.448238,0.430122,0.452983,-0.256764,0.746652,0.252054,0.0596811,0.461863,0.348222,-0.514429,-0.832191,-0.0171558,-0.271977,0.480397,0.803313,-0.457761,-0.0736902,0.521075,0.247915,0.512576,0.325679,0.424667,-0.142783,-0.128785,0.11475,0.363919,-0.408666,0.642572,0.305647,0.62106,0.10581,0.0551441,-0.178434,0.341761,-0.0556993,0.473506,0.0662853,-0.241092,-0.316005,-0.307436,-0.37509,0.0263582,-0.425672,-0.20704,0.399861,-0.359686,-0.179788,-0.33029,0.19881,-0.0268831,0.180264,0.345123,0.358438,-0.463286,0.237348,-0.481316,-0.449602,0.304008,-0.250399,0.366428,-0.227758,-0.264334,0.598149,-0.0561441,-0.341497,-0.160344,0.0982221,0.176019,0.0825089,0.521953,0.271436,0.0387721,-0.0145713,-0.266067,0.544086,-0.399791,-0.183234,0.177365,0.260975,-0.0426473,-0.278538,0.37558,-0.173298,-0.0407967,-0.0920505,0.168033,0.729486,-0.232725,-0.281455,0.141968,0.515401,0.60069,-0.547221,-0.293041,0.0128786,-0.292004,-0.369783,0.0859385,-0.400453,-0.636688,-0.0693265,0.168556,-0.278195,0.519366,0.388255,0.0595063,-0.495154,0.385251,0.102296,0.404056,0.408696,0.218405,0.46141,0.167495,-0.227411,0.463689,-0.462765,0.0266062,-0.399344,-0.261869,0.073564,0.417191,0.0417464,0.444242,0.494273,-0.077634,-0.137415,0.11359,-0.0926043,-0.104209,-0.306178,0.395906,0.521081,-0.498149,-0.259812,-0.290548,-0.194351,0.225852,-0.0868833,0.200078,-0.306406,0.207644,-0.915791,-0.0834432,0.237283,-0.845985,-0.50476,-0.430309,0.165037,0.139798,-0.431917,-0.500634,0.12375,-0.0681682,-0.292264,0.2469,-0.116319,0.397601,-0.176478,-0.624551,0.99673,-0.13819,0.247399,0.0556027,0.1987,-0.0913977,-0.373476,0.696015,0.413149,-0.533648,-0.00576511,0.451424,-0.239868,0.295015,-0.103225,-0.501039,0.408711,-0.131818,-0.215901,-0.34331,-0.807196,0.208013,-0.0719565,-0.221171,-0.123212,-0.517945,0.254917,-0.276158,0.574073,-0.141197,0.41713,0.813624,-0.529857,-0.442554,-0.344154,-0.663914,0.251826,0.321329,0.0705655,0.339811,0.138434,-0.334913,-0.233022,0.67393,-0.480999,0.193184,-0.20609,-0.0951462,0.204979,-0.616645,-0.0898835,0.282281,0.279165,0.101033,0.11248,0.272712,0.4149,0.35921,-0.355094,0.253886,0.453263,0.131788,0.251522,0.0318969,-0.505169,0.172832,-0.0120665,0.164286,0.19058,0.239429,-0.106887,0.129595,0.503328,-0.347445,-0.16088,0.629745,-0.551712,-0.089763,-0.187159,0.272436,0.142143,0.160019,-0.414544,-0.246617,-0.154736,0.52562,0.165836,-0.131546,-0.174203,-0.338833,0.170278,-0.244053,-0.480363,0.0625816,0.141238,0.187949,0.375816,0.43353,-1.19892 +3434.41,1,0.0912059,4,1.5824,0.839364,-1.70172,0.650505,0.708989,-0.0399876,-0.00963471,-0.332521,0.209014,-0.239814,0.231005,-0.510217,-0.0890929,0.572172,-0.349215,0.430404,0.108457,-0.317738,-0.00637116,-0.153553,-0.435286,-0.593468,-1.12375,-0.00984879,-0.486993,-0.0701554,-0.662046,0.407527,-0.54009,0.293476,0.656302,-0.323824,-0.160531,-0.0688289,-0.625001,0.0141142,0.118202,0.664306,0.109159,-0.598063,0.81534,0.327967,0.507768,-0.845163,-0.0215824,0.161448,-0.363354,0.449439,0.619675,0.397465,-0.217295,0.674771,0.114584,-0.102645,0.283026,0.376204,-0.473943,-0.928343,0.13769,-0.25905,0.646147,0.99955,-0.164304,-0.481096,0.421238,0.0807327,0.527846,-0.149502,0.7439,-0.399949,-0.0958312,0.336053,0.208806,-0.254107,0.561847,0.559994,0.163989,-0.169486,-0.0856459,0.100643,0.200113,-0.23603,0.164373,-0.0783555,-0.525168,-0.540906,-0.77163,-0.620099,-0.261303,-0.0572204,-0.0993039,0.163926,-0.157723,0.367307,-0.0108697,0.444175,0.10286,-0.334811,0.301738,0.0240566,-0.209466,0.405202,-0.538059,0.0251321,0.723247,-0.238726,0.360159,-0.127423,-0.105579,0.824323,0.032973,-0.213165,-0.368198,0.377269,0.0977362,0.354754,0.301718,0.572303,0.00447362,-0.454229,-0.483093,0.248793,-0.38664,-0.0605556,-0.246123,0.45953,-0.112155,0.162404,0.127191,-0.295092,0.0835024,-0.226465,0.446506,0.378781,-0.366262,-0.443821,0.197993,0.0797162,0.674559,-0.418849,-0.0591884,0.168178,-0.0467772,-0.248348,0.571953,-0.19723,-0.196638,0.75622,-0.271713,-0.453212,0.245383,0.361648,0.413101,-0.539618,0.181377,0.0847522,0.120692,0.129667,0.205253,0.281534,0.390967,-0.132891,0.418672,-0.642508,0.162741,0.316926,-0.0262877,-0.35718,0.0675426,-0.352612,0.202084,0.370671,-0.231033,-0.15661,0.495119,0.238556,-0.205813,-0.127298,0.341155,0.513045,-0.135621,-0.566557,-0.527045,-0.390815,0.369634,-0.216987,0.251355,-0.508644,-0.396602,-0.475075,-0.264575,0.207397,-0.586707,-0.256421,-0.225489,-0.00842241,-0.0171799,0.0496453,-0.869873,0.168297,-0.0807073,-0.0443656,0.351089,0.342882,-0.046716,0.389716,-0.312137,0.871761,-0.0444587,0.115827,0.16299,0.138688,-0.464322,0.206616,0.108804,0.0789334,-0.532684,0.0266571,0.310474,-0.372961,0.284122,-0.216141,-0.179945,0.291982,-0.458462,-0.159218,-0.0458168,-0.303726,0.167741,-0.228686,0.169755,-0.0469275,-0.112617,-0.132861,-0.593121,1.0334,-0.00226834,-0.383275,0.752723,-0.116716,-0.101053,-0.165232,-0.173111,0.0304817,0.328144,0.253679,0.135341,0.228876,-0.151053,-0.590914,0.0593613,-0.355031,0.306606,0.224956,-0.148838,0.0565397,-0.340829,-0.366981,0.0890386,-0.086856,0.100986,0.174132,-0.0553786,0.297408,0.511397,0.0668885,0.111472,-0.301666,0.0745728,-0.121482,-0.167296,-0.146178,-0.195402,-0.189176,0.473601,0.391507,-0.0522944,-0.15929,-0.0793094,0.481067,-0.804799,0.036717,0.0808456,-0.0737381,-0.381731,-0.274105,0.124988,0.406954,0.00901922,-0.735501,-0.0168597,-0.0401828,0.716483,0.630885,-0.215961,-0.261171,-0.21435,-0.0104103,-0.556051,0.282349,0.332517,0.115759,0.201754,0.340233,0.449171,-1.96805 +3453.33,0.999965,0.0912059,4,1.59051,0.731443,-1.7181,0.64951,0.233097,-0.0416042,-0.15721,-0.520851,0.00516467,-0.163999,-0.112658,-0.173578,-0.707646,0.38958,-0.261553,0.494884,0.182313,-0.16497,-0.422706,0.0157121,-0.165716,-1.07795,-0.550875,-0.0123173,-0.0863727,-0.217148,0.24007,-0.349134,-0.389051,0.0123229,1.12098,-0.821973,-0.0853409,0.256613,-0.294214,-0.249665,-0.869057,0.841641,0.864495,-0.446702,1.13429,1.09632,0.818917,-0.71313,-0.0210411,0.447433,-0.622313,0.292015,0.14821,0.102299,0.121792,0.489743,0.358759,-0.20927,0.444382,-0.853298,-0.435658,-1.06086,0.459994,-0.497613,0.173944,0.911819,-0.915089,-1.17374,0.190305,0.0436363,-0.128375,-0.424211,-0.504854,-0.176304,0.0829083,0.203556,0.729632,0.373759,0.448517,0.419269,0.473556,-0.0672309,-0.281686,0.0658318,0.606959,-0.363329,0.441312,-0.323086,0.0169143,0.170589,0.798693,0.183472,0.0453299,-0.790478,0.0525171,-0.0674699,0.116154,-0.414965,0.142667,-0.772556,-0.257781,-0.119419,0.208297,0.182614,0.164448,-0.612686,0.0707669,-0.495024,-0.496198,-0.00542427,-0.0687609,-0.244061,0.0589584,0.289372,-0.205309,-0.333693,0.134408,0.344127,0.207258,0.0101697,-0.38971,-0.182942,0.511912,0.0375999,-0.347379,-0.196778,0.0415661,-0.0343625,-0.063595,-0.023361,0.334091,-0.251843,0.264074,-0.179351,0.166811,0.117257,-0.388098,0.44365,0.0858825,0.304575,-0.252062,-0.1989,0.0679272,-0.20693,-0.0273762,0.0740532,-0.15189,-0.557467,-0.398462,0.13354,0.15339,-0.487725,-0.236479,-0.139157,-0.436281,-0.172046,-0.089267,0.230706,0.415074,0.231713,0.122638,0.303196,-0.38518,-0.326697,-0.244665,0.255557,0.61286,0.353458,-0.25884,-0.249329,-0.298704,-0.0097196,-0.1293,0.400914,-0.15805,-0.401017,0.0790865,0.154767,-0.0507444,0.115497,0.021144,0.251739,-0.273589,0.842913,0.337413,0.216304,0.284354,-0.0141324,-0.220094,-0.0685671,-0.306289,-0.0888489,0.475514,-0.180711,0.194778,-0.383521,0.427599,-0.356846,0.379843,0.360944,-0.0539557,-0.253011,-0.169281,-0.265291,0.209049,-0.341813,-0.161073,-0.332628,0.0409503,-0.58333,-0.535845,0.652993,0.0805957,-0.0560703,-0.119473,-0.201525,0.617618,-0.112129,-0.297525,0.445558,0.282059,-0.0206501,-0.109654,-0.29314,-0.0717168,-0.534256,-0.192931,-0.0819952,-0.0351105,0.809085,-0.733961,0.11538,-0.217159,0.119114,-0.603506,-0.00646271,0.218873,0.0631351,0.673434,-0.0242513,0.073792,0.451334,0.302907,-0.466211,0.358504,0.318962,0.0435414,-0.0189092,-0.110303,-0.0368131,0.517871,-0.0442673,0.0486964,-0.14177,-0.329863,-0.486978,0.41048,-0.423457,-0.30114,0.193629,-0.0343859,0.185229,-0.177476,0.397823,-0.155641,-0.00487616,0.100165,-0.205786,-0.241135,-0.234843,-0.544766,0.00992433,-0.364349,0.0215819,-0.13463,-0.116561,0.0978077,0.293012,-0.378016,0.222765,-0.141637,-0.00705207,-0.249008,-0.242883,0.220921,-0.218497,-0.34696,-0.100952,0.225809,0.213336,-0.189986,-0.314722,-0.276163,0.25328,-0.159516,0.0490971,-0.100699,0.012156,0.102393,-0.0663077,0.0536788,-0.110283,0.191632,-0.354397,-0.412607,0.0850391,0.338456,0.291615,0.58177,-0.179328 +3456.68,0.632464,0.0912059,4,1.59333,0.648262,-1.5801,0.68656,0.621897,-0.164248,-0.409436,-0.0736947,0.618364,0.0905691,0.490829,-0.0859552,-0.624597,0.441484,0.114039,0.758524,0.198855,0.0465152,-0.239594,-0.22551,-0.212574,-0.781481,-0.735112,0.364495,-0.459694,-0.186303,0.225099,0.380415,-0.442053,0.298535,1.02385,-0.52631,0.0367035,0.557549,-0.260779,-0.561734,0.130215,0.381737,0.0407462,-0.320031,0.670353,0.629716,0.412442,-0.886399,-0.354014,-0.497842,-0.667463,0.117908,0.509807,0.027376,0.161218,1.45501,-0.14873,-0.858204,0.659295,0.369609,-0.102379,-0.980112,0.161541,-0.315609,0.387218,1.25241,-0.517938,-1.4757,0.611765,0.268259,0.0309745,-0.0803093,0.490455,-0.438907,-0.322468,0.64986,0.413686,-0.215843,0.0657937,0.366878,0.0203044,0.476448,0.150681,0.212579,0.384264,0.18289,-0.126334,0.169411,-0.020201,-0.383405,-0.688383,-0.401531,0.0493078,-0.304281,0.117391,-0.0778725,-0.0340536,0.248315,0.392461,0.407022,0.425689,-0.261569,-0.354615,0.390082,-0.256452,0.244846,-0.422049,0.173201,0.438111,-0.295027,0.504097,-0.22698,-0.00424402,0.505602,-0.000931199,0.357232,0.221859,0.135366,0.278154,0.166657,0.16878,0.257476,0.0454733,0.171039,-0.359396,0.0432897,-0.285357,-0.238241,0.0992208,0.507447,-0.287568,0.409097,-0.0171523,-0.591698,0.210869,-0.190547,0.0128767,0.313595,-0.423381,-0.190366,0.0798146,-0.0169274,0.79908,-0.434781,-0.433639,0.0483058,0.381637,-0.106902,-0.159446,0.0542561,-0.19841,0.624432,-0.371188,-0.0187641,-0.175848,0.0966586,0.112837,-0.00874265,0.0862645,0.394914,0.135839,-0.579688,0.356289,0.104975,-0.0350591,-0.358863,0.382141,-0.361168,0.210489,0.242016,0.0355512,0.0680785,-0.350841,-0.544551,0.00395614,-0.054967,-0.419425,-0.366486,-0.465347,-0.0492791,-0.0926078,-0.2539,0.678932,0.322078,-0.0264289,-0.473774,-0.0363914,0.121865,0.328921,-0.775874,-0.149152,-0.381399,-0.294631,0.41634,0.123979,-0.172156,-0.259536,-0.402163,-0.231132,0.24969,0.456903,0.043632,-0.370674,-0.194843,-0.0355427,-0.483222,0.46111,-0.215622,0.0533019,0.362914,-0.273737,0.614916,-0.0283947,0.148304,-0.221134,-0.187394,-0.0804237,0.357226,0.198773,0.204167,-0.302067,0.308088,0.0641784,0.038276,0.180307,0.143923,-0.3026,0.191535,-0.218141,-0.0130115,-0.0869146,-0.470393,0.0430602,0.0866892,-0.0507263,-0.217933,-0.270089,-0.00150569,-0.314222,0.787585,0.0990378,-0.704965,-0.172434,0.327633,-0.358032,-0.273412,0.173203,0.145636,-0.118008,0.00136493,0.0390383,0.255932,-0.00146979,-0.210979,-0.151327,-0.167741,0.239664,-0.563942,0.0705682,0.211806,-0.0803887,0.123454,0.251974,0.151014,0.201748,0.482824,-0.275014,0.0758943,0.643054,0.132343,0.111846,0.148218,0.259414,-0.136941,-0.358318,0.0129284,-0.520362,0.156173,0.422634,-0.370471,0.315529,0.0472349,0.296172,0.0632612,-0.353663,-0.110525,0.163676,0.205948,-0.170104,-0.054838,-0.0398606,0.0546778,0.0489904,-0.0679755,-0.00954056,0.190885,0.43588,0.140632,0.078301,-0.485617,-0.447852,0.0567061,-0.302029,-0.00889043,-0.0711179,0.0863815,0.297395,0.293907,0.545339,-1.39717 +3480.19,0.991277,0.0912059,4,1.61685,0.793905,-1.2864,0.586924,0.25402,0.00044524,0.246442,0.0110281,0.506514,-0.37529,-0.0466291,-0.11024,-0.178668,0.602098,0.0420529,0.946742,0.38191,0.322846,0.05109,-0.0583051,0.182441,-0.585993,-0.583393,0.35236,-0.0377765,-0.434347,-0.115014,0.171025,-0.295717,-0.0842214,0.902476,-0.51213,-0.0172956,0.584554,-0.675864,0.223644,-0.774923,0.840759,0.451582,-0.0308233,0.726509,0.355423,0.611434,-0.7866,-0.247953,0.183217,-0.79324,-0.132671,0.285093,-0.0560642,-0.3344,-0.0422198,-0.211153,-0.329785,0.384397,-0.258224,-0.56558,-0.607818,0.071143,0.0557082,0.416495,1.05375,-0.908481,-0.278418,0.0209115,-0.00790642,0.0435153,-0.366287,-0.176626,-0.317157,0.157624,0.231491,0.654649,-0.045132,0.68226,0.222657,-0.0386428,-0.21002,-0.124129,0.0736456,0.285041,-0.405398,0.260361,-0.0729655,0.263718,0.0902632,0.565698,0.200697,0.199339,-0.221027,0.05094,0.3205,-0.43859,-0.226451,-0.43186,-0.414048,-0.342217,0.230405,0.110536,0.530578,0.530433,-0.301338,-0.263697,-0.47495,0.2113,-0.111704,0.28025,-0.0878183,0.171234,0.226403,-0.326701,-0.110688,-0.230286,0.137108,-0.489182,0.150875,-0.364391,0.0471278,-0.113875,-0.568919,-0.667545,-0.0011431,-0.0550379,-0.0917903,-0.223166,0.0250628,0.294937,0.124324,0.223061,0.162567,0.161539,-0.0744598,-0.445403,0.271909,0.0790294,0.0875133,-0.0585574,0.189039,-0.105653,-0.276567,-0.000713428,-0.309374,-0.208419,-0.191984,0.323558,0.185748,0.299594,-0.127789,0.0727043,0.0099801,-0.0447812,0.0284274,0.104007,-0.199894,0.148979,0.0746238,0.0331624,0.529244,-0.152477,-0.110863,0.116908,0.357687,0.682255,0.253515,0.0540643,0.13727,-0.303954,-0.221668,0.133106,0.344717,0.374796,-0.0152012,-0.0612825,0.0572506,0.233811,-0.445323,-0.378774,-0.263357,-0.553673,0.308444,-0.0383809,0.166166,0.104298,-0.0662959,-0.354083,0.148523,0.00856172,-0.155288,0.437218,-0.489664,-0.0189191,0.158606,-0.0507439,-0.482414,0.108999,-0.0130279,0.191021,-0.317122,-0.232534,0.0819814,-0.200262,0.212228,0.0858135,-0.175797,0.11979,-0.258474,-0.31629,0.996432,0.254025,0.151693,0.0839934,-0.0522558,0.0802528,-0.250328,-0.531648,0.0512818,-0.0105646,0.189061,0.375402,-0.454859,-0.382761,-0.657592,0.376343,0.240046,-0.0422712,0.48973,-0.590643,0.105778,0.0792009,0.188728,0.118023,-0.0507432,-0.17374,-0.138169,0.277601,0.0805993,-0.31378,0.39282,0.552951,-0.383381,0.113464,0.269283,-0.171257,-0.104155,0.275388,0.298418,0.408815,0.0449197,-0.144253,-0.176938,-0.153878,-0.366818,0.0665014,0.262862,-0.283319,0.386924,-0.0505998,0.114947,-0.0538859,-0.230184,0.0726311,0.187608,0.244935,0.00722673,-0.171988,0.145672,-0.0907928,-0.368557,-0.264475,-0.0962588,-0.0736443,-0.263719,0.0980748,-0.0494779,-0.434631,0.170627,0.103373,-0.0449999,-0.0345658,0.255673,0.14933,0.00353095,-0.223409,-0.0690441,0.0439913,0.3094,0.0648926,0.13535,0.114099,0.07921,-0.199338,-0.339048,-0.400317,0.187616,-0.161461,-0.124006,0.264369,-0.497064,0.0632785,-0.305038,-0.132694,0.0769055,0.216871,0.277318,0.465695,-0.510857 +3454.65,0.967463,0.0912059,4,1.55841,0.941069,-0.745769,0.416535,0.629722,-0.168076,0.352853,0.307534,0.360004,0.0129767,0.260901,-0.104761,0.107605,0.497657,-0.214462,0.703349,0.284177,0.20882,-0.272042,-0.233367,-0.126831,-0.550719,-0.761724,0.464009,0.175806,-0.161031,-0.303723,0.650589,-0.458227,-0.0334809,0.906988,-0.709841,0.0881209,0.423438,-0.360741,0.196376,-0.21883,0.783024,0.716814,-0.746286,0.83937,0.296003,0.300903,-1.12629,-0.100402,0.260477,-1.04055,0.0086118,0.14866,0.0230802,-0.123198,-0.217454,-0.297759,0.0466115,0.467667,-0.175748,-0.465381,-1.10671,0.312614,-0.656411,0.45104,0.938192,-0.141057,-1.2955,0.202023,0.50087,-0.114183,-0.323369,0.467273,-0.263449,-0.390463,0.360344,0.409425,0.119065,0.519901,0.111374,0.289994,0.33105,0.37685,0.15254,0.462531,-0.151756,-0.0151863,-0.439908,0.387692,0.0125105,-0.271427,0.151189,0.223089,-0.576351,0.0850772,0.047553,-0.381302,-0.199519,-0.76475,-0.0534206,-0.137773,-0.34545,-0.01599,-0.12233,0.543527,-0.0685418,-0.224907,-0.31966,0.107024,-0.106158,0.0923368,-0.242368,-0.198326,0.477444,-0.389864,0.0951258,-0.460878,0.16981,0.251441,0.50081,-0.525668,0.245521,0.258403,-0.22299,-0.776029,-0.0741331,-0.675442,-0.173462,0.556771,0.442431,0.1413,0.0664317,-0.189746,0.0541293,0.267645,-0.210523,-0.310939,0.396986,-0.226499,0.0131776,0.336507,0.202224,0.0276572,-0.0191059,0.199728,0.145524,0.0852087,-0.199652,-0.223587,-0.0279407,0.392715,0.414938,-0.0917219,-0.172849,0.127597,-0.380994,-0.018683,-0.484553,0.125513,0.205582,-0.233956,-0.201104,-0.436262,0.148783,-0.355196,-0.105316,0.298041,-0.233645,-0.162124,0.0258198,-0.23527,-0.35656,-0.0326364,0.310052,-0.0139651,-0.0796683,-0.294106,0.280602,0.295846,-0.166158,-0.141012,0.00442381,0.330647,0.225803,0.018266,0.111417,0.172152,0.0286555,0.373001,0.13227,-0.194608,-0.465882,-0.104667,-0.230964,0.0974247,0.33638,-0.0329972,-0.15724,-0.267042,0.217987,0.126308,-0.308462,-0.495555,0.273952,-0.156931,-0.129919,-0.0415065,0.319412,0.16271,0.129829,0.416841,0.653387,-0.0015287,0.281754,-0.0573071,0.0995463,-0.382141,0.219465,0.228739,0.016704,-0.149965,0.345249,0.369598,-0.207171,0.314173,-0.310705,-0.191179,-0.339346,0.390012,0.209989,-0.24212,-0.113862,0.544696,-0.24898,-0.155099,-0.13854,0.243698,-0.408752,0.155321,0.325575,-0.387812,0.482291,0.0492399,-0.475051,0.0827344,0.142509,0.160799,0.429588,0.202153,0.136609,0.193906,-0.0720608,0.121509,-0.531481,0.262662,-0.147901,0.457964,-0.189057,0.361478,0.351896,-0.352104,0.43159,0.0630302,-0.0230519,-0.311255,0.420853,0.120283,0.245091,0.028752,0.228412,0.0451931,-0.0705697,0.0633926,-0.135891,-0.187224,-0.66619,0.131337,0.151398,-0.131956,0.0250966,0.306184,0.116799,0.388557,0.353633,-0.531603,-0.293195,-0.0530068,0.470856,-0.00802252,0.011537,0.142813,0.145015,0.178515,0.146875,-0.326611,0.351739,-0.117423,0.268655,-0.301935,0.045171,0.0735054,-0.0875014,0.0986203,-0.198981,-0.393054,0.0754518,0.196413,0.274685,0.443186,-2.15707 +3449.3,0.532682,0.0912059,4,1.57277,0.92728,-1.12339,0.502799,0.421194,-0.193109,-0.022143,0.0658726,0.433399,-0.117789,0.289452,-0.000183497,-0.0337532,0.372499,-0.347372,0.65697,0.340981,0.200905,-0.416846,-0.338293,-0.15056,-0.516136,-0.674247,0.197477,0.0510843,0.0241469,-0.513506,0.706997,-0.471924,0.0462982,0.917027,-0.748202,-0.32419,0.481865,-0.440536,0.215079,-0.284182,0.798309,0.445534,-0.644363,0.795939,0.574813,0.104209,-1.22484,-0.0276185,0.286453,-0.822951,-0.114563,0.171862,-0.131188,-0.457177,0.0244432,-0.17973,0.0240977,0.31513,-0.252116,-0.453081,-1.26879,0.204673,-0.502253,0.248022,0.942024,-0.367471,-1.5693,0.0866982,0.472556,-0.0990371,-0.409812,0.260201,-0.221831,-0.361566,0.247899,0.429801,-0.0556552,0.625906,0.21571,0.293008,0.0745174,0.202145,0.103279,0.498557,-0.177081,-0.0404623,-0.2582,0.308004,0.076238,-0.701719,-0.28291,0.00368558,-0.727347,0.00415451,0.0460533,-0.530588,-0.201693,-0.519217,-0.28056,-0.0587252,-0.128441,-0.102661,-0.0793726,0.426948,-0.207259,-0.0122166,-0.239579,-0.0847962,-0.0289634,0.054548,-0.365626,-0.137915,0.408222,-0.300312,0.203514,-0.388543,0.229503,0.472279,0.470464,-0.536728,0.235929,0.363737,-0.390926,-0.708208,-0.327091,-0.469499,-0.11204,0.215577,0.518809,0.198929,-0.00944038,-0.011813,-0.146092,0.163204,-0.173439,-0.178181,0.482249,-0.197063,0.0611635,0.555597,-0.140874,-0.0749547,-0.161015,0.238856,0.178912,-0.166302,-0.0746313,-0.32885,0.00700028,0.601523,0.518918,-0.149569,-0.204093,0.271949,0.0372198,-0.0249297,-0.563702,0.175268,0.261012,-0.0826997,-0.205236,-0.356094,0.275229,-0.339927,0.0980843,0.268709,-0.202899,0.00847572,0.166748,-0.0686281,-0.270457,-0.0513955,0.322574,-0.112681,0.169787,-0.25231,0.316422,0.36415,-0.0551012,0.0886898,-0.106905,0.420982,0.211015,-0.109443,0.0307562,0.408478,0.237475,0.329107,0.0324159,-0.102266,-0.392966,-0.105796,-0.585619,-0.0663584,0.403211,0.132517,-0.112381,-0.219148,0.0371716,0.135848,-0.148627,-0.481307,0.196477,-0.331154,-0.0470189,-0.189605,0.230505,-0.0250301,0.15405,0.471693,0.567669,-0.110936,0.329656,0.148569,0.0255682,-0.117365,-0.100493,0.0053554,-0.0612367,0.0378443,0.505736,0.585432,-0.078764,0.301775,-0.388226,-0.356886,-0.171951,0.508299,0.196281,-0.397165,-0.0311743,0.830967,-0.226037,0.140639,-0.0934606,0.167824,-0.332214,0.0470005,0.278302,-0.144281,0.404693,-0.0281642,-0.268195,0.136994,0.0913885,0.151907,0.247467,0.158526,-0.140691,0.317684,0.132845,0.15501,-0.367517,0.132892,-0.0141476,0.587196,-0.164735,0.201302,0.372115,-0.244702,0.0882258,0.191403,-0.0324404,-0.296041,0.139536,0.235639,0.291985,0.116739,0.250734,0.105748,0.0170612,0.138978,-0.0125958,-0.265779,-0.516921,0.0508529,-0.00603562,-0.0599657,-0.00182368,0.295151,0.0329823,0.525136,0.478312,-0.417496,-0.586951,0.250079,0.615515,-0.0876905,-0.0288066,-0.180771,-0.0851674,0.3292,0.120447,-0.157998,0.299914,-0.27917,0.119823,-0.144485,-0.0282459,0.322833,0.019742,0.0141057,0.0459651,-0.169153,0.0896574,0.208641,0.299428,0.456772,-1.3032 +3451.28,0.765457,0.0912059,4,1.60567,0.903196,-0.976407,0.461396,0.571245,-0.227125,-0.0389574,0.00442079,0.551096,0.0128445,0.1793,-0.077575,-0.176543,0.407617,-0.375277,0.56736,0.277281,0.171643,-0.242546,-0.226336,-0.0877933,-0.622593,-0.885342,0.22349,0.0453087,0.0109238,-0.411569,0.766981,-0.639055,0.0191906,0.915602,-0.954661,-0.285925,0.664731,-0.495352,0.168247,-0.0590378,0.60712,0.584922,-0.581959,0.940802,0.606265,0.221212,-1.14976,-0.0396941,0.0587552,-0.767079,-0.0231118,0.0930713,-0.23957,-0.272869,0.112492,-0.179039,-0.0776236,0.375602,-0.333443,-0.483756,-1.13006,0.107363,-0.524721,0.266021,1.04291,-0.455423,-1.34032,-0.0157271,0.375547,-0.106412,-0.378684,0.104733,-0.262818,-0.319052,0.0985648,0.39594,-0.253838,0.719002,0.299421,0.270756,0.0979473,0.265322,0.0362478,0.562732,-0.142834,-0.156361,-0.135593,0.223993,0.13926,-0.886046,-0.262383,0.120337,-0.708373,-0.141958,0.104229,-0.515983,-0.219404,-0.392067,-0.257342,0.116918,-0.0910179,0.0453373,-0.137417,0.233705,-0.314137,-0.0820144,-0.388848,-0.120415,-0.0428769,0.0554385,-0.248461,-0.237665,0.4423,-0.438228,0.304382,-0.24943,0.236285,0.402939,0.348593,-0.533244,0.306943,0.441073,-0.229488,-0.854089,-0.234848,-0.505119,-0.143499,0.339719,0.420236,0.29263,-0.0982266,-0.04195,-0.12506,0.396819,-0.18783,-0.390926,0.516069,-0.185062,0.122447,0.484039,-0.170082,-0.00311217,-0.0947026,0.246767,0.157122,-0.258741,0.0571472,-0.478624,0.167822,0.53754,0.505087,0.00925421,-0.332215,0.267471,0.0430499,-6.39789e-05,-0.388001,0.104011,0.176601,0.070063,-0.307761,-0.278344,0.2449,-0.362003,0.152803,0.365902,-0.289144,-0.130845,0.262576,-0.0531889,-0.425105,-0.0353353,0.344926,-0.219191,-0.0177039,-0.321976,0.402061,0.507553,-0.0501519,0.00349602,-0.0291274,0.180121,0.120635,-0.0371598,-0.00464903,0.376312,0.22153,0.238043,-0.0629944,-0.232672,-0.376906,-0.0900777,-0.608616,-0.0261685,0.405281,0.210094,-0.189074,-0.286872,-0.0560007,0.0206948,-0.323547,-0.469248,0.177906,-0.341371,-0.0801181,-0.0567546,0.251821,0.183975,0.234804,0.594506,0.694662,-0.0357207,0.200801,0.0421117,-0.0714101,-0.262626,-0.413639,0.0499354,-0.0443756,-0.0367753,0.341475,0.637847,-0.00850626,0.302945,-0.528167,-0.361286,-0.11436,0.487466,0.0805316,-0.260023,-0.0263417,0.731789,-0.209582,0.306951,-0.162533,0.266679,-0.315263,-0.0144732,0.27709,0.0149986,0.364278,-0.0761197,-0.0143871,-0.0224364,0.089952,0.106393,0.181275,0.0857794,-0.11295,0.387456,0.238415,-0.0761668,-0.477086,0.146949,0.0104725,0.570785,-0.132395,0.183352,0.337373,-0.287209,0.337419,0.181812,0.0281338,-0.307416,0.0591864,0.296236,0.481025,0.17568,0.159025,0.133394,0.0504096,0.0181507,0.131318,-0.229715,-0.482282,-0.0477132,-0.0456838,-0.110615,0.109634,0.271253,0.0272972,0.551267,0.320658,-0.513184,-0.399565,0.297717,0.495181,0.0164163,-0.0419834,-0.122229,-0.125686,0.261685,0.282838,-0.0515331,0.305309,-0.129774,0.132109,-0.0627397,-0.230606,0.259024,0.076759,-0.087514,0.13189,-0.182659,0.0849861,0.239961,0.291524,0.489859,-1.75532 +3460.59,0.988128,0.0912059,4,1.61232,0.916886,-1.24495,0.623754,0.902022,-0.187336,-0.228929,-0.0138978,0.340211,0.310892,0.122363,-0.177515,-0.305161,0.314665,-0.278149,0.618521,0.198761,0.201545,-0.304457,-0.262541,-0.11712,-0.598312,-1.12556,0.317681,0.036276,0.0113365,-0.206259,0.680961,-0.773708,0.0800501,0.882206,-0.94866,-0.0202494,0.505078,-0.341947,0.0880947,0.0798659,0.687996,0.481235,-0.464709,0.98544,0.468061,0.241064,-1.11122,-0.197858,-0.0605823,-0.631769,0.169098,0.139983,-0.192796,-0.479626,0.414471,0.0636281,-0.0223986,0.145264,-0.177394,-0.579487,-0.859874,0.19464,-0.609824,-0.118435,1.04368,-0.278546,-1.07347,0.0442514,0.421599,0.0356328,-0.235482,0.303719,-0.348736,-0.178018,-0.113839,0.435657,-0.229748,0.884522,0.258115,0.182373,0.010047,0.0604248,0.0603926,0.327978,-0.248484,-0.0969449,-0.0252452,0.083325,0.231864,-0.695605,-0.31078,0.0437563,-0.499661,-0.215217,0.112267,-0.437592,-0.405653,-0.262269,-0.185827,-0.0398553,-0.107428,0.0476116,0.112397,0.533774,0.0747504,-0.159492,-0.191743,-0.121487,-0.103082,0.0457528,-0.132649,-0.0396555,0.386384,-0.338596,0.131223,-0.0657779,0.217187,-0.126343,-0.0612976,-0.431099,0.357737,0.203237,-0.0783608,-0.949444,-0.181444,-0.329989,-0.205238,0.320352,0.367033,0.253109,0.0987451,0.146888,-0.322743,0.60887,-0.0809107,0.0543669,0.493442,-0.240182,-0.0565959,0.295401,0.038638,0.0213162,-0.144842,0.157477,0.238,-0.029537,-0.0776549,-0.466582,-0.0462549,0.540583,0.412726,-0.10998,-0.206509,0.148736,0.0984215,-0.100081,-0.401815,0.0125342,0.504282,-0.19159,-0.223895,-0.181325,0.150447,-0.327062,0.325524,0.415755,0.0154344,-0.18438,0.387511,-0.0449306,-0.405297,0.0225742,0.0877957,-0.44496,-0.224232,-0.0575564,0.165922,0.435543,0.108464,-0.0748359,0.0617563,0.0301545,-0.0161801,0.253743,0.014702,0.437562,-0.118187,0.120368,-0.272586,-0.265876,-0.367641,0.143646,-0.379852,0.115144,0.215633,0.234201,-0.197603,-0.435273,-0.145175,0.0468327,-0.203875,-0.64475,0.0220911,-0.25938,-0.34088,0.204563,0.098623,0.144924,-0.0544932,0.288345,0.471466,-0.198091,0.111384,0.228208,-0.231864,-0.0814251,-0.439731,0.131711,-0.0241225,-0.16068,0.268292,0.62422,-0.172923,0.307313,-0.448734,-0.224013,-0.13622,0.44048,0.182254,-0.258952,0.0175181,0.693725,-0.0615936,0.319702,-0.164609,0.136173,-0.296679,-0.047477,0.311304,0.189661,0.355118,-0.0414511,-0.0855864,-0.244321,0.370745,0.147498,0.177049,0.162439,-0.0955112,0.500505,0.363204,0.0171604,-0.543144,0.333789,-0.0079013,0.386778,-0.279479,0.204455,0.392331,-0.0189197,0.406046,0.28706,0.0188203,-0.275665,-0.0121437,0.562755,0.610534,0.53003,0.0730773,0.315,0.192237,0.0714549,0.107948,-0.285998,-0.366991,-0.216819,-0.242351,-0.288163,-0.00690017,0.0786049,-0.053079,0.530485,0.269155,-0.563158,-0.321698,0.395104,0.792971,0.0701382,0.0466062,-0.0291043,-0.128052,0.261604,0.266078,-0.0128122,0.487581,-0.144238,0.248731,-0.218888,-0.255914,-0.0655522,-0.0670098,0.0777844,0.0665316,-0.161342,0.0760827,0.237317,0.275831,0.487152,-2.8938 +3474.75,0.586082,0.0912059,4,1.68846,0.902955,-1.3219,0.619666,0.440276,-0.112658,0.0747415,0.173792,0.300343,0.471872,-0.0127764,-0.048674,-0.354805,0.266379,0.0167593,0.688344,0.0955915,0.212691,0.0564908,-0.0257399,-0.377257,-1.02824,-0.76801,0.219797,-0.419481,-0.0815179,0.351699,0.375938,-0.619483,-0.0908613,0.713855,-0.842139,-0.098176,0.135164,-0.629913,0.121554,-0.195213,-0.016966,0.925289,-0.131856,0.715706,0.581976,0.469987,-1.19309,0.0924206,0.051635,-0.803914,0.0593457,0.39045,0.0434955,-0.0336894,0.256621,-0.416727,0.0259485,0.037015,-0.0704073,-0.591973,-0.618659,-0.0390996,-0.181633,0.197486,1.1923,-0.793035,-1.3264,0.0250286,-0.439969,-0.255177,0.457313,-0.406656,-0.367409,-0.366051,0.13035,0.798229,0.17456,0.354476,0.203935,-0.230817,0.251762,-0.49584,-0.129895,0.254594,0.201451,-0.113451,-0.212405,0.258714,-0.245544,0.108242,-0.0939236,0.0732649,-0.233312,0.377942,0.652574,-0.0531671,-0.0225097,-0.29161,-0.570654,0.10395,-0.274554,-0.214707,-0.168548,-0.0914297,0.0115254,-0.514832,-0.12124,0.318677,-0.311259,-0.188568,-0.229015,0.367782,0.507101,-0.358232,-0.0754864,-0.278747,0.277568,0.170387,0.0837836,-0.0487341,-0.00636575,0.0323572,-0.0670705,-0.572286,0.072986,0.0745726,0.0212932,-0.107335,0.003069,0.266751,0.43742,0.196458,0.114523,-0.252127,0.136018,0.0571222,0.635314,-0.112411,-0.340208,0.00735819,-0.0015415,0.445212,-0.0558325,-0.105737,-0.345883,0.0637568,-0.296642,-0.176598,0.0462159,-0.13119,0.282198,-0.218868,0.0117161,-0.356482,-0.0320779,-0.000325446,0.132304,0.632908,0.483853,-0.0342432,0.232754,-0.260128,0.163955,-0.123944,-0.125226,0.00944286,0.230144,0.16936,-0.266236,-0.552972,-0.19415,0.0982857,-0.256581,0.0614047,-0.237964,-0.190205,-0.019611,0.151888,0.10987,-0.244009,0.117429,0.266233,0.416915,0.225916,-0.150279,0.335267,0.0205988,-0.0298157,-0.10072,0.248752,-0.0155174,0.266485,-0.000144287,0.132948,-0.215158,-0.323664,-0.334814,-0.0428478,0.397002,0.0639331,-0.0198122,0.351578,0.133555,0.0491815,-0.154429,-0.00509378,0.0715558,-0.0620862,0.390239,-0.569283,1.00155,0.318185,-0.145064,-0.13621,-0.17567,-0.737068,-0.0305713,-0.17377,-0.283803,-0.418351,0.237385,-0.00767424,-0.0655681,0.147344,-0.13942,-0.164445,0.0745911,-0.40775,0.0409312,-0.0432433,-0.47024,0.449446,0.303334,-0.195059,0.0892589,-0.514937,-0.282029,-0.415985,0.454812,-0.220293,-0.00298759,0.446773,-0.359339,-0.65514,0.208493,0.417146,0.161184,0.0469178,-0.0533318,0.0320064,-0.0740639,-0.615115,-0.0380447,-0.102162,-0.675972,0.200649,-0.185896,-0.493004,0.216257,-0.106533,-0.196745,0.0287354,-0.188181,0.224663,0.290731,-0.216046,0.122794,0.0533196,-0.0639506,-0.194838,-0.0243119,0.0578483,0.0652999,-0.0416172,-0.472525,-0.0291569,0.343432,-0.00681604,0.0530751,-0.0306036,0.109467,0.184278,0.304501,-0.171715,-0.00935624,-0.433587,-0.297474,-0.13033,-0.020354,-0.0337242,0.253522,-0.0266234,-0.480306,-0.0759856,0.0579221,-0.055517,-0.210971,0.0629012,-0.123476,0.575305,0.0445109,-0.21243,-0.0468543,0.18901,0.0767677,0.270671,0.27707,0.520261,-1.2345 +3469.64,0.960919,0.0912059,4,1.56684,0.866117,-1.24795,0.41307,0.862909,-0.091056,0.39406,-0.162669,0.546204,0.155346,0.174195,-0.470426,-0.0373847,0.163261,-0.32472,0.516918,0.0290688,0.0876367,-0.400616,-0.0367027,-0.240295,-1.11587,-0.927384,0.090026,-0.258582,-0.236109,-0.0771509,0.438491,-0.29857,0.291111,0.865633,-0.48219,-0.142156,0.160203,-0.332525,-0.289959,-0.192231,0.51838,0.792735,0.107647,1.30318,0.547217,0.0847688,-0.422739,-0.082512,-0.192888,-0.644762,0.600684,0.715375,-0.147451,0.245404,0.61136,-0.247587,-0.362088,0.685205,-0.0705637,-0.283567,-0.976139,0.53659,-0.121341,0.131186,0.93274,-0.41013,-0.299206,-0.285999,0.214131,0.161601,-0.560135,0.0977893,-0.215115,-0.169084,-0.0399319,0.289377,-0.272652,0.19349,0.37004,0.271313,-0.0740416,-0.0795103,-0.163098,0.316938,-0.771094,0.248136,-0.239521,-0.0283453,-0.15551,-0.0937394,0.112856,-0.0580251,-0.239831,0.310996,-0.00308245,0.147085,0.0152177,0.312551,-0.100936,-0.0276524,-0.0294282,-0.0383829,0.60584,0.296477,0.24454,-0.160831,-0.613706,-0.143787,-0.0562042,0.486534,-0.3861,-0.191097,-0.0462966,0.30673,0.17053,0.333712,0.31534,0.194003,0.167377,-0.428977,0.332591,0.132728,0.362498,-0.304153,-0.254469,-0.568829,-0.282285,-0.208129,0.252547,-0.15998,-0.699386,-0.0794919,-0.515581,0.136066,-0.152784,-0.0313836,0.591998,-0.237844,0.17333,-0.197867,-0.296863,0.0729982,-0.384197,-0.261556,-0.0058557,0.183985,-0.0854189,-0.160572,-0.162753,0.0877331,0.127628,-0.108051,0.028367,-0.261103,0.248136,0.202733,-0.35021,-0.200855,0.0893654,-0.167342,-0.399089,-0.393778,-0.426007,0.750677,0.170439,0.612008,0.146973,0.279064,0.0507539,-0.30074,-0.0199864,-0.212037,0.125685,0.583918,0.139397,-0.0228798,-0.0820727,-0.177984,-0.549354,-0.210251,-0.318001,0.0015372,0.281443,0.473207,0.0171258,0.108431,-0.0335381,-0.0939828,-0.145979,-0.417893,-0.387703,-0.112995,-0.375237,0.128129,0.123902,0.494324,-0.179598,-0.402161,-0.120322,-0.18721,-0.0535011,-0.212187,-0.140949,-0.259962,-0.260743,0.0951117,-0.262195,-0.0184879,-0.41481,-0.144586,0.828027,-0.00104706,0.366583,0.60901,-0.0338668,0.60148,-0.119121,0.0886611,0.0249075,0.264268,-0.063306,0.234039,0.163303,-0.12138,-0.0632644,0.0409471,-0.104826,-0.222414,0.0576038,-0.177015,-0.110116,0.117601,0.497624,0.00257368,-0.148031,0.206571,0.0823311,-0.218622,0.132282,-0.182984,-0.0626213,0.243236,-0.245771,0.184912,-0.00537637,-0.46865,0.10369,0.237251,-0.0390649,0.431788,0.0926182,0.247497,-0.0761989,-0.145359,0.2404,0.110548,-0.431062,0.0505861,-0.060158,-0.0226985,0.339123,0.103564,-0.0738378,-0.0560501,0.328691,0.134643,-0.0660148,0.3034,0.129293,0.217549,-0.0544906,-0.263082,-0.118955,0.0285444,-0.0525471,-0.0553931,-0.220555,-0.429509,-0.126661,-0.169202,-0.0492137,-0.0449585,0.0312998,-0.37161,0.0701989,-0.334518,0.32245,-0.0710378,0.0929693,-0.470102,0.00946677,0.315611,0.259504,0.0168914,0.11575,0.239165,0.513407,-0.064123,-0.647566,-0.249804,-0.0894093,0.290393,-0.364151,0.0989575,0.0718583,0.242511,0.268064,0.492454,-2.54237 +3474.6,0.901104,0.0912059,4,1.5603,0.856378,-1.03879,0.313674,0.236767,-0.0952019,0.274269,-0.33943,0.643581,0.0483277,0.273186,-0.406557,-0.271375,0.472194,-0.328243,0.719228,0.226428,0.133697,-0.439186,0.0808782,-0.171863,-1.20453,-1.1969,0.281449,-0.208656,-0.0284228,0.147716,0.7731,-0.167361,0.0380572,0.738569,-0.399622,-0.527662,0.0558266,-0.251139,0.104448,-0.0966942,0.532276,0.863585,0.123305,1.02583,1.13771,0.0540678,-0.496542,-0.000399708,0.0419786,-0.884316,0.82712,0.71372,0.0954558,0.226792,0.315525,-0.180632,-0.226674,0.892306,-0.408313,0.0677694,-0.802218,0.355247,-0.141632,0.14454,1.36967,-0.287715,-0.809164,0.00638674,0.0416429,0.335466,-0.319142,-0.175079,-0.0647669,-0.423217,0.159373,0.533259,-0.231196,0.243449,0.143959,0.359478,0.300705,-0.127455,0.0356912,0.506761,-0.740899,0.133892,-0.363912,-0.233277,-0.281,-0.624063,0.03236,0.0735411,-0.335432,0.208506,0.328192,-0.216987,0.0604281,0.0870401,-0.332819,-0.185829,-0.464594,0.310221,0.478472,0.427173,0.124328,0.0696642,-0.67816,0.21315,-0.0929004,0.324069,-0.133319,0.256122,0.305173,0.335823,-0.104942,0.0282502,0.22726,-0.109251,-0.126639,-0.182737,0.168076,-0.0317461,0.488881,-0.424186,-0.180082,-0.354926,-0.101211,-0.0969389,0.323048,-0.346125,-0.14184,0.171859,-0.322082,0.541425,-0.112674,0.089677,0.456249,-0.1758,-0.0704536,-0.24331,-0.433838,0.0139361,-0.72502,-0.23402,0.0310661,-0.0566443,-0.0106604,0.0229644,0.152088,0.345944,0.0961764,-0.189573,0.309498,-0.279507,0.166608,0.397702,-0.159892,-0.0829019,0.208884,0.450156,-0.256194,-0.225719,-0.107319,0.64765,0.0325554,0.644917,0.0640446,0.0647473,-0.124898,-0.459793,0.254956,-0.243878,0.506486,0.339515,-0.0175333,-0.220227,-0.137271,-0.145051,-0.290178,-0.0487586,-0.465051,0.0870001,0.455777,0.161963,0.0421897,0.201452,-0.218406,-0.245871,-0.672977,-0.431977,-0.407391,0.108145,-0.37973,-0.185908,0.153754,0.323915,-0.297768,-0.0145425,-0.039001,-0.0753588,-0.157633,-0.110919,-0.17709,-0.17226,-0.0674695,0.371211,-0.103427,-0.156921,-0.460986,-0.377161,0.57628,0.242591,0.321542,0.067482,0.157471,0.555093,0.109773,-0.163785,-0.234997,0.0222331,-0.0919035,-0.0692273,0.00704976,-0.313635,-0.103534,-0.237446,-0.152401,-0.562744,0.156624,0.0282587,-0.304804,-0.0276593,0.534981,0.26092,-0.0797853,0.414549,-0.0421026,0.172115,0.41374,-0.209238,0.00760456,0.287918,-0.0240035,0.130542,-0.105779,-0.0820796,-0.138917,0.137944,0.437399,0.338835,0.189401,0.14362,-0.104095,0.323177,-0.146162,0.192128,-0.25956,-0.246203,-0.290041,-0.0299173,0.0718379,0.25642,0.0339762,0.19023,0.175341,-0.0668508,0.0749245,0.00288744,0.0987658,0.0026495,-0.0413677,0.0138463,-0.044294,0.157858,0.225121,0.187585,-0.0284104,-0.473983,-0.150549,0.014466,0.0615216,0.17129,-0.388734,-0.033095,0.114777,-0.108172,-0.176343,-0.10374,-0.0990555,-0.35947,0.595675,0.303137,0.0214785,0.165154,-0.120712,0.267247,0.0776955,-0.0752481,-0.480633,-0.198801,-0.0714825,-0.160323,0.158802,-0.113651,0.0720146,0.339051,0.268355,0.582281,-0.467625 +3465.65,0.715439,0.0912059,4,1.62605,0.798086,-0.376133,0.0860815,0.264033,-0.0376845,-0.322626,0.552326,0.378993,0.149905,-0.18993,0.0666606,-0.172073,0.685217,-0.0268123,0.938431,0.220879,-0.0826804,0.0162136,-0.0919446,0.108778,-0.8643,-0.91796,0.558422,-0.29385,-0.297071,-0.393457,-0.081228,-0.315893,0.114448,0.797815,-0.56982,0.158138,0.239273,-0.0673493,-0.277196,-0.835938,0.667969,0.364483,-0.619259,1.11014,0.0126687,0.169292,-0.394696,0.0334147,0.0362372,-0.20721,-0.137844,0.748207,-0.112627,0.327388,0.0828968,0.442369,-0.0237449,1.27953,-0.118314,-0.227112,-0.909165,0.797497,0.0451516,0.515593,0.795039,-1.13078,-1.01316,0.291238,0.32763,-0.503705,0.269172,0.341488,-0.660861,0.210612,0.131622,0.362618,0.0679181,0.546329,0.392325,0.0878829,-0.185016,-0.543087,-0.229387,0.498095,0.388338,0.0624941,0.334381,0.208217,0.364243,0.495075,-0.408072,-0.0526554,-0.438449,0.0622299,0.124773,0.307802,0.0774804,0.20834,0.140607,0.209969,0.107996,-0.0444131,-0.183907,-0.299251,0.210264,-0.570338,0.146201,-0.120549,-0.368791,-0.220991,-0.436271,0.287949,0.614574,-0.216326,0.0898136,-0.0477424,0.160202,0.380516,0.385005,0.0485529,-0.16388,-0.0894322,-0.823647,-0.522167,0.237033,-0.0356342,-0.22624,0.0827306,-0.0865513,0.221735,0.146953,0.136782,-0.167399,-0.49672,0.0360504,-0.0402638,0.0110336,-0.168616,-0.267346,0.176812,0.151592,0.420131,0.380309,0.0856234,-0.205272,0.100043,-0.599986,0.116707,-0.0484093,-0.466199,0.512764,-0.255328,-0.514492,-0.165076,-0.0246214,0.159003,0.336742,0.59061,0.120559,-0.33954,0.196423,0.107867,0.0417106,-0.247931,0.0109344,0.311374,-0.159425,-0.258003,0.0437743,-0.200943,-0.342059,-0.115705,-0.554623,0.108856,-0.301038,-0.219533,0.0162837,0.283223,0.603879,-0.425875,-0.0734141,0.003735,0.484222,-0.254902,-0.254225,-0.161747,0.174086,0.0634354,0.039549,0.307075,0.136399,-0.103082,0.134537,0.12543,-0.214982,-0.332723,-0.655292,0.188453,0.527231,0.00410868,-0.304927,-0.061832,0.635958,-0.0356622,-0.22423,-0.184551,0.225834,0.184586,0.391029,-0.108151,0.801951,-0.269252,0.0295613,0.140346,-0.221689,-0.307168,0.189851,-0.136157,0.295817,-0.347062,0.175996,0.22059,-0.456987,0.130394,-0.458847,0.249781,0.447267,0.0818753,0.216321,-0.126957,0.0230775,0.194364,-0.395877,-0.531045,-0.0164005,-0.458851,-0.188298,-0.124725,0.18352,-0.134615,-0.0369307,0.446038,-0.331095,-0.10237,0.151445,0.0327633,0.029899,0.0943708,-0.236637,0.308437,-0.0679161,-0.113184,-0.456545,-0.328653,-0.529955,0.197185,-0.173874,0.087323,0.396425,-0.495987,-0.130455,0.190386,-0.108788,0.0403255,0.318929,0.323586,-0.0811212,0.0393933,-0.054923,-0.263329,-0.0172767,0.120152,0.236714,-0.341771,-0.370595,-0.353231,-0.0426345,0.315001,0.203795,-0.132684,-0.129276,0.273088,0.337351,-0.114262,-0.434355,-0.128018,0.104499,-0.0304232,0.426117,0.216176,-0.393667,0.0168798,-0.225852,-0.30046,0.456134,-0.191107,0.303968,-0.255955,-0.347829,0.176839,0.0480612,0.187021,-0.311512,-0.0234816,0.0906368,0.254217,0.301059,0.504199,-0.536052 +3466.73,0.897211,0.0912059,4,1.54587,0.76919,-0.858827,0.290681,0.190427,-0.032792,-0.427246,-0.0502657,0.501741,-0.0593014,0.00388745,-0.417271,0.216535,0.444745,0.1269,1.11959,0.414685,0.152774,-0.213325,0.00959001,-0.250943,-0.918428,-0.853484,0.523823,-0.556874,0.0431313,-0.244213,-0.15566,-0.561923,0.226949,1.1295,-0.542051,-0.038788,-0.0974115,-0.0765872,0.255878,-0.513436,0.417933,-0.160383,0.0935146,1.2434,0.374774,0.159578,-0.356738,-0.084016,-0.184868,-0.571716,0.22908,0.742678,-0.216575,0.227993,0.834107,0.244838,-1.05904,1.11245,-0.57181,-0.507776,-0.957557,0.757081,-0.426691,0.315429,1.01865,-0.592158,-0.863494,0.352064,0.0347546,-0.298697,0.0507215,0.465076,-0.188372,0.303436,0.191815,0.635925,-0.216577,0.0471898,0.308332,-0.0937271,0.0336282,-0.033157,0.21384,0.423019,-0.863219,0.133613,-0.00942548,-0.480722,-0.0126902,0.280142,0.368785,-0.210295,-0.481558,-0.252028,0.115872,0.145737,-0.0484033,-0.0631678,-0.0239387,0.0148295,0.171001,-0.0548466,0.0525611,-0.506051,-0.227331,-0.668313,-0.0927392,0.0022632,0.00520358,0.076198,0.0866336,0.650943,0.289011,-0.372126,0.0489042,0.131073,0.15512,0.265105,0.358605,-0.0415229,-0.223161,-0.202051,-0.504361,-0.4037,0.38509,-0.117267,-0.380306,0.312275,0.267441,-0.0911934,0.280877,0.318464,-0.00764093,-0.298039,-0.0810216,0.348425,0.190346,0.0324307,0.109341,-0.0399193,0.141916,0.593737,-0.398584,-0.106527,-0.206966,0.0167987,-0.439753,0.187232,0.0181103,-0.411476,0.210253,-0.157275,0.156528,-0.416393,0.418725,0.0538679,0.0228394,0.279172,0.0679929,0.368147,-0.449379,-0.294243,0.380886,-0.0658241,-0.208894,0.308704,0.0801691,-0.720395,0.221372,-0.138497,-0.438775,-0.241699,0.0280716,0.321747,0.232188,-0.427561,-0.0298097,0.404897,0.087635,-0.648769,-0.164133,-0.133898,0.550225,0.162753,-0.400175,-0.397253,0.165417,-0.2263,-0.16554,-0.258992,-0.127526,0.165564,-0.0944621,0.268756,-0.361649,-0.255327,-0.283179,0.190063,-0.124196,0.426779,-0.115716,-0.264402,0.233267,-0.308775,-0.134935,0.0358743,0.237762,-0.43363,0.262239,-0.241919,0.963278,-0.0844469,0.216271,0.277816,-0.00203811,0.401438,-0.210792,-0.918505,0.549505,0.178494,-0.000721061,0.610745,0.0972946,-0.058262,-0.112422,0.256988,0.0743506,-0.166193,0.188564,-0.0548018,-0.165444,-0.249237,-0.188155,-0.368354,-0.194269,-0.0299863,-0.0857764,-0.690787,0.363408,-0.0494433,-0.230299,0.547578,-0.619378,-0.323119,-0.147863,0.361486,-0.348942,0.0992463,-0.0109989,0.547664,0.281091,-0.248498,0.0194393,0.332456,-0.706305,0.372118,-0.260376,0.0172917,0.242606,-0.503841,0.24783,0.145213,-0.0396113,0.39999,0.154135,-0.542039,-0.123445,-0.117639,-0.0624874,-0.0104691,-0.12626,-0.0649731,0.3383,0.0968593,-0.35351,-0.101535,0.140336,0.160367,-0.327566,-0.158615,-0.195499,0.277217,-0.273883,0.0809315,-0.191697,0.198589,0.0617346,-0.230522,0.619965,-0.449108,-0.407681,-0.126344,-0.584296,-0.147442,0.115285,0.0697479,0.338084,-0.43206,0.0712745,-0.183374,0.0734277,-0.534449,-0.276239,-0.110554,0.0909781,0.27502,0.301626,0.524423,-0.262429 +3455.71,0.970827,0.0912059,4,1.6352,0.808476,-0.636594,0.212815,0.327003,-0.0754501,-0.381814,-0.252089,0.585317,-0.267615,-0.035317,-0.277841,0.25702,0.347368,-0.213284,1.03892,0.234946,-0.0428911,0.317514,-0.168293,-0.0224966,-0.889715,-1.04904,0.408202,-0.875009,-0.454821,-0.232031,-0.0897268,-0.827527,0.293107,0.843415,-0.771318,0.0469436,0.159046,-0.214625,0.132392,-0.236751,0.531374,0.2053,-0.0168506,1.06308,-0.164367,0.0588414,-0.335278,-0.367242,-0.393822,-0.900487,0.190618,0.38833,-0.307695,0.0796766,0.49601,0.147144,-1.41556,1.13372,-0.424753,-0.503322,-1.33143,0.604456,-0.104266,0.451599,1.13014,-0.327775,-0.542162,0.143545,-0.074061,0.0997831,-0.252645,0.129408,-0.107118,0.0944938,0.103657,0.661761,0.00614719,0.38784,0.168452,0.320649,-0.323108,0.144299,0.335316,0.20371,-0.4378,0.136949,0.0652194,-0.138463,-0.122392,0.571922,0.267836,0.0110324,-0.343644,-0.179763,0.0979129,0.0567712,-0.0572556,-0.0910393,-0.201536,0.318361,-0.320998,-0.0491343,0.0362428,0.170602,0.217522,-0.493786,-0.142379,-0.0230549,-0.287981,-0.174118,-0.129877,0.309498,0.649208,-0.0327378,-0.135138,0.299641,-0.021312,-0.0281672,0.480671,-0.0727689,-0.201665,0.126726,-0.419971,-0.488785,0.556463,0.100158,-0.428942,0.338149,0.165072,0.307644,0.375136,0.476713,-0.140501,-0.203757,-0.023101,-0.148372,0.327936,-0.0112527,-0.418655,-0.196814,-0.10532,0.315679,-0.667849,-0.206852,0.10311,-0.258548,-0.191424,0.663601,-0.28139,-0.191059,-0.103247,-0.0838643,0.278916,-0.0143613,0.62527,-0.219331,0.0868975,0.199522,0.139813,0.480832,-0.40096,-0.13277,0.227813,-0.346615,-0.44689,0.540677,-0.311561,-0.346562,-0.0163514,-0.0943031,-0.292741,-0.154486,-0.274608,0.221533,0.174997,-0.273365,0.0684094,0.0248051,0.723565,-0.320953,0.0339406,0.210998,0.566844,0.0203936,-0.630787,0.0796295,0.0253097,-0.115586,-0.301298,-0.173079,-0.111664,0.437377,-0.00926636,0.131211,-0.165975,-0.00746827,-0.486653,0.424102,0.0937091,0.373705,-0.291225,0.167724,-0.588443,-0.0565343,0.126577,0.13222,-0.306915,0.202305,1.23332e-05,-0.0659589,0.655485,0.40512,0.0642693,-0.126171,0.0478198,0.388772,-0.119486,-0.770142,0.284366,-0.47885,0.225679,0.98219,0.391238,-0.0917767,-0.0570744,0.2656,0.140468,-0.227593,0.0786129,-0.274348,-0.122842,-0.0239159,-0.0397611,-0.230573,-0.0802228,-0.583683,0.215367,-0.21233,0.256506,0.208633,-0.311369,0.323671,-0.1466,0.0234513,-0.0655057,0.318048,-0.0556379,-0.0613622,0.161029,0.30553,-0.314321,-0.615515,0.0426985,0.222821,-0.397048,0.123124,-0.199657,-0.05406,0.377441,-0.269507,-0.302227,0.155064,-0.00913613,-0.0865675,0.756708,0.143449,0.239589,0.0556241,-0.00487139,-0.267756,-0.148102,-0.317681,0.117453,-0.142342,-0.531715,-0.11011,-0.0248952,-0.212585,-0.166463,-0.0679961,-0.136976,0.157996,-0.339157,0.0640391,0.326695,0.322656,0.0182033,-0.196505,0.243026,-0.375875,0.543094,0.324367,-0.106093,-0.32339,0.646593,0.0377247,0.165692,-0.357636,0.165868,-0.298789,-0.312085,-0.514177,-0.490497,-0.0356754,0.0872516,0.326897,0.295384,0.571749,-0.728218 +3450.1,0.986296,0.0912059,4,1.57949,0.755803,-0.907882,0.300991,0.228775,-0.0190764,-0.188207,0.320605,1.07712,-0.0038268,0.04774,-0.130146,0.111172,0.464763,-0.267509,0.503453,0.269461,-0.129092,-0.282266,-0.197985,0.0212459,-1.18609,-0.789392,0.324952,-0.246361,-0.28258,0.275051,0.0775387,-0.26138,0.320911,1.09425,-0.934249,-0.206705,0.252799,-0.204638,0.29556,-0.0257131,0.445836,0.156881,-0.414021,1.03782,0.0033807,0.272399,-0.386522,-0.218459,-0.258146,-0.497399,0.875008,0.782649,0.198264,0.100616,0.0292381,0.197345,-1.04825,0.907268,-0.70953,-0.478627,-0.783493,0.69958,-0.486863,0.352171,0.959765,-0.95567,-2.14238,0.0963355,0.413249,-0.24085,-0.283857,0.444759,-0.558984,0.0612305,-0.251193,0.556074,0.137079,0.47843,0.513069,0.0432174,0.0661756,0.317576,-0.292989,0.433391,0.152253,0.209372,-0.149493,-0.137591,-0.225209,0.413689,0.103641,-0.194212,-0.483091,-0.144969,0.365135,0.0732426,0.144298,-0.17256,-0.0294614,-0.483072,-0.422991,0.282553,0.0636769,0.509799,-0.0873367,-0.11579,-0.187268,-0.290279,-0.10041,0.115768,-0.292862,-0.00966105,0.365246,0.0813241,-0.126739,-0.51286,0.437636,-0.172039,0.554198,0.13102,-0.0236628,0.0980842,-0.212293,-0.638497,-0.16966,-0.122403,0.191292,0.356928,0.0783402,-0.400434,-0.082273,0.278398,-0.336076,0.145614,0.149564,-0.0137055,0.0919508,-0.112836,-0.191826,0.0097978,-0.0722088,0.344465,-0.229374,0.138928,-0.284645,0.232698,-0.412438,-0.416342,0.207893,-0.468811,0.348826,-0.143643,-0.247196,0.144133,0.190985,-0.165798,-0.0764056,0.303433,0.263765,0.256788,0.0249165,-0.267232,-0.285021,0.427953,0.419902,0.943649,-0.700951,-0.000103432,-0.0874743,-0.229085,0.101602,0.00750785,-0.61982,0.0929204,0.631494,-0.125017,0.351346,0.115356,0.118243,-0.311533,-0.252456,-0.0463883,0.00607942,-0.0684599,0.103626,-0.314475,0.0712704,-0.120016,-0.378792,0.136085,-0.0898005,0.47601,-0.488114,-0.0625882,-0.137236,0.100715,-0.166815,0.270065,0.237095,0.35074,-0.538452,-0.0712258,0.0698926,0.116351,0.0433977,0.0277718,-0.0166761,-0.448834,-0.164741,-0.474757,0.898179,0.374791,0.188293,-0.694195,0.341193,-0.554896,0.168212,-0.207103,0.539861,0.328768,0.0458355,0.000894576,-0.173248,-0.0106579,0.16419,-0.0273158,-0.137878,-0.6017,0.22093,-0.223673,0.119569,0.0144251,-0.128398,0.268645,-0.0639753,-0.0163994,-0.448326,-0.150746,0.197198,0.224724,0.248572,0.395433,-0.150636,0.248944,-0.221525,-0.206505,0.266235,0.239801,0.203291,0.400468,-0.076541,0.323542,-0.462492,-0.179861,-0.418187,0.277943,-0.407976,-0.0219358,0.394924,-0.39107,0.226161,0.446034,0.156627,0.0266047,0.0988936,-0.222501,-0.103633,-0.142405,-0.255941,-0.103359,-0.150561,-0.223496,0.060619,-0.0255305,0.157168,-0.726693,0.0939587,-0.454799,0.0780814,0.318732,0.268648,0.263055,-0.0819773,0.0300896,-0.54123,-0.197375,-0.318718,0.0333034,-0.0229033,0.286187,0.199979,0.187459,0.498175,-0.0691897,0.202401,0.608321,0.299857,0.026435,-0.551947,-0.462232,-0.0893943,-0.618048,0.241307,-0.0690786,0.0845759,0.378748,0.290819,0.615425,-0.319878 +3420.18,0.926358,0.0912059,4,1.55953,0.814274,-0.491281,0.157684,0.307838,-0.22838,-0.730546,0.331342,0.745641,0.318827,0.148944,-0.293628,0.0880577,0.452807,-0.468818,0.821756,0.3012,-0.0243441,-0.00233309,0.0578938,0.162516,-0.935347,-1.03836,0.532842,-0.366724,-0.0744803,0.452878,0.328417,0.0378267,0.0885066,0.875378,-1.19034,-0.286829,0.685481,-0.401239,0.186487,0.145674,0.211989,0.355978,-0.485912,0.973371,0.318096,0.0699725,-0.812606,-0.0900264,-0.117228,-0.417585,0.0815565,0.74657,0.0659078,0.0877018,-0.101651,0.196411,-0.875515,0.907578,-0.137132,-0.210068,-1.25683,0.501382,-0.390802,1.07233,1.20379,-0.52999,-0.745294,-0.0182433,0.991967,-0.234322,-0.751663,0.252236,0.284695,0.273288,0.357826,0.722461,0.503693,0.357743,0.299862,0.411585,-0.325708,-0.221723,0.0300286,0.3066,-0.157328,0.100907,-0.29881,-0.432553,-0.0925471,0.385712,0.238806,-0.0498527,0.0472951,-0.0463085,-0.0888024,-0.237686,0.348113,-0.161301,-0.383347,0.118216,-0.366313,0.168155,0.113518,0.51555,0.328519,-0.229407,-0.191898,0.281572,-0.423295,0.251036,-0.402378,-0.0177908,0.764574,-0.35784,0.00782522,-0.290832,0.369991,0.181268,0.0569314,-0.128438,0.0766595,0.580211,-0.223387,-0.57643,-0.110593,0.111632,-0.0235731,0.330444,-0.0338491,-0.812992,0.312435,0.197894,-0.396255,-0.232566,0.111989,-0.2827,0.73268,-0.379764,0.284541,-0.522393,-0.0291209,0.2324,-0.329108,-0.852829,-0.111758,0.534819,-0.483153,-0.331913,0.299557,-0.0650882,0.337015,-0.195934,-0.149246,0.0822837,-0.211714,0.635993,-0.767018,0.158941,0.415987,-0.122404,-0.251086,0.128651,0.28344,0.505837,-0.0579373,0.571903,-0.254651,-0.580267,-0.278372,-0.315902,-0.246048,0.146965,0.416195,-0.409947,0.132877,0.0944136,-0.122887,0.384424,0.596042,-0.47427,0.118957,-0.68607,0.623185,-0.240859,-0.18362,0.171374,0.193626,-0.00334523,-0.644051,-0.0802889,-0.458664,0.00942295,-0.280955,0.14217,-0.155837,0.0290064,-0.323259,0.364299,0.625606,0.218415,-0.401022,0.239345,-0.176665,-0.000898596,0.0149348,0.275867,-0.184315,-0.21018,-0.209082,0.348505,0.636422,0.215851,0.375101,-0.213294,0.0437419,-0.0877094,-0.0763295,-0.0163906,-0.0529547,0.102396,0.346406,0.61048,-0.394952,0.337343,-0.572104,-0.0687895,0.0277566,-0.140553,0.142617,-0.0557053,-0.00701409,-0.222501,-0.137499,-0.299498,0.101307,0.153527,-0.533122,-0.0342932,0.506122,-0.429213,-0.197019,0.131462,-0.457034,0.473578,-0.0227838,0.144924,-0.532592,0.0524138,-0.20868,0.259132,0.250604,0.0939552,-0.335575,0.11499,-0.628799,0.236727,-0.645469,-0.221119,0.198188,-0.14163,0.0384301,0.461015,0.10629,-0.0701339,0.390626,0.0683299,0.128381,0.445155,-0.142124,-0.162726,0.456816,0.232681,-0.0786174,0.0568404,-0.451502,-0.872299,0.580624,0.284851,0.417356,0.0736244,-0.568717,-0.114624,-0.274836,-0.150022,-0.724269,0.228027,-0.609652,-0.451357,0.133318,0.123016,-0.318758,0.0897171,0.153883,0.278465,-0.0613001,0.615835,0.182635,-0.121561,0.428786,-0.339754,0.0165188,-0.418489,0.1879,-0.00563994,0.126992,0.425476,0.356359,0.652285,-0.736342 +3403.47,0.956326,0.0912059,4,1.55091,0.932134,-0.881205,0.193429,0.451106,0.0232743,-0.321455,0.462897,0.983457,-0.0210126,-0.173473,-0.597212,-0.24169,0.36587,-0.365223,0.542912,0.169168,0.123779,-0.278594,-0.0798957,-0.384037,-1.07595,-1.72841,0.179174,-0.0740349,-0.468344,0.0944565,0.279213,-0.60986,-0.211455,0.565979,-1.03944,0.351087,0.355451,-0.358255,0.476864,-0.658901,0.630921,0.0680649,-0.160289,0.8106,-0.054738,0.35359,-0.220719,0.222353,-0.966723,-1.20656,0.0520127,0.718966,0.33491,0.096275,0.55417,0.319152,-1.4529,0.722859,-0.551076,0.155226,-0.918422,0.576834,-0.625199,0.222718,0.7896,-0.746678,-1.3414,0.285775,-0.205675,0.00201864,-0.192062,-0.43301,-0.949918,0.556469,0.598688,0.49549,0.0130894,0.920798,0.325517,0.060652,0.081362,-0.132184,-0.0728388,0.705343,-0.0255259,0.270947,0.107169,-0.373705,-0.387135,0.0484956,-0.13066,0.356472,-0.360908,0.264027,0.245688,-0.505866,0.314427,0.0807557,0.0933113,-0.425722,0.169926,0.124743,0.841856,0.105386,0.352152,-0.189558,-0.153253,0.207294,-0.140668,0.439898,-0.472599,0.374006,0.696116,-0.058816,-0.18452,0.31963,0.628663,0.517474,0.365472,-0.612926,0.185269,0.321959,-0.478503,-0.832152,0.166457,0.467896,-0.516805,0.330658,-0.194713,0.414742,-0.183017,0.0615418,-0.00717946,0.234931,0.0379902,0.22647,0.397438,-0.18627,-0.551931,-0.564261,-0.265395,-0.00599218,-0.147397,0.499022,-0.681418,-0.364163,-0.154832,-0.00563735,-0.651034,-0.0268844,0.243244,0.128633,0.155415,-0.458166,0.0513838,0.416594,-0.711622,0.061148,0.505942,0.49812,-0.107941,0.3911,0.196994,0.184725,0.300055,0.618153,0.956172,-0.640161,-0.617657,-0.3778,-0.144646,-0.19664,-0.31489,0.602209,0.147936,0.0891795,-0.0120922,-0.474989,0.0430048,-0.166611,-0.204866,0.310583,0.572634,-0.141671,-0.883714,0.136952,0.165481,-0.332899,-0.291155,-0.559176,-0.0886177,0.375254,0.128764,0.187145,0.27321,0.140018,-0.518282,-0.238272,0.204312,-0.201559,-0.203415,-0.506152,0.424266,-0.332567,0.055931,0.224789,-0.484326,0.23289,0.0453125,-0.145869,1.15174,0.509774,0.00364701,-0.18464,-0.058288,0.00360687,-0.282828,0.064108,0.277044,0.220011,0.0800923,0.453658,-0.580074,0.0196578,-0.476701,-0.116117,0.485879,-0.703146,0.392704,-0.56462,-0.374442,0.606272,-0.407332,-0.169869,0.251058,0.356285,0.340033,-0.030616,0.507876,-0.283788,-0.106869,0.694757,-0.138354,-0.244921,0.227206,0.45008,0.0635823,-0.207113,-0.123513,0.68942,0.650715,-0.702425,-0.632285,0.031844,-0.0446494,0.116171,-0.498545,0.36718,0.350676,-0.280103,0.433084,0.139374,0.0391153,-0.0763393,0.00449842,0.281514,0.266912,0.316162,0.277603,-0.260637,-0.443437,-0.342307,-0.261925,0.345615,-0.258431,-0.296924,0.159105,0.214856,-0.0735164,0.11807,0.431808,0.344075,-0.0827396,0.188909,0.435366,-0.156775,0.637512,0.147028,-0.0415568,-0.400396,0.223817,0.375717,0.0256562,0.082584,-0.470698,-0.565145,0.454064,0.201349,-0.413063,0.102898,0.13976,0.408457,-0.192467,0.252968,0.127993,0.430726,0.357762,0.656297,-1.3209 +3413.37,0.955194,0.0912059,4,1.58042,0.940341,-0.595944,0.0157263,0.556068,-0.248189,0.351546,0.370198,-0.110231,0.620425,-0.494342,-0.678612,-0.645545,0.457639,-0.791015,0.644513,-0.225151,-0.0940585,-0.250485,-0.254574,0.0348852,-1.83184,-0.993695,0.222199,-0.513785,0.251445,0.199323,-0.0389466,-0.374041,0.121675,0.664142,-0.762425,-0.0710126,0.203681,0.0483971,0.250915,0.118453,0.334034,0.896104,-0.118173,0.862802,0.802243,-0.0723257,-0.60063,0.171042,-0.189839,-0.308231,0.152165,0.933223,0.255103,0.456572,0.387924,-0.0644884,-1.73282,1.18284,-0.673788,0.224926,-1.27865,0.751512,-0.0419742,0.181775,1.03403,-0.434125,-1.05891,0.421581,0.0937412,-0.391182,0.111493,0.150074,-0.285342,0.363316,0.782136,0.278343,0.512287,0.404518,0.137523,0.257358,0.370424,-0.0480844,-0.182998,0.735914,0.270197,-0.0503873,-0.127241,0.011633,-0.0296615,-0.0832668,0.0515816,0.026933,-0.178464,0.625033,0.0429062,0.0411932,0.395685,-0.364378,-0.387542,0.716176,-0.356144,-0.302067,0.149531,-0.0183141,-0.274801,-0.327311,-0.282153,-0.214954,-0.0189767,-0.123939,-0.564992,-0.154536,0.424189,-0.445369,0.124713,-0.40667,0.374065,0.371972,-0.000573972,0.241451,0.217689,0.47388,-0.0635724,-0.27199,0.137638,-0.194375,-0.152991,0.198747,0.0276265,0.19895,-0.253078,0.546961,-0.530633,-0.381266,-0.406102,0.176212,0.732886,-0.270114,0.402454,0.282754,-0.205201,0.212322,-0.0395761,-0.48436,0.10198,0.643439,-0.0883695,-0.257204,0.10048,-0.00466491,0.119009,-0.156372,-0.125744,0.156627,-0.353641,-0.0988536,-0.235706,0.460443,-0.255762,0.127766,-0.348414,0.332281,0.00929273,0.650036,-0.331895,0.254839,-0.263466,0.571409,0.152613,-0.371229,0.280699,-0.0511546,-0.218562,0.00747111,0.853643,0.0510374,0.126713,-0.490715,0.0052091,0.0487464,-0.0128364,-0.098794,0.674955,0.513092,-0.530524,-0.0624032,-0.165537,-0.961778,-0.529285,-0.175359,0.231936,0.26429,-0.688484,-0.475547,0.235318,0.352593,-0.460113,0.174597,-0.248389,0.409567,-0.40272,-0.0601881,-0.249197,-0.318834,-0.546731,-0.161317,-0.138745,0.259937,0.263309,-0.342808,0.693128,-0.19549,0.170691,-0.0336061,0.166083,-0.0506247,0.227314,-0.107678,0.0738987,-0.27146,0.36588,0.306629,0.085029,0.0612079,-0.188384,-0.314713,0.16365,0.376649,0.0502837,0.0597117,-0.332636,0.206039,0.464434,0.227118,0.0491427,0.0921247,-0.880089,-0.34889,0.45015,0.102143,-0.143027,0.585971,-0.310084,0.306274,-0.189987,0.203132,-0.458008,-0.0800652,0.0959604,0.442651,0.36467,-0.0934204,-0.41547,0.337837,-0.180902,0.589801,-0.457917,-0.680349,-0.0396202,-0.464173,0.22739,0.407279,-0.174584,0.140512,0.522242,-0.348675,0.272456,0.10376,0.0143949,0.164982,0.446129,-0.229934,-0.00947759,-0.263124,-0.625604,0.435038,-0.0656762,-0.198873,-0.212256,0.444737,-0.0699881,0.483803,0.321209,-0.152228,-0.302525,-0.767148,-0.0976591,-0.278566,-0.149056,-0.0056119,-0.224205,0.281107,0.0127676,0.22641,0.266683,0.362599,0.438275,-0.393221,-0.215523,0.338646,0.120268,-0.550822,0.0578049,0.153776,0.114382,0.412398,0.338204,0.642182,-1.56783 +3406.78,0.714486,0.0912059,4,1.55491,1.00562,-0.745258,0.175719,0.413018,-0.068784,-0.00770465,-0.097598,0.0487313,0.903261,-0.416457,-0.572607,-0.482597,0.433196,-0.964429,0.724774,0.126066,-0.0455864,-0.0822196,-0.353496,-0.280397,-1.47221,-1.06858,0.250696,-0.255209,-0.239636,0.0361333,-0.0395622,-0.198625,0.479553,0.683157,-0.802526,-0.298777,0.19627,-0.0206576,0.257174,0.213526,0.719424,0.694926,-0.421352,0.930612,0.955685,-0.243364,-0.609178,0.117768,0.27792,-0.418416,0.0237491,0.61957,0.120271,0.168969,0.322652,0.278819,-1.72767,0.939813,-0.481345,0.0902511,-1.36688,0.550407,-0.435495,0.0955633,0.955839,-0.385636,-0.963997,0.620286,0.644741,-0.140535,0.0222831,0.154252,-0.0349289,0.523859,0.755466,0.275737,0.390781,0.764088,0.391061,0.357604,0.0187102,-0.233238,-0.214587,0.582182,0.387027,-0.196689,0.215686,0.321617,0.17863,0.251947,-0.234117,0.276161,-0.476975,0.515272,0.0624945,-0.22225,0.168741,-0.347258,-0.431549,0.297873,-0.105766,-0.20131,0.641669,0.338204,-0.388233,-0.771312,-0.283104,-0.0466185,0.25103,0.462769,-0.13154,-0.145019,0.449713,0.181214,0.0143724,-0.381382,0.183052,-0.228843,0.288902,0.0990819,-0.17101,0.180377,0.245574,-0.394106,0.216775,0.0137036,-0.162566,-0.100172,-0.371212,0.338423,-0.292925,0.534109,-0.872931,-0.143138,-0.459584,0.160232,0.547104,-0.0149131,0.30044,0.317047,-0.38757,0.0766128,0.1437,-0.338005,-0.20751,0.427547,-0.171738,-0.513074,-0.0237882,0.0117578,0.223804,-0.172104,-0.0801579,-0.0143176,-0.201757,-0.205776,-0.476949,0.155673,-0.113307,0.0610963,-0.254117,0.37714,0.244532,0.276031,-0.244564,0.154327,0.010868,0.796033,-0.043287,-0.38342,0.486998,-0.0339706,0.379524,0.158695,0.644046,-0.105627,-0.117116,-0.503447,0.200546,-0.103354,-0.204431,0.0108178,0.798638,0.306877,-0.385792,0.222524,-0.265315,-0.700549,-0.499027,-0.324928,0.182667,0.1447,-0.377919,-0.142209,0.299534,0.36043,-0.624663,0.220722,-0.227811,0.0528203,-0.721463,-0.0949827,-0.15937,-0.0339017,-0.262936,0.119345,0.125579,0.397916,-0.302903,-0.618561,1.02888,-0.465053,0.20303,-0.0915518,-0.248313,0.0533925,0.453442,-0.178799,-0.107488,-0.238431,0.349071,0.0830918,0.138333,-0.188781,-0.351314,-0.189382,0.169294,0.392051,0.0301339,-0.0098294,-0.116988,0.200216,0.0801209,-0.161874,-0.0167944,-0.301633,-0.998778,-0.172924,0.206506,-0.0538393,-0.231971,0.356948,-0.0424628,0.307367,-0.22007,-0.0987104,-0.364298,0.103055,0.129035,0.251004,0.637922,-0.129236,-0.0578522,0.755246,-0.160312,0.649439,-0.139023,0.0140265,0.0447803,-0.0220723,-0.114737,0.268497,-0.31087,0.121483,0.604271,-0.435353,0.650607,0.343468,0.15316,-0.0849689,0.557522,-0.332734,-0.18486,0.0646904,-0.561575,0.0164798,0.0353248,-0.0936499,-0.342414,0.357954,-0.105324,0.559549,0.360362,0.445699,-0.213154,-0.279281,0.00969696,-0.233652,-0.0614651,-0.168802,0.0818376,0.398208,-0.0722497,0.0164215,0.364758,0.249318,0.638381,-0.356861,-0.339309,0.0458957,0.103906,-0.39039,0.09312,0.0769033,0.102514,0.298079,0.320178,0.545966,-1.35199 +3397.89,0.896699,0.0912059,5,1.56628,0.976798,-1.25774,0.497366,0.818485,-0.171297,0.0199007,0.462278,0.484528,-0.255871,-0.233082,-0.00207192,0.218517,0.481625,-0.492239,1.06532,-0.119064,-0.365962,-0.217765,-0.255867,-0.0891468,-0.72013,-0.844575,-0.153918,-0.503727,-0.180666,0.371523,0.357762,-0.153704,0.20812,0.900948,-0.312955,-0.168131,0.402421,-0.432495,0.174498,-0.70203,0.83168,0.112699,-0.308635,0.856906,0.48174,0.478702,-0.59851,-0.378457,-0.00698677,-1.10176,0.569695,0.770493,0.18778,0.16966,0.0132613,0.0184812,-0.795627,0.347558,-0.201978,0.132878,-1.42068,0.287263,-0.683741,0.218175,0.757558,-0.734039,-0.700591,-0.240829,-0.449153,0.203713,0.0819924,0.299302,-0.597741,0.157226,0.271026,0.0885798,0.38357,0.243738,0.350176,0.276852,0.167841,0.112114,-0.0213313,0.351376,0.230477,0.288942,0.229624,-0.0867406,-0.166392,0.451443,-0.0729009,-0.591773,-0.307305,-0.0270906,1.00421,0.0120079,-0.114707,-0.084534,0.190668,-0.411183,0.343782,0.0236093,0.0879335,-0.439994,-0.113779,-0.154117,-0.0922286,0.0867905,0.31824,-0.0510623,-0.567319,0.151438,0.190493,-0.15802,-0.377016,0.440438,0.416436,-0.203452,-0.149215,-0.188052,0.176408,0.0830173,-0.1021,-0.419404,-0.275787,0.109613,0.066111,0.00198913,0.193953,0.165363,0.193808,0.466712,-0.155429,0.0914559,-0.338652,0.284442,0.37146,-0.275332,0.216918,-0.494919,0.633641,0.0434752,-0.678037,-0.664717,-0.0619109,0.49752,-0.240969,-0.0809058,-0.500018,-0.562943,-0.197731,-0.243385,-0.118866,0.0697358,0.153056,0.32564,-0.279217,0.332663,0.635621,0.192285,0.119465,-0.0698355,-0.167683,0.210624,-0.261834,1.18201,0.612952,0.208003,0.234884,-0.938175,-0.815698,-0.12168,-0.643969,0.490082,-0.023668,-0.176782,0.651129,-0.611881,0.320056,-0.321114,0.647874,0.576448,0.651064,0.328294,-0.499462,0.150723,0.373445,-0.108096,-0.510597,0.226425,0.0927935,-0.0417119,-0.667154,-0.157173,0.671235,0.0585939,-0.46766,0.364366,0.144787,0.248713,-0.326167,-0.365435,0.388426,-0.324172,-0.551576,0.617772,-0.206356,0.420635,-0.101859,-0.537548,0.5525,0.295928,0.75395,-0.156707,-0.252868,-0.156918,0.136012,0.244237,1.19768,0.0859211,-0.0922759,0.36786,-0.0583544,-0.22453,-0.348404,0.17784,-0.0322944,-0.375853,0.296236,-0.0988302,-0.304964,0.240868,-0.155358,0.123047,-0.0606336,0.047862,-0.00488093,0.102445,0.803454,-0.0859895,0.0467572,0.914228,-0.466154,-0.370674,-0.265517,-0.283494,-0.25805,0.334738,0.386429,0.797275,0.0240242,0.3733,-0.681261,-0.184586,-1.15196,0.0270207,-0.857099,-0.00881966,0.385375,-0.291007,0.190706,0.0961928,0.286567,-0.797913,0.490526,0.299603,0.122676,-0.0619069,-0.342318,-0.116965,0.290923,0.391131,-0.0824573,-0.368442,-0.61186,-0.750768,0.474668,0.342717,0.608893,-0.0522954,-0.245888,-0.0897658,0.298321,-0.128662,-0.905074,-0.63968,0.21928,-0.48978,0.0399534,-0.284604,0.22763,-0.385392,-0.554947,-0.0899387,0.257584,-0.193447,-0.167032,0.00687564,-0.089292,0.444861,0.365477,-0.295712,-0.318995,-0.168152,0.171479,0.446202,0.4141,0.667984,-2.64586 +3408.05,0.984605,0.0912059,4,1.49628,1.02083,-1.13142,0.410615,0.678459,-0.0976696,0.360745,0.160519,0.71452,-0.0138584,-0.257872,-0.126843,-0.374106,0.719676,-0.640536,1.09128,-0.121717,0.326198,0.505188,-0.63859,-0.387553,-1.09556,-0.883204,0.145892,-0.255525,-0.19605,-0.015144,0.124421,0.203733,0.430046,0.915989,-0.182617,-0.474639,0.18845,0.1099,-0.0472779,0.527481,0.714811,0.057867,-0.0926653,1.49376,0.632805,0.836596,-0.931649,-0.428418,0.607368,-0.880971,0.708974,0.41109,0.450028,0.13395,0.573964,0.333646,-0.283209,0.440114,-0.13585,-0.396422,-1.08126,0.330311,-0.222724,-0.00408843,1.00066,-0.923126,-0.780955,0.150279,0.234384,0.160453,0.42448,0.247799,-0.373511,-0.110179,-0.0991468,0.0640754,-0.188983,0.633398,0.72115,0.645498,-0.297863,-0.233977,-0.298495,0.260815,-0.379751,0.109167,0.348399,0.490037,-0.731958,0.0181915,-0.261756,0.0764154,-0.574869,0.221,-0.313485,0.355303,-0.106302,-0.15299,-0.581283,-0.238238,-0.113084,0.311052,-0.220083,-0.0133525,0.457874,-0.37054,-0.442321,0.0664502,0.132145,-0.105456,-0.466508,0.278638,0.388652,0.254679,-0.493467,-0.157792,0.280656,0.221817,0.134075,-0.222798,-0.261362,0.25366,-0.147745,-0.742966,0.436896,-0.00827492,0.0213112,-0.246469,0.311676,0.54935,-0.000763331,0.603933,-0.539662,0.0260822,-0.536581,0.202377,0.26715,-0.186816,-0.129766,-0.250791,0.151582,0.519461,-0.0225383,0.22088,-0.0895047,0.0477793,-0.562522,-0.43689,0.269801,-1.23985,0.475578,-0.46758,-0.316551,-0.256672,0.14056,-0.136488,-0.419585,0.521836,0.499998,0.446295,-0.142543,-0.495365,-0.179294,-0.328468,0.00396714,1.0675,0.0915492,-0.274741,-0.258179,-0.0221236,-0.665528,0.0291219,0.606084,-0.039663,0.211707,0.053677,0.321159,0.103737,0.100519,-0.532854,-0.324946,0.272598,0.497921,0.0277893,-0.0378021,0.212721,-0.0832873,-0.456697,0.0426136,-0.294171,-0.0584553,0.0902383,-0.319068,-0.457561,0.163111,-0.259429,-0.0666361,-0.449429,0.0176042,0.235477,-0.461547,-0.892802,0.241876,-0.066793,0.115531,0.523156,0.319609,0.359787,-0.104513,-0.738697,0.858699,0.31216,0.394793,-0.0752268,-0.417327,0.283023,0.426056,-0.0863619,0.439598,-0.223417,0.096106,0.0939227,-0.483645,0.268103,0.013158,0.4643,-0.021969,-0.308934,0.00613033,-0.229778,-0.683646,0.327583,-0.00693104,0.645607,0.108006,-0.0483527,0.0496088,0.454413,0.369635,-0.195683,-0.308129,0.657362,-0.206255,-0.11979,-0.326278,0.0824408,0.52936,0.635598,0.242098,0.392843,0.136373,0.106778,-0.552728,0.152527,-0.779013,0.908587,-0.816674,-0.164978,0.478064,-0.502305,-0.281989,-0.00786056,-0.0584209,-0.531698,0.272832,0.155746,-0.0689959,0.0134479,0.156827,0.0985948,-0.132159,0.319549,-0.376734,-0.620605,-0.719727,-0.627331,0.0393572,1.1067,0.182012,-0.0197792,-0.201299,0.275974,0.0175207,0.343895,-0.210122,-0.768572,-0.0156068,-0.0312568,0.0494093,-0.122654,0.262599,0.214661,-0.0805924,0.166436,-0.140233,0.104035,0.565479,-0.0783658,-0.161474,0.487568,0.456503,0.501632,-0.155635,0.412295,0.122451,0.326246,0.34993,0.57118,-2.33137 +3408.57,0.597194,0.0912059,4,1.43007,1.04739,-1.45751,0.54517,0.441463,-0.187008,0.14872,0.4963,0.926383,-0.140033,-0.239486,-0.173483,0.109753,0.605762,-0.537963,1.22905,-0.510999,-0.103573,0.542619,-0.587482,-0.103634,-0.949928,-0.573921,-0.0709993,-0.38428,-0.156352,-0.026759,0.389649,0.583496,0.340411,0.744051,0.136055,-0.472494,0.584378,-0.359301,-0.0472986,-0.360692,0.752991,-0.0112062,-0.79938,1.20915,0.729063,0.905016,-0.957791,-0.455746,0.0642175,-0.744814,0.353195,0.660317,0.126942,0.122287,0.864184,0.310446,-0.124617,0.135408,0.201875,-0.285184,-1.34381,0.44117,-0.324959,0.582307,0.995747,-0.62345,-1.32776,0.434342,0.122894,0.212852,0.307661,0.0419754,-0.359924,0.0562107,0.17993,0.127711,-0.0201971,0.644059,0.320893,0.513559,-0.30961,0.347629,-0.0842779,0.555121,-0.710868,0.442544,-0.483949,0.225824,-0.00644668,0.619408,-0.1776,0.0166462,-0.468981,-0.142686,-0.225767,-0.339063,-0.11013,-0.213914,0.263695,0.334304,-0.331916,0.51061,-0.562668,0.379067,0.204408,-0.132062,-0.403083,0.131788,0.465545,-0.0589206,-0.454504,0.432241,0.0324461,0.231099,-0.148609,0.0467786,0.417636,-0.152854,-0.0203135,-0.144392,0.0848326,0.503374,-0.131234,-0.156041,0.450892,-0.312253,-0.0838106,-0.0702666,0.286538,0.116935,0.247305,0.323801,-0.294585,0.153272,-0.421497,-0.124782,0.11462,0.145575,0.0125283,-0.130825,-0.197269,0.12634,-0.113164,0.341678,0.0880726,0.44172,-0.66081,0.198592,-0.0262049,-0.921417,0.115976,-0.508485,-0.203935,0.172458,-0.160233,-0.0610003,0.321693,0.129345,0.596765,0.254088,-0.330669,-0.234789,0.0160658,-0.0787521,0.546655,1.15897,0.076067,0.194774,0.0571305,-0.432041,-0.29508,-0.0449105,0.423881,-0.322825,0.100137,0.0709262,0.291777,0.383557,-0.0759386,-0.13962,-0.537211,0.278861,0.395068,0.112984,0.0159887,0.283442,0.129897,0.0185023,-0.406912,0.147625,-0.0508396,0.270177,-0.691258,-0.406167,0.251991,-0.124952,-0.226783,-0.124319,-0.048634,0.658222,-0.532552,-0.528573,0.0740055,-0.510347,0.0910367,0.427766,0.254842,0.561976,-0.322762,-0.994833,0.676489,-0.190996,0.707706,-0.409708,-0.0428805,0.322435,-0.0970128,0.196435,0.804959,-0.191287,0.0155189,0.280842,-0.430017,0.282398,-0.0112208,0.414308,-0.0589875,-0.222167,0.390914,-0.290784,-0.553213,0.611588,0.119647,0.567916,0.0262119,0.147661,0.208225,0.335607,0.34765,0.109464,0.206958,0.414065,-0.375552,0.497088,-0.203121,0.201741,0.208517,0.206362,-0.271558,0.494429,0.28704,0.251741,-0.297398,0.160749,-1.51509,1.01055,-0.732255,0.0100688,0.772967,-0.429306,-0.229286,0.190536,0.102351,-0.0501825,0.0435326,0.345837,-0.225815,-0.368934,0.347888,0.0435147,0.069404,0.428656,-0.514416,-0.480176,-0.255623,0.204009,0.338247,0.846153,0.0970151,-0.0355936,-0.279711,0.17761,0.0900029,0.0275187,-0.152238,-0.355027,0.097052,-0.110439,0.133504,-0.0401889,-0.268109,-0.0344923,-0.174911,-0.113105,-0.324294,0.0986933,0.410813,0.141369,-0.398176,0.281827,0.374366,0.358781,-0.0474279,0.158581,0.141637,0.404698,0.376347,0.636159,-1.59168 +3420.43,0.990828,0.0912059,4,1.44319,1.08651,-1.27456,0.457987,0.458018,-0.150436,0.00588423,0.178128,0.567699,0.270258,-0.225834,-0.528377,0.203077,0.463179,-0.247137,1.24533,-0.0562479,-0.133602,0.0430619,-0.391916,-0.136544,-1.41383,-0.726578,-0.368196,-0.238635,0.0120479,-0.060846,0.120602,0.301175,0.168045,0.692717,0.112051,-0.0366706,0.496772,-0.25851,-0.570021,-0.473399,1.25767,0.253497,-0.546316,1.44639,0.733165,0.682939,-0.98675,-0.0845133,-0.382146,-0.526935,0.541366,0.674295,0.194958,0.397318,0.661832,0.0605963,0.0381551,0.18834,-0.00574562,-0.233186,-1.05135,0.23734,-0.0231347,0.347249,1.34987,-0.671273,-1.20178,0.143752,0.378657,-0.478056,0.385734,0.283034,-0.365165,-0.202264,-0.00860803,0.41558,0.242663,0.469282,0.416936,0.939336,-0.13917,0.324646,-0.10254,0.669236,-0.810376,0.358286,-0.440067,-0.00940871,0.522994,0.477457,-0.298946,0.0468961,-0.191645,0.0171655,0.02991,-0.225006,-0.198557,0.0450661,0.0366639,-0.233717,-0.127091,0.220556,-0.301868,0.461748,0.218514,-0.531507,-0.396946,0.539908,0.394774,0.0494876,-0.349987,0.315686,0.339925,0.164468,-0.273775,0.31085,0.311184,0.114773,0.188338,0.0145735,-0.106156,-0.438697,-0.0378855,-0.413074,-0.0646445,-0.523596,0.0875526,0.186164,0.330277,0.189179,-0.118964,0.110233,-0.354352,-0.174338,-0.262125,0.128466,0.421626,0.102058,-0.0443416,-0.111523,-0.189712,0.0936186,-0.198788,-0.0399559,0.277372,0.0973587,-0.843618,-0.018974,-0.286327,-0.55466,0.0175848,-0.245895,0.109287,0.300996,-0.128011,0.0606713,0.461924,0.0948738,0.619752,0.824002,-0.516605,0.0206832,0.0908989,-0.14719,0.479188,0.712626,0.0663657,0.131576,0.587453,-0.417385,-0.229213,-0.139405,0.379811,0.1364,-0.0305738,-0.275334,0.439395,0.0564911,0.0582418,-0.156071,-0.106727,0.276971,0.411569,-0.207796,-0.0403676,0.264903,0.118573,-0.322933,0.111339,0.137998,-0.137707,0.298037,-0.681227,-0.166368,0.379718,-0.167744,-0.223386,0.514539,0.127243,0.42356,-0.484362,-0.490516,0.196881,-0.0659082,0.0644608,0.0626341,0.160349,0.405261,-0.205858,-0.596721,0.902595,-0.355782,-0.0246705,-0.238565,-0.131048,0.409089,-0.213202,0.25668,1.07655,-0.00900737,-0.183001,0.138803,-0.946944,0.414664,-0.326368,0.0280014,0.450982,-0.706761,0.151274,-0.199036,-0.895128,0.538044,0.244602,0.0683204,0.0173204,-0.361907,0.0687125,-0.196837,0.370662,-0.0165497,-0.0564828,0.790553,-0.398888,0.737474,-0.00994299,0.195612,0.102359,0.27006,-0.570744,0.551887,0.515622,-0.0653915,-0.361671,0.358607,-1.3338,0.955188,-0.274849,-0.0243176,0.808865,-0.72262,-0.191067,-0.0282037,0.358061,0.0636157,-0.186599,0.51167,-0.154541,-0.202321,0.443911,0.127147,-0.468304,0.0665665,-0.394043,-0.107739,-0.210651,-0.0689891,0.182001,0.884365,0.2987,-0.359508,0.155855,-0.288314,-0.181668,0.0771829,0.327942,-0.377372,0.149386,-0.246957,-0.0459361,-0.279511,-0.00211485,0.034682,0.380284,0.196452,-0.546466,0.245403,0.94706,-0.138511,-0.69186,0.392196,0.160366,-0.0331531,-0.527973,0.507605,0.118244,0.487447,0.343866,0.698174,-1.72529 +3405.81,0.826893,0.0912059,4,1.47157,1.08765,-1.36459,0.47207,0.542242,-0.167563,0.0467857,0.507917,0.682658,0.554043,-0.278403,-0.14283,0.0549294,0.649536,-0.434026,1.18562,-0.213561,-0.508793,-0.32703,-0.473933,-0.19123,-0.823651,-0.520011,-0.252134,-0.441177,0.154418,-0.346029,0.765077,0.096693,0.250061,0.589073,-0.0559694,0.0843323,0.412889,-0.115397,-0.139333,-0.743153,0.773302,0.108739,-0.623329,1.12109,0.630601,1.14375,-1.2121,-0.262435,0.287626,-0.108345,0.782946,0.655835,0.0208507,0.270688,0.39441,0.122808,0.249054,0.295961,-0.304741,-0.275307,-0.791449,0.510857,-0.153419,0.443145,1.01922,-0.656031,-0.299638,0.329598,0.164763,-0.681461,-0.114681,0.165414,-0.123219,-0.390502,0.199224,0.167344,0.233115,-0.0124231,0.572889,0.20524,-0.0115802,0.108548,-0.0476721,0.55736,-0.418307,0.216737,-0.0330269,-0.4898,0.075762,-0.0404653,0.133746,-0.160563,-0.48627,0.152241,-0.0511291,-0.225446,-0.000206626,0.369264,-0.525822,0.650684,-0.266975,0.713405,-0.131153,0.710437,-0.137708,-0.700862,-0.13683,0.16621,0.167705,0.0221224,-0.42204,0.217286,0.619726,0.25718,0.0234293,0.638316,0.24722,0.621597,0.0193166,-0.0174616,0.111992,-0.0763618,-0.119436,-0.610362,-0.100858,-0.103225,-0.48315,-0.0955814,0.436702,-0.39033,-0.347458,0.184572,0.0176246,-0.0344127,-0.490379,0.121766,0.356563,-0.593284,0.401283,0.102977,-0.0878058,-0.178431,-0.256531,0.246802,0.318274,0.161667,-0.878983,-0.299162,-0.0398278,-0.269887,0.206537,-0.0425514,0.485848,0.288484,-0.664038,-0.295836,0.187566,0.143896,0.943649,0.185287,-0.424198,0.207874,0.058589,-0.0495833,0.319688,0.3601,0.356678,-0.0379461,0.614925,-0.0557751,-0.144511,-0.807631,0.552288,-0.0252862,-0.348095,-0.0881423,0.306755,0.0747676,0.254009,-0.228543,-0.565396,0.464038,0.608532,-0.0387616,-0.387032,0.314437,0.599341,0.252239,0.0632291,0.243201,-0.563991,0.417607,-0.339365,-0.368005,0.193244,0.135027,-0.411344,0.417543,0.0246192,0.213235,-0.359253,-0.197193,-0.214443,-0.0215829,0.00953756,0.516322,-0.184459,0.707956,-0.761526,-0.342904,0.928828,-0.023519,0.0130937,0.0689471,-0.723962,0.20145,-0.0396098,-0.350605,0.427826,-0.0883711,0.0856698,0.494856,0.269528,0.130865,0.185529,1.11386,0.225288,0.0776283,0.0275388,0.0430218,-0.219579,0.860247,-0.0930828,0.246333,0.0149491,0.0199588,-0.0609505,-0.472888,0.562321,0.153234,-0.356727,0.283879,-0.422778,0.104042,-0.23529,-0.164146,0.239443,0.00605558,-0.00834911,0.58308,0.006853,-0.574927,-0.644301,0.164758,-0.698007,0.387896,-0.346871,-0.0912436,0.643361,-0.774238,-0.0145231,0.145725,0.276379,0.408457,0.491974,0.672508,-0.109628,-0.308067,-0.0474558,-0.119311,-0.648341,0.13169,-0.0684209,-0.318761,0.168621,-0.556495,0.225071,0.452768,-0.0889066,0.198867,-0.160925,-0.0665696,0.0679859,-0.00759649,-0.221021,-0.077467,0.27563,0.0155423,-0.317241,0.122443,0.379199,0.40942,0.135396,-0.200751,0.0424369,0.501702,0.520597,-0.420959,-0.233714,0.361896,0.633233,-0.161595,-0.22183,0.344497,0.152214,0.261778,0.390146,0.511643,-1.94029 +3414.61,0.87972,0.0912059,4,1.57813,0.980663,-1.22113,0.426779,0.351652,-0.0410112,-0.207923,0.0751916,0.517226,0.183876,-0.527509,-0.146423,0.0255376,0.496455,-0.250843,0.993065,-0.0867359,0.159696,0.0429105,-0.300257,-0.271258,-1.14396,-0.818318,-0.0855056,-0.0261954,-0.10732,-0.110565,0.0204059,-0.220435,-0.286611,0.724963,-0.435935,-0.0910813,0.00414134,-0.260857,-0.144076,0.0682777,0.93033,0.393374,0.00550006,1.20466,0.818625,0.187034,-0.541438,-0.154308,-0.339702,-0.56022,-0.118234,-0.0924924,-0.021757,-0.0758212,0.524812,0.233843,-0.601302,0.292093,-0.307929,-0.297431,-0.385154,0.368257,0.292874,-0.0901884,0.942453,-0.710208,-0.622516,0.115172,0.523715,-0.101068,-0.908865,0.135372,-0.216813,-0.598455,0.0573281,0.5938,-0.0908968,0.428472,0.533901,0.22786,0.116991,0.0851014,-0.385939,0.344229,-0.435599,0.42697,0.561645,-0.737202,0.610059,-0.124398,-0.626377,0.386997,-0.399745,-0.733619,0.227763,0.156139,-0.348702,0.0107705,0.338847,0.259925,-0.927517,0.125618,0.305551,0.165721,-0.346976,0.510374,-0.0545916,-0.147982,-0.51123,-0.0877101,0.197075,0.216197,0.583432,0.618187,-0.238886,0.62624,0.362583,0.231706,0.606666,-0.819872,-0.153583,0.158988,0.50514,-0.247948,0.11777,0.33611,-0.312189,-0.221706,-0.470117,0.236183,-0.258049,0.504272,-0.217683,0.131189,-0.0887691,0.197295,0.479388,0.23873,-0.0735927,-0.0369735,0.195281,0.308664,0.0388537,-0.292378,-0.127339,-0.208724,-0.358243,0.376725,0.406717,-0.152138,0.439958,-0.361118,-0.0206196,-0.258739,0.0219612,0.1849,-0.25534,0.12967,0.396534,0.763769,0.868418,-0.0682169,0.00392511,-0.232037,-0.342002,1.19434,0.262418,-0.455345,0.25513,0.507826,0.199121,-0.26812,0.0441216,0.446472,-0.0886056,-0.130309,0.180018,-0.258051,0.14831,-0.542666,-0.125817,0.390159,1.09659,-0.0783892,-0.702175,0.207989,0.193512,0.0161397,0.0016578,-0.496385,-0.0838284,-0.0147473,-0.698191,-0.217202,0.0495922,-0.278475,-0.408515,-0.546018,0.108427,-0.142101,-0.288569,-0.672586,-0.0364738,0.163883,0.0832763,0.00721496,0.291667,-0.200304,0.201012,-0.341199,0.649517,-0.370313,-0.48622,0.0841518,-0.584943,-0.243066,-0.633148,-0.390769,0.513364,-0.2042,-0.174711,0.100847,-0.979763,0.173483,-0.276789,0.00892336,-0.040955,-0.719077,0.603925,0.254114,-0.410051,0.555098,0.0918181,-0.182255,-0.0491544,-0.366289,-0.172827,-0.328486,0.11543,-0.214274,0.870988,0.653932,-0.336382,-0.0167665,0.198453,-0.142183,-0.272593,-0.202301,0.152305,0.861521,0.132957,-0.0138867,-0.535479,0.0700888,-0.824356,0.700776,0.159101,-0.138859,0.614732,-0.216875,-0.036982,0.324838,-0.124607,0.271574,0.227558,0.244805,-0.0576969,0.355518,0.142635,-0.017733,-0.0968885,0.416384,-0.0803813,-0.45359,-0.149907,-0.10306,-0.522129,0.215992,-0.1556,-0.261564,0.222564,-0.367162,-0.233407,-0.305134,-0.127144,-0.320381,-0.191011,0.280227,0.196995,0.311287,0.670777,0.0173803,-0.134736,0.0814534,0.635833,0.168027,0.00374591,-0.300382,-0.187971,0.358618,-0.193208,-0.596665,-0.204309,0.0700087,0.120849,0.21942,0.347634,0.468423,-1.07593 +3390.85,0.682128,0.0912059,5,1.6317,0.923252,-1.24903,0.371669,0.863579,-0.156888,-0.0443841,0.144464,0.255424,0.229348,-0.492175,0.0202897,-0.0475362,0.240721,-0.54377,0.74139,-0.118765,-0.201606,-0.479692,-0.334285,-0.115828,-0.912275,-0.447899,-0.234064,-0.494085,-0.188509,-0.472389,0.335438,-0.310197,0.0717474,0.248989,-0.000785286,0.168089,0.207425,-0.167526,-0.156438,-0.219288,0.681376,0.45446,-0.19024,0.890929,0.0636653,0.782582,-0.4234,-0.0595529,0.347897,-0.202349,0.341213,0.333026,-0.126676,0.315661,0.0532225,-0.0766887,-0.202163,0.75918,-0.216454,-0.125681,-1.15937,0.609235,-0.701066,-0.183173,0.930641,-0.504335,-0.760141,0.958055,-0.0992071,-0.00965605,-0.807762,-0.157714,-0.037383,-0.444127,-0.0974902,0.401495,-0.0786545,0.0829023,0.270718,-0.181139,0.106688,-0.292408,0.356978,0.697055,-0.640473,0.174813,-0.182028,0.0362162,-0.509935,0.139888,-0.527143,0.0574761,-0.244316,-0.191024,-0.724404,-0.0668863,0.297703,0.102947,0.0553392,-0.148746,0.13725,-0.231526,0.117228,0.130859,0.425499,-0.918111,-0.628451,0.204809,-0.116937,0.887328,-0.065182,1.02156,0.276112,-0.0623515,-0.0357172,-0.108004,0.222101,0.693422,-0.172112,-0.237218,0.0734201,0.199141,0.127991,-1.21055,0.470998,-0.243005,-0.673151,-0.201576,0.468431,-0.10147,-0.637757,0.473897,-0.518396,-0.0512541,-0.157282,-0.152821,-0.0151378,-0.593748,-0.405474,0.579132,-0.0197423,-0.116367,0.0401109,-0.443246,0.134432,-0.320469,-0.679878,0.44701,0.125974,0.0320677,0.371198,0.0319563,-0.29441,-0.435272,0.400741,-0.229671,0.655457,-0.385541,-0.0735599,-0.0160043,-0.433637,0.193693,0.208244,-0.196956,0.140709,0.125789,0.231398,0.683201,0.179677,-0.154326,-0.595219,-0.360144,0.573468,0.22177,-1.22681,-0.109172,0.123888,0.050304,0.556609,-0.268507,-0.448677,0.107927,0.48538,0.026004,-0.398029,-0.356624,-0.120087,-0.361344,-0.60083,-0.221652,-0.192356,-0.371749,-0.261873,0.00254189,0.195129,-0.0178601,-0.502901,0.163933,-0.134416,0.425044,-0.511695,-0.548365,-0.0660314,0.0936046,-0.579554,0.0889705,-0.202354,-0.358124,-0.551003,-0.707892,1.16763,0.17535,0.393497,-0.169689,-0.0797098,0.147212,0.343316,-0.451846,0.351948,-0.58725,-0.311259,0.257743,-0.229754,-0.466104,-0.176413,-0.249318,0.518663,-0.291936,0.493021,-0.458787,-0.111879,0.200845,0.0459348,0.045039,-0.000488449,-0.745418,0.226763,-0.211948,0.515534,-0.00915579,0.282853,0.232229,-0.782455,0.0157177,-0.556391,0.395252,-0.0435424,0.521852,0.329118,0.373199,0.0506765,-0.142234,-0.544326,-0.118027,-0.807048,0.239578,-0.306062,-1.2913,-0.3846,-0.662493,-0.121569,-0.207305,0.459842,-0.679774,0.446253,0.554187,0.192933,-0.276743,-0.455353,0.103265,-0.416228,-0.320766,-0.0590711,0.258941,-0.260225,-0.164243,-0.23476,0.38196,-0.369007,0.430648,-0.0778452,0.218418,-0.106383,0.479584,-0.252103,-0.475342,-0.229045,0.106621,0.0790571,-0.524918,-0.247438,-0.0565578,0.0963843,-0.228938,0.0772105,-0.479639,-0.108095,-0.437635,-0.771975,0.0394038,0.234887,-0.0965978,-0.45226,-0.0351092,0.136254,0.203516,0.369125,0.451128,-2.52445 +3416.36,0.995494,0.0912059,4,1.6016,0.865199,-1.15847,0.372672,0.853229,-0.0319136,0.0481617,-0.268504,0.131167,-0.0960287,-0.0382531,-0.452433,-0.312133,0.288095,-0.340509,0.694718,0.219936,0.0793651,0.184809,-0.300138,-0.200685,-1.21519,-1.01456,0.027245,-0.359317,-0.355852,0.140651,0.105255,-0.111652,0.156135,0.355518,-0.577504,0.266807,0.0382537,-0.0958003,-0.497843,0.217183,0.894944,0.28279,-0.096204,0.831301,0.754853,0.213287,-0.245061,-0.132983,-0.324222,-0.705238,-0.154854,0.459804,0.223595,0.107985,0.418338,-0.125407,0.508799,0.83664,-0.340206,-0.374809,-0.261997,0.449842,0.0499781,0.558553,0.94309,-0.742796,-0.935999,0.0650631,0.159842,-0.204614,0.105979,0.165067,-0.0854233,0.039589,-0.172521,0.449356,0.239937,0.461043,-0.103104,0.369512,0.674065,-0.222632,-0.197636,0.543086,0.596345,0.347934,-0.0640299,-0.0177643,0.192498,0.624545,-0.508537,0.0579975,0.304213,0.259688,0.159386,-0.130257,-0.124634,0.457581,-1.0132,0.0676597,0.449529,-0.154966,0.663047,0.394922,-0.140127,-0.111084,0.426317,0.147255,0.00782309,0.0721762,-0.496502,0.365838,0.666026,-0.709767,0.575285,0.154417,0.336729,-0.239956,0.074197,-0.11835,0.252706,-0.296382,-0.471565,-0.297586,0.325998,-0.263137,-0.0148619,-0.148421,-0.0102073,-0.334902,0.49213,0.273198,-0.604999,0.469113,-0.291708,0.306299,0.759882,-0.206615,0.314276,-0.386141,0.384165,0.246057,-0.146482,-0.740044,0.027637,0.468564,-0.65913,-0.434688,-0.219981,-0.305166,0.0605196,0.130846,-0.382813,-0.100304,0.285064,0.326543,-0.126422,0.567465,0.469939,0.205798,0.155523,0.129295,0.18207,-0.0550583,-0.37359,0.949229,0.00968283,-0.0200763,0.0756447,-0.222633,-0.243337,-0.0521711,0.142031,0.502094,-0.0453472,-0.239788,0.359269,0.300022,0.0878098,-0.576945,0.134717,-0.120292,0.787311,-0.00599105,-0.507297,0.0276567,-0.00103152,0.151681,-0.2151,0.0649288,-0.190566,0.0603318,-0.268888,-0.125035,-0.246705,0.105137,-0.693962,0.147604,-0.0788683,-0.0620097,-0.320733,-0.704079,0.351154,0.182057,-0.3867,0.487692,-0.0770717,-0.188003,-0.162743,-0.393196,0.967152,-0.588382,-0.138098,0.0966896,-0.29336,0.0461594,0.254941,-0.319271,0.429234,0.256329,0.348837,0.438904,0.101614,0.107848,-0.201677,-0.0801165,-0.0990362,0.0302551,0.0544196,-0.461226,-1.07851,0.845557,0.135145,-0.00573811,-0.0810909,0.0445388,0.025471,-0.552363,0.420818,0.222128,0.0883213,0.896419,-0.406939,-0.297321,-0.0186528,-0.45227,-0.26877,0.125175,-0.539485,0.552134,0.187768,-0.317827,-0.0425072,-0.0736533,-0.304779,0.101212,-0.664429,-0.0470188,0.137468,-0.139358,0.428248,0.230061,0.0848536,0.598917,0.333672,0.373174,0.22535,-0.155996,0.17658,0.312748,-1.15745,-0.952478,-0.362778,-0.372891,-0.486697,-0.336424,-0.187286,0.237579,0.247625,-0.00796982,-0.399707,-0.217436,-0.256555,0.0897963,-0.011986,-0.177988,0.246499,0.0643553,0.164532,-0.28088,0.371922,0.715497,-1.29027,0.0703599,-0.0845341,0.802313,0.0139167,0.0439044,-0.565924,0.0489107,-0.0704699,0.018624,0.491336,0.233253,0.144263,0.1956,0.379819,0.442267,-2.49734 +3410.87,0.956849,0.0912059,4,1.53659,0.877074,-1.67755,0.527315,0.594694,-0.0890606,0.0724956,-0.0189473,0.746381,0.24817,-0.137722,-0.210754,-0.22063,0.157711,-0.422019,0.765966,0.0296821,-0.439417,-0.202159,-0.290925,-0.127633,-0.486691,-0.932869,-0.216218,-0.517905,-0.144848,-0.310388,-0.221027,-0.335271,-0.328984,0.587416,-0.0480737,0.552738,0.283735,-0.188516,0.161485,-0.075408,1.32207,0.542154,-0.397496,1.12236,0.535854,1.05709,-0.531755,-0.152174,-0.0984417,0.0774772,0.0122686,0.583812,0.355923,0.465063,0.286354,-0.277756,-0.171118,0.822873,0.0614825,-0.184603,-0.523045,0.25419,-0.24761,0.438256,0.748547,-0.612241,-1.03987,0.398254,0.00418063,-0.337868,-0.026632,-0.669035,-0.515529,-0.404355,0.479058,0.683079,0.315343,0.689821,0.611032,0.404921,-0.841788,0.0251846,0.0312471,0.591351,0.0846391,0.34634,-0.384111,0.12735,0.257956,-0.000321738,-0.349875,0.530355,-0.973053,0.317086,-0.292252,0.259006,0.0946325,0.340122,-0.350267,-0.171063,-0.161859,-0.00621448,0.063807,-0.051937,0.102682,-0.648077,-0.134624,0.549283,-1.07519,0.200276,-0.217776,0.25042,0.268453,0.0131386,0.215282,-0.178917,0.0689278,0.142658,0.121103,-0.58349,0.0656068,0.243333,-0.257376,-0.51452,0.435055,0.0321715,-0.308475,-0.129596,0.733474,0.338042,-0.0286702,-0.0546659,0.128425,0.0297433,-0.0497515,-0.552902,-0.0378401,-0.267718,-0.345674,-0.21187,-0.144627,0.161624,-0.731747,-0.310427,0.234128,0.279477,-0.44314,0.506545,0.589264,-0.899619,0.125193,-0.0847313,-0.124115,-0.622406,-0.111342,0.143631,0.331411,0.429874,-0.128652,0.0025685,-0.512534,0.0583436,-0.328065,0.192011,0.633321,0.847285,0.563416,0.272095,0.136678,0.187279,-0.221857,-0.402319,-0.432016,0.406683,-0.095906,-0.153183,0.321586,0.20737,-0.0170871,-0.124682,-0.424103,0.279265,1.19863,0.402974,-0.014509,0.161526,0.304387,0.230158,-0.706513,-0.102828,-0.0461221,0.506114,-0.632421,0.00189462,-0.383301,-0.174217,-1.20467,0.164918,0.115098,0.171579,-0.766263,-0.935765,0.00314946,-0.00254984,-0.608223,-0.0335186,0.323484,0.50168,-0.0518037,-0.46013,1.11679,-0.192954,0.0241766,-0.0191452,0.144973,0.0521901,-0.585067,-0.35731,0.637082,-0.496669,0.310307,0.606139,-0.80698,-0.348528,-0.456908,-0.205749,0.206691,-0.426148,0.370122,-0.459047,-0.0523592,-0.170768,0.263969,0.0321657,-0.132633,-0.311848,0.229199,-0.672963,0.630788,-0.592858,-0.0167484,0.545104,-0.221309,0.540995,0.342579,0.12513,0.174287,0.239182,0.427297,0.207858,-0.156658,-0.197919,-0.335584,-0.0209317,-1.25189,0.206012,-0.300837,-0.329688,0.426467,-0.873216,-0.531373,-0.429496,0.33938,-0.106445,0.483845,0.0275039,0.297878,0.213543,0.316559,-0.0272332,0.0140086,-0.995474,0.273159,-0.0987792,-0.0222615,-0.16449,-0.705313,0.486278,-0.136452,0.0842903,-0.00463145,0.292188,-0.706453,-0.304881,-0.209263,-0.455906,0.359258,-0.0124706,-0.313039,-0.202088,0.897109,0.334433,-0.103864,-0.329438,0.332879,0.22179,-0.123097,0.0859485,-0.515699,0.120307,0.115297,-0.427131,-0.0135318,-0.115481,0.164329,0.298156,0.405375,0.546037,-1.5847 +3414.56,0.741603,0.0912059,4,1.61134,0.938541,-1.49445,0.45868,0.55208,-0.0660439,-0.190127,-0.0802681,0.52366,-0.0623544,0.0276648,-0.307435,-0.111734,0.172214,-0.31736,0.7138,0.178715,-0.49214,0.278056,-0.330188,-0.194467,-0.672743,-1.18229,-0.209823,-0.506872,-0.0226098,-0.267353,-0.0535363,-0.604755,-0.113225,0.688779,0.0898717,0.741868,0.0935991,-0.239177,-0.073255,-0.169475,1.35678,0.199247,-0.785717,1.29372,1.00593,1.0817,-0.457778,-0.0887174,-0.0583544,0.0495184,-0.117381,0.417361,0.583658,0.321481,0.274654,-0.246971,0.0224261,0.494074,-0.124733,-0.240656,-0.431716,0.390106,-0.0722023,0.607094,0.705304,-0.908083,-1.41091,0.381621,0.0466308,-0.00262476,-0.113167,-0.581517,-0.707076,-0.505722,0.462952,0.673863,0.207888,0.514979,0.253743,0.51796,-0.84067,-0.245942,0.121093,0.236922,0.0898092,0.258234,-0.392493,-0.122099,0.0741685,-0.187563,-0.235781,0.176765,-0.884071,0.0995995,-0.0156378,0.00643732,0.0666338,0.233618,-0.260443,-0.635265,-0.174478,0.096802,-0.111232,-0.209801,-0.0818914,-0.328912,-0.214059,0.484908,-0.798415,0.203896,-0.420401,0.120158,0.396499,0.368618,0.182231,-0.536275,0.208887,0.586369,0.222312,-0.389906,0.101582,0.126327,0.0247976,-0.789372,0.246022,0.16488,-0.135138,0.118298,0.537343,0.302426,-0.089073,-0.0386257,-0.07764,-0.0332844,-0.411777,-0.135227,0.290914,-0.396062,-0.0959742,0.268387,-0.209765,0.419043,-1.11523,-0.444603,0.3762,0.238527,-0.513426,-0.164962,0.488315,-0.691169,0.118491,0.0925075,-0.543751,-0.601943,-0.0846939,0.30183,0.00195978,0.604931,0.0609989,-0.119733,-0.618227,-0.169921,-0.551485,0.101566,0.370147,0.868486,0.602623,0.304462,0.163264,-0.0517467,-0.608517,-0.576867,-0.335807,0.158557,-0.41434,-0.112192,-0.100081,-0.0145605,0.252665,-0.191642,-0.0936524,0.122908,1.16927,0.317177,-0.0855613,-0.0163851,0.132677,0.0218473,-0.502197,0.167628,-0.33867,0.346777,-0.57153,0.177629,-0.47799,-0.343664,-1.13141,0.389511,0.141314,0.163249,-0.741058,-0.888313,-0.121461,-0.0166378,-0.610512,0.273013,0.387116,0.582755,0.181312,-0.392619,0.855736,-0.106078,-0.26243,0.26343,0.0810958,0.10312,-0.209757,-0.31863,0.549555,-0.375107,0.179301,0.467827,-1.10818,-0.529602,-0.374716,-0.134418,0.234344,-0.111354,0.310815,-0.470433,0.182059,-0.346837,0.415924,-0.382806,-0.109997,-0.149184,0.16316,-0.568722,0.585967,-0.60352,0.384078,0.905705,-0.457973,0.477492,0.0598331,0.377188,0.0694388,0.197951,0.224242,0.290317,-0.0307379,-0.439227,-0.400648,-0.109608,-1.50024,0.221863,0.145418,-0.315432,0.737131,-0.669332,-0.496185,-0.28954,0.0171352,-0.0685235,0.455135,-0.0663803,0.549723,0.147001,0.461838,-0.33504,-0.0678914,-0.958302,-0.01106,-0.109262,-0.293793,-0.358926,-0.679987,0.473612,0.0263562,0.0617059,0.246676,0.266749,-0.41759,-0.252746,-0.207952,-0.571491,0.0891892,0.159085,-0.196193,-0.180333,0.807387,0.214358,-0.432353,-0.0854286,0.421375,-0.0560681,-0.128676,0.27771,-0.527515,0.154321,0.199681,-0.295027,-0.0184665,0.0711196,0.179167,0.283374,0.423281,0.532329,-1.51402 +3406.08,0.502724,0.0912059,4,1.47965,1.06027,-1.10665,0.362819,0.988188,-0.19256,0.0540441,-0.0800994,0.50633,0.441721,-0.0760505,-0.0550703,-0.226741,-0.0922463,-0.206406,1.13093,-0.0586856,0.017712,0.278136,-0.364619,-0.223524,-0.549892,-1.08431,-0.150151,-0.00882363,-0.203846,-0.309413,0.654801,-0.0602726,0.0361774,0.641529,-1.12186,0.340589,0.337747,-0.0323039,-0.331033,-0.383214,0.7579,0.910309,0.699058,1.24424,0.832659,0.643668,-0.199681,-0.152888,0.532989,-0.383273,0.375739,0.350192,0.505911,0.0271993,0.974941,0.384789,-0.362028,0.572113,-0.506852,-0.106018,-0.795746,0.498242,-0.559167,0.141601,0.801556,-0.482466,-1.18739,0.145157,-0.0679059,-0.0558536,-0.484014,0.210393,-0.0704174,-0.375832,0.018811,0.571612,-0.382121,0.469697,0.474042,0.386791,0.300335,-0.185074,-0.187714,0.297318,-0.181055,0.322723,0.235143,0.0476658,0.323196,-0.223275,-0.0182095,0.0845485,-0.227251,-0.283703,-0.0781661,-0.190732,0.00461695,-0.0730641,-0.390218,0.706888,-0.425817,-0.142305,0.13034,-0.534008,-0.20021,-0.475442,0.0186626,-0.134914,-0.03866,0.334414,-0.207682,-0.208417,0.515434,0.225372,-0.518229,0.501008,0.3345,-0.139961,-0.0918152,0.258506,0.0808209,0.594486,-0.368722,-0.601996,0.146568,0.952527,-0.341834,0.192736,0.370886,0.364562,0.000545742,0.434559,-0.0127302,-0.350265,0.306954,0.604329,0.533276,-0.520877,0.23873,-0.973984,-0.0589222,0.0845525,-0.316503,0.396962,-0.417024,-0.00947977,-0.963591,-0.339077,-0.360651,0.0774908,0.39918,-0.234307,-0.087935,-0.274765,0.170613,0.205071,0.241969,0.317228,-0.14287,0.415622,-0.130937,0.0377065,0.273505,0.0609862,-0.498749,0.95098,0.301776,-0.0663757,0.258602,-0.0874997,-0.410465,-0.276921,-0.155858,-0.153867,0.474671,-0.2077,0.119637,-0.0999748,0.0219113,-0.37086,-0.129967,0.303705,0.785379,0.141258,0.0201558,0.462441,0.0982506,0.0615579,0.0540243,-0.347829,-0.291979,-0.257918,0.00725052,0.0773902,0.312985,0.268236,-0.959846,0.242092,-0.0224043,0.168677,0.0439493,-0.890133,0.0980242,0.0978007,-0.249749,-0.619529,0.000737053,-0.527219,0.0544814,-0.595558,0.906634,0.369242,0.165974,-0.185168,-0.136328,0.491143,0.26316,-0.319803,0.589297,-0.309459,-0.0926997,-0.309911,-0.47366,-0.0400938,-0.522467,-0.403629,-0.434776,0.125745,0.364393,-0.983617,-0.489594,-0.0190811,0.425722,-0.59141,-0.0121883,-0.506,0.195759,-0.52842,0.574628,0.283051,-0.156301,0.892892,-0.383423,0.423251,0.618416,0.349212,-0.044664,0.624372,0.378989,0.317488,0.132604,0.606831,0.0964257,-0.58712,-0.540693,0.159256,-0.328144,-0.813093,0.091847,-0.0777001,-0.0834751,-0.297,0.166675,-0.220844,-0.164648,1.09499,0.563408,0.163162,0.251769,0.0931359,-0.144509,0.556418,0.409485,-0.286758,0.00757566,0.249758,0.141735,-0.0611523,-0.318143,-0.136075,-0.213462,0.554547,0.13405,0.615139,-0.673165,-0.44574,0.527273,0.0249356,0.200357,-0.368198,0.235505,0.31175,0.614156,-0.278491,0.537394,0.584872,0.0735381,-0.385785,-0.673526,-0.341113,0.837648,0.542035,0.101147,-0.140116,0.143896,0.328454,0.379337,0.573109,-3.38992 +3404.33,0.74409,0.0912059,4,1.46827,0.92056,-1.18464,0.406158,1.20442,-0.16514,-0.2712,0.331807,0.506147,-0.1859,0.36307,-0.387368,-0.143659,0.03422,-0.788328,0.730578,-0.096649,0.170622,-0.108722,-0.200333,-0.506851,-1.24089,-0.798773,-0.281196,-0.243409,0.296489,0.348547,0.749145,-0.352305,0.0222818,0.798667,0.226915,0.364531,0.497175,0.395078,-0.320994,0.199817,0.690247,0.515175,-0.0291943,1.12587,0.974234,0.802039,-0.333881,-0.209192,0.175204,-0.300395,-0.579537,0.373664,0.24004,-0.0257864,0.743851,0.0950415,-0.218941,0.79024,0.297183,-0.391298,-1.30671,0.401404,-0.638872,0.672368,1.00027,-0.492018,-1.20703,-0.120788,0.457045,-0.0919779,0.0575624,-0.285188,-0.571946,-0.222397,0.57359,0.78953,0.397776,0.358954,0.233793,0.34267,0.052606,0.0573439,0.34339,0.702077,-0.206029,0.261238,-0.83208,-0.1445,-0.477672,0.231126,-0.449572,0.227695,-0.585538,-0.333576,-0.321065,0.062827,-0.365946,0.359807,-0.529226,-0.497703,0.5078,-0.163637,0.0248909,-0.313678,-0.63747,-0.30484,-0.0134766,0.297104,-0.372022,0.576632,-0.377859,0.533093,0.436145,0.124208,0.106615,0.627893,0.351257,-0.171531,0.744264,0.158576,0.319356,0.167661,0.101281,-0.313738,0.215117,-1.06273,0.265446,0.130323,0.0445651,0.101036,0.203395,-0.187923,-0.504297,0.528737,0.00469087,0.0799934,0.330533,0.0456349,-0.511553,0.234685,-0.250422,0.55702,-0.352696,-0.257551,0.48295,-0.130265,-0.0563839,0.54099,0.177587,-0.110563,0.598371,-0.0830979,-0.465338,0.103244,0.146228,-0.00505827,-0.0375233,0.223358,0.76229,0.309738,-0.332887,-0.202402,-0.672357,-0.0201978,-0.162661,0.874328,-0.601997,0.290551,-0.161715,-0.13495,0.222565,-0.152909,-0.265482,0.183705,-0.473844,-0.288693,-0.252745,0.138561,0.0522798,-0.154902,0.289852,0.0167884,1.09663,0.104198,-0.64803,-0.351647,-0.4449,-0.0366863,-0.678164,-0.230325,-0.535353,0.732233,-0.193224,0.122699,-0.262048,-0.51378,-0.294688,-0.161107,0.687854,-0.312658,-0.653919,-0.605899,0.66609,0.0677498,-0.0206873,0.487489,0.197109,0.358846,-0.463263,0.236908,0.868842,-0.406605,0.34546,0.0638335,-0.629049,-0.0113854,0.72252,-0.145071,0.332915,-0.609956,-0.0790423,0.0138195,-0.414522,-0.3117,0.323161,0.0214489,0.443853,-0.974233,0.204883,-0.0986427,0.0729595,0.0374944,-0.156509,0.125732,-9.67308e-05,0.111366,-0.0267491,0.13644,0.530164,-0.241233,-0.256375,0.632711,0.17169,-0.501286,0.0319931,0.256477,-0.117505,0.439597,0.0209143,0.573059,0.37405,-0.637948,-0.36108,0.0282818,-0.636349,0.533275,-0.566312,0.117946,0.530522,-0.675216,0.649215,0.920256,0.238145,0.2181,1.18464,-0.908516,-0.0574894,-0.285408,0.229882,-0.0178727,0.185776,-0.47353,-0.303363,-0.116323,-0.264277,-0.244661,0.346679,0.21712,-0.111753,-0.0243265,0.0184569,0.249962,-0.0815567,-0.00795276,0.602579,0.11899,0.0117473,0.0552081,0.329085,-0.306167,0.13921,0.0444324,-0.697646,0.160033,-0.478075,0.0996029,0.380667,0.376607,-0.208814,0.194309,-0.114073,-0.244926,0.0696884,0.44591,0.146814,0.35129,0.383163,0.592697,-3.87911 +3432.15,0.852211,0.0912059,4,1.6034,0.902199,-1.23578,0.399175,0.936325,-0.125396,-0.145453,-0.22057,0.712192,0.00357649,0.168359,0.000982363,-0.852158,-0.214232,-0.123909,1.16355,-0.0399323,-0.0914443,-0.342697,-0.23996,-0.439308,-0.749629,-1.05587,-0.128064,-0.302934,-0.843047,-0.0718167,0.0620064,-0.178562,-0.311868,0.819272,-0.812051,-0.0453276,0.206619,-0.0752824,-0.108352,-0.410272,0.484238,0.598482,-0.110205,1.4461,0.394938,0.437856,-0.474097,0.254339,0.256583,-0.726611,-0.0247797,0.171886,0.158778,0.10586,-0.0455611,0.367549,-0.0541467,0.739552,-0.468795,-0.486223,-0.609759,0.540755,-0.609095,-0.217243,0.895635,-0.167686,-0.957102,0.131305,0.44722,-0.437615,-0.0847684,0.498582,-0.454643,-0.26277,0.415508,0.668421,0.0498774,0.321853,0.385886,0.115124,0.0946269,-0.534178,-0.134105,0.362049,0.210241,0.364956,0.495016,0.189259,0.395146,0.153081,0.485659,0.279029,-0.442865,-0.0825594,0.325831,-0.0143663,0.0198336,-0.194079,0.1363,-0.0730445,-0.0780628,0.582142,-0.281558,0.459144,-0.228542,-0.399816,-0.43427,0.263434,-0.571384,0.364144,0.108355,0.256722,0.612966,0.209517,-0.124168,0.202211,0.329879,0.199292,0.206358,0.0273815,0.0934843,0.631754,-0.0305611,-0.410841,0.120801,0.245727,0.101339,-0.389632,0.555904,0.178536,0.31488,0.196215,-0.248468,0.345122,0.159107,0.0523519,-0.0572956,-0.28386,0.0439019,0.089582,-0.0772909,0.18827,-0.228861,0.146235,-0.156527,0.0372515,-0.42725,-0.713939,0.291178,-0.497298,0.317023,-0.320152,-0.701357,-0.371854,0.162644,-0.146903,0.000131669,0.703755,0.246207,-0.0538528,0.40015,-0.440734,0.58523,0.164335,0.0163376,0.362808,0.457546,0.0242379,0.496379,0.0833173,-0.115952,-0.350424,-0.1994,0.252544,-0.33178,0.109728,0.150564,0.239418,0.385962,-0.0881554,-0.363476,0.403881,0.513476,0.22212,0.243136,-0.023356,0.0890635,0.0330243,-0.641439,-0.139452,-0.375005,-0.462311,-1.09661,0.307183,-0.115777,0.16464,-0.475905,0.420348,0.212987,0.0736761,0.0258751,-0.260056,-0.50209,0.21243,-0.955247,0.314661,-0.258336,-0.0693666,-0.0415643,-0.391031,0.650183,-0.0334651,0.130386,-0.00926408,0.275082,0.381491,-0.176569,-0.231612,0.196934,0.0666575,-0.434749,0.00252545,-0.20555,0.458691,-0.252464,-0.102315,0.654647,0.189952,0.247897,-0.364129,-0.507411,-0.302994,-0.282114,-0.527624,0.00602178,-0.217505,0.393967,-0.145341,0.500587,0.435482,-0.257079,0.600087,-1.04841,0.574576,-0.283589,-0.247932,-0.12106,-0.0612257,0.174669,0.170269,-0.261165,0.685093,-0.0618142,-0.0239183,-0.269227,0.366663,0.288506,-0.124794,-0.366021,0.148878,-0.0146005,-0.392217,0.207231,0.335903,0.188404,0.320151,0.199317,0.255558,0.317683,-0.0835664,-0.153543,0.0328579,0.125381,-0.430087,-0.0295456,-0.661346,-0.132693,0.720717,0.26273,-0.139052,-0.292446,0.347836,0.218808,-0.156712,-0.504779,-0.245809,0.213661,0.0984462,-0.16826,-0.312536,-0.0187606,0.0293725,0.305424,-0.114215,0.0294249,0.789279,-0.0321175,-0.028259,-0.325329,0.362728,-0.136078,-0.449327,-0.492661,0.0852876,0.117221,0.217477,0.342376,0.466344,-2.79795 +3436.13,0.934352,0.0912059,5,1.5489,0.908742,-1.34965,0.439311,0.941027,-0.178401,0.0319762,-0.199173,0.558899,0.071046,0.0338567,0.160083,-1.03685,-0.269256,-0.0150942,1.06462,-0.0110296,-0.0957501,0.242875,-0.145659,-0.371967,-1.09986,-0.948536,-0.0395729,-0.574362,-0.58826,-0.227713,0.282079,-0.473256,-0.311392,0.754708,-0.823593,-0.0878743,0.189663,0.0576063,-0.316956,-0.0438312,0.516638,0.691897,-0.425602,1.5066,0.49474,0.229793,-0.732936,0.415103,0.34055,-0.50832,0.0247203,0.285176,0.407667,0.211483,0.367594,0.408091,-0.254561,0.698161,-0.420882,-0.465867,-0.621694,0.30603,-0.63004,0.0821216,0.896105,-0.341548,-0.795702,0.319257,0.313039,-0.073071,-0.169569,0.578255,-0.54383,-0.302549,0.402375,0.837915,0.163376,0.133288,0.209101,0.219432,-0.0518673,-0.694427,0.0976388,0.0238216,0.0486136,0.366488,-0.0295266,0.310681,0.524835,-0.0267902,0.186901,0.742191,-0.365551,-0.212512,0.267864,0.246271,-0.114441,-0.410371,-0.0675963,0.0530028,0.15551,0.298056,0.068918,0.0792053,0.236902,-0.26147,-0.366187,-0.193142,-0.577113,0.356087,-0.00620046,0.301928,0.569253,0.321008,0.201019,-0.0193503,0.245749,0.250739,-0.136453,-0.0672395,-0.127514,0.523279,-0.122319,-0.385849,0.0888972,0.11552,-0.185703,-0.400534,0.595668,-0.212058,0.274739,0.357228,-0.592209,0.458985,0.233113,-0.178306,-0.0479519,-0.117032,-0.28239,0.346517,-0.0632074,0.370264,-0.394493,-0.0161683,-0.168047,0.0732447,-0.410397,-0.5608,0.109688,-0.539427,0.391521,-0.334035,-0.489124,-0.318733,0.351403,-0.0409764,0.140225,0.439107,0.53626,-0.162421,0.763492,-0.556801,0.569656,0.331968,0.108047,0.389947,0.344353,-0.131316,0.337035,0.0642195,0.118024,-0.242157,-0.426198,0.0102525,0.0759547,-0.0363094,-0.0992714,0.200346,0.0314053,0.160652,-0.222012,0.0762785,0.629856,0.405097,0.243616,0.340086,-0.142599,0.303097,-0.631939,-0.239866,-0.117979,-0.507237,-0.343697,0.437898,-0.503191,-0.153107,-0.415847,0.324328,0.533977,-0.00312311,-0.0864658,-0.728539,-0.353611,0.161818,-0.726831,0.0540288,-0.408661,-0.123396,0.142916,-0.469819,0.595668,-0.319008,0.109952,-0.164103,0.284206,0.142495,-0.121306,-0.255504,0.176498,-0.230089,-0.20208,-0.11758,-0.458979,0.166475,-0.623124,-0.0263742,0.30727,0.038682,0.206446,-0.409572,-0.52998,-0.248723,-0.203686,-0.700144,-0.0116249,-0.226938,0.372484,-0.206349,0.638088,0.102737,-0.242111,0.452479,-0.964935,0.391291,0.033194,-0.21957,-0.0851509,0.170946,0.0579309,0.289979,-0.236429,0.442158,-0.035331,-0.233454,-0.669067,0.487921,-0.13612,-0.440367,-0.360012,0.250853,-0.105599,-0.0753121,0.107292,-0.00238178,0.38163,0.0700745,0.228798,0.239509,0.0640144,0.0766393,0.00990186,0.130607,0.340316,-0.318259,-0.0705027,-0.888725,0.0142323,0.594196,0.159316,-0.115494,-0.0361808,0.418196,0.397023,-0.103158,-0.841772,0.110424,0.298327,0.188666,-0.0266049,-0.370865,0.156232,0.279492,-0.233547,0.22857,-0.141636,0.751913,0.0331294,0.331568,-0.175912,0.348378,-0.34504,-0.972028,-0.286206,-0.155776,0.110815,0.252478,0.332888,0.502472,-2.84461 +3429.64,0.956852,0.0912059,4,1.54126,0.932568,-1.10659,0.294498,0.0253987,-0.0305157,0.110591,-0.283832,-0.199185,0.256704,-0.40911,-0.1387,0.110379,0.239912,-0.576047,0.866257,-0.116417,-0.161245,-0.510598,-0.142634,-0.612895,-0.54435,-0.634353,0.0663602,-0.514724,-0.155915,0.0216884,0.20123,-0.844439,-0.0593153,0.755908,-0.316507,-0.395972,0.0958135,-0.259202,-0.0897607,-0.464737,1.09047,0.492105,-0.106835,1.02326,1.35725,0.0128599,-0.799981,0.0261913,-0.235555,-0.427781,0.515012,0.552756,0.180477,0.165364,0.44274,-0.14115,0.549147,0.724641,0.316613,-0.15817,-0.617897,0.114018,-0.0155575,0.264767,1.3139,-0.485903,-0.897431,-0.00242053,-0.0884473,-0.262118,0.546203,-0.495612,-0.00710005,-0.173732,-0.247909,0.65725,-0.131093,0.178579,0.70956,0.230494,-0.243398,0.0332411,0.268395,0.310476,-0.032844,0.0594893,0.323255,-0.0784417,-0.339423,-0.11759,-0.395354,-0.332267,-0.448953,0.251037,0.341992,-0.30668,-0.279358,0.538394,0.0164316,-0.155671,-0.153829,-0.0225184,-0.119991,-0.439418,-0.0306663,-0.214006,-0.470633,0.586766,-0.257823,0.0650981,-0.369353,0.0404946,0.331284,0.555502,-0.143204,0.0618159,0.202366,-0.28697,0.62024,-0.174112,0.661371,0.0459429,0.227458,-0.786212,0.0357931,-0.159927,-0.544189,-0.110491,0.282225,0.244762,-0.43477,0.29339,-0.416974,0.275216,0.262694,0.219185,0.111015,0.164629,0.236237,-0.593815,-0.0236108,0.680525,-0.103297,-0.442965,0.282891,0.0268463,-0.00779647,0.423384,-0.128864,0.305536,0.420547,-0.121069,0.484152,-0.0886268,-0.193021,0.178889,0.414507,0.274075,-0.0921365,0.341735,-0.761264,0.296242,-0.773025,0.124667,0.083017,0.66037,-0.330048,-0.135708,0.108084,-0.0736535,-0.574365,0.223417,0.217724,0.458314,-0.0886676,-0.200943,-0.40864,0.156898,0.0626557,-0.0329681,0.0261522,0.323486,0.67172,-0.317782,0.319504,0.343584,-0.0872593,0.0392158,0.437751,-0.310989,-0.133753,-0.155026,0.0509392,-0.034758,0.15789,-0.247945,-0.383693,-0.43484,-0.167623,-0.27304,0.143372,-0.0528618,-0.432554,-0.128184,0.280147,-0.0212605,0.381473,-0.100554,0.285702,-0.0849764,0.851818,0.0909682,0.287013,-0.100576,-0.607006,0.154116,0.226665,-0.141822,-0.133854,-0.537461,0.039901,0.276256,0.0483693,0.155359,-0.575083,0.0164528,0.581071,-0.352183,0.641498,-0.125164,-0.147425,0.13929,0.164727,-0.0918388,-0.0665966,-0.0105809,-0.18984,-0.528793,0.432128,0.0444587,0.256539,0.327018,-0.0141939,-0.731209,-0.13721,0.0466004,0.232212,0.331182,-0.249841,0.654479,0.312264,0.113312,-0.0577315,0.308402,-0.19219,0.321147,-0.237088,-0.308062,0.378228,-0.298239,-0.521225,-0.240968,0.0782657,0.551703,0.370774,0.129323,0.382359,-0.394412,0.132891,-0.500852,0.141751,0.0331973,-0.341583,-0.164551,-0.0119945,0.594532,0.172508,-0.0916305,0.212659,0.0165349,-0.44679,0.224331,0.246344,-0.211031,0.133003,-0.591003,-0.0679555,0.0217247,-0.0340148,0.414331,0.105856,0.021193,-0.340995,-0.129748,0.598493,-0.189699,0.302907,0.426848,-0.501856,0.326237,0.219715,0.592814,0.471388,0.414728,0.130634,0.291081,0.361433,0.53952,0.11796 +3423.22,0.849134,0.0912059,4,1.44711,0.988737,-1.22227,0.330714,-0.139643,-0.0882474,0.222456,-0.0777598,-0.450045,0.380525,-0.462305,-0.0627467,-0.105151,0.223992,-0.195742,1.08771,0.0103244,-0.165557,-0.242423,0.234215,-0.541414,-0.638971,-0.55323,0.0253559,-0.431506,-0.174046,0.461115,0.107041,-0.756213,0.0337932,0.527099,-0.263133,-0.240696,0.102235,-0.447418,-0.13069,-0.850613,0.830745,0.476014,-0.244594,1.22292,1.27034,0.302917,-0.539153,0.00875453,-0.209141,-0.505942,0.507784,0.457507,0.350276,0.286566,0.438933,0.14427,0.0444772,0.590762,0.179861,-0.112522,-0.674965,0.02589,-0.0669875,0.278242,1.07105,-0.979236,-0.979918,0.149715,0.000835129,-0.541271,0.705429,-0.226547,-0.0392874,-0.156753,-0.0984526,0.462499,-0.348755,0.185622,0.615003,0.422075,-0.198599,0.102376,0.0750762,0.285175,-0.106607,-0.149455,0.0232665,-0.141965,-0.120919,-0.452895,-0.181909,-0.330854,-0.324519,0.104819,0.178174,-0.344763,-0.0055203,0.0752344,0.00888315,0.287123,-0.145487,0.093222,0.117601,-0.0702418,0.0426729,-0.409115,-0.496809,0.873672,-0.403422,0.0400512,-0.0861267,-0.191047,0.559499,0.565907,-0.203464,0.0218232,0.180741,-0.166642,0.5922,-0.105396,0.314271,-0.0279587,0.170551,-1.34692,-0.115986,0.513129,-0.727267,0.262713,0.286932,0.202689,0.0794175,0.231666,-0.57184,0.279267,0.369141,0.16608,0.199832,-0.0642393,0.0448949,-0.350932,-0.202259,0.538436,-0.236766,-0.427309,-0.115084,0.310796,-0.118226,0.27869,-0.152609,0.306498,0.0925673,-0.00684858,0.208556,0.0910315,-0.184869,0.204644,-0.0605701,-0.0248413,-0.0511973,-0.0210636,-0.84439,0.206601,-0.351853,0.303295,0.295596,0.700423,-0.38603,0.201167,0.0772566,0.0667428,-0.45462,0.215928,0.042524,0.493906,-0.320549,-0.202728,-0.166615,-0.00552766,0.246922,-0.0292537,0.00505232,0.172674,0.480379,-0.442429,0.588883,0.171488,0.149045,-0.363268,0.15138,-0.682487,0.0386488,-0.0533768,0.0987393,0.366001,0.327136,0.226777,-0.271035,-0.372862,-0.027638,-0.291544,0.113378,0.11588,-0.176453,-0.149811,0.112558,-0.199048,0.422644,-0.0746526,0.487215,-0.250452,1.16446,-0.594838,0.00171152,-0.173454,-0.132387,0.272401,0.14281,-0.196993,-0.246341,-0.512667,0.199105,0.403537,0.0365083,-0.109899,-0.300355,0.314093,0.321509,-0.343842,0.698369,0.102667,0.273894,0.0316259,0.144326,0.118362,0.105043,-0.00806774,-0.0764914,-0.235961,0.506963,-0.164213,0.23956,0.268099,0.472851,-0.280735,0.0403508,0.301092,0.191004,0.715138,0.345227,0.537765,-0.357178,-0.293197,-0.086873,0.357843,-0.0359766,0.392468,-0.193769,-0.354124,0.351616,-0.569578,-8.62391e-05,-0.290182,0.116278,0.37329,-0.297299,-0.120591,0.473535,-0.24777,0.359238,-0.0167133,0.200828,-0.383154,-0.604544,-0.254091,-0.15419,0.076964,0.053529,0.0333982,0.354313,0.293314,-0.253821,-0.075269,0.302059,0.157913,0.106351,-0.693789,-0.289962,0.488327,0.0412494,0.448109,0.362778,0.018232,-0.34739,0.0110111,0.615972,-0.208397,0.259975,0.358672,-0.44542,0.673133,0.29371,0.594158,-0.300159,0.290533,0.103504,0.320018,0.321721,0.565701,0.513281 +3430.53,0.960187,0.0912059,4,1.49466,1.05173,-1.15847,0.300846,0.0130699,-0.116606,0.208163,-0.0193164,-0.381587,0.426451,-0.346393,-0.0875389,-0.111611,0.203026,-0.155257,0.994597,-0.0183307,-0.233195,-0.345235,0.173591,-0.596067,-0.568141,-0.657166,0.127022,-0.368758,-0.226899,0.404631,-0.0210429,-0.753707,0.11256,0.511622,-0.228786,-0.281264,0.193612,-0.442077,-0.171232,-0.911632,0.875613,0.447436,-0.319445,1.24447,1.1381,0.544248,-0.469863,-0.0166552,-0.0757442,-0.607899,0.613477,0.385862,0.256566,0.262082,0.368888,0.181839,0.142314,0.62612,0.130281,-0.164918,-0.700737,-0.0248966,0.0889405,0.363351,1.10383,-0.84303,-0.934318,0.126026,0.0504643,-0.530594,0.643415,-0.195477,-0.11703,-0.157631,-0.0539939,0.381695,-0.340407,0.166077,0.639207,0.339541,-0.210203,0.0655966,0.0336635,0.332161,-0.160919,-0.0907914,-0.0405764,-0.15644,-0.136861,-0.518851,-0.16096,-0.324688,-0.32856,0.0945121,0.0871585,-0.26802,-0.0693044,0.0878645,-0.0199171,0.429393,-0.150456,0.16338,0.0955916,-0.0195073,-0.0142627,-0.425692,-0.50468,0.708127,-0.502936,0.0589935,-0.11588,-0.138268,0.637009,0.535847,-0.15403,-0.090815,0.228883,-0.17361,0.46253,-0.108732,0.337185,-0.0944301,0.11555,-1.29578,-0.0447059,0.492227,-0.913594,0.263397,0.235098,0.142114,0.0418713,0.311564,-0.527956,0.244572,0.445534,0.158359,0.224014,-0.0590157,0.0663292,-0.320812,-0.135901,0.430222,-0.436148,-0.38697,-0.05323,0.35615,-0.0734133,0.327529,0.0360275,0.297181,0.0568737,-0.0291149,0.224315,0.0142672,-0.203083,0.130374,-0.0470801,0.0140064,-0.00949579,-0.0639254,-0.772952,0.191975,-0.366297,0.316821,0.374191,0.609067,-0.259069,0.196288,0.132679,0.108462,-0.324672,0.149853,-0.0224451,0.530167,-0.382112,-0.180474,-0.164305,-0.0456893,0.183506,-0.0513702,0.0320704,0.183632,0.550187,-0.331681,0.504097,0.171812,0.250841,-0.380265,-0.0700444,-0.616765,-0.0344496,0.0455281,-0.0120032,0.37516,0.34937,0.209591,-0.359489,-0.335923,-0.0650859,-0.241832,0.115988,0.222862,-0.0289996,-0.281729,0.0661717,-0.177818,0.499021,-0.0310786,0.580213,-0.167668,1.12801,-0.548734,0.0076464,-0.199822,-0.0272482,0.243485,0.103638,-0.177452,-0.299782,-0.488425,0.154064,0.368958,-0.130469,0.00534764,-0.211126,0.0935865,0.429165,-0.313446,0.703199,0.087258,0.248044,-0.0468246,0.142756,0.0688508,0.0449978,-0.220545,-0.00759035,-0.235101,0.579262,-0.19478,0.201546,0.144122,0.46056,-0.269206,0.157928,0.31276,0.230338,0.554794,0.181432,0.563076,-0.279982,-0.19851,-0.119694,0.416165,-0.0149593,0.421651,-0.190962,-0.380802,0.318843,-0.451168,-0.164386,-0.248886,0.155129,0.372038,-0.394246,-0.142515,0.358893,-0.280919,0.321463,0.0248882,0.262402,-0.398181,-0.546315,-0.256605,-0.260405,0.0310066,-0.0735839,0.133255,0.176437,0.282751,-0.226406,-0.183711,0.196666,0.154062,0.107298,-0.62756,-0.130083,0.500302,-0.0612947,0.467464,0.299783,-0.151689,-0.294518,0.127203,0.438046,-0.100559,0.164863,0.395416,-0.512467,0.734358,0.344091,0.436016,-0.371876,0.347619,0.102914,0.334674,0.320802,0.57851,-0.0556183 +3438.17,0.960611,0.0912059,4,1.56163,1.04288,-0.817808,0.132272,-0.425371,-0.177622,-0.298974,0.523254,0.236884,0.96662,-0.660109,0.0383403,-0.00304614,0.502015,0.067451,0.50266,0.291128,-0.540215,0.195681,-0.0354494,-0.40803,-1.22798,-0.624299,0.128297,-0.0588651,-0.569687,-0.0510591,0.158806,-0.277067,-0.0747205,0.534854,0.499404,0.00545562,0.018528,-0.274458,0.274958,-0.357873,0.951194,0.0624958,-0.207223,1.16794,1.18181,0.562871,-1.0324,-0.170749,0.376941,-0.371629,0.472204,0.889312,-0.0131204,0.0255515,0.493339,0.403346,-0.058295,0.646456,0.324668,0.0412948,-0.991338,-0.0522076,0.21096,0.119996,1.25267,-0.594631,-0.366111,0.141819,0.327952,0.256908,0.10281,-0.230395,-0.5883,-0.642243,0.189816,0.872546,-0.31711,0.477655,0.281901,0.459988,-0.137311,-0.27692,0.0343278,0.357575,-0.156563,0.212087,0.086354,-0.613132,0.257528,-0.383788,0.467911,0.185231,-0.34979,0.0646205,0.295781,-0.187046,-0.419263,0.0285118,-0.165082,0.0358088,0.13058,-0.260725,0.100906,-0.185218,-0.241218,-0.658295,-0.239661,0.0270188,0.331012,0.498854,-0.0659161,0.332468,0.67897,-0.536215,-0.118001,0.507738,0.433832,0.17856,-0.191755,0.149493,0.501951,0.330927,0.446867,-0.302413,-0.346353,-0.458961,0.00759757,0.155702,-0.0598543,0.611378,0.0936636,0.22497,-0.75241,0.501155,0.0203973,-0.15961,0.336054,0.120083,-0.170837,-0.0576302,-0.418307,0.231902,-0.628974,-0.255486,-0.10406,0.310468,-0.432264,-0.553764,0.112911,-0.0319967,0.260367,-0.209589,-0.622114,-0.290962,0.0565013,-0.195169,0.318104,-0.0715864,0.271817,-0.0291048,0.284949,0.143257,0.131578,-0.193778,0.0300642,0.203904,0.43789,0.291941,-0.0261082,0.0121514,-0.0345686,0.118408,0.114745,-0.345649,-0.0153909,0.00987598,0.271913,-0.246926,0.267521,-0.105531,0.235383,0.152579,0.550373,-0.078217,-0.315874,0.310991,0.27817,0.0186393,-0.304011,-0.114627,-0.531798,-0.00477534,-0.282023,-0.127734,-0.442307,0.334318,-0.690613,0.220961,0.0950092,0.329582,-0.343518,-0.999257,-0.470865,-0.108323,-0.442456,-0.0332664,-0.0665452,0.00472791,0.400801,-0.32361,0.658068,-0.0581236,-0.249278,-0.143721,0.00753015,0.194785,0.315413,-0.474879,0.607912,0.166004,0.0578155,0.0372965,-0.462269,0.0469584,-0.147414,0.0522348,0.546768,-0.0392788,0.409178,-0.267879,-0.149014,0.167001,-0.0461392,-0.219205,-0.0111084,-0.342725,-0.0742602,0.239671,0.981216,-0.000721627,0.313314,0.408657,-0.300853,-0.223738,-0.433349,0.0572055,-0.300511,0.320322,-0.00495243,0.497841,0.310983,-0.676318,-0.273028,-0.0959943,0.0936124,0.306869,0.149859,0.291793,0.0336548,-0.213183,-0.221178,-0.196919,-0.0703124,-0.0606705,0.127084,-0.351761,-0.30903,0.415579,-0.167141,0.0932589,-0.233592,0.484947,0.0998022,-0.0452281,0.020844,0.0234559,0.246275,0.0108799,0.0349658,0.0493673,-0.212748,0.0784644,-0.0459941,0.388066,0.0150073,-0.183846,-0.724146,-0.424655,0.139859,0.499962,-0.0249317,0.108797,-0.366758,-0.0516195,-0.308203,0.279132,0.663695,-0.00378387,-0.498719,-0.273946,-0.335288,-0.159285,0.466136,-0.0217104,0.104092,0.210301,0.322632,0.458586,1.47866 +3434.78,0.561131,0.0912059,4,1.56541,1.09958,-0.878202,0.226113,-0.102214,-0.084897,0.04163,0.182757,0.1534,0.588975,-0.0856752,0.106192,-0.190355,0.257682,0.159776,0.225601,0.0573063,-0.467869,-0.352873,-0.173432,-0.721859,-0.842574,-0.849351,-0.0570852,0.0985872,-0.247913,0.0490225,0.920048,-0.271929,-0.244675,0.812011,0.0460579,-0.0664871,-0.206501,-0.507575,-0.127108,-0.155187,0.607819,-0.0104179,-0.00917461,1.40657,0.94322,0.789313,-0.192513,-0.337673,-0.248044,-0.635333,0.611295,0.479362,-0.116411,0.220085,0.153142,0.142678,-0.343088,0.444032,-0.181061,-0.559137,-0.592629,0.105186,0.0502573,0.239871,1.0921,-0.473121,-1.23264,0.336733,0.562549,-0.187247,-0.142919,-0.447261,-0.565598,-0.24303,0.262691,0.630925,-0.42768,0.664844,0.433672,0.812403,-0.306501,0.0409076,-0.0707443,0.592276,0.14492,-0.320527,-0.292358,-0.610073,0.0324716,-0.581989,-0.401955,0.462836,-0.483466,-0.294954,0.280662,0.114817,-0.0919717,0.231284,-0.819478,0.167437,0.26037,-0.271264,0.120878,-0.0179894,0.227006,-0.925488,0.0431464,0.581366,-0.447423,0.139311,-0.220841,0.16949,0.753904,0.0847826,-0.0159775,-0.445094,0.279368,0.0609812,-0.330158,0.275037,0.303559,0.262035,0.258654,-1.14061,-0.417812,-0.199582,-0.0462431,0.147449,-0.564391,0.101007,0.240141,0.0807563,-0.234172,-0.0274666,0.0728704,-0.408596,1.1568,-0.415432,-0.329056,-0.535608,0.0871412,0.42419,-0.316823,0.116838,-0.218201,-0.283233,-0.390066,0.249389,-0.62327,0.244567,0.214996,-0.391333,-0.364866,-0.286155,-0.120042,0.42895,-0.454189,-0.30603,0.310696,0.328545,-0.161532,-0.0615815,0.0951565,0.347234,-0.122787,0.661685,0.134266,-0.366195,-0.068841,0.0571825,-0.848346,0.0633599,-0.100421,0.0687156,-0.0851148,-0.080688,-0.491736,-0.0913223,0.446147,-0.479097,-0.0129453,0.292164,0.422915,-0.314209,0.528458,0.139248,0.0402096,0.113496,0.013811,-0.338472,-0.715401,-0.170763,0.0154218,0.207978,0.251526,-0.269223,-1.08528,0.429126,0.063013,0.0228477,-0.219579,-0.756392,0.269881,-0.0728697,-0.90756,0.0687943,-0.171723,-0.33919,0.116045,-0.196219,0.858778,-0.474442,0.226432,-0.0248403,-0.241592,-0.0647411,-0.664997,-0.452656,0.00962881,-0.197865,-0.103614,0.183615,-0.0647016,-0.160956,-0.253471,-0.0748562,0.0850379,-0.467807,0.32467,-0.0971153,-0.146559,0.336416,0.134717,0.185382,0.178304,-0.121907,0.333981,0.0297059,0.665019,0.254972,0.243937,0.312463,-0.21224,0.235414,0.281934,-0.0863744,0.361322,0.099041,-0.230442,0.282055,0.0276663,-0.189149,-0.135485,0.111893,-0.0957996,0.372117,0.150226,-0.642737,0.0639492,-0.464224,0.268043,-0.110598,-0.239465,-0.111216,0.337188,-0.327262,-0.325382,0.089771,-0.113616,-0.285516,0.0956381,0.138433,0.0042764,-0.731316,0.0711963,-0.217488,-0.0855429,0.341532,0.0141288,-0.13357,-0.0301374,0.115782,0.172849,0.336926,0.1265,-0.0822605,0.0586859,0.052231,0.138015,-0.144018,0.53045,0.0726775,0.112894,0.0638103,-0.233046,0.45651,-0.190526,0.175265,-0.8735,0.128931,-0.37278,0.29262,-0.21639,0.0322255,0.119604,0.275625,0.345839,0.525,0.228944 +3441.3,0.990389,0.0912059,4,1.55442,1.04863,-0.996874,0.261836,-0.147455,-0.034437,0.155309,0.0347951,0.0852908,0.925505,-0.136699,0.264587,0.025961,0.264913,0.0436605,0.543998,0.237548,-0.594562,-0.289169,-0.284552,-0.394209,-0.774252,-0.968592,0.177954,0.0636757,-0.115106,0.0178931,0.846621,-0.477136,-0.250218,0.847974,0.000831265,-0.0790226,-0.123868,-0.48978,-0.235174,-0.0675689,0.466535,0.0354199,-0.00668468,1.0552,0.977508,0.890949,-0.32944,-0.400801,-0.328537,-0.691735,0.696466,0.356512,0.0336157,0.178819,0.301693,0.10912,-0.411226,0.290608,-0.142445,-0.441016,-0.570648,0.0469611,-0.0343255,0.0904747,1.22784,-0.53619,-1.03363,0.354208,0.206789,-0.184864,-0.142777,-0.467044,-0.496857,-0.146085,0.299933,0.871492,-0.618548,0.771065,0.47331,0.692516,-0.318079,0.015109,-0.0298504,0.445265,0.0768585,-0.190973,-0.370025,-0.474559,0.105178,-0.420189,-0.30359,0.673224,-0.540879,-0.136349,0.142325,0.203733,-0.0940165,0.265621,-0.565398,0.0837658,0.0338496,0.19143,0.0223077,0.334779,0.114938,-1.12727,0.371763,0.56211,-0.486698,0.43966,-0.0848238,0.201496,0.726478,-0.0795447,-0.112403,-0.518852,0.393167,0.0527409,0.0296447,0.609979,0.266407,0.266499,0.0148409,-1.19646,-0.308242,-0.0383613,0.00817909,-0.0203131,-0.333913,0.331605,0.284423,0.0620567,-0.21384,0.178787,0.0987797,-0.416042,1.11713,-0.33154,-0.291972,-0.411136,0.190269,0.378432,-0.244307,0.060969,-0.338869,-0.074121,-0.391665,0.4967,-0.459092,0.163667,0.375696,-0.401023,-0.224837,-0.251642,0.0170267,0.377428,-0.563274,-0.298402,0.155854,0.268487,0.0507863,0.133838,0.318083,0.465502,-0.316925,0.66097,0.210386,-0.171021,-0.29455,0.0469126,-0.532588,0.409775,0.0506846,0.161098,-0.147461,0.0901339,-0.174617,-0.0669514,0.454428,-0.229188,-0.248841,0.424977,0.550089,-0.207579,0.580216,-0.0782409,0.317865,-0.0574208,0.0384914,-0.531837,-0.672998,-0.239824,-0.221425,-0.0671029,0.443267,-0.106683,-0.99818,0.488938,0.00997357,0.253872,-0.107087,-0.622157,0.319072,-0.0962645,-0.729841,-0.123911,0.0442853,-0.589785,-0.0233665,-0.346909,0.663429,-0.313169,0.520164,0.133322,-0.155671,-0.00709013,-0.477597,-0.562878,0.11147,0.00939214,-0.167244,0.139666,-0.290662,-0.0733662,-0.465138,-0.394821,0.0616417,-0.478183,0.350646,-0.173935,-0.223297,0.12666,0.220974,0.151339,0.111721,-0.0665293,0.321359,-0.0881685,0.679439,0.240793,0.143846,0.199955,-0.306427,-0.104556,0.0886059,0.122432,0.488994,0.28188,-0.275745,0.11042,-0.0458668,-0.108431,-0.155296,0.107548,-0.207692,0.266235,-0.0966438,-0.743708,0.068591,-0.451405,0.165266,0.027725,-0.161385,-0.0235945,0.26442,-0.222763,-0.465594,0.143657,-0.335871,-0.387078,0.175945,0.0567383,-0.212752,-0.365463,-0.114332,-0.162934,-0.0281205,0.419804,0.184558,-0.435335,0.000774766,0.0880134,0.198754,0.233958,-0.00135572,-0.110067,-0.221709,-0.0037001,0.0664713,-0.0492368,0.630859,-0.103004,0.133496,-0.0788852,-0.233063,0.674668,0.146303,0.1554,-0.846832,0.278401,-0.30007,0.122693,-0.352311,-0.0375653,0.125012,0.23915,0.35357,0.489029,0.47408 +3432.52,0.998966,0.0912059,4,1.57345,0.951433,-1.05227,0.369686,-0.0975974,-0.0761075,0.355156,-0.0797095,0.0491628,0.7766,-0.243723,0.100987,0.0361957,0.443546,0.0934671,0.620075,0.235767,-0.376318,-0.0290541,0.0773716,-0.529985,-0.468819,-0.673177,0.31687,-0.16237,-0.124,-0.233636,0.809851,-0.12379,-0.17157,0.838368,0.120466,-0.0635969,0.0721325,-0.395706,-0.0170378,-0.320136,0.242262,0.37959,-0.231242,1.17764,0.660755,0.937699,-0.372861,-0.629682,-0.50937,-0.0639549,0.430395,0.598684,0.129352,0.0964983,0.522662,0.0662509,-0.601868,0.242731,-0.366292,-0.553604,-0.542513,0.164144,-0.0882019,0.529927,0.946135,-0.859908,-0.832428,0.305594,-0.371305,-0.751742,-0.266376,-0.082991,-0.925729,-0.276975,-0.176589,0.607713,-0.739101,0.748083,0.650261,0.415148,-0.41997,-0.286432,0.061389,0.513683,-0.243359,-0.262996,-0.635125,-0.625265,0.141392,-0.690865,-0.217531,0.750539,-0.613565,-0.25769,0.208486,0.188549,-0.173184,0.0818437,-0.484088,-0.0896069,0.0184676,0.209079,-0.0572216,0.411072,-0.092602,-0.863752,-0.245338,0.737779,-0.316483,0.559139,-0.0200056,0.169561,0.711429,0.0390872,-0.277687,-0.229306,0.379106,-0.303036,0.49363,0.500141,0.103137,0.266275,0.351461,-1.53474,-0.0777063,0.026743,-0.236847,0.103922,-0.364413,0.290815,-0.0658196,0.225645,-0.567477,-0.0325,-0.0957791,-0.11708,0.925765,-0.647344,-0.014176,-0.0232411,0.0514735,0.185022,-0.338624,0.0216774,-0.324582,-0.306606,-0.738711,0.37145,-0.414902,0.193691,0.397556,-0.376936,-0.0432688,-0.168717,-0.00318068,0.252947,-0.284274,0.222512,0.204247,0.385511,0.145888,0.217638,0.165034,-0.243549,-0.352271,0.734421,0.169717,-0.23608,-0.309362,0.0150469,-0.0832682,0.288035,-0.529545,-0.0309753,-0.196652,0.159345,-0.193025,-0.234328,0.214877,-0.213621,0.0665515,-0.0627184,0.35116,-0.0139854,0.0782489,0.240208,0.186525,-0.0591413,-0.154392,-0.497214,-0.762326,-0.298612,-0.160917,0.00556351,0.0790512,0.0839365,-0.726614,0.223279,0.0534552,-0.214206,-0.390017,-0.706749,0.169623,-0.00216368,-0.0577763,-0.115869,-0.179864,-0.724611,-0.105267,-0.252339,0.773953,-0.675117,0.167322,0.0715399,0.0404821,0.022733,-0.259311,0.29196,0.161635,0.139693,0.134856,0.561809,-0.426121,-0.205433,-0.0153614,-0.44113,0.13093,-0.22546,0.220295,0.0332413,0.15166,-0.507884,0.113518,0.153636,0.203341,0.0595014,0.0302223,-0.0880211,0.422943,0.311831,0.221615,0.372776,0.239185,-0.225227,0.293578,-0.0168411,0.158833,0.598008,-0.263225,0.162137,-0.361871,0.308458,-0.204988,-0.0919147,-0.532214,0.148229,0.0633226,0.070983,0.356958,-0.0144463,-0.00215878,-0.0310176,-0.240241,-0.00622356,0.454452,-0.31299,-0.702769,0.217333,-0.142514,0.013402,-0.0542785,-0.298852,-0.0638633,-0.326458,-0.0763691,0.148634,0.209276,-0.172275,0.137334,-0.14069,0.0242384,-0.022973,-0.0426016,0.221975,0.333665,-0.169797,0.0691877,0.025997,0.109111,-0.0656479,0.906045,-0.0936721,-0.187168,0.314779,-0.44864,0.447544,-0.0457216,0.0412191,-0.930542,-0.240245,-0.464032,0.182828,-0.380551,-0.378555,0.127152,0.238364,0.356584,0.488226,0.436671 +3410.21,0.992605,0.0912059,4,1.55171,0.877491,-0.673377,0.277126,0.416152,-0.119248,0.186906,0.121321,0.431266,-0.0526706,0.523767,0.182455,-0.453966,0.481158,-0.141123,0.247959,0.117709,-0.0771097,-0.20899,0.127369,-0.159368,-1.75153,-0.411381,0.479741,0.201623,0.0988853,0.785133,0.285039,-0.598019,-0.152827,0.775975,-0.827819,0.144508,0.0635522,-0.587244,0.0184293,-0.176955,0.86674,0.39367,-0.494635,0.920977,0.476391,0.304981,-0.61717,-0.391026,-0.254152,-0.810526,-0.327284,0.0868649,0.0606042,-0.241119,0.529127,0.100358,-0.360178,0.502017,-0.447541,-0.329542,-1.02653,0.45548,-0.15187,-0.169719,1.38772,-0.393536,-0.989348,-0.137199,0.380035,0.0360701,-0.504347,0.260817,-0.631605,0.0243161,0.510126,0.549642,-0.296231,1.38961,0.100762,0.316111,-0.142537,0.145885,0.0180192,0.751313,-0.298925,0.172518,0.0696879,-0.281777,-0.37801,-0.190427,-0.329569,0.109727,-0.358513,0.202235,0.142687,0.176852,0.374555,-0.0202132,-0.410825,-0.329647,-0.0608541,0.203708,0.00440403,-0.331099,-0.393149,0.0359493,0.0762548,0.136193,-0.322492,-0.0963555,-0.204329,0.290408,0.760857,-0.148719,-0.175048,0.0273492,0.649332,0.469236,0.161345,0.262773,-0.297444,-0.100974,0.448201,-0.574518,-0.173838,-0.750201,0.109603,-0.0538808,0.0978162,0.429944,0.251467,-0.147908,-1.10533,-0.213162,0.191674,0.0402361,0.709958,0.088694,-0.124559,0.22231,-0.881451,0.355954,-0.80157,-0.749312,-0.239191,0.0575742,-1.07452,-0.186068,0.485995,0.140472,0.0874398,0.0708052,0.260643,-0.0718549,0.0779718,0.238776,-0.258211,0.243517,0.172485,-0.436322,0.0215706,-0.150393,-0.24971,0.747283,-0.0663008,1.42676,0.991882,0.410812,0.378687,0.229705,-0.749443,0.195567,-0.0021906,0.145341,0.463093,0.0325116,0.2298,0.111438,-0.108383,-0.0822538,-0.0741091,0.148706,0.69127,-0.0670366,-0.191108,0.357073,-0.565158,0.0313733,-0.764824,0.448294,-0.152687,0.26879,-0.164903,0.0475153,0.014405,0.195504,-0.0277634,0.386657,0.524095,0.107487,-0.231047,-0.438656,0.124427,-0.287486,-0.446104,0.364749,-0.300108,-0.176493,0.25204,-0.42852,0.988186,-0.245903,-0.0650306,-0.0316034,-0.112498,0.180379,0.298293,-0.040183,0.179644,-0.374175,0.205253,0.431354,-0.43102,-0.338668,-0.536815,-0.209729,-0.229778,-0.0988126,0.236296,-1.02021,-0.236405,0.257897,0.0864593,-0.227073,0.168903,0.741274,-0.252745,0.26003,0.398549,-0.160474,0.219582,0.263472,-0.247706,-0.274339,0.0403846,-0.0464401,-0.379113,0.68874,0.694082,0.0411037,-0.277122,0.0518967,-0.272202,0.0846497,-0.46051,0.608242,-0.0647715,-0.00391411,-0.242342,-0.208185,0.486432,-0.30536,-0.0967362,-0.261634,0.214765,0.159378,0.543423,0.178611,0.689564,-0.26284,-0.622352,-0.157116,0.474178,0.155225,-0.100939,-0.208713,0.328044,0.121809,0.221862,0.128895,0.272206,-0.346128,-0.505963,0.231414,-0.218504,-0.525794,0.364463,0.727318,0.0702877,0.295416,-0.198872,0.657875,0.0909186,-0.0464467,0.406213,0.129892,0.441046,-0.534944,-0.172348,0.406698,-0.459787,-0.0616989,-0.0247077,0.218253,0.148351,0.277574,0.385164,0.526853,-1.26039 +3384.36,0.93053,0.0912059,5,1.56865,0.8265,-1.01145,0.40798,0.422285,-0.142482,0.129028,0.323899,0.370946,-0.067907,0.562847,0.0768527,-0.349467,0.431353,-0.209838,0.312114,0.250237,-0.254184,-0.15396,0.188733,-0.000361621,-1.70239,-0.396677,0.457733,0.357276,-0.0439302,0.519311,0.336984,-0.750891,-0.162658,0.787646,-0.512135,0.0416434,0.222612,-0.762808,-0.163137,-0.507913,0.702439,0.494678,-0.455197,0.847682,0.706596,0.556318,-0.835406,-0.392968,-0.38768,-0.97514,-0.366723,0.210101,-0.111571,-0.266348,0.541189,-0.0221052,0.0121095,0.440143,-0.522467,-0.234921,-1.0537,0.29568,-0.286678,-0.0671404,1.10904,-0.533769,-1.09294,-0.0473416,0.110716,0.0714615,-0.278418,0.371846,-0.540434,-0.272967,0.793306,0.490015,-0.0746032,1.15383,0.0463022,0.356232,-0.0852919,0.177808,-0.0708762,0.64242,-0.0891935,0.150484,0.0492064,-0.138737,-0.327984,-0.164897,-0.29426,0.128623,-0.262145,-0.0222413,0.299873,0.0334545,0.46388,0.063189,-0.0742052,-0.356038,0.0631121,0.477876,0.0293361,-0.131574,-0.319146,0.22249,-0.030146,-0.115759,-0.315172,0.010738,-0.0783315,0.518776,0.845214,0.0627018,0.0271935,-0.0778262,0.53055,0.366384,0.254855,0.154116,-0.0617011,-0.377894,0.61578,-0.530408,0.0365114,-0.665304,0.0422475,0.236259,0.1335,0.324609,0.154752,-0.122918,-1.00276,-0.195815,0.0425939,-0.1447,0.745501,0.00599533,-0.126485,0.0204594,-0.891981,0.420177,-0.784966,-0.682088,-0.351808,-0.11741,-1.15191,-0.242872,0.602419,0.138829,0.011812,0.132896,0.377868,-0.0528329,0.109598,0.289991,-0.262216,0.55997,0.177731,-0.420783,0.266992,-0.0313568,-0.289384,0.909845,-0.151947,1.44624,0.985408,0.178407,0.415121,0.283919,-0.403345,0.274727,0.3323,0.405164,0.490291,0.322223,0.18156,0.128728,-0.218297,-0.208143,0.17911,0.113267,0.846955,-0.088982,-0.299021,0.472014,-0.458178,-0.114245,-0.514038,0.266233,-0.374927,0.17568,-0.2337,0.115138,0.0956056,0.151261,0.0666694,0.37565,0.489666,-0.124033,-0.112584,-0.378697,0.340704,-0.397473,-0.394313,0.778019,-0.367386,-0.359071,0.351954,-0.354997,1.02225,-0.360701,0.0114659,-0.279755,-0.0889017,0.47052,0.283696,-0.204212,-0.0194124,-0.371505,0.10312,0.501445,-0.624342,-0.240164,-0.332627,-0.189971,-0.0292536,0.152505,-0.146634,-0.89889,-0.257252,0.195227,-0.138842,-0.295476,0.418192,0.719392,-0.32508,0.154959,0.27392,-0.226593,0.058207,0.277018,-0.11796,-0.300759,-0.182116,0.0541237,-0.0557166,0.871267,0.72787,-0.164049,-0.505123,0.167626,-0.325534,0.108205,-0.304575,0.42957,-0.0430121,0.0848743,-0.0171952,-0.39746,0.283808,-0.140615,-0.221166,-0.185469,-0.209772,0.0757873,0.592652,0.201602,0.858132,-0.401029,-0.661702,-0.182365,0.47333,-0.130649,-0.272844,0.00473966,0.571611,0.309936,-0.0437551,0.0588608,0.242714,-0.418784,-0.497035,0.356249,-0.00833509,-0.340256,0.448237,0.556043,0.0478671,0.340436,-0.0640413,0.636743,0.0818154,-0.147246,0.362969,0.0224681,0.89913,-0.588097,0.0607292,0.366582,-0.464589,0.00712515,-0.105548,0.402929,0.136677,0.333265,0.369698,0.577291,-1.11432 +3420.98,0.897404,0.0912059,4,1.65099,0.968249,-0.850612,0.361677,0.112011,-0.162755,0.137579,0.259791,0.325142,0.00158724,-0.099518,-0.247077,-0.155007,0.299822,0.0845101,1.24582,-0.0332742,0.031002,-0.0531661,-0.13826,-0.337582,-0.398068,-1.18031,0.211036,-0.738965,0.174415,-0.165243,0.102058,-0.0767788,0.120676,0.766562,-0.195406,0.0403239,0.480086,-0.416331,-0.367629,0.00834269,0.520506,0.306494,-0.606285,0.703685,0.579749,0.490645,-0.760997,-0.526764,0.0772357,0.0169138,0.371812,0.454929,0.12718,0.236771,0.392673,0.00707986,-0.631481,0.365873,-0.470319,-0.63252,-0.859637,0.144554,-0.213131,0.119837,0.727687,-0.932224,-0.330486,0.256811,0.0955204,-0.710753,0.13555,-0.181347,-0.327808,-0.00946615,-0.223694,0.658153,-0.158244,0.035735,0.842684,0.370389,0.00411316,-0.685747,0.130525,0.711773,-0.170056,-0.104483,0.158716,-0.0301704,-0.106147,0.389204,0.350483,-0.0502446,-0.343278,0.248344,-0.1755,-0.370048,-0.240825,0.306118,-0.585539,0.514056,-0.30506,0.107456,0.40847,0.294437,-0.216703,-0.849153,0.0696049,0.517958,-0.49509,0.170768,-0.422327,-0.363054,0.424666,-0.227254,-0.298468,0.271811,0.223864,0.359608,-0.18075,-0.389929,-0.0197143,0.489832,0.0342628,-0.425476,0.135891,0.184796,-0.304366,-0.316253,-0.070821,-0.164402,0.315354,0.12242,0.0791175,0.35901,-0.0225357,0.00204592,0.0506788,0.0283688,-0.146286,0.0585252,0.625086,0.374449,0.12871,0.0565655,-0.0202919,0.137223,-0.158729,0.0611048,-0.36919,-0.0459416,0.558884,-0.35878,-0.62776,-0.251046,-0.214126,-0.0159939,-0.0107958,-0.119442,-0.212208,0.579014,0.0939961,0.145673,0.174561,-0.983638,0.20611,0.226439,-0.122669,-0.427388,-0.0493669,-0.499698,-0.0169512,-0.292642,-0.530085,0.119086,-0.273002,-0.373731,0.0869663,0.198491,0.224392,-0.388298,-0.689139,0.310933,0.454217,0.249324,0.0488219,-0.31075,0.39579,-0.14635,-0.0466511,-0.113165,-0.333033,0.065683,-0.356691,0.00045315,-0.0336683,-0.175197,-1.01094,-0.0982871,-0.329237,0.136417,-0.265646,-0.775367,0.245757,0.00703378,0.149501,-0.707447,0.309777,0.0355144,-0.339646,-0.442236,0.791731,0.620744,0.173868,-0.250969,0.0166076,-0.130925,-0.252932,0.0363624,0.223256,-0.0225077,0.125349,-0.343144,-0.012165,-0.0098448,-0.43578,0.337217,0.321307,-0.322231,0.673332,0.314329,0.0590549,-0.0592868,0.127135,-0.437093,-0.291413,-0.833589,0.203697,-0.138355,0.240936,0.00688355,0.115992,0.663943,-0.0177959,-0.140082,0.654393,-0.14187,-0.0869285,-0.145759,0.160389,0.507562,0.283679,-0.199688,-0.122877,0.0282019,-0.743609,0.471916,-0.0807226,-0.130882,0.400196,-0.020549,-0.14884,0.497518,0.167261,0.207139,0.0824398,-0.0283563,-0.161877,0.462362,-0.11889,0.30762,0.272068,-0.033403,-0.574907,-0.091591,0.286682,-0.726532,-0.590578,-0.533618,-0.0501511,0.101971,-0.302982,0.512204,0.110254,-0.311432,-0.385325,-0.0650403,0.00763342,-0.467141,0.0412245,-0.263721,0.412394,-0.46196,-0.255246,-0.0371564,-0.0799921,0.307213,0.0508106,0.0746536,-0.442337,-0.160964,0.348553,-0.219269,0.0968752,-0.212104,0.0913357,0.190228,0.302218,0.436151,-0.288064 +3390.44,0.73073,0.0912059,4,1.58337,0.924995,-0.659694,0.175416,0.691667,-0.0500893,0.247818,0.027595,0.417863,-0.0588905,0.0435172,-0.191247,0.27447,0.711393,-0.11684,1.16354,0.160484,0.112256,0.252676,-0.0960955,-0.12281,-1.66761,-0.527278,-0.0222261,-0.221275,-0.0877929,0.0207092,0.439262,-0.464212,-0.267751,0.636772,-0.43298,0.46743,0.248425,-0.230231,-0.276785,-0.584088,0.0384284,0.282301,-0.368153,1.10148,0.333562,-0.204838,-0.418733,-0.326306,-0.909156,-1.11006,-0.40408,0.396593,-0.190918,-0.14526,0.551212,0.340384,-0.32992,1.00981,-0.0445809,0.0743201,-0.952746,1.04653,-0.710278,0.447065,0.769518,0.090111,-1.52868,-0.327466,-0.0968295,0.536826,-0.111,0.863568,-0.53025,0.189938,0.637349,0.018123,-0.0580798,0.157634,0.0415372,-0.0159132,-0.292113,0.252101,-0.210601,0.499834,0.0230434,0.571923,0.339422,-0.474596,0.0822086,-0.397441,-0.456196,0.220794,-0.292272,-0.0318149,-0.0604032,0.120509,0.048578,-0.31139,-0.0450625,-0.33403,-0.206676,0.498513,0.126924,0.0133987,0.3087,0.238002,-0.247937,0.295151,-0.324958,0.217541,-0.072671,0.280379,0.337034,0.165313,-0.379321,0.271152,0.1446,-0.09739,0.0718379,0.194899,-0.313315,-0.0500041,-0.205564,-0.0411998,-0.318952,-0.313073,0.135121,0.199815,0.307052,0.53655,0.18185,-0.0541373,-0.580845,-0.397148,-0.60541,-0.120629,-0.147162,-0.141358,-0.0809002,-0.329144,-0.970156,0.388162,-0.494195,-0.181924,0.136988,0.166231,-0.514196,-0.17632,0.456265,0.247684,0.494604,0.146,0.292646,-0.397462,0.000571978,0.0410789,0.0818837,0.259957,1.05719,-0.214206,-0.326357,-0.237522,-0.0494974,0.59274,-0.185756,1.31437,0.0971988,0.226564,0.525898,0.093902,0.00998273,0.0276564,0.396704,0.212653,0.520214,0.0176672,-0.245599,0.0901889,0.114094,-0.626871,0.137979,-0.169165,0.917336,-0.728506,-0.399235,0.815077,-0.605321,0.205952,-0.511201,-0.0610414,-0.281603,0.176316,-0.217251,-0.309063,-0.447333,-0.267354,-0.0750011,0.0042105,0.183,0.188414,-0.0646168,-0.26163,0.219329,-0.15346,-0.395056,0.79115,-0.100205,0.135248,-0.156028,-0.053817,0.96009,-0.579443,0.0808479,0.111791,-0.636374,0.387099,0.384923,-0.059925,0.214995,-0.274597,0.128512,0.304058,0.221812,-0.15442,-0.11145,0.690583,-0.108573,0.0430461,-0.285327,-0.578393,-0.541308,-0.515933,-0.397755,-0.221381,0.0419085,0.248733,-0.264477,-0.764221,-0.0269311,0.313288,-0.432035,0.411339,-0.525619,0.157049,-0.542036,0.058682,-0.150443,0.360048,0.310203,-0.0142766,0.0868777,-0.60217,-0.654867,-0.158029,-0.506487,0.333919,-0.329267,-0.175879,0.230542,-0.427742,0.131202,-0.257174,-0.0129875,0.370559,0.12416,0.612888,0.673305,-0.256195,0.479411,-0.566033,-0.565376,-0.696703,0.416449,-0.227981,-0.0407271,0.407336,0.913199,0.62457,-0.0188671,0.0259335,0.24011,-0.270481,-0.0497258,0.709505,-0.309002,-0.070423,0.0315447,0.444756,0.0869693,-0.00496861,-0.445557,0.236697,0.373318,-0.149928,0.268305,-0.21077,0.607925,-0.674912,-0.320065,-0.212066,-0.150665,-0.320463,-0.387884,0.415414,0.119204,0.471952,0.34526,0.686988,-2.15538 +3384.73,0.539784,0.0912059,4,1.55097,0.906968,-0.696487,0.182322,0.697178,-0.105664,0.195893,0.11943,0.387513,0.231373,0.0559787,-0.203012,-0.13133,-0.0468658,-0.181882,1.09709,0.176716,0.0426353,-0.0836462,-0.160103,-0.470719,-0.592766,-0.913433,0.247837,-0.679725,-0.122424,0.108938,0.295728,-0.413167,0.278996,0.890424,-0.220018,0.0489653,0.520149,-0.198855,-0.174945,-0.76123,0.173519,0.543408,0.144924,1.04203,0.175229,0.558843,-0.339732,-0.38268,0.0477951,-0.00702844,0.27325,0.712868,0.181679,0.130985,0.0825577,0.459314,-0.717125,0.798341,-0.707814,0.260907,-0.632915,0.486791,-0.225394,0.370024,0.887452,-0.303951,-0.680474,0.132584,0.176219,-0.295706,0.357588,-0.439371,-0.244854,-0.200204,-0.0303286,0.876578,-0.526258,0.309723,0.65448,0.543399,-0.0421957,-0.797593,0.543356,0.481208,-0.650007,-0.227274,0.226826,-0.0232939,-0.0947897,0.490272,0.182678,-0.228552,-0.485703,-0.116673,0.456566,0.0262939,-0.0912046,0.540892,-0.655151,0.399334,-0.18176,-0.42453,0.164337,0.453084,0.120388,-0.957951,0.128259,0.0760869,-1.00946,0.360166,-0.567659,0.439226,0.84267,0.183741,-0.0326262,0.240205,0.56141,0.344458,-0.773934,-0.461309,0.162371,0.539995,0.0712308,-1.32459,-0.54612,-0.164073,-0.255331,-0.729172,-0.00169824,-0.230931,0.0435239,0.265719,-0.274939,0.109356,0.333237,0.240426,0.296087,-0.487102,-0.861661,0.385135,0.501257,0.362398,-0.299348,-0.580494,-0.192858,0.405675,-0.589992,-0.153029,-0.256458,-0.483811,0.491731,-0.468239,-0.671002,-0.121776,0.0836508,0.166197,0.0438657,0.653783,0.102183,0.592742,-0.195218,0.385899,-0.0338511,-0.094373,0.237176,1.10131,0.283335,0.0878097,-0.42462,-0.424348,-0.528783,-0.255601,-0.812867,-0.326912,-0.78708,-0.0294421,0.379838,-0.866838,-0.326951,-0.145695,-0.309593,0.164333,0.77759,-0.169695,-0.0675086,-0.182501,-0.147771,-0.221504,-0.0321762,-0.586412,-0.302754,0.152688,-0.678132,0.0312666,-0.0403551,-0.223477,-0.947811,0.193794,-0.0090385,-0.100185,-0.225731,-0.282798,0.048334,0.0206224,-0.161613,-0.422314,0.0382452,-0.238608,0.527925,-0.543648,0.843925,0.157733,-0.130626,0.115297,0.378935,0.107779,0.866303,0.279063,0.0452507,-0.395632,0.190134,0.569988,-1.36187,0.28758,0.231532,-0.546578,0.532265,-0.654658,0.674575,0.158477,0.160293,-0.00194641,-0.0342454,0.583514,-0.042873,-0.196423,-0.589726,-0.0446166,0.692129,0.0656023,-0.274216,0.659194,-0.955177,0.246805,-0.209067,0.11908,-0.188933,0.255698,0.164836,0.588902,0.412476,-0.369122,-0.171565,0.169839,-0.673031,0.125752,-0.621695,-0.210561,0.107966,-0.142744,0.221872,0.557167,0.0725244,0.238324,0.739732,-0.311559,-0.794293,0.897921,-0.277363,0.391624,0.338774,0.196453,-0.37152,-0.287716,-0.516794,-0.108154,-0.303265,-0.137855,-0.0887814,0.0129858,0.142582,0.198544,0.125761,-0.218928,-0.465944,-0.24398,0.169915,-0.719076,0.390308,-0.395675,1.04526,-0.690427,-0.339509,0.431113,0.0778339,-0.0748173,-0.130057,0.139624,-1.28513,-0.88068,0.261609,-0.241248,0.283196,-0.171605,0.176414,0.134463,0.420016,0.366692,-2.14753 +3383.52,0.958736,0.0912059,4,1.52398,0.858391,-0.561652,0.130743,0.532035,-0.0819794,0.137751,0.306264,0.199021,0.332614,0.137056,-0.319214,-0.101361,0.0507948,-0.00337608,1.11951,0.216906,-0.0434218,-0.0804537,-0.236479,-0.418329,-0.68349,-0.808881,0.438103,-0.629944,-0.168539,-0.0315913,0.341836,-0.542639,0.176159,0.910194,-0.360532,-0.0535917,0.339772,-0.0579943,-0.0478555,-0.814366,0.378629,0.512295,0.0679001,0.986135,0.177024,0.465717,-0.233911,-0.463874,-0.0907649,0.0131149,0.288977,0.74423,0.155919,0.178684,0.0938019,0.46385,-0.793637,0.853432,-0.685121,0.197571,-0.683399,0.417376,-0.328309,0.298237,0.920073,-0.193778,-0.636011,0.417783,0.230996,-0.34748,0.568869,-0.470829,-0.321736,-0.0660878,-0.0282074,0.810533,-0.564755,0.222229,0.733554,0.656025,-0.0215608,-0.700083,0.642703,0.449346,-0.466204,-0.199285,0.448411,-0.0823126,-0.118552,0.296092,0.281853,-0.206895,-0.599286,-0.0511719,0.557051,0.102688,0.0945977,0.326311,-0.844551,0.260846,-0.234794,-0.345986,0.129479,0.437446,0.178991,-0.739898,-0.00985835,-0.0019816,-1.19188,0.313695,-0.599654,0.470147,0.811052,0.331505,-0.0384728,-0.0266906,0.619298,0.564955,-0.719422,-0.51591,0.182776,0.509436,0.0458554,-1.23133,-0.588387,0.106436,-0.0779719,-0.582052,0.0636994,-0.217909,0.0762465,0.243096,-0.631535,0.075724,0.234982,0.193796,0.273189,-0.536323,-0.794361,0.372486,0.651353,0.388544,-0.361193,-0.552987,-0.232427,0.421461,-0.429877,-0.118985,-0.178171,-0.560447,0.533378,-0.419127,-0.70219,-0.159901,0.0598434,0.133522,-0.0329752,0.672806,0.0279055,0.600418,-0.287643,0.408837,0.0594155,-0.266387,0.172578,1.08057,0.42193,0.117098,-0.395348,-0.386536,-0.617453,-0.0802275,-0.786311,-0.427657,-0.877081,0.0343311,0.461745,-0.78325,-0.528732,-0.0270265,-0.35677,0.180503,0.759988,-0.105906,-0.0969475,-0.000532083,-0.214695,-0.0564828,-0.200517,-0.624702,-0.328267,0.271595,-0.664335,0.0818688,0.0183487,-0.157655,-0.999425,0.253348,-0.0900092,-0.00819602,-0.21171,-0.338896,0.177249,0.123625,-0.230544,-0.297725,0.163543,-0.196374,0.489121,-0.427483,0.968881,0.13937,-0.0579619,-0.0382566,0.403877,0.0654937,0.824557,0.413387,0.0874224,-0.345089,0.278102,0.695023,-1.32156,0.393652,0.140507,-0.326274,0.340909,-0.505376,0.662742,0.187314,0.0960489,-0.0223986,-0.0733918,0.64692,-0.0269278,-0.261044,-0.501061,0.0486675,0.788402,-0.0340518,-0.238913,0.535061,-0.860501,0.187767,-0.148046,0.242066,0.015436,0.197925,0.318168,0.563024,0.406279,-0.343715,-0.137972,-0.00989568,-0.668971,0.022517,-0.520664,-0.163353,0.151398,-0.0989485,0.132446,0.51544,0.121998,0.151964,0.781423,-0.35936,-0.650887,0.79035,-0.173567,0.328698,0.364702,0.135763,-0.113276,-0.162405,-0.549628,0.0652534,-0.383756,-0.0492057,0.0611831,0.0118762,0.120312,0.274671,0.123585,-0.139887,-0.350573,-0.336122,0.147166,-0.615846,0.326929,-0.536523,0.888825,-0.64326,-0.328356,0.550482,-0.00900491,-0.193844,-0.180144,0.29012,-1.035,-0.857216,0.160619,-0.233599,0.396859,-0.121285,0.182248,0.132207,0.426906,0.363603,-1.56825 +3406.81,1,0.0912059,4,1.60262,0.773516,-0.556696,0.215082,0.473936,-0.0542852,0.187755,-0.208531,0.0543438,0.133787,0.0411372,-0.127922,0.293,0.277454,-0.222649,0.573103,0.464344,-0.00817197,-0.0411618,-0.0941344,-0.623061,-0.637035,-0.879435,0.306936,-0.265038,-0.201982,0.190348,-0.000963149,-0.28178,0.217024,0.745978,-0.539813,0.326776,0.155885,0.0779343,0.168758,-0.505884,-0.0503621,0.245779,-0.787882,1.01734,0.473505,0.0325956,-0.552674,-0.0378582,-0.340607,-0.934194,-0.471538,0.858289,0.0308981,-0.134193,-0.118671,0.627265,-0.208233,0.661878,-0.145544,-0.00266969,-0.313584,0.418277,-0.452725,0.0506807,0.962646,-0.849999,-1.14885,-0.526106,-0.0275501,0.567115,0.197976,0.0811367,-0.172162,0.151673,-0.00447302,0.704047,-0.201329,0.842486,-0.282285,0.294695,0.0743406,0.0372575,0.106512,0.444503,-0.487285,0.653642,0.282485,0.217335,0.0902038,0.0577768,-0.244919,-0.207791,-0.0344292,-0.154472,-0.235263,-0.213857,0.22012,-0.098879,-0.0587647,-0.348002,-0.232968,0.140454,0.118003,0.150805,-0.542296,-0.0528451,-0.691611,0.0116723,0.0791696,0.427611,-0.540706,0.161252,1.06081,0.367107,-0.557619,0.351803,0.62067,0.385874,0.128121,-0.0333114,-0.0973433,0.312027,-0.00617692,-0.370974,0.0110252,-0.520239,-0.28196,0.176598,-0.0475154,0.507442,-0.443054,0.647485,-0.0674352,-0.355204,-0.0328606,-0.0813557,0.238399,-0.463211,0.0738257,-0.211245,-0.00986288,1.25581,-0.851135,0.183004,0.166697,0.265819,-0.43454,0.289194,0.353462,-0.200684,0.124694,0.140613,-0.398816,-0.104335,0.105508,-0.112837,-0.131889,0.463963,0.388537,-0.208274,-0.0145822,-0.22522,-0.130116,0.551007,-0.408171,1.09833,0.576,-0.0711546,0.454851,-0.318901,0.341268,0.0969721,-0.658582,0.0331057,-0.220622,0.240449,0.174615,0.371165,0.136873,-0.609386,0.316216,0.21498,0.518026,-0.210004,-0.332837,0.619357,0.176811,0.0115099,0.284259,0.0610042,-0.27185,0.249952,-0.364948,0.0474814,-0.132377,0.0165097,-0.758707,0.206702,0.215967,0.486489,0.391004,-0.365943,0.217871,-0.210948,0.31099,0.619351,-0.318681,0.163341,-0.109499,-0.266101,1.28467,-0.236694,-0.371278,0.597167,-0.174084,0.0947108,0.203999,0.112302,0.365716,-0.340004,0.00823558,-0.467704,-0.0240743,-0.170083,-0.437481,0.11167,0.301834,-0.658145,-0.435141,-0.648615,-0.38083,0.625392,-0.387028,0.485258,0.494347,-0.565668,-0.364674,-0.948207,0.646723,-0.399779,-0.481916,0.13046,-0.447063,-0.114286,0.214565,-0.423916,0.0609158,0.163031,0.169109,0.337429,0.0297388,-0.525129,-0.326622,0.445288,-0.948751,0.646867,-0.283172,-0.497166,0.430686,0.186973,-0.225324,-0.0239969,0.109527,-0.0790404,0.407616,0.305937,0.134068,0.0271664,0.211542,0.146553,-0.500688,-1.13823,0.0846562,-0.13419,-0.578461,0.136339,-0.0832005,-0.00717319,0.540097,-0.118791,0.14664,0.324053,-0.333219,0.0988049,-0.0534085,-0.480096,-0.268434,-0.387246,-0.269195,-0.597512,0.258205,-0.316423,-0.433708,-0.0565139,0.322074,0.318297,0.369118,0.235303,-0.598528,0.165499,-0.0338043,0.408996,0.34456,-0.126466,0.156931,0.451112,0.396146,0.671649,-1.23619 +3385.04,0.854833,0.0912059,4,1.69185,0.975774,-0.228708,-0.120017,0.120375,-0.0611038,0.141254,-0.417925,-0.07739,-0.110892,-0.176965,-0.408677,-0.652766,0.493614,-0.0211526,0.52521,0.337064,0.118767,0.0426439,-0.236835,-0.912142,-1.07235,-0.682592,-0.0516632,-0.604746,-0.647091,-0.300166,0.0257203,-0.250868,-0.116766,0.421363,0.186276,0.466044,0.11772,-0.108092,-0.2013,-0.749578,0.464733,0.734657,-0.407132,1.42854,0.472698,-0.417102,0.0233366,-0.31995,-0.742574,-0.690488,0.0929698,1.0888,0.0162537,-0.1692,0.137572,0.268777,-1.53447,0.899522,-0.113956,-0.483147,-0.537543,0.214369,-0.211934,-0.0273023,0.979883,-1.00409,-1.26349,0.127812,-0.274257,-0.0294582,0.192278,0.228026,-0.187694,-0.286125,0.609373,0.331906,-0.389947,0.444406,0.391975,0.0986947,0.271448,-0.215449,0.921481,0.435246,-0.201926,-0.125534,0.329055,-0.0558973,-0.369985,-0.862882,0.165193,-0.0600921,-0.0232411,-0.307251,0.0503325,0.181302,-0.026442,0.440967,0.187434,-0.12825,-0.0748785,0.0388978,0.018927,-0.398149,-0.437878,-0.528901,0.342438,0.265109,-0.0586322,0.290399,-1.19224,0.524124,1.08238,0.229869,-0.507735,0.347005,0.602899,0.386284,0.323556,-0.278777,0.710468,0.0758867,-0.00660004,-1.20255,-0.0577785,-0.939641,-0.756833,-0.0928685,0.966054,0.653058,0.389112,-0.218095,0.0950152,0.254894,0.0422538,0.330383,0.853763,-0.281929,-0.20598,-0.412754,-0.0239741,0.440295,-0.914502,-0.437094,0.12303,0.373336,-0.275121,-0.234877,0.511745,-0.0205709,-0.040913,-0.014239,0.255007,-0.449443,0.308158,0.0929666,0.0425254,0.272705,0.167369,-0.239921,0.277997,-0.631339,0.00395809,0.241553,-0.284471,0.433968,0.0336421,-0.397308,0.511542,-0.13641,-0.276098,-0.0395635,-0.123417,0.149566,-0.0164374,0.187425,-0.288768,-0.20616,-0.38856,0.225051,-0.301548,0.497496,0.51087,-0.0524964,0.290227,-0.179942,-0.280498,0.360515,-0.246434,-0.385317,-0.015652,0.200851,-0.685396,-0.242547,0.0591895,0.413169,-1.22517,-0.397645,-0.0272041,-0.102933,0.288132,-0.738558,0.221731,0.270967,0.376173,0.114591,0.0309819,0.627491,-0.482381,-0.250329,0.826096,-0.513962,0.316884,-0.215601,0.125944,0.238488,-0.488264,0.177141,0.083283,0.102999,-0.254946,-0.117965,0.475767,-0.109367,-0.137294,-0.328134,0.224406,-0.240443,0.185232,-0.387515,-0.0168069,-0.0171278,-0.0490519,0.272702,0.030499,-0.54157,-0.187939,-0.206029,0.83791,0.289833,-0.492672,0.464355,0.181466,-0.439069,0.427475,-0.119035,0.288439,-0.0522722,0.396983,0.15048,-0.0394276,0.234899,-0.34478,-0.482699,-0.239157,-0.321126,-0.346475,-0.679216,0.299183,0.466187,0.850999,0.0722681,0.10218,0.325621,0.0952827,-0.0332802,0.311728,-0.0226812,0.0108164,0.417417,-0.450665,-0.482098,-0.320673,-0.557195,-0.0840781,-0.592383,0.266568,-0.447042,0.0247714,-0.085511,-0.696082,0.394533,-0.137885,0.100646,-0.589632,0.185732,0.312243,-0.137882,0.401327,0.353862,-0.135809,-0.0160971,0.0134947,0.417362,-0.257501,0.505193,-0.022149,0.246468,-0.489499,-0.371138,-0.543805,-0.170952,-0.573422,0.318159,0.140067,0.192107,0.374256,0.4383,-0.183623 +3404.32,0.958226,0.0912059,5,1.62038,0.932509,-0.409121,-0.0726004,-0.378262,-0.020993,0.443002,0.0892674,-0.329594,0.51403,-0.0207588,-0.0916555,0.0209186,0.657732,0.0246564,0.594125,0.0773868,-0.19859,-0.487091,-0.166212,-0.599787,-1.20121,-1.22754,0.0585282,-0.484501,-0.172974,-0.0483691,0.142667,-0.259399,-0.101868,0.401148,-0.608968,-0.298264,0.014938,-0.137918,0.206493,-0.194165,0.225251,-0.264034,-0.391139,1.49903,0.841244,-0.212815,-0.502465,0.289176,0.111549,-0.794218,-0.230864,0.985271,-0.351734,0.141747,-0.247188,0.526738,-0.282888,0.817289,0.000207316,0.000141274,-0.551281,0.0727509,-0.32307,-0.158875,1.01961,-0.990664,-0.994313,0.0253591,-0.0304529,-0.245229,0.223215,-0.0143297,-0.558029,-0.182385,0.134101,0.719167,-0.144396,0.784962,0.415127,0.0728487,-0.222081,-0.232256,-0.2063,0.704496,-0.155131,0.554629,-0.549019,0.221497,0.270861,0.661599,0.0757908,-0.14749,-0.436601,-0.555663,-0.198336,-0.326896,0.431468,-0.0503005,0.287428,-0.326189,-0.346913,0.321198,-0.336614,0.0592516,-0.0474771,-0.687649,-0.318586,0.0683962,-0.232344,1.05132,-0.406136,-0.094602,1.12022,-0.0273243,-0.66539,-0.168081,0.698895,-0.160835,0.280824,0.0367338,0.314016,0.410377,-0.0479081,-0.328008,-0.284974,0.23785,-0.5117,-0.431405,-0.0330524,0.603828,0.0109994,0.157215,-0.817082,0.409112,0.0758178,-0.252848,0.402436,0.0698723,-0.248992,0.472024,0.211263,0.716901,-0.280734,0.00287944,-0.0349078,0.31695,-0.783179,-0.00410264,-0.162771,0.114855,0.351953,0.0595414,-0.630381,-0.835104,-0.0775226,0.349899,0.201429,-0.232086,0.520256,0.402093,-0.419762,-0.42148,-0.514354,0.683364,0.076557,0.370894,-0.0524668,0.382351,0.546841,-0.540427,-0.139995,0.368531,0.230309,0.236268,0.0348452,0.246979,0.0579518,0.0221141,0.384729,0.232428,0.1254,0.234609,0.825112,0.188785,-0.302185,-0.0252163,-0.39295,0.378554,-0.195927,0.107807,-0.391902,0.367477,-0.377188,0.153569,-0.235991,0.173015,-0.67859,-0.0675798,0.137514,-0.0793413,0.0742561,-0.217824,0.735933,-0.119345,0.2631,0.13921,0.241708,-0.384247,-0.0273906,-0.896317,1.28001,-0.455238,-0.574383,-0.277958,-0.540369,0.27953,-0.101348,-0.0396529,-0.170595,-0.539851,0.100173,-0.000412563,-0.546042,-0.277429,0.0507033,-0.0448451,0.214398,-0.465873,0.156862,-0.20088,-0.442816,0.158297,-0.212728,0.156655,0.575086,-0.044611,0.00585224,-0.3309,1.16488,0.097198,-0.0980322,0.18854,-0.557477,-0.325176,0.55751,-0.541654,-0.260179,0.43769,0.183604,0.121353,-0.0118692,-0.633633,-0.726732,0.477872,-0.945527,0.356091,-0.102867,0.168,0.774987,-0.277749,-0.0528668,0.228084,0.019931,0.437994,0.566232,0.60442,0.32526,-0.149085,0.326265,-0.282145,-0.166523,-0.481158,0.179091,-0.0213981,0.121836,-0.5857,0.241516,0.439059,0.473492,-0.287252,0.566764,0.258106,-0.0481196,-0.195685,0.0192403,-0.372644,0.153482,-0.395535,0.487937,-0.00886193,0.00770939,0.0348297,0.485298,-0.0620954,0.177164,0.1966,0.437344,0.167315,-0.0837567,0.354568,-0.420725,-0.218213,-0.0183205,-0.0295807,0.148326,0.534029,0.385131,0.730773,1.51656 +3411.65,0.851648,0.0912059,4,1.57208,0.865941,-0.241314,-0.0477184,-0.353152,-0.0157135,0.604931,0.170461,0.295903,0.386825,-0.207269,-0.103553,-0.124918,0.576978,0.135829,0.894852,0.308111,-0.201293,0.0743302,-0.375265,-0.309615,-0.756017,-1.14963,0.110378,-0.223108,-0.196723,-0.615982,-0.0586114,-0.290803,0.119501,0.635923,-0.958851,0.23049,-0.0152045,-0.663282,-0.0137849,-0.343949,0.0849474,-0.19268,-0.10775,1.45384,1.00268,-0.222933,-0.26866,-0.0133477,-0.169429,-0.892059,-0.254279,1.09102,-0.145657,0.383977,-0.122685,0.379973,-1.13527,1.06715,-0.0743377,-0.4179,-0.646861,0.184906,-0.225781,0.134802,0.749645,-0.887318,-1.15915,-0.277106,-0.499566,0.0373694,-0.0585033,-0.333128,-0.442184,-0.543203,-0.0891055,0.439669,-0.282969,0.709845,0.551068,-0.106763,-0.0711,0.211398,-0.146743,0.127333,-0.126107,0.16409,0.0688581,-0.57525,0.474278,0.429999,0.209465,-0.26319,-0.0921438,-0.187873,-0.244579,0.258813,0.548955,0.106557,-0.424601,-0.395797,-0.318652,0.407252,-0.286924,0.0860032,-0.164465,-0.68336,-0.258995,-0.300176,-0.436792,0.190467,-0.532301,0.751453,0.723357,-0.269515,-0.604831,-0.128996,0.462498,-0.00556215,0.426936,0.0648446,0.53396,0.105129,0.364467,-0.948074,0.0210391,0.493316,-0.602378,0.0138851,0.0457942,0.196888,-0.15584,0.178354,-0.211165,0.174102,-0.00585814,0.185502,0.322647,-0.180691,0.500889,-0.0942752,0.00544049,0.610342,-0.620356,-0.275978,0.354845,0.312698,-0.928982,0.378592,-0.571377,0.112713,0.296135,0.121225,-0.119381,-0.46716,-0.121479,0.289359,0.362796,-0.118213,0.362585,0.313446,-0.143106,-0.039522,-0.478102,0.27996,-0.0237613,0.428313,0.0163062,0.304428,0.518468,-0.450459,-0.207409,0.101667,-0.494722,0.259147,-0.415826,0.155936,-0.222221,-0.350913,0.204166,-0.107009,0.236481,0.376923,0.755777,0.638745,-0.000749792,0.237566,-0.0808233,-0.478368,-0.320431,-0.481661,-0.148515,-0.364669,-1.47737,-0.0535124,0.6556,0.116444,-0.422447,0.0407693,0.292778,0.702611,-0.118799,-0.604956,0.932549,0.250326,0.259511,-0.596085,0.173104,0.0784203,-0.039985,-0.302886,1.11177,-0.219298,-0.0411983,0.167876,0.0414931,0.276454,-0.215766,-0.146156,0.240188,-0.111568,-0.00492233,0.127011,-0.693967,-0.392172,-0.381066,-0.0320246,0.514785,0.0434954,0.386303,-0.0318511,0.102418,0.212569,0.272012,0.125113,0.0157197,-0.0607492,0.0843525,-0.288811,0.73977,0.279449,0.258507,0.735584,-0.604044,0.758692,0.3238,-0.0784004,-0.656964,0.919893,0.217303,-0.227281,0.125126,-0.29617,-0.0775175,-0.505022,-0.55716,0.296334,-0.383197,-0.0539015,0.498879,-0.260956,0.0109206,-0.188618,-0.277917,-0.177178,0.569371,-0.02684,0.35559,0.112397,-0.0529776,0.424833,-0.0616707,-0.359135,0.02742,0.384297,-0.0659352,-0.00752533,0.275589,0.682298,-0.102482,-0.192399,0.0363143,0.51091,-0.191242,-0.258719,-0.311524,-0.17235,0.25975,0.0840657,0.525055,-0.103599,0.299138,-0.440175,0.347751,0.325073,-0.360303,0.00694124,0.156507,0.0909152,-0.0987559,0.351421,-0.244502,-0.314131,0.131587,0.11519,0.139269,0.20649,0.373188,0.454412,1.3895 +3431.52,1,0.0912059,5,1.4922,0.961452,-0.282515,-0.0756314,-0.719773,-0.0335505,-0.167952,0.628391,0.141361,1.02912,-0.0543098,0.128409,0.372449,0.586412,-0.146334,1.05521,0.131948,-0.475491,-0.257397,0.137986,-0.455445,-1.05758,-0.411597,0.373663,-0.0137196,-0.186416,0.223726,0.033281,-0.481556,0.233375,0.987137,0.337487,-0.519588,-0.0744516,-0.387167,0.385975,-0.402937,0.480316,-0.252754,-0.812037,1.33832,0.26778,0.0448246,-1.08441,-0.274497,0.177386,-0.471782,1.00351,1.00216,-0.406931,0.588532,0.403931,0.0618255,-0.532685,0.754684,0.217563,-0.0337071,-0.220597,0.422203,-0.0594627,0.292293,1.39332,-0.686197,-0.80149,0.102034,0.616752,0.0161767,0.290323,0.165574,-0.578553,-0.30631,0.487758,0.804537,0.0430099,0.315613,0.554852,0.651502,-0.421505,-0.38087,0.38977,0.922482,-0.5564,0.219254,-0.000904939,-0.0801032,0.121333,-0.430098,-0.183161,-0.222187,-0.341318,0.313687,0.564652,-0.440353,-0.00811099,-0.174507,-0.265737,0.64608,-0.0190107,0.195546,0.0506103,0.349872,-0.463813,0.222209,-0.597314,0.299937,0.118248,0.322078,-0.375611,0.430005,0.3476,0.333772,-0.0882944,0.177234,0.741934,-0.255512,0.370934,-0.0410625,-0.0347401,0.401143,-0.622233,-0.652495,0.492603,-0.133791,0.633742,0.101497,-0.145934,0.156103,0.0656727,0.17492,-0.586755,0.126928,0.0737458,0.429259,0.571434,0.370975,-0.0527665,-0.213682,0.101892,0.367261,-0.307413,-0.118027,-0.355265,-0.0644311,0.00723445,0.304254,0.696892,0.435943,0.00539317,-0.092889,-0.668803,-0.373494,0.572459,0.579629,0.0676464,0.0562404,0.323472,0.605598,-0.156476,-0.0469373,-0.011794,0.425995,0.018726,1.00064,0.0955658,0.0318277,-0.101531,0.0491376,0.119723,-0.223616,0.0892756,0.097794,0.418963,0.299251,-0.394016,0.236442,-0.0617851,-0.343587,0.0997605,0.156979,0.424796,-0.404218,0.296192,-0.111728,0.30525,0.00106574,-0.0487764,-0.214243,-0.395255,0.173026,-0.124163,0.0706658,-0.000678532,-0.175432,-0.322472,0.4419,0.0122958,0.264633,-0.57556,-0.746587,0.253161,-0.152346,-0.481592,-0.182918,0.621834,0.0249658,0.17917,-0.706075,0.986052,0.355653,0.407178,0.110483,0.255433,-0.074495,-0.109845,-0.0438262,0.36567,-0.161379,-0.0318533,0.14216,-0.151007,0.371118,0.0572665,0.27797,0.272351,-0.511233,0.231432,-0.122148,-0.165159,0.17357,0.158911,-0.31211,0.545228,0.111405,0.0961535,0.0342277,0.421127,0.412668,-0.092363,0.00497901,-0.434192,-0.204191,0.450006,-0.189767,0.0672949,-0.239033,-0.0505148,0.416664,0.296008,-0.13749,-0.315933,0.386375,-1.43603,0.593011,0.136066,-0.0440374,0.592309,-0.0966401,-0.339586,0.182826,0.205075,0.349935,-0.027673,0.449357,0.0822202,0.242795,0.234922,-0.440962,0.255276,-0.524437,0.301945,-0.385898,-0.197104,-0.346376,0.255097,-0.266457,0.546228,-0.0987388,-0.0966296,0.396304,0.279882,0.0141634,-0.35813,-0.648805,-0.416033,-0.26578,-0.253903,0.0288906,-0.178922,0.42555,-0.059323,0.118715,0.381595,0.216096,0.20122,0.188802,-0.234601,-0.17906,-0.165341,-0.100875,-0.0662289,-0.150152,0.136256,0.360814,0.369128,0.600678,2.41044 +3423.02,0.931944,0.0912059,4,1.45763,0.952709,-0.4851,-0.0114621,-1.19153,-0.0872931,0.129048,0.36146,0.21727,0.472451,-0.551198,-0.121018,0.0297433,0.848284,0.221587,1.00799,0.442586,-0.675702,0.00291837,0.178745,-0.269367,-1.27609,-0.750964,0.310462,0.0533332,-0.273518,-0.362298,0.142614,-0.279226,0.320929,0.823834,0.364647,0.148457,-0.277824,-0.449354,0.52961,-1.06916,1.16838,0.265374,-0.63094,1.4441,1.01365,-0.26181,-0.890508,-0.239961,0.000180559,-0.818744,0.630888,1.14777,-0.218818,0.696099,-0.695964,0.243408,-0.520213,0.738616,-0.188213,-0.177409,-0.178656,0.43099,-0.00729752,0.107153,1.22098,-0.832161,-0.696833,0.607613,0.348192,-0.200576,-0.0919954,0.384353,0.084542,-0.592543,0.443919,0.751606,0.319701,0.322158,0.530751,0.856372,-0.0137177,-0.453051,-0.0370776,0.969921,-0.57552,0.0256291,0.0187013,0.203096,0.0126538,-0.527506,-0.712975,-0.441507,-0.367346,-0.210906,-0.00373162,0.158698,-0.175994,-0.0644872,0.271987,-0.346467,-0.0512931,0.134057,0.131687,-0.0897733,0.105199,-0.267479,-0.0685047,-0.297139,-0.196615,0.611016,-0.280999,0.0214124,0.412548,-0.195623,0.048184,0.0255401,0.624311,0.391206,0.237567,-0.0349774,0.272511,0.49977,-0.161309,-0.731642,0.10704,-0.938536,0.317814,-0.573544,-0.339698,0.38826,0.242174,0.433552,-1.0805,0.56833,0.420632,-0.104385,0.222767,-0.0821397,0.0650147,-0.0652264,0.341854,0.567273,-0.239221,-0.277945,-0.0370095,0.731035,-0.489581,0.119199,0.21582,0.232018,-0.235493,-0.0628792,-0.0275112,-0.736258,-0.0425423,0.154549,-0.117956,0.450208,-0.381788,-0.23165,0.177901,0.023223,-0.0138815,0.466627,-0.127908,1.04137,0.109884,0.329602,-0.294859,-0.285746,0.0742084,0.0272298,0.339662,0.398471,0.0806006,0.173306,-0.057339,0.0349229,-0.220362,-0.874083,0.317221,0.475936,0.273495,0.00127569,0.0156086,-0.118587,-0.478459,-0.27901,-0.679765,-0.317323,-0.463953,0.423572,0.314728,-0.0118258,-0.241783,-0.0143979,-0.452238,0.140696,0.0257765,0.0840482,-0.34571,-0.732282,0.0903152,-0.120795,-0.221586,-0.229743,0.0711747,-0.0898211,0.47468,-0.231774,0.805579,-0.36148,-0.0375442,0.0429245,-0.0220994,-0.0117319,-0.0320149,-0.771703,0.422572,0.106741,0.208699,0.42479,-0.26374,0.10475,-0.248236,0.132044,-0.126252,-0.485759,0.504235,0.0915251,-0.292547,0.346518,0.0864077,0.204451,0.284711,0.130504,-0.108685,-0.479895,0.626945,0.679409,0.447671,0.0818427,-0.407488,0.197112,0.0776544,0.403886,-0.33995,0.335114,-0.608671,0.320094,0.135847,0.233382,0.120712,-0.0708456,-1.21026,0.494874,0.287811,-0.0459496,-0.0259287,-0.304647,-0.331504,-0.0659033,-0.111078,-0.34637,-0.186682,0.286725,-0.136268,0.213824,-0.32691,0.078641,-0.00468111,-0.0120016,0.444544,0.110629,-0.47617,0.16856,0.311164,-0.537042,0.445213,0.0284701,-0.278874,0.677308,0.389228,-0.248038,-0.116477,-0.714111,0.313571,-0.0959097,-0.0405149,0.406227,0.108426,0.206412,0.618713,0.471909,0.0100447,0.00653165,0.230635,-0.0781651,-0.171418,0.408229,-0.635335,-0.246389,0.238751,-0.421314,0.130316,0.370544,0.360994,0.608723,4.01648 +3418.43,0.467215,0.0912059,5,1.51349,0.954185,-0.469166,-0.0604269,-1.07941,-0.042217,0.158245,0.447488,-0.37991,0.832873,-0.551768,-0.170659,-0.0575396,0.738482,0.538381,1.03273,0.476192,-0.490509,-0.0870386,0.486245,-0.482677,-1.27297,-0.230933,0.228191,0.179055,0.138262,-0.507954,0.19235,-0.581231,0.202184,0.772315,0.198582,-0.0117467,0.184002,-0.406469,0.526943,-1.2282,1.1787,-0.188082,-0.686743,1.41326,0.963784,-0.0216507,-0.865894,-0.230508,-0.113544,-0.896383,0.648579,1.19624,-0.147818,0.776011,-0.65121,0.199961,-0.802161,0.841672,-0.0357099,-0.263403,-0.338331,0.292037,0.165815,0.328565,1.35433,-0.69948,-0.83025,0.932603,-0.0886358,-0.260617,-0.258814,-0.0466441,-0.129525,-0.105676,0.390113,0.542069,-0.230156,0.263625,0.168317,0.575577,0.0893452,-0.316796,0.242324,0.543842,-0.753661,0.293543,-0.356655,-0.0832724,0.39521,-0.55137,-0.552067,-0.110602,-0.400939,-0.128658,-0.307962,-0.117741,-0.387332,-0.129589,0.0713459,0.259174,0.203873,0.252003,0.117117,-0.0261413,-0.0841107,-0.442847,-0.122529,0.0819242,-0.0794039,0.965805,-0.0211094,0.191882,0.751041,0.0215942,0.170797,-0.0624617,0.496871,-0.102612,0.211988,-0.501437,0.315695,0.30943,-0.349687,-0.605582,0.318258,-0.560915,0.190318,-0.202818,-0.38188,0.339363,0.0344662,0.33627,-1.0693,0.860079,0.144467,0.122291,0.36223,-0.137538,-0.0650133,0.288235,0.204025,0.305875,-0.342164,-0.250026,0.00748492,0.393597,-0.334697,0.101241,-0.0885546,0.468503,-0.0470558,-0.070781,-0.0438953,-0.450528,0.167274,0.0611642,-0.12731,0.615618,-0.152711,0.0929115,0.0244595,0.114596,-0.0627218,0.101948,0.532639,0.659849,0.342266,0.180211,-0.153095,-0.190077,-0.200665,-0.106723,0.0110437,0.475676,0.108745,0.171495,0.13568,0.366095,-0.146353,-0.316854,0.347129,0.00613043,0.270994,0.142224,-0.000552362,-0.210003,-0.679902,0.0199678,-0.335394,-0.447406,-0.507556,0.38814,-0.0498956,0.0813689,-0.306213,0.0283303,-0.713125,0.258908,-0.416967,0.0705578,-0.27166,-0.146052,-0.224527,-0.0575565,-0.489112,-0.474211,-0.142018,0.402896,0.0943159,-0.398878,1.00279,-0.571054,-0.0503845,-0.081786,-0.0595946,-0.14,-0.372996,-0.445367,0.853669,-0.111865,0.304118,0.119762,-0.0729824,0.0911612,-0.515217,-0.0059961,0.0497492,-0.749509,0.323774,0.0381644,-0.0769207,0.0163096,-0.152534,-0.211496,0.436801,0.135997,-0.265618,-0.131807,0.296024,0.657608,0.241732,-0.0137516,-0.583793,0.242154,0.274733,0.0426308,-0.0669145,0.580278,-0.770536,0.201701,0.371081,-0.437662,-0.013658,-0.282313,-0.78364,0.0445903,0.0248405,-0.640661,-0.0216434,-0.0305395,-0.361709,0.215364,0.0761552,-0.136333,-0.251201,-0.0440575,0.295549,0.301653,-0.191013,0.118966,0.651322,-0.827652,-0.164829,0.336536,-0.413199,0.698474,0.29919,0.105915,-0.230068,-0.0370089,-0.409653,0.681563,0.603181,-0.0996963,-0.205705,-0.666828,0.270921,0.0126915,0.229631,0.0960693,0.170899,0.0654868,0.303195,-0.0253173,0.334082,-0.328491,0.389342,-0.429152,-0.568144,0.0876175,-0.217387,-0.0667724,0.30878,-0.396333,0.11457,0.453722,0.338483,0.673589,3.72431 +3436.82,0.998255,0.0912059,4,1.43618,1.00001,-0.137514,-0.295729,-0.673401,-0.11056,0.0184639,0.131501,0.434085,0.539687,-0.142493,-0.428657,-0.148425,0.414997,-0.0410733,0.836745,0.496995,-0.395084,-0.352078,-0.125556,-0.390613,-1.14852,-1.01293,-0.0296847,0.025905,-0.484018,0.0698185,0.300088,-0.467967,-0.0330512,1.05276,-0.294275,-0.44942,-0.569827,-0.0257997,0.714121,-0.575065,0.140166,0.0154615,-0.49841,1.89962,1.18439,-0.572512,-0.221781,0.230924,-0.277545,-0.643886,0.397135,1.25848,-0.110841,0.747803,0.349298,0.8297,-0.343514,1.33069,0.7095,0.266121,0.0622742,0.730322,0.144949,0.611134,1.49091,-1.56995,-1.3195,0.0545045,0.509636,0.265468,0.266658,0.470136,-0.615999,0.163586,0.570712,0.775385,0.13369,0.861796,0.127343,0.399393,0.161516,-0.105383,-0.0298386,0.569187,-0.241447,0.343763,-0.332716,-0.218585,-0.201838,-0.00183182,-0.00493674,-0.19266,-0.372716,-0.101132,0.530113,-0.134092,0.540152,-0.070674,-0.0272272,0.18498,-0.503102,0.00136947,-0.0999074,-0.0828987,0.448617,-0.412085,-0.0221129,0.161836,0.0580292,-0.298157,-0.728735,0.332818,0.575191,0.186752,-0.478733,0.283843,0.650895,-0.179017,0.0731825,-0.110349,-0.0440669,0.191861,0.195308,-1.11488,-0.0076895,-0.094664,-0.217883,0.117933,0.0855065,0.582201,0.0633791,-0.0445226,-0.162741,-0.0556256,-0.0665239,-0.174823,0.358771,-0.450211,0.0849031,-0.242975,-0.254647,0.395504,-0.257207,-0.0923303,0.0851972,-0.0194502,-0.536337,0.402108,0.11402,-0.44119,0.456992,-0.223464,-0.257405,-0.609546,0.293443,-0.0164912,0.248404,-0.294145,0.147679,0.263161,0.597463,-0.199642,-0.262315,0.18067,-0.156676,0.871277,-0.0614043,0.255644,-0.223875,0.147561,-0.356846,-0.380044,-0.656483,-0.26893,-0.36731,0.176019,-0.091582,0.260869,0.126483,0.0690727,0.20836,0.141332,0.29824,0.366477,-0.535619,0.26133,0.555216,-0.143323,-0.551743,-0.0361444,-0.0896503,-0.0704518,-0.464079,0.236798,-0.056863,-0.364156,-0.562211,0.22213,0.301241,0.182389,-0.255619,-0.640568,-0.272133,0.0543007,-0.272077,0.0272876,-0.237313,-0.609391,0.247212,-0.36676,0.595951,-0.0996569,-0.0676517,0.349749,-0.120675,-0.268114,-0.257035,0.12912,0.222256,-0.351467,-0.24326,0.356066,0.00865544,0.237396,-0.507056,0.304426,0.268074,-0.456677,0.395354,0.134561,-0.395768,0.0464648,-0.0890683,-0.190882,0.0426029,-0.441955,0.288497,-0.24526,0.528763,-0.282176,0.270437,0.379741,0.170591,-0.861485,-0.0913043,0.295608,0.1425,-0.224528,0.173524,0.502993,0.429527,-0.332509,-0.313523,0.322792,-0.756149,0.0625787,-0.199622,-0.221045,0.440218,-0.642996,0.26566,-0.54096,0.356854,-0.0977699,0.481604,0.363478,-0.0442776,0.225033,-0.0643669,-0.37365,-0.18343,0.0261513,0.0922176,-0.165321,0.01708,-0.699515,-0.596794,0.0839265,-0.400123,-0.23242,-0.811515,0.168154,-0.0290609,0.009318,0.137747,-0.0948691,-0.139527,-0.135458,0.606298,-0.531187,0.272506,0.0440004,-0.54375,0.318347,-0.309737,0.395953,-0.143391,0.0304989,-0.0256968,-0.0652303,-0.435682,-0.221045,-0.122994,0.482639,0.122712,0.488744,0.350303,0.699102,2.28411 +3410.56,0.599337,0.0912059,4,1.4828,0.859319,-0.689753,-0.00820481,-0.887153,0.00507592,0.0600797,0.173114,0.186382,0.138821,-0.0571361,-0.455963,0.0579501,0.777701,0.210531,0.805008,0.34398,-0.279908,-0.508258,0.127677,-0.266424,-1.27185,-0.830001,0.289845,0.136029,-0.651404,-0.0522752,-0.0657594,0.0766254,0.165685,0.997586,-0.707326,-0.643898,-0.209635,-0.15429,0.436435,-0.502903,1.3607,0.593935,-0.347206,1.6512,0.74994,0.320657,-0.469104,-0.425702,-0.303861,-0.454551,0.806248,1.13966,0.386469,1.24756,0.231984,0.607726,-0.249222,1.16254,-0.068704,-0.204904,-0.0580762,0.626812,-0.171702,0.462722,1.57312,-1.16375,-0.985341,0.926849,0.0561897,0.0437363,0.035999,-0.00092196,-0.366458,-0.0277989,0.389851,0.461487,0.150859,0.2023,0.421852,0.209482,-0.137045,-0.207126,-0.0354586,0.603414,-0.221782,0.114418,0.469166,-0.247798,-0.701822,-0.0500821,-0.210545,-0.0847931,-0.586843,0.13324,-0.354958,0.321036,-0.039217,0.0889019,-0.650906,-0.723822,-0.166802,0.633544,0.00408497,-0.246224,-0.116738,-0.237426,0.0452412,0.466243,-0.210844,0.669677,-0.0530961,0.367512,0.404179,-0.607031,-0.233039,0.00957944,0.458867,-0.0594075,-0.101291,-0.392959,0.570846,0.507611,-0.100257,-0.870558,0.0816372,0.0855144,-0.670797,-0.367559,-0.145518,0.0411409,0.775361,-0.130982,-0.205372,0.652245,0.119187,0.0848585,0.230414,-0.0476199,0.0561576,-0.0786939,0.0665958,0.0555966,0.0298012,-0.314114,0.201812,-0.357609,-0.171105,-0.0595851,-0.341374,-0.255525,-0.126215,-0.557403,0.171503,0.107055,0.411919,0.488478,-0.259993,0.642405,0.384166,-0.132293,0.115456,-0.19203,-0.09998,0.142053,-0.134656,0.821129,0.160072,-0.00242196,-0.443217,-0.0615689,-0.340908,0.152542,-0.223475,-0.493015,0.16548,-0.0233169,0.533068,-0.0360622,0.253622,-0.641518,0.168131,-0.0639635,0.260218,-0.0580378,-0.00688537,-0.382897,-0.67252,-0.0604459,-0.472199,-0.12434,-1.00266,0.873735,-0.555965,0.0388869,0.151218,0.278903,-1.01736,-0.0595721,0.203971,0.335911,-0.0631091,-0.184482,0.320896,0.107491,-0.439796,0.221353,-0.346879,-0.0377774,-0.188675,-0.535632,0.754818,0.177427,-0.216266,-0.0530617,0.386292,0.267369,0.485943,-0.447464,0.18473,-0.3525,-0.0933658,0.629469,0.306506,-0.241113,0.369801,-0.374755,0.363082,-0.313148,0.358113,-0.388615,-0.397852,0.965158,0.10108,-0.308329,0.340167,-0.249349,-0.389538,-0.789876,0.325736,0.226961,0.0974395,-0.0406111,-0.251321,-0.404692,-0.630397,0.159406,-0.553147,0.0174028,0.0282289,-0.0929265,0.410655,-0.42068,-0.537613,-0.528755,-0.240742,0.136167,-0.339217,-0.578296,0.459052,0.199244,-0.00735984,-0.268615,-0.149871,-0.0176164,0.389156,-0.377455,0.130401,0.540046,-0.257837,-0.320836,0.033279,0.258416,0.364419,-0.33303,-0.287499,-0.0204188,0.225486,-0.154851,0.283268,-0.288985,-0.0682699,0.855729,0.320983,0.358647,-0.97492,-0.077347,-0.0257566,-0.14329,-0.0862145,-0.52113,0.117602,0.0968066,-0.0973741,-0.108924,-0.0648725,0.526278,0.713396,-0.206168,-0.283027,-0.0477491,-0.322256,0.10384,0.51959,-0.380704,0.131916,0.452195,0.363203,0.672455,3.27764 +3417.34,0.405469,0.0912059,4,1.37329,0.823478,-1.0659,0.130231,-0.742739,0.00867457,0.485078,0.137591,0.320119,0.160151,-0.123021,-0.621343,-0.345598,0.790557,0.626221,0.947877,0.451946,-0.439381,-0.215624,0.203734,-0.39525,-1.02013,-0.574956,0.211306,-0.126591,-0.741763,-0.0701122,-0.18641,-0.131186,0.177537,1.12746,-0.577449,-0.513748,-0.101158,-0.388072,0.467751,-0.658997,1.36435,0.96739,-0.648903,1.74251,1.00345,0.482682,-0.320876,-0.183722,-0.284894,0.0283514,1.15815,1.08324,0.719007,1.21215,0.339513,0.894885,-0.673966,1.23455,-0.0116221,-0.0746875,0.069114,0.489651,-0.120126,0.66384,1.59389,-1.14447,-0.124112,0.835315,0.290994,0.283024,-0.118446,0.151023,-0.154253,0.176958,0.579083,0.858079,-0.111514,0.474749,0.529428,0.422159,-0.0548078,-0.362915,0.0101615,0.490905,-0.0915769,0.240749,0.118432,-0.0604158,0.0160265,-0.10521,-0.250986,-0.146958,-0.456023,0.015306,-0.353226,0.112355,-0.15987,0.1278,-0.613657,-0.281046,-0.347004,0.620618,0.0115336,-0.206038,-0.437297,0.000172796,-0.0139512,0.0979199,-0.517261,0.553258,-0.0438046,0.16923,0.273994,-0.142768,-0.137895,0.0310674,0.416387,-0.188135,0.103723,-0.227114,0.192377,-0.0345733,-0.155444,-1.23972,0.39286,-0.277307,-0.520447,-0.706536,-0.0975359,-0.00830491,0.327559,0.22118,0.438908,0.301392,0.253658,-0.0878278,-0.0125925,-0.22855,-0.205925,-0.34073,0.177508,0.0590876,-0.0696532,-0.247854,0.268873,-0.0439562,0.304859,-0.262123,-0.205193,-0.156383,-0.0911041,-0.34518,0.537984,-0.404866,-0.149043,0.378631,-0.0229565,0.181438,0.223721,-0.0088053,0.43187,-0.29656,-0.282499,0.405699,-0.0266954,0.805164,-0.0707281,-0.570345,-0.426611,-0.101126,-0.291957,0.0464935,-0.512115,-0.0104053,0.14135,-0.0809842,0.299135,0.144377,0.130529,-0.460623,0.200314,0.142205,0.324355,-0.105868,0.410757,-0.232293,-0.307842,-0.296329,-0.700832,0.324348,-0.63146,0.343931,-0.367428,0.0684609,-0.154184,-0.290746,-1.17828,0.00513448,-0.106732,0.207929,-0.104264,-0.00737223,-0.00950962,-0.033004,-0.131793,0.368472,-0.177173,-0.150425,0.423019,-0.378667,0.605759,0.233216,-0.284263,-0.485308,0.465236,-0.0375662,0.165453,-0.376201,-0.187631,-0.562697,-0.0126067,0.443788,0.150131,-0.251204,0.44458,-0.306577,0.377978,-0.229817,0.62201,-0.33006,-0.145848,0.589008,0.0703685,0.130626,0.0298019,-0.185612,-0.263119,-0.86278,0.75297,0.221022,-0.194298,-0.227449,-0.426913,-0.253557,-0.329999,0.258104,-0.114525,0.0613875,-0.0337119,0.241546,0.4451,-0.138695,-0.851273,-0.147376,-0.645774,0.397161,-0.107257,0.199196,0.409978,0.27674,0.30287,-0.165824,-0.074815,-0.0214008,0.174877,0.113992,-0.0399907,-0.191977,-0.0111363,-0.249032,0.381108,-0.0223629,-0.0552353,-0.201262,-0.19764,0.234035,-0.488223,-0.546005,0.332821,-0.0484904,-0.303708,1.15359,0.283726,0.110372,-0.50577,-0.225572,-0.195079,-0.175996,0.133311,-0.0530437,0.0991538,-0.171894,-0.236574,0.0374539,0.321488,0.398514,-0.0593087,-0.0691986,-0.249613,0.39403,-0.260251,-0.0911017,0.40475,-0.0873025,0.111852,0.449713,0.334442,0.670607,2.81752 +3393.98,0.853701,0.0912059,5,1.31258,0.722442,-1.09791,0.282533,-0.545366,-0.186515,0.526539,0.412212,0.142731,0.113334,-0.219104,-0.115301,-0.664138,1.43239,0.0640271,1.08527,0.63008,-0.234422,0.036293,0.442669,-0.237463,-1.03332,-1.04356,0.726281,0.023217,-0.555468,0.146971,0.221079,-0.480819,-0.0545373,1.37344,-0.10699,0.187647,0.294727,0.124512,0.518437,0.311125,0.69211,-0.0302998,0.0173606,1.77512,0.947913,-0.502876,-0.504665,0.0250665,0.576752,-0.491038,0.105246,0.603504,-0.0352801,0.664734,-0.0445239,0.389779,-0.951566,1.31508,0.547082,0.0726711,0.515462,0.825923,0.837392,0.519925,1.59559,-1.03803,-0.629069,1.48568,-0.386082,-0.474114,-0.231113,0.444485,-0.421326,-0.0781751,0.89441,0.082786,-0.151735,0.533789,0.244262,0.552983,-0.504373,-0.104107,0.200231,0.452786,-0.661259,0.231525,-0.139453,-0.124191,-0.218798,-0.28939,-0.045152,0.428285,-0.592185,0.418004,-0.178223,-0.103351,0.0157003,0.203649,-0.558514,0.265091,-0.481287,0.492817,-0.00023005,0.683165,0.201185,-0.149114,-0.118434,0.436497,-0.162211,0.0980477,0.00284159,0.0318033,0.354868,0.205162,-0.113895,0.843705,0.33064,0.0907676,-0.125259,-0.360218,-0.0477675,0.119422,0.173539,-0.410095,-0.319819,0.145997,-0.662136,-0.144954,0.439825,0.533084,0.28627,0.275877,-0.48823,-0.0151755,-0.753802,0.10854,0.125197,-0.0712765,0.363045,-0.0224665,-0.311106,0.937219,-0.15377,-0.527225,-0.283846,0.491818,-0.395035,0.455756,0.553073,0.587082,0.612242,-0.339531,-0.0987922,-0.0366108,0.528789,-0.352684,-0.173586,0.395858,0.383672,0.389759,0.042234,-0.0378483,0.264442,0.408022,0.142928,0.82558,-0.170401,-0.0354747,0.576841,0.776814,-0.00917907,-0.167528,0.431788,0.181144,0.296972,-0.0383562,-0.622498,0.244778,-0.237745,-0.509668,0.131392,0.492186,0.439639,0.587033,-0.522152,-0.045789,-0.0976231,-0.0890254,-0.413719,-0.476429,-0.00124545,0.537744,-0.403801,-0.0670953,-0.337312,-0.442525,-0.158222,0.259077,0.261118,-0.106106,-0.257187,-0.610919,-0.142783,-0.0188205,-0.0969135,0.424299,0.164391,-0.193068,-0.0939691,-0.481512,0.697516,0.117893,0.375483,0.185467,-0.783661,0.358378,-0.831262,-0.629068,0.266405,-0.311169,-0.0368745,0.00183837,-0.0751794,-0.140256,-0.186717,0.0461717,-0.424697,-0.174806,0.722101,-0.761122,-0.308921,-0.929848,-0.0964148,-1.23649,0.0787785,-0.0400144,0.0736112,-0.359665,0.215733,0.196239,0.365631,0.299557,-0.151901,-0.00683476,0.0901363,-0.557144,-0.291761,0.448752,-0.000564818,0.540134,0.174594,0.365267,0.00745757,0.0730152,-0.253521,0.510189,0.169505,-0.497183,-0.107611,-0.589197,0.17813,0.400321,0.103078,-0.0925043,0.58793,-0.178366,0.171229,-0.249207,-0.0797098,-0.247764,-0.032715,-0.130782,0.078777,0.0463117,-0.0325832,-0.753588,0.358375,0.231126,-0.170446,-0.0814336,0.55594,0.138715,-0.113221,-0.390935,-0.755387,-0.38831,0.362562,0.552693,0.0897738,-0.10865,0.235943,-0.221769,-0.281879,-0.0767104,0.245103,0.300481,-0.151472,0.0944946,-0.77599,-0.214462,-0.679576,-0.425973,-0.102051,-0.279703,0.146858,0.561918,0.38322,0.749612,2.20137 +3402.98,1,0.0912059,4,1.375,0.583229,-1.63723,0.535902,-0.853654,-0.277555,0.205928,-0.0133608,0.382953,0.296455,0.171822,0.0484021,-0.0667092,1.15746,0.619028,1.20614,0.646567,-0.204712,-0.0640273,0.858515,-0.0553759,-0.77129,-0.568347,0.54014,0.0159361,-0.441481,-0.0222701,-0.0240045,0.112033,0.0170385,1.01565,0.0380482,-1.00263,0.069987,-0.186305,0.000815456,-0.434387,1.49504,0.125816,-0.438219,1.50531,0.950973,0.384533,-0.587246,-0.117734,0.468232,-0.0337203,0.928682,1.10243,-0.0174895,0.83764,0.487012,0.410028,0.0053534,0.92431,0.671056,0.049355,0.1429,0.235489,0.0940713,0.721914,1.63882,-0.583323,-0.68712,0.346782,0.177369,-0.532787,-0.31233,0.111736,-0.216244,0.0526936,0.225954,0.713106,-0.112324,-0.128525,0.472676,0.465678,0.274484,-1.08225,0.172949,0.835483,-0.36068,0.143764,0.0247781,0.00566365,-0.274516,0.0441827,-0.125285,-0.111589,-0.212548,-0.68423,0.199012,0.0235296,-0.57214,0.21952,0.203875,-0.449999,-0.133121,-0.185546,0.375669,-0.800126,0.360951,-0.616196,0.09831,0.0540638,0.00480109,0.999923,0.10662,0.812421,0.308275,-0.409607,-0.0142137,-0.65592,0.242866,-0.195924,0.393993,-0.797079,-0.10233,0.124939,0.193644,-0.879498,0.0737775,-0.102057,-0.118334,0.0475601,-0.0714505,-0.312514,-0.128577,0.159246,-0.446729,0.333816,0.030731,-0.269769,-0.0515894,-0.315558,-0.213555,-0.427041,-0.494913,0.213971,-0.629195,-0.000913891,0.331708,-0.457103,-0.727901,-0.409294,-0.344517,-0.168268,0.383533,-0.00164172,-0.233502,-0.446599,-0.233975,0.0338642,0.149962,-0.322893,-0.0393454,0.374804,0.255312,-0.0629823,0.332409,0.538099,-0.422141,0.474901,-0.665583,-0.689545,-0.0142598,-0.311693,0.0144117,0.155815,-0.353988,0.271067,0.0876677,-0.24292,-0.166664,0.0638489,-0.461098,-0.164474,0.0648023,0.0112867,0.272214,0.533484,0.0365106,-0.0288199,-0.214787,-0.300856,-0.818613,0.358084,-0.427891,-0.08324,-0.364341,-0.0986801,-0.208216,-0.637718,-0.798469,-0.11832,-0.28539,-0.117575,-0.0106666,-0.439651,-0.351938,0.00440327,-0.539854,0.0317058,-0.537871,-0.361665,-0.263834,-0.582953,0.949101,-0.238121,0.062985,0.0148926,-0.288128,0.432992,0.23782,-0.134046,0.670577,-0.37935,0.03214,0.533072,0.420198,-0.0310242,-0.590607,-0.0306536,0.483822,0.196283,0.321402,-0.139393,-0.597676,0.398746,-0.0350895,0.67544,-0.11219,-0.419213,-0.378679,-0.392505,0.818418,-0.296507,-0.219357,0.273044,-0.266893,-0.12686,0.11512,-0.125515,0.530944,0.133954,0.240183,0.286895,0.270452,-0.33796,-0.531484,0.274107,-1.36315,0.570548,-0.010594,-0.192549,0.274848,0.560745,0.614801,0.317551,0.437189,0.196868,0.365392,0.763602,-0.399887,0.645211,0.454744,0.244603,-0.223237,-0.0864725,0.0841204,-0.560881,-0.00451016,0.134851,-0.153466,0.598514,0.416252,-0.204465,-0.0389546,0.46751,0.105965,0.463977,0.44968,-0.123511,0.155368,0.0687275,0.699031,0.383152,0.456038,0.63054,-0.334304,0.170701,-0.481685,-0.00913757,-0.058844,0.0864916,-0.823088,0.0222829,-0.199201,0.269328,-0.741752,0.0237749,0.164668,0.351812,0.405793,0.593138,3.59921 +3378.1,0.779049,0.0912059,4,1.21635,0.673075,-1.66624,0.507732,-0.299952,-0.313415,0.137509,0.391936,0.00794483,0.112791,-0.020254,-0.0185961,-0.548657,0.920838,0.381733,0.916533,0.674443,-0.114945,-0.363372,0.749568,-0.484225,-0.701338,-0.912626,0.381206,0.0798528,-0.262956,-0.232495,0.205921,-0.230621,0.115126,0.893186,0.626087,-0.616209,0.280924,0.0627309,0.343173,-0.478884,0.9673,0.280643,-0.126504,1.59409,1.57087,0.454009,-0.0816511,0.00924004,0.127457,-0.346172,0.774776,0.929526,-0.126477,0.820159,0.0107365,0.451725,-0.300903,1.4692,0.705824,0.342775,0.112971,0.804854,0.287934,0.980031,1.5522,-1.32364,0.0304879,0.484281,-0.117777,-0.239206,0.308636,0.327998,-0.567729,0.191915,-0.0249352,0.567294,-0.524669,0.687497,0.290212,0.631964,-0.240998,-0.92934,0.787223,0.618848,-0.790514,0.651351,-0.577987,-0.173278,0.00685056,-0.131067,-0.559038,-0.125015,-0.235322,-0.138607,-0.097924,-0.275787,-0.0774874,0.246776,0.452585,-1.07433,-0.615129,0.265526,0.207423,0.0387624,0.231864,-0.349614,-0.0218414,0.869877,-0.45281,0.416882,-0.0774633,0.457293,0.694171,-0.65043,-0.199893,-0.418392,0.0786303,0.252265,0.706756,-0.675144,0.351774,-0.173754,-0.263505,-0.475983,0.0812891,-0.187274,-0.090956,-0.404079,0.0131955,0.138241,-0.00260426,0.54443,-0.212248,0.2739,0.128179,-0.319524,0.430232,-0.470217,-0.135224,-0.70061,-0.480164,0.765142,-0.394314,-0.244383,-0.00381997,0.398019,-0.573888,0.451385,-0.264109,-0.51293,0.0727443,-0.120755,-0.318031,0.390103,0.309142,0.0580251,0.262131,-0.233059,0.483119,0.410026,0.17775,0.284608,-0.054883,0.145041,0.166363,0.918107,-0.046137,-0.229095,-0.379827,-0.0199619,0.380036,-0.185681,-0.372769,-0.206948,0.176003,-0.349674,0.530476,-0.0270715,0.107511,-0.298276,0.321827,0.244131,0.542958,0.392773,-0.181654,0.464228,0.271136,-0.0743058,-0.918364,0.010126,-0.591339,0.554822,-0.495542,0.00391681,-0.604052,-0.368923,-0.463711,0.259193,-0.656729,-0.226639,-0.0663333,-0.525854,-0.00912955,0.278127,0.12167,-0.0307969,-0.217955,-0.0182713,-0.111749,-0.759833,1.27374,0.0339465,-0.167761,0.0883774,0.0963675,0.221475,0.317653,-0.905617,0.350315,0.0145141,0.233726,0.390115,-0.0011198,0.0349977,-0.336406,-0.181537,0.10753,-0.00745626,0.433554,-0.04626,-0.341985,0.0283397,0.0254266,0.0561321,-0.173427,0.354424,-0.726069,-0.926581,0.27432,-0.486353,0.374036,-0.0978067,0.520575,0.408468,0.385527,0.138701,0.0872857,-0.0875019,0.0448277,0.537993,0.460583,-0.323649,-0.0618958,-0.54647,-0.259938,0.807186,-0.0260791,-0.0748237,0.108871,0.387453,0.246725,0.306617,0.809504,0.144716,-0.129567,0.302887,0.332929,0.594194,0.418234,0.291691,0.291388,0.231314,0.423118,-0.178043,0.0984293,0.551801,0.0940492,0.371428,1.15606,-0.200483,0.439195,0.326853,-0.212459,-0.0149738,0.106952,0.27663,0.12445,0.490251,0.620367,-0.138552,1.1459,0.324702,0.0763249,-0.255163,-0.1557,0.0638622,-0.121411,0.0821933,-0.226812,-0.303326,-0.129004,0.690447,-0.087226,0.0253395,0.156835,0.39689,0.396024,0.629992,1.49447 +3365.38,0.532815,0.0912059,4,1.32864,0.935466,-0.827328,0.133934,-0.818399,-0.0952176,-0.11574,0.0806912,0.193933,0.817705,-0.164164,-0.353665,0.406386,0.786956,0.516493,0.684629,0.1911,-0.0805211,0.189688,0.722375,-0.523403,-0.721755,-0.623202,0.325967,-0.0197522,-0.531017,-0.0658212,0.653508,-0.049319,-0.130697,0.886667,-0.813408,-0.0578765,-0.174166,-0.476409,0.579442,-0.119439,2.02038,0.547307,-0.178941,1.17518,0.836524,0.6763,-1.03858,-0.446403,-0.118563,-0.43305,0.472472,1.1747,-0.0148102,0.656344,1.20469,0.647344,-0.270383,1.41901,0.26701,-0.170386,0.492436,0.796028,1.16694,0.563209,1.00701,-0.166535,-1.84494,0.541876,0.288083,-0.0567724,0.211203,-0.275954,-0.198837,-0.265348,0.309919,0.737645,-0.41972,0.291361,0.716301,-0.0686285,-0.188022,-0.316954,-0.0700362,0.159847,-0.235789,0.240437,0.0875135,7.78752e-05,-0.040122,-0.605517,0.37866,0.314132,-0.0412338,0.259169,0.128331,0.365801,0.036082,-0.0168746,-0.835473,-0.474563,0.0493529,-0.0686654,0.342056,-0.565927,-0.587805,-0.26664,-0.0471678,0.0491469,-0.756865,0.650384,-0.545304,0.476295,0.554119,-0.176004,0.192839,0.364509,0.0298465,-0.0969101,-0.355763,-0.491937,-0.170663,-0.155296,-0.13668,-0.923252,0.27859,-0.240015,-0.469588,0.673925,-0.0215423,0.554198,0.201177,-0.0591063,-0.303646,0.412082,0.0842673,-0.0714012,0.369313,0.194762,-0.177967,0.225107,-0.191462,0.530466,-0.564382,-0.794939,0.284566,-0.499288,0.237022,-0.0941113,-0.41558,0.539859,0.372978,0.199367,-0.210969,-0.524678,-0.021471,0.234359,-0.202828,0.379654,-0.471555,0.0009657,0.0233035,-0.0178757,-0.269859,0.0121299,-0.209419,0.923049,0.582405,0.484162,0.460598,-0.289815,-0.358199,0.0622314,0.143519,0.490801,-0.245499,-0.595404,-0.901284,0.369806,-0.335324,-0.373868,-0.664936,0.23322,0.710919,-0.177269,-0.139047,0.627405,-0.107077,-0.0771652,-0.166782,-0.509589,0.00678384,-0.0238594,-0.318339,0.292802,0.071303,0.518981,-0.283293,-0.0721472,0.733388,-0.0943511,0.174871,-0.47303,0.491829,0.0923908,-0.339051,0.33093,0.0229225,-0.722302,0.0012335,0.332769,0.898978,-0.534519,0.0839149,0.0756007,-0.140873,0.0648672,0.160072,-0.332692,-0.0647194,0.18744,0.0693495,0.473999,-0.108097,0.24603,0.191334,-0.0292823,0.345811,0.0319524,0.192377,-0.1429,0.0957265,0.273198,-0.0878812,-0.237381,-0.391715,-0.554432,0.601022,-0.686991,0.522344,-0.186054,-0.742529,0.938948,-0.606319,0.182254,0.137341,0.00263409,-0.0482673,0.206503,0.0643814,0.457092,0.201178,0.0392792,-0.375976,0.56561,-0.202188,0.182542,-0.982203,-0.363645,0.0952965,-0.608987,-0.179086,0.119745,0.196769,0.0162169,0.673613,0.122,-0.302276,-0.413047,0.0548702,0.109224,-0.297629,-0.36986,-0.0868675,0.527788,0.049132,-0.681877,-0.373081,-0.361394,-0.73902,0.507048,-0.766618,-0.236107,0.376522,0.504338,-0.123684,-0.416507,0.623138,-0.245592,0.581215,0.429701,-0.824172,-0.103871,0.526869,-0.370071,-0.292857,0.349988,-0.402832,0.106371,-0.459786,0.60861,0.121521,-0.942661,0.250376,0.0426118,0.153672,0.476314,0.39201,0.690155,2.72317 +3381.8,0.437427,0.0912059,5,1.31854,1.04249,-1.02021,0.359276,0.3315,-0.124575,0.553245,0.705997,0.67622,0.452421,-0.204812,0.252148,-0.0920201,0.37106,0.0936438,1.1969,0.0750951,-0.114819,-0.255303,-0.240515,-0.225412,-1.12726,-0.875173,0.119371,0.158413,-0.513819,1.09299,0.389999,-0.0922988,0.176533,0.44003,-0.0222523,0.223467,0.501935,-0.224286,0.411386,-0.653117,0.461907,0.204973,-0.0849023,1.2318,1.0341,0.401554,-0.650395,-0.241858,0.502854,-0.589776,0.634044,0.619878,0.214523,0.606506,0.537146,0.485238,-0.484856,0.559274,0.322556,0.225959,-0.593632,0.885248,-1.02243,0.136805,1.18254,-0.386525,-0.389221,0.406255,0.24521,-0.0445835,-0.412333,0.305116,-0.321354,0.255183,-0.00918666,0.819049,0.229189,0.626281,0.269443,0.512618,0.0969334,-0.176421,0.169916,0.920503,-0.535794,0.368078,-0.388476,0.161702,-0.349377,0.430267,-0.615137,0.139393,-0.0495306,0.245972,-0.363229,-0.750153,0.194091,-0.265471,0.214206,0.0324664,-0.97395,0.481659,0.0815686,0.676456,0.765445,0.00875946,0.107767,0.200115,-0.0055035,-0.138231,-0.309214,0.290783,0.456252,-0.124122,-0.74664,0.107532,0.468452,-0.420568,0.248682,-0.405004,0.1158,0.80457,0.79213,-0.290329,-0.783169,0.335855,0.000866084,-0.39481,0.0955296,-0.163912,0.06708,0.745487,-0.302277,0.151366,0.25863,-0.137978,0.43088,-0.318438,-0.0827304,-0.191048,0.117425,0.148897,-0.292092,-0.314766,-0.0717948,0.462613,-0.653016,-0.204825,0.29845,-0.651145,0.371437,0.155216,0.204779,0.103712,-0.205623,0.114682,-0.463218,0.495941,0.914627,-0.0794803,-0.0350082,0.0382642,0.0477672,0.676726,0.420203,1.01799,-0.589318,-0.390716,0.00101719,-0.458043,0.0905253,-0.615187,-0.215966,-0.461681,0.0253829,-0.0178606,0.644587,0.0748009,0.29831,-0.232043,0.730354,0.5381,0.999947,-0.0214779,-0.342323,-0.0074538,-0.116347,-0.113917,0.170543,0.128788,-0.273179,0.222847,-0.715993,0.125022,-0.179021,-0.683894,-0.462529,0.334901,-0.420808,0.00656782,-0.713277,-0.0917814,0.245816,0.0403232,-0.804834,0.943248,-0.173184,0.349103,0.105201,-0.880536,1.33784,0.674949,0.203924,-0.461612,0.230576,-0.231397,0.0804868,-0.19295,0.241844,-0.649434,0.0743118,0.149241,-0.315816,0.00708824,-0.512212,0.171333,-0.175904,-0.520551,-0.00544669,-0.490972,-0.486359,-0.47958,-0.160898,0.116069,0.0778942,0.155071,-0.635773,-0.323571,0.155832,0.591981,0.828653,0.491136,-0.21084,-0.133827,0.233317,0.174703,-0.190044,0.594106,0.181385,0.64835,-0.0684001,-0.445399,0.202269,-0.569579,-0.727082,0.750355,0.722846,0.176591,0.504365,0.105796,0.476208,0.419357,0.210365,0.0595408,0.102902,-0.440632,0.100683,0.671551,0.59603,0.525634,0.404942,0.0413967,-0.181445,-0.430112,-0.60052,0.299068,-0.0289225,0.227369,0.527332,-0.412442,0.762415,0.200548,-0.0423546,-0.105379,-0.0336754,0.378874,-0.192462,-0.0709882,-0.275024,-0.623451,0.763126,-0.0450576,-0.819405,0.0710961,0.301988,-0.324609,0.410987,-0.513962,0.205765,-0.0722693,0.254314,0.171782,-0.0783176,0.380119,0.181161,0.37214,0.42563,0.610033,-1.39858 +3381.24,0.853748,0.0912059,4,1.3345,0.982213,-0.333131,0.0669946,-0.0663099,-0.244981,0.193408,0.16817,0.427855,0.192347,-0.197424,0.0843122,0.297184,0.780974,0.323484,0.908439,0.604379,-0.065146,0.303639,0.782259,-0.050995,-1.17796,-0.8275,0.1871,0.248619,-0.420866,1.16533,0.558906,0.241919,0.383981,0.480539,-0.138237,0.142959,0.939222,0.00351127,0.498106,-0.733708,0.799621,1.07606,-0.321451,1.34087,0.3464,0.44002,-0.804195,-0.283267,-0.0635641,0.00494713,0.128144,0.944929,0.108215,0.716675,0.190788,0.387386,-0.892675,0.944388,-0.433496,0.0998135,-1.0016,0.358787,-0.0140622,0.134224,0.886762,-0.491085,-1.32702,0.66386,0.543279,0.583825,-0.267419,0.46376,-0.532519,-0.209992,-0.3213,0.526992,0.0716649,1.0595,0.259137,0.578168,0.25423,-0.801265,-0.116823,0.54762,-0.645546,0.39273,-0.343206,0.149119,-0.525289,0.0345656,-0.744073,0.043448,-0.0032332,-0.0801844,0.788331,-0.599491,-0.577542,-0.0778016,-0.146939,-0.827421,-0.657463,-0.496133,-0.00833015,0.00889575,0.179858,-0.359698,-0.259616,0.679784,-0.175008,0.12921,-0.351407,0.378341,0.287604,0.0815671,0.200342,0.588243,0.323331,0.428485,-0.20341,0.438294,-0.0804787,0.470951,0.219137,-0.679328,-0.161605,0.801164,-0.652556,-0.307415,0.415094,0.0812923,0.857282,0.420928,-0.423497,0.0797941,0.012349,0.474219,0.665045,-0.0177423,0.0437535,0.202922,-0.436286,0.655078,-0.362003,0.334093,0.191435,0.432167,0.203955,-0.673539,0.487664,-0.0492983,0.403806,0.34341,-0.211553,0.663232,0.146191,0.0603453,-0.148905,-0.299762,0.569921,0.221761,0.113426,-0.0538547,-0.195033,0.32094,0.355712,1.0662,-0.538736,-0.0562724,0.407982,0.0134952,-0.0937864,-0.18606,0.190351,0.570442,-0.593857,-0.0551532,0.0433881,-0.338466,0.0447703,-0.360088,-0.288071,0.568145,0.675054,-0.223337,-0.438472,-0.0946388,0.130041,-0.0466983,0.684015,-0.356002,-0.387243,0.0737811,-0.680813,0.0223234,-0.0626804,0.105072,0.085785,-0.150662,-0.0994002,-0.129294,-0.0585516,-0.277221,0.182406,0.210589,-0.375211,0.656529,-0.848462,0.75094,-0.0532331,-0.58151,1.32193,-0.0973486,0.21844,-0.406649,-0.400378,-0.196901,0.0695715,0.118987,0.278854,0.0158762,0.1349,0.448884,-0.00509537,0.0452957,-0.426974,0.356182,0.159821,-0.662625,0.622203,-0.487229,-0.553297,0.233883,-0.130314,-0.121776,0.0410001,0.0578968,0.0428726,-0.299497,0.565799,0.0339697,0.128997,0.52182,0.14379,0.395146,-0.230512,1.0021,-0.0254374,1.21278,0.324738,0.898881,-0.0975786,0.129413,-0.362358,-0.509183,-0.625354,0.488008,0.203313,0.244047,0.509953,-0.245431,0.804347,-0.409553,0.223563,0.294669,0.962333,-0.43414,-0.311824,0.230989,-0.0309246,0.416755,-0.011073,0.335359,-0.405419,-0.420303,-0.556194,0.393283,0.195258,0.0373766,0.528894,0.300001,-0.364841,-0.205927,0.124582,0.735527,-0.321724,-0.0557649,0.130301,-0.11144,-0.100987,-0.27511,-0.0259399,-0.0397411,0.157823,0.150161,0.327397,0.167073,0.567687,-0.350077,-0.279987,0.713001,-0.0126739,-0.771841,0.448781,0.223557,0.189012,0.355924,0.434755,0.596594,-0.00913187 +3382.62,0.999567,0.0912059,4,1.35329,0.983212,-0.509047,0.167764,0.235796,-0.20933,0.551219,0.264166,0.588,0.178789,0.121432,0.00805064,0.329831,0.837576,0.383029,0.595591,0.172408,-0.14592,0.0845105,0.42005,-0.341459,-0.681251,-0.5883,0.222809,-0.364768,-0.677697,1.1902,0.148089,0.0811291,0.246193,0.823439,-0.237069,0.397417,0.57596,0.0147667,0.108863,-0.427702,0.939558,0.17581,-0.390214,1.37001,0.675322,0.245694,-0.603473,-0.531622,-0.564229,-0.128098,0.0462271,0.37132,0.255625,0.47482,0.0297066,0.305619,-0.287534,0.783783,-0.270663,0.0449054,-1.1185,0.654081,-0.107937,0.0386757,1.1108,-0.834704,-1.1673,0.61942,0.180654,0.403766,-0.24139,0.456502,-0.467262,-0.0395672,-0.161613,0.547075,-0.398029,1.18364,0.404529,1.00105,0.183358,-0.759829,-0.538853,0.855573,-0.530941,0.210263,-0.461361,0.620427,-0.588241,-0.156463,-0.727388,-0.37212,-0.194649,-0.193327,0.515325,-0.613562,0.048386,-0.0287286,-0.0107243,-0.494959,-0.562304,0.0275018,0.0525919,0.0440524,-0.325185,0.0915023,0.107129,-0.151718,-0.319931,0.329049,-0.223496,0.2813,0.382354,0.262638,0.145849,0.448553,0.48495,0.0031688,-0.206898,0.447546,0.320487,0.459128,0.194941,-0.639422,0.0817383,0.306906,-0.421882,-0.356137,0.5142,0.0375375,0.510535,0.424641,-0.274488,0.150306,0.0135299,0.226504,0.859853,-0.0141903,-0.048129,0.321684,-0.530295,0.466792,-0.767438,0.276636,-0.177909,0.184695,-0.163967,-1.17905,0.743123,-0.273108,0.433457,0.245052,-0.21131,0.172006,-0.444405,0.350858,-0.327015,0.067652,0.177619,0.0107759,-0.119235,-0.0671116,0.016482,0.391165,0.209727,1.15999,-0.76256,0.1621,0.857179,0.0189589,-0.415508,-0.424693,-0.421803,0.0219971,-0.298407,-0.0354669,0.156264,-0.294636,-0.03207,-0.532738,-0.725606,0.488502,0.670708,-0.156467,-0.120346,0.166968,0.320387,-0.0260083,0.103782,-0.294506,-0.288424,0.215396,-0.546525,-0.224111,-0.0721166,-0.275664,-0.273143,-0.597212,0.0462119,-0.0560218,-0.482294,-0.767212,0.23318,0.462923,0.176674,0.146712,-0.954052,0.12004,-0.399219,-0.787968,1.1349,-0.643977,0.208123,-0.601227,-0.412246,-0.118075,0.0263189,0.0160026,0.363967,0.358747,-0.0609076,0.308434,0.149693,0.299551,-0.204882,-0.068523,0.346662,-1.02565,0.307932,-0.358049,-0.669475,0.726596,0.069952,-0.493694,0.0226028,-0.143965,0.10437,-0.336013,0.568723,0.442821,-0.00928144,0.856205,0.268377,0.283604,-0.446222,0.421284,0.220416,0.711773,-0.437688,0.776657,0.353573,-0.649723,-0.729838,-0.61579,-0.757788,0.502832,0.0121417,0.505025,0.240046,-0.105645,0.823139,-0.0179371,0.356562,0.447431,0.957734,-0.798566,0.657951,0.484128,0.103921,0.695749,0.164457,-0.0275653,0.234032,-0.720776,-0.236293,0.233713,0.487438,-0.0895448,0.526704,0.0908608,-0.2177,0.127858,0.763427,0.226594,-0.371509,-0.397603,0.240685,0.134788,0.243348,-0.318444,0.545905,-0.297913,0.011903,0.147903,0.36255,0.149367,0.66017,-0.0239304,-0.0264222,0.0766895,-0.00193297,-0.477839,0.464868,-0.347085,0.180687,0.31126,0.425073,0.557907,-1.00708 +3386.52,0.931094,0.0912059,4,1.38374,0.830548,-0.641334,0.267826,0.377388,-0.281037,0.9209,0.22081,0.39744,0.30095,0.311054,0.0545757,0.365376,0.814916,0.387992,0.810678,0.322925,-0.0306289,0.0701033,0.27861,0.0208695,-0.721324,-0.426143,0.514964,-0.275977,-0.682733,1.30507,0.193751,0.0928628,0.131125,0.922002,-0.100509,0.175181,0.62894,0.0942717,0.258703,-0.291334,0.888233,0.267416,-0.718352,1.20492,0.621989,0.503563,-0.714122,-0.373678,-0.514863,-0.505114,0.14448,0.615136,0.370114,0.316172,-0.0678541,0.391754,-0.52039,0.92867,-0.542263,0.109689,-1.15542,0.279821,-0.306009,0.275853,0.98458,-1.06002,-1.19508,0.928305,0.462039,0.0825373,-0.259024,0.79272,-0.588707,-0.116848,-0.556106,0.572077,-0.619197,0.754464,0.580995,1.2007,-0.0355437,-1.03672,-0.383696,1.1031,-0.50162,0.116193,-0.353026,0.317509,-0.375378,0.126911,-0.703049,-0.142252,-0.217441,-0.470325,0.574231,-0.619611,-0.0169861,0.0928234,0.267921,-0.297054,-0.512367,0.0497837,0.0684752,-0.292412,-0.206387,0.140915,0.262629,-0.0671125,-0.260058,0.274827,-0.605324,-0.015702,0.413285,-0.144549,0.194951,0.760848,0.470527,0.154697,-0.211042,-0.0715601,0.25015,0.611732,-0.154063,-0.472918,0.00428755,-0.260935,-0.388907,-0.627158,0.42471,0.239087,0.671221,0.270178,-0.415786,0.0162029,0.0825466,0.231045,0.70004,0.00372018,-0.376631,0.537398,-0.301352,0.704246,-0.722811,0.865799,0.0448879,-0.121356,-0.243998,-0.7063,0.646882,-0.0963971,0.624413,0.199574,-0.226013,-0.317919,-0.126547,0.218403,-0.26882,0.349246,0.279902,0.174374,0.232018,-0.165411,-0.206087,0.471101,0.138915,1.13104,-0.667047,0.0411189,0.693554,-0.132562,-0.494189,-0.192406,-0.109007,0.0620745,-0.103473,-0.0852129,-0.130405,-0.317037,0.14325,-0.448968,-0.338115,0.424209,0.320405,0.325822,0.31558,0.112611,0.129327,-0.147022,0.137081,-0.425858,-0.550706,0.557147,-0.170676,-0.189433,-0.155033,-0.0917349,-0.236156,-0.366383,0.0530665,0.0926024,-0.448663,-0.524337,-0.114852,0.356148,0.297177,0.387468,-0.829706,0.283137,-0.130665,-0.532407,0.913086,-0.153048,0.554011,-0.404675,-0.377165,0.110558,0.351341,-0.127438,0.32602,0.267356,-0.332218,0.346433,0.196717,-0.00242112,-0.367384,-0.0993607,0.0855264,-0.772197,0.0237456,-0.299329,-0.685087,0.67224,0.163983,0.185537,0.184313,-0.123744,0.00490472,-0.45366,0.806425,0.294611,-0.00283554,0.847515,-0.237755,-0.0695614,-0.410673,-0.0406039,0.0106322,0.51633,-0.114512,0.610258,0.365437,-0.725787,-0.696467,-0.463882,-0.650129,0.529288,0.153067,0.478961,0.231463,0.164165,0.721134,-0.284493,0.529977,0.149917,0.85156,-0.406893,0.393891,0.213554,-0.40115,0.406682,0.328868,-0.26727,-0.0606709,-0.562637,-0.30717,0.22965,0.388801,0.135107,0.557254,0.00665728,-0.292693,0.275945,0.641742,0.217009,-0.422313,-0.194875,0.365775,0.232072,0.0101012,-0.0825218,0.137652,-0.302638,0.20564,0.192228,-0.119227,-0.228458,0.628518,-0.0659974,-0.330315,-0.372784,-0.101906,-0.538309,0.289355,-0.0980199,0.168413,0.321367,0.410381,0.566893,-1.18425 +3398.84,0.884066,0.0912059,4,1.43363,0.985476,-0.18224,0.0495906,0.108253,-0.161605,-0.175489,0.283482,0.97544,0.259213,0.304425,0.0976504,0.563925,0.788443,0.168467,1.16968,0.638831,-0.0604171,0.069641,0.488383,-0.167899,-1.17353,-1.17828,0.241003,0.157672,-0.524993,0.641345,0.362104,0.247196,0.380332,1.18408,-0.299846,0.0346591,0.681061,-0.229413,-0.0511913,-0.947074,0.0791543,-0.0952728,-1.01697,1.03377,0.492438,-0.0359921,-0.598011,-0.1032,0.328637,-0.601058,-0.339758,0.721769,0.260178,0.371019,0.631662,0.22555,-0.647817,0.894132,0.0944222,0.131137,-0.684869,0.255009,-0.431601,0.548252,0.848552,-0.531002,-0.940905,0.102614,0.054079,-0.165087,-0.846956,0.0415283,-0.339668,-0.00489733,0.745647,0.36327,0.0249262,0.346157,0.0846247,0.379626,-0.529427,-0.186602,0.149738,0.847726,-0.120727,0.303823,-0.556434,0.581893,-0.76768,0.080597,0.106246,0.347454,-0.673568,-0.0914211,-0.300688,-0.161154,-0.30313,0.000154378,-0.832334,0.29055,0.240816,0.54105,0.351779,-0.567191,-0.12197,0.0447965,0.175549,0.678421,0.12461,0.512663,-0.109604,-0.0230451,0.407085,-0.183873,-0.17138,0.366176,0.462252,-0.20733,-0.54606,-0.0477552,0.36352,0.257129,-0.442995,-0.846021,-0.0319302,-0.35549,-0.383413,0.239972,0.343215,-0.544968,0.281858,-0.203596,-0.684999,-0.247573,-0.0764952,0.290621,0.652688,-0.265682,0.695698,0.0384633,0.232093,0.263023,-0.250042,0.163286,0.0251636,0.50963,0.0503453,-0.450825,-0.00309864,-0.421832,0.661378,-0.491954,-0.197116,-0.783772,0.152431,0.388899,0.092987,0.382855,0.234465,0.386816,0.185107,0.105538,0.0715133,0.21548,-0.163281,0.659212,0.299724,-0.260161,0.0940775,-0.258698,-0.803914,-0.66031,-0.504735,-0.119153,0.0528077,0.166256,-0.428723,0.38487,-0.0726769,-0.198979,-0.42617,-0.026771,0.873525,0.302278,-0.298963,0.255486,0.214348,0.235956,0.48694,-0.895496,-0.305413,0.00607283,-0.918791,0.00369214,-0.100226,-0.124727,-0.719478,-0.220561,0.0943546,-0.288959,-0.360395,-0.127928,-0.0940815,-0.150555,-0.299554,0.22512,-0.398547,-0.0850481,0.31781,-0.498234,0.856002,-0.0299475,0.733566,-0.354803,-0.280691,0.179745,0.47948,-0.49991,0.408518,0.607044,0.120184,0.757257,-0.326768,-0.585032,-0.459113,-0.0184107,0.401252,-0.412169,0.207102,-0.811824,-0.317087,0.515253,-0.184653,-0.415761,0.109119,-0.792833,-0.540935,-0.251771,0.400124,0.638617,-0.147916,0.327953,0.0230127,-0.0797895,-0.24643,0.102246,-0.206364,0.145483,0.115932,0.425885,0.179873,0.280754,-0.0158515,0.0814038,-0.803445,0.112244,-0.321392,0.351902,-0.0215852,0.217974,0.285333,0.319107,0.176291,0.126499,0.916485,0.10017,-0.532556,0.546009,-0.46287,-0.182349,0.142495,-0.112784,0.260456,-0.217472,0.226784,0.463835,-0.226073,0.685517,0.427562,0.44091,-0.558259,0.448954,0.174681,-0.074678,0.111913,0.0666698,0.626381,0.291929,-0.226082,0.0530204,-0.549075,0.125178,0.235943,0.253944,-0.347222,-0.0748952,0.958941,0.0318118,-0.432035,-0.411002,0.0492225,-0.628322,-0.129423,-0.536921,0.164824,0.364255,0.405985,0.603536,-0.578902 +3396.03,1,0.0912059,4,1.56948,0.868032,-0.890351,0.368052,0.307246,-0.231348,0.186043,0.300383,0.568803,0.706011,0.0531025,0.0984678,-0.393165,0.966193,-0.0276797,1.1131,0.427675,-0.0879201,0.180708,0.497487,0.0277534,-0.792358,-0.563874,0.214288,-0.299464,-0.385521,0.927737,0.902007,-0.399555,-0.161134,0.875175,-0.151971,-0.284468,-0.0033438,-0.638881,-0.414236,-0.253426,0.815909,0.0825105,-0.702375,0.875902,0.901975,0.736131,-0.590657,-0.143417,-0.112321,-0.581293,-0.31523,0.287558,0.560994,0.413178,0.287878,-0.00932468,-0.384558,0.397323,0.02408,-0.0680527,-0.86421,0.266953,-0.835494,0.390871,0.85962,-1.43732,-1.26335,0.579422,0.416218,0.119225,-0.290845,0.199374,-0.35983,-0.270338,0.247266,0.0696784,0.194488,0.675431,0.577182,0.820577,-0.316688,-0.70259,-0.0955604,0.766989,-0.220355,0.173969,-0.860594,-0.267487,-0.217643,-0.243018,-0.143691,0.307249,-0.547824,-0.344208,-0.0593499,0.0331611,0.419504,-0.348632,-0.212117,-0.137793,-0.314912,0.0942695,0.235469,0.0714721,-0.606397,-0.886122,-0.120301,0.291515,-1.10035,0.195115,-0.288034,-0.042716,0.086916,0.123256,-0.0919484,0.1085,0.540556,0.32278,-0.0705996,-0.412438,0.128708,0.128195,0.132761,-0.904648,0.232723,0.0610151,-0.171399,0.302766,0.328348,0.148703,0.160211,0.258288,-0.0382337,0.121585,-0.477069,0.179027,0.403537,-0.278298,-0.134461,0.198303,-0.844655,0.420183,0.0475466,0.344528,0.0923545,0.436793,0.330524,-0.264178,0.0337039,0.0518096,0.326483,-0.362262,-0.343555,0.916987,-0.0358887,0.328795,0.595019,0.43328,0.465778,0.353142,0.126519,-0.242433,-0.353631,0.612435,-0.18198,0.642416,-0.652112,0.245976,0.266584,-0.309478,-0.118122,-0.268601,0.251529,0.249089,-1.01765,0.00378381,-0.754208,-0.331367,0.135845,-0.294922,-0.106782,0.330117,0.624671,0.352377,-0.113431,0.168241,-0.0488469,-0.0963409,-0.325983,0.131902,-0.250388,-0.459676,-0.390198,-0.167615,0.313622,-0.236802,-0.675599,-0.130859,0.100678,-0.304858,-0.406303,-0.100634,-0.448175,0.0828157,0.165826,0.758122,-0.109551,-0.337701,0.2015,0.38684,0.722313,0.485718,0.501873,0.156733,0.108059,-0.0614805,-0.218586,0.774575,0.189102,-0.291697,0.194477,-0.00673685,-0.156478,0.286448,-1.23352,-0.910667,0.380924,0.515996,0.517421,-0.5749,-0.175372,-0.4321,0.36164,-0.195304,0.238315,0.0510682,-0.443356,-0.271611,0.66603,0.0897995,-0.366333,0.810249,0.290896,0.365873,-0.117229,-0.164517,-0.304736,0.23097,0.450481,0.381955,0.503879,-0.0733117,-0.558794,-0.0302195,-0.558329,0.401953,0.215194,-0.576392,0.247304,-0.483596,0.145578,0.43393,0.314597,0.0577179,0.520233,-0.0263709,-0.104097,-0.121877,0.362486,0.301194,-0.613569,0.254748,0.142548,0.00543867,-0.301983,-0.441211,-0.570822,0.221305,-0.551858,0.0902686,-0.414565,0.100105,0.271385,-0.0864318,0.315244,0.0251342,0.864462,0.0173112,-0.430653,-0.420285,0.000732816,-0.0134382,-0.373314,0.245552,-0.0722563,-0.0847862,0.546446,-0.318241,0.00113879,-0.494678,-0.506089,-0.0256661,0.139727,0.0578098,0.141394,0.324162,0.376024,0.569353,-0.808554 +3408.54,0.979052,0.0912059,4,1.51012,0.979841,-0.96028,0.459423,-0.143371,-0.210775,-0.0129359,-0.061168,1.1339,0.34174,-0.172447,-0.144681,0.0337014,0.855798,-0.260563,1.11072,0.280661,-0.119441,0.201183,0.314713,-0.092257,-1.19445,-0.655803,0.325934,-0.383784,-0.609171,0.277223,0.476538,-0.300744,-0.261515,1.20025,-0.335848,0.0374412,0.366445,-0.673646,-0.0955402,-0.647935,0.69928,0.399966,0.147711,0.876178,0.574091,-0.494433,-1.21554,-0.131473,0.172118,-0.158805,0.0109946,0.517129,0.464554,0.158331,0.240835,-0.33767,-0.0607651,-0.14145,0.161155,-0.0384634,-0.656438,0.00930744,-0.591491,0.337095,0.94936,-0.799338,-1.45946,0.845144,0.271889,0.257634,-0.044938,-0.324687,-0.357197,-0.655579,0.752301,0.132127,-0.305191,0.526966,-0.021644,0.353991,-0.153707,-0.436668,-0.148746,0.23958,-0.903959,0.107204,-0.888933,-0.724532,-0.00936107,-0.391927,-0.454193,0.189985,-0.584118,0.132058,-0.584469,0.12203,-0.11638,-0.393764,-1.01971,-0.333497,-0.258429,-0.335162,0.494575,0.19214,-0.466491,-0.178786,-0.383379,0.251532,0.0414493,0.569453,-0.196613,-0.26141,0.226635,0.241443,-0.0132507,0.794384,0.471585,-0.0167808,-0.267661,-0.963244,0.120419,0.470471,0.221147,-0.722196,0.282426,-0.0643401,-0.302322,0.0806415,-0.129819,0.216013,0.310269,0.257464,-0.651186,0.259463,-0.268471,0.0992713,0.105773,-0.0890854,-0.461243,0.158068,-0.57716,0.27172,-0.277426,-0.25823,-0.054036,-0.0395316,-0.0147279,0.0792598,-0.381247,-0.269584,0.479953,-0.37678,-0.0647144,-0.247689,0.169274,-0.0517868,0.17008,0.243348,-0.270975,0.271732,-0.22536,0.237605,0.000261137,0.417149,-0.25288,0.537625,-0.0514602,-0.605802,0.571661,0.0937149,-0.993949,-0.288327,0.234428,0.431088,-0.457192,0.170198,-0.413916,-0.209034,0.330506,-0.367921,-0.18878,-0.116461,0.545039,-0.0377854,-0.163925,-0.592046,0.462079,0.225143,-0.662737,-0.194884,-0.248086,-0.0944545,-0.674506,-0.148369,0.380364,-0.366739,-0.251193,0.497758,-0.279206,-0.462629,-0.630287,0.23941,-0.114442,-0.313618,-0.0913249,0.48221,0.0498902,-0.173419,0.105635,0.0101394,0.674523,0.290619,0.248969,0.0460008,-0.322679,0.399813,-0.293086,0.179304,-0.115567,-0.402033,0.187319,0.415787,-0.529288,0.381915,-0.604682,-0.087603,-0.145137,-0.461141,0.0328667,-0.897687,-0.427858,0.269395,0.464828,-0.677966,0.0720187,0.00417406,-0.761822,-0.608033,0.510607,-0.0824234,0.0408526,0.387804,-0.160498,0.27345,-0.33818,0.123289,-0.161231,-0.226837,0.32883,0.7758,0.35085,0.0795776,-0.473154,-0.203887,-0.730037,0.441386,-0.20148,-0.623982,0.353595,-0.243305,0.608824,0.194715,0.0533174,-0.447635,0.264048,-0.224786,-0.219585,0.0347735,0.0219417,0.155634,-0.0443362,0.101716,0.402421,-0.0111096,-0.498624,-0.178714,-0.228581,0.101702,-0.518302,0.307706,-0.346988,0.358819,0.0999762,0.0618126,0.440331,-0.54915,-0.36304,0.102923,-0.22481,0.0845814,-0.605836,0.373088,-0.166703,0.247182,-0.128134,0.00236591,0.0377441,-0.0593261,0.267796,0.19104,-0.194859,0.0166458,-0.144721,-0.3105,0.145653,0.51167,0.381646,0.715311,0.375306 +3411.35,0.956993,0.0912059,5,1.54039,0.977793,-0.955928,0.421954,-0.0538513,-0.188387,0.0367058,-0.0904841,1.22887,0.364915,-0.084406,-0.151146,0.0606464,0.842508,-0.211173,1.07246,0.319016,-0.224633,0.269193,0.337497,-0.0918604,-1.25026,-0.678342,0.440598,-0.446377,-0.560912,0.325729,0.546764,-0.236578,-0.248243,1.1976,-0.0691716,-0.00468061,0.20256,-0.745438,-0.101981,-0.621667,0.773816,0.281756,0.150666,0.825375,0.536822,-0.598658,-1.27198,-0.143123,0.258252,-0.232696,-0.0565998,0.459782,0.541283,0.268023,0.308959,-0.300074,0.0618105,-0.0906972,0.146534,-0.00728563,-0.655771,0.121629,-0.537682,0.321222,0.930262,-0.799853,-1.5043,0.946059,0.215581,0.385868,-0.0571617,-0.226049,-0.292155,-0.469344,0.681532,0.123817,-0.298943,0.538798,0.0742748,0.342213,-0.193681,-0.418349,-0.184578,0.270806,-1.06274,0.055744,-0.789828,-0.762086,-0.163346,-0.471736,-0.523896,0.202476,-0.568244,0.0511281,-0.572414,0.121737,-0.0201743,-0.438438,-1.1266,-0.235328,-0.365741,-0.325816,0.463917,0.21045,-0.495286,-0.109569,-0.368627,0.236871,0.0431284,0.52686,-0.0856549,-0.296926,0.22992,0.136072,-0.0350771,0.882382,0.405342,-0.0286592,-0.320344,-0.719276,0.108222,0.42938,0.220805,-0.760863,0.30808,-0.114414,-0.276588,0.165239,-0.0475837,0.198602,0.365988,0.343995,-0.479933,0.276371,-0.231204,0.0926909,0.239782,-0.0300854,-0.485567,0.149789,-0.468193,0.285505,-0.261976,-0.341042,-0.0309196,0.0170369,0.0412772,-0.0945151,-0.363301,-0.232752,0.415326,-0.311846,-0.0842488,-0.0549271,0.277196,-0.105453,0.133204,0.119426,-0.320262,0.294807,-0.190739,0.152773,0.00689407,0.523179,-0.269542,0.514089,-0.0836173,-0.696505,0.417171,0.0631867,-0.959122,-0.324355,0.24204,0.361287,-0.527412,0.232251,-0.479216,-0.270619,0.391485,-0.42667,-0.151454,-0.12586,0.563346,-0.108502,-0.193971,-0.70565,0.483092,0.261477,-0.607655,-0.209193,-0.191103,0.00407064,-0.671617,-0.153075,0.275229,-0.413424,-0.305184,0.386786,-0.368236,-0.488988,-0.557228,0.150371,0.018779,-0.354562,-0.119669,0.412095,0.0418081,-0.247275,0.0192391,0.10268,0.73185,0.516154,0.37216,0.0997714,-0.318527,0.432604,-0.319616,0.201786,-0.0758077,-0.262053,0.178431,0.339679,-0.632256,0.291945,-0.710048,-0.0209221,-0.0237327,-0.463293,0.0276954,-0.851181,-0.35004,0.148237,0.476984,-0.533217,0.129963,0.00212324,-0.734921,-0.632724,0.538435,-0.05453,-0.0474799,0.406182,-0.166553,0.382857,-0.432821,0.152279,-0.216206,-0.111537,0.482698,0.700024,0.246957,0.106425,-0.528833,-0.30634,-0.636654,0.403587,-0.258791,-0.588942,0.367671,-0.147919,0.656248,0.142265,0.0786964,-0.349914,0.406164,-0.351406,-0.132329,0.186548,0.0454386,0.0331498,-0.107523,0.0590475,0.389891,-0.0623999,-0.54539,-0.26314,-0.182883,0.0510913,-0.531076,0.210773,-0.186082,0.345013,-0.0207202,0.0272843,0.492742,-0.524063,-0.352671,0.0502741,-0.250613,0.0647306,-0.522171,0.387596,-0.313743,0.335312,-0.121561,0.0887316,0.00312393,-0.0728328,0.27524,0.101743,-0.0764532,-0.156593,-0.148639,-0.462473,0.136439,0.529457,0.369376,0.727638,0.139669 +3416.3,0.994974,0.0912059,4,1.57532,0.896481,-0.632905,0.343219,-0.52622,-0.099955,0.48,0.000142995,-0.167188,0.450732,-0.0184965,-0.172893,0.272611,0.61711,0.316018,0.9948,0.144615,-0.253823,-0.554876,0.244822,-0.0342178,-0.462728,-0.769253,0.656715,0.319131,-0.327901,0.144778,-0.0190886,-0.128579,-0.0512402,1.40577,0.306511,-0.162133,-0.0477099,-0.681243,0.119593,-0.621724,0.717903,-0.307583,-0.488749,0.801525,0.703523,0.396036,-0.43707,-0.107362,-0.516007,-1.15832,0.61557,0.401366,-0.400458,-0.0878225,0.647153,-0.0760458,-0.763144,0.161635,-0.27783,-0.194874,-0.337905,0.146684,-0.112555,-0.0488598,1.08098,-1.31351,-0.538967,0.70554,0.0138675,-0.194265,-0.192849,-0.149974,-0.722543,0.471652,-0.444412,0.934408,0.117583,0.180366,0.960609,0.429417,-0.0829996,-0.132114,-0.0464723,0.214632,0.15707,-0.0870289,0.247463,0.413753,-0.241073,0.438654,0.197361,0.304597,-0.451657,-0.911092,0.458223,-0.0108551,-0.00690608,-0.0223901,0.130759,0.185005,-0.250471,-0.335569,0.253866,0.432108,0.392085,-0.658084,-0.45242,0.257172,-1.05622,-0.27418,-0.330378,0.297966,0.802031,-0.269314,-0.336516,-0.451266,0.496382,0.0443303,-0.0544973,-0.0334986,0.0472499,0.308381,0.163471,-0.600342,0.0474972,0.11321,-0.905135,-0.417989,0.143352,-0.47777,-0.12005,0.0452715,-0.0350652,-0.585066,0.103679,-0.0350275,0.177859,0.0129898,0.240245,-0.131051,-0.190481,0.0927493,-0.873137,-0.383504,-0.147788,0.291647,-0.270626,-0.0436276,0.461123,-0.577168,0.22569,-0.423983,-0.416596,-0.447247,0.21877,0.106804,-0.38891,0.378889,0.133919,0.0695153,0.0708748,0.260732,-0.228046,0.501156,-0.401398,0.158711,-0.0770552,0.378167,0.188035,-0.125367,-0.475538,0.0688297,-0.376022,0.0370532,-0.172568,-0.225432,-0.466535,-0.214941,-0.320808,-0.449494,-0.0242658,0.149907,0.240604,0.400781,-0.447013,0.237956,-0.701601,-0.222403,-0.17242,0.114202,-0.496718,0.316924,-0.0800404,0.211866,-0.403062,-0.115026,-0.618667,0.0401585,0.610494,0.412457,-0.294802,-0.425111,0.000346827,-0.0183114,-0.801713,0.0871974,-0.125321,-0.660959,0.283709,-0.590382,0.640573,-0.361914,-0.567249,0.329482,0.0492561,-0.157592,0.190338,-0.497027,0.452734,-0.690429,0.255839,-0.00554813,0.812818,-0.372192,-0.347448,0.309269,0.695118,0.264085,0.448038,-0.281101,-0.199791,0.146925,0.147913,-0.173484,0.111469,-0.15364,0.176906,-0.127759,0.256584,0.0685115,0.517113,0.222066,0.112855,-0.049467,-0.0513245,-0.552785,0.0692059,-0.00182758,-0.386569,0.328429,0.185287,-0.282316,-0.14267,0.324238,-0.580082,0.550334,0.121116,0.325557,0.041785,-0.486638,-0.0890164,0.00180991,-0.15768,0.52404,0.398268,-0.0551686,0.0584755,0.0765583,0.49431,-0.379653,-0.54892,-0.108609,-0.540228,-0.354023,0.0390801,0.354997,0.203531,0.284681,-0.187582,0.111565,-0.0304138,0.35844,-0.00561473,-0.464777,-0.452,-0.111526,0.306247,0.131681,0.234428,0.0717217,0.423188,-0.193499,0.116524,-0.043872,0.417385,-0.262745,-0.144271,-0.0757318,-0.499934,-0.0934842,-0.148747,-0.603039,0.361515,-0.439095,0.128171,0.191894,0.358009,0.438057,1.76935 +3403.34,0.938346,0.0912059,5,1.6161,0.717404,-0.943587,0.423874,-0.324347,-0.0591333,0.303978,0.105943,0.166556,0.581316,0.191068,-0.121275,0.205093,0.389576,0.49122,1.0759,0.222983,0.138778,-0.43267,-0.00991195,0.352596,-0.779027,-0.727019,0.587462,-0.174289,-0.488902,0.19027,0.0483026,-0.142629,-0.203143,1.08854,0.192733,-0.410308,0.467864,-0.709308,-0.0611535,-0.382316,0.888479,-0.259158,-0.532561,0.705786,0.556058,-0.0279292,-0.305024,-0.232736,-0.27649,-0.674605,0.43486,0.335265,-0.764106,-0.0857708,0.624888,-0.0748128,-0.815197,0.503686,0.09517,-0.1515,-0.185201,0.426951,-0.257784,-0.296171,1.20269,-1.26222,-1.2646,0.0541224,-0.0197444,0.130992,0.0106665,0.241452,-0.807488,0.58315,-0.348417,0.983756,-0.0439701,0.0753669,0.839881,0.429341,-0.156298,-0.166713,-0.153448,0.0247721,0.121598,-0.169908,0.299965,0.631166,0.0660586,-0.0987655,-0.255326,0.367911,-0.781361,-1.05882,0.42363,-0.0311924,-0.122465,-0.136277,-0.33599,0.216135,-0.847322,0.0831293,0.330966,0.34053,0.162716,-0.493177,-0.595958,0.463948,-0.741817,0.0617441,-0.482007,0.455228,0.859538,-0.575073,0.0260607,-0.0608678,0.331031,-0.00246236,-0.0739748,-0.307366,-0.00511119,0.344803,0.321454,-0.796286,-0.151771,0.167307,-0.477367,0.19854,0.301261,-0.407143,-0.235516,0.0343647,-0.537692,-0.716894,0.506428,0.0239056,0.780984,0.256061,-0.00240345,-0.300334,-0.0215989,0.00160821,-0.660907,-0.198344,-0.015955,0.203444,-0.0819147,-0.0156222,0.486197,-0.298559,-0.0243798,-0.275324,-0.352639,-0.547789,0.0417141,0.299151,-0.141197,0.280667,0.505868,0.120926,-0.105646,0.00835052,-0.0657664,0.0219099,-0.636831,0.0977512,0.183312,0.322724,0.401543,0.0882487,-0.364722,0.133925,-0.511551,-0.513429,-0.551354,-0.060586,-0.366428,-0.468324,-0.649192,-0.716018,-0.11831,0.227442,0.172582,0.181685,-0.304213,0.28822,-0.833485,-0.0486577,0.14069,0.0599082,-0.38218,0.207848,0.117081,0.0813993,-0.141722,-0.290396,-0.674825,-0.19021,0.54563,0.360615,-0.389892,-0.310321,0.219072,-0.288082,-0.445609,0.0339504,0.22303,-0.656557,-0.293918,-0.553112,0.620624,-0.296975,-0.163488,-0.0701283,0.231155,0.290296,0.310067,-0.478567,0.35233,-0.912461,0.245187,0.223098,0.381028,-0.225251,-0.63538,-0.0284274,0.783419,-0.129842,0.710638,-0.128077,0.450085,0.00375946,0.113596,-0.161409,0.306257,-0.316222,-0.220296,-0.336989,0.125536,0.012655,0.238112,0.0752157,0.155427,0.134988,-0.145364,-0.391797,0.19675,-0.0281352,-0.275028,0.229389,0.295144,-0.081615,-0.0621191,0.346834,-0.404455,0.59756,0.0302288,0.281577,0.00971009,-0.545836,-0.236031,0.388915,-0.122789,0.316337,0.142119,-0.0368734,0.0809606,0.167516,0.76025,-0.3749,-0.441085,-0.164479,-0.668504,-0.350363,0.0547255,0.394363,0.142349,0.707791,-0.245214,0.330515,-0.186742,0.175217,-0.234947,-0.0258642,-0.186336,-0.173666,0.0761083,0.265244,0.434506,-0.514255,0.581054,-0.15829,0.146304,0.0530894,0.213212,-0.269566,-0.207808,-0.164356,-0.372994,0.056179,-0.435977,-0.700418,0.137514,-0.0679842,0.144614,0.276563,0.380282,0.525893,1.5331 +3404.26,0.95018,0.0912059,4,1.59138,0.823108,-1.13558,0.520198,-0.0660944,-0.161078,0.268332,0.164817,0.069681,0.578624,0.251466,-0.263434,0.279841,0.244739,0.41496,0.855711,0.138506,-0.0651591,-0.343299,0.232545,0.152628,-0.604105,-0.951765,0.711462,-0.153328,-0.442059,0.0643644,0.0524702,-0.119065,0.0315324,1.03773,0.229719,-0.123784,0.316278,-0.434024,0.0350529,-0.464155,0.845008,-0.0218633,-0.588376,0.784849,0.850487,-0.137474,-0.406809,-0.230013,-0.0575329,-0.634909,0.235362,0.376641,-0.694623,0.120216,0.799628,0.0126907,-0.859502,0.190347,0.190711,0.0274629,-0.127406,0.385964,-0.443388,-0.153651,1.2292,-1.35161,-1.38663,0.271555,0.126499,0.449324,0.157744,0.184166,-0.658337,0.392636,-0.459674,1.18217,0.163299,0.576663,0.93156,0.619358,0.0703502,-0.0190475,-0.112397,0.366613,-0.103167,-0.209677,0.340628,0.632021,0.306963,0.0988541,-0.236625,0.364148,-0.85283,-0.869996,0.468636,0.0320872,0.0343866,-0.0833367,-0.77877,0.0748332,-0.771837,0.210437,0.417428,-0.110011,0.0901255,-0.47636,-0.562693,0.566642,-0.590521,0.197055,-0.0753599,0.420746,0.591501,-0.200383,-0.138755,-0.25246,0.366703,-0.0064413,-0.394631,-0.3892,-0.0644347,-0.0558315,0.197821,-1.06707,-0.291842,-0.297703,-0.997995,-0.0997783,0.122874,-0.128557,-0.07615,0.145254,-0.646837,-0.89807,0.504294,0.0884965,0.669339,0.157711,0.0245484,0.067288,0.137995,-0.0441175,-0.602316,-0.573897,-0.103564,0.121989,0.0136926,-0.355575,-0.0178776,-0.339946,0.516802,-0.190132,-0.416735,-0.629671,-0.0081366,0.348499,0.0608028,0.432884,0.372427,0.198818,-0.0242797,0.0884447,0.0541455,-0.130245,-0.514553,0.24132,0.03099,0.302822,0.631301,0.0373903,-0.461857,0.0464423,-0.469157,-0.469537,-0.540667,9.54371e-06,-0.519282,-0.642563,-0.290747,-0.722085,-0.192054,0.0874864,0.271749,0.171696,-0.295814,0.260686,-0.845407,0.0621938,0.304307,-0.144986,-0.390838,0.138112,0.178484,0.287491,-0.0128176,-0.350511,-0.638875,-0.139773,0.316049,-0.0392284,-0.373444,-0.326874,0.315089,-0.336763,-0.19955,0.0413957,-0.176155,-0.266118,0.117856,-0.478566,0.78837,-0.321398,0.0469904,0.0944845,0.186708,0.244264,0.305353,-0.569872,0.446046,-0.75311,0.187115,0.528906,0.727844,-0.410312,-0.547991,-0.0180591,0.599512,-0.182413,0.515979,-0.0213835,0.468546,0.153186,0.0710576,-0.254588,0.0567687,-0.0862055,-0.0957166,-0.431276,0.113732,-0.146461,0.34497,0.14259,-0.097988,0.449447,0.0613438,-0.413928,-0.128457,0.118447,-0.237194,0.228347,0.499453,0.275788,-0.142644,0.27242,-0.0686435,0.751549,-0.216532,0.357767,0.06901,-0.443473,-0.615694,0.407087,-0.0658313,0.679875,0.28552,-0.0679386,0.55295,0.25906,0.272958,-0.646353,-0.158363,0.0122775,-0.497778,-0.075082,0.415521,0.0869299,0.343577,0.536611,-0.240707,0.441512,-0.311763,0.119416,-0.409041,0.0701757,-0.462192,-0.0332776,-0.0361527,0.14643,0.553496,-0.435287,0.647997,-0.0529288,0.221785,0.0882448,0.16019,-0.0564338,-0.478335,-0.0464816,-0.27389,0.157474,-0.206638,-0.500253,-0.300815,-0.114244,0.164553,0.305897,0.405652,0.553079,0.499163 +3398.37,0.946197,0.0912059,4,1.68953,0.907695,-0.719185,0.290842,0.596095,-0.0648062,0.248144,0.303675,0.329431,-0.1517,-0.263399,-0.31744,0.0194811,-0.0680185,-0.100941,0.69434,0.0884878,-0.189406,-0.261728,-0.00158625,-0.0789191,-1.39235,-0.735789,0.70988,-0.363827,0.023094,0.0497993,0.5697,-0.669361,-0.282702,1.03499,-0.0281445,0.034194,0.257079,-0.659413,-0.577207,-0.660413,0.273007,-0.00199707,-0.823737,0.86313,0.213301,-0.190108,-0.941428,0.418559,-0.180897,-0.923021,-0.31182,0.311443,-0.192675,-0.110668,-0.43695,0.00234193,-0.122482,0.549397,-0.119756,-0.57683,-0.551481,0.534047,-0.205324,0.226231,0.794798,-0.0825371,-0.886696,0.0392061,0.379231,-0.337009,0.326139,0.301089,-0.222078,0.0690769,0.159225,0.90361,-0.741652,0.603715,0.467336,0.306646,-0.185586,0.0803253,-0.202578,0.399138,-0.0208664,0.0280783,-0.142121,-0.373285,-0.812446,-0.408,-0.254948,0.146127,-0.377823,-0.00950048,0.0166421,-0.204645,-0.110494,0.385445,-0.357915,0.18417,-0.680813,-0.0971901,0.10371,0.65006,0.83552,-0.0164664,-0.66734,0.350124,-0.425761,0.269813,-0.113952,0.693406,0.890809,-0.267431,0.0569676,0.169423,0.448028,-0.0999398,-0.116068,-0.348232,-0.501228,0.59142,0.047443,0.0399676,0.257112,0.278968,0.154704,-0.138268,-0.253958,0.0821995,0.527459,0.204271,-0.337862,-0.144394,0.327023,-0.13157,0.440023,-0.829777,-0.345581,-0.00439002,-0.378955,0.469278,0.503315,0.375448,-0.449061,-0.389847,-0.812006,0.327859,0.0650052,0.00434041,0.286591,-0.469681,-0.263506,-0.92166,0.371261,0.19613,0.024849,0.283628,0.360181,0.604918,0.475617,0.100922,0.0393231,0.33258,0.0384054,0.037664,-0.0512216,0.541348,0.396892,0.237583,-0.361082,-0.433112,-0.172567,0.512678,0.322968,-0.00956492,0.0887739,0.0877989,-0.398955,-0.305256,-0.463938,-0.0331304,0.848775,0.443763,-0.0786118,0.206694,-0.323069,-0.0617664,-0.230134,-1.09144,-0.0478247,0.11921,-1.11794,0.508775,-0.579413,-0.186881,-0.247759,0.279848,0.591767,0.130007,-0.523078,-0.211772,0.200849,-0.539693,-0.176462,-0.0361184,0.196686,0.357121,0.188819,0.163629,0.461513,-0.0996925,0.137606,0.211546,-0.0933691,0.0473626,0.0600042,-0.428839,0.6189,-0.559285,0.110529,-0.0465738,-0.796311,0.206835,-0.38343,-0.329157,0.221147,0.179423,0.4861,0.0268885,-0.823067,0.658947,0.0622439,-0.781829,0.147048,-0.491444,-0.715938,-0.0492404,0.248011,-0.345161,-0.263755,0.38167,0.138369,-0.152117,0.0317208,-0.169546,-0.0924826,0.140867,0.5091,0.542715,0.316716,-0.149129,-0.320991,-0.618904,-0.320714,0.629204,-0.027013,-0.0110263,-0.24331,0.0238614,-0.388375,-0.226017,-0.430658,-0.229429,0.681524,0.733206,0.0588265,0.243692,0.564822,-0.0916236,-0.212866,-0.271424,0.0779329,-0.136371,-0.302141,-0.663439,0.19075,0.1431,-0.00203932,-0.0235958,-0.0936569,0.602088,0.0841003,-0.343489,-0.343316,-0.595338,0.125309,-0.112617,0.647055,-0.0661942,0.655688,0.306606,-0.445518,-0.0749914,0.0245651,0.828055,0.110977,-0.179809,-0.40456,-0.22988,-0.417954,-0.407751,-0.0670544,-0.0669554,0.170202,0.259738,0.412555,0.509645,-1.7759 +3394.68,0.765932,0.0912059,4,1.6372,0.865833,-0.821878,0.300469,0.350174,-0.158192,0.29033,0.0534964,0.255357,0.129877,-0.0614246,-0.228593,0.0598329,-0.067524,-0.0365369,0.519751,0.0135592,-0.139752,-0.252167,-0.211542,-0.0899126,-1.31566,-0.761704,0.395469,-0.30895,0.016329,0.11432,0.487726,-0.570082,-0.214491,1.07608,-0.141136,-0.0876963,0.369939,-0.487194,-0.548503,-0.527603,-0.0146445,-0.0768463,-0.879937,0.69278,0.290094,0.190928,-0.86938,0.372671,-0.119219,-1.02864,-0.382975,0.356444,-0.342802,-0.00739427,-0.119208,-0.157455,0.0637866,0.56361,-0.174409,-0.54222,-0.601475,0.543491,0.106916,0.160137,0.742941,-0.184505,-0.966921,0.0916835,0.442849,-0.288887,0.508194,0.40522,-0.233808,-0.0304128,0.216942,0.796159,-0.700058,0.709654,0.600365,0.23171,-0.00336995,0.00893391,-0.390491,0.421427,-0.103673,-0.0322352,-0.0405195,-0.177278,-0.699226,-0.23192,-0.404438,0.211567,-0.467309,0.0807511,0.0078646,-0.165474,-0.0632349,0.451581,-0.397532,0.0801198,-0.940018,-0.12153,0.2317,0.617759,0.696435,0.089922,-0.566507,0.286656,-0.269733,0.199344,-0.142618,0.588069,0.841248,0.133906,0.202223,0.0877363,0.280763,-0.103716,0.020149,-0.344464,-0.0864856,0.548737,0.150277,-0.0782053,0.433218,0.375539,-0.0830412,0.115449,-0.14995,0.474374,0.152237,0.0557341,-0.304438,0.157832,0.390481,-0.185966,0.31812,-0.736495,-0.639276,0.100063,-0.359369,0.450238,0.523283,0.222372,-0.652585,-0.287157,-0.922956,0.279293,0.19668,-0.0181346,0.29875,-0.533913,-0.0438097,-0.539251,0.189188,0.175487,0.0236232,0.471878,0.351439,0.674113,0.162485,0.0958662,0.204278,0.308887,0.202104,0.175385,0.0963573,0.554599,0.534486,0.0860966,-0.317821,-0.573541,0.0428555,0.506463,0.309206,-0.102718,0.0665836,0.187592,-0.13556,-0.35756,-0.642118,-0.0689882,0.88865,0.555386,0.00477142,0.0103152,-0.11952,0.247227,-0.0990785,-1.05295,-0.285095,0.197975,-1.14131,0.592107,-0.472578,0.0501241,-0.411604,0.419353,0.576058,0.126939,-0.671917,-0.130821,0.102007,-0.614444,-0.133633,0.0207806,0.30219,0.264107,0.207619,0.0388685,0.601549,-0.42272,0.134715,0.0511196,-0.0953259,-0.000196642,-0.131419,-0.767451,0.264922,-0.539238,0.0740096,0.155023,-0.882133,0.0647971,-0.14452,-0.122057,0.153775,0.47649,0.317213,0.030637,-0.927517,0.516903,-0.183873,-0.655718,0.201941,-0.758668,-0.654388,-0.169122,0.330538,0.0181274,-0.397755,0.224475,0.312648,-0.107932,0.0287194,0.049659,-0.0235943,0.0229013,0.731475,0.387985,0.370379,-0.0890771,-0.291066,-0.874552,-0.296818,0.6908,-0.166604,-0.177279,-0.278332,0.00306771,-0.200258,-0.263434,-0.257289,-0.361024,0.381077,0.461841,-0.202761,0.0272651,0.442516,0.145097,-0.174012,-0.0870328,0.138529,-0.141885,-0.152404,-0.523708,-0.433104,0.298148,0.07268,0.0418605,-0.301208,0.799397,-0.0536717,-0.295015,-0.494743,-0.614255,0.0720882,-0.181884,0.282818,-0.0635662,0.614341,0.298854,-0.442485,0.0135361,0.00275302,0.674073,0.0844544,-0.235881,-0.345566,-0.268145,-0.455263,-0.494455,-0.277132,-0.185205,0.153755,0.233847,0.392116,0.483577,-0.86963 +3402.49,0.741108,0.0912059,4,1.60423,0.9895,-0.280331,0.0475976,0.220189,-0.022299,0.0586067,0.254041,0.912913,-0.0754869,-0.0410455,-0.279945,0.0260783,0.0150817,0.365148,0.59847,0.204235,0.222379,-0.370009,-0.0246566,-0.250195,-1.00735,-1.22239,0.186896,-0.0433448,-0.0528551,-0.293559,0.355892,-0.376697,0.0440101,1.00048,-0.599231,0.261134,0.104895,0.0631856,-0.506156,-0.341998,0.49524,0.187194,-0.591279,0.610696,0.337843,-0.261171,-0.388436,-0.169193,-0.359105,-0.350126,-0.19483,0.24753,-0.220694,0.0621624,-0.524048,-0.100716,-0.382303,0.76727,-0.183939,-0.211382,-0.783173,0.641143,-0.618184,0.00404825,0.941313,-1.13739,-1.59587,0.181225,0.231134,0.357089,-0.0350295,-0.164566,-0.175642,-0.0878739,0.135192,0.775252,-0.0656351,1.11071,0.343461,0.40333,0.454216,-0.473569,-0.0703825,0.671373,0.125687,-0.134939,-0.223258,-0.367053,-0.346458,-0.906058,-0.396798,0.200284,-0.74551,0.14543,0.176755,0.20087,-0.0177199,0.492613,-0.457261,0.44739,-0.226774,0.0799214,0.500768,-0.149925,0.224681,-0.643165,-0.709174,-0.0861759,-0.446587,0.444513,-0.372866,0.675808,0.284643,1.08325,0.12908,0.245337,0.487238,0.334083,0.513094,0.145552,-0.134012,-0.419175,0.350163,-0.484119,0.125957,0.209186,-0.204413,-0.0814343,0.27361,-0.677909,-0.0111625,0.293184,-0.658838,0.314903,0.113985,-0.137255,0.768869,-0.380394,-0.373286,-0.426068,0.420273,0.102971,-0.143845,-0.69346,-0.210324,-6.82842e-05,-0.480921,0.290809,0.247682,-0.00574286,0.570562,-0.314373,-0.54209,-0.190405,-0.302857,-0.596996,0.0286868,0.0480801,0.589047,0.636393,1.03651,0.521242,0.279614,0.543251,0.0367313,0.325468,0.108018,-0.534134,0.375306,-0.0401299,-0.251175,-0.163036,-0.353958,0.326214,-0.249382,-0.0102318,0.0186607,0.0361306,-0.0233299,-0.760239,0.252887,0.539296,0.682018,0.0235967,-0.147934,0.294767,-0.598622,-0.159652,-0.640918,-0.34672,0.0184825,-0.151595,-0.499274,0.227483,-0.251982,0.711886,-0.773334,-0.222443,0.738545,0.293729,-0.239313,-0.417684,0.516263,0.0581177,-0.0547354,0.263476,-0.0393482,0.0574104,0.1232,-0.508217,0.720108,-0.0804689,0.430104,-0.106037,-0.131514,0.893592,0.156983,-0.242925,0.238769,-0.521419,0.579176,0.0761841,-0.788196,-0.377051,-0.198045,-0.241608,0.757543,-0.0525907,0.380213,0.356871,-0.148922,0.370396,-0.00631214,0.066822,-0.0896974,-0.21023,0.335018,-0.575487,0.0665988,-0.109223,0.527604,-0.213601,-0.290927,-0.481338,0.278809,-0.426843,0.0767225,0.244624,0.708411,0.0698759,0.640411,-0.894503,0.176225,0.128592,-0.290195,-0.0580925,-0.568762,-0.0190918,-0.0569899,-0.603167,0.551179,0.0303764,-0.086163,-0.00277241,0.455039,-0.119542,-0.206702,-0.058479,0.409121,-0.35789,-0.0179854,-0.0441497,-0.250659,-0.241529,-0.409204,0.438363,0.204766,-0.138418,-0.275118,0.381558,-0.24706,0.259958,-0.0803489,-0.654944,-0.277953,-0.0390596,-0.130238,0.0545325,0.367081,0.249611,-0.491507,0.317093,-0.183919,0.0771843,-0.0679311,0.0522394,-0.18602,-0.19702,-0.390315,-0.223358,-0.355216,-0.985159,-0.725728,0.0369372,0.152929,0.249878,0.391062,0.499878,-0.76841 +3407.69,0.988522,0.0912059,4,1.61474,0.995961,-0.199596,0.00866469,0.348464,0.0263015,0.253138,0.132318,0.825512,-0.122834,0.00375777,-0.331361,0.203044,0.138145,0.272718,0.617441,0.215275,0.0996298,-0.264475,-0.051736,-0.261067,-1.25099,-1.03267,0.136416,-0.0532832,0.0188842,-0.173802,0.514311,-0.22,0.0452026,1.16181,-0.597922,0.467585,0.155392,0.201245,-0.370929,-0.134983,0.147722,0.230999,-0.415969,0.569752,0.402916,-0.383196,-0.238275,0.138521,-0.115946,-0.226318,-0.110272,0.365947,-0.327095,0.311398,-0.595142,-0.11848,-0.46973,0.904108,-0.456755,-0.204273,-0.496039,0.5785,-0.594114,0.0472853,0.859945,-0.879168,-1.40262,0.215676,0.282012,0.139056,-0.158305,0.196929,-0.164684,-0.047627,-0.00544529,0.8727,-0.0976571,0.763203,0.390664,0.463371,0.3629,-0.50082,0.0193481,0.642506,0.0701573,-0.0120154,-0.383946,-0.319419,-0.196377,-0.87255,-0.328787,0.131055,-0.598374,0.279665,-0.0420356,0.0964343,-0.0256921,0.197663,-0.291796,0.708274,-0.341225,0.0532252,0.455546,-0.0105341,0.306987,-0.612014,-0.629868,-0.000582332,-0.372237,0.263893,-0.38336,0.809172,0.296737,0.901519,0.195076,0.14956,0.43711,0.370876,0.370264,0.182636,-0.0418166,-0.299789,0.476181,-0.52056,0.244138,0.28007,-0.170007,-0.319289,0.12757,-0.863642,0.0568218,0.120819,-0.576713,0.370331,0.255846,-0.217043,0.82839,-0.386897,-0.367718,-0.378829,0.300158,0.149095,-0.072716,-0.460935,-0.150087,-0.0017296,-0.548142,0.228186,0.20435,0.040143,0.400741,-0.267078,-0.512123,-0.175354,-0.213138,-0.308809,-0.0174541,0.115602,0.616319,0.77505,1.1152,0.435537,0.322108,0.519992,0.035421,0.309863,-0.0229675,-0.441871,0.376668,-0.0370805,-0.23783,-0.00363478,-0.397711,0.121038,-0.101859,0.0573108,0.352717,0.22594,0.156854,-0.768214,0.294358,0.412376,0.533454,0.275064,-0.368023,0.373553,-0.57325,0.0990261,-0.438188,-0.12826,-0.0102689,0.0292327,-0.413675,0.312018,-0.227745,0.796872,-0.699958,-0.102082,0.808249,0.334765,-0.225143,-0.547,0.774037,0.0128499,0.0338971,0.388357,-0.107343,0.10514,-0.0652556,-0.535657,0.647157,-0.133209,0.455185,-0.187087,-0.251164,0.921764,0.201072,-0.334172,0.473715,-0.340029,0.429733,-0.0519795,-0.869994,-0.5605,-0.119321,-0.274461,0.876732,0.177825,0.397057,0.130586,-0.304933,0.366714,0.15464,0.154527,-0.0903266,-0.0511988,0.0938338,-0.563504,0.0805705,-0.182274,0.357952,-0.18474,-0.382604,-0.4923,0.250021,-0.55763,0.352623,0.154777,0.75542,0.326023,0.581536,-0.66716,0.181316,-0.0537526,-0.0774818,-0.1246,-0.484763,-0.116868,0.233357,-0.566792,0.589828,-0.129906,0.0890897,0.0321644,0.324009,-0.00838924,0.21405,-0.165385,0.26846,-0.344,0.0428581,-0.396778,-0.335665,-0.317386,-0.236193,0.424191,0.0529511,-0.313335,-0.27799,0.450795,-0.203988,0.162494,-0.110383,-0.710734,-0.160792,-0.0117762,-0.18485,-0.0671897,0.225594,0.212501,-0.743143,0.502242,0.0668439,-0.0129964,-0.0424161,0.0740347,-0.0209075,0.0423682,-0.216575,-0.36364,-0.244831,-0.904244,-0.500986,0.0993419,0.157919,0.213051,0.39739,0.461574,-1.21282 +3406.18,0.883004,0.0912059,4,1.53316,1.04444,-0.44416,0.0741992,0.242207,-0.13707,0.298991,0.181379,1.42315,0.22973,-0.256632,0.0725598,0.249834,0.015012,-0.036332,0.308856,0.190814,-0.024658,0.359194,-0.358373,-0.461753,-1.3022,-1.49687,0.245975,-0.361924,-0.0773766,0.648635,0.0572111,-0.0449879,0.216114,1.18257,-0.169085,0.162387,0.595634,-0.417392,-0.0186262,-1.01889,0.522421,-0.115495,-0.361755,0.685502,0.0958082,0.541834,-0.343478,0.20305,-0.174675,-0.763578,-0.0630477,0.798622,0.0798839,0.071326,-0.104049,-0.0648524,0.12726,0.838438,-0.164767,-0.0663506,-0.554733,0.746624,-0.272196,0.0333006,1.04058,-0.349022,-0.49012,0.0885587,0.476806,-0.0516968,-0.34126,0.188828,-0.532649,-0.236924,0.529698,0.971403,0.0230119,1.25723,0.666597,0.273666,-0.307869,0.22782,0.136251,0.94109,-0.233216,-0.0820612,0.012944,-0.484499,0.271757,-0.518039,-0.209713,0.00828561,-0.778442,0.571181,-0.0105681,-0.220831,0.208292,0.245413,-0.170118,-0.262655,0.191741,-0.424827,0.580078,0.274645,0.0102555,-0.4729,-0.0114673,0.447952,-0.405814,0.917571,-0.657059,0.0915107,0.289403,0.660298,0.0542613,0.209203,0.289373,0.396991,0.0795802,-0.604328,-0.13738,1.06861,0.0491654,-0.925608,-0.037647,-0.0157115,-0.319666,0.50836,0.0284057,-0.0160815,0.30023,0.437318,-0.984847,-0.0568144,0.468452,0.210515,1.03145,0.0999915,-0.403344,-0.0793643,0.192186,0.651151,-0.112148,0.137546,-0.158811,0.119888,-0.429115,-0.330342,0.872099,-0.294067,0.649572,-0.548997,0.0151337,-0.345367,0.143979,0.432187,-0.335111,0.0481643,0.0282794,0.541119,-0.286176,0.730106,0.405212,-0.140573,-0.333875,0.549195,0.0938642,-0.126928,0.0119395,-0.112383,0.201195,0.181118,-0.152314,0.279671,-1.05485,-0.170282,-0.113795,-0.249675,-0.00475297,-0.502778,-0.674044,0.449664,0.733468,0.123081,0.285429,0.5372,-0.711464,-0.577954,-0.994025,-0.0187983,-0.374251,-0.23051,-0.410388,0.288785,0.202836,0.161245,-0.512807,0.210936,-0.211355,0.358795,-0.327695,-0.194491,0.518142,-0.382364,0.32084,0.15615,0.0645151,-0.104802,-0.278571,-1.37981,0.54331,-0.00782612,-0.604329,-0.172443,-0.322189,0.107653,0.061198,-0.0489247,-0.0588785,-0.901145,0.116662,0.617104,-0.256902,-0.0750293,-0.590231,0.189834,0.105692,-0.515611,0.357397,-0.446473,-0.257819,0.630066,0.481864,-0.366949,0.135986,0.407903,-0.221355,-0.574972,0.406003,0.0681916,0.024469,0.992319,-0.910378,-0.144953,-0.472408,-0.471159,0.193168,-0.165562,0.107473,0.483914,0.101274,-0.0586038,-0.262546,-0.124392,0.0935154,0.152684,-0.0138402,-0.157024,0.223383,-0.195451,0.366863,-0.0438834,-0.260461,0.698662,0.244693,0.0975146,0.389381,-0.24682,-0.13815,-0.230359,0.527954,-0.576312,-0.138974,-0.161678,-0.390591,-0.0280844,0.212397,-0.0339573,-0.0308798,0.662778,0.154406,0.30683,-0.22435,-0.144759,-0.196461,-0.898678,0.155624,0.024121,-0.192461,-0.364001,0.454256,0.16383,0.0148571,-0.0973053,0.0429585,0.360453,0.248515,-0.183794,-0.854768,0.304048,-0.147346,-0.184835,-0.262995,0.00825313,0.175937,0.304496,0.419448,0.551812,-0.920163 +3382.72,0.982836,0.0912059,4,1.47545,1.17327,-0.123053,-0.0341371,0.497007,0.0353896,0.322823,0.208338,0.388586,0.917706,0.00958485,0.0494249,0.179554,0.288556,-0.295642,0.868177,-0.076047,0.0461344,-0.515782,-0.143153,-0.275003,-1.28429,-0.0959235,0.0198289,0.0261962,0.0854701,0.426454,0.415312,0.240911,0.460313,1.26754,-0.653261,0.491835,-0.0709638,0.0682478,0.11904,-0.195218,0.5687,0.683408,0.167456,0.6818,0.296931,0.532997,-0.330092,-0.202682,0.367065,-0.341719,-0.0444282,0.29241,0.133887,0.303523,-0.0465176,-0.204918,-0.208093,0.707722,-0.0135798,0.258135,-0.386164,0.431459,-0.631573,-0.0610485,0.554094,-0.692541,-1.35793,0.149701,-0.601045,-0.358997,0.216808,-0.534055,-0.421067,0.390073,0.826702,0.682816,0.568142,1.03102,0.313926,0.113161,0.24028,-0.55715,0.24234,1.11422,0.452667,0.454086,-0.108421,-0.0975229,-0.564418,0.169242,0.249009,0.0530837,-0.800241,0.367797,0.933794,0.0885433,-0.496192,-0.0225289,-0.781382,0.0474042,-0.256137,-0.159939,0.559486,0.296836,-0.00319734,-1.03537,-0.746989,-0.180615,-0.308942,0.408791,-1.06932,0.77329,0.753117,-0.0833872,-0.0551895,0.0687492,0.549735,0.227435,-0.0430811,0.0278675,0.0417692,0.139389,0.0804118,-0.767901,0.855112,-0.837662,0.035565,-0.21359,0.66594,0.356795,0.136201,0.313073,-0.0480551,-0.291974,-0.00724507,0.36782,0.585573,-0.0659574,-0.0518655,0.519936,-0.0372934,0.286102,-0.358692,-0.468155,-0.0851971,0.416003,-0.716496,-0.597191,0.581582,-0.455366,0.127369,-0.634826,-0.13686,-0.750374,0.0606019,0.0351855,-0.189779,0.378498,0.600486,-0.179762,-0.221769,0.240452,-0.175219,-0.215812,-0.46098,0.828309,-0.247555,0.120108,0.46435,0.212725,-0.565537,-0.100939,0.0866031,0.555402,-0.0115388,0.133346,-0.190007,-0.308909,-0.128136,-0.276249,-0.830093,0.1085,1.00357,-0.0967239,-0.102064,0.202149,-0.333794,0.107495,-0.62493,-0.531912,-0.27082,-0.368832,-0.764055,0.0231751,-0.158385,0.409128,-0.503428,0.476468,0.513538,0.337336,-0.444925,-0.0465275,0.0873746,-0.114881,-0.081263,0.232424,-0.524165,-0.165429,-0.533037,-1.13701,0.489286,0.629496,-0.220901,0.152552,0.280229,0.223124,0.576812,0.064213,0.76409,-0.688908,0.633534,0.432188,-0.926654,0.271327,-0.609985,0.16768,0.416029,0.0364514,0.272983,-0.430909,-0.722521,0.547298,0.332844,-0.838073,0.0320613,-0.336717,-0.687476,-0.36874,0.292902,0.0771642,0.089854,0.420921,-0.641318,-0.736917,0.373566,0.483612,0.503807,0.110239,0.299788,0.200989,-0.370641,-0.446857,-0.134036,-0.00364835,-0.375761,0.412152,-0.510462,-0.382812,0.775434,-0.3501,0.0478246,-0.322821,0.0337984,-0.342718,-0.25167,-0.683713,1.00699,-0.0312755,-0.414929,-0.708007,-0.0110976,0.0956323,-0.11176,-0.0495657,-0.690675,0.367449,0.393519,0.179429,-0.223379,0.207998,0.220926,-0.0149632,0.00261607,0.096719,0.246879,-0.0262915,0.325648,0.174691,0.355022,0.152229,0.319873,0.694886,0.177316,0.0593083,-0.384114,-0.00793878,0.0654765,0.155024,-0.075431,0.213275,-0.596845,-0.168375,-0.515172,0.129316,0.189868,0.198958,0.435739,0.446047,-2.16061 +3408.51,0.967169,0.0912059,4,1.42004,1.07169,-0.213311,-0.0173358,0.735206,-0.0412869,0.652212,0.1983,0.737715,0.106281,-0.0991609,-0.017025,0.230805,-0.121188,-0.126233,1.03065,0.268397,0.0434082,0.265549,-0.155436,-0.123893,-0.579682,-0.901298,0.0605387,-0.485572,0.11156,0.80272,0.102088,-0.394566,0.332256,0.750448,-0.332672,0.075301,0.413762,-0.00764282,0.10292,-0.829659,-0.0229689,-0.123833,-0.313759,1.07485,0.179929,0.562432,0.11971,0.177315,-0.0802451,-0.832359,-0.426705,0.766288,-0.413576,-0.238318,-0.326462,0.234251,-0.0631929,0.831368,-0.443607,0.231416,-0.757277,0.388674,-0.248514,0.582508,1.25175,-0.741314,-0.4231,-0.173658,0.312126,-0.10928,0.209924,0.611349,0.0891257,-0.425691,0.298732,0.551114,0.0345495,0.378049,0.693202,0.747388,0.303558,-0.403481,-0.168767,-0.00369184,-0.448492,-0.00392008,0.175077,-0.246666,0.0329647,0.311029,-0.221898,-0.201888,-0.228699,0.160501,0.0970822,0.164271,-0.0527148,-0.19599,0.129963,0.425418,0.0774951,0.0289088,0.370809,0.35598,-0.140659,-0.280348,-0.0441349,0.170594,-0.395662,0.516644,-0.241312,0.258589,0.902302,0.113223,0.258267,0.201812,0.540463,0.192557,0.0078998,-0.577901,0.63598,0.207081,-0.167892,-0.38206,-0.375839,0.374018,0.0589948,0.220636,0.0193404,0.437882,0.0550455,-0.0466885,-0.821836,-0.131232,0.285161,0.422984,0.410221,-0.126928,-0.389064,-0.680314,0.280162,0.0831803,-0.787426,-0.134749,-0.0788494,0.458885,-0.238257,-0.164807,0.481059,-0.138965,0.265125,-0.292082,-0.284404,-0.0868832,0.11324,0.533988,0.275166,0.0999831,0.0932184,0.892349,0.180915,0.527075,0.565045,0.130718,-0.153665,0.875994,-0.415618,-0.633987,0.0684165,-0.106058,0.35092,0.479961,0.00038042,0.10022,-0.320929,0.154216,0.286839,-0.418244,-0.0660231,0.0935431,-0.625678,0.128655,0.665689,-0.0520644,0.213131,0.183648,-0.362615,-0.0852721,-0.376021,0.0372455,-0.666325,0.121459,-0.0335854,0.432475,0.288556,0.105866,-0.77163,-0.325199,0.681611,0.185111,-0.180562,-0.295071,0.133113,0.198102,-0.130912,0.0815744,0.164498,-0.101214,0.316615,-0.000992942,0.856828,0.0936895,-0.100311,-0.0052843,-0.205692,0.118616,0.378891,0.464778,0.205428,-0.679387,0.0971715,0.44394,-0.00366373,-0.513152,-0.095736,0.193695,-0.0163042,-0.10695,0.434084,-0.285512,0.0165926,-0.264519,0.203093,-0.271154,0.43063,0.0312214,-0.570872,-0.838427,0.59768,0.260223,-0.154047,0.735421,-0.525261,0.14325,0.413808,-0.533259,-0.0266783,0.254863,-0.201027,0.522486,0.180119,-0.627875,-0.24895,-0.107311,-0.655207,0.351334,-0.0675928,-0.747506,-0.0568091,-0.0698023,-0.256167,-0.118662,0.0295488,0.570809,0.721934,0.169252,0.0514943,0.574915,-0.0580251,-0.135616,0.24631,0.133307,-0.0240716,-0.219961,-0.583198,0.0155902,-0.313408,-0.188274,0.475679,0.01012,0.398456,0.10035,-0.482396,-0.354582,-0.0035169,0.0709569,-0.066851,-0.0913133,0.829724,-1.07262,0.8548,-0.0864633,-0.300146,0.170504,-0.00231658,-0.0677577,0.461094,-0.102597,-0.244728,-0.211641,-0.552069,0.0399943,0.414768,0.36227,0.137583,0.324491,0.370921,0.569641,-2.77653 +3403.87,0.959725,0.0912059,4,1.5631,1.15475,-0.178866,-0.0816157,0.476245,0.0788145,0.395912,0.956053,0.129727,0.153045,-0.0394927,0.125634,-0.0138092,-0.263098,-0.247342,1.36766,-0.247194,0.130113,-0.99374,-0.299729,-0.371027,-0.969645,-1.37727,-0.0778991,-0.524812,0.216848,-0.0408435,0.39314,-0.229981,0.188701,0.753808,-0.988653,0.33571,-0.102583,-0.178575,0.123292,-0.370089,0.176854,0.503632,-0.211632,1.00785,-0.217893,-0.110328,-0.426056,-0.145532,-0.328127,-0.180131,0.472046,0.731149,0.154034,-0.142714,0.470673,0.373201,0.012839,0.862957,-0.485548,0.534678,-0.266249,0.583091,-0.568039,0.44287,0.749391,-1.12046,-1.23307,-0.145867,-0.200129,0.00945919,0.678897,0.619046,-0.44132,-0.332369,0.213122,1.41694,0.237866,0.361871,0.211317,-0.0266547,0.508214,-0.230279,-0.134692,0.547011,-0.110303,0.149724,0.486867,-0.0279182,0.311545,0.772078,0.270378,-0.142873,-0.508105,0.79882,0.319305,0.381196,0.31082,0.676224,-0.128563,-0.208062,0.135996,0.445427,0.0437397,0.587645,0.153507,-0.501655,-0.243173,0.123374,-0.480709,0.0426602,-0.398659,0.387704,0.987377,-0.0029415,0.183614,0.355005,0.514206,-0.313933,0.0819239,-0.237761,0.106036,0.528527,0.0421725,-0.601027,0.282865,-0.0229895,-0.0546007,0.161799,0.349635,0.368649,-0.089173,0.367329,-0.373974,0.443677,0.62753,-0.30651,0.137219,-0.21229,-0.231429,-0.338556,-0.148752,0.253306,-0.650979,0.637041,-0.012062,0.355511,-0.737807,0.523782,0.124453,-0.316829,0.158838,-0.562332,0.326254,-0.624127,0.244724,0.111611,-0.230957,0.446959,0.712412,0.441942,-0.0172756,-0.128949,0.373437,-0.0595018,-0.225949,0.954831,0.152268,-0.0976671,0.181635,-0.395364,0.521257,0.437068,0.482344,-0.165224,0.127755,0.0444833,0.0604858,-0.334525,0.0970279,-0.448466,0.0840428,-0.33322,0.705918,-0.0342286,-0.303357,-0.205969,-0.433372,-0.352118,-0.163599,-0.30589,-0.254194,-0.283156,-0.381187,0.505707,0.11709,0.132967,-0.311397,-0.0970062,0.48335,0.111702,-0.180454,0.0189347,0.284249,-0.191806,0.280405,-0.0100948,-0.25158,0.135194,0.122386,-0.597185,0.806882,0.00942733,0.711082,0.00328319,0.414408,-0.103247,0.58992,-0.33396,0.325082,-0.30019,0.406796,0.340515,0.0897106,-0.266625,0.0689473,0.381428,0.143689,0.121598,0.0520839,0.120643,-0.139216,-0.013534,-0.125304,0.0336616,0.0467218,-0.126801,-0.449188,-0.812011,0.484078,0.311389,-0.00945325,0.345917,0.119948,0.344379,0.290226,-0.176555,-0.163431,0.736879,-0.264541,0.232054,0.130991,0.27737,-0.425787,0.136198,-0.349634,0.260156,-0.594607,-0.551685,0.796476,-0.391759,0.0166537,0.444752,-0.056049,0.243394,0.0520537,-0.515681,0.886609,0.0460139,0.139555,-0.164334,0.313185,0.0925238,0.131793,-0.243549,-0.477271,-0.24092,-0.696796,0.133723,0.2676,-0.189468,0.541345,0.285969,0.146378,-0.221028,-0.126277,0.180697,0.00224057,-0.449148,0.304274,0.28003,0.222749,-0.207389,-0.267468,-0.0553989,0.172031,-0.359298,0.176282,0.155177,-0.678717,-0.226571,-0.342817,0.299795,-0.638431,0.554034,0.142791,0.273128,0.377877,0.522617,-1.9078 +3392.01,0.995746,0.0912059,4,1.51146,1.17172,-0.36393,0.00967373,0.668348,0.0414803,0.19945,0.243992,0.188027,0.793174,-0.219882,0.140406,-0.0146588,-0.597445,-0.144312,0.97883,-0.22579,0.0515811,-0.68992,-0.212711,-0.503106,-1.0987,-0.630572,-0.0460007,-0.530403,0.357753,0.126976,0.238839,-0.603388,0.209806,0.837915,-0.544231,0.409736,-0.226869,-0.424752,-0.111219,-0.194686,1.0102,0.527722,-0.24015,1.13448,-0.0658103,0.12416,-0.706104,-0.321572,-0.554224,-0.397568,0.37458,0.782655,-0.20114,-0.547735,0.450735,0.235164,-0.0512804,0.862593,-0.193836,0.00252114,-0.540303,0.415155,-0.45815,0.453204,1.07125,-0.64032,-1.44917,-0.0622535,0.111088,-0.410032,0.472622,0.270118,-0.624437,-0.368254,0.333876,1.31736,0.0489144,0.649006,0.531876,0.245321,0.694835,0.282068,-0.00674164,0.275876,0.0420351,0.0519494,-0.0270581,-0.239505,0.161279,0.970158,-0.112613,-0.216576,-0.604662,0.671064,0.28216,0.393683,0.105143,0.262267,-0.486886,-0.0857983,-0.226893,0.354943,0.0612895,0.758735,-0.257574,0.0245143,0.0611233,0.0974689,-0.508524,-0.262594,-0.221948,0.325146,0.962491,0.168652,0.0922519,-0.0309344,0.309102,-0.29264,-0.361756,-0.500777,0.0198044,1.00014,-0.176645,-0.85173,-0.0458767,-0.0946138,-0.362139,0.180984,0.37922,0.544458,-0.0405164,-0.054811,-0.38165,0.638271,0.538211,-0.463055,0.439234,-0.138515,-0.131408,-0.0862964,0.173851,0.311017,-0.745013,0.349036,-0.173977,0.0969016,-0.263386,0.194493,0.371886,0.014855,0.38367,-0.524565,0.359157,-0.398859,0.263689,0.362622,-0.0428027,-0.0301762,0.467729,0.15914,0.322544,-0.00354548,0.554558,0.341933,-0.437621,1.36189,0.0868619,-0.177813,0.61848,-0.0266631,0.479947,0.494198,0.136371,0.459191,0.0582814,0.121761,-0.184965,-0.176535,-0.359992,-0.136361,-0.0237247,0.105138,0.701875,-0.132222,-0.540769,-0.0843446,-0.268888,-0.301704,-0.17661,-0.818758,-0.51422,-0.127016,0.163986,0.758515,-0.00912408,0.354526,0.0469495,0.0872366,0.764853,-0.28167,-0.0710387,0.167157,-0.213337,-0.0797187,0.31818,0.0971612,-0.469685,-0.040647,-0.151873,-1.26224,0.829072,-0.483167,0.27165,0.34191,0.365532,-0.466488,0.369493,-0.638093,0.490516,-0.516177,-0.0496761,-0.124366,0.0332514,0.912492,0.12197,0.934746,0.231362,-0.496241,0.217082,-0.389365,-0.181966,-0.383763,-0.690643,0.178211,0.0481354,-0.223835,-0.867231,-0.924225,0.481087,0.376366,0.486057,-0.0491575,0.155126,0.134017,0.209432,-0.1392,-0.312206,-0.0125367,-0.177545,0.175019,0.0975579,0.162483,-0.174584,0.46935,-0.436909,0.145517,-0.274663,-0.655457,0.370816,-0.0215338,-0.167221,0.523546,-0.226906,0.570956,-0.0184769,0.421388,0.557428,0.0736004,0.369341,-0.509769,0.293879,0.114112,0.506553,-0.395227,-0.365731,-0.29642,-0.152602,0.266744,0.361041,-0.225485,-0.270597,0.389231,0.14956,-0.0157374,-0.0428088,0.0353643,-0.190749,-0.862024,0.520524,-0.0275924,0.518772,-0.27004,-0.0121329,-0.336985,0.0432283,-0.103587,0.42897,0.00394189,-0.723742,-0.114806,0.0441992,-0.0823793,-0.204609,0.0346949,0.157671,0.289743,0.397078,0.538278,-2.60719 +3411.32,0.947655,0.0912059,5,1.60345,1.17834,-0.126709,-0.00780807,0.489434,0.0642282,0.294179,0.201572,0.772596,0.893732,0.159318,-0.173893,-0.304893,-0.232721,-0.158859,0.999027,-0.0567166,-0.0617198,-0.394103,-0.602502,-0.539208,-0.882462,-0.720985,-0.135515,-0.314071,0.313418,0.107541,0.175765,-0.174899,0.0259272,0.813086,-0.977834,0.309069,-0.0172754,-0.410998,-0.0375206,-0.522925,0.581561,0.559057,-0.288149,1.01257,0.092816,0.159416,-1.13453,-0.485072,-0.273054,-0.860271,0.112441,0.503724,-0.171345,-0.235178,0.508143,0.35189,-0.270727,0.604834,-0.174478,-0.218171,-0.380584,0.400725,-1.16312,0.423351,1.14091,-0.810307,-1.08974,-0.0233693,-0.213463,-0.162526,0.490045,0.0302146,-0.275922,-0.254279,0.52741,1.06629,-0.103912,0.675439,0.641795,0.00155742,0.0568691,0.0861949,0.10703,-0.0308395,-0.350239,0.000911833,0.178473,-0.0351692,0.0747468,0.997143,-0.000980751,-0.155793,-0.643511,0.591012,0.259742,0.415212,0.00147332,0.0870837,-0.0298433,-0.348064,-0.184936,0.581607,0.132451,0.858202,-0.0432924,-0.120096,0.144653,0.321538,-0.608072,-0.402657,-0.262105,-0.196165,0.9991,-0.0310763,0.167526,0.0731263,0.374247,-0.21744,-0.113107,-0.181588,0.0384123,0.465337,-0.0842677,-0.899738,0.0140366,-0.068121,-0.563166,0.0690739,0.282074,0.932204,-0.124679,-0.0271724,-0.225744,0.224916,0.457145,-0.393862,0.494797,-0.315466,0.048647,0.205672,0.023336,0.392653,-0.676814,0.164875,0.0479242,-0.15432,-0.53837,0.317474,0.395348,-0.0831354,0.351879,-0.260437,0.198371,-0.289299,0.576258,0.165972,0.393738,0.12799,0.438648,0.0853332,0.234758,-0.130508,0.578665,0.479556,-0.0914147,1.35623,-0.198175,-0.168158,0.406116,-0.00512584,0.457976,0.298344,0.380296,0.228972,0.0263995,-0.115803,-0.618078,0.075251,-0.217017,-0.10334,-0.115139,0.512783,0.44406,-0.117277,-0.8136,-0.0832256,-0.144584,-0.00650682,-0.144166,-0.398486,-0.191039,0.075746,0.270752,0.657171,0.192377,0.201329,-0.304132,0.477729,0.68457,-0.3279,-0.200366,-0.101663,0.263335,-0.0911997,0.567703,0.0060779,-0.421118,0.00288838,-0.00751023,-1.18035,0.698855,-0.240516,0.243533,0.421833,0.48128,-0.0704318,0.0879841,-0.313728,0.539257,-0.522458,-0.105057,0.136435,-0.278965,0.316883,0.275484,0.508503,0.38382,-0.528805,0.179888,0.00470574,0.204409,-0.0959113,-0.398429,0.0936702,0.0951436,-0.385477,-0.713978,-0.46291,0.412258,0.391837,0.264371,-0.0438431,0.0588223,-0.398978,0.179943,-0.256083,-0.256578,0.273422,0.245683,0.0341337,-0.0134441,0.0889472,-0.136077,0.194232,-0.656852,0.338934,-0.206634,-0.334962,0.37063,-0.297782,0.0484081,0.818728,-0.33361,0.438153,0.218706,0.421421,0.118981,-0.0580509,0.293832,-0.0617771,0.206064,0.0367015,0.282414,-0.398789,-0.369492,-0.373926,-0.357365,-0.248341,0.316902,-0.0361793,-0.270043,0.530079,0.434206,-0.192203,-0.0939661,0.078266,-0.12118,-0.848816,0.159752,0.122017,0.694871,-0.398077,-0.340509,-0.0289099,0.209805,0.167619,0.617654,-0.1265,-0.980727,-0.123306,0.0921154,-0.0337131,-0.0389885,-0.234734,0.175295,0.312737,0.418682,0.559229,-2.04669 +3405.99,0.792742,0.0912059,5,1.61396,1.04042,-0.299228,0.0721329,0.592417,0.040959,0.00432337,0.191899,0.388973,1.08936,-0.0497638,-0.34978,-0.288594,-0.326694,-0.0915375,0.974916,-0.0209092,-0.12866,0.237193,-0.313298,-0.339931,-1.0372,-0.898475,0.166078,-0.627395,0.0779442,0.185358,-0.0141081,-0.538011,0.0507772,0.897962,-0.845668,0.00323896,0.251936,-0.357083,0.0968778,-0.664175,0.74339,0.374318,-0.632456,1.1252,-0.0788652,0.138347,-0.740184,-0.445731,-0.505092,-1.26889,0.229686,0.593761,-0.00369892,-0.482153,0.332627,0.224099,-0.276431,0.887148,-0.221406,-0.316826,-0.748705,0.381492,-1.02903,0.106436,1.11568,-0.822267,-1.27274,0.196017,0.0538779,0.0918041,0.436794,-0.302998,-0.1457,0.0661246,0.368983,0.995966,0.254888,0.773425,0.668886,0.0637192,0.256225,0.116654,0.0133276,-0.000549523,-0.0609428,0.134997,0.273965,0.0186859,0.21444,1.0892,-0.0242762,0.057377,-0.937359,0.785103,0.0302595,0.293411,0.140528,0.10608,-0.00574279,-0.187691,-0.5371,0.376615,0.113152,0.697731,-0.0169382,-0.630445,-0.0444918,0.628894,-0.595922,-0.21672,-0.204954,0.103564,0.799784,0.0322078,-0.178796,-0.073629,0.231201,-0.474071,0.122211,-0.256419,0.118213,0.61263,-0.0692524,-1.01164,-0.189858,-0.0990658,-0.224742,-0.184993,0.235397,0.650523,-0.0106674,-0.266967,-0.203435,0.355896,0.659265,-0.429071,0.719263,-0.110087,-0.00639217,0.245087,0.394903,0.648964,-0.625749,0.578807,-0.0939066,0.147764,-0.270581,0.306133,0.287336,-0.249488,0.445087,-0.0764944,-0.201151,0.469763,0.515595,0.0163466,0.256231,0.587548,0.26997,-0.0173445,0.0373176,-0.476016,0.182162,0.413089,-0.0694584,1.27125,0.279159,-0.0416106,0.109525,0.104825,0.403744,0.170671,0.335316,0.247849,-0.107191,-0.0483413,-0.550999,0.404199,-0.65819,-0.112541,0.0577711,0.372455,0.774264,-0.147278,-0.751445,0.102825,-0.333434,-0.216875,0.355332,-0.233782,-0.239525,0.359084,0.24798,0.692229,0.263519,0.396342,-0.589877,0.418379,0.443543,-0.110714,-0.33942,0.0800303,0.43387,-0.173057,0.256463,-0.0774983,-0.617808,0.0317337,-0.0932326,-0.980791,0.504122,-0.389301,0.180091,0.2184,-0.108317,-0.0743685,0.418937,-0.278053,0.865362,-0.38243,-0.0262462,0.0647007,-0.213985,0.570759,-0.278841,0.155669,0.186945,-0.33095,0.480013,0.260057,-0.106068,0.0125303,-0.5281,0.0147889,-0.0302659,-0.24695,-0.470325,-0.469944,0.339128,0.470811,0.155692,-0.0563108,0.301497,-0.0951262,0.0567716,0.127828,-0.382325,0.127855,0.103359,0.265295,0.0319542,0.208932,0.101249,0.116494,-0.305131,0.233473,-0.268093,0.273668,0.604861,-0.463726,-0.201189,0.413748,-0.311443,0.243148,0.357313,0.390302,0.352489,-0.118914,0.300831,-0.211529,0.0163838,0.108545,0.176476,-0.10786,-0.62335,-0.334637,-0.123026,-0.0945795,0.514315,-0.0676037,0.0644645,0.696902,0.0811655,-0.232238,-0.105842,0.106677,0.289664,-0.804657,0.215618,-0.175032,0.0790138,-0.439929,-0.185201,-0.0980521,0.138205,0.121517,0.337367,-0.262263,-1.28985,0.148065,0.0949021,0.153951,0.0744545,-0.0938325,0.135612,0.300778,0.368256,0.548432,-2.11358 +3393.94,0.89986,0.0912059,4,1.59508,1.05258,-0.402411,0.132772,0.753764,0.0265746,-0.180325,0.216848,0.573105,1.21615,-0.127801,-0.258199,-0.262306,-0.255488,-0.255902,0.805954,-0.0771069,-0.167122,0.326747,-0.184939,-0.35652,-0.986973,-1.03574,0.130207,-0.587661,0.0864553,-0.0426952,0.0750496,-0.398253,0.00561527,0.95616,-0.719384,0.173973,0.0626744,-0.235479,0.179591,-0.564531,0.682208,0.58947,-0.902883,1.04756,0.0013378,0.270813,-0.681649,-0.355523,-0.810348,-0.942684,0.473887,0.489719,0.211719,-0.522637,0.19705,0.0568836,0.0139048,0.756176,-0.298653,-0.248995,-0.526725,0.499566,-1.03149,0.0959099,0.943242,-0.702149,-1.27425,-0.0810226,0.181651,0.276987,0.442455,-0.438556,-0.289359,0.29528,0.380059,1.13506,0.393492,0.522467,0.630389,-0.0690337,0.112456,0.15452,-0.0118652,-0.0470341,-0.116096,0.0155939,0.23712,0.00277216,-0.0653414,1.18298,-0.221542,0.0436425,-0.892911,0.840279,0.129549,0.262679,0.488253,0.165358,-0.131239,-0.179163,-0.919134,0.199824,-0.0344341,0.47732,-0.286257,-0.459505,-0.272141,0.376761,-0.126564,-0.174033,-0.442086,0.16685,0.92147,-0.0693005,-0.0349991,0.167318,0.265784,-0.466879,0.344842,-0.16677,0.0266969,0.457164,0.0994574,-1.3399,-0.0606958,-0.00543671,-0.125132,-0.0426094,-0.217057,0.580555,-0.159663,-0.0809155,0.0843321,0.358477,0.788177,-0.443848,0.868474,-0.303076,0.10156,0.00490806,0.527572,0.398281,-0.349174,0.864992,-0.0909093,0.376838,-0.330819,0.702025,0.141162,-0.484544,0.627482,-0.29797,-0.483336,0.079224,0.409526,-0.199245,0.00162258,0.437893,0.0835315,-0.00853086,0.260542,-0.485061,0.22179,0.294031,-0.0778113,0.86619,0.510261,-0.194901,0.0968071,0.0526183,0.0921267,0.185722,0.232358,0.096392,-0.070356,-0.00166417,-0.400048,0.375352,-0.790125,-0.280389,0.144838,0.217158,0.742089,-0.135096,-0.693054,0.0494284,-0.395558,0.0512678,0.282546,-0.207196,-0.283702,0.292394,0.416283,0.759812,0.247901,0.233407,-0.563062,0.621479,0.328419,0.107397,-0.184379,0.0424051,0.416757,-0.106248,0.111025,0.0532344,-0.525175,-0.0424789,0.0512701,-1.00491,0.536509,-0.178395,0.276221,0.236154,-0.12885,-0.142169,0.324561,-0.257692,0.833449,-0.394094,0.0323564,-0.303243,-0.165498,0.509439,0.0268988,0.243055,0.220754,-0.208861,0.256795,0.19954,-0.0886675,-7.62517e-05,-0.646918,0.0482162,-0.147295,-0.0027228,-0.209354,-0.298,0.217876,0.244076,0.225126,-0.264088,0.109586,0.169574,-0.0349024,0.0556651,-0.411629,0.108861,0.124988,0.440907,0.0613607,-0.0257359,0.181104,0.00941633,-0.188159,0.251559,-0.295545,0.123224,0.561727,-0.347526,-0.241949,0.482312,-0.285149,-0.0173416,0.413322,0.150398,0.369813,-0.207113,0.390041,-0.304779,0.115221,0.0176229,0.217598,0.0399286,-0.542741,-0.249624,-0.109289,-0.329387,0.431935,-0.0251333,0.252547,0.357237,0.0211122,-0.338917,-0.281504,0.0468916,0.197238,-0.619418,0.251591,-0.0456961,0.0749093,-0.292761,-0.3055,-0.323597,0.140857,0.130531,-0.11384,-0.18519,-1.35014,0.155659,0.292485,0.0758522,0.246456,0.203876,0.122541,0.372989,0.350058,0.610728,-2.6893 +3414.62,0.71334,0.0912059,4,1.58263,0.874698,-1.09724,0.381532,0.369373,-0.110272,-0.0641116,-0.109877,-0.291718,-0.609744,-0.0509014,-0.168987,-0.214993,0.652759,-0.26775,0.893703,0.115856,0.0799594,-0.564731,0.170089,-0.474876,-0.484189,-1.05226,0.239195,0.0501042,-0.0979154,0.160495,0.775001,0.00666258,-0.054085,0.713131,-0.254731,0.403709,0.287643,-0.0941127,-0.479973,-0.156551,0.136821,0.246586,0.159504,1.16935,0.533516,-0.037386,-0.570096,-0.018355,0.561499,-0.424983,-0.318539,0.228934,0.0959107,0.409669,0.0911952,-0.0171435,-0.655218,0.978364,-0.261282,-0.765264,-0.998791,0.725543,-0.346553,-0.191444,1.12793,-0.670815,-0.824793,0.15721,0.33843,0.0523058,-0.196581,0.472543,-0.449223,-0.22267,0.534151,0.348384,-0.371785,0.30526,0.043704,0.656865,0.0209544,-0.37296,0.148206,0.717231,0.342607,0.0809723,-0.118234,-0.122448,0.0420993,-0.864065,-0.257332,0.107529,-0.194741,-0.604391,-0.141534,0.167559,-0.504523,-0.271489,-0.284124,-0.100008,0.330975,0.328027,0.160069,-0.0202518,0.497012,-0.16496,-0.204135,-0.0715271,-0.330963,0.576023,-0.0303315,0.058107,0.0699333,0.243132,-0.244085,0.091471,0.0304382,0.399659,-0.0459559,-0.306504,-0.125217,0.345405,0.444046,0.00915998,0.230772,0.0702017,-0.231922,0.425738,0.0619974,0.313744,0.287521,0.423038,-0.713881,-0.0643864,-0.490076,0.36229,-0.0254997,-0.157179,-0.175492,0.0376217,-0.36235,0.467188,-0.618284,-0.631025,-0.215721,-0.0181796,-0.125824,-0.238465,-0.0517208,0.209094,-0.097146,-0.365899,0.143166,-0.667015,0.204705,0.473346,-0.0228341,-0.148587,0.554113,0.183458,-0.805791,-0.00828114,0.0270088,-0.105987,-0.0644332,0.677582,0.00813071,-0.045127,0.00184674,-0.23076,-0.70833,-0.320646,0.0550677,0.244511,-0.223584,-0.6704,0.179648,0.137189,0.387697,-0.489819,-0.26461,-0.0071881,0.521156,0.464869,-0.296608,0.391424,0.433176,0.146255,0.121965,-0.328117,-0.0928128,0.110043,-0.851633,-0.31722,0.0832976,-0.306614,-0.371465,-0.420078,0.469312,0.42867,-0.150583,-0.700317,0.202133,-0.246107,-0.38043,0.047572,0.37458,-0.27314,0.00462221,0.437084,0.807624,0.418789,-0.120554,0.00994294,-0.191114,0.20162,-0.0620042,0.252379,-0.242548,-0.128643,-0.176293,0.771369,-0.135587,-0.662815,-0.650106,-0.78432,0.392003,-0.457712,0.349282,-0.636622,-0.224027,0.0763955,0.544622,-0.221392,-0.422827,-0.252907,0.391096,0.0378591,0.327355,0.357387,0.294273,0.892171,-0.667092,-0.483952,-0.015055,0.26284,0.193388,0.518881,-0.101398,0.24065,0.120042,0.245942,-0.658758,-0.179252,-0.613645,0.202042,-0.0722761,-0.400333,0.161633,0.0797706,-0.00125327,0.342437,0.00145704,0.25155,0.117548,-0.242557,-0.234704,0.247835,-0.153805,-0.254786,-0.0212015,-0.289997,0.15812,-0.298026,0.110984,0.0941771,0.235363,0.42539,-0.174262,-0.243591,-0.332831,0.307089,0.0504556,0.154297,-0.194354,-0.245532,-0.360933,0.364789,-0.312523,-0.232725,0.595408,0.289203,0.1065,-0.309411,-0.205649,0.427556,0.11952,-0.37304,0.541173,-0.31118,-0.563583,-0.30665,0.118047,-0.553972,0.0989222,0.217004,0.314519,0.465836,-0.947786 +3418.04,0.79714,0.0912059,4,1.67033,0.713551,-1.43245,0.473012,0.837973,-0.100798,0.0574631,-0.0235951,0.419738,0.305189,-0.112881,-0.345771,-0.266697,0.275145,-0.522543,0.546959,-0.168864,-0.201123,0.229901,-0.330326,0.0448265,-1.01954,-0.637983,0.093128,-0.868113,-0.354219,-0.0931105,0.176273,-0.785966,0.153402,0.520987,-0.857658,0.128957,0.134015,-0.503931,-0.396424,0.0874691,0.895908,1.00168,-0.183301,1.08146,0.367984,0.562531,-0.702393,0.0135058,-0.152786,-0.395116,-0.0636775,0.333093,0.269108,-0.132257,0.166697,0.371977,-0.346269,0.896729,-0.336209,0.178627,-0.593057,0.996945,-1.08017,0.586466,0.812524,-0.622386,-0.723421,-0.384686,-0.283632,0.194547,-0.0485131,-0.387461,0.0940633,-0.238793,-0.161064,0.396739,0.278465,0.55484,0.668954,0.218454,-0.0881575,0.102235,0.0419989,0.0746546,-0.819344,0.268008,-0.109919,0.0469637,-0.528751,-0.143339,-0.117361,-0.100225,-0.400808,0.184607,-0.723093,0.206602,0.699754,0.671583,0.0155547,-0.465958,-0.415805,-0.316235,0.117868,0.353114,-0.0174,-0.327055,-0.0319452,0.525889,-0.817869,0.256024,-0.347198,0.360233,0.71747,0.053176,0.0216675,0.414634,0.238474,-0.13545,0.28231,-0.553945,-0.0140668,0.300011,-0.470372,-1.07653,0.553231,-0.321572,0.481699,-0.579127,-0.186737,0.0593102,0.146445,0.266142,-0.324984,0.125216,0.00448865,0.0632336,0.637981,-0.124126,-0.108403,0.0880254,-0.143384,0.41747,-0.32268,0.00425948,0.169166,0.340552,0.0327668,0.0239413,0.0254099,-0.328482,0.530827,-0.0334847,-0.296536,0.129706,0.314738,0.166362,0.82287,0.109142,0.0267738,-0.0693289,0.277615,-0.0677868,-0.293204,0.24586,0.378047,0.520326,-0.0741947,-0.0169836,0.259815,0.00141374,0.06896,0.0781062,-0.0574267,0.144421,0.244707,-0.0189604,0.0630293,0.0698554,-0.128328,-0.535469,0.295128,-0.103388,0.70453,-0.22578,0.0767864,0.195514,-0.596118,-0.418436,-0.656011,-0.313281,-0.0194555,0.409561,0.147208,-0.0535136,0.0356612,0.257505,-0.871927,0.0967089,-0.164002,-0.751532,-0.422639,-0.527921,-0.460186,0.038057,0.140725,0.225449,-0.607143,-0.52848,-0.362241,-1.10841,0.884371,-0.547869,0.145627,0.0268223,0.171745,0.536239,0.0510826,0.0217728,0.168585,-0.319544,-0.0521679,-0.285882,-0.126306,0.685197,-0.498001,0.325529,-0.0325203,0.217316,0.341851,0.0241917,-0.392466,-0.385896,-1.02648,-0.16419,-0.0966183,-0.0728318,-0.294765,-0.278661,0.0135786,0.49934,-0.0710848,-0.0607888,0.144424,0.054301,0.208203,-0.823537,-0.20739,0.153851,0.423367,0.829623,0.0495918,-0.236667,-0.414448,0.0518822,-0.637987,0.345656,-0.271998,0.0870113,0.325875,-0.31561,-0.212689,0.295521,0.130397,0.0583733,0.408354,0.327213,0.0999728,0.146151,0.091905,0.176916,-0.245074,-0.552166,0.00135283,0.343767,-0.535695,-0.859792,-0.199888,-0.394822,-0.33888,0.194442,0.104105,-0.172732,0.0262808,0.0187274,-0.0916932,0.148059,0.255387,-0.12215,0.613763,-0.301482,0.227897,-0.0946109,-0.0175298,-0.229782,0.741932,0.118083,0.252906,-0.356594,-0.782903,0.166448,0.661385,0.0193538,-0.347796,0.109633,0.116368,0.287102,0.341127,0.535819,-2.04384 +3425.96,0.846001,0.0912059,4,1.51854,0.766834,-1.53757,0.656621,0.871447,-0.0395175,0.523523,0.230413,0.0486151,-0.265947,0.168322,-0.0117437,-0.274202,0.128773,-0.652442,0.611189,0.0553853,0.334924,-0.0473135,-0.00245355,0.225761,-0.805755,-0.530088,0.175864,-0.312973,-0.215847,-0.527512,0.262007,-0.400127,-0.0254236,0.96944,-0.979709,0.184097,0.618972,-0.364471,-0.201893,-0.0873149,0.338898,1.04088,-0.829841,0.696314,0.972569,-0.0304672,-0.779025,-0.433154,0.451232,-0.506081,-0.0616715,0.325638,-0.276892,-0.219075,0.450086,0.297166,0.104391,0.361685,-0.266778,-0.362083,-0.823958,0.666795,-0.70782,0.535781,1.2609,-1.23067,-1.263,0.0787673,-0.178566,-0.508469,-0.427402,0.0190258,-0.0240003,0.141613,0.177899,0.745917,-0.139182,0.335508,0.518572,0.208988,-0.295026,-0.56271,-0.479281,1.01175,-0.325649,0.463744,-0.283243,0.295108,0.209592,0.724195,0.603061,-0.0845408,-0.334109,0.0174888,-0.00057739,0.0616392,0.260565,-0.0310437,-0.211214,0.356443,-0.178039,0.126409,0.425586,0.130823,-0.0649102,0.373964,-0.277651,0.159335,-0.183137,-0.102624,-0.277761,0.436997,0.548429,-0.148769,-0.179282,0.537243,0.475064,0.396906,-0.133224,0.214464,-0.393404,0.58613,-0.0986018,-0.867879,0.701486,0.158627,-0.465349,-0.191568,0.308906,-0.155541,-0.188209,0.20689,-0.233223,-0.458688,-0.0118144,0.142563,0.525658,0.363398,0.0772049,-0.0995698,0.0876779,0.0435342,-0.0582648,-0.437438,-0.078653,0.127619,-0.387803,0.093702,0.0467335,0.134643,0.411676,-0.0896429,0.181418,-0.0198948,0.160033,0.524092,-0.0716311,0.283268,0.579558,-0.188548,0.488643,0.250364,0.158134,0.467272,0.230611,1.24633,-0.0164293,0.19148,0.176493,-0.242987,0.203128,0.22571,-0.0548454,0.165694,-0.329898,-0.117246,0.132266,0.187885,-0.123916,-0.328641,-0.00334353,-0.163676,0.600321,0.26178,0.321519,0.512169,0.173701,-0.0747342,-0.0705895,0.153087,-0.199564,0.112996,-0.304561,0.137951,0.0385282,-0.683223,-0.577683,-0.0584048,0.105763,0.270247,-0.260317,-0.0530009,0.326034,0.146865,-0.058926,0.0922614,0.261538,-0.291022,0.105937,-0.331506,0.833008,0.0382855,-0.011349,0.0100518,0.309198,-0.534954,0.0716817,-0.3376,0.138691,0.160959,0.409298,0.142746,0.329681,0.195391,-0.0183539,-0.498405,-0.0249788,-0.574765,0.704167,-0.158654,-0.0925144,0.0638411,0.262275,-0.219033,0.163106,0.05417,0.162182,-0.139194,0.234723,0.0120939,-0.503564,0.783867,-1.24327,-0.0532814,-0.206456,-0.256836,-0.0379538,0.0910002,-0.286337,0.632939,-0.0592624,-0.542007,-0.131496,0.50487,0.0924573,0.330986,-0.288657,-0.141402,0.472366,-0.371276,0.0832672,0.0317176,0.0336305,0.017977,0.667351,-0.143695,0.11555,0.660478,0.204975,-0.349379,0.694623,0.180474,-0.0859958,0.0412132,-0.316916,-0.360908,0.0661442,-0.745197,0.723642,0.262489,-0.314765,-0.00840935,-0.196635,0.378737,-0.80058,-0.859837,-0.00233077,0.0243114,-0.266268,0.404696,-0.156992,0.0504899,-0.469726,0.163813,0.0565404,-0.648764,-0.381085,-0.35,-0.250129,-0.0634185,-0.335113,0.143048,-0.435336,0.508643,0.126729,0.299858,0.35599,0.547593,-2.53518 +3406.98,0.904685,0.0912059,4,1.5184,0.814716,-0.98884,0.426114,0.562663,-0.0739679,0.670059,0.254648,0.460673,-0.344623,0.0304384,-0.261583,0.109648,0.56023,-0.729705,0.597543,0.205786,0.159922,-0.176662,0.197618,0.349884,-1.09283,-0.570669,0.171218,-0.388552,-0.0319992,-0.295094,0.53451,-0.485028,-0.015615,0.943411,-0.519929,0.298295,0.37313,-0.603932,0.118341,0.133011,0.330527,1.16048,-0.683315,0.642146,0.713222,-0.394158,-0.708193,-0.210981,0.158412,-0.762572,0.0693395,0.306816,-0.313628,-0.270915,0.579741,0.370446,-0.168732,0.506909,-0.187182,-0.598513,-0.715616,0.629761,-0.612016,0.469528,1.07459,-0.847677,-1.21997,-0.0687547,-0.0357639,-0.316465,-0.249031,-0.157422,0.0867585,0.368095,0.445857,0.638621,-0.287616,0.239946,0.144238,0.422993,-0.13139,-0.732954,-0.151679,0.807671,-0.29421,0.325345,0.1799,0.0854675,0.322008,0.589034,0.377198,-0.140774,-0.446591,-0.0719876,-0.339053,0.0548219,0.38569,-0.238142,-0.242944,0.131507,-0.192742,-0.00425525,0.438626,0.0783408,-0.0257919,0.558915,-0.107746,0.385631,-0.310273,0.0269716,-0.00550376,0.545607,0.734488,-0.051891,-0.336162,-0.0568007,0.483568,0.587376,-0.0752222,0.192416,-0.0592035,0.734226,-0.369569,-0.733393,0.0834009,0.0691653,-0.719901,-0.301907,-0.000930595,-0.250346,-0.277005,0.149109,-0.694619,-0.068036,0.158253,0.44126,0.39143,0.159777,-0.0340074,0.0944937,0.0676076,0.33588,0.293166,-0.342461,0.334334,-0.11816,-0.272569,0.0821431,-0.0446149,0.132129,0.585146,-0.0343591,0.170612,-0.202451,-0.00428389,0.113767,-0.062433,0.032059,0.615185,-0.266845,0.140937,0.392738,-0.243488,0.393456,0.120183,1.00794,0.143704,0.288763,-0.10573,0.102721,0.278753,0.017067,-0.166588,0.0161539,-0.44773,0.117606,0.355836,0.339094,0.393395,-0.444451,0.286959,-0.164865,0.743588,0.362456,0.100507,0.276394,0.29164,-0.0420799,0.0667969,-0.0659362,-0.296802,0.145613,-0.210902,0.0586997,-0.157597,-0.410784,-0.682741,-0.318347,0.0611549,-0.163637,-0.387551,0.0404647,-0.012558,0.315732,-0.394966,0.260925,0.111507,-0.0565284,0.100752,-0.254324,0.945412,0.0901935,0.205587,0.0640223,-0.195359,-0.499899,0.0314326,0.0291218,-0.31494,0.244718,-0.02077,-0.0708125,0.531266,-0.19124,-0.192633,-0.257155,0.555916,-0.507134,0.578576,-0.0236043,0.300958,0.318459,-0.00614521,-0.569008,0.179024,0.268615,0.0782877,0.0630333,0.571413,0.719774,-0.459541,0.759157,-1.1315,-0.214368,-0.370775,-0.194492,-0.563096,0.176619,0.0508558,0.23336,-0.0456355,-0.597867,-0.454589,0.493441,0.283802,0.214589,-0.24186,-0.181977,0.599485,-0.362162,0.203976,0.192801,0.0483792,-0.138949,0.544844,0.0857068,0.102375,0.718153,0.279791,-0.307078,0.242807,0.201645,-0.0326539,0.356033,-0.17327,-0.415067,0.222891,-0.451142,0.904679,0.120887,-0.747679,-0.0276167,0.214655,-0.429704,-0.158961,-0.516884,0.427572,-0.422446,-0.378343,0.118632,-0.064327,-0.127641,-0.148127,0.236305,0.0336648,-0.889617,-0.2538,-0.694426,-0.479301,-0.180286,0.144858,0.208209,-0.280956,0.406933,0.115327,0.264883,0.339598,0.514668,-1.65597 +3417.88,0.90709,0.0912059,4,1.51555,0.805667,-1.01202,0.415332,0.703989,-0.0510831,0.306742,0.351177,0.717381,-0.240812,0.361035,-0.26057,0.240619,0.27347,-0.421934,0.586789,0.516779,-0.068079,-0.103243,0.0198393,0.110804,-0.723566,0.0055241,0.321101,-0.469123,-0.120511,0.102069,0.217975,-0.182679,0.0848675,0.838428,-0.765957,0.568636,0.458781,-0.0281285,-0.089083,-0.330265,0.3494,1.01179,-0.827388,0.807358,0.254937,-0.231796,-0.574978,-0.3234,0.153106,-0.759715,-0.211271,0.215683,-0.279262,-0.455296,0.776587,0.480397,-0.143507,0.441307,-0.260979,-0.142967,-0.493529,0.438943,-0.797538,0.863429,0.821263,-0.915881,-1.1531,0.558404,0.116826,-0.020598,-0.111374,-0.0801372,0.125544,0.247818,0.145708,0.538602,-0.525118,0.327473,-0.0327788,0.592632,0.221709,-0.379273,0.0403758,0.636992,-0.344543,0.13056,-0.0104783,0.171974,0.124187,0.259214,0.285791,0.180878,-0.0839859,-0.0122971,-0.0860874,0.23089,0.302985,-0.320656,-0.552635,0.290336,-0.484395,0.566889,0.636784,0.115518,0.0759154,0.106582,-0.111683,0.277115,0.393983,-0.00608637,0.150229,0.594697,0.595622,-0.0401843,-0.442668,-0.0137803,0.647947,0.446853,0.120035,0.0452866,-0.108545,0.465224,-0.23063,-0.701246,0.407179,-0.0322368,-0.180003,-0.600893,0.0573778,-0.263044,0.436023,0.108211,-0.575566,0.258448,0.19856,0.107737,0.697556,-0.073279,0.118157,-0.0294991,0.142055,-0.0403922,-0.173127,0.0150822,0.0824006,-0.146811,-0.331284,0.309053,0.448004,0.021914,0.575349,-0.310705,0.265794,-0.0491325,-0.311408,0.246771,-0.497786,-0.0153093,0.814407,-0.459754,0.0792737,0.362952,-0.311701,0.44665,0.383397,1.09408,-0.258132,0.264141,-0.110592,0.164319,0.107201,0.310065,-0.36494,0.29804,-0.243709,0.129,0.00358302,0.310978,-0.219622,-0.303678,-0.0711391,-0.217678,0.611713,0.213393,0.258577,0.16936,0.224961,-0.198179,0.168602,0.019718,-0.155387,0.305532,-0.535778,0.393685,-0.384306,-0.115175,-0.32325,-0.42963,0.591096,-0.0542442,-0.325773,0.192615,0.206537,0.0828713,0.0474479,0.127916,-0.108245,-0.314278,-0.0152035,-0.387021,0.962597,-0.19885,-0.213197,0.225272,0.203984,0.216588,-0.0417918,0.112373,-0.152694,0.0644726,-0.0775301,0.0881823,0.4378,-0.0173744,0.0179398,-0.171068,0.70049,-0.452155,0.636247,0.122403,0.383041,0.224192,0.133442,-0.547793,0.29389,-0.0313804,-0.0344534,-0.211176,0.42195,0.317324,-0.00358174,0.71566,-0.71916,-0.25444,-0.607173,-0.357749,-0.518609,0.437003,-0.0197531,0.140679,0.368332,-0.590292,-0.253358,0.344197,0.117886,0.408848,-0.584357,-0.0651573,0.483196,-0.406489,-0.116261,-0.0790902,0.0303472,-0.0815142,0.231299,0.313146,0.262681,0.491049,0.344303,0.205406,0.00442836,-0.071272,-0.376798,0.173826,-0.23052,-0.553516,0.232578,-0.33092,1.15794,0.218657,-0.428537,-0.259663,0.110708,-0.472998,-0.187893,-0.678569,-0.197461,0.0498512,0.0568893,-0.14913,-0.125706,0.224909,-0.335577,0.266041,-0.0688024,-0.883862,-0.322883,-0.587926,-0.353861,-0.0280182,0.195138,0.126531,-0.285257,0.0662283,0.131198,0.295156,0.362213,0.543283,-2.0953 +3408.59,0.861257,0.0912059,4,1.55525,0.8621,-0.890498,0.307781,0.808181,0.0136536,-0.205969,0.366662,0.297597,-0.487763,0.218386,-0.361244,0.0764215,0.277308,-0.201395,0.969144,-0.00959996,0.256511,-0.31728,-0.205987,-0.173328,-0.705148,-1.1266,0.401089,-0.41506,-0.323273,0.124856,-0.257286,-0.514341,0.138947,0.734622,-0.61359,0.420739,0.664429,-0.437153,-0.17196,-0.310361,0.245774,0.63937,-0.70298,0.747998,0.284622,-0.0198275,-1.01582,-0.303795,0.178152,-0.57355,0.124831,0.184898,-0.310248,0.0121489,0.682299,0.00038561,0.227965,0.743343,-0.519257,-0.152206,-0.892056,0.731077,-0.541455,0.468505,0.693885,-0.812534,-0.79301,0.559588,0.0606021,-0.090772,0.0887393,-0.389569,0.185349,0.2204,0.133111,0.661916,-0.0607065,0.535689,0.147957,0.153137,0.171442,-0.461788,-0.0610245,0.588611,-0.743021,0.311504,0.00660861,0.144593,-0.0410171,-0.130502,-0.0171888,0.0653011,-0.177339,0.0251529,-0.314177,0.101515,0.189136,-0.576133,-0.202709,0.151131,-0.417898,0.640587,0.537948,-0.142583,0.0108129,0.0345286,0.244759,0.582413,-0.111706,0.508548,0.458517,0.589466,0.3773,-0.134158,-0.541767,0.294038,0.650212,0.356941,0.217595,-0.195367,0.131231,0.0594691,-0.0145024,-0.607282,0.832928,0.134134,-0.480308,-0.389034,0.184513,-0.0242833,0.0418173,0.100673,-0.633761,-0.114928,-0.110353,-0.359438,-0.0671745,-0.342001,0.233734,0.0116862,-0.346267,0.231609,-0.345267,0.329988,-0.0663974,0.247991,-0.381845,0.469023,0.210681,0.0173422,0.683341,-0.153733,1.05085,0.204252,-0.151829,0.155851,0.0682974,0.158902,0.737998,-0.17102,0.240982,0.175793,-0.562014,0.146885,0.543343,0.974629,-0.233257,0.119087,-0.0538826,0.0463202,0.105206,0.286172,-0.390592,-0.119353,-0.103619,0.191227,-0.0709491,0.368545,-0.0404156,-0.0491882,-0.00767807,-0.102963,0.430806,0.230432,0.530647,0.32217,0.735334,-0.538803,0.0325825,-0.100365,0.11132,0.422814,-0.330259,0.0946318,0.230793,0.0467363,-0.500227,-0.10887,0.942133,-0.197937,-0.365975,-0.21678,0.0982224,-0.40727,-0.152597,0.238217,0.111108,0.21442,-0.173532,-0.0372785,1.10127,-0.218872,-0.120015,-0.128164,0.25887,0.474665,-0.381554,0.554061,-0.389339,0.376791,0.234374,0.670003,0.147808,0.0498174,-0.196403,-0.153689,0.384007,-0.659732,0.651489,-0.128907,0.438695,-0.146601,-0.174846,-0.403923,0.224623,-0.00387092,0.0603508,-0.111807,0.342332,0.287877,-0.188569,0.717628,-0.123388,-0.663112,-0.800622,-0.344202,-0.240108,-0.11879,0.191558,0.209692,0.55475,-0.0716168,-0.322558,0.2148,-0.383393,0.251291,-0.380458,-0.118468,0.426951,-0.537924,-0.150928,-0.0774066,-0.0749674,0.133773,-0.119563,0.062312,0.42251,0.433657,0.334377,0.10731,-0.0580694,-0.457848,-0.187761,0.0206291,0.215862,-0.595926,0.152609,-0.457239,0.889028,0.647677,-0.297373,0.0223041,0.122968,-0.733505,-0.379306,-0.188986,0.175071,-0.202299,0.256835,0.33545,-0.301129,0.155975,-0.653117,0.0272011,0.27454,-0.163312,0.252595,-0.205213,-0.139502,-0.0784198,0.364831,0.156662,-0.674491,-0.108447,0.136206,0.204556,0.369061,0.452279,-2.47931 +3419,0.945635,0.0912059,4,1.57563,0.744351,-1.1404,0.504548,1.1357,-0.0261419,-0.0494894,0.0290391,0.693613,-0.234663,0.0871185,-0.412258,-0.496694,0.373812,-0.148452,0.934738,0.467123,0.18724,-0.211107,0.27405,0.290086,-0.832466,-0.399474,0.474283,0.222958,0.329071,-0.364534,0.0043113,-0.275477,-0.22653,0.71625,-0.371666,0.123926,0.289823,-0.0971315,-0.257005,0.344293,0.130841,1.20625,-0.826925,0.489909,0.361085,0.207155,-0.367039,0.211563,-0.216177,-0.327095,-0.180177,-0.0764439,-0.174938,-0.328021,0.149095,0.41744,-0.0969836,0.50495,-0.541362,-0.115723,-0.933251,0.264443,-0.577097,0.110249,0.93606,-0.511746,-1.28023,-0.188807,0.082033,-0.0929851,0.187748,0.103585,-0.169539,0.383361,0.04015,0.539481,-0.309574,0.336955,0.241443,0.443648,0.484128,-0.00142474,-0.283645,0.183594,-0.741524,0.0553678,-0.370213,-0.691759,0.0146977,-0.103529,-0.471587,0.0656884,-0.54712,0.011993,-0.0492179,-0.0407835,-0.296762,-0.323345,-0.437581,-0.326917,-0.5343,0.329304,0.403133,0.152259,0.0637534,-0.129857,0.207119,0.301617,-0.115732,0.241126,-0.1348,0.772643,0.164199,0.325542,-0.446651,0.44515,0.486283,0.00577306,-0.178876,-0.713269,0.0495395,0.727156,0.123862,-0.663907,0.41689,-0.358747,-0.547146,0.710099,0.564143,0.0185318,0.14486,0.00450695,-0.367188,-0.197422,-0.117258,-0.130374,0.0292783,-0.097376,-0.169353,-0.283908,-0.191036,0.292612,-1.02835,-0.329863,-0.203848,0.0817413,-0.245582,0.0063278,0.434954,0.187362,0.382891,0.346797,-0.24682,-0.496673,0.283919,0.335669,-0.0177384,0.140178,0.533562,0.23899,-0.195184,0.549813,0.0460713,0.234201,0.191576,0.521291,-0.52073,-0.00859784,0.0978529,0.391373,0.312234,-0.284111,-0.248501,-0.0258871,-0.192766,0.00939626,0.235204,0.0397973,-0.725381,-0.000322191,0.0913012,-0.233943,0.824782,-0.00152913,0.016633,0.100704,0.265203,0.183284,-0.536368,-0.775071,-0.133748,-0.00073929,-0.336113,0.023121,0.0189189,0.0387134,-0.351979,0.198895,0.591765,-0.149395,-0.14541,-0.207857,0.145321,-0.185964,-1.01353,0.203417,-0.524906,0.381811,-0.73383,-0.303874,1.11243,-0.376896,0.379578,0.0787389,0.267249,-0.141028,-0.125181,-0.323845,-0.00719176,-0.500648,0.258107,0.743247,-0.2989,0.0616138,-0.453861,-0.365911,-0.0314621,-0.0073465,0.624916,-0.254726,-0.359957,-0.473588,-0.0874987,-0.560418,0.186401,-0.291999,0.183521,-0.270743,0.455301,-0.0836057,-0.363894,0.647815,-0.530294,-0.457856,0.105119,-0.378832,-0.455125,0.650941,0.64536,0.48761,0.0370388,-0.104937,-0.364916,0.209254,0.0922109,0.051698,-0.318787,0.332208,-0.214702,-0.449926,0.477389,-0.464097,-0.245574,0.129222,-0.11365,0.762561,0.31979,0.413523,0.186814,-0.0589379,-0.478453,-0.216445,0.00433169,0.245844,0.281259,-0.622621,0.373769,-0.298796,1.03356,0.158571,-0.406567,0.646359,0.289948,-0.538316,-0.0486697,-0.103899,0.473978,0.195082,0.414439,0.206422,-0.326315,-0.158229,-0.642345,0.147712,0.218361,-0.223311,0.552282,-0.0662071,-0.316997,-0.222508,0.262141,-0.0821733,-0.114776,0.248725,0.135267,0.262555,0.367787,0.512401,-3.38339 +3423.05,0.977817,0.0912059,4,1.54074,0.868782,-1.17968,0.627259,1.30439,-0.0546909,0.368599,-0.280841,0.418809,-0.0889984,0.486517,-0.176235,-0.131457,0.212951,-0.0129863,0.914934,-0.0611637,0.448302,-0.426507,-0.156721,0.233639,-1.08554,-0.459559,0.640701,-0.291084,0.0706216,0.417622,0.558479,-0.321214,0.452569,0.697112,-0.354613,0.0371144,0.423412,-0.759812,-0.658085,-0.211453,0.814321,0.881934,-0.4879,0.599543,0.319088,0.827065,-1.08736,0.220999,0.0459133,-0.430009,-0.0303665,0.0810208,-0.186121,-0.0981697,0.460739,0.230181,0.04102,0.350949,-0.940887,-0.306247,-0.849861,0.376485,-0.727295,0.480291,0.613951,-0.706291,-0.947881,0.017122,-0.204041,0.039396,-0.142815,0.143643,-0.354115,0.465932,-0.333755,0.625081,-0.00154064,0.530815,0.485356,0.311197,0.330927,-0.638628,-0.237016,0.685658,-0.168343,0.0379475,-0.314745,-0.459259,0.297792,-0.00635949,-0.259469,0.220448,0.115901,0.236794,0.275246,0.508769,-0.0196482,0.192388,-0.393253,0.590753,-0.637902,0.621847,0.563689,0.00211263,-0.102203,-0.0282876,-0.70534,0.595459,-0.312055,0.0277985,-0.0782928,0.420038,0.261961,-0.314333,-0.694397,0.324362,0.326335,0.677831,-0.169991,-0.0859603,0.183517,0.0349452,-0.686844,-0.70501,-0.234307,0.27364,-0.163148,0.187456,0.55855,0.260904,-0.164385,0.240775,-0.0191079,0.764643,-0.0585789,-0.435308,0.357196,-0.0664904,-0.18615,-0.0854434,0.0183543,0.165122,-0.754489,-0.129085,-0.275411,0.431946,-0.338646,-0.167376,0.293452,0.493178,0.166856,0.267086,0.0390579,0.0663863,0.446203,0.120469,0.0845099,0.471498,0.331578,-0.437082,-0.635143,0.383721,0.0715898,-0.156525,-0.384163,0.328341,-0.175262,0.151867,0.461336,0.106232,0.0289001,-0.443115,-0.753946,-0.132571,-0.0670205,-0.0612599,0.421668,0.139052,-0.600808,-0.0524066,-0.0252995,-0.728983,0.929728,-0.18478,-0.558463,0.122464,-0.0889368,0.26838,-0.537868,-0.614449,0.331079,0.128572,-0.353998,-0.140603,-0.168139,-0.152859,-0.588814,0.0592129,0.757888,-0.11292,-0.477128,-0.354107,0.901591,-0.316687,-0.206246,0.0906409,-0.0254734,-0.158114,-0.488272,-0.528881,1.00848,-0.259241,0.421506,0.503001,0.354764,0.015821,-0.0508754,-0.0560863,0.487528,0.0954924,0.326105,0.697489,-0.293202,0.00790363,-1.0894,-0.17169,0.0652694,-0.418609,0.324195,-0.198963,-0.381042,0.00362605,0.120842,-0.0911127,0.0969194,0.257651,-0.303858,-0.100623,0.470191,0.243983,-0.369718,0.628937,-0.403494,0.0514847,0.137743,-0.271367,-0.36778,0.297152,0.426095,0.294063,0.281322,-0.13773,-0.0679526,0.0745153,-0.856249,-0.0175056,-0.0497757,-0.128289,0.378435,-0.781249,-0.196067,-0.122989,-0.418263,0.0594471,0.304213,0.419722,0.461093,-0.199964,0.578012,-0.186658,-0.218797,-0.132832,0.179672,0.0822008,-0.0982196,-0.489793,0.113344,-0.363185,0.17448,0.310904,-0.682007,0.691168,0.428906,-0.109696,-0.220585,-0.113804,-0.198323,-0.214943,0.275891,0.185407,0.549667,-0.115413,-0.342592,-0.213033,0.0159504,-0.253655,0.611165,0.155299,-0.332913,-0.474032,0.0586724,0.163062,-0.448208,-0.4361,0.143118,0.278519,0.37831,0.527749,-4.28688 +3432.22,0.892948,0.0912059,4,1.60473,0.842798,-1.14154,0.515096,1.19717,-0.0625182,0.302413,-0.0170091,0.266713,-0.196986,0.273334,-0.294848,0.101831,0.221287,0.0735303,0.841505,0.158202,0.17644,-0.184793,-0.282314,0.124375,-0.9935,-0.390556,0.544745,-0.450864,0.383682,0.138539,0.720708,-0.58168,0.411431,0.573109,-0.436073,0.298967,-0.0435286,-0.359717,-0.519107,-0.185898,0.477597,1.04978,-0.288793,0.566865,0.254449,0.584815,-1.03893,0.156164,-0.0262504,-0.314479,-0.155408,-0.0627871,-0.145623,-0.0221531,0.864854,0.0947452,-0.386944,0.445709,-1.11376,-0.250245,-1.08808,0.392903,-0.525934,0.953233,0.592208,-0.73335,-0.529231,-0.25973,-0.431652,0.0176987,-0.508388,0.314333,-0.520012,0.346845,-0.304366,0.557612,0.0331441,0.73185,0.43896,0.362231,0.209807,-0.196625,0.0154714,0.699843,-0.222438,-0.117871,-0.0940508,-0.344924,0.187526,0.12787,-0.0561221,0.0738692,0.140808,0.335965,0.445688,0.533695,0.0914573,-0.0323395,-0.397571,0.4256,-0.473092,0.0554133,0.217159,0.00103784,-0.779495,0.0066235,-0.867535,0.166292,-0.514579,0.0775988,-0.588592,0.0132258,0.0641597,-0.171802,-0.311314,0.462551,0.358543,0.75977,0.10711,-0.0232884,0.344035,0.377012,-0.172966,-0.449288,-0.163184,0.434563,-0.0800186,0.215395,0.519581,-0.253503,-0.452979,0.148703,0.0443029,0.305478,-0.0900292,0.0565984,0.169711,-0.0585846,-0.0239995,-0.0312589,0.0449762,0.386715,-0.696086,-0.110359,-0.297634,0.602871,-0.353076,0.116918,-0.113578,0.376436,0.377271,0.0190656,0.343985,0.0677264,0.612446,0.363102,0.0750532,0.300425,0.339049,-0.136376,-0.40832,0.340615,0.275499,-0.090513,-0.274387,0.486795,-0.0939302,0.0495094,0.271082,0.257146,0.15601,-0.494517,-0.46667,-0.332509,0.105271,0.121724,0.577511,0.106623,-0.464859,-0.0247901,-0.309638,-0.858427,1.11015,-0.225399,-0.437567,0.0486936,-0.0508747,0.140213,-0.122723,-0.684494,0.170086,0.328888,-0.243228,-0.242063,-0.0697165,-0.282381,-0.927752,0.0358178,0.441392,0.268863,-0.403237,-0.362339,0.544849,-0.468908,0.112154,0.163552,-0.0216858,-0.056535,-0.214784,-0.544657,1.15506,-0.374067,0.440867,0.244581,0.552167,0.0251493,-0.011972,-0.6326,0.163165,0.0248048,0.133428,0.334735,-0.526464,0.114287,-1.09865,-0.264651,0.784071,-0.153836,0.626702,-0.404047,0.103575,-0.251817,-0.0945891,-0.457855,-0.0226594,0.149786,-0.330733,-0.21375,0.471564,0.408327,-0.625612,0.645715,-0.43663,-0.0112788,0.194721,-0.286316,-0.127351,0.359195,0.313879,0.365151,0.407499,0.0209295,-0.342422,-0.0293702,-0.819453,0.234148,-0.314767,-0.320866,0.269541,-0.789139,-0.0679844,-0.378881,-0.387291,0.236634,0.247333,0.36115,0.402392,-0.195234,0.413928,0.0610481,-0.310242,-0.183329,-0.0280345,0.0333202,0.0329192,-0.637984,0.544907,-0.131622,-0.137799,0.314947,-0.4878,0.640466,0.177064,-0.240311,-0.317893,0.0311818,-0.00347344,0.0961312,0.0140591,-0.309495,0.285398,-0.108074,-0.352164,-0.105344,0.0212014,-0.0228258,0.360513,0.198042,-0.294444,-0.648046,0.0176649,0.00787621,-0.318536,-0.770813,0.124556,0.247007,0.352925,0.496998,-3.73274 +3436.02,0.96287,0.0912059,5,1.55422,0.85754,-1.16565,0.612543,1.1615,-0.148408,0.418367,-0.0683349,0.409233,0.0641367,0.50097,-0.165443,0.289453,0.285342,0.0735447,0.885689,0.367872,0.145594,-0.131702,-0.290164,0.0839086,-0.948726,-0.344953,0.661101,-0.429886,0.387707,-0.00241468,0.885261,-0.467827,0.31397,0.500277,-0.575096,0.399446,0.228122,-0.695296,-0.540233,-0.260012,0.497301,1.07862,-0.316989,0.482689,0.291665,0.61519,-0.821336,0.285089,-0.00223358,-0.306691,0.0112913,0.0154495,-0.225055,-0.00363988,0.908692,0.143969,-0.472062,0.214309,-1.18145,-0.318833,-1.15387,0.342275,-0.67878,0.941944,0.548823,-0.392539,-0.854129,-0.334048,-0.419815,-0.00566951,-0.561209,0.229416,-0.424875,0.207192,0.0184657,0.602536,0.012442,0.341602,0.424619,0.325139,0.391857,-0.0658207,-0.00207415,0.671363,-0.254685,-0.0740979,-0.101561,-0.549249,0.148951,-0.290914,-0.0169232,-0.0446514,0.22364,0.250308,0.426883,0.449253,0.0934126,0.289492,-0.135769,0.328147,-0.404432,-0.0467042,0.184067,0.0568894,-0.724548,0.0969872,-1.0093,0.358015,-0.485373,0.00723138,-0.403398,0.0802829,0.0310549,-0.112316,-0.346179,0.292648,0.544556,0.738498,-0.0113292,-0.144431,0.344926,0.769707,-0.171407,-0.433842,-0.21584,0.306245,0.338667,0.0691003,0.247649,-0.0910849,-0.446551,0.147357,0.0184127,0.07888,-0.219207,-0.167946,0.143166,-0.110483,-0.326879,0.242738,0.0311224,0.216287,-0.524667,-0.142063,-0.238748,0.479503,-0.142532,0.128194,-0.423244,0.268845,0.454381,0.0399984,0.510193,0.0875424,0.496075,0.523787,-0.0116227,0.127815,0.340253,0.00646531,-0.376825,0.196882,0.205501,0.046496,-0.175782,0.555631,0.151969,-0.0340364,0.153212,0.301789,0.105559,-0.536588,-0.495908,-0.266063,0.247191,-0.0732757,0.466174,-0.153148,-0.439104,-0.0608594,-0.277265,-0.731819,1.12302,-0.195825,-0.350122,0.066755,-0.234841,0.200866,-0.0412539,-0.539609,-0.0393063,0.122189,-0.419165,-0.179666,0.0387268,-0.192924,-0.898399,0.09012,0.297841,0.372566,-0.60592,-0.495487,0.289175,-0.33355,-0.0601692,0.127428,-0.270724,-0.464797,-0.0848718,-0.24238,1.09977,-0.0272213,0.0655738,0.160185,0.638476,0.222265,-0.153708,-0.648433,-0.315148,0.0392548,0.183475,0.428495,-0.358416,-0.00924661,-0.800056,-0.0110029,0.368899,-0.467231,0.600811,-0.385102,-0.0284099,-0.334557,-0.119749,-0.177758,-0.0051554,0.230817,-0.481688,-0.348648,0.521184,0.473644,-0.727474,0.618116,-0.603133,0.0346626,0.0741685,-0.299637,-0.278637,0.530748,-0.00632022,0.286713,0.248939,-0.35617,-0.425978,-0.124559,-0.832672,0.0732511,-0.278526,-0.438694,0.276961,-0.546701,-0.0200602,-0.512334,-0.18587,0.281937,0.0593171,0.483267,0.343969,-0.0450524,0.138955,0.249721,-0.388142,-0.288641,-0.184463,0.0458597,0.0197827,-0.442276,0.674766,-0.109452,0.0844238,0.429542,-0.635563,0.479901,0.143309,-0.38386,-0.00427367,-0.0607729,0.104367,-0.0262861,0.0678282,-0.504027,0.142404,-0.0719413,-0.536571,-0.00269286,-0.0492714,-0.0976246,0.354947,0.0193681,-0.687022,-0.36384,-0.0620435,-0.228992,-0.669311,-0.897798,0.132826,0.245718,0.364452,0.4957,-3.74915 +3443.26,0.824451,0.0912059,5,1.59762,0.822719,-1.50669,0.543809,-0.0564121,-0.148134,0.0704059,0.290901,0.152021,0.137329,-0.0889517,-0.571859,-0.388424,0.68373,-0.179075,0.597714,0.557536,-0.27005,-0.169477,0.595716,-0.238863,-0.568551,-0.797579,0.364445,-0.0703274,-0.856103,-0.0590614,-0.282852,-0.20597,-0.119592,0.589906,-0.0679356,-0.0143542,0.102935,-0.54882,-0.433839,-0.298192,0.96562,0.00246424,0.173341,1.16511,0.749343,-0.0149535,-0.851094,-0.140559,0.171132,-0.85118,0.372586,0.537554,0.0971031,0.258072,0.19787,0.229005,-0.0307406,0.286572,0.177031,-0.0982538,-0.535219,0.530026,-0.25979,-0.270382,0.878866,-0.828484,-0.736285,0.562296,0.653292,-0.120275,0.439536,0.00340154,-0.252252,0.032349,0.194655,0.300388,-0.166208,0.6612,0.131785,0.444067,-0.201575,-0.503751,-0.284756,0.343846,-0.385649,-0.149427,-0.386189,0.213555,-0.14322,0.22253,-0.204689,0.460994,-0.525493,-0.307295,-0.181922,-0.278904,0.108821,-0.229581,-0.413163,-0.255756,-0.219869,0.141166,0.122615,-0.00189628,0.252082,-0.873781,0.189375,-0.110916,0.169966,0.277329,0.0130273,0.499568,0.533629,0.117401,-0.234531,-0.317248,0.413053,-0.422735,0.0724407,-0.162567,-0.148209,-0.189418,-0.278854,-0.504492,0.0352062,-0.760966,-0.509397,-0.370102,0.0884693,0.373133,0.697332,0.337652,-0.416344,0.305775,-0.0390201,0.199817,0.739358,-0.567547,0.217403,-0.055116,-0.369375,0.257975,-0.453873,-0.553593,-0.423943,-0.508309,-0.563194,0.0312061,0.565416,-0.410587,0.381832,0.199739,-0.693236,-0.526442,-0.138646,0.0797657,0.0584275,0.225376,0.397042,0.300186,0.0771153,-0.266223,-0.270077,0.483698,0.0593973,0.302219,-0.013401,0.241699,0.175495,-0.331597,-0.29655,-0.134285,0.392084,0.189558,-0.144544,-0.181388,-0.229768,-0.353657,0.467113,-0.423566,0.313264,0.789367,0.446645,0.335083,-0.205478,0.175576,0.00432232,-0.271294,-0.552865,0.185932,-0.411258,0.434597,-0.443269,-0.0639796,-0.170905,0.0555845,-0.393574,0.06543,0.0679956,-0.322882,-0.18573,-0.245558,-0.417605,-0.227896,-0.353605,0.164191,0.127603,0.286142,0.0729308,-0.325937,1.0945,0.00342216,0.167982,0.0497531,-0.634697,0.0893343,0.276663,-0.114118,0.710892,-0.617986,-0.148259,0.0125746,0.118084,-0.17265,-0.334896,-0.09148,0.117737,-0.0134009,0.325401,-0.467063,-0.788627,0.521641,-0.176179,0.158885,0.0698392,-0.219296,0.0624163,0.00453526,0.311234,-0.198431,0.477704,0.693766,-0.11834,-0.265914,0.390785,0.191264,0.235031,0.0883397,0.315699,0.574906,0.240931,0.28541,-0.395232,0.0308989,-0.314648,0.224062,-0.0321596,0.255393,-0.0228454,-0.244009,0.25164,0.0673473,-0.235076,-0.240383,0.429903,-0.34021,-0.193224,0.346154,0.340146,-0.0352863,0.0743055,0.0884271,0.335467,-0.0257,-0.439581,-0.507767,-0.373497,0.20019,-0.375913,-0.43566,0.653432,-0.00308301,-0.172995,-0.18166,-0.21644,-0.510525,0.0587765,0.119622,0.373417,-0.10777,0.310484,-0.155223,0.363128,-0.296518,0.388931,0.0923718,0.195675,-0.248699,0.378135,0.107275,0.207776,-0.0474168,0.247241,0.802358,0.106751,0.174821,0.326728,0.418116,0.643311 +3448.74,0.710977,0.0912059,4,1.6139,0.85785,-1.27956,0.432433,0.0438337,-0.114937,-0.0937337,0.220371,0.154137,-0.0769817,-0.0671008,-0.439397,-0.541595,0.588075,-0.214814,0.644944,0.508985,-0.299387,-0.208257,0.50569,-0.295438,-0.38946,-0.856644,0.308808,-0.00613086,-0.835587,-0.0554076,-0.0711653,-0.183101,-0.201171,0.595992,-0.0287518,-0.122084,0.0930929,-0.482929,-0.422658,-0.191384,0.820782,0.195457,0.109095,1.19249,0.689742,0.15172,-0.937811,-0.226942,0.207467,-0.999876,0.420316,0.649484,-0.111683,0.345397,0.402181,0.203949,-0.0412025,0.424219,0.00566966,-0.173893,-0.57886,0.41035,-0.37691,-0.00904316,0.747125,-0.828922,-0.972888,0.542198,0.459292,-0.374645,0.531484,-0.0933756,-0.460476,-0.0284229,0.276982,0.403668,-0.149835,0.553634,0.0272005,0.525588,-0.141563,-0.34799,-0.200262,0.410818,-0.280131,-0.235497,-0.416057,0.131402,-0.196648,0.209911,-0.235678,0.550505,-0.612514,-0.366877,-0.20472,-0.187084,0.233595,-0.140026,-0.295923,-0.0758203,-0.245961,0.221871,0.136099,0.0412506,0.311965,-0.682376,0.360317,-0.308666,-0.0930859,0.272967,-0.156007,0.303123,0.572532,0.124863,-0.187953,-0.17513,0.371069,-0.290327,0.120486,-0.327195,-0.156437,-0.243722,-0.270288,-0.462942,0.161033,-0.784453,-0.418159,-0.407854,0.0790847,0.485937,0.631136,0.33769,-0.629739,0.342473,0.0647442,0.0846817,0.649849,-0.601952,0.17548,-0.131527,-0.509712,0.287965,-0.369609,-0.505714,-0.420276,-0.486683,-0.532689,-0.0186598,0.563177,-0.288584,0.417734,0.254919,-0.672154,-0.384896,-0.0123479,0.105828,-0.0216983,0.118246,0.325363,0.210461,-0.0671527,-0.209298,-0.413213,0.364936,0.0152813,0.305658,-0.0811489,0.110896,0.365666,-0.458178,-0.212516,-0.0887252,0.0926761,0.17593,-0.0954332,-0.103547,-0.23754,-0.478746,0.434166,-0.4385,0.194345,0.696305,0.470383,0.220271,-0.0210991,0.0823608,0.021613,-0.168532,-0.603944,0.320519,-0.310183,0.294704,-0.376153,-0.0448331,-0.0811486,0.0627304,-0.202523,0.0786723,0.156972,-0.192635,-0.269692,-0.381023,-0.449512,-0.092629,-0.356567,0.128512,-0.131407,0.520726,-0.0571834,-0.386019,1.0546,-0.0418764,0.043204,0.039373,-0.636613,0.0719685,0.103502,0.140139,0.844879,-0.490676,-0.185499,-0.19298,0.0814147,-0.110038,-0.331268,-0.241567,0.12643,-0.0681114,0.304418,-0.371534,-0.707156,0.516485,-0.21984,0.111829,0.134762,-0.210996,0.0825464,0.0480668,0.103251,-0.356396,0.392675,0.695634,-0.279513,-0.478124,0.50336,0.0779327,0.290345,-0.026557,0.250356,0.665044,0.198232,0.243062,-0.5428,0.161648,-0.405079,0.135508,-0.00684552,0.360108,0.0450538,-0.245635,0.317554,0.225817,-0.34195,-0.300326,0.339585,-0.310306,-0.167745,0.257785,0.257297,-0.00861507,0.00795801,0.118137,0.0733247,0.246265,-0.431501,-0.378943,-0.249523,0.0770642,-0.263645,-0.325656,0.515352,-0.106856,-0.043891,-0.201216,-0.188218,-0.280544,-0.217065,0.0072536,0.374812,-0.0872272,0.39614,-0.0827389,0.246636,-0.215461,0.322041,0.0741954,0.0705286,-0.255477,0.301002,0.229272,0.158476,0.011343,0.0908826,0.500347,0.10783,0.170544,0.328374,0.41297,0.24268 +3443.4,1,0.0912059,4,1.57553,0.961687,-1.0751,0.385708,0.129884,-0.0849878,0.0196253,0.182297,0.314555,-0.125866,-0.155721,-0.578247,-0.549251,0.503422,-0.377926,0.631167,0.338424,-0.14109,-0.19753,0.530926,-0.17944,-0.651559,-0.578602,0.352188,-0.00143093,-0.648877,0.0394112,-0.154826,-0.360326,-0.241217,0.477954,-0.0556471,-0.0669247,0.176451,-0.546935,-0.441615,-0.160084,1.01194,0.147423,0.00208179,1.13896,0.854232,0.30328,-1.15917,0.032083,0.510615,-0.792302,0.369059,0.56072,-0.257842,0.184746,0.622904,0.218475,0.0642585,0.408773,0.0154976,-0.357344,-0.512934,0.552472,-0.219583,0.145478,0.674328,-0.949003,-0.880203,0.59321,0.441401,-0.323406,0.356604,0.158112,-0.561636,0.126682,0.100187,0.250803,-0.0549432,0.388576,0.0682549,0.449224,-0.214296,-0.352318,-0.166786,0.257462,-0.497267,-0.119361,-0.209805,0.276017,-0.22519,0.0449457,-0.0611491,0.633598,-0.54389,-0.389256,-0.209607,-0.266809,0.0910052,0.0764228,-0.385601,-0.16878,-0.336203,0.366352,0.0542625,-0.124985,0.253858,-0.636961,0.307747,-0.435609,-0.0153572,0.484735,-0.228543,0.142772,0.584022,0.185006,-0.319279,0.0958827,0.390694,-0.202913,0.00115106,-0.392486,-0.0515801,-0.206394,-0.265866,-0.529815,0.162911,-0.67233,-0.227957,-0.504012,-0.103749,0.671092,0.577977,0.423495,-0.592093,0.100243,0.157507,0.05548,0.657472,-0.529049,0.196347,-0.167525,-0.535296,0.215836,-0.148556,-0.586021,-0.363085,-0.251339,-0.71133,-0.129739,0.514746,-0.259269,0.481453,0.0852207,-0.68719,-0.423651,0.0476869,-0.12443,-0.0255074,0.304303,0.30248,0.426108,-0.17476,-0.142978,-0.47868,0.522764,0.0507859,0.565383,-0.0969671,0.230041,0.306503,-0.590412,-0.139891,-0.247788,-0.0514684,0.141554,-0.39723,-0.159884,-0.0487834,-0.511895,0.201314,-0.337551,0.348139,0.294472,0.395825,0.398021,-0.0959795,-0.0252224,0.150639,-0.348107,-0.545178,0.0437631,-0.261331,0.175163,-0.0989907,-0.0306184,-0.122596,-0.113479,-0.449598,0.0335337,0.0640031,-0.271352,-0.277766,-0.443759,-0.580271,-0.213386,-0.280949,0.169513,-0.041205,0.435582,-0.36654,-0.436704,0.919161,-0.0570008,0.311603,0.288222,-0.741982,-0.0222417,0.0724912,0.11522,0.537253,-0.366068,-0.0654966,0.0672176,0.187449,-0.0680273,-0.476555,-0.171967,0.0734545,-0.213049,0.339464,-0.22587,-0.751252,0.53781,-0.199656,0.124792,0.150816,-0.358536,0.108183,-0.00384514,0.00967857,-0.56108,0.562453,0.644318,-0.0237508,-0.265704,0.296709,-0.0891433,0.183302,-0.0295522,0.337188,0.579238,0.169401,-0.0999885,-0.547547,0.135328,-0.336386,0.140565,-0.101155,0.162918,0.164897,-0.270126,0.420892,0.22014,-0.373398,-0.449678,0.261975,-0.147962,-0.211646,0.190533,0.369042,-0.0527535,0.0421197,0.223992,0.180971,0.361541,-0.161061,-0.431376,-0.325365,0.210943,-0.107046,-0.0965953,0.587007,-0.32637,-0.0902244,-0.172815,-0.00388495,-0.482421,-0.276076,0.0414605,0.523637,-0.297792,0.303199,-0.0156505,0.156546,-0.164157,0.192822,0.0937264,-0.0703703,-0.313818,0.426855,0.177463,0.168417,0.107648,-0.0222372,0.379606,0.114968,0.181814,0.339069,0.426397,-0.335544 +3423.92,0.764329,0.0912059,4,1.63258,0.863658,-1.22781,0.430488,0.329933,-0.207316,0.500739,-0.151976,0.332631,-0.560529,-0.307198,-0.28538,-0.0359994,0.253916,0.107356,0.369677,0.211797,-0.350727,-0.00556138,-0.335973,-0.179674,-1.24969,-0.136116,0.413148,-0.107376,-0.130045,0.390977,-0.201969,-0.281675,-0.232292,0.814538,-0.0538165,0.282174,0.321068,-0.638281,0.188986,-0.725359,1.25829,0.341741,0.00484458,1.2126,0.211883,-0.161201,-0.0640134,-0.243913,0.471646,-0.944329,0.159774,0.366965,0.128288,0.230211,0.725772,0.100053,0.212688,0.588278,-0.227396,-0.226959,-0.5709,0.311642,-0.135511,0.301342,0.609973,-0.528763,-0.926803,0.147816,-0.170651,-0.211405,-0.339093,-0.0637294,-0.584237,-0.183223,0.109969,0.831351,0.159657,1.06715,0.329512,0.0645485,0.0355816,-0.178915,-0.226527,0.692051,-0.672268,-0.101944,-0.273744,0.241356,-0.0765463,0.292026,-0.107946,0.477938,-0.431365,-0.852707,0.0532972,-0.299029,0.140398,0.3167,-0.0790931,-0.304772,-0.324961,0.412398,0.0355041,-0.0495893,-0.131763,-0.205333,-0.335511,0.0744383,-0.057519,0.402935,-0.559987,0.175935,0.21875,-0.0321412,-0.185484,0.0951993,0.111194,-0.0260781,-0.047427,-0.453483,-0.219336,-0.0907649,-0.20929,-0.559525,0.117383,-0.602818,-0.632966,-0.342842,0.328738,0.484737,0.656425,0.176506,-0.297564,0.163851,-0.141703,-0.0333593,0.299799,-0.0290112,0.136352,0.196034,-0.0922411,0.150291,-0.489567,-0.284312,-0.372269,0.0400416,-0.281609,-0.226806,0.0405569,-0.122921,0.417436,-0.0587236,-0.0737691,0.232895,0.00441392,0.537455,0.146724,0.22896,-0.0198173,0.263292,-0.643693,-0.485634,-0.0971117,0.419696,-0.107564,0.367197,-0.339464,0.108572,0.10895,-0.692883,-0.368251,-0.0744516,-0.337082,0.475868,-0.0586354,-0.20744,-0.285727,-0.511541,-0.200988,-0.455623,-0.549222,0.218653,0.638776,-0.420233,-0.325639,0.110932,0.223528,0.158856,0.0350119,0.18353,-0.284126,0.0299529,-0.816443,0.0681404,-0.592328,0.218853,-0.606397,0.111758,0.208903,0.011291,-0.395824,-0.666737,-0.432927,-0.157642,-0.175328,0.200155,-0.288089,-0.280257,0.385206,-0.504926,0.978384,0.0648336,0.260173,-0.364057,0.0152945,0.140508,0.126551,-0.487347,0.199485,-0.25952,-0.155464,0.281136,0.404175,-0.118977,-0.478515,-0.431469,-0.269392,-0.167231,0.358281,-0.325609,-0.555009,-0.227051,-0.180049,-0.0885641,-0.221898,0.385083,-0.126913,-0.245557,0.523148,-0.713157,0.722036,0.655873,-0.197138,-0.186787,-0.434757,-0.504918,0.0795815,-0.292842,-0.172471,0.564708,0.21681,0.626146,-0.338249,-0.243802,-0.614777,0.118468,-0.293086,-0.588058,0.162724,-0.217156,0.359063,-0.0899454,-0.0748879,-0.000507924,0.450127,0.0581767,-0.407325,-0.0675015,0.531821,-0.234013,0.0705239,0.133607,-0.264254,0.249228,-0.440914,-0.562587,0.22441,-0.300854,-0.108219,-0.0535528,0.0172508,-0.518069,-0.231949,-0.0930361,-0.252114,-0.136579,-0.830874,0.432594,0.186035,0.113191,0.331771,-0.147297,-0.151514,0.000829807,-0.591804,0.37488,0.531022,-0.219342,-0.162538,0.185229,0.447197,0.212743,-0.311248,0.265102,0.122885,0.266785,0.35055,0.516512,-0.700951 +3424.93,0.999892,0.0912059,4,1.62626,0.874652,-1.11515,0.435713,0.0330928,-0.186336,0.442168,-0.256422,0.441624,-0.206463,-0.317445,-0.16792,-0.0246901,0.378112,0.0401779,0.610816,0.27148,-0.297981,0.0335872,-0.115671,-0.233846,-1.01401,-0.105769,0.492255,-0.139489,-0.255843,0.198084,0.0256597,-0.0698836,-0.254082,0.703881,0.0720126,0.0694099,0.414716,-0.624859,0.111376,-0.760093,1.14772,0.313841,-0.151425,1.19131,0.492959,0.157722,-0.350683,-0.347699,0.703912,-0.6908,0.158767,0.178731,0.0092488,0.205102,0.625449,-0.0167052,0.0655694,0.520188,-0.137739,-0.371578,-0.48579,0.276619,0.0789146,0.321181,0.617731,-0.706763,-1.04092,0.385925,-0.23268,-0.232958,-0.176179,0.0779779,-0.833294,-0.380829,0.195907,0.81845,0.171993,0.975543,0.38992,0.298643,0.218116,-0.261272,0.0687021,0.632825,-0.409117,-0.129347,-0.393881,0.0407172,-0.0358504,0.448335,-0.28448,0.512064,-0.676336,-0.61573,0.123299,-0.25391,0.233166,-0.0584706,0.0151937,-0.936644,-0.431434,0.363475,0.0857506,0.203775,-0.14477,-0.276973,-0.367108,-0.22256,-0.29558,0.600894,-0.322495,0.151659,0.388329,0.0444419,-0.382548,0.193651,0.217921,-0.204146,-0.00850159,-0.110644,-0.39573,-0.224683,-0.0336981,-0.859183,-0.00272939,-0.644567,-0.615583,-0.175011,0.179652,0.454805,0.672637,0.507228,-0.194298,0.0329911,-0.05791,-0.179798,0.312405,0.119049,0.0321114,0.35404,-0.0243332,0.026996,-0.556105,-0.0902187,-0.171829,0.0238251,-0.249424,-0.22049,-0.0600178,-0.245546,0.347504,-0.0874299,-0.0933758,0.200148,-0.0264453,0.410517,0.24327,0.0978438,-0.150772,0.0204425,-0.695205,-0.463267,0.0614633,0.203686,-0.143266,0.429139,-0.207324,0.280487,-0.130732,-0.684467,-0.607747,0.010151,-0.417256,0.572741,0.0797965,-0.240771,-0.183203,-0.393254,-0.278027,-0.349854,-0.171457,0.0774176,0.932316,-0.481365,-0.22527,-0.100057,-0.103988,-0.187916,0.147415,0.307071,-0.295941,0.134631,-0.523973,0.0375425,-0.552641,0.0655185,-0.480706,0.143178,0.0902609,-0.012924,-0.280407,-0.549516,-0.574342,-0.177921,0.0137567,0.420095,-0.310579,-0.0981092,0.0588644,-0.710061,0.922686,0.10474,0.444277,-0.234257,0.0808079,-0.172943,-0.136519,-0.386121,0.459003,-0.446625,-0.253881,0.117653,0.232811,-0.0444669,-0.661646,-0.589155,-0.506066,-0.290242,0.465297,-0.560159,-0.505344,-0.0665524,-0.190794,-0.373075,-0.165006,0.377094,-0.0191433,-0.419313,0.490183,-0.812348,0.576824,0.680644,-0.0443401,-0.118021,-0.375569,-0.482856,-0.0563691,-0.356113,0.255446,0.629935,0.269805,0.863275,-0.327286,-0.277517,-0.623966,0.144753,-0.299704,-0.850575,0.25996,-0.350089,0.494203,0.137742,-0.211648,-0.296965,0.293348,-0.00572991,-0.481207,-0.257821,0.238856,-0.1825,0.163769,0.0748475,-0.321956,0.328464,-0.506297,-0.271635,0.219177,-0.144113,0.0132128,0.0738025,-0.0539534,-0.45589,-0.105006,-0.109882,-0.114607,-0.242277,-0.606472,0.443475,0.258546,0.098987,0.335129,-0.0320687,-0.198595,-0.0203301,-0.617783,0.127579,0.265252,-0.401983,-0.0506614,0.237832,0.402868,0.421846,-0.044509,0.115741,0.110554,0.25759,0.332497,0.507534,0.189344 +3429.33,0.625125,0.0912059,4,1.5699,0.932773,-1.12677,0.468068,0.0661038,-0.220273,0.0563672,0.0589072,-0.268916,0.0913468,-0.186919,-0.309557,-0.0919106,0.269532,-0.0108667,0.649798,0.291947,-0.00110312,-0.00302475,-0.1487,-0.0908596,-0.933508,-0.457786,0.136881,0.0791114,-0.460261,0.370357,0.178651,-0.230522,0.0934439,0.960928,-0.281244,-0.0119676,0.346927,-0.929208,0.0327267,-0.270134,0.770443,0.530607,-0.0749294,1.28001,0.716967,0.182894,-1.22392,0.0640577,-0.100143,-0.388307,0.56362,0.313331,-0.285679,0.0917647,0.267383,-0.0903296,-0.506588,0.320705,0.265855,-0.241703,-0.697436,0.0581719,-0.134083,0.0108517,0.798913,-0.819363,-0.768362,0.286391,0.104058,0.145113,0.166711,0.372323,-0.61923,-0.055741,0.4874,0.809996,0.113665,1.00533,0.298326,-0.0904121,0.444686,-0.0284309,-0.0177996,0.494125,-0.216237,0.224184,-0.0825218,-0.266738,-0.0938394,-0.148748,0.108722,0.46426,-0.69497,-0.19489,0.42388,-0.204648,-0.0906886,-0.315787,-0.0973422,-0.613056,0.0343701,0.230834,-0.00924062,-0.214532,0.404531,-0.524789,-0.403829,0.101072,-0.497543,0.175648,-0.114527,0.101101,0.273708,0.134388,-0.393446,0.441813,0.07424,-0.300762,-0.1858,-0.165451,0.0119329,0.00848931,-0.733052,-0.320436,0.468009,-0.207311,-0.019872,-0.538285,0.626229,0.381048,0.634913,0.173807,-0.473654,-0.218722,0.246507,0.355455,0.141403,-0.15865,0.242985,0.0815848,0.0472959,0.237042,0.0752097,-0.08397,-0.0277748,0.151232,-0.203557,0.112182,0.271928,-0.0188753,0.324595,-0.107671,-0.123099,-0.0252223,0.106513,0.324403,0.0340405,-0.535563,-0.269969,0.109355,-0.363502,0.0302605,-0.0191561,0.410382,0.146169,0.149085,0.12526,0.353278,-0.185295,0.0804385,-0.142813,0.119852,-0.426712,0.186598,-0.648711,-0.407743,-0.0737292,0.00324867,-0.60284,-0.00101564,0.412642,0.190699,0.470947,-0.0981866,-0.36957,0.403832,0.173835,-0.311033,0.0143845,0.0206501,-0.0573903,0.2327,-0.31536,-0.103853,-0.220922,-0.206513,-0.889301,0.411473,0.0948065,0.345315,0.00338917,0.213449,-0.200335,-0.109335,-0.205542,-0.00392602,-0.176868,0.0325701,0.285203,-0.559348,0.945659,-0.0679363,0.29191,-0.300232,-0.199926,0.151116,-0.287043,-0.379634,-0.208641,-0.518275,-0.535637,0.353409,0.0719134,0.152712,-0.217253,-0.311608,-0.0932563,-0.212792,0.363295,-0.255964,-0.382742,-0.288938,-0.438256,-0.319049,-0.144759,-0.0619298,0.107666,-0.607558,0.586952,-0.649215,0.39946,0.467566,-0.771292,0.0987229,-0.0428964,-0.550829,0.145199,-0.266799,-0.0331923,0.956993,0.253165,-0.136159,0.00381834,-0.146224,-0.293089,0.363278,0.0815547,-0.41041,0.676948,-0.328573,0.447476,-0.09259,-0.13077,0.44374,-0.10186,-0.0326413,-0.33611,-0.192833,0.397577,-0.10675,0.334327,-0.254814,-0.150421,0.104532,-0.387631,-0.742671,0.464083,-0.264651,0.0945388,-0.349169,-0.244348,-0.552601,-0.0958373,-0.244876,0.0577465,-0.951966,-0.0815469,0.302273,-0.0283897,-0.129625,0.448489,0.395234,0.00490324,-0.190313,0.0360528,0.48301,0.3388,0.144433,0.0246328,0.1704,0.23496,-0.157302,0.142334,-0.784979,0.143063,0.143396,0.378236,0.378676,-0.095459 +3451.48,1,0.0912059,4,1.52697,0.855506,-1.02204,0.28298,0.0193312,-0.143484,0.221079,0.074866,0.0581903,0.24629,-0.308382,0.0700368,-0.352104,0.612014,-0.377928,0.699675,0.410869,-0.34867,-0.502571,-0.0655043,-0.00674484,-1.05469,-0.819634,-0.0651964,-0.340242,0.0985092,-0.0599288,0.580423,-0.0016926,-0.211078,1.19044,-0.37948,-0.240974,0.288515,-0.271018,0.377223,0.0765356,0.531358,0.331214,-0.0369843,1.13157,0.587049,0.507656,-0.83566,-0.335551,0.274742,-0.253102,0.404579,0.794401,0.105877,0.269402,0.44653,0.379269,-0.688742,0.794645,-0.454441,-0.198642,-0.566344,0.331714,-0.192031,0.278795,0.551957,-0.845305,-0.796726,0.462582,0.19648,-0.391062,-0.0757505,-0.178635,-0.0175101,-0.198612,0.227467,0.359739,0.124083,-0.0484528,0.181444,0.513907,-0.213037,-0.156784,-0.102234,0.236443,-0.344014,0.252957,-0.539367,-0.147779,-0.126384,-0.0421117,-0.485884,-0.0407285,-0.377399,0.199252,-0.72273,0.0524952,-0.00297544,0.159741,-0.556967,0.635201,-0.310531,-0.353515,0.164283,0.471468,-0.355921,0.16143,-0.0529301,0.234738,-0.158262,0.287236,-0.284425,0.438356,0.720573,-0.205466,-0.0232359,-0.243699,0.403256,0.0650802,0.34291,-0.289757,0.378515,0.284881,0.850077,-0.442897,-0.405153,-0.113195,-0.319751,0.143861,-0.255689,0.376252,-0.0091339,0.356299,-0.179801,0.232264,-0.170597,-0.124292,0.649715,-0.476997,-0.351531,0.0842845,-0.013411,0.268386,-0.404435,-0.474873,0.1276,-0.0339846,-0.308631,0.0204702,-0.168226,-0.254453,0.100312,-0.553519,0.039233,-0.25205,-0.128583,-0.0321066,-0.527909,0.22363,0.73833,-0.104896,-0.144063,-0.176178,0.0533109,-0.00163333,0.137633,0.919155,-0.0101926,-0.585717,0.0913875,-0.259757,-0.0734196,-0.439083,0.0318552,0.021101,0.0612477,0.0291476,-0.19303,0.025901,-0.0798919,-0.189068,-0.321051,0.32103,1.07962,0.554641,0.475217,-0.205724,-0.0894232,0.419371,0.0654793,-0.223043,-0.193851,-0.198138,-0.089045,0.144878,0.151286,0.149704,-0.304288,-0.165867,0.277717,-0.105349,-0.63968,-0.801179,0.0345656,0.147774,-0.0680915,0.240332,-0.224921,-0.126348,-0.44145,-0.157962,0.444887,0.0479683,0.0133655,0.00273766,-0.126028,-0.317665,0.300709,0.188486,0.334298,-0.159468,0.494907,0.0868889,-0.433179,-0.124812,-0.496323,0.164413,-0.235877,-0.470408,0.354139,-0.317388,-0.101143,0.659054,0.0614161,-0.165153,-0.219061,-0.0682782,-0.301422,0.287679,0.515606,0.450779,0.00946763,0.819976,0.1988,-0.0814121,0.0165366,0.304816,-0.020539,1.15316,0.154425,0.0247854,0.190854,0.239245,-0.262474,0.413812,-0.741929,0.158419,-0.537647,0.242303,0.041582,-0.025727,-0.0531344,0.188069,0.57297,-0.283127,0.388046,0.100023,0.140961,0.31363,-0.00619221,-0.215877,-0.201165,0.356987,0.0323135,-0.542716,-0.297581,-0.173502,-0.334425,0.243475,-0.175201,0.308559,0.218156,0.330614,0.214723,0.0799121,0.024664,0.0672426,-0.0166328,-0.0742157,0.301087,0.175375,0.258605,-0.127151,-0.0372819,-0.0359064,0.327716,-0.419965,0.25506,0.0660668,-0.656739,-0.224381,0.0258242,0.284734,-0.7452,0.387828,0.114462,0.397382,0.338322,0.630382,0.254798 +3449.87,0.642884,0.0912059,5,1.6636,0.501849,-1.16233,0.455851,0.64524,-0.0619656,-0.326154,-0.446511,0.383291,-0.415678,0.267708,-0.429064,-0.315537,0.653784,-0.0351231,0.362754,0.0904898,-0.185966,-0.232461,0.030311,-0.134633,-0.742578,-0.649359,0.657638,-0.433371,-0.0462776,-0.24181,0.0780956,-0.827072,-0.0676965,1.08164,-0.781546,-0.299266,0.317058,0.0314837,-0.212118,-0.84569,0.545183,0.529201,-0.183907,0.919945,0.638614,-0.110151,-0.250077,0.380216,-0.197199,-1.13335,0.019538,0.387625,0.553466,0.179675,-0.229448,0.227802,-0.485757,1.01518,-0.193291,0.281419,-0.797657,0.577243,-0.514723,0.0238684,1.10858,-0.548855,-1.31032,-0.409473,0.18283,-0.370585,-0.0359,0.147653,-0.47323,-0.0102787,0.355889,0.47169,-0.206983,0.529698,0.568864,-0.348209,0.0974601,-0.594283,0.182,0.40732,0.0406388,0.0420668,0.270289,0.169519,-0.109066,0.187559,0.0992263,-0.132428,-0.126217,-0.0564393,0.541277,0.0428223,-0.00534305,0.06665,0.159324,-0.513643,-0.13957,0.412211,0.332011,-0.223822,0.105806,-0.463864,-0.422171,-0.0694557,-0.299869,0.0270715,-0.241855,0.0988238,0.328343,-0.261868,-0.134931,0.466137,0.527631,-0.08309,-0.238134,-0.139396,-0.0679816,0.383633,-0.912866,-0.561312,0.533078,0.182716,0.0595821,-0.219175,0.484582,0.201771,0.145036,0.0368685,-0.305623,-0.0754824,0.0704409,0.143541,0.159321,0.183752,0.0540797,-0.486025,-0.348881,0.533259,-0.499252,0.241766,-0.199337,-0.130077,-0.213929,0.176938,0.29219,0.0193109,0.216218,0.217243,-0.0446088,-0.224883,0.499008,0.00654569,0.37152,0.0994091,0.0242157,0.426313,0.286062,0.193167,0.0141366,0.193426,-0.0260192,0.250658,-0.0421335,0.217255,0.213693,0.41062,-0.0888405,-0.0260651,-0.184601,0.0307493,-0.07448,0.199139,-0.717489,-0.16455,0.104722,-0.450112,0.0707317,0.0418536,0.294751,-0.295032,-0.562625,0.394287,0.0437361,-0.196134,-0.429966,-0.0426817,-0.104113,0.613603,-0.555315,-0.221789,-0.0822149,-0.384078,-0.74287,-0.0433072,-0.314106,-0.140298,0.273834,0.0185101,0.233177,0.0989557,-0.263741,0.0885519,0.244211,0.104793,0.426411,-0.376331,0.571232,-0.095718,0.262401,0.254025,0.00667507,0.412265,-0.00937683,-0.230714,-0.0191961,-0.173366,0.12395,0.417048,-0.0303161,-0.0694949,-0.0994223,0.026676,0.41403,-0.0744627,0.541385,-0.095667,-0.106793,-0.702332,-0.175767,0.0753732,-0.0459002,-0.305528,0.24912,-0.430477,0.226479,-0.289762,-0.190696,0.138538,-0.541421,-0.154676,0.0569041,0.137923,-0.0235721,-0.463431,-0.0685237,0.438297,0.507657,-0.410746,-0.310808,-0.427858,0.0804414,0.850617,0.130963,-0.394801,0.0797056,-0.0508255,0.247373,0.261187,0.0849516,0.379302,0.324858,-0.202001,0.213349,-0.077515,-0.0301774,-0.296585,0.134503,-0.242362,0.405515,0.295546,-0.280681,0.0337569,0.630836,-0.0792623,0.294092,0.448267,-0.355268,-0.115519,0.0332202,-0.303716,-0.124632,-0.387521,-0.159142,0.189408,0.226582,-0.391148,0.116481,0.162882,0.115344,0.162994,-0.182697,0.235802,0.0152553,-0.205113,-0.251618,0.100263,-0.18218,-0.0813944,0.647173,-0.360375,0.0898014,0.241741,0.299669,0.491672,-1.17182 +3419.4,0.702644,0.0912059,4,1.5935,0.710561,-0.634789,0.299058,0.741034,-0.149592,0.077392,-0.0360432,0.217415,0.318349,0.0426789,-0.728703,-0.274624,0.378616,-0.753371,1.26467,0.334847,0.0717724,-0.04968,0.014703,0.160889,-0.58674,-1.47323,0.30595,-0.312798,-0.392167,0.138395,0.114694,0.0598187,0.722642,1.12064,-0.736866,-0.289838,0.374191,0.222715,-0.695856,-0.404182,-0.238622,0.423659,-0.543551,0.992672,0.370877,0.299262,-0.343932,0.117912,0.181641,-0.67533,0.0460284,0.659915,0.143935,-0.0188001,0.223979,-0.0711929,-0.881744,0.985381,-0.671651,-0.357734,-0.490794,0.607827,-0.517267,0.232136,1.27351,-0.341399,-1.56007,-0.0413059,-0.0165796,0.203863,-0.351873,-0.192046,-0.339452,0.573054,0.160835,0.516142,0.651308,0.122085,0.447349,0.750469,-0.103766,0.126556,-0.0431469,0.349848,-0.230472,0.358404,-0.294905,0.283937,0.116347,-0.0331032,-0.324998,0.043241,-0.807134,0.0946426,0.186341,0.571414,-0.0788203,0.156694,-0.45784,0.381821,-0.165176,-0.217306,0.146669,0.0604832,-0.440945,0.0803374,-0.0716235,-0.0521993,-0.0192876,-0.0914937,0.0314897,-0.271198,0.332025,0.2148,-0.0525436,-0.172489,0.22642,0.418773,0.362884,-0.35552,-0.0204832,0.0236671,0.404935,-0.951103,-0.99868,-0.187768,-0.251772,0.32103,-0.00579324,-0.276806,-0.0396311,0.508829,-0.0496115,0.118256,-0.237887,-0.079944,0.232313,-0.117177,-0.145646,0.284803,0.124015,0.0866735,-0.311012,-0.167728,0.228164,0.0469509,-0.139254,-0.184761,-0.20003,-0.363651,0.00685542,-0.775079,-0.282731,-0.368685,0.0524172,0.118693,0.0657427,0.155415,0.550447,-0.187117,-0.557644,-0.225145,-0.218745,-0.0504444,0.177196,0.689271,0.0817539,-0.224862,-0.145423,-0.40413,-0.284783,-0.369517,0.140277,0.232654,-0.131033,-0.137765,0.842725,-0.34538,-0.452794,-0.0918354,-0.215858,0.0397521,0.338987,0.24789,0.630227,0.0219666,-0.303607,0.283882,-0.249673,-0.395306,-0.0768013,0.388889,-0.0160584,0.0926647,0.284273,0.0122797,0.0958229,0.0272008,0.680925,0.241929,-0.605132,-0.588957,0.0337524,-0.197489,0.0699809,-0.193552,-0.576369,-0.0280065,-0.430775,-0.576031,0.753575,-0.406821,-0.0764511,0.210781,-0.160924,0.199377,0.400288,0.234213,0.252919,-0.129682,0.107895,-0.719508,-0.371033,0.0169643,-0.798882,-0.0660919,0.0535307,-0.486436,0.241465,-0.55009,-0.676163,0.768603,0.208524,-0.0048282,0.264116,0.144358,-0.703412,0.0665085,0.381572,0.0529593,0.0270392,0.287873,-0.0650613,0.294966,-0.148911,-0.249915,0.182297,0.554729,0.047051,0.530169,-0.0733897,0.314103,-0.0964059,0.237874,-1.09379,0.223768,-0.455998,0.357057,0.318663,-0.31249,-0.00912131,0.0693386,0.158869,-0.15973,0.084697,0.0775357,-0.176067,0.265478,-0.333627,0.0027244,0.0050206,0.361245,0.0476235,-0.641585,0.404325,-0.0297038,-0.290149,-0.158487,-0.0203838,-0.231913,0.268742,0.320206,-0.139054,-0.437654,-0.50389,0.432942,0.0727865,0.047294,-0.27489,0.046973,0.306675,-0.174994,-0.0754918,0.149671,0.377235,-0.546808,-0.0603744,0.0445349,-0.125007,-0.0455178,-0.403744,-0.0799832,-0.288972,0.0678349,0.112615,0.4424,0.335582,0.665131,-2.0355 +3393.56,0.99833,0.0912059,4,1.56726,0.722707,-0.707684,0.319545,0.5411,-0.0444441,-0.0693357,0.0973128,0.08589,0.0571022,0.535381,-0.0346026,0.0797905,0.760919,-0.158915,0.935341,0.44315,-0.204696,-0.187606,-0.0828288,0.257141,-0.756939,-0.0192357,0.512754,-0.612931,-0.0232433,0.379193,1.43481,-0.601675,-0.203848,1.06353,-0.0301023,0.0102546,0.398228,-0.00918939,-0.265402,-0.866915,0.642425,0.205228,0.0341345,1.18908,0.321784,0.114163,-0.936939,0.157872,-0.0353871,-0.627154,0.117058,0.27981,0.0412602,0.0492674,-0.648698,-0.244835,-0.541858,0.832383,-0.766083,0.406369,-0.826058,0.589838,-0.727942,-0.132398,1.33554,-0.704364,-0.940775,-0.561266,0.331333,0.149521,-0.0250981,-0.242177,-0.355015,0.270687,0.0359405,0.428446,0.101777,0.047598,0.374947,0.437118,0.385491,-0.264004,-0.0608693,0.57634,0.0767769,-0.0246064,0.258191,0.017455,-0.257762,-0.672502,0.270546,0.159419,-0.203489,0.0825582,-0.000461456,-0.0714506,-0.314339,0.105734,-0.609756,-0.317498,0.101598,-0.16772,-0.0864522,0.0511939,-0.111072,-0.94436,-0.612891,0.172556,-0.198178,0.505599,-0.668961,0.858188,0.563653,0.0276358,0.232778,0.303286,0.499767,0.422168,-0.266758,-0.76087,0.0371608,0.642465,-0.885954,-0.940713,-0.426016,0.251498,-0.123835,-0.0335593,0.240003,0.297642,-0.50114,0.053987,-0.491903,-0.0079589,0.244563,0.428698,-0.0955118,-0.122939,0.0633493,-0.129608,-0.277068,0.293139,-0.214646,0.0684499,-0.14396,0.313331,-0.286515,-0.248669,-0.490746,0.430158,0.619924,0.113659,0.0409117,-0.234822,0.271542,0.0590055,0.304144,0.333725,0.313425,0.19852,-0.0539466,-0.173142,0.193563,0.52675,0.181938,0.222879,-0.528559,0.349136,0.121625,0.0549404,0.0600402,0.177549,-0.164366,0.603925,0.685746,0.0552354,-0.20249,-0.0334359,0.221438,-0.164982,0.168397,0.150745,-0.304715,-0.0094119,-0.0672919,0.322567,0.422122,-0.312317,-0.183986,-0.187846,-0.137504,0.0461137,-0.356608,-0.0951088,-0.0393274,-0.496136,-0.975498,0.395374,-0.246612,0.489542,-0.181327,-0.111376,-0.0757311,0.206352,0.155479,0.266548,-0.192733,-0.0694982,0.326364,-0.726979,0.624471,0.287003,0.478763,-0.131696,-0.293661,0.289847,0.55556,-0.526514,0.561733,0.350755,0.0447449,0.447419,-0.159132,0.638571,-0.873962,-0.114879,0.0302888,-0.761925,0.582685,-0.106752,0.0870576,-0.0987642,0.15454,-0.476301,-0.167508,-0.279964,0.0204314,0.174029,0.238809,-0.474386,0.146167,-0.175672,-0.558069,0.11746,0.0398031,0.134463,-0.518825,0.432673,0.0331231,0.0426744,0.673756,-0.278137,-0.332401,0.077793,0.124775,0.00575933,-0.569233,-0.32853,-0.0308443,-0.679448,-0.479064,-0.433167,-0.0185971,0.310462,0.565307,-0.400364,-1.00982,-0.0139093,0.590449,-0.331859,-0.170067,0.154805,0.268462,0.0121888,0.160367,-0.569094,-0.12605,0.0994089,-0.316963,-0.350578,0.126591,0.369106,0.495154,0.385432,0.317944,-0.366258,0.168543,0.259149,0.371665,0.250603,-0.447643,0.434718,0.0975501,-0.0329993,0.834055,-0.00537791,0.0819397,0.0644713,-0.88345,-0.139114,-0.0801148,0.0243199,0.00503958,0.549766,0.126693,0.236746,0.355939,0.486565,-1.42689 +3442.54,0.676627,0.0912059,4,1.49813,0.806485,-1.01666,0.389393,-0.0656785,-0.11423,-0.417004,0.139995,0.544074,0.349395,0.0418292,0.103371,0.124346,0.587696,-0.0170928,0.749643,0.645207,0.0901128,0.152597,0.335989,0.0332097,-1.01934,-0.777246,0.529674,-0.0835891,-0.419787,0.351105,0.77823,-0.197704,-0.046051,1.22729,-0.433588,-0.370356,0.347905,0.115442,-0.139274,-0.287902,0.656472,0.153902,-0.409408,1.2975,0.743736,0.0567226,-0.285835,-0.0840164,0.516508,-0.294644,-0.167944,0.815442,-0.424394,-0.083118,0.00162488,-0.119978,-0.380056,0.443183,-0.056899,0.034673,-0.285261,0.567445,-0.30033,0.257484,1.43401,-0.298104,-1.42243,0.39116,0.400215,-0.305834,-0.106906,0.545644,-0.616103,-0.337076,-0.235994,0.61131,0.198699,0.186197,0.116348,0.531761,0.523297,-0.129611,0.0555944,0.938556,-0.200917,0.16264,-0.011312,0.206964,-0.0471463,-0.307239,0.0740279,0.260176,-0.458511,0.276185,0.258539,-0.09146,-0.731532,0.405539,0.0138484,0.532484,-0.135445,0.254508,0.0527991,0.125973,-0.406621,-0.239961,-0.689325,0.28828,0.269002,0.557828,-0.551117,0.346383,0.821203,-0.306293,-0.012101,0.116053,0.462923,0.00307857,-0.155419,-0.260321,0.0707483,0.501222,0.287996,-0.835902,-0.0764542,0.42523,-0.439941,9.43067e-05,0.14369,0.282019,0.0570054,0.339058,-0.496818,-0.0746325,-0.177831,0.376044,0.383906,-0.116643,0.00908121,0.0161581,-0.342565,0.305016,-0.113303,-0.449846,-0.00240349,-0.345735,-0.045289,0.118084,-0.835191,-0.0647535,0.79412,-0.186028,0.0948165,0.205284,-0.368687,0.0567507,0.36134,0.450745,0.170284,0.263527,0.257466,-0.316852,-0.220047,0.223661,-0.253834,0.722859,-0.0737184,0.478037,0.162353,-0.138465,-0.0160342,-0.0349834,0.119778,0.23343,-0.0522764,-0.0340712,-0.120357,-0.234051,0.0969873,-0.328202,-0.345025,-0.059122,0.6018,-0.354243,0.237593,0.398751,0.205015,-0.144791,-0.111195,0.086387,-0.126521,0.309801,-0.155176,-0.20733,0.0677832,-0.379528,-0.779652,-0.477629,-0.351812,0.383028,-0.181116,0.165609,-0.450004,-0.00814469,-0.147163,0.35458,-0.52474,-0.141791,0.334378,-0.324763,0.665333,0.29633,-0.023774,0.0283785,-0.170808,0.191738,0.0554531,-0.351499,0.329136,-0.017399,-0.127564,-0.313279,-0.260264,-0.126486,-0.648289,-0.125539,-0.295186,-0.763284,0.202882,-0.238143,-0.318542,-0.145508,0.251492,-0.243577,0.229316,0.130596,-0.101292,-0.649522,0.232743,-0.0982475,0.267531,0.378745,0.250219,0.168506,0.167436,-0.077183,-0.275248,0.118426,0.432278,0.273204,0.116725,-0.465758,-0.302624,-0.23921,-0.23286,0.188429,-0.62205,-0.231509,0.247376,-0.311382,-0.18744,0.0070109,0.210523,0.277295,0.23973,-0.0352819,-0.650434,0.598105,0.138641,-0.45263,-0.155044,-0.309984,-0.0293441,-0.462766,0.12539,0.253014,-0.435029,-0.0582975,-0.646059,0.23372,0.0246442,0.774941,0.497433,-0.0437916,-0.286828,-0.127153,0.244569,0.0620889,0.0490244,0.201132,-0.557456,0.337334,-0.0806577,0.128745,0.0254037,-0.25939,0.166687,-0.392505,-0.220906,0.377727,-0.1929,-0.0305261,-0.0301286,0.293695,0.117741,0.31532,0.343135,0.561534,0.483788 +3443.8,0.85105,0.0912059,4,1.49937,0.770578,-0.926985,0.365352,-0.0607787,-0.112449,-0.420909,0.166823,0.58384,0.271439,0.103408,0.0676999,0.0819515,0.574881,0.049887,0.779451,0.615429,0.158895,0.0435667,0.351937,0.0681713,-1.06512,-0.781568,0.47855,-0.0714143,-0.397037,0.311093,0.778208,-0.269552,0.0306334,1.14909,-0.471531,-0.356718,0.365549,0.0188113,-0.164805,-0.251854,0.668489,0.144773,-0.405898,1.36177,0.742081,0.165564,-0.311862,-0.0618132,0.475121,-0.386143,-0.214791,0.872069,-0.454779,-0.14601,0.0723991,-0.129063,-0.334771,0.469369,-0.0827639,0.00759596,-0.314312,0.498264,-0.241944,0.273959,1.40887,-0.31954,-1.38707,0.379933,0.450521,-0.343823,-0.140394,0.567078,-0.653665,-0.263274,-0.208545,0.614993,0.172458,0.221758,0.0998292,0.522465,0.490357,-0.0465048,0.0957779,0.939278,-0.238782,0.190551,0.0481911,0.138258,0.015514,-0.238379,0.123578,0.217497,-0.41739,0.227896,0.284246,0.0146427,-0.676816,0.398088,0.0102826,0.446365,-0.152445,0.223517,0.148658,0.0792608,-0.443544,-0.352883,-0.706423,0.218402,0.21369,0.621428,-0.490906,0.398179,0.817524,-0.265612,0.051413,0.0773354,0.518432,0.0579342,-0.109963,-0.233883,0.0489152,0.4659,0.363843,-0.820394,-0.0180427,0.457465,-0.446835,0.0223432,0.153209,0.218741,0.127157,0.283176,-0.468164,-0.158453,-0.244412,0.450218,0.35907,-0.0470578,0.0823877,0.0656807,-0.327085,0.308589,-0.165848,-0.429482,-0.0822628,-0.268301,-0.101105,0.135386,-0.864741,-0.037047,0.704221,-0.185628,0.05049,0.154299,-0.333848,0.0188723,0.377659,0.471749,0.179868,0.144589,0.228667,-0.341802,-0.216539,0.246201,-0.273499,0.652015,-0.0438583,0.529163,0.219302,-0.140737,0.0527142,-0.0282618,0.197699,0.224619,-0.0827515,-0.0124211,-0.134993,-0.331885,0.0216046,-0.354355,-0.323124,-0.0503807,0.588137,-0.2399,0.228159,0.371571,0.247525,-0.103361,-0.132467,0.171636,-0.16035,0.325568,-0.119275,-0.176183,0.115122,-0.336402,-0.807168,-0.491764,-0.433543,0.345254,-0.190374,0.234722,-0.392835,-0.0249562,-0.13007,0.355462,-0.513546,-0.153513,0.346656,-0.337735,0.65735,0.289352,-0.0588756,0.0293883,-0.195688,0.156728,0.0488153,-0.387378,0.410682,0.0737341,-0.113707,-0.276927,-0.25232,-0.1015,-0.625535,-0.176196,-0.328032,-0.803099,0.171912,-0.184191,-0.33684,-0.210295,0.178405,-0.220084,0.258749,0.188141,-0.0557293,-0.682021,0.208631,-0.0487896,0.174462,0.348197,0.316392,0.235421,0.136266,-0.169201,-0.218111,0.229895,0.411553,0.256035,0.203129,-0.481721,-0.334804,-0.316954,-0.231602,0.194507,-0.633255,-0.200342,0.243267,-0.326976,-0.186079,-0.0250375,0.197686,0.220556,0.272745,-0.063018,-0.507779,0.565529,0.142484,-0.414631,-0.10256,-0.401256,-0.0808857,-0.441256,0.0882508,0.209571,-0.425485,-0.143659,-0.635622,0.24614,-0.0323181,0.694098,0.493348,-0.01999,-0.324043,-0.0865731,0.205064,0.0490433,-0.0299746,0.204877,-0.602503,0.450054,-0.0839904,0.129942,-0.00206041,-0.21767,0.19713,-0.315601,-0.203212,0.323613,-0.242572,-0.100864,0.00758186,0.32643,0.123405,0.302285,0.35129,0.549804,0.50748 +3454.13,0.81873,0.0912059,4,1.52147,0.990618,-0.908209,0.239506,0.331275,0.0131708,0.107447,-0.0220852,-0.0950001,0.219411,-0.0566889,-0.308025,-0.294732,0.482543,-0.139035,1.23403,0.156276,-0.203261,-0.403869,-0.464246,-0.163497,-0.714731,-0.246627,0.142388,-0.491942,-0.0769852,0.24358,-0.081766,-0.196813,-0.255267,0.634728,-0.940264,0.296576,0.340381,-0.029361,-0.467331,-0.700997,0.768456,0.793226,-0.397153,0.922462,0.883617,0.351869,-0.684128,-0.297205,-0.229776,-0.441114,0.288618,0.363579,0.226642,0.417254,0.671542,0.0270769,-0.201026,0.672994,-0.392265,-0.18135,-0.431656,0.649325,-0.0280483,-0.0440021,1.03633,-0.974963,0.0361311,0.0299118,0.426339,0.279542,0.402203,-0.509506,-0.389643,0.301432,0.0768668,-0.0233947,-0.130649,0.426088,0.599942,0.0313319,0.227268,0.092457,-0.179048,-0.277594,0.0869513,0.029006,0.205186,-0.160941,-0.262889,-0.111647,0.0631675,0.407466,-0.340999,0.187965,-0.0955424,-0.400941,0.385742,-0.0258619,-0.579755,-0.257345,-0.354927,0.0669173,-0.0408385,-0.0803081,0.0801084,0.0421078,0.254626,-0.214343,-0.430279,0.0121971,0.0914209,0.310487,0.293613,-0.188615,0.000958729,0.113425,0.37488,-0.0697604,0.630755,-0.347062,0.00265958,-0.135349,-0.155931,-0.423153,-0.182394,-0.2542,-0.104537,0.301483,0.438227,0.435441,0.470879,0.0966938,-0.0574472,0.250236,-0.137597,-0.169384,0.300374,-0.34204,-0.0333011,0.230558,0.392854,0.0678134,-0.706166,-0.620667,0.0914283,0.0226686,-0.415231,0.354771,0.303077,-0.229159,0.50971,-0.147345,0.395859,-0.361206,0.188697,-0.152612,0.479461,0.218445,0.156806,0.318397,-0.0156877,0.119085,-0.04319,0.674202,-0.293183,0.926168,-0.301168,-0.241692,0.435962,0.2522,0.393993,-0.0490849,0.201213,0.558738,-0.0152659,0.106565,0.265594,0.171334,-0.188889,-0.300824,-0.217259,0.520888,0.260777,-0.0884072,-0.443932,0.220492,-0.113019,0.400325,-0.366246,-0.636479,-0.260288,-0.276667,-0.16867,-0.263474,0.129928,-0.0320276,-0.63976,0.391637,0.099239,0.024514,-0.443832,-0.266855,0.112235,-0.210703,0.20066,0.18089,-0.0768843,0.169307,-0.353056,-0.664129,0.887086,0.366883,0.00258796,-0.433079,-0.246174,0.66982,0.494841,-0.0570489,0.0986456,-0.0990328,0.327067,0.374874,-0.345898,-0.0835024,0.205152,-0.154457,0.205967,0.277589,0.375181,0.375069,-0.00461124,0.470878,0.45842,-0.0336394,0.00265404,-0.162515,0.0622458,-0.161657,0.438423,0.167948,-0.0305458,0.0875986,-0.137736,-0.381529,0.255848,0.258012,-0.114726,0.0167037,0.243814,0.415872,0.16053,0.147882,-0.72454,-0.139456,-0.379354,0.0923885,0.272458,0.313264,0.0793249,-0.488896,-0.109725,0.10002,-0.0401343,-0.0698493,0.302726,-0.469037,0.0534556,-0.0960115,-0.0068303,-0.102545,0.0148409,0.540012,-0.115523,-0.175166,-0.143541,0.130869,-0.0700383,0.0716899,0.467983,0.0419431,-0.0830668,0.175369,-0.406284,0.195659,-0.287397,0.185971,-0.197096,0.13315,-0.137884,-0.25405,0.661373,0.0555128,0.299186,-0.00109057,0.182284,-0.128853,-0.16957,-0.00427025,0.0270892,0.37523,-0.0859003,-0.214277,-0.307576,-0.0846193,0.0973438,0.215423,0.312,0.464137,-1.08289 +3463.4,0.997515,0.0912059,4,1.54876,0.970455,-1.39813,0.44859,0.534823,-0.135549,0.108256,-0.12039,0.167696,0.0331918,-0.0801573,-0.338393,0.0127018,0.118916,-0.0434545,0.47204,0.1115,-0.0564878,-0.224139,-0.189059,-0.945067,-0.698496,-1.45199,0.124666,-0.0620405,-0.161474,-0.489455,0.924761,-0.486285,0.00767909,0.520129,-0.221328,0.0558889,0.211858,-0.427737,-0.133033,-0.375726,1.15579,0.51716,0.491938,0.905099,0.0869317,0.206163,-0.56385,-0.204948,0.887609,-0.424066,0.27114,0.606299,-0.0461768,-0.0580774,0.516806,-0.0651066,-0.592955,0.642068,0.0274554,-0.195988,-0.486412,0.413517,-0.660799,0.210293,1.06085,-0.0578082,-1.26928,0.801488,-0.2148,0.0111263,0.0877522,0.432309,-0.145143,-0.168717,0.117515,0.606217,-0.0843713,0.517415,-0.0523733,0.399985,0.000668337,-0.127875,0.464157,0.447195,-0.254024,0.232657,-0.447201,0.196766,0.323141,-0.372067,-0.674206,-0.182133,-0.268373,0.264198,0.154713,0.0966191,-0.226679,0.379145,0.627765,-0.0885415,-0.0277662,-0.360875,0.556108,0.165001,0.122204,-0.375687,-0.0975495,0.446001,-0.34276,0.0366723,-0.316682,-0.092049,0.613267,0.159381,0.0822537,0.142292,0.151329,0.438067,-0.114249,-0.289079,0.241991,0.577,0.00431909,-0.409995,-0.534811,0.0469311,-0.521391,-0.327576,-0.263821,0.608874,-0.273819,0.364928,-0.706853,0.00165886,-0.348713,-0.0732398,0.392259,-0.0347392,-0.21147,0.0921585,-0.395209,0.67756,-0.439937,-0.013828,-0.240744,0.0713382,-0.20429,-0.170447,-0.115848,0.282275,0.253312,0.0492356,-0.811823,0.086695,-0.188946,0.447006,0.0121844,0.183348,0.112888,-0.0617399,0.0520533,-0.0968058,0.213231,-0.0139871,-0.0399707,0.670239,0.335399,-0.0795799,-0.245997,-0.384691,-0.357692,-0.0372192,-0.463737,0.0958203,0.0685301,-0.376299,0.155152,0.0494106,-0.0832922,-0.0865974,0.147614,0.178074,0.801474,0.304634,-0.0813894,0.00873968,-0.00382896,-0.0345141,-0.106047,0.364292,-0.347732,0.648755,-0.230774,-0.221842,-0.331739,-0.189431,-0.461665,-0.138492,0.137207,-0.0140793,0.179323,-0.567423,0.31948,-0.0621899,-0.110955,0.31495,0.379611,-0.335811,0.244584,-0.00913452,0.894093,-0.143812,0.140587,0.0801004,-0.0279026,-0.15651,-0.00925339,-0.409737,-0.0467082,-0.70176,-0.00452224,0.395067,-0.00427976,-0.075518,-0.486471,0.148552,0.319909,-0.469017,0.142832,-0.549108,-0.537964,-0.0199045,0.0650171,-0.503024,-0.20611,-0.300813,-0.378723,-0.268961,0.447399,-0.0131578,0.714343,0.76141,0.209557,-0.0611845,-0.54952,-0.446704,0.123372,0.479812,0.15682,0.444368,0.0387802,-0.11503,-0.214321,-0.058343,-0.207244,0.27172,-0.342596,0.0625827,0.427749,0.00618521,-0.183464,-0.269917,-0.183296,-0.0468581,-0.106283,0.363229,-0.0758765,0.216933,0.183812,-0.0341871,-0.0574759,-0.623722,0.162632,0.271474,0.132769,-0.116406,-0.225299,-0.0333401,-0.493094,0.272763,0.303403,-0.0163992,0.274791,-0.047834,-0.158178,-0.242588,0.175402,0.104349,0.265427,0.153664,-0.225557,0.132139,-0.190804,-0.140373,0.0797551,0.0404807,0.205346,-0.064623,-0.572166,-0.54891,0.117852,-0.148887,0.225783,-0.0998883,0.0972383,0.264109,0.31183,0.513915,-1.59939 +3446.37,0.923645,0.0912059,4,1.63331,0.965484,-1.09635,0.360922,0.253855,-0.0535766,-0.0986879,-0.0265129,0.244798,0.136704,-0.499165,-0.285578,0.184234,0.258782,-0.340243,0.820665,0.0510946,-0.280182,-0.382,-0.357654,-0.591367,-0.992446,-1.25158,0.103736,-0.142269,-0.406763,-0.0324681,0.249211,0.0485206,0.0671626,0.535829,-0.252764,0.310199,-0.214351,-0.416753,-0.247531,-0.549677,0.842562,0.214729,0.329742,0.81919,0.123396,0.356364,-0.923125,0.0458574,0.659185,-0.288305,0.867067,0.291263,0.186713,0.307665,0.158452,-0.167025,0.308263,0.408843,-0.178788,-0.217011,-0.543175,0.096142,-0.762032,0.311929,0.9428,-0.343812,-1.07773,0.803397,-0.0859442,-0.103138,0.156801,-0.119158,-0.24098,-0.188856,0.317551,0.404047,0.00229677,0.608049,-0.0461893,0.347197,0.324236,-0.437236,0.00810598,0.229182,0.104014,0.0164466,-0.228137,-0.128867,0.529941,-0.00242956,-0.332876,-0.152907,-0.317335,-0.425515,-0.583053,-0.239048,-0.0431648,0.264578,-0.0335707,0.144707,-0.291883,-0.0317992,0.283904,0.384447,0.146365,0.169688,-0.221533,0.0848581,0.103464,-0.41119,-0.706284,0.254637,0.16681,-0.380469,-0.242926,-0.289044,0.379958,0.323454,-0.240463,-0.0350102,0.4291,0.77262,0.342158,-0.395557,-0.308851,0.172496,-0.0629428,-0.179767,0.668102,0.0151791,-0.109386,0.274639,-0.410733,0.0172137,-0.248394,0.135074,0.747555,-0.282663,0.0735896,-0.59475,0.121941,0.746212,-0.241207,0.00759721,-0.0650801,0.1402,-0.29714,0.360861,-0.00770857,0.265403,0.0326004,0.0211843,-0.28461,0.139838,0.260519,0.204339,-0.29055,0.336362,0.0868007,0.672403,-0.0441104,0.193641,-0.0335705,-0.0318824,0.322245,0.634152,-0.312825,-0.332716,-0.338696,-0.12941,-0.023786,-0.547474,-0.0656568,0.416412,-0.0229397,-0.0370453,0.0466073,-0.00993528,-0.394823,0.114674,-0.0663703,0.553719,0.425066,-0.00565323,0.217737,-0.276994,-0.220054,-0.155997,-0.254587,0.0698459,-0.0958543,0.203765,-0.85684,0.243416,0.423189,-0.626357,-0.640149,0.11915,0.528226,0.52025,0.206963,-1.12339,0.131787,-0.383517,-0.564352,0.244924,0.423382,0.151171,-0.000952075,-0.250643,0.973123,-0.158214,-0.415709,0.02548,-0.0481592,0.315461,0.0425693,-0.642046,-0.190143,-0.451574,0.403041,0.651907,0.300103,0.0293904,-0.283878,-0.187425,0.290961,-0.391842,0.655655,0.13735,0.0339434,-0.0402245,-0.0310897,-0.457127,0.0647997,-0.278671,0.0830344,-0.0747164,0.610185,0.0737974,-0.0132168,0.14508,0.0249946,-0.632967,-0.246306,-0.00928625,0.184565,-0.00457892,0.210597,0.669495,0.168404,-0.253269,0.0643062,0.129257,-0.615062,0.371813,0.248667,0.140285,0.41331,0.0889281,0.124067,0.114694,-0.14937,-0.185162,-0.0559383,-0.111515,0.293518,-0.11249,0.0632764,0.265607,-0.00378603,-0.00502436,-0.00867105,-0.0754494,0.198649,0.16444,-0.256848,-0.196487,-0.522688,0.333,0.497938,0.0514131,0.0807538,-0.350572,-0.24141,-0.337842,0.232993,0.0652841,0.417965,-0.0482166,-0.170353,0.270262,-0.00473608,-0.271193,0.147923,0.190734,0.0562828,-0.509528,0.149822,-0.127081,-0.432996,-0.182923,-0.232813,-0.0260795,0.106009,0.347709,0.32559,0.589669,-0.669218 +3443.39,0.964503,0.0912059,4,1.66238,1.07464,-1.112,0.325002,0.139227,-0.249456,0.300958,0.0175808,-0.161684,0.771813,-0.375708,-0.322396,-0.0561204,0.272954,-0.045683,0.812652,-0.274065,-0.429335,-0.0448595,-0.762339,-0.858312,-0.912974,-0.55853,-0.212915,-0.551853,0.0975882,-0.0797184,0.24964,-0.487085,0.0690848,0.689285,-0.629407,0.365101,0.0480828,-0.53258,0.0351579,-0.355795,0.581472,0.467254,-0.424417,0.890191,0.858396,0.603004,-1.07944,-0.587168,-0.45647,-0.40397,0.386406,0.369907,-0.476335,-0.0534077,0.627469,0.266335,-1.0664,0.187317,-0.654586,-0.299271,-0.769406,0.186489,-0.5845,-0.0444231,1.5114,-0.799815,-0.322985,0.304207,0.190048,-0.402067,-0.0958185,-0.30049,-0.0790957,-0.174724,-0.287918,0.422561,-0.300735,0.238072,0.534135,0.32558,-0.169809,0.352278,0.340083,0.301725,-0.301681,0.100006,0.425094,-0.432792,-0.711226,0.144497,-0.202564,-0.25203,-0.456889,0.159954,-0.0517752,0.305825,-0.281584,-0.153166,-0.634918,-0.0542914,-0.68151,-0.195654,0.416453,-0.16558,4.61371e-05,0.0226755,0.0618626,0.560264,-0.60963,0.115785,0.247084,0.329457,0.387319,0.423328,-0.1358,0.49684,0.3309,-0.260229,0.296257,0.0143553,0.183281,0.321825,-0.0201323,-0.508698,0.310879,-0.247574,-0.372648,0.176652,-0.193122,0.343922,-0.123459,0.049393,0.312497,0.0204645,0.244523,-0.533208,-0.0464928,-0.188179,-0.19184,0.131317,0.261314,0.475161,-0.430302,-0.349621,-0.323838,-0.0580821,-0.55038,0.0276591,-0.115643,-0.0937989,0.150032,-0.366513,0.0173829,-0.491086,-0.0238331,0.413766,-0.122804,0.463899,0.4209,-0.0886656,-0.170452,0.0563655,-0.213413,0.272878,-0.0643721,0.740572,-0.108259,0.39773,0.316377,-0.359378,-0.106705,0.0461807,0.433165,-0.00439622,0.11155,-0.052983,0.311075,0.0475621,0.213237,-0.0143278,-0.209366,0.179696,0.267072,-0.2794,-0.14473,0.151371,0.110281,-0.284181,-0.224704,-0.41288,-0.238275,-0.0702047,0.144605,-0.0785205,-0.237652,0.35995,-0.451772,-0.145651,-0.119405,0.00107994,-0.233319,-0.133551,-0.107504,-0.012061,0.00387556,-0.170537,-0.0804917,-0.276866,-0.416607,-0.344125,0.625434,0.227142,0.192584,-0.322675,-0.535278,-0.338943,-0.0397638,0.431443,0.691182,-0.19102,0.0191362,-0.299134,-1.14513,0.124442,-0.215016,-0.038712,-0.57104,-0.517613,0.0611906,-0.399202,-0.188535,0.0398333,0.216,-0.420123,-0.00182504,0.648077,-0.146525,-0.123548,0.421575,0.276824,0.00055223,0.0237901,-0.338067,0.332771,0.132646,0.186424,-0.102735,0.282778,-0.0932701,0.294471,-0.0856042,-0.429899,-0.479844,-0.083034,-0.0635279,0.346587,0.112464,-0.920486,0.829101,-0.000827886,-0.25442,0.108179,0.0918855,0.270614,0.365436,0.110665,0.0153716,0.0341351,-0.210932,-0.278425,0.296816,-0.494736,0.0531644,-0.286572,-0.0588557,-0.466159,-0.182608,0.41461,0.242511,0.046235,0.297977,0.0697058,0.0078429,0.185427,0.0673185,-0.195366,0.00618751,0.074084,-0.011294,-0.0707839,0.193739,-0.225205,0.105729,0.472944,0.0535502,0.0343707,0.102234,0.0210824,0.200421,0.3845,0.00626999,-0.167106,0.300629,0.174099,0.0961491,0.210565,0.310079,0.458874,-0.36133 +3441.5,0.457645,0.0912059,4,1.56741,0.988137,-1.23901,0.516995,0.12387,-0.145341,0.0406836,0.0656732,0.520204,0.696287,-0.178015,-0.397407,0.0881096,0.205643,0.644328,0.981197,0.138698,0.0168073,-0.319209,-0.255189,-0.453864,-1.12039,-0.385361,0.26254,-0.0877924,-0.338141,0.528041,-0.116557,-0.499319,0.0728511,0.677924,-0.970496,0.0769156,0.0218332,-0.417892,-0.152251,-0.376618,0.780906,0.765265,-0.522015,0.808241,0.532587,0.666425,-1.09107,-0.788354,-0.236358,-0.366092,0.625402,0.294739,-0.140543,-0.0823665,0.646706,0.00510772,-0.703685,0.0301186,-0.421705,0.0548376,-0.227485,-0.19353,-0.211676,-0.0502566,1.16452,-0.860565,-0.990861,0.0119067,0.0659089,-0.253845,0.0628798,0.188894,0.0254841,-0.201064,0.161846,0.59291,0.0519011,0.553119,0.524492,-0.0349211,-0.117406,-0.154002,0.209556,0.101772,-0.296853,0.0265062,0.0353905,-0.448482,-0.376477,-0.237787,0.608975,-0.617528,-0.352161,0.16035,-0.198623,0.207053,-0.171889,0.137888,0.269447,-0.342254,-0.0476404,0.214761,0.191655,-0.387181,0.222088,-0.385158,0.138355,0.147165,-0.400674,0.170698,0.0132823,0.407966,0.18546,-0.00546094,0.168581,0.213256,0.468166,-0.45762,-0.053008,-0.400989,0.353339,0.283384,-0.400073,-0.78819,-0.0489677,-0.0258417,-0.339093,-0.0923541,-0.0409217,0.368629,0.0311189,-0.10343,-0.258856,-0.0382899,0.043153,-0.218618,0.285854,-0.0803731,0.388739,-0.213385,0.301868,0.130957,-0.560688,-0.181484,-0.411053,-0.360049,-0.458504,-0.168744,0.201618,0.155927,0.11646,-0.282482,0.338878,-0.235509,0.204832,-0.185891,-0.39958,0.116235,0.581237,-0.238529,-0.0118392,0.454998,-0.472035,0.521279,-0.15227,0.81741,-0.217045,0.057523,0.330837,-0.266787,-0.150279,0.0499805,0.0775143,0.028055,-0.0176413,-0.0116999,0.0622677,-0.132799,-0.315679,-0.0804584,0.0132952,-0.0975759,0.420405,0.207338,-0.017611,0.542265,0.416952,-0.0804425,0.297181,-0.332802,-0.4205,0.1999,0.0288685,0.353816,-0.480081,0.318959,-0.497241,0.0121831,-0.576489,0.126333,-0.364068,0.229563,-0.247216,-0.0144495,-0.192448,-0.198251,-0.0283289,-0.228395,-0.151394,-0.194006,0.985626,0.137656,-0.134451,-0.0329537,-0.405413,0.00553513,0.247003,-0.265664,0.20898,0.0885077,0.473854,0.229063,-0.509747,0.393856,-0.29271,-0.085082,-0.328878,-0.266874,0.405034,-0.67669,-0.318495,-0.163554,-0.15563,-0.691312,-0.132484,0.0180699,-0.470728,-0.282058,0.664373,-0.203548,0.12983,0.119748,-0.174506,0.0878271,0.407248,0.067051,-0.271232,0.367478,0.36674,0.184059,0.126416,-0.190002,-0.14107,-0.142542,-0.0669392,0.603871,-0.422678,-0.891847,0.485979,0.124538,-0.15551,0.319135,-0.0505001,0.571063,0.494465,-0.149054,-0.573926,-0.263585,0.012714,-0.160786,0.0607032,-0.507128,0.136223,-0.191001,-0.521143,-0.274568,-0.147058,-0.442681,-0.120037,-0.010942,0.547351,0.263603,0.324712,-0.0710074,0.208268,-0.219424,-0.146904,0.0368437,0.403537,0.0910571,0.268005,-0.199895,-0.0455496,-0.17452,0.0431884,-0.220956,0.494963,-0.220621,0.0137725,0.103091,-0.6369,0.0195451,0.259966,0.0944191,0.0919601,0.325635,0.303249,0.570645,-0.393762 +3444.57,0.590504,0.0912059,4,1.58895,1.04518,-0.805268,0.372792,-0.0881824,-0.0103177,0.643804,0.250061,-0.1423,0.520821,0.14513,0.116976,0.334854,0.4088,0.0527276,0.794161,0.235476,-0.252566,0.56526,0.124393,-0.309043,-1.08682,-0.292002,0.141062,-0.0896381,0.0907728,0.182964,0.417734,-0.450431,0.158021,0.981506,-0.282298,0.771044,-0.0147969,-0.720987,0.135127,-0.578695,0.755454,0.377651,-0.424506,0.664851,0.712984,0.369518,-1.24337,-0.554965,0.390351,-0.470855,0.198795,0.179134,-0.202187,0.0441473,0.386205,-0.046709,-0.40435,0.146255,0.106498,-0.422868,-0.473038,-0.129206,-0.334024,0.279907,0.904957,-1.27687,-1.44581,0.0176097,0.418015,0.151386,-0.0711694,0.541806,-0.326576,-0.325518,-0.112606,0.466932,0.0396483,0.546294,0.00373436,0.154767,-0.446862,-0.342895,0.187939,0.273675,-0.0425019,0.0972352,0.194792,-0.399402,-0.140706,0.167118,-0.0694273,-0.287567,-0.322892,0.0958607,-0.587134,0.184304,-0.100158,-0.208719,0.158551,-0.751586,0.111717,0.18472,0.2456,0.685718,-0.0996314,-0.386756,-0.0935259,0.247163,-0.430612,0.329579,-0.175128,0.105023,0.50317,-0.752287,-0.10647,0.819985,0.168485,-0.0950679,-0.351744,-0.588245,0.374953,-0.288766,-0.406822,-0.427975,-0.0349366,-0.438753,-0.792039,0.126544,0.296502,0.190829,0.0767028,0.113174,-0.280877,0.0425152,0.0587123,0.445457,0.522289,-0.105948,0.39114,-0.242723,0.0402044,0.210031,-0.262147,-0.0391345,-0.263205,-0.409995,-0.785314,-0.839093,0.286113,0.315787,0.440813,0.118077,-0.152191,-0.667729,0.215866,0.147608,-0.0794042,-0.00785828,-0.408656,0.045448,-0.110765,0.369066,-0.225815,0.0662202,0.171841,0.83863,0.0652879,-0.0233611,0.736207,0.109918,0.239307,-0.0958749,0.470033,0.0276557,-0.123954,-0.0923895,-0.00351322,-0.168041,-0.181133,-0.108254,-0.241953,-0.193429,0.316494,0.231215,-0.0401322,0.386445,-0.0221039,-0.191353,-0.333622,-0.0447705,-0.0899407,0.285532,-0.26089,0.496348,-0.379877,0.155879,-0.350059,0.0617343,-0.0481898,-0.136976,-0.0634935,0.0982477,-0.0873356,-0.372523,-0.30604,-0.0163331,-0.354723,0.0109978,-0.221518,-0.220298,0.576761,0.264688,-0.294102,0.353731,-0.50826,-0.43211,-0.135257,-0.252248,0.12077,0.189629,0.290044,0.0985905,-0.353093,0.219995,-0.102934,0.14649,-0.364911,-0.581216,0.196429,-0.405944,-0.0833114,0.227716,0.112396,-0.371501,0.19228,-0.313844,-0.329115,-0.405317,0.598233,-0.240968,0.398092,-0.026162,-0.170708,0.103489,-0.186434,-0.355656,0.276055,0.202291,-0.0328628,0.233286,0.204786,-0.155338,-0.100298,0.0168919,0.124845,0.170181,-0.385769,-0.209832,0.0842473,-0.350765,0.117985,0.0602287,0.106762,0.617444,0.294423,-0.214965,-0.136829,0.0791782,0.275783,-0.297732,-0.117196,-0.356447,0.242085,-0.403431,-0.468037,-0.32347,-0.256844,-0.448247,-0.020068,0.00575414,0.199259,0.243637,0.142581,0.187691,-0.0552534,0.312022,0.337434,0.00287991,0.293088,-0.227097,-0.166496,-0.210138,-0.0332978,-0.0278614,0.241843,0.278113,0.171044,-0.0369213,-0.133889,0.601786,-0.325655,-0.0131976,-0.272854,0.0827401,0.0980074,0.215349,0.313061,0.464057,0.105995 +3431.67,0.951239,0.0912059,4,1.63865,0.949041,-0.864676,0.425218,-0.0645401,-0.178232,0.546763,0.328795,-0.165414,0.627053,-0.130559,0.0749982,0.493499,0.43369,-0.0292931,0.615971,0.429628,-0.107306,0.0866589,0.0762741,-0.221982,-1.06105,-0.668498,0.620321,-0.414784,0.237952,0.272301,0.378108,-0.0822127,0.149933,0.942283,-0.221474,0.772423,-0.0978816,-0.777314,0.0831173,-0.677795,0.862543,0.256656,-0.587894,0.773977,0.481948,0.575849,-0.960955,-0.417255,0.196501,-0.151913,0.262673,0.318428,-0.375606,0.197191,0.25886,-0.0768454,-0.531266,0.167426,-0.0570076,-0.337759,-0.448949,-0.338873,-0.260165,0.434747,1.10057,-1.15815,-1.11095,0.355533,0.595756,0.443899,0.295063,0.673416,-0.32742,-0.0993551,-0.246029,0.739118,-0.183322,0.485072,0.0437733,-0.105204,-0.672854,-0.178196,0.158045,0.406963,0.0539026,-0.00687864,0.0235739,-0.280521,0.0993424,-0.0096197,-0.186685,-0.18812,-0.427149,0.465547,-0.317146,0.152781,-0.34868,-0.27365,-0.220723,-0.831237,0.172393,-0.234026,0.238172,0.519769,-0.117823,-0.354967,-0.101396,0.0759939,-0.609372,0.507149,-0.110477,-0.00738057,0.574583,-0.610451,-0.089548,0.584306,0.148348,-0.290774,-0.498327,-0.680557,0.186954,-0.0194366,-0.293798,-0.395312,0.0765252,-0.359468,-0.917343,-0.403704,0.293713,0.222483,-0.0767619,-0.177044,-0.248043,0.0641196,0.0897884,0.369567,0.606154,-0.162464,0.612366,-0.121917,-0.0385532,0.0322044,-0.175589,0.112048,-0.17435,-0.253227,-0.435719,-0.675815,-0.0580574,-0.0775804,0.317089,0.154705,-0.468299,-0.317924,0.318042,0.0451544,-0.067747,0.308123,-0.19038,0.355735,-0.406863,0.355154,-0.194149,0.440535,0.0247238,0.795496,-0.00182815,-0.0642311,0.355681,-0.0135246,0.174636,-0.137341,0.466652,-0.100419,-0.358642,-0.0567837,0.100362,-0.117636,-0.198745,-0.153865,-0.581112,-0.161183,0.293929,0.407134,0.235358,0.318784,-0.29144,-0.0653769,-0.413298,-0.216433,0.0949893,-0.0126892,-0.0995005,0.353314,-0.365671,0.593676,-0.387878,-0.00635664,0.0911771,-0.0104618,-0.162404,0.00831888,0.0425477,-0.359586,-0.238439,0.0903362,-0.320361,0.217693,-0.028603,0.0860739,0.591323,0.359369,-0.292728,0.261408,-0.49259,-0.264328,-0.0704625,-0.113542,-0.0743164,0.329578,0.161499,-0.00021464,-0.522575,0.180857,-0.260568,-0.185761,-0.228091,-0.744853,0.365441,-0.65075,0.091767,0.319925,-0.00652686,-0.177266,0.054705,-0.255693,-0.437718,-0.515305,0.743651,-0.261724,0.486514,0.0779433,-0.337983,0.204004,-0.0989085,-0.366084,0.211256,0.141056,-0.157829,0.209552,0.607874,-0.246757,-0.375267,0.0393274,-0.173697,0.136025,-0.351664,-0.193145,0.0472177,-0.0760846,-0.0827971,0.181793,0.00132621,0.451872,0.405171,0.025104,-0.175785,-0.162903,0.0707977,-0.237013,0.0614444,-0.605491,0.328771,-0.201141,-0.254932,-0.506716,-0.114732,-0.128438,0.157003,-0.161114,-0.0868588,0.0800384,0.0501564,0.0738934,-0.00520285,0.237687,0.739437,0.150548,0.457395,-0.0249951,-0.431346,-0.066076,-0.0885882,0.0220117,-0.092079,0.317627,0.201218,0.222093,-0.0926163,0.287768,-0.457063,-0.168153,-0.338784,0.453057,0.103408,0.240658,0.32157,0.490569,0.270663 +3439.53,0.994136,0.0912059,4,1.52345,1.02157,-0.728942,0.300826,-0.0664614,-0.123528,0.0382876,0.154622,0.0798517,0.283528,-0.141175,0.34826,0.641938,0.440171,0.0844508,0.721241,0.411008,0.032524,0.308521,0.0479363,-0.277836,-0.988014,-0.707045,0.265024,-0.154889,0.168416,-0.112654,0.430706,-0.0571416,-0.044605,0.911187,-0.443289,0.294377,0.142488,-0.659447,0.270592,-0.465153,0.569597,0.0363251,-0.584796,1.00178,0.778529,0.690364,-1.02328,-0.57219,0.407996,-0.633002,-0.186122,0.459435,-0.0524516,0.177917,0.470967,0.0730367,-0.416898,0.322546,-0.0793753,-0.529835,-0.388734,0.0951191,-0.293362,-0.147385,0.876934,-0.461455,-0.521453,0.263049,0.163619,0.750089,0.223248,-0.152255,-0.475319,-0.503815,0.323622,0.807161,-0.208092,0.847025,0.217634,-0.00848632,-0.469361,-0.126506,-0.0302147,0.0692258,-0.140383,-0.236071,-0.097219,-0.121635,-0.438115,-0.285813,-0.130075,0.462779,-0.397676,0.569893,-0.378285,-0.158118,0.00652948,-0.238201,-0.404202,-0.439432,-0.174746,-0.0140744,0.211789,0.21153,0.0923901,-0.405563,-0.464702,-0.0935225,-0.218456,0.575971,-0.302092,0.00669358,0.211536,-0.668019,-0.320768,0.363418,0.41928,0.319548,-0.500251,-0.756756,0.376079,0.813113,0.0661721,-0.666121,-0.229074,-0.218959,-0.150193,-0.00287577,0.130161,0.109393,-0.211427,0.258875,-0.312288,-0.034156,0.101017,0.417798,0.575294,-0.128154,0.131959,-0.29168,-0.139838,0.322415,-0.295565,0.106594,-0.186027,0.0843399,-0.437628,0.00370527,0.094089,0.0652339,-0.0501385,-0.200518,-0.474268,-0.801235,0.189608,0.437873,-0.445311,-0.279638,0.153214,0.0997756,0.0786774,0.0768065,-0.247979,-0.114704,-0.181153,0.576694,-0.0684329,-0.278247,-0.372046,-0.06922,0.391105,-0.0322478,0.641092,-0.066678,-0.395129,-0.323434,-0.14172,0.331547,0.0492506,0.255451,-0.684972,0.164109,0.534746,0.432813,-0.110839,-0.0267944,-0.103244,-0.619038,-0.608487,0.187457,-0.115589,0.0411065,-0.538703,0.0109627,-0.151605,-0.279402,-0.434328,0.200184,0.448776,0.13123,0.0859625,-0.453173,0.257776,-0.549164,0.105137,-0.0339278,-0.280562,0.194064,0.160018,-0.204662,0.820491,-0.181073,-0.316371,-0.0580471,-0.0846929,0.00363717,0.123542,-0.097436,0.101183,0.0665308,-0.0274827,0.185604,-0.31055,0.262964,-0.207935,-0.202257,0.412614,-0.194856,0.141017,-0.492634,0.0807821,0.310953,0.248238,0.070207,0.00718989,0.133277,0.0208497,-0.317383,0.46813,-0.0581237,0.0807139,0.164948,-0.106144,-0.457597,-0.305108,-0.971747,0.353741,0.337915,-0.140377,0.104792,0.0724341,-0.0888619,-0.102596,-0.255438,0.15811,0.359393,-0.0154059,-0.436557,-0.0786729,-0.113921,-0.660903,0.443417,-0.0682027,-0.0459461,-0.134073,0.243392,-0.266787,0.300305,0.292633,-0.0670867,-0.380252,-0.431885,-0.220412,0.0285237,-0.381496,0.0583363,-0.0866775,0.550573,-0.236183,0.343662,-0.326914,0.28631,0.279385,-0.0558231,0.26182,-0.572909,0.183148,0.0587751,0.073732,-0.462025,-0.216099,0.151623,-0.16685,0.0598236,-0.0698216,0.617088,-0.35016,0.132194,-0.355556,0.379854,-0.338167,-0.394975,-0.279645,-0.323387,0.0985324,0.267044,0.313899,0.516763,0.0665809 +3447.69,0.986623,0.0912059,4,1.48975,1.00267,-1.10842,0.372945,0.481136,-0.0749102,0.211988,0.019905,0.390196,0.0701018,-0.12674,-0.275458,-0.60959,0.382579,-0.175091,1.0969,-0.0856898,0.21536,-0.156673,-0.254443,-0.0890088,-0.749486,-0.549303,-0.155225,-0.086818,-0.554332,-0.176425,0.296338,-0.491734,0.0388276,0.578713,-0.18436,-0.486767,-0.0292528,-0.275234,-0.437509,-0.00246287,0.448107,0.37298,-0.0586544,0.695407,0.626852,-0.260569,-0.455024,0.189245,-0.183389,-0.127572,0.85019,0.248408,0.0191413,0.0647489,0.232798,-0.0694605,-0.21983,0.536783,-0.0503674,-0.071917,-0.946423,0.84172,-0.237459,0.749352,0.932275,-0.850154,-0.860307,-0.0205274,0.0205065,-0.758774,-0.115405,0.251455,-0.101696,0.188198,0.0109663,0.284618,0.10939,-0.111831,0.659368,0.258876,0.364857,-0.226383,0.0464465,0.411364,-0.140771,0.304586,0.033217,-0.0827222,0.446634,0.281767,0.0337167,-0.458444,-0.249038,-0.49864,0.3969,0.101019,0.243319,0.281949,0.0470059,0.508192,-0.133899,0.0868488,0.48574,-0.197177,-0.134557,-0.123824,0.0716174,0.268729,-0.145268,-0.358743,-0.117388,0.361553,0.445047,0.632325,0.0890373,-0.207139,0.2279,-0.190507,0.801437,0.311338,-0.234376,-0.733713,-0.0782389,-0.250497,0.28391,0.0554733,0.0106785,-0.152335,0.0770771,0.132029,0.307511,-0.00845385,-0.25905,0.12951,-0.118001,-0.433178,0.0665102,0.0091977,-0.423877,0.190669,-0.0174284,0.270976,-0.377794,-0.385341,-0.170511,0.0454798,-0.179461,0.180798,0.0551855,0.0641814,0.407009,0.096956,0.30367,0.542355,-0.245127,0.0896056,0.358485,0.420608,0.388229,-0.0323995,-0.183174,0.255958,0.142961,0.314724,0.095987,0.393538,0.0705986,0.0832706,0.39272,-0.101203,-0.527724,-0.273855,-0.590793,0.221,0.399468,0.0709833,0.114577,-0.134036,-0.1878,-0.69858,0.466074,0.0345164,0.422643,-0.2412,0.000183826,0.308374,-0.0528084,0.528994,0.324838,-0.487363,-0.317757,0.0487134,0.129759,-0.0588584,0.158461,0.216144,-0.179393,-0.289677,-0.315714,-0.0155694,-0.5088,-0.214718,-0.055638,0.245011,-0.373856,0.145549,0.299035,-0.213246,-0.110524,-0.401718,0.900407,0.189907,0.409371,0.0154303,0.127985,0.0675919,-0.090488,-0.0446507,0.168914,-0.377819,0.474152,0.0303082,-0.113723,-0.333808,-0.34694,0.179987,-0.16329,-0.234662,0.403183,0.062965,-0.426411,-0.151722,-0.250963,-0.193354,-0.192504,-0.286579,0.00594705,-0.0846801,0.156594,0.0354539,-0.0518534,0.515211,-0.128609,0.309931,0.480925,0.715918,-0.314946,0.105882,0.207055,0.382382,-0.00283321,-0.0196717,-0.308499,0.216472,-0.817425,0.326385,-0.504274,0.170715,0.456136,-0.263319,0.506678,-0.260198,-0.0126138,0.227648,0.451104,-0.0423292,0.347475,0.0858291,-0.185374,0.0987497,0.234076,0.352163,0.242768,0.0434946,0.080377,-0.36853,0.239837,-0.545809,0.226341,0.0136882,0.265939,-0.0594712,-0.233259,-0.18166,-0.381799,0.25631,-0.108988,-0.0143363,0.197104,0.168517,0.536439,-0.156779,0.0418568,0.131442,0.246789,-0.289012,0.515549,-0.277769,-0.143822,-0.340894,0.162764,0.306329,0.159754,0.372678,0.0984665,0.189009,0.313794,0.434751,-1.63278 +3455.8,0.728857,0.0912059,4,1.51489,0.968448,-1.15453,0.338325,0.306344,-0.0100075,0.0693511,-0.00532729,0.323747,0.120373,-0.242491,-0.392512,-0.57295,0.416927,-0.373588,1.18751,-0.133436,0.223566,-0.118451,-0.0942412,-0.293893,-0.905187,-0.858069,-0.163295,-0.114568,-0.600832,0.0869488,0.396994,-0.521497,0.00316756,0.571605,-0.0996199,-0.541609,0.0767448,-0.232947,-0.574467,-0.375265,0.572985,0.655521,-0.0216103,0.902275,0.696662,-0.450009,-0.505539,-0.0329385,0.19117,-0.342054,1.00616,0.290577,-0.0391803,-0.1034,-0.0586651,0.0179005,0.0123154,0.558043,-0.0540416,-0.170245,-0.955489,0.631643,-0.46596,0.816441,0.879373,-0.919281,-1.09106,0.0288,0.0368706,-0.474257,-0.257255,0.341005,0.0363306,0.211429,-0.177205,0.41521,0.0855392,0.0457867,0.562545,0.227897,0.324894,-0.206718,0.101103,0.310679,-0.240299,0.378738,0.256811,0.0329304,0.454037,0.478387,0.0772942,-0.402525,0.00284891,-0.482764,0.308576,0.00149965,0.287988,0.0605928,-0.026114,0.394167,-0.0242224,0.370991,0.403023,-0.192573,-0.255059,-0.256503,-0.00951901,0.464924,-0.296582,-0.290795,-0.156205,0.352325,0.701038,0.593166,0.00881814,0.301739,0.290943,-0.497121,0.795136,0.123069,0.0100184,-0.448018,-0.283288,-0.430324,0.37613,-0.109277,0.134792,-0.0707486,0.180896,0.265952,0.321622,-0.0543251,-0.0220239,0.221516,-0.187914,-0.511458,0.147259,0.0814592,0.130313,0.215726,0.0114069,0.482165,-0.204693,-0.227279,-0.253966,0.0260716,0.0837274,0.0651126,-0.0315911,0.0259585,0.502443,0.178801,0.130735,0.369094,-0.296644,0.167623,0.408025,0.38945,0.372166,-0.0486109,-0.108694,0.420697,0.18798,0.554551,-0.160453,0.338468,0.0611633,0.0878794,0.158652,0.140867,-0.437334,-0.264239,-0.210199,0.263888,0.166503,0.109584,0.00462386,-0.34874,-0.217407,-0.691493,0.564629,0.256423,0.46706,-0.0142149,0.0340697,0.138057,0.064545,0.309257,0.0904377,-0.670345,-0.375289,0.138471,0.178161,-0.115384,0.0600403,0.179507,-0.108333,-0.157235,-0.217228,-0.042093,-0.446964,0.0293309,0.0923083,0.314142,-0.485097,0.0924513,0.277892,-0.164902,0.0442579,-0.417088,0.943641,0.227134,0.194616,-0.0760495,0.123513,0.254229,-0.203791,-0.365286,0.321177,-0.413532,0.365791,-0.0154421,-0.0563999,-0.312596,-0.110337,0.200605,0.0349304,-0.110003,0.412504,0.274952,-0.300995,-0.0354979,0.0245,-0.165043,-0.110806,-0.304681,-0.0815471,-0.0798159,0.161608,-0.105243,0.0250446,0.522251,-0.300374,0.145205,0.302818,0.265615,-0.317826,0.0246805,0.320701,0.393024,0.0124036,-0.00542154,-0.434174,0.185229,-0.908997,0.325556,-0.3132,0.295614,0.235637,-0.235746,0.298147,0.118073,0.2245,0.309859,0.265218,0.0884218,0.268471,-0.0870163,0.0938561,0.0100295,0.0083977,0.548766,0.24884,-0.0531672,0.0836149,-0.29633,0.442381,-0.365375,0.0992632,-0.0576521,0.127494,0.0194978,-0.381443,-0.132362,-0.34741,0.0795528,-0.150597,-0.0165324,0.337669,0.125572,0.29698,-0.0194311,-0.117912,0.165393,0.28669,-0.347566,0.442027,-0.342598,0.083431,-0.204604,0.192298,0.0431354,-0.0618537,0.468693,0.0844359,0.247229,0.290579,0.497222,-0.926025 +3452.83,0.906008,0.0912059,4,1.59805,0.901648,-1.27881,0.403762,0.39353,-0.162812,0.082375,-0.280991,0.436468,0.0929332,0.021803,-0.220085,0.265678,0.578337,-0.0550062,0.82527,-0.102373,-0.20688,-0.1607,-0.07836,-0.315978,-0.942366,-0.841601,0.131205,-0.105634,-0.482219,-0.552974,0.0527581,-0.227756,0.0566926,0.559539,-0.488888,0.363967,0.328753,-0.360486,-0.215969,-0.265871,-0.303713,0.541629,0.0635442,0.777022,0.741008,0.0784741,-0.385064,0.10195,0.566365,-0.113854,0.376687,0.537827,0.120705,0.303189,0.518901,0.141056,-0.445871,0.448678,-0.130174,0.000603271,-0.617289,0.438305,-0.491638,0.192788,0.744968,-0.798889,0.104315,0.224523,0.22699,-0.282676,0.322427,-0.212524,-0.224657,0.244724,0.494113,-0.00226431,0.0606522,0.559576,0.570616,0.0676961,0.36182,0.115847,0.0287589,0.416958,-0.0354397,0.0578057,-0.18331,0.130674,-0.0910031,-0.16059,-0.00779847,-0.129312,-0.553152,-0.0814674,0.517246,-0.138246,-0.169369,0.11981,-0.291915,0.626469,-0.158425,-0.126909,0.621191,0.185304,0.99222,-0.402068,-0.0807658,0.0614659,-0.0697201,0.00443011,-0.257144,0.0850275,0.0621109,-0.128855,0.0994817,0.0724171,0.588171,0.413316,-0.541098,0.219256,-0.176888,0.447611,-0.14685,-0.122818,0.283406,-0.432759,-0.0237355,-0.283163,0.0786524,-0.233396,0.212517,0.325911,-0.458767,0.323833,-0.262589,0.053164,0.36709,-0.272116,-0.0290294,-0.194915,-0.134926,0.338304,-0.274589,-0.533603,-0.0163008,0.20882,-0.200803,-0.00953256,0.545057,0.142606,0.203375,-0.0468806,-0.417498,-0.160891,0.345631,-0.0202732,-0.0846917,-0.0059981,0.307145,0.255926,0.136591,0.277005,-0.0684354,0.208557,-0.279052,0.669359,0.111099,0.210913,-0.302074,-0.180987,-0.112488,-0.104084,0.0940601,0.104516,-0.14769,-0.00710602,0.218323,0.166348,0.287598,-0.159782,-0.278275,-0.149102,0.61823,0.453516,-0.147346,-0.0462086,-0.376615,-0.218496,-0.212818,0.104084,0.215791,-0.117095,-0.130091,-0.533263,0.304926,-0.402118,-0.399209,-0.147609,0.301573,-0.405051,-0.260934,-0.108695,0.00399535,-0.375119,-0.197951,-0.262001,0.026088,0.491404,-0.376905,-0.151884,0.958357,-0.0276267,-0.266121,0.153767,-0.309951,0.473286,-0.403972,0.0249823,0.419956,0.365817,0.0371423,0.283492,-0.36851,0.0275986,-0.525621,0.191569,0.307099,-0.469955,0.166781,-0.291538,0.0563284,0.396326,0.0786168,-0.289734,0.325244,-0.153217,0.0633239,-0.271049,0.4914,0.46374,0.0409154,0.764009,-0.562759,-0.388751,-0.062609,-0.0012441,0.690568,0.268687,-0.260053,0.284377,0.318685,0.208707,-0.412917,0.182185,-0.305977,0.567931,-0.106755,-0.303143,0.0657358,-0.0708035,-0.291654,-0.533381,-0.131417,-0.175712,0.510819,-0.145945,0.546858,0.29816,-0.128147,-0.0150159,0.269641,-0.37831,-0.030804,-0.0232443,-0.189284,0.1967,0.474042,0.268591,-0.528082,-0.032723,0.156638,-0.156178,-0.172804,-0.327568,-0.300053,-0.467678,0.0981901,-0.094156,-0.029422,0.0327402,0.1341,0.326676,-0.119805,0.016756,-0.407295,0.215049,-0.329135,-0.0536752,0.224125,0.0930466,0.363214,-0.0833825,0.239308,-0.502788,0.0839011,0.187418,0.289657,0.432918,-0.972758 +3447.46,0.838977,0.0912059,4,1.60755,1.05484,-0.704441,0.0445987,0.217874,-0.0308483,0.0749301,-0.0869411,0.337156,0.491098,-0.540623,-0.304972,-0.89462,0.307658,-0.40027,0.770663,0.151553,0.0323721,0.0714558,-0.134722,-0.181998,-0.647842,-1.01201,-0.169713,0.219364,0.0545381,-0.178894,0.355177,-0.595505,-0.265464,0.551743,0.0689578,-0.329349,-0.125939,-0.287714,-0.353641,-0.255734,0.560098,0.172106,-0.228246,1.0183,0.246418,0.36036,-0.472147,0.0535018,0.0812547,-0.507458,-0.21724,0.475578,0.518839,0.139706,0.294331,0.126796,-0.324828,0.741915,-0.41486,-0.507995,-0.562363,0.552059,-0.312344,0.454936,0.937981,-0.705985,-0.917721,0.170991,-0.190305,0.6963,0.0250484,-0.326633,-0.120382,-0.2396,0.350342,0.547394,-0.250253,0.193328,-0.0983553,0.301941,-0.535777,-0.375646,-0.0150615,0.0634252,0.284374,0.0729857,-0.572651,0.0270615,0.00723496,0.48662,0.170593,0.0191395,0.135998,0.37349,0.339685,-0.01523,0.474925,0.194652,-0.16983,-0.100429,0.0414435,0.15575,0.275072,0.281591,-0.317012,-0.352434,-0.496362,-0.331907,-0.107491,0.27445,0.224636,-0.295479,0.271545,-0.189915,0.0480704,-0.0898751,0.446444,0.333454,0.0777046,-0.441037,0.0330011,-0.0374654,0.234284,-0.207397,0.390258,-0.125986,0.0414442,0.061556,0.237195,-0.0519939,-0.475726,0.235065,-0.187187,0.438992,-0.390651,-0.672308,0.572849,-0.0452286,-0.485892,-0.648948,-0.225757,0.170313,-0.211746,0.274234,-0.384617,-0.436938,-0.604442,-0.0168316,-0.164285,0.194862,0.821695,-0.329598,-0.0120422,-0.351707,-0.186357,0.65493,-0.0818044,-0.0555648,0.315178,0.129451,-0.219507,0.11,0.068291,-0.375019,0.343088,0.457482,0.379614,-0.274413,0.143203,-0.29625,-0.608971,-0.092383,-0.201476,0.0431905,0.226491,0.156962,-0.22609,-0.0720719,-0.526146,-0.446465,-0.202738,0.223722,0.674268,0.118277,-0.438432,0.303915,-0.255313,0.59471,-0.206685,-0.282546,-0.0398404,0.119709,0.0236258,-0.215561,0.233561,-0.175659,-0.540049,0.118681,-0.0240582,0.317271,-0.420299,-0.721364,0.351497,0.0192953,-0.269113,0.200724,-0.0666167,0.0766777,-0.119338,-0.144028,0.667946,-0.133121,0.158348,0.0714127,0.18386,0.200361,0.154607,-0.064064,0.483243,-0.45065,0.232092,0.292454,-0.0574332,-0.328866,-0.121028,-0.172745,-0.687182,0.0547729,0.449016,-0.550873,-0.255622,0.0248929,-0.00658125,0.0187886,0.0899035,0.481979,0.176498,-0.121876,0.405093,-0.0624716,-0.23461,0.417496,0.122185,-0.279787,0.00277274,-0.151991,-0.194952,-0.0675322,0.29733,0.274667,-0.216929,-0.519248,-0.298494,-0.427164,0.00507107,0.176459,-0.0430701,-0.0890575,0.105441,-0.728407,0.172531,0.355284,0.1984,-0.428864,-0.132148,-0.358563,-0.184024,-0.106786,0.147535,-0.11994,-0.241271,-0.0339292,-0.0513522,0.0333943,0.0123103,-0.332779,-0.48688,-0.271383,0.274113,0.105142,-0.243248,0.171463,0.0859512,-0.00705466,-0.187855,-0.255892,0.0378305,-0.0478706,-0.0694494,-0.0980978,0.176917,0.00557044,-0.36168,0.32387,0.57066,0.363848,0.118613,-0.22264,-0.210222,-0.128065,-0.177756,0.329224,-0.337199,0.635452,0.0865534,0.208689,0.2942,0.456825,-0.645113 +3459.87,0.973254,0.0912059,4,1.46221,1.02056,-1.03792,0.370708,0.569589,-0.103641,0.168581,-0.248772,0.484061,-0.0782922,0.0564961,-0.123497,-0.0588124,0.675388,-0.171279,0.911206,0.0313992,-0.0358793,0.135468,-0.542098,-0.157382,-1.19116,-0.757538,0.0619927,-0.369481,-0.0453712,0.111894,0.105391,0.14893,-0.0908864,0.82456,-0.617135,0.245105,0.185802,-0.513439,0.292586,-0.213612,0.520915,0.314066,-0.223977,1.22158,0.841346,0.666415,-0.585932,-0.311535,-0.0756598,-0.389063,0.236977,0.608683,-0.216788,0.089683,0.735963,0.308483,-0.621006,0.308665,0.106207,0.184729,-0.583732,0.824883,-0.288201,-0.074353,1.0593,-0.651915,-1.13916,-0.0309867,0.310316,-0.242365,-0.0574971,0.320313,-0.51462,-0.0863134,0.597103,0.0453392,0.222713,0.652429,0.705564,-0.0017749,0.265821,0.0774923,-0.109576,0.3584,-0.508036,0.143978,-0.0646628,-0.276622,0.0341467,-0.206599,-0.809514,0.34609,-0.876817,-0.325096,-0.125303,-0.0622027,0.0152228,-0.338873,-0.152533,0.0739903,-0.353136,0.107812,0.0471845,-0.0594956,-0.200121,0.0914587,0.251723,0.551681,-0.273804,0.334101,-0.48843,0.597341,0.548224,0.198691,-0.306806,0.0203605,0.380159,-0.0439355,0.297503,0.00294927,-0.279357,0.385621,-0.0932879,-0.533307,-0.292966,0.0643423,-0.280571,-0.123107,-0.0663409,0.368239,0.386856,0.18117,-0.236164,-0.367262,-0.0961101,0.61705,0.165345,-0.27656,0.29609,0.271957,0.210987,0.135905,-0.451025,-0.30494,0.278987,0.293259,-0.131113,0.249988,0.274184,-0.450775,-0.005271,-0.0389522,-0.200562,0.0647954,0.208003,0.300435,0.0489247,0.462105,0.199282,0.497204,0.271572,-0.0355437,-0.379069,0.342552,-0.238145,0.677381,-0.216727,0.478357,0.321658,0.138276,0.406261,0.0888022,-0.0637789,0.191326,0.307605,-0.113917,0.0189156,0.0424179,0.331644,-0.133662,0.0587756,-0.248293,0.344417,0.170818,0.390714,0.0390269,0.192087,-0.35488,-0.232798,-0.0695599,-0.0659141,0.123908,0.0798976,-0.182001,-0.162463,0.122704,-0.331285,-0.426884,0.0266889,-0.171413,-0.352904,-0.3839,-0.103469,-0.141141,-0.232759,-0.267202,0.157098,0.019428,-0.0823488,-0.229115,0.857049,-0.0167523,0.273881,-0.0648385,0.101288,0.0925497,0.00729404,-0.260509,0.239248,0.126134,0.0429484,0.0394181,-0.34955,0.185737,-0.118274,-0.251225,0.754321,-0.302635,0.335585,-0.0358985,-0.126256,-0.0854056,0.00166598,0.0283798,-0.0227731,-0.664139,-0.276632,-0.263692,-0.0128552,0.111852,0.289693,0.217043,-0.386749,-0.066237,-0.0320215,-0.234318,0.162375,0.236404,0.110054,0.567811,0.321038,0.183818,-0.398052,0.431681,-0.611069,0.123367,-0.581949,-0.343864,0.581744,-0.0682729,-0.14627,-0.332811,-0.0851601,0.53332,0.37885,0.281336,0.347657,0.462964,0.135398,-0.0306408,-0.276535,0.0649886,-0.0232437,0.261189,-0.262854,-0.202547,0.536821,0.510662,-0.163771,0.102918,0.305517,-0.0432838,-0.121455,0.192488,-0.0547246,-0.124957,0.0371683,0.322573,0.282382,-0.162209,0.0374222,0.210808,0.348276,0.0380574,-0.408179,-0.0997158,0.216386,-0.354176,-0.261434,-0.00556341,0.270307,-0.372925,0.0475567,-0.540698,0.0793273,0.296986,0.281651,0.544964,-2.01333 +3447.27,0.820527,0.0912059,4,1.54109,0.840278,-1.09485,0.275474,0.320974,-0.102653,-0.447929,-0.360194,0.24467,0.269592,0.00711216,-0.097279,-0.319809,0.520115,-0.676001,0.46936,0.196141,-0.405269,-0.364538,-0.246119,-0.260421,-1.2701,-0.731844,-0.110117,-0.247987,-0.457384,-0.113046,0.627956,-0.547804,0.101928,0.88762,-0.457959,-0.298963,0.0879897,-0.0391134,-0.399738,-0.230365,0.850895,0.290977,-0.402719,1.01802,0.674264,0.175029,-0.191743,-0.0313947,0.284926,-0.713229,0.164742,0.574758,0.244897,0.286261,0.40547,0.455601,-0.431245,0.9994,-0.0545382,-0.320399,-0.625185,0.535311,-0.0218708,0.451525,0.801816,-0.494496,-0.69067,0.384881,-0.083136,0.158163,-0.0898653,-0.140062,-0.0403013,-0.133682,-0.108606,0.489102,0.0309908,0.244703,-0.029164,0.509715,-0.305722,-0.194871,0.0115204,0.654317,0.0966362,0.333443,0.0445617,0.354719,-0.126734,0.109912,0.490617,-0.272355,-0.131346,0.393316,0.279423,-0.0212102,0.216075,0.46776,-0.269783,-0.202456,0.223297,0.223874,0.338515,0.0532704,0.0524106,-0.579079,-0.574565,-0.429086,-0.0235402,-0.00247037,0.112924,-0.184174,0.519884,-0.372891,-0.27396,0.329894,0.404703,-0.0864505,-0.116937,-0.487575,0.0658795,-0.153654,-0.0390392,-0.585799,0.10732,-0.234871,-0.0930436,0.168856,0.40747,-0.230996,-0.209763,0.269001,-0.372136,0.594154,-0.405784,-0.451678,0.709883,-0.0887964,-0.409087,-0.354534,-0.165787,0.307202,-0.00605009,-0.108129,-0.318788,-0.0237884,-0.460709,-0.227063,-0.245969,0.1116,0.454961,-0.542795,-0.00919996,-0.307874,-0.175566,0.273738,-0.100464,-0.108507,0.181074,0.00441885,-0.0589256,0.0338327,0.326363,0.00340193,0.251703,0.522841,0.346589,-0.448467,-0.10049,-0.301783,-0.481593,-0.213105,-0.0388873,-0.394945,-0.386184,-0.0107122,-0.204953,0.0529238,-0.54387,-0.707088,-0.303467,0.60806,0.581731,-0.26584,-0.790877,0.0964714,-0.216115,0.246188,-0.211846,-0.210256,-0.252441,0.140874,-0.55704,-0.241513,0.57291,-0.140729,-0.499996,0.573995,0.115766,0.546419,-0.222862,-0.0759968,0.263276,0.0945443,-0.148526,0.702359,-0.252248,-0.1603,-0.206333,-0.417909,0.662396,-0.0738627,-0.0226966,0.0172151,-0.0627656,0.0735996,0.164044,-0.198866,0.593737,-0.457172,0.0886928,0.188464,-0.0527313,-0.20697,-0.447338,0.245785,-0.401996,-0.154247,0.328897,-0.398132,-0.0898985,0.0917847,-0.359532,0.259962,-0.15022,0.424672,0.158378,-0.230859,0.352102,-0.141783,-0.200586,0.482817,0.0161545,-0.065705,0.000653135,0.292065,-0.203013,0.0452233,0.169083,0.250712,-0.0785185,-0.364759,-0.48162,-0.0251882,-0.0216192,0.496156,0.350043,0.0798251,0.142361,-0.464202,0.526075,0.434448,0.349959,-0.21701,0.199756,-0.221757,-0.271425,-0.376443,0.028308,-0.446043,0.130306,-0.241097,0.0104075,-0.187787,0.0130098,-0.166556,-0.536697,-0.270128,0.281692,0.0358995,-0.326605,0.321163,0.209472,-0.257016,-0.33876,-0.0926669,0.0216763,-0.237425,0.106746,0.173588,0.100182,-0.48004,-0.690463,0.0793259,0.503385,0.286694,0.00991144,-0.148612,-0.313831,0.210294,-0.463571,0.149485,-0.29153,0.420493,0.0996,0.257847,0.315595,0.507786,-0.670381 +3447.78,0.738683,0.0912059,4,1.55943,0.815095,-0.944952,0.262083,0.376964,-0.0360517,-0.249066,0.287391,0.60955,-0.0870927,0.105689,-0.15679,-0.0426453,0.840223,0.206925,0.734604,-0.0586167,-0.0127342,-0.0321904,-0.270686,0.116296,-0.789691,-1.08265,0.134424,-0.149297,-0.152618,0.0207435,0.190874,-0.333869,0.329648,0.804958,-1.01385,0.12572,0.170327,-0.336016,0.0941771,0.060566,0.772077,0.238129,-0.189066,1.01919,0.234675,0.285262,-0.65431,0.228845,-0.213625,-0.259394,0.17584,0.462448,0.361315,0.0174512,-0.408209,0.730047,-0.858132,0.838239,-0.336772,0.245795,-0.530594,0.412044,-0.556597,-0.00788147,0.789776,-0.569076,-0.883184,-0.0158397,0.137521,-0.0425664,-0.0642579,0.15605,-0.347896,0.465836,-0.43526,0.122408,-0.468812,0.413988,0.591315,0.311564,-0.278636,-0.065774,-0.317627,0.540109,0.0272864,0.46074,0.141214,0.0691557,-0.0215882,0.0841486,0.295403,0.281962,-0.549727,0.507611,0.019832,0.320359,0.243795,0.209117,-0.14717,0.0169466,-0.483903,0.46956,0.112163,-0.0825362,-0.157836,-0.127049,-0.113556,0.307583,-0.324931,-0.144916,-0.167007,-0.00774236,0.33722,-0.318673,-0.376641,0.00905061,0.509149,-0.22167,-0.216227,-0.262795,0.407016,-0.129385,-0.0074058,-0.0541489,-0.0456212,0.336852,-0.458862,0.113262,0.53718,0.111614,-0.146802,0.00303566,0.0170874,-0.0183455,-0.446684,0.572366,0.602405,-0.262068,0.0560325,0.124415,0.201531,0.227406,0.0142182,0.275295,0.16201,0.288382,-0.666456,-0.0969872,-0.337296,-0.198598,-0.201676,-0.122742,-0.150418,-0.120413,0.358542,0.0872955,0.0874648,0.183497,0.228988,0.790871,-0.6409,-0.0701183,0.409021,-0.124613,-0.447745,0.660298,0.345843,0.27599,0.155879,-0.172818,0.280481,-0.0758217,0.22199,-0.189555,-0.0507001,0.154535,0.253161,-0.0999184,-0.0418654,0.153319,0.2169,0.0341416,0.78686,0.436758,0.00344572,-0.310889,-0.154526,-0.383845,-0.503931,-0.574585,-0.542973,-0.0543519,-0.389655,-0.334578,0.203338,-0.0931919,-0.14503,0.27203,0.592842,0.268802,-0.62782,-0.042026,0.0979692,0.11415,-0.251103,0.204055,0.342018,0.0224841,-0.192824,-0.717363,0.744638,-0.13977,0.253155,0.255067,-0.306519,0.18195,0.0669587,-0.385586,0.446247,0.011676,0.0663773,0.224984,-0.0387774,0.217551,0.0547832,0.117109,0.27688,0.0948262,0.204133,-0.541589,-0.262796,-0.0172983,-0.384564,0.254473,0.347159,-0.0862268,-0.0554368,-0.290708,0.720477,0.13309,0.283035,0.846073,-0.726314,-0.392998,0.0622514,0.106788,0.19084,0.684688,0.416024,0.293014,0.213718,-0.260695,-0.722221,0.184045,-0.392166,0.466908,0.0395411,-0.337266,0.223978,-0.0608869,-0.14268,0.113653,0.161603,-0.657785,0.578092,0.205491,-0.295036,-0.596054,-0.0273612,-0.34346,-0.142673,0.387768,-0.0762481,-0.0304413,0.0494449,-0.25603,0.133671,-0.108076,0.23196,0.193238,0.155502,0.393716,-0.00826833,-0.565005,-0.07022,-0.472922,-0.071815,0.0610632,-0.351294,0.0559083,0.323183,-0.350352,-0.532524,0.0897416,-0.0629163,-0.25981,0.217191,-0.274387,0.0282109,0.288891,0.443404,0.161806,0.146236,-0.433877,0.108694,0.216327,0.329687,0.46511,-0.876098 +3428.91,0.931647,0.0912059,4,1.50882,0.802647,-0.686964,0.229475,0.716467,0.116052,0.0532154,-0.00286014,-0.249513,0.198669,0.315402,-0.0764118,0.0665702,0.856394,-0.309379,0.5604,0.207624,0.23139,0.122091,-0.193514,0.0661495,-0.540294,-0.36833,0.291005,-0.368723,-0.420948,0.0359342,0.63742,-0.264911,0.330162,1.23637,-0.613313,0.0814775,0.398378,0.10852,-0.225841,-0.68282,0.429906,-0.107508,-0.167974,1.15238,0.33322,-0.159521,-0.160704,0.12972,-0.28995,-0.15219,0.0691022,0.514053,0.0650369,0.291943,-0.326131,0.729057,-0.523689,0.90995,-0.29592,0.291585,-0.271823,0.487742,-0.46439,0.210948,0.704964,-1.13116,-1.01757,-0.0361792,-0.184841,-0.316855,-0.0571292,0.332684,-0.756518,0.0236942,-0.147308,0.131498,-0.164174,0.43156,0.70056,0.174092,-0.285932,-0.0893996,-0.00703187,0.688756,-0.588776,0.13513,0.0929882,0.126629,-0.457063,0.121957,0.171341,-0.0907841,-0.275412,0.639617,0.191635,0.37315,-0.193799,0.211749,0.360377,0.0298534,-0.395934,0.331949,0.2866,0.0805027,0.105237,-0.244678,-0.191297,-0.173829,0.0414958,-0.286273,-0.183208,0.378844,0.323277,-0.428471,-0.293471,-0.312504,0.52117,0.37361,-0.364331,-0.517856,0.0297626,0.0703015,-0.115808,0.0909423,-0.22114,0.322461,-0.918411,0.161635,0.0684694,0.436709,-0.17115,-0.0404433,-0.124186,-0.335028,-0.386114,0.249088,0.473536,-0.411067,-0.684629,0.0767199,0.544886,0.41041,-0.320971,-0.455057,0.239224,0.268863,-0.737884,-0.289723,0.0136215,-0.017166,0.00621009,-0.0590615,-0.177792,0.493791,0.394698,0.412112,0.198893,-0.0804129,-0.160977,0.291534,-0.377441,-0.294238,0.188638,0.121737,0.167292,0.480652,0.112366,0.168146,0.474923,-0.0537285,0.291826,-0.249624,-0.115809,-0.0967823,0.313882,0.154528,0.715188,0.109441,-0.392271,0.0295527,0.129548,-0.0464135,0.909159,-0.0542322,-0.127676,-0.313482,0.0918796,-0.042171,-0.407865,-0.218146,-0.0898585,-0.264638,-0.390472,-0.308329,0.0472074,-0.297276,-0.110847,0.295804,0.0934922,0.666573,-0.379087,0.0983298,-0.0952478,-0.00952923,-0.0177979,0.258871,0.241321,0.10166,-0.191169,-0.266674,0.841245,0.325076,-0.0160164,0.39455,0.0471456,0.619,0.372612,-0.372714,0.484584,-0.184988,0.152194,0.124779,0.429208,0.0734172,-0.203408,0.159352,-0.102673,0.0452961,0.0620303,-0.996515,-0.19203,0.396631,-0.233737,0.519473,0.334886,0.0614711,-0.117226,0.243765,0.666953,0.0131015,0.445814,0.784567,-0.260603,-0.223094,0.488698,-0.0527046,0.311487,0.148656,-0.105744,0.190079,0.011299,-0.394164,-0.398974,0.0433217,-0.529627,0.501622,-0.229067,-0.553179,0.548766,-0.34618,-0.406403,0.651297,0.294765,-0.249191,0.497998,0.26325,-0.122142,-0.331319,0.0452048,-0.420544,-0.10734,0.201079,-0.0898709,-0.0311366,0.0575051,0.1022,0.112596,0.0691516,0.265233,-0.0672462,-0.255244,0.0966936,0.0469962,-0.114416,-0.312101,0.085923,-0.484864,0.0398254,-0.0357362,-0.120962,0.204272,-0.681451,-0.806892,0.102649,0.188724,0.247892,0.254715,-0.311177,-0.617722,0.12474,0.058957,0.247012,0.387315,-0.528136,0.103858,0.247452,0.32227,0.497446,-2.17444 +3444.86,0.915991,0.0912059,4,1.50837,0.6847,-0.690749,0.153172,0.664577,-0.0626696,0.0589835,0.0356542,0.0643764,-0.419633,0.287985,-0.307553,0.43982,0.671,-0.010804,1.13283,-0.0304155,0.212964,0.489442,-0.865092,0.172056,-1.1403,-0.803987,0.42973,-0.205514,0.417546,0.0893178,0.141832,-0.385344,0.554598,0.8934,-0.831901,-0.256547,0.14791,0.251059,0.117055,-0.162462,0.443684,0.183859,-0.0421109,0.916309,0.537813,0.180423,-0.232083,0.196119,0.45872,-0.678989,0.136152,0.914633,0.328914,0.338024,0.520214,0.595315,-0.836595,1.62295,-0.624248,-0.116833,-0.67427,0.853504,-0.164804,0.0527369,1.08655,-0.8364,-1.177,0.180509,0.0281169,-0.203616,-0.0398338,-0.0237812,-0.388169,0.107155,0.0150472,0.422205,0.0549197,0.255198,0.807406,0.00932371,-0.0226257,0.0483983,-0.0396659,0.657728,-0.418121,0.57499,0.0332455,0.204948,-0.216693,-0.0567162,0.123531,0.0443346,-0.378544,0.371804,0.0578943,0.122887,-0.405878,0.147968,-0.167708,-0.0656326,-0.327604,0.593041,0.270267,0.0300705,0.282172,-0.395043,-0.277603,0.664605,-0.0420144,-0.0599282,-0.0538318,0.0967203,0.149332,-0.0675505,-0.161728,-0.0294793,0.31415,0.0485194,0.122067,-0.65657,-0.113552,0.0414251,-0.0668571,-0.36156,0.16759,0.589141,-0.0109621,-0.0196753,-0.0163227,0.664775,0.234586,0.0515655,-0.705265,0.0319853,-0.0125917,0.0771715,0.165306,0.0456764,-0.205579,0.350606,0.47997,0.268486,-0.337271,-0.515607,0.164729,0.0780138,-0.173348,-0.138877,0.430829,-0.087016,-0.238612,-0.0808104,0.765818,0.201466,0.313528,0.577609,-0.0495784,-0.158847,0.668372,0.282756,0.0932959,0.19962,-0.130159,-0.0446563,-0.00752558,0.451227,0.00591203,0.0171734,-0.0732103,0.143092,-0.205002,-0.0342928,-0.107491,-0.309479,0.152534,-0.0135858,0.207326,-0.155415,0.0251376,0.0840164,0.0487848,0.192048,0.519592,0.385562,-0.35078,0.00287132,0.191047,-0.50428,-0.627993,-0.414375,0.105631,0.298733,-0.32595,-0.248258,0.129376,0.0657359,-0.122285,0.0430803,0.106349,0.343372,-0.35825,-0.19332,-0.209243,-0.0287729,-0.165167,0.099791,-0.366878,0.167774,-0.22576,-0.118438,0.723565,-0.0679422,0.322655,0.208088,-0.238207,0.322713,0.281382,-0.349948,0.124038,-0.292698,0.349385,-0.0251491,0.409403,0.494058,-0.071342,0.248822,0.0928797,-0.399704,0.193837,-1.11604,-0.0123919,0.677873,-0.25086,0.0508318,-0.0725986,0.0700159,-0.584113,-0.156576,0.617524,0.0738254,0.10715,0.35707,-0.520217,0.501749,0.266402,-0.135043,0.27431,0.859339,0.290203,0.169058,0.39081,-0.249422,-0.568942,-0.213845,-0.56013,0.395783,0.00194168,-0.39569,0.314787,-0.0385837,0.195471,0.0320645,-0.226327,0.127092,-0.00153288,0.122902,0.383771,-0.11931,0.080902,0.0716764,0.0689635,0.33407,0.319196,-0.113137,-0.604533,-0.411982,0.158542,-0.0529212,0.0319169,0.237363,-0.427563,-0.179819,-0.217835,0.128124,-0.361244,-0.306675,-0.0549254,-0.159875,0.0609936,-0.206231,-0.027283,-0.135272,-0.279233,-0.22826,0.0353545,0.284529,0.157129,-0.119487,-0.687246,-0.386258,0.108918,0.187735,0.0848667,0.195142,0.0931451,0.289384,0.305197,0.537944,-1.67506 +3461.12,0.897283,0.0912059,4,1.53585,0.688351,-0.856187,0.303016,0.637245,-0.0823359,-0.253297,0.0198956,0.280128,-0.495438,0.309231,-0.0263445,0.120242,0.723083,-0.0544189,1.15432,0.0637339,0.272772,0.674425,-0.555029,0.266852,-1.26264,-0.651847,0.517886,-0.389015,0.256903,-0.14121,0.165635,-0.605673,0.441394,1.16956,-0.489924,0.00121574,0.21205,0.342558,0.0698533,-0.168899,0.318082,0.23798,0.0281235,1.02455,0.361813,0.0620326,-0.495833,0.291309,-0.00626096,-0.549504,0.0933832,0.598686,0.310247,0.0907668,0.308729,0.74854,-0.945687,1.32603,-0.60223,-0.0334964,-0.566543,0.764256,-0.208708,0.451853,1.15939,-0.784601,-1.18107,0.278801,-0.0202653,-0.134152,0.17006,0.0363385,-0.262927,-0.0177249,-0.120093,0.321951,-0.0697952,0.0623509,0.730832,0.000642486,-0.0379251,0.0618755,-0.0751353,0.829538,-0.222348,0.525021,0.0584882,0.0126356,-0.476996,-0.142521,-0.115631,-0.176538,-0.484946,0.200678,0.272138,0.204444,-0.437879,-0.115556,-0.0712471,-0.0790652,-0.20793,0.476126,0.314702,-0.00289393,0.0980701,-0.163033,-0.171855,0.744537,-0.321594,0.324402,-0.133556,-0.0517482,0.251506,-0.0733481,0.0102546,-0.0880081,0.10096,0.267081,0.0694694,-0.501347,-0.0980683,-0.0215398,-0.000941847,-0.478023,-0.00073856,0.430249,-0.0622686,0.117749,-0.00460318,0.556783,0.281047,0.142685,-0.528041,0.125638,-0.0158578,-0.112945,-0.00437227,0.0595512,-0.0575357,0.109133,0.585322,0.406213,-0.282636,-0.598511,0.180153,-0.0875675,-0.472185,-0.178791,0.250784,-0.201322,-0.0720607,-0.155124,0.446726,0.254731,-0.0801393,0.551635,-0.0705224,-0.0603835,0.663525,0.408427,-0.07816,0.15723,-0.0953971,-0.24276,-0.0998887,0.391434,0.108447,0.0860633,-0.242633,0.140293,-0.24529,-0.116759,-0.472797,-0.308263,0.0725981,-0.0870437,0.0473456,-0.0914281,0.166147,0.0961979,-0.009923,0.406169,0.62023,0.200526,-0.299063,0.275891,0.349754,-0.593572,-0.367461,-0.244343,-0.0180789,0.444469,-0.41676,-0.217231,0.176699,-0.236048,-0.158125,0.027964,0.21791,0.374263,-0.140056,-0.239092,-0.157864,-0.0243766,-0.129451,0.142201,-0.136568,-0.0937578,-0.00706459,-0.276155,0.707365,-0.040159,0.0981544,0.109954,-0.309584,0.458641,0.0154781,-0.424752,0.176717,-0.403287,0.135439,-0.00909941,0.128467,0.701468,-0.397341,0.0669025,0.00791609,-0.664833,-0.0703151,-0.964988,-0.275051,0.616919,-0.0851475,0.0990102,-0.133189,0.144366,-0.274777,-0.165149,0.415583,-0.0271434,-0.12438,0.32093,-0.320659,0.333966,0.279341,0.00392816,0.0130815,0.740033,0.032563,0.187194,0.14073,-0.0391265,-0.716418,-0.243613,-0.536502,0.629595,-0.0459082,-0.337637,0.314268,-0.0684217,0.0569531,0.21321,-0.0650607,0.132258,0.022078,0.23951,0.288077,0.112898,0.0353661,0.0523644,0.412093,0.159246,0.158009,0.0635583,-0.356951,-0.292371,0.397954,0.113803,0.162441,0.17639,-0.629757,-0.216186,-0.0961914,0.148284,-0.208251,-0.178553,0.0697876,-0.189166,0.0905027,-0.0803695,0.124726,0.02017,-0.436592,-0.265114,-0.124187,0.353527,0.171405,-0.0487849,-0.565268,-0.547717,0.0579276,0.216727,0.0543782,0.115687,0.0922781,0.268516,0.303773,0.518186,-1.61357 +3450.61,0.870565,0.0912059,4,1.41624,0.736583,-0.89996,0.29855,0.581973,-0.0915385,0.0564618,0.0463415,-0.103081,-0.496657,0.301639,-0.233859,-0.0975142,0.945281,-0.093843,1.28875,0.0361161,0.421118,0.346285,-0.535042,0.0208415,-1.32361,-0.666741,0.441318,-0.423772,0.102883,0.217959,0.359695,-0.146725,0.574253,1.36365,-0.591126,0.262545,0.372577,-0.0510139,0.0717552,0.00719792,0.438973,0.845685,-0.15469,1.0963,0.304671,0.149102,-0.628919,0.405939,0.0468487,-0.536543,0.0551388,0.809809,0.178266,0.151977,0.488651,0.413426,-0.555095,1.30833,-0.617235,0.0124468,-0.360565,0.812848,-0.171896,0.517339,1.31622,-0.590531,-1.21133,0.167027,0.106133,0.144378,0.0986216,0.187134,-0.14638,-0.026059,-0.116544,0.252415,0.0252845,0.224548,0.706431,-0.141132,-0.526341,0.17692,-0.165399,0.731577,-0.3308,0.459844,-0.0131908,0.0084656,-0.273609,-0.268202,-0.191257,0.0733456,-0.354752,0.563281,0.770964,0.124991,-0.326757,-0.371949,0.0585875,-0.529329,-0.471118,0.443119,0.318673,-0.151958,-0.234407,-0.038066,-0.0156144,0.666639,-0.530896,0.205259,-0.0677352,0.033208,0.531036,0.0244419,-0.0574321,0.210991,0.333522,0.453629,0.233829,-0.454305,-0.129337,-0.143663,0.251273,-0.835302,-0.119652,0.318454,-0.18161,0.102535,0.193752,0.898354,0.278487,0.188796,-0.327714,0.268819,-0.00929779,-0.38871,0.231966,-0.235836,0.188953,-0.196162,0.452931,0.524926,-0.349588,-0.746959,-0.00295868,0.221272,-0.452447,-0.318554,0.183756,0.0459308,-0.266713,-0.169353,0.78938,-0.115295,0.294595,0.371233,0.0420516,0.0906325,0.463485,0.416871,0.254359,0.149397,0.173825,-0.106913,-0.100298,0.480262,0.210143,0.0593946,-0.0333931,0.262674,-0.527831,-0.0885736,-0.37977,-0.222055,-0.0233702,0.0234249,0.316561,-0.192398,-0.162275,-0.0883211,-0.116331,0.435656,0.488061,0.189628,-0.313833,0.441071,0.348758,-0.450693,-0.307062,-0.482119,0.239458,0.228591,-0.0409038,-0.123201,0.355241,-0.303022,-0.241106,-0.0681921,0.0723884,0.494673,-0.180361,-0.307942,0.259711,0.0229228,0.211163,-0.257942,-0.256284,-0.0562656,0.348537,-0.535796,0.69624,0.0447687,-0.144312,0.0476354,-0.287884,0.202758,0.305463,-0.280105,0.024004,-0.209703,0.266277,0.284789,-0.144837,0.475147,-0.210134,0.286906,0.138555,-0.415422,0.0835484,-0.754407,-0.568276,0.179115,-0.0803363,-0.421002,-0.120408,0.395812,-0.148466,-0.487779,0.267107,0.0717944,-0.274049,0.290194,-0.202605,0.266158,0.174189,-0.0368524,-0.14366,0.33296,0.406032,0.0689399,0.0718922,0.160371,-0.611646,-0.0753024,-0.834969,0.502394,0.115181,-0.155429,0.57534,-0.226917,0.288563,-0.144651,0.129179,0.0525225,0.755286,-0.070644,-0.0237369,0.0879818,-0.25204,-0.0449719,0.203154,0.219299,0.298845,0.0951785,-0.531841,-0.233524,0.00668081,0.0123946,0.198815,0.0910189,-0.662204,-0.0412874,-0.0955706,0.147336,-0.144034,-0.175947,0.0928084,-0.219147,0.0931191,0.00867609,-0.0509442,0.0979472,-0.149979,-0.0333357,-0.233136,0.0688931,-0.0824974,0.111242,-0.571253,-0.121996,-0.0905675,-0.201781,0.0625209,-0.120127,0.0888253,0.38312,0.298036,0.618967,-1.60542 +3415.05,0.919058,0.0912059,4,1.4624,0.73843,-0.583574,0.23366,0.573091,-0.034769,0.0410411,0.777644,0.558602,0.0532914,0.42057,-0.0829746,-0.111612,0.537913,-0.183292,0.921149,0.404966,-0.0708703,0.70937,-0.037772,-0.0110043,-1.04887,-0.733053,0.4869,-0.14855,0.324555,0.502509,0.622814,-0.146576,0.435268,1.01524,-1.13414,0.0649972,0.544461,0.200926,-0.080666,-0.466355,0.64572,0.191036,-0.954237,0.938038,0.573568,0.442219,-0.130473,-0.0886719,-0.28284,-0.36749,-0.459506,0.396523,0.574033,0.40867,0.524003,0.3457,-0.149169,1.23411,-0.733753,0.0202837,-0.671084,0.794857,-0.600059,0.244715,1.05051,-0.375988,-1.64906,-0.409884,0.0151503,-0.228828,-0.487461,0.775925,-0.742564,0.228331,0.946186,0.578555,-0.0324171,0.426628,0.277755,0.103872,-0.20609,0.0208179,0.51746,0.197194,-0.0317851,0.225863,0.118759,-0.0682937,-0.0604139,-0.348542,0.0741896,0.131118,-0.273709,0.0509321,0.207969,0.131525,-0.348644,-0.16345,-0.0306014,-0.50157,0.179654,0.17034,0.271354,-0.903745,0.043021,-0.364638,-0.410469,-0.177424,-0.435325,0.271851,-0.31617,-0.0931151,0.454616,-0.282907,-0.103584,0.312281,0.344748,-0.736708,0.0637579,-0.304062,0.123875,0.092898,-0.0317003,-0.287038,-0.236638,-0.0170241,-0.390487,-0.312347,-0.336403,0.0695793,-0.055341,0.190925,-0.0688056,-0.419199,-0.134632,0.387224,0.492335,0.236081,0.318624,0.0754116,0.445612,0.308546,0.597965,-0.160003,0.148717,0.266304,-0.628368,0.283348,0.405093,-0.0029558,0.199035,-0.277038,-0.221882,-0.0792581,-0.173669,0.0951207,-0.591244,0.21685,0.0421951,0.166829,0.612042,-0.0950221,0.464957,0.0867834,-0.241066,0.127487,-0.173471,0.408612,-0.0615349,-0.0992666,0.13075,-0.188744,-0.801832,-0.0661063,-0.0375701,-0.276364,0.203512,-0.232473,0.249735,-0.592663,0.426338,-0.441632,0.426175,0.0132742,0.0877197,-0.0502952,0.11983,0.101511,0.0936299,-0.0801521,-0.496657,0.373516,-0.412865,-0.0217189,0.233515,-0.0636679,-0.765955,0.21403,0.00512931,0.714882,-0.319702,-0.397806,-0.0451566,-0.0076549,0.162624,-0.240501,-0.209445,-0.184515,0.131866,-0.525494,1.04421,-0.34616,-0.046686,0.0672973,-0.0327835,0.509351,0.188438,0.425089,-0.358648,-0.193847,-0.0602456,0.50562,-0.514928,0.234978,-0.566261,0.215271,0.155821,-0.571962,0.471792,-0.420738,0.0557839,0.587688,0.0727499,0.0481727,0.1363,-0.129469,0.166127,-0.190433,0.393,0.220129,-0.088566,0.427437,0.28679,0.540632,0.22866,-0.200446,-0.517504,0.00692697,0.280815,0.534036,0.0801988,-0.44083,-0.359378,-0.0127869,-0.849639,0.553228,-0.320419,-0.429188,0.235134,-0.0867504,-0.0815286,-0.132579,0.0522254,-0.000691241,-0.170184,0.270004,-0.611667,-0.04931,-0.150337,-0.404165,0.300449,-0.178448,0.146406,0.0439065,-0.111482,-0.592897,0.47989,0.207091,0.446907,0.408109,0.169149,0.0575259,-0.0763402,-0.245474,-0.326167,-0.0473453,-0.304443,-0.103372,0.318421,-0.0213881,0.156179,-0.265418,-0.198723,0.00699615,-0.370489,-0.134034,-0.159812,-0.602021,-0.231018,0.156915,-0.146453,-0.201981,-0.0676143,-0.128211,0.126624,0.439071,0.355843,0.662624,-1.65192 +3445.24,0.732178,0.0912059,4,1.44354,0.744089,-0.541107,0.231913,0.732624,-0.0608289,-0.141945,0.142816,0.738142,-0.391267,0.650489,0.0911783,0.409061,0.413508,-0.262216,0.917147,0.337276,0.156839,0.0908278,-0.0775513,0.158881,-0.63649,-0.678549,0.755232,0.172303,-0.124208,-0.157341,0.745535,-0.660148,0.381095,1.14906,-0.946817,0.856645,0.872192,0.159168,0.144456,-0.318594,0.0941133,0.741898,-0.890016,0.986868,0.392095,0.485612,-0.552213,0.421482,0.137995,-1.12768,0.48098,0.678108,0.0557703,-0.114286,0.37877,0.0433538,-0.466891,1.25963,-0.441148,0.145711,-0.437029,0.794908,-0.604417,0.137857,1.00233,-0.470754,-1.98062,-0.0409234,0.257785,0.0896791,0.0012026,-0.116907,-0.164735,0.238197,0.235357,0.730686,-0.02424,0.638673,0.626484,0.965087,0.337032,0.25248,0.218106,0.792275,-0.0383868,0.0644256,0.035292,-0.167944,-0.0954291,-0.17065,-0.0207598,0.635558,-0.365727,-0.361594,-0.216941,-0.181736,-0.0603202,0.0652066,-0.079124,-0.0384884,-0.321205,0.504158,0.42585,0.0108071,-0.166724,-0.1549,-0.398306,-0.42051,0.0309529,0.104929,-0.0204575,0.0570856,0.274975,-0.414554,-0.616966,0.0773589,0.380965,-0.333534,0.288786,-0.0157864,0.169757,0.337089,-0.190525,-0.868896,0.242221,0.0697193,-0.00184549,0.3243,0.0654741,0.0783137,0.707524,0.107904,0.22452,0.0252379,0.0973776,0.235869,0.551119,-0.316386,0.0766237,0.116601,-0.127896,0.282289,0.340618,-0.529781,-0.216653,-0.296354,-0.403012,0.632877,-0.24297,0.206156,-0.0401265,-0.0351813,-0.0127177,-0.340447,-0.0907587,0.179009,0.0881012,0.061647,0.165394,0.157744,0.249872,0.146318,-0.194846,0.107655,0.291063,0.406468,-0.485306,-0.170743,0.048033,-0.0995772,0.147035,0.0106354,-0.191622,-0.0410255,0.669312,0.163606,0.00576083,0.196289,0.314777,-0.164002,0.109386,0.0539951,0.741865,-0.24245,0.195408,0.601444,0.0692678,0.167585,-0.801029,-0.0493278,-0.280377,0.0793495,-0.39013,0.11569,0.303978,-0.162273,-0.72576,-0.0636693,0.00924838,0.120564,-0.264457,-0.0597643,0.399576,-0.17476,-0.169181,-0.366651,-0.360907,-0.418879,-0.170588,-0.422662,0.750459,-0.162433,-0.287156,0.0536065,-0.445373,-0.00123087,0.0102294,-0.60444,0.126144,-0.431276,0.350053,0.410488,0.0738373,-0.0344657,-0.257976,-0.168571,-0.0771457,0.131216,0.247008,-0.679086,-0.350653,-0.0626479,0.363492,0.454647,-0.0850742,0.112697,-0.104664,-0.412606,-0.210608,0.103894,0.429479,0.348885,-0.374293,0.382062,-0.190909,-0.275282,0.0759812,0.248928,-0.0048008,-0.0612567,0.173169,-0.276363,-0.0468678,-0.118274,-0.106417,0.152694,0.12485,-0.00108727,0.216021,-0.142758,-0.287856,-0.174531,-0.186323,-0.20329,0.353311,0.0468428,-0.0428461,0.335627,-0.318748,0.179866,0.272619,-0.642055,-0.0672331,-0.197993,-0.426867,-0.464152,-0.0554486,-0.0216941,-0.163375,-0.121556,0.00159072,-0.281402,-0.14715,-0.748883,-0.221135,-0.183822,-0.26661,0.0334592,-0.0266102,-0.00109048,-0.128611,-0.0904858,-0.219087,0.00103462,-0.0873775,0.200535,0.305993,-0.248818,-0.149296,0.0122633,0.16466,0.217902,-0.185166,-0.373045,0.0876847,0.346613,0.296116,0.588739,-2.22455 +3418.31,0.913274,0.0912059,4,1.40818,0.770644,-0.334273,0.165529,0.673654,-0.128799,-0.374717,0.151752,0.844219,-0.262418,0.641055,0.227391,0.391423,0.452463,-0.180429,0.491889,0.537411,0.241518,-0.162613,-0.0882126,0.281875,-0.754302,-0.831239,0.894758,0.118637,0.0508402,-0.185499,1.13827,-0.581531,0.47785,0.974103,-0.776016,0.808329,1.0545,0.37321,0.170245,0.0815534,-0.158486,0.730945,-0.807721,0.823208,0.492509,0.628629,-0.566993,0.299249,0.180792,-1.19193,0.651303,0.617949,0.0824921,0.0775284,0.630627,0.148455,-0.704221,1.043,-0.26786,-0.0139135,-0.522555,0.9469,-0.730631,0.0997586,0.971532,-0.481604,-1.94402,0.0919272,0.215826,0.0224826,0.116717,-0.0839593,-0.203926,0.484524,0.101786,0.688958,0.114477,0.683455,0.559982,0.945365,0.213243,0.35284,0.341301,0.803072,0.362546,0.206034,-0.081964,-0.239209,-0.219021,0.0989531,-0.0298019,0.670353,-0.318973,-0.278465,-0.127894,-0.197251,-0.247259,0.152188,-0.31205,0.125579,-0.303009,0.734517,0.440433,-0.0804306,-0.015272,-0.11668,-0.355418,-0.507642,0.109157,0.0264436,0.105509,0.136151,0.330598,-0.270219,-0.811148,0.376818,0.406338,-0.0925628,0.0060028,0.0876308,-0.0281958,0.225003,-0.192507,-0.622249,0.405847,0.0591593,0.0172899,0.370853,0.0215494,-0.0208662,0.720604,0.206948,0.248056,0.109057,0.246416,0.154581,0.506844,-0.315925,0.0790186,-0.229223,-0.353282,0.252714,0.244944,-0.37309,-0.311377,-0.0926611,-0.706338,0.67734,-0.266906,0.0236208,-0.327659,-0.168434,-0.154872,-0.194612,-0.276179,0.241257,0.0745185,-0.0279922,0.0287233,0.113077,0.237013,0.147667,-0.0654575,0.33315,0.222053,0.441984,-0.481296,-0.0823214,0.0673279,-0.158969,0.306121,-0.179069,-0.445323,0.0417889,0.655519,0.0111246,-0.177817,0.134885,0.242961,-0.0463841,0.262915,-0.169222,0.622997,-0.0370678,0.32264,0.596556,0.0307267,0.309981,-0.782035,-0.108717,-0.197281,0.194443,-0.434174,0.0806729,0.559589,-0.122164,-0.789398,0.00187257,0.169609,0.295475,-0.205386,-0.0794752,0.287145,-0.196584,-0.227738,-0.240771,-0.485061,-0.108247,-0.342951,-0.287253,0.847437,-0.303964,-0.229352,-0.136676,-0.419864,0.00645698,0.0156434,-0.483395,0.193429,-0.295626,0.300481,0.42782,0.26834,-0.0441709,-0.300457,-0.219376,0.105781,-0.237062,0.384656,-0.680199,-0.327943,0.079005,0.286897,0.653882,-0.0346314,0.148385,-0.18428,-0.364583,-0.119183,0.219027,0.538738,0.226369,-0.289731,0.160285,-0.0579499,-0.250632,-0.048311,0.138905,-0.057339,0.127934,0.376448,-0.458291,0.117072,-0.0697918,-0.293296,0.448778,-0.103586,-0.260345,0.324637,-0.0772574,-0.386088,-0.0753398,-0.179627,0.0275656,0.634647,0.0877171,0.175595,0.357536,-0.338839,0.191495,0.148036,-0.746164,-0.18864,-0.126552,-0.399138,-0.370037,-0.0735955,-0.145059,-0.10908,-0.253958,-0.176892,-0.103469,-0.0639526,-0.391463,-0.392222,-0.13151,0.165195,-0.120824,0.149477,0.152279,-0.0964984,-0.0315488,-0.0871302,0.247602,-0.0979968,0.161828,0.166631,-0.0323472,-0.0746408,-0.183545,-0.0591248,0.101117,-0.387148,-0.241499,0.0972287,0.310123,0.311815,0.556887,-2.13982 +3431.73,0.87421,0.0912059,4,1.47946,0.780997,-0.469204,0.105461,0.993773,-0.1236,0.305994,0.119686,0.352441,-0.590155,0.49104,-0.0116909,-0.236641,0.36715,-0.0418772,0.851067,0.282472,0.125988,0.00546043,-0.20985,-0.103235,-0.73188,-1.24708,0.625432,-0.280644,-0.0122467,0.167117,0.855214,-0.417876,0.588585,1.00182,0.0911026,0.287989,0.700345,0.479627,-0.140152,0.0125099,0.17641,0.813667,-0.19797,1.02067,0.50681,0.0858225,0.133006,0.178929,-0.0461115,-0.848378,-0.0670019,0.661954,0.441953,0.309183,0.0486174,0.435484,-0.62321,1.38173,-0.213266,0.397942,-0.716154,0.881912,-0.480974,-0.150218,1.12137,-0.60669,-0.73364,-0.752703,0.354136,0.000863293,-0.247627,0.129518,0.00438201,-0.106689,0.0918996,0.603935,0.338799,0.56616,0.237619,0.322304,0.0117823,-0.0562497,0.222989,0.590677,0.0027488,0.0028092,0.006495,0.319621,0.440123,-0.350621,0.374703,-0.377575,-0.189783,-0.0600906,-0.182197,-0.0728108,-0.256408,-0.090867,-0.139051,-0.0128892,-0.580122,0.379057,0.492052,-0.0911963,0.0866932,-0.37795,0.073867,-0.656052,0.0290993,-0.804077,-0.827934,0.448826,0.440437,-0.168551,0.180353,0.165033,0.42813,-0.0923188,-0.131209,-0.045608,-0.00736137,0.454845,0.270527,-0.520974,-0.145104,-0.114776,-0.203268,0.172958,0.250235,-0.22224,0.273045,-0.149403,-0.199278,-0.138184,0.0558385,0.128351,0.690279,-0.14938,0.37773,0.0920656,0.193203,0.554589,-0.319344,-0.773272,-0.170138,-0.0361107,-0.388571,-0.0726164,-0.54031,-0.147,0.415829,-0.154473,0.0223266,-0.0573973,0.249836,0.0461101,0.0978572,0.115417,0.539509,-0.0914094,0.0429854,0.161048,-0.691257,-0.149804,-0.0749654,0.647415,0.0293697,-0.131577,-0.222096,-0.41755,0.231675,-0.649509,-0.0040488,0.0109416,0.0551336,0.00353591,-0.135169,0.0843121,-0.103937,-0.224034,0.222845,-0.0646188,0.209783,-0.130678,-0.11043,0.0808259,-0.263349,-0.543236,-0.344533,0.5017,-0.257802,0.184485,-0.0786623,0.0326982,0.0678265,0.461996,-0.109393,-0.102606,0.607976,0.605323,-0.397784,-0.352636,0.258405,0.0957226,-0.21975,0.677117,0.186142,-0.501267,0.198188,-0.683628,0.976178,0.334255,-0.212765,-0.325571,-0.265978,-0.0334965,0.246712,-0.560867,0.0251356,0.255158,0.228271,-0.0317612,-0.245151,0.161695,-0.545672,-0.349677,0.688189,0.218369,0.201048,-0.264871,-0.186483,-0.0282676,0.291305,0.311264,0.24896,-0.414863,-0.39665,-0.388871,0.403644,0.135283,-0.185459,0.296686,-0.472484,0.106375,0.260217,0.0745165,0.713094,0.553635,0.173996,-0.0690797,0.185027,0.0696841,-0.0734499,0.240682,-0.286273,-0.0564351,-0.230616,-0.527796,0.760857,0.01513,-0.363693,-0.309298,-0.316294,0.530389,0.737004,0.518208,-0.142954,-0.0192129,0.495251,-0.0127263,-0.513787,0.432698,-0.134168,-0.258418,-0.123328,-0.765303,0.0394023,-0.362977,-0.0631713,0.0341748,-0.103103,-0.214849,0.00966647,-0.0586227,-0.0159326,0.0837175,-0.486988,0.241893,-0.239166,0.0738829,-0.109358,0.0053573,-0.21877,0.0232146,0.00594685,-0.505272,-0.118323,-0.0127455,-0.744905,0.00177923,0.289966,0.411535,-0.217244,-0.145624,0.122744,0.420187,0.350348,0.648218,-3.023 +3436.01,0.95839,0.0912059,5,1.71756,0.96781,-1.17225,0.429636,0.018974,-0.129117,-0.493281,0.47357,0.555881,-0.0773725,-0.514905,-0.396426,-0.248894,0.400108,-0.129699,0.917337,0.0240512,-0.0794035,0.0391408,0.438453,-0.454093,-1.16499,-0.584464,-0.263602,-0.261803,0.095197,-0.243128,-0.0799365,-0.297966,0.152628,0.830796,-0.0966957,0.0925892,-0.0637781,-0.689122,0.0641289,-0.161919,0.707902,0.124568,-0.303503,1.08229,0.734733,0.295556,-0.982971,-0.529218,0.158707,-0.271738,0.0657312,-0.278881,-0.52287,-0.200377,0.693939,-0.174414,-0.134756,0.307239,0.0587628,-0.307603,-0.788449,0.10291,-0.00535819,0.214867,0.936909,-0.684441,-0.0559988,0.0404745,0.808881,0.0227245,0.0491864,0.399897,-0.0570456,0.00033305,-0.15998,0.450214,0.0163443,-0.0825887,0.470012,0.268316,-0.0885708,-0.688311,-0.0832851,0.583188,-0.165093,0.635033,0.115418,-0.529415,0.210305,0.230013,0.2251,-0.643226,-0.442799,0.119907,-0.216052,0.0728273,-0.127652,-0.0828445,-0.192902,0.00615524,-0.480396,0.336767,0.0174278,0.403514,0.0830894,-0.366909,0.0823305,-0.415886,-0.298336,0.0212183,-0.38427,0.503479,0.405207,-0.128088,-0.00698851,0.325966,0.351023,-0.105197,0.0801581,-0.204913,0.170051,0.00401555,0.151734,-0.541157,0.150878,-0.108403,-0.416288,0.493784,0.204634,0.0892779,0.402748,0.199996,-0.410199,-0.291104,-0.114191,-0.220091,0.163157,-0.194548,0.260168,0.0668029,-0.539432,0.599001,-0.664327,-0.978075,0.00652173,0.266714,-1.08747,-0.403376,0.0771979,-0.229445,0.147628,-0.0406134,-0.0348136,-0.242108,0.211525,0.00818579,-0.0682974,0.17053,0.631624,-0.0305141,0.0040064,-0.239165,-0.187127,-0.057171,-0.00443407,0.764947,0.212873,-0.5928,0.367258,0.156391,0.187279,-0.637634,0.041094,-0.283296,0.0224692,-0.220809,-0.318361,0.201379,-0.324058,-0.146043,-0.238488,-0.0178874,0.439375,-0.078685,0.15289,-0.150556,-0.0462755,-0.430476,-0.473802,0.507852,0.047681,-0.0645976,-0.251866,-0.0473722,-0.317071,-0.026693,-0.208874,-0.250107,0.557289,-0.270672,-0.664181,-0.248025,0.059622,0.144435,-0.0757261,-0.154897,-0.0536633,0.118355,0.10552,-0.958025,0.612139,0.336417,-0.303404,-0.179249,-0.119109,-0.350097,0.251235,-0.553289,0.3072,0.14182,-0.0870093,0.535937,-0.292617,0.188507,-0.511324,-0.147462,0.277625,0.62541,0.9036,-0.147102,-0.133339,-0.194424,-0.0989788,0.295842,-0.0783709,-0.176087,-0.22456,-0.44216,0.303665,-0.374086,-0.144202,0.351436,-0.139006,-0.0836174,0.0042163,0.364897,0.615738,0.816608,0.352838,0.244054,0.0989248,-0.113081,-0.0864032,-0.0297925,-0.659953,0.129225,-0.406469,-0.482551,0.0088184,-0.201905,-0.362408,-0.0485677,0.0735855,0.649943,-0.0805429,0.382235,0.467104,-0.0167031,0.243341,-0.0966085,-0.630398,0.206966,-0.100974,-0.229151,-0.260642,-0.76441,0.0987616,-0.190357,-0.054836,-0.0746324,0.343595,0.0726035,0.0846469,0.00937278,0.292751,-0.429454,0.0743202,0.539459,-0.196944,0.313444,0.192244,-0.202882,-0.234494,-0.281048,0.0537591,-0.254484,-0.220304,0.0998692,-1.16592,0.0502754,0.341281,0.497447,-0.133262,-0.326907,0.125401,0.19521,0.35412,0.441826,0.184279 +3422.92,0.9649,0.0912059,4,1.65954,0.952197,-1.39555,0.440416,0.0786407,-0.0653013,-0.0818797,-0.405293,-0.263327,-0.109503,-0.403768,-0.305378,-0.621612,0.0438834,-0.014589,0.547204,-0.128263,-0.31723,-0.223348,-0.0891973,-0.339763,-0.832122,-0.51705,-0.318581,-0.838421,-0.292765,0.164692,0.604647,-0.370882,-0.0447456,0.630191,-0.763801,-0.118021,-0.204232,-0.376141,-0.252181,-0.465305,0.600115,0.482957,-0.141047,0.780741,0.648136,0.798528,-1.03678,-0.151344,-0.503648,-0.663328,0.161133,0.570209,-0.344709,0.165766,0.00402829,0.157088,-0.176121,0.328441,0.134429,-0.322902,-0.33076,0.144471,-0.165947,0.381111,0.279454,-1.06929,-1.47538,0.507255,0.0280291,0.0295119,-0.266838,-0.0623906,-0.705559,-0.0394453,-0.169907,1.02376,-0.629295,0.800316,0.465009,0.331077,-0.431243,-0.498442,-0.331843,0.229936,-0.369243,0.138204,0.124643,0.186647,-0.113766,-0.318551,0.107087,0.258332,-0.425757,-0.0861274,0.140018,-0.582737,-0.381104,-0.0604556,-0.266835,0.207929,0.255254,-0.648797,0.358347,-0.271731,-0.178844,-0.0687762,-0.530173,-0.000201679,0.0153486,0.478967,-0.246816,0.544934,0.855847,-0.147131,-0.0633747,-0.169407,0.236893,-0.221905,0.0850291,-0.316397,0.0225984,0.355193,0.431549,-0.197458,-0.395646,0.27426,0.0782048,0.596272,-0.217398,-0.236269,0.242094,0.518754,0.142554,0.112339,0.217283,-0.135671,0.746903,-0.156095,-0.696784,-0.459854,-0.461985,-0.125038,-0.663545,-0.268295,0.261212,0.0958932,-0.544239,-0.0240994,-0.526801,0.198209,0.0719812,-0.371905,-0.330978,-0.604868,-0.0382145,-0.573308,-0.328552,0.0743169,0.197867,-0.0524805,-0.444118,0.57395,-0.280674,0.338062,-0.0447583,0.578221,0.186609,-0.0638538,0.311397,-0.153611,0.202276,-0.138479,-0.356329,0.492629,0.142542,-0.068167,-0.152204,0.0542315,-0.149589,-0.111619,0.189725,0.289057,1.09676,0.379786,-0.639421,0.330399,0.235991,0.192121,-0.533118,-0.0833292,-0.245199,0.410185,0.57599,0.163862,0.155957,0.162531,-0.200224,0.244565,-0.244451,0.115157,-0.399185,-0.149418,0.087371,0.226199,-0.0629885,-0.145186,0.450083,-0.435694,-0.358576,-0.148856,0.867915,-0.0373378,0.216825,0.490305,-0.089262,0.543331,0.280381,-0.297954,0.0976657,-0.68117,0.185538,-0.0311375,-0.751184,-0.1241,-0.523742,0.288784,-0.0395592,-0.399148,0.295907,0.17863,-0.116372,0.151893,0.128737,-0.284277,0.00628913,-0.160264,-0.209678,0.128096,0.695701,-0.0115223,-0.106374,1.2214,-0.336624,-0.18877,-0.19824,-0.00176892,-0.615035,0.280218,0.31306,0.483185,-0.685416,-0.129078,-0.524765,0.0947764,-0.477723,0.505826,-0.617283,-0.0287112,-0.546244,-0.16181,0.144538,-0.299414,0.373593,0.353026,-0.100789,-0.413712,-0.028131,0.0631101,-0.200268,-0.0640369,-0.328206,0.011222,0.0975036,-0.244618,-0.188095,-0.0576154,0.0155656,-0.494992,-0.582604,0.26252,-0.534027,0.424011,0.397649,0.0375173,-0.399475,-0.441011,-0.0663347,-0.184815,0.446097,-0.201342,0.345286,0.0489831,-0.0516371,0.0938387,-0.239372,0.108544,0.196074,-0.231703,-0.419945,-0.294606,0.0835024,-0.266953,0.327967,0.739358,0.126209,0.224726,0.355259,0.474053,0.046925 +3447.13,0.787706,0.0912059,4,1.76034,0.839474,-0.73538,0.194944,0.491626,-0.0278383,-0.319018,0.0520598,0.63933,-0.143605,-0.525381,-0.287919,0.183619,0.252602,-0.467937,0.868575,-0.308345,0.196007,-0.132174,0.304582,-0.112845,-0.903318,-0.918386,0.11997,-0.110452,-0.500393,-0.217043,0.238023,-0.42986,-0.0331703,0.464669,-0.227832,-0.25914,0.118747,-0.0265015,-0.0712768,-0.474392,0.309741,-0.15373,0.305738,0.662073,0.664229,-0.0753669,-0.243509,0.116771,0.0642767,-0.246783,0.398991,0.410188,-0.391366,-0.0857637,0.167596,-0.447881,-0.0853026,0.768559,-0.0202438,-0.326899,-0.823771,0.152671,-0.267531,-0.177194,0.828,-0.45412,-0.286888,-0.329657,0.298168,0.0295204,-0.24433,-0.143762,-0.421465,-0.557183,0.309655,0.35019,0.20487,-0.0238408,0.656782,0.127575,0.452801,-0.343308,-0.387878,0.139059,-0.638578,0.500656,0.171506,0.0664738,0.15456,-0.103749,-0.687922,-0.631231,-0.210682,-0.0931252,0.269783,0.216449,-0.0639263,0.332054,0.221345,0.347151,0.0215582,-0.252295,0.259784,0.0602545,-0.472375,-0.164401,-0.371093,0.313151,-0.282215,-0.288843,-0.196776,0.0473278,0.245561,0.26851,-0.16238,-0.132597,0.549713,-0.351265,0.195282,-0.47047,0.301006,-0.13046,0.188424,-0.46644,0.101997,-0.00374585,-0.0296672,-0.165332,0.425134,0.22963,-0.346602,0.575439,-0.381238,-0.451169,-0.0112736,0.17406,0.198499,0.181468,-0.291556,0.0805922,-0.264045,0.450539,-0.569125,-0.229095,0.144398,0.283581,-0.765984,0.0873366,-0.259826,0.4783,-0.0275087,0.00683299,-0.275695,-0.0763822,0.289921,-0.0145998,0.221992,0.403831,0.665733,0.329142,-0.554803,0.302301,-0.184112,-0.055991,-0.0634428,0.46161,-0.0811908,-0.156259,-0.0245553,0.0657285,0.155024,0.0320204,0.270114,0.406674,0.165078,0.0458967,-0.218044,-0.29631,-0.422391,-0.157436,0.0585064,0.214627,0.814597,0.230522,-0.0882128,0.171053,-0.073479,0.529867,-0.280831,-0.379344,-0.282439,-0.166125,-0.487701,-0.140596,0.15317,-0.331831,-0.248577,-0.211861,0.602903,-0.418547,-0.469147,-0.486011,-0.0892743,-0.222073,-0.154841,0.40938,-0.106714,-0.298602,-0.242692,-0.568781,0.83764,-0.355737,0.197224,-0.181051,-0.0122958,-0.210321,-0.208981,0.074284,0.682819,-0.457617,0.451359,0.350107,-0.23622,-0.217735,-0.275769,-0.293526,-0.274968,-0.322556,0.181969,-0.080293,0.0668055,0.446007,0.23113,-0.075432,0.12581,-0.133851,-0.0187653,-0.139752,0.440802,-0.175685,-0.236305,0.420268,-0.272686,-0.217225,0.0841881,-0.110384,0.169707,-0.078912,0.468755,0.745939,0.339948,-0.238683,0.0682978,-0.378099,-0.853691,0.419421,-0.379993,-0.353377,-0.00728904,-0.394373,-0.0982817,0.184529,-0.0522962,-0.036184,0.430076,0.366608,-0.610387,-0.27332,0.00525415,-0.163758,-0.297828,0.104181,-0.138873,-0.240211,0.0543578,-0.160632,0.205297,0.440961,-0.0466856,0.159729,0.356035,0.246919,-0.498933,-0.281352,0.22983,0.144425,-0.0629469,-0.0376518,0.0800772,-0.0555139,0.614559,0.701708,-0.146683,-0.0995175,-0.216754,0.398845,-0.365867,0.0622712,-0.410495,0.557842,0.286381,0.203747,0.459428,-0.363077,0.102007,0.156264,0.319385,0.395302,-1.14744 +3434.03,0.932553,0.0912059,4,1.65778,0.972326,-0.937036,0.350484,0.480934,-0.0487801,0.290622,-0.380096,0.0157637,0.469324,-0.307625,-0.250245,-0.252689,0.36709,0.144393,0.812042,-0.0637082,-0.0784013,0.0221371,0.020561,-0.158844,-0.312787,-0.350934,0.0616159,-0.617622,0.0600275,0.28304,0.296281,-0.473286,0.194333,0.424669,-0.781553,0.103157,0.132436,-0.317225,-0.421503,-0.623996,0.0932444,0.417296,-0.658354,0.763758,0.0299409,0.0731383,-0.774774,0.0589031,-0.0655255,-0.684223,0.000191898,0.624695,-0.147933,0.0482212,0.195254,-0.0310526,-0.383875,0.196294,-0.296586,-0.121467,-0.253959,-0.0821723,-0.49076,0.0438933,0.432193,-0.806802,-1.07926,0.235232,0.0931321,0.509609,-0.472622,0.267985,0.0875635,0.354011,0.0491315,0.425338,-0.420608,0.810162,0.540248,-0.0245487,-0.492128,-0.367823,-0.219822,0.00658707,-0.236059,0.079886,0.103299,0.0369483,-0.0751194,-0.0660427,-0.046398,-0.233647,-0.569271,-0.169045,0.142016,0.20967,0.00706136,-0.165327,0.336704,0.277667,0.221636,-0.12398,0.205245,0.287449,-0.229233,-0.551983,-0.347471,-0.447778,-0.537083,-0.204438,-0.631825,0.491696,0.811777,-0.440433,0.314864,-0.406243,0.495628,0.0985169,-0.0126305,-0.181766,-0.00353726,0.666689,0.253666,-0.0782095,0.13207,-0.359648,-0.158157,-0.461435,0.150031,0.211488,-0.00467659,0.14399,0.142366,0.117577,-0.105466,-0.2736,0.438068,-0.100745,-0.315801,-0.354242,-0.187025,0.0594079,-0.982439,0.294729,0.0380357,0.118213,-0.621471,-0.202968,0.251484,-0.213264,0.392778,-0.147914,0.0730929,-0.217302,0.0163072,0.159198,0.0386837,0.630639,0.0945212,0.554819,-0.719873,-0.0643625,-0.161868,0.437452,-0.374984,0.130892,-0.147044,-0.0173569,0.124968,-0.184311,0.067894,-0.0332162,-0.136695,0.347107,0.000966915,0.199974,-0.12427,0.0849071,0.0268968,0.15663,-0.0587187,0.360955,0.73892,-0.35655,0.146777,0.342952,0.523736,-0.151389,-0.250729,0.2169,0.0781513,0.358797,0.0847512,-0.176854,-0.0436378,-0.125102,-0.315028,-0.0576768,-0.575681,-0.102316,-0.616659,-0.16627,0.158409,-0.202793,-0.0202183,-0.0619205,0.179749,0.383358,0.388599,-0.0965635,0.944822,-0.104339,0.463414,0.167575,-0.332965,0.610734,0.53647,0.250225,-0.357434,0.243157,0.14411,-0.0555486,-0.49326,-0.202527,-0.411263,-0.0427474,0.0920429,-0.221772,0.284782,0.166174,-0.611257,-0.170251,0.314962,0.180787,0.259457,0.261252,-0.105595,-0.470997,0.550142,0.234564,0.375458,0.940772,0.193521,0.0622227,0.23345,0.0588816,-0.315455,0.11086,-0.148904,0.237616,-0.0514455,-0.424485,-0.927792,0.258917,-0.444388,0.546717,-0.266012,-0.201989,-0.523693,-0.494349,-0.331504,-0.149099,0.173124,0.207887,0.0696828,-0.578509,-0.102263,0.69684,0.241082,0.0419827,0.423189,-0.304737,-0.130646,-0.522169,-0.308737,0.0577346,-0.0754708,-0.50034,-0.00842409,0.132198,-0.424,0.78702,0.0149767,-0.303715,-0.167073,-0.210501,0.152431,-0.447227,0.568861,-0.137739,-0.0503984,0.0027285,-0.441523,0.23734,0.178111,-0.285421,0.20395,0.0726501,-0.0990221,0.0399587,-0.473338,-0.0493529,-0.378721,0.248136,0.124937,0.161201,0.353465,0.401499,-1.4857 +3434.48,0.937973,0.0912059,4,1.63254,1.16517,-0.185316,-0.0414349,0.528155,-0.112302,0.0232735,0.308534,0.886068,-0.0594324,-0.131385,-0.353118,0.195709,0.193396,-0.0725661,0.648643,0.257038,0.103783,0.152335,0.0172917,-0.446481,-0.914614,-0.669855,-0.171462,-0.0702424,-0.0788143,0.427865,0.0577727,-0.561796,-0.0095772,0.164191,0.433737,0.10654,0.201314,0.070987,-0.26292,-0.482689,0.287415,0.0415619,0.102692,0.685068,0.781779,0.0108384,-0.220091,0.0146909,0.0389195,-0.329324,-0.0372265,0.463751,-0.336985,-0.343435,0.192335,0.251887,-0.386331,0.607209,-0.361131,-0.420524,-1.01342,0.301521,-0.169545,0.11144,0.968332,-0.683257,-0.514485,-0.550767,-0.00273498,-0.153133,-0.402861,0.0124613,-0.609234,-0.253623,0.175354,0.127471,-0.390718,0.527298,-0.0391514,0.0557008,0.403289,-0.492517,-0.185244,0.0280565,-0.207532,0.109905,-0.0762022,-0.224215,-0.336038,0.307761,-0.236495,0.190089,0.216022,0.0835643,0.0752599,-0.103263,-0.259366,0.431888,-0.476064,0.00518828,-0.584796,0.0719707,0.358597,-0.153121,0.0438009,-0.114744,-0.124304,0.557891,0.159332,0.427562,0.0970635,0.178773,0.36502,0.723986,-0.775184,0.410212,0.482128,-0.203979,0.508325,-0.424625,0.308845,-0.201813,-0.455683,-0.737704,-0.0398363,0.0551028,0.255221,-0.230068,0.525702,0.148094,0.135826,0.260758,-0.599275,0.226561,-0.471468,0.0256097,0.675214,-0.404856,-0.310252,-0.261077,-0.450032,0.163478,-0.278723,-1.03531,-0.232967,0.00646797,-0.56814,-0.299273,0.187319,0.586225,0.16979,0.14639,-0.37784,0.153835,0.246746,-0.070511,0.295004,0.211702,0.797165,-0.317919,0.561064,0.381422,-0.20217,0.327565,-0.144349,1.01045,0.311682,0.00800683,0.0394993,-0.0146556,-0.0218989,-0.139436,-0.146752,-0.0615425,0.110557,0.0227164,-0.0561898,-0.0916781,-0.164914,-0.385577,-0.226062,-0.126607,0.670728,0.735109,0.0254417,-0.0892952,-0.503982,0.150647,-0.0663594,-0.468509,-0.367598,0.104936,-0.686914,-0.269032,-0.38234,0.390417,-0.893801,-0.355539,0.415722,-0.559064,-0.188218,-1.15256,-0.407973,-0.0891977,-0.0974145,0.214148,-0.416755,0.120803,-0.0264978,-0.685847,1.02565,-0.193249,-0.339638,-0.292073,-0.12701,-0.0828533,-0.114491,-0.284323,0.57142,-0.79913,0.169877,0.380786,-0.162517,-0.546554,-0.285629,-0.471576,0.207886,-0.182859,0.199849,-0.0625459,0.255159,0.0398198,-0.472145,0.264442,-0.0947149,-0.0577894,-0.198421,-0.156017,0.425823,-0.594859,-0.355708,0.220611,0.116639,-0.329047,0.413199,-0.0436418,0.291496,0.518018,0.257372,0.60776,0.261035,-0.289467,-0.195177,-0.580488,-0.40172,-0.103009,-0.459908,-0.122126,0.220169,-0.258806,0.139441,0.0400728,-0.168898,0.20127,0.307561,-0.0219909,0.616074,0.253303,-0.337149,0.318648,-1.06236,0.243658,0.0620202,-0.0237238,-0.0534194,-0.0457924,0.476122,0.390407,-0.0610029,0.105328,0.285298,-0.00757266,-0.253783,-0.128786,-0.217368,-0.302529,0.134543,0.248139,0.0303779,0.306955,0.464807,0.0442417,-0.210473,0.0694224,0.111877,0.19213,-0.166781,-0.164158,-0.481759,0.06516,0.377969,-0.169401,0.0612066,-0.301897,0.127851,0.165695,0.357563,0.407056,-2.01605 +3410.44,0.275764,0.0912059,4,1.64698,1.20113,-0.110896,-0.110613,0.477551,-0.135113,0.682785,-0.136252,0.429665,0.789744,-0.133731,-0.163355,-0.343264,0.343634,0.0596527,1.0472,0.00563454,-0.488388,-0.233028,-0.0519032,-0.554691,-0.900822,-0.274987,-0.137753,-0.521694,-0.321714,0.41647,0.438307,-0.140498,0.391066,0.312875,-0.592933,0.316251,0.146872,-0.00265566,-0.14734,-0.258864,0.378528,0.172637,-0.0623015,0.618518,0.250889,-0.0423646,-0.240485,-0.421303,-0.394835,-0.800594,-0.259922,0.136756,-0.208858,0.0865075,-0.252336,0.20626,-0.352808,0.832005,0.278743,-0.0372499,-0.790439,0.342516,-0.016262,-0.0335958,0.837092,-0.512276,-1.62455,0.122343,0.0370747,-0.0432883,-0.163223,0.15317,-0.513995,-0.198651,0.366386,0.491239,-0.248513,0.441117,0.27004,0.452145,0.0103002,-0.222398,-0.0403894,0.504887,-0.382131,-0.132973,-0.143252,-0.266845,0.272302,0.00706532,0.287468,-0.0343425,-0.367881,0.156619,0.402289,-0.145798,-0.0153714,-0.148582,0.141529,0.221485,-0.242726,-0.0396023,0.550192,-0.342388,-0.456895,-0.204406,0.0217004,-0.156205,-0.396913,0.602771,-0.397863,0.489977,0.898127,0.133299,-0.337547,0.100796,0.334264,-0.0075982,-0.0242459,-0.56907,0.488089,-0.218397,0.789496,-0.838282,0.0914296,0.313435,0.159176,-0.791556,-0.000142261,0.173528,0.59757,0.00235095,-0.17236,0.125058,-0.478303,-0.113511,0.564241,-0.394552,0.124679,0.00788066,-0.105751,0.12706,-0.707803,-0.468306,-0.110434,0.0973427,-0.141984,0.0931544,0.346429,-0.199705,0.226357,0.413605,0.344032,-0.656198,-0.265631,-0.250106,0.148342,0.146201,0.46424,-0.106474,-0.661236,-0.125775,0.25474,0.29153,-0.3147,0.760079,-0.732843,0.265444,0.358955,-0.0884998,0.0735607,-0.584674,0.166668,0.48588,0.538742,-0.0855613,-0.450965,0.0767101,-0.409188,-0.460654,-0.347598,0.34564,0.4428,0.176278,-0.156268,-0.416607,-0.655255,0.183449,-0.105886,-0.812802,-0.730464,0.380807,-0.487547,-0.288787,-0.252561,0.090118,-0.753656,0.341941,0.307324,-0.438137,-0.00539209,0.30837,-0.631832,-0.504638,0.0368298,-0.0436456,0.303622,0.0969974,0.159205,-0.810402,1.20449,-0.00775203,0.273994,-0.0209593,-0.31254,0.4222,-0.347963,-0.781177,0.572508,-0.1197,0.403404,-0.697934,0.507304,-0.332279,0.0156284,-0.0467951,-0.0630699,-0.252587,0.636624,0.211501,-0.171219,0.364514,-0.356026,0.155154,0.25473,-0.756466,0.187628,-0.683151,0.713265,-0.116864,0.145192,0.260212,-0.184958,-0.643223,0.238617,-0.00615657,0.388216,-0.0507745,-0.366341,-0.143083,0.130161,0.401562,-0.618655,-0.448088,-0.39888,0.159827,-0.355211,-0.697908,0.00732171,-0.0721155,-0.265324,-0.39538,-0.066772,0.169125,1.14593,-0.517834,-0.194797,0.447357,-0.167222,-0.0997963,0.12081,-0.0824008,-0.198946,0.00740949,-0.0110235,-0.521227,0.16175,0.160823,-0.468455,0.66887,-0.253881,0.243012,-0.631235,-0.255417,-0.0238191,-0.144304,0.0970928,0.129987,0.297698,-0.303887,0.737817,-0.219931,-0.309713,0.0731475,0.228627,0.0660291,-0.0054981,0.342929,-0.561639,-0.71967,-0.189314,0.185064,-0.108065,-0.457633,0.149347,0.207783,0.386455,0.455832,-1.86497 +3435.89,0.953761,0.0912059,4,1.65628,1.17715,-0.117044,-0.105158,0.1992,-0.0990078,0.695579,-0.223641,0.3494,0.983192,0.0824684,0.175068,-0.148845,0.375168,0.134682,0.784009,0.12892,-0.234045,-0.293705,-0.0452794,-0.711296,-1.05376,-0.281791,0.0622111,-0.0198273,-0.439457,0.298071,0.500592,-0.303109,0.18083,0.244844,-0.359697,0.316166,0.314432,-0.0821475,-0.084725,-0.330655,0.444648,0.160156,-0.471636,0.70005,0.402913,0.138666,-0.0430804,-0.264946,-0.179023,-0.696505,-0.173836,0.209188,-0.274907,0.0613437,-0.429482,0.0719528,-0.419122,0.782424,0.177427,-0.058297,-0.387528,-0.119393,0.0615988,-0.224531,1.03851,-0.843159,-1.46144,0.181738,-0.0906445,0.277752,0.0535671,-0.00781726,-0.533526,-0.233542,0.298062,0.249219,0.0643071,0.356695,0.163543,0.291017,-0.0575845,-0.424629,-0.0407093,0.433842,-0.438006,-0.0746729,-0.310153,0.072164,0.550539,-0.0801145,0.0564038,0.0428664,-0.300611,0.340188,-0.117531,0.30695,-0.387389,-0.221682,-0.268907,0.514582,-0.0177628,0.453662,0.164206,-0.0669797,-0.417583,-0.538941,-0.193458,-0.488634,-0.481949,0.524546,-0.33406,0.628081,0.579022,-0.0614426,0.0787421,-0.437665,0.240178,0.12504,-0.0954109,-0.684298,0.157249,-0.180179,0.780555,-0.532846,-0.0078584,0.330919,-0.0428736,-0.216105,0.175024,0.522247,-0.174051,0.25555,-0.166986,0.2708,-0.1582,-0.0140755,0.658436,-0.567178,-0.204896,-0.302725,-0.2501,-0.14275,-0.800747,-0.218071,-0.171337,0.595841,-0.375963,0.166235,0.301181,0.0593618,0.205821,0.0265217,-0.127765,-0.621525,-0.323035,-0.124653,0.189355,-0.0890467,0.394038,0.0530325,-0.259439,0.033186,0.315236,0.148566,-0.463886,0.718546,-0.606664,0.143104,0.292788,-0.0528893,0.190142,-0.707862,0.192068,0.376464,0.355405,-0.0525554,-0.464371,-0.0236167,-0.14833,0.135143,-0.10092,0.217566,0.45822,0.2264,-0.164545,0.0055144,-0.267616,0.167212,-0.222069,-0.493286,-1.02253,-0.151726,-0.705866,-0.0627958,0.439668,0.20686,-0.306927,0.252041,0.376736,-0.185093,-0.0948597,0.0710371,-0.40591,-0.367293,0.111815,0.114958,-0.258903,-0.166225,-0.230107,-0.583527,1.15984,-0.243617,-0.194875,-0.3208,-0.389584,-0.150196,-0.0846003,-0.0793688,0.273879,-0.207278,0.252555,0.0957509,-0.181289,-0.078432,0.212768,-0.174305,-0.375306,0.184738,0.794902,-0.0996682,-0.309188,0.392041,-0.157853,0.0483331,0.0147303,-0.520506,-0.2457,-0.872857,0.719686,-0.00392991,0.252163,0.602237,-0.161658,-0.242483,-0.105941,-0.158542,0.468693,-0.241388,-0.0702992,-0.00454039,-0.0316676,0.00932723,-0.694528,-0.119778,-0.105532,0.497433,-0.366518,-0.639343,0.326904,0.0789112,0.149872,0.0319145,-0.199477,0.419307,0.927667,-0.440231,-0.309278,0.335876,-0.0334851,-0.347628,0.156787,0.0509942,-0.627885,-0.404439,-0.593061,-0.229303,0.251195,0.168406,-0.104592,0.327254,0.132828,0.160716,-0.0525492,0.135805,0.295124,-0.203146,-0.132444,0.0698284,0.379337,0.0561113,0.10208,0.267895,-0.456964,-0.0668029,-0.0640103,-0.342545,0.294375,0.358586,-0.380957,-0.550225,-0.154805,0.0354893,0.00535351,-0.363116,0.123458,0.189177,0.351366,0.434945,-0.900201 +3438.18,0.999556,0.0912059,4,1.64778,1.14354,-0.302819,0.0433488,0.367189,-0.125786,0.664236,-0.0669588,0.0905957,0.656881,-0.110706,0.16919,-0.375294,0.145799,0.185846,0.68652,0.0443078,-0.0147942,-0.220248,0.0919764,-0.57627,-0.895582,-0.610582,0.0336966,-0.077403,0.0381803,0.356964,0.142713,0.00137539,0.121827,0.523271,-0.249682,0.0890654,0.408978,-0.0565508,-0.193619,-0.372241,0.268334,0.0909034,-0.681729,0.596979,0.584846,0.441375,-0.2208,-0.426999,-0.25303,-0.389724,-0.096357,-0.0400563,-0.264639,0.160242,-0.512899,-0.311091,-0.723272,0.592875,0.128635,-0.0199499,-0.333604,0.0355207,-0.151192,-0.0536123,0.848038,-0.499426,-1.49422,0.178101,0.119009,0.12597,0.367006,-0.122599,-0.688972,-0.106926,0.292653,0.251897,0.0266678,0.515825,0.254897,0.277536,0.0526293,-0.375312,0.0908689,0.793168,-0.606896,0.0811552,-0.431039,0.0547628,0.273016,-0.422269,-0.160036,0.21043,-0.225286,-0.0349343,-0.309437,0.0324105,-0.313808,-0.256716,-0.30813,0.810842,-0.0846708,0.00263796,0.290009,-0.450536,-0.536801,-0.454302,-0.114673,-0.134393,-0.450243,0.352392,-0.27944,0.280497,0.48915,-0.0874736,-0.197907,-0.264864,0.217361,-0.207185,-0.31939,-0.430913,0.492381,-0.0441307,0.848274,-0.701459,0.229445,0.0642571,-0.00983393,-0.242073,0.0938619,0.405291,-0.041038,-0.0457552,-0.311854,0.533651,0.0411944,-0.092229,0.653657,-0.40458,-0.347582,-0.407292,0.0717693,-0.0755867,-0.697021,-0.191912,-0.129773,0.237894,-0.401579,0.306863,0.0392795,-0.228825,0.29753,0.229918,-0.183522,-0.0283705,-0.252275,-0.115979,0.312511,0.0462273,0.829146,0.2533,-0.482428,0.0362791,0.0427394,-0.0678418,-0.76553,0.867677,-0.468737,0.035695,0.288078,-0.249733,0.414014,-0.635663,0.10445,0.273044,0.432294,0.0154294,-0.203261,-0.0840785,-0.05599,0.0182664,-0.110136,0.0900297,0.581915,0.420587,0.258007,-0.286534,-0.204428,0.187,0.257127,-0.404945,-0.881477,-0.0199702,-0.890134,-0.0659542,0.263304,0.364292,-0.21116,0.118061,0.337625,0.0314067,-0.0560814,0.110395,-0.185953,-0.223673,-0.240298,0.224569,-0.337241,-0.10233,-0.295085,-0.512104,1.09924,0.156749,-0.0384511,-0.461313,-0.239432,0.0102528,0.0150395,-0.271922,0.201074,-0.210705,0.221161,0.0714489,-0.337535,-0.286938,-0.0357217,-0.115735,-0.161847,0.348324,0.51524,-0.319883,-0.402388,-0.17837,-0.0928644,-0.0465106,-0.118844,-0.496479,-0.222357,-0.694592,0.638652,0.0720206,0.365337,0.461871,-0.221868,-0.402088,0.372842,-0.295302,0.384683,-0.09302,-0.0199173,0.0232691,0.0585197,0.173196,-0.451941,-0.110147,-0.327302,0.219275,-0.398688,-0.472685,0.24302,0.147398,0.0625435,-0.0669582,-0.372954,0.251225,0.955634,-0.217499,-0.141941,0.458837,0.294415,-0.119226,-0.0608533,0.177987,-0.760798,-0.373781,-0.573357,0.0567068,-0.0503616,0.191331,-0.199382,0.527725,0.406046,0.223734,-0.272386,0.101129,0.367702,-0.281762,-0.0481973,0.179866,0.167855,-0.258074,-0.0870142,0.150058,-0.0564607,-0.0927988,-0.378399,-0.322757,0.211654,0.40849,-0.465387,-0.360091,-0.488943,0.114875,-0.346874,-0.104005,0.114355,0.15323,0.338165,0.391446,-1.44349 +3435.63,1,0.0912059,4,1.55201,1.02441,-0.380782,0.125778,0.422924,-0.0442472,0.404238,0.0895874,0.235756,0.581224,0.247894,-0.0151803,0.131901,0.531764,0.0170074,0.737365,0.00718311,0.370213,-0.185877,-0.138884,-0.427527,-0.700733,-0.868105,0.0477031,0.167036,-0.149565,0.170429,0.542768,-0.142447,0.359168,0.426223,0.0769108,0.384481,0.530791,-0.107505,-0.0224289,-0.380776,0.225798,0.716004,-0.363874,0.728891,0.844282,0.56086,-0.561325,-0.201528,-0.0614145,0.19702,-0.149639,0.317699,-0.420744,0.205533,-0.213155,-0.0560491,-0.882166,0.555034,0.114722,-0.0262517,-0.632937,0.200352,-0.106104,0.000208808,0.888653,-0.445879,-0.989637,-0.12249,0.0842038,-0.15592,0.0704224,0.132019,-0.751098,-0.436341,0.466158,0.402176,-0.0598449,0.837711,0.650716,0.0184523,0.266505,-0.407107,0.322104,0.617402,0.0126185,0.189192,-0.238414,-0.0906423,0.0182275,-0.541801,-0.569648,-0.0465315,0.176442,0.363352,-0.277391,0.104893,-0.477608,-0.118795,-0.166062,0.706297,-0.742697,-0.0793507,0.230575,-0.310676,-0.0465789,-0.80643,-0.131311,-0.306103,-0.743995,0.150394,-0.180321,0.251492,0.559766,0.0793204,-0.561626,-0.264759,0.423465,0.0269074,-0.111788,-0.659547,0.237847,-0.0615523,0.544669,-0.602622,-0.348683,-0.0611238,-0.595334,-0.681276,-0.06893,0.793787,0.0605999,0.321065,-0.33627,0.226407,-0.12809,-0.125648,0.505522,-0.205102,-0.576996,-0.461276,-0.307479,0.357717,-0.71566,-0.357454,0.103001,0.102707,-0.453868,0.0506724,-0.0446497,-0.044753,-0.205467,-0.196564,0.25861,0.186496,-0.197266,0.228273,0.109372,0.262123,0.221872,0.171487,-0.26103,0.0232862,-0.55978,0.384327,-0.0596038,0.77216,-0.278122,-0.509658,0.277911,0.0317751,0.584097,-0.640662,-0.188796,0.203278,0.409433,-0.148173,-0.495077,-0.288493,-0.208468,-0.408697,-0.397338,0.473766,0.307598,-0.242499,0.415984,-0.0321959,-0.483535,0.755529,0.566758,-0.380571,-0.236583,-0.0166058,-0.526504,-0.0237232,-0.200953,0.325804,-0.732088,0.0573282,0.436326,0.131974,0.116809,0.0908055,0.0593952,-0.206715,-0.600384,0.418675,-0.195223,0.229474,-0.408651,-0.759188,1.09326,-0.253189,0.411908,-0.117981,-0.326252,0.549817,-0.205525,-0.100195,0.543291,-0.204797,0.205304,0.0836539,-0.391209,-0.341711,-0.599745,-0.0299963,-0.0817885,0.18094,0.63318,-0.684595,-0.578662,-0.0639699,0.088268,-0.104654,0.199308,-0.133681,-0.0108032,-0.902383,0.587491,-0.095192,-0.131732,0.318523,-0.520734,-0.286806,0.0190803,0.209185,0.816613,0.672156,0.25761,0.0510962,0.39114,0.0678848,0.00928593,0.132142,-0.582311,0.291218,-0.145605,0.0210992,0.191936,0.108043,0.125168,0.118976,0.110193,0.54151,0.529195,0.192343,0.0448313,0.16307,0.272631,0.148671,-0.072317,-0.128381,-0.432876,-0.295667,-0.501898,-0.13662,-0.160856,0.0506784,-0.186198,0.532622,-0.42116,0.0133179,-0.225127,-0.113027,0.14291,-0.384073,-0.178382,0.118678,0.426557,-0.650723,-0.0680791,-0.178643,0.623713,0.196324,-0.326972,-0.471269,-0.39362,-0.0756854,-0.618036,0.0083166,-0.11879,0.113522,-0.295738,-0.0630704,0.146244,0.185045,0.382419,0.430169,-1.57128 +3427.73,0.988758,0.0912059,4,1.59543,0.986426,-0.975572,0.307187,0.226981,-0.137772,0.838333,-0.207752,-0.0882325,0.131799,-0.0679316,-0.0546208,-0.124215,0.283145,-0.0188126,0.625412,0.312687,-0.351958,-0.16776,0.0364326,-1.00058,-1.21012,-0.657617,0.101058,-0.355293,-0.441967,0.246707,0.430697,-0.263252,-0.0510879,0.462372,-0.389126,0.102716,0.0626687,-0.388723,-0.400112,-0.228406,0.845693,0.0046396,-0.469796,0.632825,0.225091,0.0644673,-0.563172,-0.054933,0.149717,-0.346209,0.316258,0.0180613,-0.00837696,0.104069,0.624573,0.0775259,-0.432765,0.297935,-0.042324,-0.256909,-0.161181,0.368351,-0.207477,-0.0489418,0.726727,-0.658499,-0.878697,-0.13235,-0.253806,-0.1839,0.0777768,-0.510716,-0.354932,-0.367615,0.363371,0.488698,0.322385,0.789415,0.311824,0.650484,-0.0863722,0.198182,0.183521,0.355969,0.178712,-0.0249962,-0.355431,0.166492,-0.1232,-0.217954,0.324841,0.333656,-0.418828,0.452919,0.287669,-0.236184,-0.0302601,-0.0940084,0.127545,-0.206059,0.0422935,0.450278,0.700455,0.107849,-0.34629,0.140213,-0.623643,-0.0515919,-0.0546364,0.125555,-0.0455545,0.498083,0.324129,0.0189661,-0.042558,-0.0409337,0.569613,0.160343,0.0553299,-0.789958,-0.00635747,0.0886373,0.351461,-0.806027,0.143042,0.0660891,0.0876784,-0.546081,0.431429,0.176864,-0.162488,-0.155749,-0.23385,0.258046,-0.119571,-0.354855,0.83382,-0.0512926,0.0706714,-0.0810378,0.349936,0.679669,-0.0672647,-0.53041,-0.366751,0.103301,-0.593881,0.365054,-0.0107899,0.15132,0.460324,0.278641,0.140084,-0.156136,-0.0529322,-0.325357,-0.0626286,0.384237,0.35128,-0.0217053,0.0497925,0.174628,0.745011,-0.280369,-0.272454,0.411493,0.0580281,-0.0629787,-0.0815453,0.198967,-0.0664546,0.0846386,-0.329095,0.17816,0.0524197,0.315816,-0.243726,-0.0414933,0.474504,-0.32,-0.428,0.32242,0.961504,0.0582703,-0.341514,0.106599,-0.011333,-0.0202051,-0.117249,0.135269,-0.41579,-0.0144005,-0.636826,0.0292832,-0.519677,-0.0822149,-0.442679,-0.103173,0.421851,-0.222288,0.479679,-0.795887,0.0912755,-0.183577,-0.0519881,0.345623,-0.217786,0.188588,-0.0110807,-0.471511,1.06635,0.092651,-0.024567,0.183987,-0.0692379,-0.369765,0.232645,-0.777387,0.212187,-0.81948,0.675537,0.494384,0.407689,-0.341178,-0.476548,0.557964,-0.238614,-0.508389,0.539425,-0.0073244,-0.338762,0.355067,-0.0089906,-0.867216,0.152176,-0.250963,-0.415254,-0.306038,0.478245,-0.169404,0.146615,0.86577,-0.346333,0.0713634,0.423172,-0.615858,0.00769533,0.81591,0.107497,0.300276,-0.147656,-0.116095,-0.622687,0.238197,-0.541088,-0.0351191,-0.176622,-0.172208,0.0820823,0.0287432,0.577799,0.529437,-0.075229,-0.209418,0.677584,-0.354719,0.372018,0.370115,0.0982999,-0.253596,-0.113689,-0.279581,0.23014,-0.0116824,-0.415973,-0.728925,0.464959,-0.276488,-0.127314,-0.0875735,-0.238599,-0.213884,0.252504,0.163902,-0.0481495,-0.385641,0.537747,0.199582,-0.184147,0.297845,0.937279,0.46086,0.752089,0.0237563,0.243981,-0.109646,0.0464759,0.10171,-0.0689119,-0.0472835,0.079732,0.392197,0.148645,0.431962,0.149645,0.187246,0.38684,0.432719,-0.646345 +3436.53,0.987635,0.0912059,4,1.55236,0.846111,-1.1238,0.486288,0.289914,0.0791485,0.18373,0.0857099,0.298113,0.119793,0.160766,0.376925,-0.392561,0.481493,-0.136552,0.56221,0.168806,-0.048471,0.010496,-0.315247,-0.00136974,-0.942965,-0.216861,0.433359,0.346782,-0.141193,0.257345,0.378144,-0.141806,0.192493,0.75803,-0.255659,0.0232285,0.347018,-0.539397,0.0931755,-0.500573,0.475242,0.485289,-0.292075,0.316591,0.490645,0.366811,-1.04043,-0.108462,0.309264,-0.551219,0.193028,0.120565,-0.200008,0.143751,0.0227756,0.169678,-0.30022,0.312227,-0.385727,-0.163892,-0.676075,0.0480752,0.0434046,0.541568,0.536917,-0.762329,-0.331342,-0.115886,0.303434,-0.0176924,0.392651,0.439838,-0.0458159,-0.584396,0.380396,0.597982,-0.37087,0.570358,0.259406,0.638982,-0.269919,0.24601,0.27869,0.861974,-0.604274,0.105314,-0.363387,-0.175377,0.381259,-0.162531,-0.114501,-0.189633,-0.254593,0.142933,0.114259,0.0237253,0.0473254,0.269167,-0.166804,0.22245,0.224681,0.261517,0.650732,0.624895,-0.423515,-0.179972,-0.257278,0.350104,-0.216133,-0.145545,0.0579946,0.322785,0.405124,-0.109957,-0.21435,-0.275613,0.4086,-0.252159,0.349204,-0.853289,0.167248,0.0978132,-0.22533,-0.943633,0.0202519,-0.109015,-0.218707,0.00264906,0.557726,-0.23063,0.175167,-0.0148819,-0.74779,0.457188,-0.124372,-0.616606,0.504821,-0.0880339,0.0378054,0.309233,-0.245863,0.459175,-0.0765929,-0.307111,-0.0464159,0.0097822,-0.11982,-0.0339139,0.280042,0.264208,0.518044,0.0333808,-0.019321,-0.0539773,0.27661,0.147787,0.296917,0.265274,0.130969,0.200337,0.365292,0.439945,-0.513862,0.335277,0.370581,0.386031,0.0593463,0.128804,0.294203,0.165395,0.215521,-0.131904,-0.185004,-0.111574,0.115573,-0.0854432,-0.171662,-0.0533867,-0.0323906,-0.0912311,0.44548,0.166206,1.0255,-0.0583901,-0.210173,0.136615,-0.110636,0.134678,-0.16241,-0.00492455,-0.789104,0.304854,-0.48765,0.237678,-0.229173,-0.151094,-0.585974,0.351408,0.139648,0.250115,-0.0633458,0.0600676,0.144922,-0.115887,-0.154553,0.520604,-0.256279,-0.175284,-0.0657656,-0.381591,1.06894,-0.24915,-0.250495,-0.253752,0.178679,0.453279,0.410295,-0.784714,0.455218,-0.718464,0.739467,0.281913,-0.14552,-0.208343,-0.501899,-0.101627,-0.075369,0.127135,0.70254,-0.311386,-0.255854,0.191878,-0.101664,-0.0867243,0.247393,-0.338387,-0.328669,0.0164976,0.547753,-0.0840591,0.493404,0.439696,0.119274,0.295922,0.864221,-0.650865,-0.176882,0.170348,0.336745,0.444597,-0.330923,0.0779153,0.0417811,-0.300343,-0.590113,0.113465,-0.147353,0.355955,-0.0180244,-0.465766,0.349976,-0.0315291,-0.269093,0.101769,0.0455439,0.206827,-0.358921,0.261665,0.196633,-0.0751314,0.432695,-0.335204,-0.122181,0.0273601,-0.412789,0.272204,-0.130331,0.717511,0.28455,0.903312,-0.236462,0.103608,0.397867,-0.679087,-0.519366,-0.409834,-0.312274,0.262729,0.226093,-0.535307,0.276174,0.146037,-0.248664,0.0871981,0.0308936,-0.0663639,-0.0490318,-0.445762,-0.406553,-0.438683,0.17059,0.13215,0.776864,-0.0212934,0.108556,0.108251,0.329478,0.329015,-0.796478 +3431.94,0.907234,0.0912059,4,1.63221,0.802818,-1.06071,0.400378,0.230988,-0.0795459,-0.0030384,0.25364,-0.0618233,-0.109556,-0.0841308,-0.189802,-0.445651,0.242017,0.0828676,0.958448,0.506391,-0.786843,-0.429707,0.118143,-0.196885,-0.648602,-0.745899,0.344779,-0.230716,-0.0872157,-0.25412,0.0223473,-0.317458,-0.12342,0.59739,-0.427189,-0.398829,0.206795,-0.650189,-0.478859,-0.171344,0.127734,-0.404854,-0.352699,0.674439,0.322078,0.114395,-0.836099,-0.110089,-0.288604,0.27351,0.21565,0.0521638,-0.0652771,0.073097,0.66853,0.0846884,-0.749092,0.648313,0.215558,-0.243124,-0.393694,0.329574,-0.281393,-0.453929,0.946689,-0.747463,-0.938723,0.637577,-0.0370424,-0.0964095,0.00995476,0.122628,-0.456689,-0.0532066,0.343809,0.91786,-0.135257,0.158645,0.422355,0.703193,-0.254527,-0.00331908,-0.0437288,0.28185,0.250831,0.0877163,-0.358083,-0.120538,0.466735,-0.578804,-0.48154,0.207905,-0.159293,-0.110294,-0.00130062,0.121802,0.154889,-0.397254,-0.131518,0.348885,0.163474,0.139538,0.270153,0.219058,-0.372082,-0.635336,-0.619874,0.163764,-0.52131,0.261049,0.0812548,0.581624,0.702945,0.172221,-0.131143,-0.366584,0.325509,-0.0969247,-0.0402998,-0.554208,0.0821231,-0.18879,0.4877,0.0772567,0.0176115,-0.426387,-0.653317,0.281283,0.0685619,0.0262007,0.316088,0.259719,-0.262659,0.280096,0.179958,0.0702668,0.542237,-0.547567,0.14253,-0.362917,0.275019,0.318747,-0.266146,-0.486469,-0.349441,-0.608095,-0.0362649,-0.328742,0.349939,-0.0168633,0.493132,0.0257684,0.294635,0.268834,0.0339723,0.383844,-0.0708972,0.0243294,0.123784,-0.160957,0.136159,0.341631,0.243017,-0.331497,0.0323307,0.744653,0.517925,-0.434576,-0.377256,0.171642,-0.335238,-0.161511,-0.794046,-0.272837,-0.0403579,-0.0287222,0.254409,-0.0843982,0.310511,-0.11344,-0.25698,0.136705,0.584652,0.482897,0.0738106,0.526382,-0.443964,-0.298349,-0.929503,-0.237103,-0.144123,-0.173901,-0.44797,0.345529,0.122399,-0.0779736,-0.614895,0.288083,0.519474,0.235794,-0.650145,-0.497701,-0.0143798,-0.206141,-0.493467,-0.299011,-0.440115,0.271578,0.0621113,-0.385653,1.05943,0.191821,0.00824729,-0.187494,0.089094,-0.105221,0.256482,-0.145413,0.517266,-0.115484,0.433841,0.392718,0.0053446,0.38583,-0.0979542,-0.162207,0.0920493,-0.359953,0.548697,-0.632328,-0.700424,0.338693,0.00265127,-0.0519639,-0.145076,-0.744562,-0.0805042,-0.0419806,0.288842,0.102909,0.348297,0.426541,-0.13165,-0.0756341,0.217365,0.233444,-0.764273,0.564302,0.43572,0.411238,0.0283269,0.123228,-0.553439,0.33884,-0.526944,0.246554,-0.358723,0.139218,0.278952,-0.299355,0.110656,-0.0257015,-0.304442,-0.0549407,0.493786,-0.138071,0.160683,0.329784,-0.380425,-0.193541,-0.0484236,-0.386584,-0.198578,-0.0936115,-0.519512,-0.703618,0.301985,-0.0865765,0.0414607,-0.0011479,0.11592,0.109014,0.66204,0.368872,-0.0322832,-0.688175,-0.00632373,0.155337,0.310001,0.0174497,0.0223638,-0.238193,0.0237789,-0.247215,0.278094,0.127943,-0.17612,0.0313533,-0.708171,0.131496,-0.245815,-0.370994,-0.333144,-0.149623,0.141757,0.210735,0.376506,0.459059,-0.356468 +3434.23,0.995891,0.0912059,4,1.64358,0.896169,-0.959267,0.3402,0.24015,-0.065386,-0.222651,0.0151939,0.167649,-0.218839,-0.219922,-0.231248,-0.488196,0.24085,-0.1332,0.891301,0.217988,-0.467467,-0.789202,-0.0367327,-0.161862,-0.508819,-0.777349,0.42997,-0.194806,-0.162638,-0.190286,0.0317328,-0.22295,-0.0862423,0.581694,-0.55842,-0.194067,0.253649,-0.54155,-0.180982,-0.308846,0.198269,-0.11236,-0.632175,0.725307,0.616638,0.174644,-0.730312,-0.0565453,-0.220436,0.122809,0.163106,0.0824279,-0.277418,0.1289,0.613443,0.175537,-0.806621,0.624647,0.0413286,-0.236613,-0.74226,0.239095,-0.566727,-0.232688,0.838026,-0.434632,-0.870816,0.480524,0.0677282,-0.0939203,0.325243,0.0142783,-0.168315,-0.0249081,0.586888,0.899928,-0.0579273,0.425981,0.407205,0.816952,-0.342489,-0.00386293,-0.0272114,0.37553,0.0785158,0.283348,-0.282117,-0.388833,0.583279,-0.676152,-0.485591,0.519731,0.0568339,-0.00492601,-0.0719176,-0.14335,0.215012,-0.0143957,-0.142266,0.150957,0.207857,0.0120215,0.43208,0.109465,-0.175993,-0.559384,-0.954274,0.00442794,-0.510037,0.364567,0.160579,0.511613,0.7085,0.331548,-0.238998,-0.370558,0.335153,-0.244654,-0.0611093,-0.34008,0.182194,-0.00411572,0.23465,-0.069153,-0.177044,-0.255576,-0.60313,0.392583,0.124273,0.207387,0.332112,0.673875,-0.389449,0.182292,0.0689553,0.0182925,0.355164,-0.319935,0.196567,-0.422784,0.194446,0.322093,-0.442016,-0.506432,-0.334198,-0.624222,-0.106462,-0.220966,0.280276,-0.101955,0.586143,0.0464685,0.325117,0.291574,-0.186376,0.339014,-0.186723,-0.0742547,0.14568,-0.107029,-0.112279,0.380925,0.00838047,-0.163261,0.0481371,0.810053,0.453421,-0.760774,-0.489335,0.0995171,-0.492154,-0.35716,-0.6256,-0.29816,-0.141672,-0.0203691,0.299963,0.0428532,0.359896,-0.0305824,0.0889035,0.00480687,0.638434,0.265307,-0.0311627,0.385705,-0.409449,-0.375346,-0.874646,-0.518615,-0.13191,-0.000522039,-0.11471,0.190377,-0.2923,0.0950109,-0.566114,0.407367,0.888509,-0.123652,-0.634287,-0.603663,-0.0945283,-0.322813,-0.228499,-0.297668,-0.322236,0.303144,-0.000574454,-0.538983,0.936804,0.132321,0.249267,-0.320634,0.151856,0.0789667,0.200935,0.0639196,0.37987,0.120358,0.50998,0.328107,0.141544,0.350554,-0.0718151,-0.138727,0.137547,-0.519008,0.370001,-0.695418,-0.532768,0.219896,-0.0313982,-0.133295,-0.150087,-0.578112,-0.0719288,-0.0578548,0.162179,0.240219,0.206936,0.621466,-0.229765,-0.0407605,0.233801,0.49919,-0.890687,0.813163,0.414803,0.34386,0.256209,0.132761,-0.464967,0.268301,-0.734028,0.432515,-0.236811,0.282837,0.228932,-0.282257,0.038824,0.0305803,-0.347897,0.236811,0.425083,-0.360375,0.208338,0.428488,-0.0761642,0.0217414,-0.0455018,-0.30266,-0.528255,-0.0241775,-0.414062,-0.85993,0.238127,-0.239383,0.134359,0.0220073,-0.0974031,0.191368,0.646006,0.165727,-0.0703194,-0.94236,-0.21112,0.265284,0.308472,0.195209,-0.0898713,-0.262855,-0.114788,-0.372488,-0.116147,0.32216,-0.391501,0.213395,-0.494314,0.48043,-0.0708095,-0.0585516,-0.376167,-0.396522,0.142446,0.18997,0.377421,0.435856,-0.540322 +3415.69,0.898854,0.0912059,4,1.61652,0.706092,-0.763976,0.229358,0.205372,0.0109415,-0.163109,-0.242952,0.351747,-0.185423,-0.204114,-0.0126878,-0.418787,0.39012,-0.28511,0.395174,0.111998,-0.0801335,-0.348364,0.0207488,-0.17395,-0.547692,-0.695168,0.472753,-0.00310993,-0.160955,0.117397,0.224894,-0.523688,-0.0283899,0.820756,-0.0991962,-0.000606398,0.707612,-0.255608,-0.0700318,0.00433892,0.366489,0.23906,-0.605795,0.566638,0.744099,0.174924,-0.91793,-0.213809,0.293398,0.135851,0.506909,0.603071,0.210296,0.426347,-0.0022032,0.399298,-0.49443,1.12763,0.210404,-0.392453,-0.893816,0.37458,-0.178442,-0.0962623,0.774562,-0.529771,-0.628398,0.102332,0.288263,-0.205746,0.216282,-0.109671,-0.0673646,-0.0753432,0.503429,0.927932,-0.625595,0.832407,0.603936,0.294055,-0.239905,-0.247413,0.0798929,0.168577,-0.165521,-0.0209967,-0.613406,-0.0321952,0.179868,-0.425104,-0.694928,0.0483197,-0.0888163,-0.206719,-0.129975,-0.158203,0.094923,0.160205,0.297214,-0.0553048,-0.245736,-0.437577,0.469343,-0.0480698,-0.375051,-0.652309,-0.666674,0.0319188,-1.00154,0.261783,-0.331032,0.609034,0.327962,0.0375684,-0.12645,-0.342286,0.215903,-0.456857,-0.0154593,-0.511135,0.0256972,0.53154,0.0762258,-0.434929,-0.245719,0.316764,-0.331209,0.431131,0.499652,-0.368258,0.199351,0.323862,-0.792253,0.0899123,-0.0057049,-0.451902,0.28433,-0.371617,-0.263162,0.239746,0.175878,0.532238,-0.580791,-0.319598,0.00321947,-0.387167,-0.0916146,0.357337,0.184859,0.328865,0.149681,0.14687,-0.0338812,-0.119113,-0.130263,0.0920161,0.17337,-0.230396,0.800702,0.0349033,-0.102453,-0.00252675,-0.530477,-0.264518,0.157041,0.761982,0.149551,-0.92864,0.272015,0.123681,-0.276286,-0.778872,-0.137537,-0.0673697,-0.439943,-0.213941,-0.118903,0.28186,-0.282188,0.0622863,-0.215737,0.187539,0.506563,0.220754,-0.151251,0.337892,0.537079,0.00346369,0.0581933,-0.153941,-0.0803634,0.288371,0.0694629,-0.0439503,-0.0393031,0.311535,-0.250318,-0.0160088,0.650563,0.048943,-0.594543,-0.830826,-0.382013,-0.361566,-0.569583,-0.392138,0.243711,-0.286951,0.393108,-0.573714,0.834452,0.460693,0.0636103,-0.139663,0.0714956,0.074346,-0.0430904,0.123519,0.622283,0.0785753,0.819572,-0.376432,0.356927,0.554724,-0.716647,0.588912,-0.892902,-0.849715,0.537735,-0.249611,-0.0513258,0.1587,-0.428917,-0.293001,0.0867063,-0.555216,-0.00578524,-0.095111,0.708244,0.345599,0.279844,0.284518,-0.599175,-0.0942512,-0.0703614,0.326624,-0.525139,0.510534,0.441096,0.452564,0.28436,0.238563,-0.425964,-0.0791186,-0.908433,0.46532,-0.0985915,-0.187387,0.272437,0.116249,-0.226988,0.240529,-0.163009,0.469714,0.652011,-0.693104,0.222854,0.317457,0.280187,0.161491,-0.352764,0.118441,-0.2332,-0.137407,-0.271528,-0.819642,0.584967,-0.0781389,-0.157304,0.0697562,-0.0464923,0.40983,0.493508,-0.106817,0.0704394,-0.698583,-0.545591,-0.0996138,-0.00736093,-0.28943,-0.39081,0.0701318,-0.248789,-0.0527234,0.338381,0.275378,-0.514992,-0.193355,-0.316825,0.629578,-0.0809605,-0.383615,0.141254,0.210699,0.143569,0.162635,0.378905,0.403281,-0.132455 +3416.96,0.822237,0.0912059,4,1.49405,0.733403,-1.25185,0.40778,0.682841,0.0432588,-0.786113,0.109133,0.235313,-0.018205,0.0381728,-0.0726012,-0.278311,0.0816613,0.272717,0.687179,0.154454,0.146103,-0.0875478,0.0166978,-0.0953179,-0.458781,-0.801393,0.55677,-0.0767396,-0.315851,-0.128918,0.662515,-0.925146,0.0978015,0.521964,-0.603339,0.105148,0.46045,0.0840988,0.0351259,-0.114509,-0.19015,0.565444,-0.061452,0.953082,0.719492,0.275538,-0.220762,0.125147,0.137186,0.383597,0.0358461,0.318454,0.116776,0.638784,0.277971,0.0299084,0.101722,1.06717,0.31918,-0.461504,-0.418758,0.359016,-0.241798,-0.576091,0.823418,-0.397881,-0.978736,0.195896,-0.0608933,-0.38589,0.204245,0.188306,0.0250145,-0.108533,0.0249083,0.942711,-0.273171,0.592566,0.47776,0.247702,-0.492146,-0.165257,0.215257,0.441468,-0.00391711,0.3484,-0.24877,-0.0682956,-0.33651,-0.11089,-0.340032,0.0499048,-0.00517167,0.074347,0.230204,0.00712104,-0.11928,-0.104407,-0.0709023,0.0337613,-0.276577,-0.226106,0.444671,-0.0268916,-0.532654,-0.167955,-0.40693,-0.0379484,-0.0632845,0.643149,-0.0760265,0.153783,-0.133105,-0.547978,0.0960732,-1.03156,0.437917,-0.39708,0.674916,-0.323904,0.0905901,-0.0459134,0.073729,-0.719742,-0.500352,0.415588,-0.080329,0.401544,-0.300038,-0.3834,0.616007,0.760322,-0.518815,-0.151829,0.180376,0.106672,0.598936,-0.242327,0.0205613,-0.234889,-0.133362,0.417896,-0.265069,-0.0155046,-0.217706,0.0953558,-0.260545,0.305631,-0.405998,0.0215237,0.224638,0.156762,-0.0877692,0.0728334,-0.179057,0.215775,0.0389239,-0.611214,0.278022,0.32879,-0.448534,-0.100607,-0.312691,0.32989,-0.0353416,1.11483,-0.290131,-0.505934,0.0395702,-0.230131,0.0794011,-0.788561,-0.13553,-0.0034175,-0.697225,-0.215202,-0.197551,0.196848,-0.544935,0.0988719,0.248773,0.6473,0.516861,0.0765352,0.091962,0.421639,0.334823,0.187272,0.397455,0.507616,-0.404752,0.303673,-0.292924,0.376713,-0.136657,-0.229914,-0.307867,0.568843,0.0632654,-0.0415069,-0.0857315,-0.790599,-0.384803,0.024665,-0.608599,-0.12891,-0.0119247,-0.386654,0.233852,-0.450443,1.26919,-0.0647324,0.483087,0.0540471,0.156495,-0.286117,-0.0644635,0.223808,0.264083,0.446767,0.399417,-0.00061591,0.164002,0.154062,-0.248557,0.328128,-0.0242008,-0.0389896,0.249762,-0.0710557,-0.393715,0.352044,-0.342047,-0.332921,-0.149938,-0.411392,0.0877987,-0.0499473,0.74726,0.148586,0.217446,0.871566,-0.289756,-0.632555,-0.252718,0.250735,-0.487558,0.144518,0.273381,0.277991,-0.0657731,-0.469513,-0.328741,-0.14229,-0.684893,0.422806,-0.524534,-0.467872,0.115711,-0.084973,-0.159861,-0.505183,-0.338185,0.0227511,0.0909501,-0.838496,0.0106277,0.503446,0.124096,0.056581,0.304331,-0.101522,-0.469955,-0.370785,-0.146714,-0.23011,0.453071,-0.279138,0.00325663,0.176708,-0.363615,0.119183,0.158034,-0.0618232,0.115418,-0.302584,-0.297901,0.318246,-0.264841,-0.116467,-0.239562,0.0481048,-0.772842,-0.142013,-0.644582,0.210816,-0.0834245,-0.327524,-0.654521,0.560714,0.279499,-0.646724,-0.166138,0.343399,0.140107,0.187829,0.374309,0.433392,-1.80925 +3425.72,1,0.0912059,4,1.47271,0.67336,-0.980246,0.408484,0.262584,-0.0750169,-0.448215,-0.0823994,0.310801,-0.139828,0.17962,0.0244115,-0.205862,0.446559,-0.0818169,0.507583,0.216145,0.202487,0.13145,0.314408,-0.152848,-0.68859,-0.400052,0.706849,-0.378356,-0.273534,0.339973,0.342002,-0.924151,0.51991,1.01426,-0.811417,-0.157511,0.743207,-0.538184,0.377281,-0.0186012,0.519116,0.620648,-0.0885802,1.0284,0.611489,0.171576,-0.542089,-0.273558,0.14106,0.095273,-0.0353846,0.732934,0.102214,0.456597,0.417842,0.186448,0.0990946,1.09281,0.00592785,-0.173284,-0.940117,0.756116,-0.438868,-0.176564,0.869335,0.00769001,-0.957095,0.313782,0.268441,0.168985,0.0373418,-0.323475,-0.350383,0.395948,0.750003,0.706419,-0.233989,0.927457,0.521731,0.380105,-0.386325,-0.0944836,-0.0697786,0.678783,-0.0551049,-0.276784,0.0592708,-0.324221,-0.537652,-0.388928,0.0450856,0.225772,-0.354532,0.0576977,0.409478,0.0295707,-0.448252,-0.129514,-0.530434,0.412831,0.00185634,0.328289,0.0619168,0.228127,0.094848,-0.928037,-0.328156,0.45083,-0.375701,0.313989,-0.018639,0.203059,0.543063,-0.0353071,0.035607,0.116985,0.0929715,0.669735,0.612787,-0.0874245,0.106775,0.509948,0.0560263,-0.817939,0.159155,0.181919,0.24953,-0.115316,-0.492691,0.27679,0.687458,0.218518,-0.266177,0.146567,0.270309,0.0345865,0.479678,-0.148646,-0.617174,0.20179,-0.256186,0.597617,-0.848928,-0.0863389,-0.211139,-0.149345,-0.160751,0.148598,-0.0601524,0.205157,0.278053,-0.278889,0.183774,0.0275214,0.0847303,0.448804,0.146534,-0.178709,0.686923,0.0791845,0.206436,-0.0789252,0.31015,0.447567,-0.0219417,0.787563,0.0862978,-0.0236347,0.46927,-0.192682,-0.452287,-0.82178,-0.467092,0.0963073,0.236857,-0.0291647,-0.0886499,0.221376,-0.295964,-0.257907,-0.151193,0.184682,1.00482,0.092086,0.140817,-0.244272,0.639497,-0.267174,-0.316832,-0.0464733,-0.23472,0.128254,0.0897243,0.278255,0.0700234,-0.107603,-0.132561,0.0616905,0.595222,-0.0562676,0.168754,-0.67429,-0.0357012,0.0901074,-0.486363,-0.143172,-0.303911,-0.744712,0.263507,-0.499043,1.03238,-0.362433,0.199387,-0.120046,0.160256,-0.625418,-0.00352171,-0.0474127,0.401889,-0.0391849,0.100773,-0.0559823,-0.00991218,-0.23655,-0.0990691,0.600899,0.19434,-0.853227,0.292153,-0.262729,-0.476938,0.0638623,-0.100935,-0.298037,0.113577,-0.43617,0.11996,0.0518174,0.0640229,0.532354,-0.131847,0.273876,-0.396844,-0.148665,0.0733126,0.455047,0.31809,0.283216,0.000822392,0.716231,0.471918,0.312182,-0.236555,0.164485,-0.799191,0.424591,-0.755259,-0.341684,0.185428,0.155964,0.00500194,-0.695874,0.0814293,0.131625,0.474427,0.0175494,0.578685,0.530935,-0.251167,0.192892,0.0925282,-0.539618,0.022926,0.20669,-0.379596,-0.193965,0.293228,-0.206762,-0.414318,-0.0739222,-0.274221,0.709708,0.0206774,0.0467063,-0.281266,-0.399855,0.405748,-0.292437,0.179798,-0.453683,-0.684046,0.426256,-0.269283,-0.154508,-0.101967,0.0343151,0.0823277,-0.246104,-0.270351,0.0784634,0.257213,-0.12031,-0.402246,-0.17151,0.119502,0.304477,0.345691,0.551794,-0.443084 +3422.62,0.746826,0.0912059,4,1.46901,0.659599,-1.33989,0.583693,0.701387,-0.180894,-0.807619,0.0739739,-0.187048,-0.0847328,0.294751,-0.225138,-0.12694,0.449446,-0.0213468,0.609961,0.19936,0.120716,0.173918,0.448323,0.153021,-0.770806,-1.07379,0.845622,-0.612662,-0.220545,0.0968182,0.403902,-0.547241,0.171061,0.971377,-0.718479,0.0186058,0.408738,-0.150621,0.496534,0.215867,0.59181,0.738307,-0.00900751,1.19967,0.458174,0.164534,-0.339525,-0.110978,-0.194937,0.214667,-0.0627432,0.510134,-0.125356,0.244961,0.572445,0.346064,-0.0700797,0.86396,-0.296068,0.011483,-0.818555,0.761112,-0.430772,-0.112768,0.769805,-0.273334,-0.696797,0.479982,0.252673,0.191337,0.376641,-0.155728,-0.372623,0.128716,0.537621,0.469825,-0.155093,0.832188,0.406572,0.47091,-0.587134,-0.146601,-0.123609,0.444256,-0.0918325,-0.068205,0.199663,-0.350392,-0.521591,-0.462318,0.37537,0.236381,-0.183287,-0.286747,0.453944,0.272303,-0.418288,-0.428939,-0.469518,-0.0881794,-0.414732,-0.201053,0.2046,0.081615,0.0546738,-0.987009,-0.308064,0.652548,-0.503168,0.433224,0.160308,0.0605575,0.498073,-0.271193,-0.578213,0.16652,0.227411,0.492017,0.429124,-0.169414,0.0220144,0.23096,0.254641,-0.436184,-0.0557084,0.216429,0.324761,-0.293049,-0.0510838,-0.154219,0.627831,0.38446,-0.237845,0.255774,0.198982,0.36629,0.734581,-0.111577,-0.440366,-0.0900517,-0.397076,0.336738,-0.767284,-0.0835638,-0.305111,0.128427,0.00833874,0.174955,-0.0264797,0.468151,0.242897,-0.198189,0.148328,0.493666,0.0601653,0.454052,-0.0343312,-0.416834,-0.125134,0.174599,0.0366308,-0.027004,-0.0143172,0.257346,-0.0511204,0.856774,-0.257346,-0.156132,0.507531,-0.00175477,-0.500144,-0.611568,-0.116091,0.265209,0.106495,-0.257741,0.0174434,0.209114,-0.55917,-0.541158,-0.286876,0.225446,0.717026,-0.0810861,-0.208338,0.0033055,0.0128427,-0.450925,-0.0951463,-0.403661,-0.0399821,-0.0691379,0.226059,0.254265,-0.289871,0.0906463,-0.237202,-0.121518,0.432941,-0.0322626,0.188425,-0.418503,0.0163889,0.0278355,-0.186603,-0.104086,-0.327519,-0.328937,0.33334,-0.551208,0.805137,-0.442942,0.649416,-0.0889934,0.175236,-0.505735,0.0980025,0.21475,0.140891,-0.181036,0.195348,0.306841,-0.086203,-0.280565,-0.0216968,0.25131,0.728051,-0.460184,0.434281,0.0589127,-0.120248,-0.147221,-0.0842708,-0.287176,-0.0473818,0.0456926,0.295098,0.330606,0.249472,0.975015,-0.0305092,0.524603,-0.588795,0.192594,0.0354397,0.331352,0.337411,0.594641,0.160602,0.160377,0.546358,0.0398924,-0.271921,-0.0375159,-1.11299,0.345306,-0.69028,-0.274277,0.101591,-0.0313765,-0.359955,-0.405412,-0.12287,-0.0358265,0.271876,0.202939,-0.203459,0.331078,-0.326706,0.257529,-0.0579302,-0.880557,0.0349351,0.304862,-0.519984,-0.323544,-0.0906906,0.249692,-0.0727842,0.089008,-0.247845,0.492406,-0.189968,0.0729822,-0.176103,-0.0409685,-0.17698,-0.342816,0.034447,-0.0400685,-0.87608,0.0896763,-0.243512,0.0590629,-0.00366214,-0.0771893,0.244516,-0.288552,-0.712596,0.160658,-0.0786731,-0.569643,0.140602,-0.210969,0.140414,0.295752,0.374718,0.543831,-1.82991 +3430.38,1,0.0912059,4,1.45279,0.782516,-1.60682,0.68775,0.341809,0.0190869,0.35539,-0.275307,0.235646,0.0669928,0.234679,-0.174597,-0.513649,0.434346,-0.138239,0.727975,0.190034,0.0226663,0.00813517,0.0544338,0.111461,-0.477978,-0.256038,0.256025,0.212933,0.081606,-0.00851901,-0.0278545,-0.3654,0.0631824,0.731055,-0.176368,-0.265242,0.157804,-0.440417,-0.45614,-0.124001,0.416925,0.280095,-0.111459,0.874797,0.583345,0.543977,-0.519624,-0.0322351,0.0241503,-0.904495,0.24931,0.11402,0.22601,0.0758469,0.615395,0.116923,-0.436473,-0.151578,-0.0441117,-0.310762,-0.328173,0.251166,-0.273237,0.788331,0.652607,-0.199523,-0.599787,0.0432062,0.305118,-0.162625,-0.047565,0.0878752,-0.288849,0.11991,0.0354528,0.707252,-0.256681,0.204024,0.397962,0.111647,0.433397,-0.528054,0.122922,0.446027,-0.802779,0.473495,-0.28211,0.213676,0.0174504,0.383999,-0.546731,-0.224538,-0.318426,0.136615,-0.153336,0.0143531,0.490739,0.458871,-0.161593,0.440679,-0.689128,0.199913,0.353924,0.104837,-0.263922,-0.181405,0.505447,-0.475922,-0.452496,0.00376237,-0.216624,0.509369,0.360629,-0.028709,-0.625608,0.324244,0.842038,0.0348763,0.0168991,-0.255237,-0.171174,0.327113,-0.370762,-0.511144,-0.0980234,-0.194591,-0.429651,0.197491,0.388776,0.587097,-0.709798,-0.00245873,-0.277473,0.29879,-0.0674872,-0.285199,0.197827,-0.24277,0.304943,-0.359411,-0.303239,0.217026,0.112026,-0.0475982,0.294927,0.0656693,-0.523862,-0.340018,0.16606,0.035122,0.535529,0.128339,-0.335266,-0.686172,0.252386,0.100517,-0.129415,-0.162109,0.837582,0.319369,-0.0338178,0.250366,0.199406,-0.0906198,-0.499777,0.546248,0.467303,0.381728,0.000756537,0.190477,-0.00223495,0.019866,-0.0296141,0.13868,0.0629282,0.570977,-0.203326,-0.0284907,-0.43834,-0.232435,0.199347,0.109219,0.909047,-0.331104,0.234379,-0.390257,0.0475677,0.255228,-0.0494535,-0.114793,-0.25975,0.564288,-0.64911,-0.158376,0.336622,-0.129205,-0.607771,0.245692,-0.258833,-0.235067,-0.544481,-0.293864,0.445974,-0.0838298,-0.61941,0.154548,-0.0511622,0.337922,-0.0810209,-0.182458,1.12231,0.23606,-0.0901701,0.367949,-0.239866,0.5929,-0.034791,-0.276485,0.659535,-0.219607,0.19238,0.118952,-0.0239261,-0.103868,-0.324149,0.196358,-0.58915,0.0316255,0.503297,0.014309,-0.270468,-0.0559167,0.0782331,-0.555277,0.559557,-0.415939,-0.856026,-0.433864,0.339268,-0.623752,0.00379511,0.633477,-0.353349,-0.459577,0.294142,-0.32639,-0.403854,-0.147218,0.0694039,0.552374,-0.141571,-0.0782209,-0.241065,-0.307236,-0.0061724,0.294933,0.0938834,-0.142531,0.0308044,-0.447408,-0.0547868,0.453953,0.257214,0.337138,0.288247,-0.217323,0.583871,0.0843408,0.178641,-0.175636,-0.122929,0.641974,0.147444,-0.349569,-0.256115,-0.0705907,0.255267,-0.381109,-0.438944,0.18274,0.337222,0.0969687,-0.145721,0.0136034,0.509467,-0.430008,0.572063,0.531849,0.291038,-0.172217,0.91,0.178746,-0.187526,0.267881,0.354472,0.370339,0.112727,-0.0536053,0.0546193,-0.563477,0.172206,0.174722,-0.586777,-0.0418176,0.136482,0.145717,0.369434,0.381729,-0.878149 +3439.38,0.562965,0.0912059,4,1.52905,0.631533,-1.58436,0.6729,0.683135,-0.116654,-0.195197,0.156162,0.26305,0.267278,0.2467,-0.18797,-0.455876,0.372678,0.0406343,0.770476,0.439183,-0.0454446,0.185512,0.492913,0.221078,-0.232142,-0.988353,0.273509,-0.311158,0.153958,-0.262758,0.0927173,-0.249937,0.0141156,0.862884,-0.502495,-0.0792757,0.224935,-0.220594,-0.383648,0.00637352,0.0514628,0.773875,-0.297109,0.6851,0.529476,0.191272,-0.427645,-0.354203,-0.426331,-0.221688,0.125344,0.11258,-0.285846,0.101699,0.385092,-0.284594,-0.190588,0.202571,0.0844328,-0.0766872,-0.164447,0.432129,-0.423882,0.442428,0.876945,-0.286634,-0.260991,-0.142518,0.593153,-0.139388,-0.183889,0.303535,-0.280026,0.0700491,0.149254,0.622762,0.192848,0.491926,0.284964,0.661954,0.0511403,-0.611607,-0.154543,0.204053,-0.0604369,0.662545,-0.6448,-0.268529,-0.349559,-0.326711,0.0744388,-0.0717235,-0.577448,-0.379763,-0.0928103,0.67477,-0.034222,0.519439,-0.371841,0.387949,-0.556925,0.0444225,0.140915,0.0754495,-0.0177773,-0.206427,0.359579,-0.0850946,-0.369094,0.0673157,0.352823,0.313824,0.610633,0.340331,-0.190178,0.267543,0.794583,-0.24927,0.0221244,-0.136331,-0.239062,0.192279,-0.0897625,-0.340164,-0.05673,0.314324,-0.480176,-0.167377,0.325039,-0.172229,-0.372776,0.229974,-0.380864,0.224906,0.191858,-0.302879,0.188791,0.101423,0.136188,-0.480486,-0.21338,0.260592,-0.414959,0.179835,-0.0899362,-0.284596,-0.693394,-0.186183,0.0868334,0.43976,0.631316,0.0679624,-0.294079,0.132292,0.415455,-0.0701996,0.0568735,0.832932,0.796044,0.288582,0.497992,0.56824,-0.079586,0.0544027,-0.35208,0.719684,-0.0759063,0.63727,0.403905,0.0119224,-0.0288331,-0.111077,0.081251,0.301772,0.090845,0.330442,-0.139538,-0.0410763,-0.566013,0.304081,0.451536,0.280722,0.989649,0.0181919,0.510849,0.0418209,0.0803929,0.275055,-0.240132,-0.406902,-0.19035,0.193392,-0.756713,0.254198,0.241383,0.614713,-0.506763,0.539185,0.283256,-0.0970491,-0.137123,-0.73743,-0.117219,-0.0521183,-0.0770793,0.262444,0.116063,-0.0488591,-0.271962,-0.16393,1.00922,0.2155,0.508677,0.487516,-0.21775,0.272905,-0.0564614,-0.19963,0.0134673,-0.0734783,0.230633,0.0285953,-0.459094,-0.297479,-0.0740627,-0.182534,-0.0854066,0.280095,0.519062,-0.549128,-0.212191,-0.00612474,0.592014,-0.358613,0.482059,-0.202214,-0.367891,-0.976899,0.429073,-0.54375,0.240629,0.810688,-0.212326,-0.142256,-0.258525,0.000757017,-0.373981,0.0783836,0.405781,0.338793,0.146767,0.280455,-0.18431,-0.417465,-0.385617,0.29881,-0.325785,0.1071,0.00183313,-0.331718,-0.637176,-0.353137,0.301826,0.497967,-0.0296974,-0.00583106,0.297816,-0.169738,-0.0646411,0.245761,0.113298,0.329085,-0.199165,-0.476922,0.144219,-0.639953,0.477326,-0.017667,0.198542,0.409422,0.208962,-0.306835,-0.0897937,0.185282,-0.134329,0.11595,0.285939,0.0137562,0.114293,-0.408783,0.784223,0.313127,-0.0360852,0.316367,-0.109545,0.308254,-0.128692,-0.00372489,-0.18576,-0.121606,-0.0757412,0.30622,0.148903,-0.0165957,0.126361,0.155471,0.355473,0.394298,-1.63186 +3432.02,0.959789,0.0912059,5,1.63309,0.690751,-1.88326,0.643106,0.728105,-0.193528,-0.12404,-0.45691,-0.358389,-0.306347,0.318707,-0.464936,-0.233148,0.167202,-0.423218,0.272786,0.110093,0.223308,-0.136101,0.127007,-0.178771,-0.432588,-0.162116,0.0869038,-0.160537,-0.243117,0.145668,0.110591,-0.532254,0.197525,0.993334,-0.622991,-0.197805,0.000327065,-0.0634897,-0.101721,-0.225097,0.873015,0.782673,-0.0953699,1.21773,0.39444,0.612932,-0.551661,0.347801,0.81337,-0.500059,0.253987,0.235319,0.582022,-0.264642,0.410788,0.104636,-0.0886521,0.528497,-0.329908,-0.09823,-0.867749,0.574177,-0.317076,0.13904,1.15575,-0.28946,-1.05063,0.356394,-0.205458,0.402148,0.236551,-0.533042,-0.637915,0.0139165,0.499769,0.442846,-0.376754,0.577598,0.0918778,-0.22248,-0.209584,-0.409374,0.0122077,-0.173609,-0.708688,-0.0740579,-0.00431164,0.182992,-0.384834,0.302636,-0.296343,-0.018788,-0.269816,-0.125553,-0.10948,0.177789,-0.229171,-0.17109,0.111098,0.180695,-0.303678,0.333938,0.437474,0.272289,-0.326171,-0.611,-0.851846,0.333489,0.268863,0.0706664,-0.376763,0.0345248,0.470229,-0.349513,-0.201524,-0.113381,0.357202,0.489931,0.0826321,-0.775543,0.431945,0.209428,-0.427991,-0.752275,-0.165985,-0.201706,-0.0391509,-0.313484,-0.507935,0.305608,0.440454,-0.00539442,-0.13068,0.00834413,-0.27803,0.0535668,0.373586,-0.563058,-0.254513,0.175661,-0.450748,0.307591,-0.820102,-0.499591,0.268553,0.413314,-0.468832,0.0224762,-0.0632793,-0.220205,-0.0453978,-0.508208,-0.141355,-0.139367,0.558676,0.182158,0.0532398,-0.303089,-0.023655,-0.252391,-0.23334,-0.0938733,-0.12042,0.316071,0.425724,0.411826,0.145422,-0.258138,-0.377812,0.397316,-0.203646,-0.243491,-0.209316,0.531925,0.39532,0.0160179,0.404116,0.00981108,0.650825,-0.623243,-0.269222,0.00419466,0.204093,-0.0606833,-0.561316,-0.182565,0.0822195,-0.227886,0.103226,-0.343345,-0.572293,0.326459,0.0197613,-0.237033,-0.119988,-0.508487,-0.478113,-0.434241,-0.355824,-0.26648,-0.603475,-0.661546,-0.226823,0.174022,-0.484481,-0.0237157,-0.108596,-0.0197493,0.0942906,-0.665289,0.493839,0.0023206,-0.183697,0.300757,-0.159381,0.211803,0.125041,0.280915,0.0072416,-0.137115,0.276977,0.528268,0.117028,-0.113296,-0.45491,-0.0855546,0.045553,-0.542125,0.635783,0.011482,-0.0457129,0.0323559,-0.303942,-0.168613,-0.10864,-0.401729,-0.120349,0.308697,0.3936,0.491062,-0.14503,0.329083,-0.58396,-0.446531,0.538717,0.0420118,0.472485,0.911643,-0.245063,0.209919,0.511963,-0.260072,-0.184827,0.139703,-0.32345,0.12204,-0.118891,-0.674351,-0.00240699,-0.0255583,0.527342,0.140337,0.23462,-0.41183,0.116973,0.186883,0.367767,0.288815,0.218012,-0.435655,-0.0655569,0.0274792,0.578457,0.208714,-0.296236,-0.0814805,-0.679748,0.17965,-0.239817,0.188525,0.0486546,0.0916319,0.123521,-0.246069,0.073692,-0.454014,-0.0126084,0.320995,0.305857,0.353339,-0.482319,0.408776,-0.271851,0.140859,-0.0448848,-0.0974611,0.113981,-0.00504072,-0.264944,-0.178295,0.0161161,-0.32197,-0.155408,0.0315239,0.113029,0.164947,0.336198,0.406137,-1.57729 +3430.47,0.843425,0.0912059,4,1.6249,0.851069,-1.25902,0.51729,0.783398,-0.268094,0.0662075,-0.378959,0.0154529,0.062788,0.192658,-0.326731,-0.541128,0.126656,-0.68933,0.805975,-0.0568762,0.116438,0.113981,-0.115271,-0.222818,-0.864186,-0.760451,-0.0836921,-0.605088,-0.903864,-0.354127,0.112549,-0.695612,0.262986,0.817806,-0.552005,-0.363183,0.0144689,-0.288106,0.00545356,0.26501,0.34757,0.874581,-0.731758,0.585669,0.179248,0.215321,-0.440033,0.350421,-0.0771818,-0.519722,-0.29381,0.276937,-0.0757263,0.104403,0.854328,0.132472,-0.524955,0.285222,-0.163091,0.0498775,-0.57362,0.290946,-0.631456,0.540389,1.21807,-0.437436,-0.307803,-0.277922,0.160861,-0.0304179,0.413048,-0.112026,-0.535676,-0.20401,0.287867,0.665986,0.439145,0.511368,0.611485,0.111235,0.180814,-0.105373,0.0737764,-0.00808517,-0.527507,0.293802,-0.433723,0.74728,-0.0155955,0.165426,0.0420221,-0.295874,-0.637877,0.130516,0.76924,0.382085,-0.0880636,0.137742,-0.430547,0.219254,0.276036,0.297117,0.0905253,0.671112,0.0288021,-0.853596,-1.10815,-0.20515,0.260161,0.0470106,-0.450917,0.390106,0.583311,-0.384933,-0.00971857,0.393323,0.450704,0.220395,0.0558497,-0.120816,0.0138995,0.20746,-0.0916612,-0.226987,0.173777,-0.138043,-0.403233,-0.247678,0.331733,0.575607,0.367348,0.154041,-0.410489,-0.0284379,0.0738051,-0.0601104,0.127471,-0.462954,0.0666653,-0.613565,-0.348573,0.184964,-0.738566,0.0150022,0.12959,-0.0758476,-0.300601,0.00808897,0.385096,-0.196343,-0.110703,-0.142449,0.0230675,-0.156694,0.127377,0.317012,-0.450895,0.629176,0.292187,0.0823908,-0.0150158,0.0992521,0.302077,-0.333779,-0.155053,0.0753512,-0.423303,-0.069884,-0.145613,-0.341951,0.0688995,-0.188377,-0.102075,0.143499,-0.856619,-0.0809389,-0.134308,-0.300071,-0.273541,0.116532,0.112659,-0.119883,0.439465,0.686775,-0.228057,0.203953,-0.282088,0.182597,-0.116502,-0.408849,0.0261039,0.362887,-0.463657,0.142826,0.243667,0.385574,-0.524987,-0.317996,0.328268,-0.207798,0.160001,-0.187324,-0.406074,0.131654,-0.29425,0.234635,-0.0630572,-0.0698208,0.0251393,-0.792255,0.839971,0.232386,-0.0822961,0.206397,0.325172,-0.269391,-0.164637,-0.47953,0.139665,-0.350213,-0.0824772,0.0612142,-0.40803,0.100435,-0.411996,-0.036803,0.294154,0.0551931,0.160934,-0.390035,-0.734399,-0.195045,0.060206,-0.295149,0.248877,0.136241,-0.215424,-0.242413,0.523151,0.08588,0.102278,0.263876,-0.10395,-0.153517,-0.205322,-0.227653,-0.256889,-0.271922,-0.102654,0.449134,-0.3532,0.297995,-0.103913,-0.0451779,-0.281507,0.66957,-0.142352,-0.0138382,-0.0675656,0.159424,-0.0205564,-0.19698,0.629716,0.604137,0.655557,-0.0353394,0.249676,0.254095,0.0865031,-0.0157786,-0.293479,-0.423884,0.249661,-0.528086,-0.232454,-0.366298,-0.0855026,-0.421721,0.439995,-0.265797,0.0794411,0.485101,0.191257,-0.256444,0.290808,-0.531644,0.592804,0.0812776,-0.0355821,0.163336,0.108874,-0.222415,-0.133162,0.204015,0.411428,-0.128183,0.106525,0.22592,0.025524,-0.598798,-0.155231,-0.165077,0.129055,-0.794367,0.109337,0.273044,0.330662,0.522536,-2.24251 +3432.25,1,0.0912059,4,1.59536,0.672298,-1.88254,0.864202,0.895378,-0.171709,-0.179327,0.0961706,0.171092,-0.264003,0.257823,-0.0986835,-0.577511,0.535358,-0.545733,0.216603,0.17095,-0.101168,-0.304299,0.134406,-0.100505,-1.05803,-0.5552,0.192976,-0.105716,0.0776276,-0.0783275,-0.0300082,-0.546884,0.0655478,0.8691,-1.07496,0.0767296,0.392958,-0.320849,-0.557583,-1.19266,1.00323,0.342571,-0.858187,1.2369,0.55808,0.745115,-0.46522,0.0122689,0.523095,-0.100018,-0.107235,0.161751,0.0603259,-0.189388,0.335212,-0.363099,-0.543093,-0.0791184,-0.598612,-0.147217,-0.983951,0.452028,-0.677302,-0.133663,1.0547,-0.786545,-1.14746,0.173393,-0.0917337,-0.225053,-0.522713,0.274016,-0.155491,0.00288463,0.569461,0.217077,0.0164651,0.43002,0.147946,0.254158,-0.447031,-0.765004,0.264591,1.12633,-0.425858,0.439276,-0.0120901,-0.207585,0.198733,0.0570553,0.1658,0.0651782,-0.161187,-0.000512238,0.0503799,-0.232536,0.0720496,-0.0180699,0.138655,-0.253733,-0.643754,0.462383,-0.131061,-0.38075,0.00874859,-0.0496219,0.105797,0.408084,-0.248606,0.306409,-0.131762,0.26959,0.485779,-0.0517827,-0.535564,0.32546,0.611899,-0.0357965,-0.17959,-0.0924623,0.081288,0.579824,-0.0556075,-1.10867,0.133623,-0.509842,0.360573,-0.341174,-0.0429064,-0.152957,-0.247786,0.170095,-0.200141,0.300622,-0.212307,0.576896,0.740504,-0.23185,-0.0440516,0.485906,-0.000220781,0.886138,-0.0666817,-0.556542,0.200583,-0.0389735,-0.111189,-0.090751,-0.0514472,0.0068799,0.378718,-0.205786,-0.197343,-0.0789985,0.469943,0.429896,0.743259,0.332911,0.0904476,0.153257,0.752999,-0.367937,-0.141514,0.129662,-0.302157,0.575952,0.087557,-0.174347,0.607483,-0.17122,-0.228204,0.168599,-0.0672468,0.748467,0.272498,0.182427,0.0234371,-0.131929,-0.134367,-1.01536,-0.109705,0.130092,0.365894,-0.215604,-0.649031,-0.191275,0.261864,-0.217088,-0.626032,-0.0993884,-0.253633,-0.104113,-0.129674,-0.215567,0.167453,-0.756585,-0.592159,0.298669,-0.0192909,0.177603,-0.456257,-0.275691,0.141792,0.123785,-0.486591,0.254193,0.0747894,0.166065,0.106955,0.0390145,0.887786,0.137177,0.265517,-0.0165254,-0.0331788,0.447151,-0.0214935,0.00170609,-0.116854,-0.197309,-0.0531909,0.310572,-0.386479,-0.0876143,-0.751467,0.0212091,-0.532544,-0.500622,0.221855,-0.0485974,0.116405,0.351177,0.132146,-0.26815,0.11677,0.093065,-0.344462,-0.0351363,0.356898,0.00804578,0.136422,0.395581,-0.115778,0.035498,0.453225,-0.105167,-0.0269437,0.709194,-0.0318765,0.458317,0.577844,0.0405805,-0.4323,0.341341,-0.783839,0.1636,-0.0036197,-0.111392,0.438506,-0.0207705,0.727995,0.340088,0.0438583,0.0572851,0.471629,0.32149,0.366415,0.514002,0.159121,0.160305,0.364279,0.0138171,0.373887,0.296157,-0.276625,-0.0653231,-0.239272,0.354522,0.888843,-0.127689,-0.0309604,-0.151943,-0.138368,-0.0369484,0.0158263,-0.573577,-0.25073,-0.0540641,0.346708,-0.304487,0.112334,0.829083,0.177246,0.118007,-0.394253,-0.121775,0.0445876,-0.208769,-0.258819,0.326419,0.100903,-0.152175,-0.385887,0.879375,0.127456,0.349759,0.357009,0.591404,-2.35322 +3437.89,0.986017,0.0912059,4,1.60288,0.692844,-1.7043,0.728046,0.582905,-0.182841,0.204844,-0.0638561,-0.235806,-0.193401,0.432664,-0.429264,-0.137022,0.230547,-0.654074,0.893072,0.177825,0.0266478,-0.12799,0.314701,-0.171911,-0.844555,-1.101,0.231844,-0.151099,-0.0984772,-0.316756,0.252797,-0.570301,0.607268,0.963382,-0.635731,-0.1769,0.327708,-0.35432,-0.458295,-0.0979361,0.672461,0.55118,-0.909964,0.863835,0.483632,0.642502,-0.656222,-0.736002,-0.0327603,-0.65675,0.12046,0.264182,0.0616924,-0.132489,0.814169,-0.217672,0.0166709,0.253814,-0.418316,-0.0185401,-0.562253,0.43797,-0.577321,0.641219,0.644291,-0.665861,-1.32894,0.0903433,-0.179582,-0.30829,0.0530044,-0.119335,-0.669451,0.0721508,-0.111023,0.853219,0.0849678,0.185485,0.265508,0.169824,0.410961,-0.107854,0.127239,0.0812424,-0.0137347,0.135284,-0.496039,-0.312507,-0.150139,-0.179268,-0.554263,-0.27981,-0.559475,-0.124068,-0.0412263,0.377329,0.136995,0.553851,-0.565631,0.0373565,0.143257,-0.102374,0.450838,0.311621,-0.183861,-0.876964,-0.0328593,-0.337033,-0.265264,0.326169,-0.188374,0.152392,0.438733,0.0228978,0.724241,0.0650652,0.402986,-0.0652417,0.0882193,-0.253852,-0.22572,-0.000280359,-0.188169,0.1254,-0.544856,0.671107,-0.69802,0.0726121,0.165202,0.336711,0.4736,-0.038123,-0.350521,-0.140894,0.178883,-0.244325,0.0186247,-0.350637,-0.0429045,-0.581704,-0.611499,-0.152312,-0.53393,0.136431,-0.00479939,-0.351304,-0.203405,0.105447,0.154492,0.118332,-0.295134,-0.100969,0.174462,-0.086638,0.00324742,0.187852,-0.337403,0.613664,0.227866,0.345773,-0.180675,0.234287,-0.389957,-0.391208,-0.092641,0.983062,-0.336036,-0.0344711,-0.31649,-0.0367785,-0.256023,0.0789644,0.0341878,-0.134694,-0.349734,-0.120955,0.392395,-0.280253,-0.335506,-0.0197439,0.313456,0.0736123,0.799077,0.293872,0.232269,0.433014,-0.382659,-0.26928,0.269398,-0.344728,-0.344125,0.295646,-0.702717,0.22058,0.16035,0.388173,-0.433433,-0.0701866,0.397146,-0.498693,0.240234,-0.463926,-0.295515,8.28016e-05,-0.337978,-0.1956,-0.176093,0.0631282,-0.224574,-0.993103,0.766194,0.0433727,-0.169735,0.209875,-0.545407,0.0964591,0.261766,-0.358247,0.510883,0.180821,0.136252,0.085046,-0.150843,-0.178424,0.457458,0.042251,0.574295,0.154405,0.461754,-0.263469,-0.0786131,0.311647,0.0187005,-0.33866,0.154214,0.268247,-0.053113,-0.360319,0.147144,0.171384,-0.266023,0.489704,-0.192937,-0.0734711,-0.513286,-0.235843,-0.000829776,-0.0374098,0.382194,0.0631354,-0.271668,-0.111446,0.0566112,0.0423397,-0.273575,0.224714,0.072557,0.134985,-0.126459,-0.0894797,-0.318791,-0.0856256,0.381329,-0.238324,-0.348252,-0.228297,-0.153595,0.0457417,-0.287923,-0.15321,-0.3029,-0.102505,-0.180736,-0.195767,0.129265,-0.405344,0.0745124,0.058408,0.295206,0.253433,0.170252,-0.00835138,-0.294419,0.186357,-0.321459,0.34696,0.252609,0.171404,-0.214368,0.225512,-0.0280927,-0.134809,-0.344922,0.0917164,0.615385,0.0744445,0.210573,-0.152916,-0.473568,-0.199045,-0.275021,0.63859,0.00858685,-0.735718,0.113987,0.297932,0.33762,0.545832,-1.30643 +3444.85,0.826106,0.0912059,4,1.6605,0.585599,-1.70487,0.750855,0.381526,-0.0834641,-0.0441919,-0.146713,-0.621652,-0.392169,0.133325,-0.284071,-0.262704,0.374435,0.133573,0.521693,0.249736,-0.267796,-0.648982,0.371212,0.143033,-0.558989,-0.803915,0.558446,-0.0206569,-0.347091,-0.245434,-0.245092,-0.115515,0.454209,1.01345,-0.92305,-0.0478718,0.251513,-0.484995,-0.000152615,-0.107523,0.751536,0.00832758,-0.154122,0.986747,0.67693,0.729004,-0.455065,-0.300019,0.369949,-0.820576,0.177606,0.178405,0.260186,0.188248,0.585878,-0.193319,0.28567,0.2346,-0.480556,-0.0705433,-0.644288,0.311935,-0.520468,0.185627,0.862247,-0.364645,-1.42026,0.464513,-0.44507,0.267589,0.0885987,0.648694,-0.889479,-0.0909389,0.216328,0.506995,0.00856683,0.488244,0.714741,0.117743,0.278171,-0.768694,-0.193413,0.416722,-0.573796,0.132035,-0.240042,-0.398543,-0.106196,-0.205128,0.271788,-0.4748,-0.47536,-0.443069,-0.148326,-0.17247,-0.111786,0.0656903,0.0716878,-0.513573,-0.143576,0.261676,-0.245968,0.161172,-0.485891,-0.284914,0.337248,-0.747331,-0.427609,0.0774129,0.134311,-0.130898,0.067102,-0.445114,0.310043,-0.422308,0.50971,-0.0963838,-0.485918,-0.70064,0.311742,-0.0982974,-0.214769,-0.533689,-0.462163,0.289986,0.303025,-0.0657053,0.282231,0.166861,-0.0722744,0.411435,-0.351825,-0.0139834,0.125581,0.101188,0.35411,-0.155949,0.0911686,0.0455865,-0.497143,0.464076,-0.44885,-0.298539,0.18273,0.0639926,-0.212253,0.223592,0.0883791,0.0740551,-0.176748,-0.453812,0.380414,-0.126979,0.0439156,-0.0159247,0.164576,0.251834,0.420509,0.00415056,0.134176,0.0587199,0.447919,0.346582,-0.124909,0.783944,-0.614139,0.364274,-0.0343977,-0.311379,-0.435604,-0.311577,-0.473819,0.372528,-0.142998,0.23075,-0.046658,-0.274021,-0.423977,-0.333412,-0.239838,0.220567,0.634336,-0.346473,0.163158,0.386775,-0.654888,-0.0427741,-0.236502,0.0589979,-0.194647,0.428832,-0.0433638,0.144481,0.306384,-0.449072,-0.371691,-0.147074,0.317679,0.136715,-0.0843585,-0.181218,0.104534,0.266914,-0.507916,-0.0661028,0.304505,-0.153619,-0.717038,-0.173056,0.612622,0.06008,-0.0650242,0.113438,0.0268912,0.420595,-0.0682472,-0.17705,0.149583,-0.238979,0.051618,0.0961847,-0.0758924,0.0135243,-0.404577,-0.316138,0.532071,0.0981105,0.347592,0.063661,-0.0713279,0.0559037,-0.0516034,-0.111997,0.119479,-0.0535897,0.0552322,-0.0620274,0.00268145,-0.358518,-0.144104,0.627733,-0.327464,-0.152331,-0.0737674,0.26799,0.0918561,0.374797,0.73648,0.343121,0.0380947,-0.486849,-0.468554,0.27735,-1.0859,0.248099,0.0577147,-0.284044,-0.321408,-0.197916,-0.302396,0.373028,-0.0513889,-0.140403,0.210485,-0.0292647,0.127496,0.259461,0.228817,0.0868477,-0.245139,-0.0171159,0.162664,0.0498262,-0.0371386,-0.354471,0.0839153,0.370376,0.427005,-0.0153972,0.145824,0.153661,-0.327355,-0.0599067,-0.093019,-0.164171,0.0856022,0.265197,0.0181117,0.130521,0.215489,0.289555,0.120156,0.123887,0.390255,-0.184617,0.0555628,-0.0312377,-0.0120976,0.228936,-0.127948,-0.131237,-0.156783,-0.140641,0.0927515,0.234776,0.304551,0.484537,-0.436848 +3424.05,0.929503,0.0912059,4,1.51928,0.5373,-1.66903,0.694054,0.261132,-0.117193,0.306471,-0.665652,0.0560921,-0.49804,0.243068,-0.711163,-0.344741,0.812856,-0.564686,0.806185,0.3445,0.20774,-0.539281,0.433989,-0.0516313,-0.582277,-0.966576,0.839083,-0.236964,-0.0899839,-0.303768,0.0972431,-0.489047,0.0429481,0.992016,-0.901659,0.0223999,0.667773,-0.520903,-0.252886,-0.71893,0.462254,0.470909,-0.604906,1.14344,0.705501,-0.138442,-0.772437,-0.367399,-0.162375,-0.331831,-0.0865788,0.624316,0.201983,0.0770652,0.594845,-0.00916889,-0.940887,0.618041,0.144407,0.221208,-0.49168,0.380727,-0.108641,0.13542,0.86783,-0.710553,-0.721846,-0.166975,0.024393,0.0295141,0.213579,0.170345,-0.121918,0.31721,0.47968,0.575193,-0.0575892,0.246999,0.253331,0.335535,0.419478,-0.213728,0.302148,-0.0684798,-0.679458,0.412685,-0.0212904,0.460609,0.249108,0.416274,0.0193585,-0.0624716,-0.406655,0.329226,0.031691,0.31732,0.224928,0.0638067,0.115308,-0.104149,-0.24399,0.341117,0.149144,-0.201959,0.169154,-0.218751,-0.296215,0.328853,-0.228308,-0.199406,-0.441962,-0.133996,0.549809,-0.251949,0.46772,-0.012781,0.3712,0.225148,0.141109,-0.187356,0.100819,0.748755,0.176482,-0.596411,0.0733867,-0.261226,-0.151091,-0.361028,-0.0188895,-0.274905,0.62111,0.223433,0.300692,-0.115957,-0.243501,-0.378734,0.337808,0.114862,-0.0909619,0.059524,-0.0513602,0.308441,0.0995621,-0.196046,0.0409622,-0.103306,-0.202646,0.0282482,-0.174738,-0.374952,0.643674,-0.0357313,-0.243222,-0.602582,0.0282982,0.545339,0.0131128,0.344032,0.486472,0.452514,-0.348982,0.0336767,-0.391521,0.399957,-0.0180947,0.867269,0.257111,0.27318,0.140801,-0.0725243,0.15214,-0.362965,0.249939,0.104045,0.0366252,-0.194042,0.214549,-0.0860596,-0.579491,-0.0611115,-0.568652,0.523878,0.795117,0.48099,-0.428706,0.0911017,0.217957,0.0726634,-0.054616,0.542201,-0.12826,0.16182,-0.178079,-0.0284665,0.00377032,-0.34893,-0.0456457,0.232722,-0.446182,-0.150999,-0.556411,-0.468678,0.222243,-0.196046,-0.335904,0.354699,-0.604811,0.157574,0.223353,-1.06681,0.943675,0.181653,-0.300865,-0.43768,-0.0772772,0.00139582,0.842777,-0.647613,0.492237,-0.0946423,0.148541,0.377433,-0.45586,-0.203672,0.0155626,0.366591,0.0300404,-0.174156,0.485152,-0.603486,-0.0862485,-0.129502,0.0352446,0.651123,0.101186,-0.149114,-0.403313,-0.450204,0.623351,0.473491,0.370875,0.626861,-0.155077,-0.109109,-0.181467,-0.136877,-0.159328,0.545698,-0.710842,0.423454,0.725893,0.410532,-0.370485,0.0751146,-0.0142473,0.354291,-0.34742,-0.298898,-0.115491,-0.314691,-0.0484287,-0.142763,0.187385,0.20611,0.310694,-0.247226,0.111138,-0.0993509,-0.157336,-0.0325038,-0.0354465,0.218364,-0.557718,-0.0714468,-0.709445,-0.77321,0.10215,0.240728,-0.0547198,0.124741,-0.361857,0.394319,0.132633,-0.170476,-0.0232344,-0.835267,0.554845,0.0601728,-0.619523,-0.16671,-0.0991125,-0.174967,-0.116102,0.0104457,-0.0616977,-0.554429,0.467326,-0.103607,-0.16289,0.368271,-0.335723,-0.186038,-0.288486,0.178267,0.125457,0.3114,0.354199,0.558033,-0.0495268 +3416.62,0.900705,0.0912059,4,1.60753,0.438767,-1.22845,0.60581,0.141035,0.0388075,0.264963,-0.381882,-0.427026,-0.402601,-0.0896458,-0.5271,-0.0222055,0.990026,-0.0048337,0.297315,0.562087,0.152797,-0.367934,0.396385,0.552846,-0.361418,-1.19015,0.933831,0.421105,-0.219196,0.132428,0.195046,-0.72767,-0.057609,1.41566,-0.64042,-0.053722,0.407435,-0.431798,0.0770137,0.148701,0.199796,0.169762,-0.161611,1.20654,0.799563,0.239931,-0.798753,-0.287459,0.493591,-0.137996,-0.0191277,0.460568,0.0852725,0.397871,0.583899,-0.118351,-1.06902,0.893935,-0.116629,-0.18987,-0.798808,0.188355,-1.11479,0.0384056,0.60212,-0.332557,-1.54836,-0.26079,-0.157825,0.571483,0.326901,0.107837,0.322688,0.48574,0.185394,0.591716,-0.127961,0.373278,0.743582,0.111625,-0.186866,-0.294034,0.422057,0.270266,-0.847501,-0.11621,-0.320809,0.516063,0.154217,-0.128492,-0.212531,0.0444847,-0.601091,-0.232067,0.0594181,0.174745,0.316282,-0.241654,-1.18652,-0.106998,-0.533194,0.454673,0.0237026,-0.244359,0.0502382,0.0987092,-0.16464,0.519166,-0.585088,-0.0100187,-0.275955,-0.170514,0.71573,-0.147654,0.403728,0.555603,0.296462,-0.0832071,-0.0692999,-0.0162124,-0.0235805,0.533992,-0.371895,-0.771091,-0.748672,-0.253971,-0.259166,-0.576898,0.31043,0.462402,0.666238,0.44993,0.113607,-0.236927,-0.0651375,-0.527024,0.0995292,-0.140512,0.0298356,0.206673,-0.215752,0.390548,0.0396303,-0.365125,-0.132878,-0.0988843,-0.177937,-0.70843,-0.046696,-0.475923,1.04123,-0.319676,-0.093112,-0.953934,0.247262,0.0350402,-0.069943,0.245941,0.247247,-0.181851,-0.205984,-0.30961,0.0136441,0.0106419,0.306119,0.914383,0.20256,0.409144,0.131889,-0.252262,-0.276114,0.0176076,-0.342019,0.287385,0.469628,-0.0313571,-0.365643,-0.185207,-0.116447,-0.171001,-0.0598569,0.211788,0.835135,-0.143068,0.0936346,0.104305,-0.217741,0.348617,-0.346133,-0.285521,-0.430966,0.741073,-0.119399,-0.0218932,0.68604,0.19216,-0.400422,0.292213,0.0794442,0.0112967,-0.432872,-0.16932,0.337573,-0.0167053,-0.184525,-0.132074,-0.21772,-0.2749,0.514166,-0.284891,0.598856,-0.16945,-0.0644253,-0.314945,0.0127134,0.638315,0.185148,-0.205087,0.068505,-0.106788,-0.258192,-0.0360249,-0.143633,0.392269,0.337301,0.126051,-0.0939199,-0.550498,0.231749,-0.405331,-0.395375,0.0686309,-0.109401,-0.0420618,-0.0244043,-0.288201,-0.124978,-0.417676,0.672447,0.411252,0.334277,0.884141,-0.194215,-0.283009,-0.156108,-0.12761,0.00895393,0.184042,-0.142001,1.02499,0.649495,-0.225975,-0.688684,0.285073,-0.0488387,0.283346,-0.0825864,-0.0239722,-0.053906,-0.254112,0.31714,-0.114503,-0.108559,-0.248455,0.403676,0.210124,-0.0553206,0.0498031,0.311908,-0.139344,0.239423,-0.194648,0.128708,-0.110983,-0.0475719,0.0519476,0.301627,-0.0949181,-0.122945,-0.419311,-0.411896,-0.0640534,-0.156112,0.0598842,0.121546,-0.489843,0.0436171,-0.0626851,-0.108851,-0.202604,0.120153,-0.00450828,-0.381367,-0.0490111,0.153291,-0.0866723,0.845637,-0.318284,-0.880289,-0.0525475,0.0734088,-0.149276,-0.194807,-0.255875,0.123692,0.323958,0.351699,0.569173,0.424824 +3413.83,0.87883,0.0912059,4,1.58582,0.602346,-1.10978,0.580704,0.404703,-0.244607,0.701376,-0.0362351,-0.135991,-0.595958,0.48435,-0.463534,0.0729721,0.525239,-0.0444189,0.426622,0.132051,0.0801418,-0.289953,0.137686,-0.0642653,-0.529497,-0.739338,0.819613,-0.041356,-0.597276,-0.579414,-0.353884,-0.378495,-0.109519,1.36515,-0.471185,-0.157826,0.650395,-0.190007,-0.526176,-0.241906,0.0042434,-0.296465,0.0525468,1.00288,0.526224,0.451014,-0.947375,-0.184551,-0.253416,-0.307379,0.379773,0.176781,0.13108,-0.202707,0.643076,-0.16514,-1.20147,0.499951,0.243968,-0.478946,-0.906155,0.513133,-0.323048,-0.168072,0.48768,-0.494451,-1.59548,0.0770262,-0.488393,0.347414,0.314732,0.261466,-0.000477586,0.694255,0.387681,0.539892,0.324827,0.553239,0.771298,0.108994,0.158581,-0.119666,0.127544,0.291386,-0.334234,0.21687,-0.188445,0.232308,-0.0189334,-0.712687,-0.301716,-0.11582,-0.593337,0.306937,0.543132,0.193683,0.0528079,0.0713203,0.0466213,-0.326736,-0.117075,-0.300977,0.493857,-0.404567,-0.0774748,-0.271215,0.0804416,0.214128,-0.675853,0.2311,0.156683,-0.0860836,0.513319,-0.28994,0.0487064,0.246913,0.546593,-0.409206,0.245248,0.109768,-0.251701,0.242512,-0.14897,-0.706226,-0.245952,-0.545843,-0.514035,-0.30708,0.302127,0.713691,0.114498,0.16395,-0.352249,0.189494,0.182595,0.0730287,0.359161,-0.36652,-0.151007,0.157895,-0.281477,0.0479143,-0.502437,-0.456722,-0.152434,-0.08094,-0.177399,-0.448893,-0.501892,0.0375804,0.577596,-0.128114,-0.207179,-0.774813,0.476367,-0.143941,0.013846,0.264057,0.02973,0.188242,-0.714059,-0.198602,-0.104115,-0.238273,-0.0102552,0.566202,-0.324506,0.311139,0.134353,-0.135744,-0.310733,-0.118851,-0.219453,0.219557,0.292446,-0.186629,-0.0973327,-0.145476,-0.0919202,-0.475206,0.306913,0.151225,0.977536,0.456012,-0.383849,0.344794,-0.244713,0.573555,-0.386369,0.310506,-0.129833,0.625902,-0.266832,0.231224,-0.146363,0.0752587,0.110532,0.145069,0.497998,0.205404,0.0681728,-0.138842,0.553792,0.0159163,-0.546184,-0.0146457,-0.771642,-0.184104,0.759605,-0.298394,0.687137,-0.124862,0.221788,0.0308587,-0.418375,0.580376,0.0315841,-0.426648,0.087836,-0.339041,-0.175886,0.191445,0.000731878,-0.201279,-0.138873,0.671913,0.19988,0.0510217,0.726649,0.0111469,-0.246611,0.0602246,0.00189249,-0.153563,0.102389,-0.321103,0.102132,-0.0221098,0.503944,0.229666,0.257316,0.781289,-0.192158,-0.156374,-0.313665,-0.354129,0.36883,0.499542,0.612661,0.667896,0.657106,-0.0138265,-0.473596,0.047106,-0.329181,-0.121942,-0.0797231,0.153083,0.317242,-0.28432,0.179847,-0.112572,0.18544,-0.0696873,0.451964,-0.377934,-0.14321,0.397306,0.562921,-0.180115,0.00122471,0.115528,-0.0227704,0.0446428,0.00595488,-0.223252,0.486943,0.191349,-0.0256327,-0.0946101,-0.173542,0.240432,0.615148,-0.327014,0.0943434,-0.716489,-0.426935,-0.161058,0.127167,-0.0818241,0.45316,0.11987,-0.533697,0.0662944,0.0759924,0.237801,0.301191,-0.292402,-0.285157,-0.153255,0.280833,-0.131872,-0.152739,0.273052,0.120945,0.308577,0.347772,0.555497,-0.729092 +3421.73,0.731639,0.0912059,4,1.68261,0.580766,-0.90261,0.35103,0.167045,-0.028042,-0.170872,-0.30301,-0.639855,-0.207419,0.0330873,-0.414393,-0.380723,0.713635,-0.278524,0.376452,0.388049,0.319478,0.202136,0.451551,0.104999,-0.748239,-0.674136,0.400874,0.239036,-0.676942,0.058547,0.386268,-0.681898,-0.0735052,1.17943,-1.1845,-0.167185,0.19004,0.126933,-0.333642,-0.556524,-0.538719,0.793556,0.052458,0.969962,0.057678,0.174315,-0.259098,-0.266926,-0.492082,-0.987284,-0.182122,0.442178,-0.325245,0.216511,-0.293955,-0.0312627,-1.16448,0.899925,-0.35486,-0.32648,-1.1393,0.687301,-0.460618,-0.0244358,0.392846,-1.23812,-0.80137,-0.0748506,-0.181968,-0.127958,0.323688,-0.107873,-0.843036,-0.0910575,-0.0409128,0.670682,0.16895,0.701035,0.434714,0.123226,-0.273589,-0.485528,0.462999,0.0918319,0.00400963,0.242083,-0.728286,-0.398102,-0.314249,0.126951,-0.12819,0.49539,-0.345738,0.175917,0.0414392,-0.0365904,-0.0639084,0.569516,-0.873283,0.132659,-1.02724,-0.165129,-0.372832,0.524111,-0.449574,-0.741172,-0.298883,-0.389289,-0.218208,-0.320752,-0.231354,0.664671,0.543452,0.051844,-0.144428,0.385161,0.177224,-0.146597,0.445826,0.00901374,-0.247274,-0.0347631,-0.444403,-0.371713,0.409755,-0.422487,0.203815,0.0343776,-0.437985,-0.107771,-0.0311488,0.165781,-0.132982,0.0173914,-0.138184,-0.068825,0.741453,-0.115017,-0.40415,-0.047228,-0.287194,0.410349,-0.567046,-0.649409,0.156686,-0.251497,0.239644,0.0974056,-0.132327,0.228944,0.244068,-0.302641,0.10007,-0.155239,-0.0167885,0.153079,0.192786,-0.264489,0.129534,0.483815,-0.207533,0.137026,0.03117,-0.275888,0.382625,0.822644,-0.229906,0.214769,-0.0846292,-0.27237,-0.0229615,-0.192844,-0.358302,0.563003,0.346843,0.0906376,0.0852671,0.240809,0.540602,-0.363467,0.00892643,0.149204,0.899486,-0.145841,-0.17716,0.180099,-0.0567367,-0.223069,0.0160123,0.188582,-0.479895,0.212484,-0.544382,-0.153313,0.0419876,0.127054,-0.489596,-0.26241,-0.305844,-0.428193,-0.068413,-0.216046,-0.146697,0.0625408,-0.755324,0.23675,-0.0862078,-0.310588,-0.14498,0.10524,0.761861,0.0349316,-0.299672,-0.114401,-0.250069,0.00390989,-0.0547836,0.229772,0.206193,-0.0365407,0.0853457,-0.0216099,-0.410854,0.133429,-0.361247,-0.596526,-0.208381,-0.141829,0.271898,-0.497413,-0.274836,0.0395976,0.425846,-0.0339981,0.0457119,0.201248,-0.217607,-0.137126,0.158541,-0.250446,0.442574,0.912463,-0.229711,0.162315,0.0260744,0.173159,-0.0215358,0.060672,-0.213142,0.235154,0.415858,0.031945,-0.0354049,-0.105526,-0.201241,0.173216,-0.212439,-0.330481,-0.072336,0.145609,-0.00261627,0.482975,0.220863,-0.199368,0.669543,0.647957,0.372866,0.165397,0.225418,-0.0221902,0.107439,-0.524917,0.0938357,-0.485337,0.0707222,0.555865,0.439028,-0.480126,-0.228071,0.128783,0.13312,0.725709,-0.392151,0.533667,-0.120823,0.236167,-0.0259615,0.298261,0.0374437,0.277557,0.459207,0.21154,-0.444787,0.0935796,0.0684726,-0.205401,0.249881,-0.264255,-0.513801,-0.0976312,0.0663671,0.396219,0.051745,-0.0310371,0.132543,0.298822,0.364064,0.546646,0.249645 +3415.58,0.970756,0.0912059,4,1.7472,0.50534,-0.64964,0.311559,0.510378,-0.179753,-0.191969,0.374234,0.268598,-0.168918,0.605852,0.0123742,-0.427587,0.65728,-0.2289,0.176486,0.386592,0.210008,-0.0813797,0.304554,-0.192135,-0.447938,-0.551221,0.669949,-0.295128,-0.560287,-0.43487,-0.719271,-0.168056,-0.115487,1.28636,-1.17641,-0.247317,0.562364,-0.0762774,-0.428412,-0.230462,-0.243452,0.271265,-0.422012,1.12442,-0.0332439,-0.416969,-0.551636,-0.486849,-0.400305,-0.838316,-0.0053926,0.333294,-0.0545254,0.141001,-0.253451,-0.391141,-0.451081,1.17944,-0.457463,-0.540123,-0.984789,0.747461,-0.598222,-0.154808,0.722439,-1.31009,-0.842101,-0.257606,0.289873,-0.495239,-0.150908,-0.5195,-0.563409,-0.240041,-0.0254788,0.483252,0.191644,0.759328,-0.0114261,0.432508,-0.415425,-0.296623,0.125003,0.43723,0.0911247,0.219192,-0.792278,-0.411237,-0.23764,0.1417,-0.884611,0.165694,-0.627377,0.293253,0.161962,0.0485035,-0.0809818,0.265191,-0.0261748,0.222082,-0.734186,-0.0777836,-0.106962,0.282268,-0.0306199,0.0691382,0.0883283,-0.385133,0.0258679,0.117047,-0.137706,0.434914,0.56753,0.0690653,-0.403591,-0.00102585,0.473275,0.465792,0.536522,-0.268695,-0.108441,0.593771,-0.341005,-0.0409841,0.0689432,-0.413484,-0.348454,-0.514009,-0.0903929,0.286753,0.455345,0.327069,-0.40383,0.0689807,-0.0251964,0.215107,0.670097,0.156093,0.00960524,-0.213125,-0.365599,0.463602,-0.649769,0.0076937,0.143385,-0.268971,-0.348567,0.0829438,-0.600174,-0.0242059,0.591282,-0.534763,-0.0384107,-0.468339,0.297557,-0.382812,0.244594,-0.507944,0.987697,-0.937405,-0.101074,-0.209111,-0.0415377,0.357821,-0.260943,1.1615,-0.422106,0.384011,-0.163906,0.0456863,-0.244794,-0.374553,0.30558,0.713384,0.343758,-0.128819,-0.0310968,0.299439,0.15582,-0.505422,0.377326,-0.155702,0.774082,-0.584834,-0.0839556,0.110342,-0.264733,0.00711481,-0.0550844,0.0465943,-0.0440759,0.357575,-0.29748,-0.381733,0.449517,0.258527,-0.215106,-0.481051,0.524136,-0.192397,-0.188543,-0.13549,-0.0421617,0.00881764,-0.236006,0.0969715,0.0691536,0.323399,0.0790559,-0.238459,0.694693,-0.0672445,0.191548,0.148767,-0.403647,0.107965,-0.0867569,-0.0292731,0.0244855,-0.153876,-0.317675,0.687435,0.0351752,-0.0247195,-0.343372,0.0244884,0.300518,-0.120053,0.660512,-0.103564,-0.31073,0.474863,0.0157894,-0.233868,-0.0674968,-0.170954,-0.0140045,0.364798,0.340892,0.284451,0.18158,0.661464,-0.275411,-0.0784738,0.117339,-0.451337,0.000983493,0.287388,-0.395066,0.478793,0.083107,-0.0521079,-0.528068,-0.2767,-0.673353,0.580627,-0.0496832,-0.238815,-0.20946,0.0267911,-0.183537,0.325932,-0.109579,0.139173,0.859282,0.172452,0.228675,-0.0504643,0.318155,0.0556877,-0.0779878,-0.216856,-0.218527,-0.0819325,-0.0864207,-0.307208,-0.257122,-0.0229142,-0.236941,-0.0616996,-0.0875933,-0.0372951,0.209799,0.213385,0.0129779,0.222436,0.0219243,0.196155,-0.059836,-0.273425,0.396103,0.254906,-0.22942,-0.0658786,-0.351916,0.746926,0.473796,-0.626858,-0.963398,0.203357,-0.596821,0.398629,-0.480164,-0.175379,0.10797,0.223818,0.328589,0.473094,-0.749762 +3406.34,0.848956,0.0912059,4,1.66247,0.578005,-0.962101,0.410372,0.33861,-0.0765955,-0.23524,-0.453134,-0.221352,-0.178168,-0.0300073,-0.00902571,-0.345504,0.607594,-0.245689,0.155546,0.0222534,-0.53685,-0.525886,0.155361,0.106966,-0.615249,-1.13658,0.662919,-0.274852,-0.0112362,-0.371512,0.505103,-0.52886,-0.25346,1.16565,-0.493853,-0.414655,0.152235,0.265482,-0.132185,-0.242357,0.142877,0.6416,-0.341437,0.936666,0.0357952,0.160697,-0.551343,-0.192724,0.21592,-0.826334,-0.203947,0.381233,0.0146557,0.180217,0.0234271,0.399521,-0.818666,0.910797,-0.22557,-0.712131,-0.711876,0.475309,-0.642787,0.322466,0.345928,-0.650302,-1.1298,-0.014764,-0.17773,-0.0867099,-0.10264,-0.339525,-0.557336,-0.0345861,-0.0555071,0.394812,-0.0217841,0.623204,0.957033,0.394269,0.337969,-0.012076,0.0179368,0.452452,-0.334211,0.0549819,-0.399092,0.157024,0.0429151,0.475395,-0.257536,-0.169356,-0.158232,-0.406463,-0.397258,-0.0461239,-0.308419,0.138958,-0.207247,0.0798197,-0.741501,-0.477976,-0.141633,0.17621,0.126963,-0.0720071,-0.302638,0.339487,0.0341286,0.0642514,-0.198845,0.334386,0.0734477,-0.429508,-0.194819,0.750629,0.134281,0.351567,0.188612,-0.181569,0.363656,0.463378,-0.631056,-0.435844,-0.493435,0.0390544,-0.328431,0.00112034,0.0162766,0.230508,0.210511,0.0862362,-0.532735,-0.132213,-0.0148159,-0.395401,0.615111,-0.27084,0.643744,-0.160009,-0.369629,0.595807,-0.384585,-1.30654,-0.148303,0.00590714,-0.127728,0.304288,0.3843,0.0471342,0.416538,-0.280294,-0.0763966,-0.188764,-0.0988455,0.187178,-0.140022,0.216283,-0.493865,-0.0054865,0.460957,0.255257,0.344554,0.397618,-0.613659,0.699118,-0.13838,0.00648245,-0.605808,0.232827,0.246838,-0.0745211,-0.518158,-0.0381679,0.282275,-0.0788983,-0.608731,0.0866428,-0.137512,-0.290554,0.817943,0.0367409,0.784963,0.319668,0.384007,-0.112733,0.156145,-0.406842,-0.791184,0.242703,-0.312627,-0.122943,-0.618431,0.129222,0.0997536,0.668128,-0.665688,0.0728313,0.32387,-0.0728042,-0.207355,-0.271387,-0.810773,0.0688379,-0.211402,0.0854553,0.152551,-0.27095,-0.268834,0.0358931,0.550453,0.264946,0.343508,0.109286,-0.277697,0.0345562,-0.250199,0.1624,0.0119165,0.0509314,0.34911,0.06682,-0.180953,0.435367,-0.227878,0.193877,0.120865,-0.345821,-0.0550002,-0.316552,0.100523,0.14467,-0.367493,-0.129858,0.0122528,-0.600081,0.17727,-0.0154318,-0.153857,-0.26481,0.040045,0.474957,0.0230118,0.370421,-0.181219,-0.0421017,0.11639,0.40051,0.432591,0.0976382,-0.0348764,0.168332,-0.0203666,-0.43285,-0.939959,0.475465,-0.21183,0.0254737,0.451865,0.249586,0.113846,-0.0457958,-0.0788731,0.0281055,0.183302,0.281012,-0.271022,0.047711,0.232621,-0.343852,-0.490589,0.113811,0.168908,-0.363511,0.035126,-0.358946,0.475623,-0.47318,-0.53173,-0.016955,-0.0832386,-0.131702,-0.131338,0.253841,-0.188979,0.0811347,0.26044,0.0898103,-0.119091,0.0698447,0.0560881,0.201035,0.423146,0.050413,0.047063,0.436816,0.211041,-0.0843253,-0.168359,-0.691898,0.666324,0.281633,-0.1485,0.162736,0.128952,0.264281,0.359099,0.514083,-0.348061 +3460.28,0.889304,0.0912059,4,1.69093,0.645028,-0.892086,0.369662,1.06199,-0.161042,-0.10424,0.17908,0.0563465,-0.480573,0.45879,-0.178823,-0.306919,0.100884,0.0332789,0.547344,-0.0907528,-0.0231019,-0.225871,-0.288357,-0.35135,-1.06287,-0.608664,0.356653,-0.476214,-0.476503,-0.378389,-0.174815,-0.109269,0.149815,0.886542,-0.922668,0.251245,0.559336,-0.272135,-0.262432,0.0432954,-0.155251,0.561824,-0.0671267,0.928188,-0.276635,-0.194473,-0.432624,-0.0397932,-0.441689,-0.554925,0.0372942,0.4765,-0.325251,-0.0158084,0.0421537,-0.122065,-0.554081,0.663222,-0.18995,-0.257175,-0.689693,0.670051,-0.723465,0.394313,0.566361,-0.496639,-0.814062,0.134621,0.334442,0.164871,0.294137,0.322739,-0.301251,-0.145544,0.123932,0.457769,-0.458412,0.349823,0.437132,0.647513,-0.0489758,-0.217017,0.469148,0.647159,-0.0018639,0.056608,-0.547234,-0.342736,0.0367434,-0.490701,-0.148238,0.0115115,-0.496194,0.171905,0.0606964,0.153006,0.0708298,0.0675315,-0.537321,-0.0320102,-0.142594,-0.00302518,0.483556,0.472052,0.266887,-0.207935,-0.386218,0.115212,-0.00437574,0.372089,-0.49068,0.292152,0.549743,0.0150949,0.0769109,-0.0729458,0.694143,-0.288472,0.444994,-0.495902,-0.0185191,0.15241,-0.262141,-0.228548,-0.147529,-0.0823609,-0.571798,-0.374785,-0.00158195,0.228713,0.39417,0.237531,0.150668,0.107462,0.0682504,-0.248091,0.481341,-0.0990485,0.11464,0.262283,-0.22802,0.262638,-0.254034,-0.393744,0.0379762,0.467646,-0.23787,-0.0178432,-0.241742,-0.147844,0.478691,-0.0408081,-0.295044,0.0177302,0.215091,0.075064,-0.00520885,0.0752971,0.880247,-0.36365,-0.0508463,-0.165842,0.0444648,0.109343,0.556914,0.425942,-0.141455,-0.210447,0.300656,-0.145716,0.10671,-0.108803,-0.226017,0.147946,0.200683,0.123401,-0.246917,0.152433,0.077629,-0.361176,-0.623249,-0.0269204,0.973148,-0.0483216,-0.196491,-0.197669,-0.501495,-0.49048,-0.644202,0.0285902,-0.0783421,0.0408223,-0.168133,-0.0141109,0.0644982,-0.3028,-0.0871924,0.396521,0.326773,0.360943,0.0600637,-0.269196,0.306471,-0.183135,-0.375473,0.450903,0.00258343,-0.557994,0.178616,-0.187449,0.761264,-0.163188,-0.299567,-0.335436,-0.397975,0.203273,-0.160675,0.151051,0.216492,-0.312334,-0.278123,1.09546,0.0961064,-0.271704,0.0643199,-0.247889,0.0459487,0.0322349,0.523248,-0.207925,-0.41003,-0.155493,0.206028,0.226326,0.189997,0.247135,-0.0169554,-0.286286,0.423844,-0.129337,-0.284657,0.871073,-0.513833,-0.43949,0.22254,0.27691,-0.281023,0.31587,-0.394702,0.567001,0.0745458,0.0268358,-0.628252,-0.23781,-0.375147,0.58456,-0.30511,-0.141271,0.198742,0.186847,0.0428203,-0.251939,0.204297,0.0816662,0.348507,0.043539,0.766402,0.114227,0.142945,-0.0486799,0.112102,-0.222138,0.114904,0.180708,-0.156582,-0.0997509,-0.0450802,0.151937,-0.484512,-0.114447,0.128466,0.378235,0.0563641,0.0552534,0.194787,-0.0247757,-0.0063047,-0.167302,0.518427,-0.182405,0.42894,-0.0382334,-0.555069,0.0922625,-0.0720864,0.538337,0.057331,-0.28035,-0.170459,-0.351592,0.114269,-0.43426,0.233642,-0.175561,0.0938367,0.197358,0.306328,0.444249,-2.81661 +3439.95,0.979148,0.0912059,4,1.64132,0.909515,-1.32354,0.472144,-0.0076249,-0.0966349,0.328405,-0.0380557,0.610516,0.549409,-0.574982,-0.536623,-0.443243,0.424624,-0.147436,0.582105,0.23037,-0.252526,-0.188835,0.18504,-0.161239,-0.682751,-0.870835,0.355627,-0.261562,-0.285447,0.125884,0.378857,-0.820526,-0.313271,0.690423,-0.587769,-0.348059,0.391433,-0.441725,-0.131546,-0.931264,0.596997,-0.179178,-0.250517,0.978463,0.291564,0.659441,-1.38051,-0.319975,0.484767,-0.346992,-0.41955,0.88095,-0.155934,-0.0469818,0.477163,0.146046,0.0735592,0.152386,-0.459109,-0.749403,-0.697124,0.26037,0.313385,0.424199,1.01117,-0.364563,-1.13726,0.0513354,-0.226758,-0.319419,-0.655928,-0.488536,-0.229961,0.262933,0.660124,0.585312,-0.141546,0.786994,0.433618,-0.122648,0.0372243,-0.0296602,-0.42055,0.065073,-0.928838,0.00755354,0.375492,0.327189,-0.07665,0.350411,-0.835404,0.381109,-0.160321,-0.244742,-0.348771,-0.403572,-0.259834,0.193884,0.126122,0.250458,-0.232225,-0.039559,0.0843896,0.433601,-0.903847,-0.0576775,0.120476,-0.323259,-0.237724,-0.00198438,-0.321343,0.323938,0.247556,0.101187,-0.0373271,0.165096,0.436075,0.52409,0.144171,-0.503939,-0.00896789,0.0392655,-0.127448,-0.739854,0.0394344,0.154499,0.197456,0.0950375,0.0224035,-0.128976,-0.54746,0.396108,-0.108177,0.0813821,-0.0634964,0.0504029,0.495155,-0.0329071,0.0456365,-0.0674974,0.208654,0.260774,-0.0428104,0.0360559,-0.321111,0.184416,-0.276343,-0.128981,0.506145,0.31892,0.2205,-0.254273,0.0934012,-0.630421,-0.234157,-0.00946274,-0.0917576,0.436997,0.0305529,0.95471,-0.0146468,-0.100931,0.3748,0.29111,-0.384695,0.668982,-0.053357,-0.121152,0.40388,-0.218105,0.0446162,-0.245398,0.158571,0.0424389,-0.480277,0.0422422,-0.235087,-0.1139,-0.20622,-0.184574,0.0786951,-0.407955,0.316579,-0.109123,-0.305213,0.48804,-0.275285,0.059375,-0.13795,-0.261254,-0.544515,0.425751,-0.30446,-0.013133,0.019161,0.0812591,-0.756361,-0.211325,-0.043015,-0.116732,-0.564283,-0.262198,-0.203891,-0.186085,-0.447016,0.0948293,0.269778,0.0346263,0.064471,-0.508581,0.964304,0.00809528,0.344579,-0.10174,-0.153334,0.0163,0.659225,0.109514,0.367349,-0.412288,0.394809,0.110304,-0.356273,0.53581,-0.704559,0.208127,0.047236,-0.287796,-0.0788142,-0.0580951,0.135596,-0.00685235,-0.109983,-0.614083,0.178562,0.248236,0.207486,0.28676,0.130555,-0.244761,0.127909,0.0580235,-0.203108,0.494274,0.179806,-0.394209,0.160616,-0.158499,0.785337,0.521878,0.00451923,0.387834,-0.0489412,-0.0940475,-0.378917,0.361674,0.163468,-0.046559,-0.126433,-0.378517,0.072017,0.562796,-0.208184,0.0926178,0.536062,0.127849,-0.260855,0.475437,0.327137,0.0513728,0.0682453,-0.331096,-0.221943,-0.537523,-0.182643,-0.656551,0.16291,-0.131427,0.022385,0.231895,-0.4108,-0.010549,0.185451,-0.0663107,-0.105071,-0.587137,0.393109,-0.254015,0.0552245,0.0284687,0.102775,0.0618577,0.269803,0.246607,0.142282,0.195217,0.243224,-0.167399,-0.583181,-0.135263,-0.11178,-0.483197,0.0694497,-0.330751,0.112115,0.261614,0.334836,0.511482,0.330461 +3456.4,0.911987,0.0912059,4,1.61437,0.797946,-1.55493,0.729967,0.469561,-0.168716,0.00269082,-0.121617,0.505414,-0.552799,0.106741,-0.0987951,-0.122293,0.641037,-0.347094,0.708535,0.199161,-0.338952,-0.052445,0.11886,-0.191632,-0.821146,-0.844765,0.640414,-0.409852,-0.225562,-0.136496,0.00614532,-0.506668,0.339422,0.893409,0.343815,0.184084,0.359936,-0.681893,-0.117581,-0.264187,0.804162,0.321537,0.0320718,0.723745,0.81771,0.357002,-0.487853,-0.270951,0.0746232,-0.759628,0.00421713,0.158751,-0.292207,0.325835,-0.0243935,-0.479896,-0.698876,-0.00871251,-0.396173,-0.0851581,-0.69908,0.0578387,-0.973627,0.627519,0.855921,-0.86773,-1.35513,-0.196872,0.0248034,-0.410368,-0.441964,0.141823,-0.236947,-0.569875,-0.0641446,0.348636,-0.109781,0.387519,0.455965,0.358989,0.0165485,-0.615985,0.132121,0.0937348,0.348917,0.0806973,0.0325286,-0.559687,0.30339,-0.274816,0.645327,-0.0515119,-0.17016,0.157262,0.287141,-0.219025,-0.278228,-0.243526,-0.131396,-0.00383139,0.14368,0.0070421,0.265112,0.192221,-0.022592,-0.565588,-0.0775369,0.0706477,0.0443134,0.842473,-0.433431,-0.434893,0.452762,-0.11872,0.373092,0.320087,0.493891,0.388683,0.00454969,-0.335404,0.395929,0.390195,0.191428,-0.626042,-0.15094,-0.175488,-0.680335,0.0126134,0.150746,0.156845,0.421856,0.336732,-0.0366379,0.257981,0.0152106,0.404387,0.274864,-0.0806384,0.110978,-0.148777,-0.375649,0.364486,-0.257522,-0.00442478,-0.281078,-0.0991832,-0.211983,-0.174862,-0.278241,0.258599,0.36643,0.0243164,-0.0362329,-0.159173,-0.0390011,-0.00589503,-0.0364862,0.439566,0.505189,0.223264,-0.334238,0.103594,0.169765,-0.0654472,-0.256171,0.227925,0.127577,0.106404,-0.0307412,-0.239692,-0.0180708,-0.435257,0.634064,0.613387,0.0826242,0.0710887,0.0749659,-0.0150159,-0.368086,-0.289982,0.312983,0.122153,0.923064,-0.0963752,-0.126395,0.355226,0.041751,-0.137976,-0.362033,-0.0858426,0.0782118,0.224367,-0.182376,-0.316775,0.303473,-0.0331426,-0.186191,0.661084,0.247578,0.0473865,-0.0143591,-0.0205904,-0.266754,-0.241924,0.342441,0.0149032,-0.370349,-0.305613,0.181908,-0.272784,1.00291,-0.369784,0.00885813,-0.532052,-0.0827856,0.245356,0.219632,-0.0504473,0.567355,-0.0339483,-0.0315357,-0.406129,0.451283,-0.221722,-0.517857,0.258969,0.374971,0.0392215,0.0669557,-0.381133,-0.504725,-0.0204787,0.480483,-0.44012,0.0979361,-0.194008,-0.210597,-0.408576,0.365454,0.426278,-0.00160402,0.592053,-0.447667,-0.149753,-0.0742942,-0.0561364,0.293147,0.174348,0.130651,0.639864,-0.237978,-0.11991,-0.377659,0.309448,-0.229918,0.323538,-0.157132,-0.347383,0.223176,-0.111007,-0.15856,0.131123,-0.223205,-0.0168274,0.334874,-0.219535,0.669305,0.0931883,0.0701518,0.0451891,-0.69852,0.244405,0.286553,0.0714933,-0.23364,-0.0731448,-0.0725289,-0.183142,-0.374307,0.178331,0.404259,-0.348037,-0.265582,0.144807,0.206297,0.018106,-0.0243724,-0.0899714,0.204215,-0.293728,0.520653,0.159067,-0.397565,0.0806302,-0.165032,0.0678748,-0.0696506,-0.388462,-0.370999,0.166929,-0.125487,-0.142998,0.301563,0.203642,0.0893027,0.245083,0.298836,0.495058,-1.18831 +3454.2,0.886815,0.0912059,4,1.53562,0.7242,-0.833832,0.450047,0.200392,-0.175361,0.170155,0.658121,-0.15085,0.533405,-0.239705,0.022519,-0.472079,0.742851,-0.108621,0.861249,0.644717,0.234009,-0.0641881,0.372671,0.07496,-0.414584,-0.552819,0.556052,0.0217782,0.404479,0.335292,0.630686,0.123835,-0.277175,1.02536,-0.864107,-0.0777479,0.351508,-0.32159,-0.190378,-0.597429,0.589362,0.619283,-0.854807,1.05428,0.273754,0.275115,-1.24967,-0.0509414,0.149155,-0.347054,0.538215,0.430271,-0.251689,0.0463755,0.0174252,-0.126667,-0.208305,0.898182,-0.175386,-0.527361,-0.794108,0.232458,-0.0146092,0.165571,0.588385,-0.777717,-0.232329,0.386391,0.196266,-0.0867457,0.388392,0.179968,0.03119,0.118954,0.387185,0.388187,0.48135,0.406285,0.259846,0.431106,0.0162197,-0.198828,-0.0888066,0.433987,-0.63892,0.000732193,0.0154527,-0.000439221,-0.517355,0.205288,-0.897176,0.264873,-0.323941,-0.367265,-0.176372,0.193571,0.241554,0.188054,-0.284944,0.0146955,-0.637007,0.3197,0.158326,0.0790873,-0.451445,0.368887,-0.338308,0.376281,-0.255508,-0.489629,-0.212958,0.607931,0.135802,-0.0632938,-0.335712,0.236471,-0.0983134,-0.252432,0.0946927,-0.119727,-0.221642,0.124194,-0.372834,-0.0653336,0.298625,0.0245227,0.41423,-0.218426,-0.0766053,0.0507832,0.110481,0.173481,-0.364143,0.109737,-0.293087,-0.134357,0.421547,-0.213174,-0.409984,-0.00281781,-0.258222,0.364806,-0.452678,-0.387509,0.00719363,0.227632,-0.483955,0.274424,0.164193,-0.426512,0.179362,-0.122237,-0.352258,-0.310283,0.0177007,0.120487,-0.124091,-0.412575,-0.0973791,-0.077568,0.20222,-0.0166046,-0.0292343,0.496675,0.277255,0.606993,0.0590229,-0.306915,0.154649,-0.196997,0.0514581,-0.207716,-0.379055,0.0683867,-0.300567,-0.477729,-0.0822906,0.0273784,0.0715103,-0.0337518,-0.2509,-0.0774634,0.416249,0.36325,-0.0158694,0.167207,-0.0196769,-0.15212,0.317113,-0.19123,-0.280883,-0.0812978,0.09472,0.109526,-0.0772119,-0.101084,-0.559032,-0.214623,0.15566,-0.369588,-0.210302,-0.53925,0.277608,-0.191468,-0.61921,-0.107288,0.121546,0.101278,-0.382416,-0.451616,0.933332,0.220477,-0.0683309,0.418615,-0.0191912,-0.207905,0.271592,-0.311013,-0.265952,-0.132999,0.233629,0.639129,-0.562606,0.405574,-0.232257,-0.110114,-0.097905,-0.529087,0.221881,0.132079,-0.049245,0.218594,-0.268524,-0.108238,-0.288567,-0.16419,-0.0303644,0.026268,0.47167,-0.0379834,-0.299846,0.421637,0.238834,-0.234395,0.0867202,0.0104957,-0.436564,0.377274,-0.0134224,0.423021,0.51668,0.346716,-0.362212,-0.30896,-0.847538,0.20201,-0.053746,0.0272576,-0.259648,-0.0964721,0.0392911,-0.0235983,0.146707,0.173593,-0.080635,0.175695,-0.432794,0.117805,0.135453,0.125492,0.51241,-0.377778,-0.171552,-0.266168,0.0753661,-0.0772049,0.10394,0.0701925,0.268276,0.143271,-0.402979,0.645535,0.259606,-0.213792,-0.492845,-0.319279,0.0891468,-0.163497,0.254936,-0.182141,-0.187884,0.453052,0.130976,-0.299976,0.581672,0.119053,0.544491,0.227917,-0.134177,-0.386129,0.348294,0.0666565,-0.476787,0.00177135,0.0823313,0.249342,0.286934,0.499342,-0.35485 +3436.22,0.99852,0.0912059,4,1.60136,0.62396,-1.65465,0.634424,0.460412,0.00364129,0.00249869,-0.058,0.116604,-0.414136,0.350342,-0.210648,0.454625,0.239198,-0.138308,0.805442,0.385323,0.14207,-0.0670093,-0.233426,0.243727,-0.960757,-0.944186,0.549258,-0.453702,-0.379615,-0.499409,0.190536,-0.339199,0.182266,1.18964,-0.49392,0.0884407,0.380904,-0.253363,0.147278,-0.412095,0.36864,0.59184,-0.229343,1.01179,0.680685,-0.119782,-0.632198,-0.113426,-0.0992652,-0.411181,-0.0424302,0.545008,-0.148511,-0.048087,0.587784,0.295408,-1.00818,0.93855,-0.242392,-0.121902,-0.267961,0.559809,-0.348371,0.510181,1.06578,-0.718886,-1.2972,-0.265123,-0.165585,-0.182794,0.22044,0.0224189,-0.573038,0.0999507,-0.0729084,0.752675,-0.492787,0.22128,0.26651,-0.0153258,0.0775463,-0.220784,-0.152169,0.518489,0.576336,0.334148,-0.28774,-0.432265,0.703943,-0.52364,0.371531,-0.100603,-0.30769,0.740716,-0.0881102,-0.472634,-0.00409167,-0.25194,0.225688,0.117097,0.0735526,0.446157,0.111554,0.202941,0.104457,-0.35974,-0.0476293,-0.407702,-0.307525,-0.0792706,-0.345226,-0.00391732,0.968968,0.296276,-0.170998,-0.0729436,0.180829,0.130308,0.251377,-0.442958,0.130489,-0.0396711,-0.106981,-0.803045,-0.257864,0.00382461,-0.624267,-0.0715858,-0.354238,0.291142,-0.0047089,0.0767568,-0.0213116,-0.277487,0.375158,0.182126,0.294146,-0.280119,0.0178054,-0.379255,0.326265,0.329086,0.0183887,-0.38166,-0.141338,-0.0924269,-0.624431,-0.1138,-0.387417,0.361423,0.891862,-0.320241,-0.013048,0.010609,0.315913,0.169944,-0.0259511,0.437281,0.593716,-0.15955,-0.0267824,-0.104748,0.101378,0.070825,0.226348,0.411631,0.163471,0.185084,0.117797,-0.115047,0.251009,-0.194546,0.0130512,0.262881,0.171677,-0.161105,0.355261,0.219087,-0.416159,-0.423039,-0.222676,0.00967863,0.766149,-0.341015,-0.744613,-0.110616,-0.0903381,-0.591818,-0.774542,0.0640475,-0.433805,0.333947,-0.757089,-0.0905386,0.399738,-0.188262,-0.365708,0.197304,0.192106,0.502278,-0.0528288,-0.389918,-0.446048,0.0915279,0.114074,0.263982,-0.289066,-0.121172,0.170263,0.110145,0.710508,-0.325918,0.410218,-0.083862,-0.213951,0.333078,0.158142,-0.0486468,0.193096,0.0844875,-0.0108681,-0.323482,0.480832,0.0921047,-0.744851,0.149398,0.181628,0.000882686,0.199674,-0.229923,-0.126892,-0.0721217,0.111924,0.268832,-0.249046,-0.188015,-0.22464,-0.368322,0.152496,-0.0740661,-0.0388816,0.459509,-0.254763,-0.17387,-0.0831945,-0.351786,0.222614,0.0955258,-0.143253,0.161451,-0.874575,-0.586628,-0.323028,0.21424,-0.0148155,0.263345,-0.49659,-0.269597,0.69591,-0.218462,-0.144101,0.413077,-0.265063,0.16017,0.486367,0.00436522,0.0366846,-0.299212,0.0590629,-0.315714,-0.328529,-0.045465,0.349294,-0.106672,-0.682441,-0.109417,-0.0976396,-0.333048,0.121177,-0.0686473,0.119397,-0.325642,0.127537,-0.198154,0.0845799,-0.198851,-0.0486113,0.0954537,-0.114646,-0.145992,0.483815,-0.155532,0.0379327,-0.373088,-0.494373,-0.122344,-0.593895,-0.483793,-0.492686,0.319794,-0.427923,-0.145046,0.00780158,0.323492,0.106429,0.248914,0.326235,0.498913,-0.763437 +3415.01,0.955449,0.0912059,4,1.55377,0.570894,-1.58474,0.697946,0.0502265,-0.0896692,-0.224032,0.123669,-0.517875,-0.0602726,0.0843611,0.289443,-0.257138,0.732249,-0.215116,0.371691,0.370272,-0.00670068,0.179565,-0.134331,0.165602,-0.441201,-0.646786,0.554479,-0.344989,-0.219173,0.0794172,0.627168,-0.45724,-0.166676,1.04832,-0.452845,-0.460852,0.611452,-0.509259,-0.497289,-0.363764,0.217133,0.0180186,-0.478052,1.25354,0.701199,0.31188,-0.885045,0.28388,0.171979,-0.582478,0.598318,0.346691,0.00222002,-0.158193,0.356445,-0.10559,-0.174842,0.787924,0.0152706,-0.338823,-0.229049,0.230698,-0.0967912,-0.223545,0.74994,0.136399,-0.791359,0.320508,0.290345,-0.238984,-0.151843,0.337241,0.0202669,-0.678904,0.430458,0.525992,0.161805,0.877562,0.773443,0.590279,-0.0117732,0.437173,0.463622,0.620922,-0.305551,0.252657,-0.116726,0.11375,-0.508867,-0.568998,-0.503169,0.0813082,-0.315512,-0.78851,-0.2321,0.156665,-0.00333201,0.1528,-0.17447,0.637737,-0.0612396,0.407573,-0.200611,-0.388834,-0.204674,-0.0540137,-0.930206,-0.101012,-0.226114,-0.103738,-0.0713821,-0.126664,0.446645,0.00351038,0.316881,-0.208081,0.0877608,0.19459,-0.253962,-0.496309,-0.111434,0.273538,0.283761,-0.115329,-0.0843549,-0.134876,0.253213,-0.0366744,0.141484,-0.104276,0.0794826,0.665742,-0.204507,-0.406769,-0.105785,0.132565,-0.0229538,-0.139328,-0.0608626,-0.535522,0.586137,0.49106,-0.392638,-0.179858,0.131901,0.502172,-0.0920681,0.139362,0.28746,-0.0472566,0.184405,0.0297575,-0.566037,-0.0788326,-0.127088,-0.441899,0.425659,-0.110719,0.634581,0.602253,0.477207,-0.340043,0.0630265,-0.215171,-0.287712,0.515492,-0.0737093,0.0934783,-0.177403,-0.0396561,-0.134628,-0.370389,0.385525,-0.346871,0.0914988,-0.423008,-0.152625,-0.0221274,-0.737104,-0.0431274,0.247397,0.835235,0.509472,-0.15127,0.220221,0.631498,0.25789,-0.092746,-0.107572,-0.445168,-0.0664004,-0.370297,-0.722866,-0.0245217,0.0991759,0.00539184,-0.484278,-0.0374693,-0.309667,0.254835,0.274567,-0.0563775,0.255723,-0.0710476,-0.105701,0.0257011,-0.0563851,-0.79104,0.177701,-0.717826,1.11816,0.303295,0.0282677,-0.00985443,-0.200403,0.174334,-0.317676,0.211035,0.438183,-0.237951,0.256024,-0.141653,0.267836,0.0882307,-0.797921,0.0899633,-0.301309,-0.101345,0.54614,-0.0308891,0.0149976,-0.039769,0.237611,-0.0911489,-0.137553,-0.562259,0.246249,-0.356561,0.339771,0.386892,0.235518,0.594805,-0.240018,0.301241,0.102692,-0.204967,-0.0702809,1.14023,0.356522,0.618717,-0.103411,-0.182564,0.0565038,-0.058242,-0.917668,0.385672,-0.182408,-0.0590822,0.00620876,-0.246763,0.340428,0.125791,0.544599,0.722236,0.352484,0.532394,-0.321991,0.216018,0.129539,0.0959003,-0.160057,0.161684,-0.196872,0.00987401,0.088363,0.236052,0.40249,0.111009,-0.868268,-0.0221287,-0.0805927,0.269983,0.128017,-0.273052,-0.581002,0.085101,0.0923402,-0.386875,0.0326667,0.134934,0.0728659,-0.231377,-0.556675,-0.179146,0.290813,-0.170639,0.276058,-0.240726,-0.608517,-0.415778,-0.160547,-0.815897,-0.655354,-0.386035,0.143892,0.192734,0.379332,0.439015,0.570874 +3432.69,0.968574,0.0912059,4,1.52892,0.482014,-2.04434,0.92431,0.180528,-0.109602,-0.149655,0.000958968,-0.0458276,0.242366,0.0137184,0.129697,0.0432011,0.830527,-0.0130748,0.634988,0.432858,-0.0290698,0.00244404,-0.135477,-0.0207734,-0.60767,-0.732157,0.910923,-0.215316,-0.471341,-0.10368,0.0592644,-0.795165,0.212,0.842677,-0.273294,-0.64475,0.474031,-0.382825,-0.470248,0.438024,0.337561,0.428565,-0.679277,0.729978,1.04283,-0.00388031,-0.519577,-0.299423,0.475004,-0.457509,-0.0113487,0.308,-0.244088,0.155423,0.511292,0.25847,-0.837025,0.50033,-0.33458,0.0559845,-0.714682,0.452706,-0.246851,0.213726,0.789484,-0.770987,-1.85054,0.113618,0.446142,-0.0954378,0.0338864,0.166564,0.27952,-0.23365,0.478294,0.494774,0.054798,0.399946,0.478123,0.297118,-0.0611606,0.202421,0.287198,0.274788,-0.448318,0.206915,-0.105015,-0.341943,-0.0154805,-0.276242,-0.463838,-0.281273,-0.454292,-0.677466,-0.228079,-0.388584,0.0290866,0.0179331,0.0898828,-0.114337,0.0375233,0.141107,0.231665,0.148289,0.501015,-0.891884,-0.326889,0.260178,0.219122,0.302798,-0.235175,0.342292,0.940625,-0.143775,0.074757,0.216671,0.0998745,0.142941,-0.0759162,0.204304,-0.0606239,0.375382,-0.0962176,-1.18792,-0.0595173,0.331295,-0.533992,0.145609,0.189078,-0.0379615,0.35171,0.48811,-0.467934,0.0348138,-0.222683,0.522695,0.0590253,-0.311713,-0.0126964,-0.0770618,0.22013,0.397691,-0.551512,0.116911,0.138935,0.120957,-0.45607,0.070145,-0.135832,0.443152,0.705006,-0.0477695,-0.366358,-0.259491,0.389323,-0.128486,0.184286,0.0412075,0.701657,0.526071,-0.274614,0.248433,0.145881,0.278874,-0.483796,0.677884,-0.0362438,-0.400422,0.055213,-0.30085,0.0270242,-0.00553785,0.0592632,-0.468539,-0.192951,-0.276118,-0.522924,-0.405835,-0.0208497,-0.586534,-0.380834,0.467588,0.835639,0.376381,0.0200847,0.462154,-0.130906,-0.157763,0.0271765,-0.724764,-0.150328,0.135253,-0.76399,0.253534,0.185465,0.332507,-0.325876,0.129281,-0.0243059,0.74772,-0.313881,-0.0430554,-0.0435467,0.02385,-0.0712722,0.0240024,0.253969,-0.428544,0.22266,-0.524535,1.09207,-0.817582,0.479891,-0.150194,-0.0953949,0.412413,0.157867,0.086234,-0.0887603,-0.359104,0.176778,0.405856,0.347547,0.0254047,-0.31074,0.0683179,-0.289274,-0.16562,0.354371,-0.017566,-0.287358,0.465875,-0.411675,0.178945,-0.204402,0.58379,-0.342952,-0.192827,0.0276633,-0.341757,0.257444,0.542102,-0.306089,0.0981523,0.0103126,0.213088,0.508092,0.312848,0.00496914,0.416656,-0.0584902,-0.0442243,-0.503378,-0.146086,-0.680969,0.262222,0.209435,-0.0919721,0.203395,-0.157553,0.00466496,-0.0731429,-0.263836,0.07706,0.61311,-0.26389,-0.302298,0.293576,-0.271516,-0.0898012,-0.397859,0.460957,0.137735,-0.0513048,0.0444727,-0.715297,0.400138,-0.187788,0.0950479,-0.162031,0.00434654,0.69775,-0.141072,-0.403364,-0.0876578,-0.301683,0.198558,0.232501,0.184759,-0.103928,0.402473,0.13017,-0.837053,-0.205119,-0.0307334,-0.109778,0.221865,0.13763,0.283606,0.226833,0.275869,-0.53468,-0.524339,-0.0680806,0.114571,0.276134,0.338484,0.525484,0.302371 +3401.39,0.611588,0.0912059,5,1.57519,0.571345,-1.99595,0.946996,0.235685,-0.025672,-0.331669,-0.807984,-0.175037,-0.025871,0.105848,0.0784873,-0.0195376,0.749593,-0.280144,0.729796,0.498062,-0.260702,-0.413445,-0.15706,0.290099,-0.748692,-0.404471,0.657351,-0.552734,-0.407035,-0.382391,0.259153,-0.284203,-0.0374917,1.10804,-0.353836,-1.14957,0.217106,-0.725353,-0.731041,0.475512,0.64396,0.567707,-0.409398,1.05793,0.56565,0.194185,-0.791882,0.0468003,0.0847036,-0.451548,0.378281,0.323184,0.00309834,-0.232704,0.344748,-0.0440255,-0.837879,0.167842,-0.264901,-0.0947287,-0.243586,0.359542,-0.301612,0.166044,0.936534,-0.923248,-1.61006,0.168946,-0.165464,0.0649826,-0.325335,-0.0639179,-0.0416927,-0.0346929,0.119634,0.466307,0.255967,0.534206,0.567205,0.24307,-0.120771,-0.0836793,0.154584,0.511747,-0.561993,0.270477,-0.151299,-0.106137,-0.397605,-0.231483,-0.418745,-0.0675292,-0.363329,-0.799174,-0.169801,-0.157091,0.0543659,0.0159188,-0.00515313,0.113306,-0.097436,0.355217,0.0129205,-0.0287995,0.655258,-0.588222,0.176022,0.570124,0.227052,0.0429651,0.0728078,0.536715,0.730082,0.459902,-0.196732,-0.0574341,0.105269,0.213467,-0.0382734,0.19059,-0.169563,0.153919,-0.284441,-1.22908,-0.261579,0.0895515,-0.405426,-0.055961,0.284537,0.0898372,0.350913,0.612025,-0.864135,0.0579752,-0.261611,0.553635,0.278042,-0.57441,-0.0622075,0.42929,0.220243,0.337793,-0.964574,0.308257,-0.132802,0.435606,-0.739004,0.292508,-0.336453,-0.172621,0.582209,0.138356,-0.143689,-0.586866,0.174219,-0.61099,0.256395,0.0956957,0.708362,0.217522,-0.268683,0.369791,-0.270078,0.540332,-0.192578,0.758399,0.15165,-0.389084,-0.17089,0.0138634,-0.0533906,-0.0259543,0.437045,-0.552019,-0.247665,-0.136216,-0.572571,-0.517709,0.214723,-0.38382,0.0671286,0.311716,0.983804,-0.391741,0.015896,0.177437,0.25484,-0.0248735,-0.0391289,-0.779787,-0.0371204,-0.0457768,-0.463751,0.073972,-0.0827412,0.194579,-0.181557,0.0210338,0.241989,0.6387,-0.0556255,-0.221383,-0.287974,-0.140709,-0.417275,-0.440677,0.535628,-0.314614,0.13277,-0.740215,1.03144,-0.364131,0.223926,-0.0134685,-0.41912,0.110797,-0.264829,-0.106781,0.501925,-0.532005,0.348172,0.702348,-0.0528183,-0.025218,-0.317016,0.268425,0.471023,-0.026329,0.353449,-0.460584,-0.341966,0.352183,-0.333951,-0.205185,-0.14852,0.210056,-0.666279,0.171829,-0.0605217,-0.39677,0.654902,0.674856,0.128635,0.0494813,0.259837,0.278235,-0.208991,0.478373,0.0529966,0.680193,0.224552,0.11132,-0.340521,-0.0197323,-0.578709,0.349606,0.530192,-0.344082,0.187844,-0.24666,0.180375,0.122189,-0.191915,0.711178,0.865046,-0.226676,0.24316,0.244191,0.246632,0.0789579,-0.643282,-0.10286,0.0915521,0.124998,-0.119011,-0.543623,0.291013,-0.165522,-0.26495,-0.309339,-0.371316,0.515906,-0.226158,0.0325773,-0.444399,0.060833,0.422996,-0.00844528,0.26584,-0.100741,-0.0413677,0.0220699,-0.479366,-0.253296,0.0660618,0.123863,0.322085,-0.0669105,0.0174582,0.443047,0.205434,-0.661411,-0.81686,0.257444,0.14729,0.334028,0.383784,0.577951,-0.0603218 +3412.92,0.997005,0.0912059,4,1.61988,0.567883,-1.66831,0.731539,0.0804699,-0.0322912,0.0895636,-0.0311402,2.62992e-05,-0.0187388,0.0491137,0.331767,-0.131031,0.761543,-0.77697,0.381579,0.652955,0.00985092,-0.481885,-0.0696399,-0.0176188,-0.48482,-0.596332,0.777502,-0.469092,-0.0868998,0.0161821,0.27863,-0.276461,-0.0837575,0.794537,0.108724,-0.742178,0.470315,-0.0684463,-0.278041,-0.335011,0.279667,0.69896,-0.375431,0.763835,0.85249,0.0279818,-0.575364,-0.371067,-0.263732,-1.096,0.301825,0.0670481,0.151497,0.083642,-0.0483644,-0.101914,-0.582295,0.423618,0.380316,0.0734354,-1.17503,0.495442,-0.0471485,0.285528,1.01084,-0.933311,-1.47882,0.126676,0.12973,0.133679,-0.0700489,0.114017,-0.168066,-0.495506,0.0722059,0.622382,0.210587,0.0208083,0.0229357,0.151627,0.356897,0.134436,0.321764,0.493751,-0.61222,0.322714,0.131826,-0.0159595,-0.442217,-0.0199813,-0.0352611,-0.110895,-0.0470387,-0.338049,0.0650264,0.32593,-0.283834,0.989291,-0.185617,0.517801,-0.398666,0.129927,0.0571804,-0.581494,1.00157,0.0922671,-0.337777,0.346704,-0.670005,0.75831,0.288098,-0.0443952,0.588609,0.315515,-0.354822,0.413948,0.495532,0.0230145,-0.439215,-0.196179,-0.231718,0.466347,-0.422413,-1.11241,-0.517833,-0.0607758,-0.509254,-0.0540834,0.364474,0.332238,0.118934,0.24431,-0.379042,0.0720962,-0.326941,0.558454,0.480934,-0.519542,0.336612,0.394275,0.194807,0.568332,-0.538311,0.119256,0.184556,0.516156,-0.434993,-0.645373,0.329754,-0.343413,0.387435,-0.309038,-0.104204,-0.0999865,0.529393,-0.460675,0.237627,0.455382,0.680601,0.190371,0.0306754,-0.0303325,-0.507302,0.335959,-0.0428007,0.203923,-0.113004,-0.463952,0.0810028,-0.166785,-0.565605,-0.304204,-0.137268,0.0471407,-0.405727,-0.175435,0.659195,-0.154352,0.37342,-0.198231,-0.242085,0.072558,0.422552,0.0222007,0.308798,-0.184876,-0.363425,0.210767,-0.332954,-0.211199,0.0626001,0.0921305,-0.619426,-0.138775,0.431203,0.423668,-0.509118,0.115102,-0.0604667,0.420274,-0.475283,-0.383215,0.138383,-0.016638,-0.126092,0.295167,-0.486099,-0.258966,-0.151612,-0.0216459,1.023,-0.380058,0.290159,-0.173125,-0.305192,0.53917,-0.0796476,-0.00876871,0.083344,-0.216347,0.381188,0.0282949,-0.289161,-0.385748,-0.496466,0.260159,0.333903,-0.122714,0.674845,-0.453476,0.220769,-0.337812,0.249755,0.0069136,-0.0378613,-0.325322,-0.209687,-0.152529,0.459894,-0.0934017,0.381623,0.187009,0.334854,0.00543855,0.614461,0.245645,-0.18238,0.0558786,-0.376469,0.567611,-0.297944,-0.331862,-0.408466,0.396903,-0.246987,-0.0212152,0.300902,-0.621067,0.206291,-0.348971,-0.0173953,-0.0174082,0.224888,0.31816,0.168624,-0.563712,-0.428935,0.599109,0.498125,-0.0930223,-0.544281,0.22754,-0.0631263,-0.176306,-0.284195,-0.43669,0.00986627,-0.237551,-0.028613,-0.169971,-0.0808429,0.237274,-0.0559654,-0.0643614,-0.114574,-0.216528,0.178811,-0.158974,-0.263452,-0.182564,-0.146118,0.571371,-0.660209,-0.256858,0.177832,-0.119312,-0.118303,-0.375468,-0.289093,0.238132,0.00992595,-0.268057,-0.035209,0.0526399,0.119764,0.316481,0.34607,0.562566,0.53962 +3421.91,0.999433,0.0912059,4,1.58149,0.544424,-1.86104,0.821451,0.34291,-0.00235614,0.242371,0.0841127,-0.0674645,0.0152446,-0.00809497,0.18634,-0.438936,0.99345,-0.7748,-0.0141218,0.798248,-0.274548,-0.0743395,-0.0854534,0.0273187,-0.679344,-0.510498,0.423332,-0.611673,-0.355485,0.456167,0.481367,-0.336556,-0.0532397,1.06299,-0.101537,-0.617399,0.365422,-0.291523,-0.224591,-0.338784,0.531462,0.942812,-0.323405,0.934722,0.816198,-0.101421,-0.652908,-0.180558,-0.266541,-1.14236,0.427267,0.127731,0.28836,0.120293,0.0405044,-0.188361,-0.308742,0.507853,-0.0045609,0.0739419,-1.17569,0.434897,-0.422344,-0.09545,1.1102,-0.736085,-0.849076,-0.0181532,0.149234,-0.172347,0.162523,0.175296,-0.0974198,-0.0742665,0.216279,0.658326,-0.145545,0.226147,0.0579704,0.0871271,0.367696,-0.0874181,0.165318,0.169933,-0.445676,0.337982,0.229483,-0.11199,-0.507684,-0.178573,0.000725515,-0.126273,-0.183569,-0.682226,0.234489,0.170441,-0.189512,0.641115,-0.153057,0.599483,-0.267125,0.278927,0.241299,-0.185528,0.683844,0.0820891,-0.24398,0.16487,-0.460194,0.765153,-0.000371285,-0.198147,0.367191,0.719287,-0.343628,0.291697,0.238259,0.086425,-0.374555,-0.151459,-0.133759,-0.117609,-0.226888,-0.832867,-0.520918,-0.429967,-0.296801,0.00388252,0.10305,0.469324,0.330935,0.374001,-0.621099,0.147856,-0.185527,0.176178,0.679734,-0.517877,0.232773,0.379797,0.311684,0.620855,-0.631199,-0.0798484,0.365465,0.486899,-0.187888,-0.423278,0.252877,-0.315831,0.487759,0.0372541,-0.239733,-0.0740694,0.50305,-0.40811,0.404602,0.373822,0.773714,-0.0239745,0.166178,0.100517,-0.64453,0.190914,0.21647,0.315458,-0.355266,-0.598874,-0.239163,-0.236821,-0.160736,-0.255712,-0.463884,0.112421,-0.467559,-0.203521,0.565073,-0.258659,-0.0184214,-0.0164991,-0.44214,-0.0546011,0.495121,0.359327,0.0692674,-0.00299308,-0.524425,0.0560704,-0.0953782,-0.146773,-0.0494583,0.142866,-0.34899,-0.177919,0.528221,0.805909,-0.17596,0.152502,-0.119935,0.121433,-0.120337,-0.531104,-0.0640822,-0.107954,-0.292362,-0.0405246,-0.558794,-0.151068,-0.341422,0.172033,1.01166,-0.262005,0.0252224,-0.222006,-0.237223,0.471461,0.0941575,-0.17077,-0.173806,-0.156956,0.119662,0.230503,-0.0611355,-0.100135,-0.471512,-0.214326,-0.169596,-0.05611,0.718901,-0.652588,0.0931147,-0.441882,0.307126,0.0427885,0.109012,-0.393981,-0.576813,0.0136724,0.184342,-0.0415214,0.378736,0.465938,0.0383952,-0.141729,0.183965,0.445504,-0.16387,-0.09175,-0.440761,0.179235,-0.409243,0.147553,-0.580891,0.255081,-0.362529,0.0290324,0.11824,-0.426416,0.410596,-0.274342,-0.179785,-0.0932193,0.30199,0.397916,0.115672,-0.314852,-0.39592,0.457798,0.241448,-0.144334,-0.727066,-0.121634,0.0301017,-0.183198,-0.447179,-0.531817,0.291592,-0.309222,-0.298929,-0.0787731,0.155923,0.125171,0.0506905,-0.569567,-0.451133,-0.295377,0.068026,0.000622442,0.0668916,-0.181377,0.11275,0.242746,-1.05388,-0.168352,-0.0685126,-0.202372,-0.2933,0.0587882,-0.321442,-0.0454284,-0.339779,-0.537881,0.139478,-0.00346874,0.113333,0.265322,0.33665,0.515094,-0.320036 +3439.78,0.994536,0.0912059,5,1.48473,0.702898,-1.36053,0.509207,0.306047,0.00374718,-0.457025,0.16185,0.0282625,-0.338432,0.269048,-0.468213,-0.0835589,0.679871,0.188991,0.759767,0.360185,0.172193,-0.227691,-0.203526,0.18235,-0.0513312,-1.12263,0.13646,0.0112518,0.0444589,-0.23385,-0.440207,-0.34056,0.08981,1.11276,-0.725673,0.0950124,0.49899,-0.104764,-0.428498,-0.91268,0.334486,0.0855656,0.108798,1.11582,0.503347,0.622704,-0.554307,-0.511251,-0.261811,0.0121978,0.309698,0.44466,-0.0565903,0.176074,0.632896,0.29787,0.0289863,0.502361,-0.365779,-0.202095,-0.252855,0.533302,-0.019877,0.52002,1.12593,-0.654967,-0.521918,0.138953,-0.0753217,-0.298607,-0.108367,0.066166,-0.312755,0.0961206,0.352882,0.354155,0.135934,0.965346,0.448336,0.797323,-0.0618847,-0.12456,-0.187861,0.239634,-0.05166,0.475692,-0.28504,-0.346193,0.1587,0.05059,-0.0602405,0.360857,-0.418148,0.181072,-0.0678685,0.0666569,-0.17397,-0.0374317,-0.20627,-0.327106,-0.290704,-0.433164,-0.00565469,-0.0606921,-0.422906,-0.42859,0.153726,0.51492,-0.0294775,-0.42679,-0.108187,0.470828,0.604929,-0.23067,0.169378,0.209411,0.599953,0.353261,0.56844,-0.494272,0.24531,0.496001,0.482139,-0.250263,0.484383,-0.0637136,0.454229,-0.155776,-0.0310451,-0.228457,-0.0607463,0.212923,0.0604933,-0.228785,0.0392394,-0.123895,0.742308,-0.016058,-0.362233,-0.245341,-0.0918157,0.0987202,-0.503192,-0.364775,0.0802559,-0.303895,-0.430239,0.279435,0.089742,0.302785,0.360645,-0.299762,-0.0291138,0.159943,-0.151335,0.307061,0.258653,0.129017,0.0266318,0.244731,-0.308153,-0.181436,0.455647,0.262359,-0.0763709,1.20364,0.86776,0.62632,0.280874,0.271534,-0.302129,0.135862,0.259908,0.284952,0.0523301,0.250228,-0.409024,-0.0144732,0.183716,-0.363058,-0.0851337,0.245306,0.590339,0.183243,-0.416387,0.519879,0.500666,-0.278273,-0.503813,-0.205734,-0.286253,0.0945062,-0.215268,0.00710884,-0.102144,-0.425501,-0.920902,0.0621358,0.129296,0.0498726,-0.298583,-0.610547,0.513338,0.474239,0.0728716,0.140083,0.244678,0.299906,0.123405,-0.523593,0.81896,0.237362,-0.00153709,0.190082,-0.38373,-0.0830746,0.515549,-0.229988,0.513718,-0.125651,-0.0480793,0.353434,-0.105866,0.121487,-0.0218531,0.163016,0.433965,-0.668075,0.20825,0.193542,-0.345372,0.480069,-0.0521792,-0.159896,0.128213,0.0674774,0.168305,-0.449356,0.715107,0.115544,-0.407306,0.183857,-0.513269,-0.0813796,0.121058,-0.432318,-0.296701,0.669918,0.729461,0.55842,0.44169,-0.196712,-0.115826,-0.118773,-0.2058,0.130084,-0.228443,-0.152118,0.167502,-0.227482,-0.23354,0.0680419,-0.0195159,-0.467561,0.378469,-0.00998612,0.267737,-0.478172,0.0817209,-0.080594,0.0826653,0.310783,-0.210825,-0.45051,0.286659,0.296659,0.314314,-0.000184307,0.114589,-0.185662,-0.163151,0.203467,0.117169,0.490943,0.053327,-0.392064,-0.145978,0.139423,0.117721,0.0724791,0.108453,0.0884441,-0.23882,0.332665,-0.11768,0.241446,0.512181,-0.366345,-0.519063,0.12618,0.079282,0.415423,-0.291953,-0.103127,0.101748,0.201146,0.31898,0.448493,-0.542972 +3407.43,0.987556,0.0912059,4,1.45608,0.758527,-1.50333,0.479436,0.0562095,-0.145413,0.0629482,0.00891595,0.522897,-0.149934,0.0663219,-0.095238,0.0102162,0.284842,-0.317273,0.221305,0.513624,-0.135098,0.0485536,0.321953,-0.0351803,-1.27886,-0.746377,-0.00780763,-0.0527659,-0.327043,-0.219415,0.0787325,0.0154897,0.0635357,0.869026,-0.594505,-0.144507,0.562036,-0.00808211,0.21367,-0.15616,0.993515,0.65978,0.0547863,1.50312,1.08832,0.240493,-0.392574,0.339874,-0.422118,-0.798494,0.561901,0.477185,0.196472,0.0988143,-0.670251,0.162615,-0.208581,0.250188,0.288958,-0.00342827,-0.471113,0.371837,-0.324118,-0.0535095,1.05831,-0.385948,-0.0743806,-0.317601,0.106048,0.482665,-0.20427,0.309321,-0.279122,0.120423,0.16064,0.834865,0.118804,0.123525,0.051214,0.110229,0.392391,-0.0122102,0.0646851,0.586925,-0.321767,0.464691,0.291635,0.301316,-0.153635,0.235213,-0.242386,0.0997708,-0.436714,-0.113039,-0.56794,-0.0989394,-0.226432,0.462108,0.0280864,0.237624,-0.200666,0.348183,0.354149,-0.263057,0.713425,0.0207564,-0.364778,0.320759,-0.125855,0.209119,0.174937,0.280571,0.643736,-0.0226988,0.147289,-0.0368588,0.896374,0.331343,-0.158585,-0.0948674,-0.0864598,0.210678,0.00332736,-0.777373,-0.335506,-0.261282,-0.66068,0.577432,0.0451747,0.395496,0.331815,0.313657,-0.26531,0.391167,-0.243281,0.071429,0.71873,-0.486833,-0.060262,0.270355,-0.0589419,0.59966,0.0127654,-0.372601,0.216081,0.0480091,-0.443698,-0.0744065,0.120255,-0.0158061,0.418826,0.0613493,-0.0272004,-0.0672283,-0.34607,-0.0451979,0.303179,0.361632,0.799951,0.629907,0.0019289,0.0435152,-0.532307,0.270277,0.0508502,0.12358,0.274738,-0.204506,0.099886,0.0266,-0.103819,-0.137615,-0.50836,-0.460672,-0.039765,0.371818,0.10906,0.0200435,-0.398708,-0.0801075,0.0169876,0.63524,0.734151,0.251635,-0.0503666,0.713876,-0.0676198,-0.000428816,-0.718808,-0.167455,-0.0615175,0.57288,-0.749333,0.0661798,-0.0845193,0.246598,-0.352612,-0.166904,0.123951,-0.134404,-0.111986,-0.385854,-0.287645,0.0597989,-0.952909,-0.0535684,0.313921,-0.020807,-0.0598503,-0.963818,0.95472,-0.287072,0.293064,-0.417126,-0.273175,0.5781,0.463317,0.0538562,0.417361,-0.515462,-0.0523885,0.220831,-0.324429,-0.361982,-0.467825,0.127461,0.191758,0.0401575,0.680718,-0.594704,0.151546,0.145004,0.284565,-0.610353,0.683362,-0.4785,-0.160129,-0.679251,0.364739,-0.0108494,-0.300663,0.889468,-0.837372,-0.90284,0.81287,0.701194,0.332286,-0.316491,0.337692,0.404656,-0.195905,-0.0788289,-0.225984,0.210509,-0.226036,0.435922,-0.255987,-0.0683197,0.459488,-0.257997,-0.0241433,0.733767,0.549869,-0.0359244,0.642275,0.320324,0.162424,-0.459397,0.164289,0.0145508,0.518287,-0.842713,-0.0175532,-0.216551,-1.0371,-0.785026,-0.151265,0.296363,0.127898,0.0567496,0.422348,-0.00644239,-0.0307372,-0.019036,-0.387985,-0.0257555,0.343461,0.122377,0.519325,0.13303,0.45974,-0.0343983,0.370723,0.432883,0.00460265,0.00775858,0.0544228,0.0773757,-0.289372,0.287549,-0.244784,-0.506545,0.108001,0.00505517,0.174978,0.247629,0.418303,0.497623,0.299988 +3385.16,0.665104,0.0912059,4,1.37956,0.83874,-1.40224,0.425645,0.162412,-0.16681,0.156119,-0.128563,0.372486,-0.329371,-0.0901929,-0.646709,-0.159203,0.662825,-0.225954,0.945445,-0.0358659,-0.158608,-0.431082,-0.25937,-0.202629,-0.749555,-0.558142,0.13169,-0.0889952,-0.285904,0.128237,0.332056,0.778528,0.0461476,0.763786,-0.357729,0.273531,0.550336,-0.265933,0.0560384,-0.902776,0.717132,0.398806,0.0297729,1.1429,0.551908,0.31349,-0.479646,0.448007,0.166334,-0.652823,0.325025,0.39313,0.18513,0.241272,-0.0800931,0.49425,-0.213364,0.478402,0.0730412,0.287148,-0.11002,0.542547,-0.169235,0.580497,0.840793,0.0906578,-1.4424,0.312103,0.389251,0.090757,-0.253464,0.719889,-0.296409,0.244049,0.56214,0.389561,-0.459655,0.846258,0.925788,0.36843,-0.201228,-0.156965,0.0485258,0.494562,-1.02124,0.33333,0.246349,0.41108,-0.338485,0.128099,-0.734958,-0.114797,0.00209997,0.564998,-0.451093,0.0570351,-0.270643,-0.165967,0.224256,0.0867088,0.207092,0.379199,-0.191233,0.214584,0.454522,-0.173073,-0.705257,0.026244,-0.260181,0.452407,-0.490858,0.518221,0.451608,-0.347314,-0.109568,0.325977,0.676707,0.088863,-0.0273269,-1.04623,0.376051,0.190479,0.0743895,-1.03587,0.100259,-0.347989,-0.248649,-0.340938,0.337302,-0.223403,0.602346,0.208527,-0.681102,0.575908,-0.00219487,0.677832,0.589605,-0.252658,-0.460029,-0.177495,-0.942278,0.346818,-0.103863,0.148378,0.189225,-0.199609,-0.435672,-0.00967597,0.248075,-0.980898,0.37726,0.0504034,1.10896,-0.0623063,-0.166176,0.619892,0.0373765,0.339573,0.498402,0.0909906,-0.232461,-0.0414949,0.273172,-0.0926376,-0.0355983,0.288937,0.172987,-0.282912,0.474131,0.0633873,-0.0778855,0.212403,-0.402453,-0.0221826,-0.110012,0.400723,0.334644,0.0739957,0.166912,-0.160841,0.0699365,0.512096,0.930155,0.0464027,0.372897,1.15676,-0.560685,-0.075495,-0.467601,-0.252967,0.0596771,0.445146,-0.389123,0.0687465,0.197524,0.693807,-0.349098,0.171703,0.302843,0.292915,-0.0919716,-0.776155,-0.456761,0.498459,-0.688271,-0.118879,-0.347219,-0.487668,-0.909097,-0.423985,0.916717,0.0666006,0.390367,-0.338965,-0.0359459,-0.160466,0.512543,0.0977971,0.2438,-0.611899,-0.0436777,-0.21395,-0.379109,0.129765,-0.413102,0.565411,0.921925,0.0562763,0.643025,-0.551814,0.130132,0.0799849,0.346476,-0.200658,0.20498,-0.475862,-0.542765,-0.769773,0.672812,0.554653,0.494629,0.926499,-0.137257,-0.0970257,0.628686,-0.127032,0.0721831,0.430938,0.656167,0.674545,0.130072,-0.460124,0.0946955,0.158609,-0.711109,0.617478,-0.4232,0.138884,0.600905,-0.158283,0.306651,0.0313147,0.145546,0.1269,0.518061,0.204475,0.250864,-0.389954,0.797222,0.254659,-0.301438,-0.347998,-0.0864437,0.0693777,-0.581286,-0.600814,0.63715,0.143643,0.0189167,-0.0033019,0.665798,0.165476,-0.164382,-0.671671,-0.00436211,0.620829,-0.259822,0.615462,0.1588,0.0425942,0.219985,0.0391773,0.243775,0.550855,-0.55539,-0.538013,-0.072312,-0.354726,-0.252457,-0.077835,0.238459,-0.292259,-0.456151,0.216504,0.168223,0.239441,0.41015,0.489327,-0.267673 +3378.11,0.953354,0.0912059,5,1.58346,0.785319,-1.07966,0.327392,0.0984845,-0.183935,-0.155752,0.312038,-0.29657,0.141102,-0.0282126,0.507822,-0.180114,0.31925,-0.435625,0.507199,0.144757,-0.225414,0.133898,0.160933,-0.353014,-0.209437,-0.464858,-0.0749346,-0.335006,0.0542321,-0.622546,0.05006,-0.531896,0.596949,0.118331,-0.559918,-0.0394206,0.0257011,-0.356217,0.0597134,0.0111321,-0.0114142,0.0633461,-0.226766,0.445976,0.404222,0.165462,-0.486037,-0.559785,-0.0255728,-0.626216,-0.0985385,0.602857,0.0276907,-0.423991,0.169017,0.0489628,-0.248622,0.78723,0.116511,-0.117503,-0.638167,0.236573,-0.439905,0.0162041,0.984689,-0.932639,-0.382473,-0.312075,-0.231097,0.0740745,0.100747,-0.407425,-0.459889,-0.58405,0.136855,0.803047,0.490864,0.637291,0.413239,0.338027,-0.101058,-0.611023,0.128548,0.0115149,-0.141724,0.404277,-0.674871,-0.76625,0.233247,-0.155499,-0.266238,-0.202241,-0.0922515,-0.245304,0.349298,-0.312229,0.39727,-0.17661,-0.792908,0.04718,-0.537277,-0.110687,0.612997,0.0591326,-0.165672,-0.584477,-0.0458803,0.344948,-0.472738,0.115121,0.0340636,0.107427,1.45182,0.41372,-0.202891,-0.242154,0.208773,-0.0657726,0.096337,-0.116218,0.0757657,0.745223,-0.280047,-0.338914,-0.596808,0.258019,-0.0390354,0.306004,0.245213,0.411157,0.197566,0.379586,-0.605562,0.0230753,-0.0282652,-0.0472251,0.805341,0.133956,0.171325,-0.164968,0.106823,0.551047,-1.12254,-1.02638,0.223932,0.0855363,-0.794053,0.0610961,0.0610453,-0.197736,0.0415439,0.354037,-1.7991,-0.210654,0.269867,-0.00141207,-0.513787,0.258118,0.590993,0.486802,-0.0695339,0.06698,-0.450395,0.345162,-0.0878353,1.10462,-0.038988,0.16392,0.291681,-0.0841748,-0.105549,0.213988,0.619337,0.355115,0.25254,0.102705,-1.29833,-0.25277,-0.728731,-0.317489,0.144492,-0.245359,0.723393,0.330174,-0.288716,-0.510751,0.461187,-0.170871,-0.482609,0.303049,-0.524547,-0.35339,-0.547539,-0.029948,0.321992,-0.533448,-0.487382,-0.00155624,-0.0814152,-0.309714,-0.375384,-1.05733,0.239683,-0.110181,0.0269387,0.113395,0.285196,0.334909,0.231576,-0.72117,1.6618,0.536117,-0.34842,0.231288,0.0482745,-0.121293,0.0710135,-0.360049,0.541859,-0.141288,0.239247,0.946252,-0.643582,-0.35076,-0.437587,-0.518729,-0.641351,-0.398772,0.303314,-0.372376,-0.0127119,0.407398,-0.217904,-0.354314,-0.0891179,-0.0376366,-0.0555745,-0.380988,0.555216,-0.226615,-0.347379,0.459109,-0.721031,0.488546,-0.0553896,-0.178259,0.35003,0.238785,0.178662,0.305055,-0.0157514,0.522018,-0.72329,0.235373,-0.308703,0.272152,0.0428744,-0.455721,-0.231218,-0.279122,-0.628217,-0.248248,0.50853,-0.253949,0.45965,-0.0857312,-0.0218733,-0.101466,-0.834587,0.267415,0.109868,-0.158034,-0.0327925,-0.0540494,-0.417971,-0.38874,0.133431,0.180126,-0.116526,0.151398,-0.209659,0.198927,0.132114,0.295589,-0.728107,-1.08225,0.844888,-0.458014,0.260748,0.410929,1.1246,0.382427,-0.074685,0.119237,0.608338,0.242919,0.329382,0.554741,0.0546429,0.0120134,-0.222146,0.248151,0.772993,-0.295227,0.175993,0.12581,0.419515,0.354696,0.17088 +3379.4,0.999637,0.0912059,4,1.65191,0.871887,-0.906707,0.296585,0.471651,-0.214861,-0.310796,-0.601165,0.0383926,0.186838,-0.0103232,0.0611995,-0.486537,0.32485,-0.0584884,0.408333,0.0292439,-0.291909,0.103594,-0.0357797,-0.144242,-0.447483,-0.48458,-0.227112,0.0176033,0.26407,-0.100372,-0.0251964,-0.202251,0.640496,0.291676,-0.518721,-0.242466,0.241129,-0.202197,0.116157,-0.174179,0.561274,-0.139279,-0.549003,0.823866,0.491232,0.34856,-0.556723,-0.390945,0.135412,-0.33756,0.0625038,0.205543,0.0269276,-0.354784,0.0887273,-0.0761985,-0.32104,0.639485,0.121395,-0.229488,-0.522904,0.208896,-0.544475,0.673289,0.824683,-0.630031,-0.378346,0.014978,0.444284,-0.177836,0.047681,-0.224947,-0.582076,-0.465268,0.270543,0.529937,0.0922273,1.00221,0.61,-0.081016,-0.447478,-0.254819,-0.140074,-0.0893699,-0.234609,0.457264,-0.474756,-0.757941,0.027243,-0.0396409,-0.126133,-0.6029,0.149618,-0.544437,0.178799,-0.0988922,0.392632,-0.43542,-0.958649,-0.257221,-0.345588,0.188598,0.660895,0.0575493,-0.545133,-0.564019,-0.597953,0.102285,0.233232,0.110296,-0.323568,-0.135489,0.798888,-0.581831,0.167579,-0.710383,0.402934,0.224421,0.110662,-0.341878,0.54169,0.68204,-0.408655,-0.169784,-0.322835,0.472134,-0.141131,0.294308,0.138078,0.648105,0.143388,0.151254,0.118866,0.0528457,-0.118218,-0.18388,0.472966,-0.283186,0.159537,0.0126913,0.174545,0.395301,-0.999692,-0.945053,0.377303,0.192403,-0.929719,0.642158,-0.25882,-0.248302,0.26448,0.386106,-1.03677,-0.435795,0.340841,-0.371279,-0.404165,0.40754,0.322109,0.376516,-0.286913,-0.0663933,-0.129144,0.605209,-0.208333,1.08362,-0.839884,0.282147,0.0981604,-0.0924212,0.208476,-0.0784006,0.654554,0.527121,0.10947,-0.114631,-1.5501,0.102385,-0.221201,-0.279992,-0.214315,-0.117559,0.664263,0.511253,-0.450335,-0.632062,0.830901,-0.149625,-0.777506,-0.126451,-0.318143,-0.572044,-0.358002,-0.112402,0.562045,-0.299656,-0.938992,-0.000316831,0.151199,-0.0915495,-0.295029,-1.28774,0.349715,0.37237,-0.425315,-0.57494,0.256157,0.104808,0.303573,-1.01831,1.33674,0.0362214,0.0239231,0.463577,-0.106482,0.140925,-0.33896,-0.289672,0.415935,0.337285,0.779547,0.276191,-0.621833,-0.194858,0.0234532,-0.320884,-0.12634,-0.599002,0.667479,-0.3699,-0.177713,0.0833523,-0.60063,-0.286953,-0.0666359,-0.722332,-0.127272,-0.091104,0.438206,-0.637126,-0.246457,0.550287,-0.91764,0.0664015,-0.285512,-0.121078,0.585274,0.170048,0.0801615,0.602149,0.257617,0.663653,-0.177196,0.315558,-0.679007,0.199836,0.0440607,-0.738267,0.476105,-0.189369,-0.32594,-0.0891298,0.78925,-0.12416,0.330637,-0.343566,-0.254872,0.174456,-0.643975,0.758358,0.69499,-0.298981,0.046958,-0.28799,-0.456859,-0.37897,0.114531,0.487749,-0.211374,0.145687,0.12589,0.535541,0.180268,0.102242,-0.812665,-1.36788,0.927305,0.107244,0.20011,-0.0593699,0.93911,0.441463,0.0224694,0.0593363,0.173585,0.0442911,0.443622,0.44963,-0.259777,-0.108342,-0.0641125,0.353018,0.36877,-0.4758,0.259967,0.141503,0.509869,0.376169,-1.20648 +3384.2,0.882282,0.0912059,4,1.55071,0.849306,-0.702401,0.282553,0.0409837,-0.181018,0.167672,0.425436,0.0863867,-0.0694894,0.244691,-0.19594,-0.150914,0.48216,-0.128452,0.481975,0.53381,-0.0302823,0.0174875,-0.204843,-0.234251,-0.321396,-0.565673,-0.0370109,-0.0414087,-0.276265,-0.116153,0.186519,-0.188673,0.254509,0.434366,-0.227769,0.248502,-0.204797,-0.522262,0.282773,-0.475146,-0.082588,-0.0364235,-0.257414,0.405958,0.233292,0.0487919,-0.289362,0.0418775,-0.17605,-0.469929,0.00357458,0.546258,-0.039621,-0.0251468,-0.208495,-0.0900285,-0.152859,0.767271,-0.0656143,-0.329622,-0.36636,0.185645,0.184606,-0.160586,0.821295,-0.420771,-1.00247,0.144618,0.022477,0.314003,0.455995,0.47075,-0.687595,-0.70855,0.865503,0.68411,-0.488431,0.992483,0.326602,0.699737,-0.350674,-0.259086,0.268683,0.395191,0.0609578,0.486514,-0.556762,0.0561966,0.284669,-0.0820032,-0.0916694,0.161559,-0.121051,0.2138,0.399349,-0.0880787,-0.26639,-0.318554,-0.226647,0.377566,-0.387671,0.359619,1.04646,0.602002,-0.250861,-0.993789,-0.836636,0.0102714,-0.32031,0.278101,-0.112068,0.580042,1.16058,-0.81545,0.202776,-0.370743,0.306719,-0.643775,0.459365,-0.36975,-0.0744948,-0.101363,-0.166259,-1.19701,0.537242,0.140864,0.073623,-0.214497,0.296454,0.525399,0.782434,0.222654,-0.397085,0.0815941,0.230054,-0.616501,1.02339,-0.712301,-0.0259368,0.0122127,-0.349337,0.331547,-0.90076,-0.966131,0.36555,0.279353,-1.24353,0.165548,0.381728,0.168935,-0.72458,0.199308,-0.54835,-0.716565,-0.00986401,0.323291,-0.0819558,0.626712,0.615466,0.201022,0.218991,0.750189,-0.240769,0.0959547,-0.634774,0.421279,0.818645,-0.322752,-0.13611,-0.462305,-0.978039,-0.155345,0.52202,-0.0939806,0.111835,-0.183404,-0.0161424,-0.52738,-0.969563,-0.0959988,0.257864,0.351816,0.807759,-0.557444,0.307947,0.124038,-0.00117713,0.166902,-1.09596,-0.00697555,-0.566042,0.283687,-0.300736,-0.0386077,0.0124315,-0.0915168,-0.155588,0.194489,-0.015499,0.175122,0.083935,-0.601323,0.0264907,0.333552,-0.45705,0.166154,-0.153137,0.873803,-0.24749,-0.713059,1.45916,0.331692,0.0139194,-0.133753,-0.330112,-0.29104,0.00605159,-0.139164,0.833784,-0.690799,0.251206,0.0245527,-0.979526,-0.343411,-0.706462,-0.366461,0.400864,-0.407696,0.320664,-0.30214,0.302866,0.429965,0.362519,-0.176966,0.124201,0.382875,0.219289,-0.664551,0.740075,-0.280484,-0.0278017,0.482587,-0.550882,0.481701,0.181333,0.362431,-0.156723,0.315962,0.618461,0.349695,0.105266,0.715082,-0.207429,0.225526,-0.0179124,0.557224,0.0322827,-0.979838,0.62719,0.0843462,-0.158664,0.326082,0.02976,-0.144819,0.598436,0.645035,0.31587,0.159864,0.0230984,0.0435493,-0.279007,-0.416188,0.493465,-0.229195,-0.648657,-0.547898,0.39112,0.898069,0.99505,1.03834,0.489003,0.394245,-0.24448,-0.0932114,0.146955,-0.416318,0.193754,0.0377252,0.0383303,0.188025,0.509406,0.166001,0.140992,-0.0737626,-0.192118,0.246281,0.266244,-0.368551,-0.547454,-0.000998603,0.102224,-0.215255,-1.3699,-0.243127,0.22221,0.115596,0.471392,0.339994,0.0594633 +3371.54,0.905156,0.0912059,4,1.53772,0.971987,-0.737092,0.214533,0.00985506,-0.143859,0.154925,0.491585,-0.00779287,-0.104744,-0.0719141,-0.259589,-0.0335155,0.316816,-0.0315979,0.534482,0.25982,0.0238421,-0.0414445,0.0662987,-0.393397,-0.418674,-0.498865,0.0370343,0.153223,-0.135398,-0.307659,-0.233152,-0.0867867,0.297233,0.308755,-0.0504346,0.160438,-0.167962,-0.666037,0.0590146,-0.452748,0.136273,-0.172885,-0.488307,0.453562,0.331326,0.134021,-0.257978,0.186385,-0.110377,-0.285425,-0.195484,0.627684,-0.0410725,0.0159791,0.0983686,-0.155796,-0.202007,0.641107,-0.250844,-0.262689,-0.538342,0.351947,0.082164,-0.0933146,0.733212,-0.533748,-1.36978,0.628472,0.0640816,0.308184,0.514489,0.503943,-0.770775,-0.705208,1.02753,0.630428,-0.740898,1.21605,0.338644,0.60101,-0.235305,-0.435792,0.215274,0.354008,0.154935,0.344674,-0.464178,-0.00535134,0.425802,-0.485402,-0.200032,-0.00497417,-0.239544,0.126392,0.00466557,-0.0017826,-0.380979,-0.172399,-0.053743,0.731307,-0.12553,0.531779,1.03939,0.614798,-0.273614,-0.842902,-0.837635,0.0448811,-0.284207,0.400202,-0.179281,0.703882,1.10771,-0.813558,-0.028116,-0.165734,0.368033,-0.65624,0.598176,-0.398089,-0.0955783,0.161544,-0.139517,-1.17076,0.382443,-0.099414,0.096475,-0.319106,0.483507,0.550141,1.00596,0.253189,-0.463049,0.0874944,0.350986,-0.486697,0.954609,-0.738674,-0.074795,0.153341,-0.150937,0.373474,-0.835286,-1.16204,0.289014,0.089085,-1.22986,0.149126,0.541121,0.196932,-0.493402,0.487448,-0.434671,-0.94649,-0.00883039,0.584834,0.178314,0.561484,0.450434,0.298337,0.405264,0.577725,-0.347711,0.174299,-0.632534,0.222734,0.463874,-0.244196,-0.197871,-0.285284,-1.02168,0.0513516,0.695217,-0.170363,0.192357,-0.264056,-0.0814559,-0.506837,-0.938626,-0.169171,0.343795,0.347738,0.96666,-0.351279,0.197396,0.216009,-0.103164,0.246026,-1.12582,0.130399,-0.55157,0.380669,-0.0766035,0.185395,-0.210038,-0.118874,-0.114575,0.187106,0.0134349,0.155898,-0.123623,-0.533205,-0.185554,0.372836,-0.608589,-0.0608763,-0.270709,0.743015,-0.188502,-0.589895,1.44795,0.359388,-0.147672,-0.0548067,-0.24112,-0.299296,0.141683,0.154096,0.882526,-0.697602,0.267268,0.0302691,-0.76713,-0.327503,-0.723272,-0.56248,0.259062,-0.382291,0.456864,-0.0600911,0.354848,0.51964,0.0758071,-0.364154,0.000632401,0.323786,0.157533,-0.765962,0.767903,-0.46973,0.0691368,0.436204,-0.875158,0.892945,0.321424,0.591073,-0.229879,0.211085,0.377053,0.48365,0.028073,0.670145,-0.232195,0.255405,-0.0447263,0.55747,0.320406,-0.498075,0.676723,0.0888312,-0.193412,0.497525,0.0799471,0.0309439,0.844824,0.485292,0.46937,0.206578,0.070538,0.107422,-0.111493,-0.579088,0.33697,-0.215161,-0.714605,-0.829263,0.363047,0.801017,0.95183,0.886491,0.811787,0.16818,-0.0793352,0.0927953,-0.340234,-0.431157,0.20151,-0.0410339,0.0845521,0.350315,0.225035,0.132932,0.0677478,-0.172584,-0.0986367,0.136628,0.365533,-0.290197,-0.567124,0.145363,0.164127,-0.106644,-1.24957,-0.388305,0.22602,0.119793,0.475415,0.346111,0.00636931 +3387.72,0.757944,0.0912059,4,1.45977,1.03374,-1.4689,0.541032,0.857015,-0.213738,-0.263504,-0.0361127,0.54354,0.367272,0.0839838,0.0658852,-0.427431,-0.0800052,0.064453,0.516419,-0.144252,-0.108458,-0.0207859,-0.226661,-0.304307,-0.903045,-0.456839,0.00356652,-0.294732,-0.000480278,0.0243414,0.749578,0.0389083,0.00365613,0.601284,-0.421991,0.337942,0.414262,-0.683309,0.0604713,-0.0893665,-0.115468,0.423554,0.0248638,0.62012,0.463275,0.606157,-0.470383,-0.39565,0.158038,-0.322903,0.227837,0.45658,-0.347947,-0.359031,0.313863,0.49989,0.00776884,0.480566,-0.0635502,0.267633,-0.359588,0.328665,-0.331063,0.521568,0.728712,-0.179477,-0.0962045,-0.299763,0.60151,-0.440031,-0.149723,-0.110857,-0.135525,-0.0952941,0.440474,0.63424,-0.123164,0.885215,0.485206,0.0992252,0.435199,-0.228852,0.0931077,0.20178,-0.297931,0.274566,-0.806411,0.123653,0.0253007,0.23818,-0.474726,-0.118824,-0.152184,-0.152532,0.14568,-0.293839,0.279177,-0.436107,-0.792311,0.377305,0.152145,-0.225153,0.17703,-0.0131663,0.0256234,-0.390365,-0.223245,0.655123,-0.315456,0.91303,-0.600043,0.295998,1.04271,0.292751,0.00441177,0.101935,0.296863,0.657176,-0.430758,-1.09603,0.365731,-0.00663496,-0.00988958,0.103153,-0.407668,-0.259495,-0.488126,-0.0930493,-0.395689,0.439925,0.333225,0.0457125,-0.307907,0.236868,-0.260493,0.307644,1.13444,0.205277,0.176634,0.311734,-0.361125,0.407899,-0.807203,-0.384211,-0.0727027,0.550834,0.0417724,0.633146,0.203024,-0.337944,0.687005,-0.404747,0.189429,-0.266,0.245083,-0.356635,-0.432744,0.235912,1.12223,0.467244,-0.606406,0.241893,0.357248,-0.319742,0.333308,1.13714,-0.687439,-0.29716,0.554696,0.0253278,0.850612,-0.0197115,-0.295189,-0.125008,-0.136399,-0.199434,-0.0851774,-0.218356,0.134628,-0.0243583,-0.567034,0.477364,1.08162,0.181387,-0.386225,0.0246533,-0.458186,-0.44932,0.0839421,-0.131728,-0.441836,0.21047,0.23975,-0.0482948,0.26588,0.547085,-1.03961,0.228983,0.745964,-0.383785,-0.577237,-0.54967,0.527076,-0.209447,0.0221111,-0.18399,0.732633,-0.476783,-0.305443,-0.644045,0.846586,-0.150271,0.32999,-0.099884,-0.397504,0.197864,0.244985,0.501058,0.247454,-0.187459,0.798254,1.12375,-0.0596442,-0.171074,0.15821,0.48397,0.235444,-0.247113,0.104238,-0.101798,0.0370979,0.270387,-0.234606,-0.239316,-0.147042,-0.00761302,-0.383005,-0.212033,0.369872,-0.0621999,0.291539,0.993972,-0.697644,-0.437587,0.190987,0.372136,-0.389027,0.967406,-0.0667125,0.364214,0.456418,-0.104124,-0.12188,-0.140227,-0.329717,0.219927,-0.614701,-0.323586,-0.147952,-0.15635,-0.0370202,-0.162511,0.35163,0.655041,0.305256,-0.167668,0.41823,-0.32706,-0.163193,0.362398,-0.363106,-0.540458,-0.308452,0.198216,-0.442862,-0.6466,1.05883,-0.0541065,-0.289448,0.28101,-0.42386,0.373877,-0.345678,-0.253157,1.08288,-0.0946212,0.256755,-0.0720629,0.41308,0.197586,0.592794,0.0202983,-0.492772,-0.114207,0.603947,-0.308112,-0.178077,0.36607,-0.820971,-0.0729478,-0.0963957,0.396119,-0.334803,0.122627,0.168453,0.117199,0.410431,0.342343,-2.90082 +3403.76,0.991675,0.0912059,4,1.54198,1.02546,-1.23191,0.531075,0.895362,-0.150152,-0.222443,-0.215388,0.30726,0.0132919,-0.0196205,0.0633217,-0.217302,0.349251,-0.298344,0.452446,-0.0310388,0.10419,-0.0680691,0.0798985,-0.199978,-0.667119,-0.321966,-0.140706,-0.063378,0.0404155,-0.178927,0.345776,0.0362968,-0.0367138,0.582599,-0.121926,0.338919,0.400489,-0.495885,0.02819,0.00823162,0.11529,0.16257,0.0567931,0.346064,0.370277,0.610881,-0.756673,-0.495287,-0.256649,-0.0955497,0.304227,0.256182,-0.151217,-0.556092,0.465429,0.152225,0.129103,0.342335,-0.232632,0.224819,-0.752439,0.165364,0.0817164,0.384844,0.810907,-0.430511,-0.300171,0.0742851,0.556411,-0.405002,-0.0581863,-0.19118,0.136955,-0.315121,0.0928004,0.442491,-0.403609,0.702576,0.241068,-0.133834,0.272852,-0.449225,0.117006,0.293667,-0.337949,0.412613,-0.847667,-0.306905,-0.411001,0.378786,-0.59779,-0.223338,-0.158169,0.493368,0.473545,-0.375892,-0.141088,-0.549708,-0.865554,0.326766,0.0858712,-0.18919,0.267333,0.207256,-0.210398,-0.0523127,-0.361863,0.198604,-0.364003,0.585319,-0.43038,0.137604,0.819548,0.251204,0.0457794,0.183522,0.18339,0.701498,-0.0532742,-0.539638,0.0796095,-0.12808,0.120208,-0.303622,-0.45401,-0.289936,-0.228989,-0.00170984,0.0826478,-0.114311,0.49814,0.276522,-0.385778,0.31876,-0.352356,0.022571,1.14078,0.223124,0.245182,0.458095,0.000874309,0.0732228,-0.58585,-0.0823363,0.0526949,0.509299,-0.502928,0.658709,0.465786,-0.422705,0.671183,-0.275909,0.311029,-0.0294431,0.413331,0.159711,-0.667404,0.505859,0.50037,0.778374,-0.274905,0.390473,0.335786,-0.204382,0.0628417,1.23878,-0.822986,0.102661,0.416318,-0.106942,0.59225,-0.222085,-0.352444,0.175084,0.102378,-0.0607819,0.154819,-0.173449,0.304085,-0.288747,-0.67461,0.564502,0.96073,0.453302,-0.279623,-0.0398906,-0.48967,0.072012,0.090507,0.188809,-0.298201,0.15031,0.548358,0.112221,0.154879,0.270169,-0.886323,0.463607,0.557222,-0.532343,-0.362598,-0.523378,0.368989,-0.172693,-0.108139,-0.17697,0.277844,-0.513594,-0.0616974,-0.353731,1.053,0.191281,0.3816,-0.252059,-0.554989,0.503418,0.483308,0.346611,0.515042,-0.135357,0.96258,0.657468,-0.271946,-0.122006,-0.233687,0.388787,0.218045,0.0667685,0.322798,-0.400371,-0.0489528,0.257187,0.00259036,0.104078,-0.2411,-0.201697,-0.351238,-0.111321,0.577131,0.136732,0.433684,0.766003,-1.03758,-0.44397,-0.261326,0.241997,-0.00238408,0.831891,-0.056921,0.424486,0.324432,-0.428253,-0.337635,-0.186757,-0.225976,0.409399,-0.485918,0.220972,-0.00184389,-0.100627,0.204558,0.0491939,0.330983,0.387054,0.500857,0.449783,0.666971,-0.318432,0.0154886,0.511439,-0.427139,-0.988966,-0.0201995,0.0438246,-0.563078,-0.898125,0.707107,0.0580059,-0.0680688,0.63882,-0.538855,0.51695,-0.347071,-0.219482,0.75653,0.0460611,-0.056819,-0.316759,0.433337,-0.189793,0.518676,-0.141999,-0.635141,-0.210521,0.818395,-0.290686,-0.0391954,0.357934,-1.30531,0.156229,0.0948208,0.029401,-0.504208,0.281595,0.204183,0.107505,0.451866,0.327879,-3.06224 +3389.2,0.721288,0.0912059,4,1.53623,1.05529,-1.31742,0.505846,0.878306,-0.154534,-0.118372,-0.184826,0.171365,0.0532574,-0.0314689,-0.199099,-0.180474,0.222911,-0.322299,0.746217,0.00419065,0.215438,-0.247076,-0.07957,-0.185346,-0.401012,-0.384618,-0.186226,-0.192812,-0.0306326,0.10311,0.21129,0.0251557,-0.00791653,0.485179,-0.0152093,0.349807,0.469855,-0.395687,-0.217263,0.0885342,0.130978,0.0254859,0.0460518,0.370705,0.278971,0.405175,-0.685272,-0.23806,-0.32977,-0.246552,-0.0539455,0.388642,-0.145639,-0.386513,0.579906,0.0885392,-0.173757,0.426417,-0.46927,0.0381499,-0.54022,0.173255,0.410025,0.283062,0.948475,-0.252143,-0.47391,-0.104136,0.443005,-0.575055,-0.0391416,-0.265152,0.0761757,-0.295492,0.0559727,0.247242,-0.333999,0.927762,0.27686,-0.14755,0.200641,-0.759308,-0.0599039,0.290522,-0.265417,0.333426,-0.706569,-0.382322,-0.536533,0.581192,-0.840898,-0.281051,-0.111222,0.700443,0.363716,-0.559747,-0.0770402,-0.575786,-1.03739,0.456886,0.176061,-0.21705,0.426697,0.246143,-0.061321,-0.385898,-0.381299,0.421778,-0.5053,0.327368,-0.311315,0.262892,0.789393,0.272771,-0.185509,0.163644,0.150565,0.542854,0.105178,-0.75806,0.178573,-0.305364,0.0697787,-0.278055,-0.515212,-0.653211,0.0759494,0.181913,0.358913,-0.338632,0.507848,0.414754,-0.481978,0.260542,-0.148183,0.242849,0.862142,0.0537386,0.40785,0.815231,-0.0564063,0.134206,-0.68365,0.150984,-0.113832,0.31231,-0.469183,0.99823,0.731759,-0.652579,0.82482,-0.278582,0.204932,0.04091,0.169705,0.100017,-0.817872,0.670966,0.214301,0.864051,-0.590882,0.410373,0.220506,-0.105118,0.107217,1.42102,-0.4586,0.194467,0.496117,0.0208937,0.520787,-0.155901,-0.419243,0.0352901,0.0276515,-0.26136,-0.223848,-0.126905,0.0681947,-0.0416619,-0.533859,0.503822,0.960384,0.395663,-0.300907,-0.124912,-0.216423,0.409165,0.368381,0.0389182,-0.411545,0.135269,0.697439,-0.121461,0.280446,0.107132,-1.09993,0.529678,0.727957,-0.566914,-0.271038,-0.650747,0.319963,-0.116059,-0.204745,0.142744,0.251482,-0.448545,-0.268383,-0.138682,1.03806,0.114779,0.280169,-0.217661,-0.540391,0.498238,0.652591,0.240069,0.347399,-0.140659,0.811157,0.485251,-0.20335,-0.164206,-0.137922,0.293953,0.234298,0.188987,0.319581,-0.105711,0.0360849,0.441755,-0.224222,-0.207526,-0.129266,-0.395269,-0.0861044,0.0284426,0.368898,-0.122249,0.475049,0.881232,-0.988622,-0.710286,-0.446422,0.112859,-0.0144228,0.807543,0.0152798,0.421744,0.0576929,-0.275477,-0.260185,-0.271363,-0.02516,0.467328,-0.727011,0.154451,0.0435041,-0.0976766,0.338116,0.112818,0.256042,0.506474,0.561491,0.0802337,0.51153,-0.203698,0.066285,0.488433,-0.157706,-0.710418,-0.0214487,0.0496798,-0.294123,-0.772513,0.530903,0.206595,-0.1479,0.752639,-0.465276,0.652656,-0.184648,-0.247573,0.622519,0.0418071,-0.107426,-0.411899,0.533755,-0.0322884,0.43493,-0.126684,-0.482962,-0.290605,0.870958,-0.313013,0.237566,0.0880148,-1.47062,0.265752,-0.00830556,0.0445047,-0.498579,0.384708,0.177941,0.097361,0.42183,0.312027,-2.99417 +3408.78,0.974495,0.0912059,4,1.61274,0.995878,-0.894584,0.250373,0.456509,-0.199554,0.232137,0.410366,0.509626,0.232989,-0.0610217,0.0824161,-0.00879438,-0.0119071,-0.362704,0.317048,0.0197078,-0.039502,-0.158501,-0.0825179,-0.098085,-0.624289,-0.377275,-0.111206,-0.434821,-0.159515,-0.496463,0.222737,-0.226673,-0.161142,0.445421,-0.679289,0.0574584,0.173943,-0.0194941,-0.263821,-0.271315,0.716178,0.540257,0.045448,0.487862,0.80961,-0.0969354,-0.596385,-0.16665,0.597289,-0.232179,-0.108336,0.303642,0.0280313,0.0143979,0.0166019,-0.0334576,-0.0834292,0.664219,-0.0711313,-0.203048,-0.425628,0.222357,-0.625646,-0.129826,0.543641,-0.148437,-0.5419,0.0847603,0.136609,-0.19389,0.16914,0.312393,-0.905065,-0.154265,0.734117,0.778403,0.463024,0.480195,0.384764,0.350366,0.00680307,-0.215806,-0.419842,-0.11617,-0.559254,0.00440106,0.343346,0.0257106,1.11171,-0.222564,0.35926,-0.0275519,-0.540763,-0.0224422,-0.0154895,0.306816,-0.102232,0.586915,-0.893372,0.14341,-0.353766,-0.104178,0.907424,0.055631,-0.0305291,-0.246165,-0.00860617,-0.548232,-0.550012,0.482447,-0.172095,0.422019,0.473401,0.184664,0.0881661,0.339818,0.199799,0.184077,0.326031,-0.59078,0.18197,0.203463,0.245403,-0.427748,0.142639,0.654289,-0.0162132,-0.313791,0.407161,0.217451,0.104027,-0.0182845,-0.374924,0.145013,0.0529282,-0.0286919,0.702691,-0.653927,-0.514671,-0.185897,-0.121617,0.235993,-0.700976,-0.377725,0.00849506,0.621424,0.341379,-0.0214534,0.41727,0.532861,0.802319,0.216845,-0.517496,-0.563939,0.0998341,-0.0390405,0.539663,-0.259302,0.295709,0.44778,0.16888,0.497352,-0.582892,0.557963,-0.0978742,0.577537,0.277409,-0.2722,0.807137,-0.580911,-0.141264,-0.234923,0.316967,0.301159,-0.0480763,-0.212722,0.211639,-0.27708,-0.560649,-0.527216,-0.21983,0.216561,0.746231,-0.782735,-0.101918,0.900193,0.415036,-0.432155,-0.819803,-0.805977,-0.319947,-0.397751,-1.07351,-0.0213908,-0.369419,0.469781,-0.57181,-0.334147,0.112131,0.403967,-0.509083,-0.413658,-0.578013,-0.0631073,-0.417558,0.0770191,0.338874,0.432034,-0.436699,-0.317408,1.0351,-0.180658,0.212038,0.10614,-0.254039,-0.383012,0.00221641,-0.313082,0.339425,-0.689642,0.393276,0.0547857,0.488836,-0.494497,-0.780879,-0.495477,-0.237947,-0.367179,0.500645,-0.831681,-0.536546,0.243575,0.343464,-0.35233,-0.0339357,-0.329182,-0.41032,-0.616065,0.646015,-0.0649863,0.251235,0.858446,-0.597223,0.104265,0.792961,-0.361215,-0.0161168,0.199214,0.513167,0.518855,0.318695,-0.535187,-0.550639,0.359822,-0.360836,0.10831,-0.025834,-0.393609,0.19932,-0.451377,-0.99721,-0.12151,0.0825758,0.0572892,0.333994,0.0203093,0.0810412,0.123344,0.498371,-0.158318,-0.185936,0.0843943,0.0772235,-0.292011,0.068228,0.390695,0.0510611,0.55203,-0.0155485,0.36687,-0.463291,1.00952,0.148562,-0.244976,0.104362,0.149731,0.185559,0.286968,0.442299,0.245223,0.0834602,0.651707,0.277014,0.0907621,-0.0919757,0.128998,0.200087,0.392601,0.375395,-0.529518,0.390753,-0.289674,0.853318,0.0565508,0.190531,0.101686,0.436498,0.318883,-1.38097 +3402.45,0.425577,0.0912059,4,1.5418,0.976033,-1.0761,0.414912,0.486622,-0.193218,0.275591,0.161641,0.540855,0.0196521,-0.00107907,0.0625665,-0.19596,0.152097,-0.220679,0.271672,0.323731,0.0283511,-0.514741,-0.313279,-0.0500973,-0.462898,-0.544681,0.148547,-0.345069,-0.219755,-0.529388,0.234876,0.00147262,-0.225573,0.482591,-0.390957,-0.14053,0.159655,-0.127199,-0.324432,-0.545509,0.750856,0.173276,0.168194,0.55533,0.817121,0.138018,-0.447172,-0.0649905,0.285515,-0.417309,0.042636,0.31244,0.019782,-0.0595706,0.132939,0.0445711,-0.0461284,0.460214,-0.234576,-0.171941,-0.362348,0.394161,-0.308392,0.185966,0.82218,-0.38839,-0.524614,-0.0768233,0.408629,0.237142,0.239899,-0.135437,-0.745354,0.0725636,0.777798,0.842526,0.289182,0.571491,0.248105,0.113596,0.101137,0.013389,-0.205155,-0.0809001,-0.705865,0.060521,0.184861,-0.139686,0.826323,-0.237559,0.100235,-0.167993,-0.284938,0.147968,-0.230634,0.123489,-0.169029,0.372233,-0.583363,0.111197,-0.462115,-0.216341,0.861951,0.130255,-0.241503,-0.625225,-0.40968,-0.616738,-0.510091,0.208151,0.0596407,0.151506,0.730142,0.055731,0.16258,0.146257,0.216038,0.480297,0.613168,-0.470336,0.104668,0.293657,0.0205239,-0.365378,0.147427,0.652625,0.224664,-0.0713534,0.298815,-0.0111726,0.398394,0.458882,-0.318647,0.0166423,0.125685,-0.19253,0.629828,-0.747323,-0.690398,-0.325602,-0.176271,0.110837,-0.543824,-0.527833,-0.223758,0.633371,-0.0437602,0.077016,0.018738,0.248156,0.648859,0.158689,-0.532572,-0.612803,0.379958,0.149912,0.530737,0.175772,0.20449,0.601421,-0.0784496,0.603991,-0.708913,0.399588,-0.0109823,0.549058,0.205519,0.110892,0.551571,-0.578071,-0.36035,-0.0620057,0.365811,0.153414,0.0749604,0.0676747,-4.98951e-05,-0.252917,-0.713356,-0.603966,-0.299176,-0.0168939,0.794994,-0.919532,-0.137889,0.913223,0.156707,-0.15068,-0.620151,-1.05542,-0.224638,-0.417861,-1.42175,-0.11718,-0.111107,0.140858,-0.259277,-0.299054,-0.0187331,0.368572,-0.751364,-0.438244,-0.433792,-0.233131,-0.262216,0.0367029,0.256333,0.275403,-0.253092,-0.505649,0.971778,0.097344,-0.0930646,-0.0383584,-0.0921849,-0.239281,-0.060546,-0.335573,0.456378,-0.555554,0.681228,0.406742,0.751468,-0.320391,-0.925271,-0.313628,-0.0107731,-0.343148,0.688142,-0.698021,-0.448407,0.53421,0.0479035,-0.399374,-0.0549625,-0.486181,-0.317791,-0.663309,0.687774,-0.332806,0.037969,0.776198,-0.552641,-0.116289,0.608382,-0.120155,-0.122782,0.534004,0.630672,0.418879,0.462917,-0.479035,-0.40507,0.348328,-0.358023,0.327832,-0.251925,-0.304842,0.281413,-0.397324,-0.922335,-0.20971,0.17645,0.0532587,0.120073,-0.0467505,0.377058,-0.0739126,0.549562,0.110987,-0.34674,0.33071,0.07846,-0.163941,0.118984,0.485658,0.211734,0.483317,-0.0138035,0.120615,-0.558071,1.12438,0.217833,-0.424787,0.0672258,0.282757,0.0582347,0.375914,0.419475,0.246159,0.172877,0.487237,0.382336,0.0077416,-0.271042,0.260796,0.3579,0.355556,0.143318,-0.508341,0.189058,-0.634812,1.14154,-0.128576,0.180841,0.146946,0.425254,0.383335,-1.57905 +3404.24,0.989392,0.0912059,5,1.57842,0.849876,-1.1095,0.392949,0.127455,-0.224364,0.218873,-0.0476618,0.47746,-0.0512226,-0.272505,-0.149071,0.0301398,0.228034,-0.292702,0.593469,0.380662,0.0509598,-0.0932064,-0.0701099,-0.0226078,-0.630038,-0.157031,0.180524,-0.495305,-0.317028,-0.565585,0.434256,-0.0788848,-0.232753,0.647842,-0.20602,-0.135256,0.106101,-0.307073,-0.0741522,-0.413731,0.576051,0.13626,-0.0859131,0.4809,0.451589,0.156325,-0.576657,-0.068836,-0.0384372,-0.488385,0.14988,0.0573626,0.0198004,-0.142497,0.0726161,0.106107,-0.171883,0.741739,-0.118071,-0.463133,0.0443003,0.127635,-0.226662,-0.0374289,1.02201,-0.345737,-0.84071,-0.102224,0.26808,0.251873,-0.0678705,-0.245009,-0.890941,-0.311738,0.679901,0.805749,0.422333,0.730825,0.140878,0.0650189,0.164867,0.165627,-0.122084,-0.0358369,-0.73851,0.170677,0.329989,-0.183068,0.954615,-0.636925,0.259947,-0.272871,-0.327363,0.140629,-0.17219,0.138267,0.248134,0.174142,-0.243745,0.11152,-0.483176,-0.0456885,0.827704,-0.175869,-0.305208,-0.650844,-0.225412,-0.244322,-0.36491,0.17848,0.0910197,0.167206,0.835372,-0.0352646,0.278573,0.30221,0.366021,0.245234,0.841153,-0.681871,0.0181022,0.254388,-0.0299124,-0.705164,0.237341,0.836876,0.0307419,-0.254501,0.476805,-0.163309,0.221398,0.240942,-0.44881,0.0598534,-0.0236255,-0.167065,0.606942,-0.464741,-0.619451,-0.407749,-0.0829694,0.129706,-0.535132,-0.564281,-0.149353,0.530614,0.547916,-0.13014,0.259759,-0.293029,0.593877,-0.20238,-0.626716,-0.293271,0.00524949,0.0486119,0.204404,0.205084,0.420893,0.58454,-0.31038,0.697766,-0.706298,0.0837407,-0.0842512,0.789025,0.12156,0.370482,0.5098,-0.177255,-0.112644,0.144935,0.0309045,0.673884,-0.100297,-0.297649,-0.0100809,-0.382004,-0.5112,-0.357684,-0.369188,0.155336,0.765232,-1.04135,-0.0839622,1.07009,-0.29635,-0.035809,-0.78567,-1.01534,0.0299589,0.190604,-1.32395,-0.139183,-0.291956,-0.0170159,-0.43499,-0.417166,0.172456,0.602963,-0.585396,-0.446489,-0.360092,-0.527648,-0.339232,0.435568,0.153296,-0.1442,0.0277095,-0.488458,1.00672,0.075477,-0.0687377,-0.104536,-0.285763,0.00173829,0.161364,-0.182932,0.262784,-0.718116,0.526388,0.335444,0.314597,-0.263312,-0.563244,-0.386366,-0.228026,-0.0869621,0.905436,-0.976056,-0.476319,0.431621,0.0806298,0.00409528,0.0740564,-0.480727,-0.11817,-0.635324,0.754524,-0.401012,-0.159987,0.662643,-0.321652,-0.278079,0.642427,-0.150186,-0.467122,0.3404,0.587647,0.323906,0.474472,-0.600402,-0.257205,-0.0116887,-0.271152,0.176709,0.0637543,-0.579323,0.20027,-0.377344,-0.762868,-0.127946,0.072502,-0.143377,0.422491,0.42576,0.587549,-0.282056,0.444473,0.246552,-0.143184,0.0590534,0.0558191,-0.432055,0.0766183,0.517716,-0.188852,0.416865,-0.0401756,0.224478,-0.584318,0.67172,0.157551,-0.234649,0.318327,-0.151476,0.340708,0.541038,0.229526,0.0677753,0.284833,0.6815,0.264007,0.0582395,0.0471708,0.193137,0.473634,0.189481,-0.0901626,-0.0805087,0.215263,-0.56612,1.04677,0.167658,0.208068,0.135121,0.456145,0.367588,-0.0808574 +3391.92,1,0.0912059,4,1.53194,0.901166,-1.23985,0.377401,0.81471,-0.118065,-0.260712,-0.534388,0.268846,0.345238,-0.0853463,-0.681172,-0.46203,0.235567,-0.65261,0.575883,-0.0935025,-0.0431565,0.0256705,-0.640538,-0.117357,-0.698541,-0.562758,0.164624,-0.243328,-0.147834,-0.619787,0.399226,-0.349372,-0.354895,0.41879,-0.719493,-0.220849,0.0906022,-0.207504,0.102981,-0.569918,0.379296,0.203333,-0.372704,0.345062,0.554052,0.111303,-0.365885,0.159387,0.442992,-0.571667,0.0187363,-0.0433558,0.47692,-0.0619536,0.493345,-0.0268199,-0.351203,0.946474,0.0369143,-0.012447,-0.611454,0.306573,-0.111757,0.141035,0.771853,-0.327574,-0.543795,-0.145825,0.415276,0.311532,-0.335588,-0.374175,-0.85872,-0.316385,0.229345,0.261709,0.287561,0.62999,0.246695,0.480118,0.0408746,0.183923,-0.321985,0.256032,-0.750019,-0.0268185,-0.0680393,-0.287778,0.648086,-0.439576,-0.240708,-0.439096,-0.399666,-0.0527798,-0.363216,0.332024,0.293417,-0.290527,0.291972,0.607324,-0.718822,-0.501424,0.960474,-0.0228728,0.0191607,-0.539471,-0.485628,-0.212076,-0.128465,0.585633,0.0607742,-0.0701232,1.10288,-0.451588,-0.521795,0.420009,0.32055,0.18767,0.598613,-0.779008,0.270559,0.458082,0.0194826,-0.955603,-0.281618,0.392711,-0.525462,0.091993,0.345289,-0.0838863,-0.0189696,0.686873,0.0139103,0.273589,-0.0795521,0.42488,0.404733,-0.638078,-0.431823,-0.0610427,0.149028,-0.172869,-0.673146,-0.573432,-0.256372,-0.000554531,-0.208113,-0.187228,0.0826306,-0.283866,0.706406,0.0274545,-0.240797,0.0562747,0.111958,0.393482,-0.528402,0.256339,0.550114,0.667542,0.713876,0.576169,0.38321,0.729955,0.0938968,0.744299,-0.13155,0.502126,0.192545,0.247068,-0.0247107,-0.30357,-0.110665,-0.101103,-0.067814,0.0624097,0.72811,0.12803,-0.824484,-0.198338,-0.433605,0.242776,0.728725,-0.175446,-0.577375,0.62029,0.0803306,0.323096,-1.40411,-0.524209,-0.314083,0.418573,-0.785595,-0.0246781,-0.220998,0.186761,-0.807184,0.0593432,0.363734,-0.0779092,-0.138926,-0.185599,0.047151,-0.325604,-0.54511,0.276047,0.335691,0.20061,-0.00505289,-0.22372,0.991622,0.0303257,-0.217688,0.130779,-0.122716,0.06265,0.355148,-0.135557,0.593091,-0.86386,0.879973,0.718914,0.0185057,0.127136,-0.638867,-0.764406,0.946646,-0.426257,0.904961,0.00169731,-0.0940386,0.122099,0.176131,0.119662,-0.135277,-0.350182,-0.00413893,-0.540532,0.676514,-0.289924,0.467006,0.490096,-0.456546,-0.6198,1.30854,-0.0860722,0.646505,0.0331065,0.316763,0.731743,0.105883,-0.532012,-0.434104,0.362782,0.308878,0.296665,-0.325422,-0.231776,0.138067,-0.425992,-0.429005,-0.566647,-0.275694,-0.316663,0.356237,0.57792,0.481175,-0.0335775,0.690977,0.170085,-0.583247,-0.328989,0.160378,-0.287526,0.258014,0.430764,-0.33369,0.760271,0.329632,0.886376,0.144105,0.143554,0.278659,0.381808,0.135882,-0.698119,0.208491,0.598056,-0.270387,-0.188899,0.0788835,-0.0207714,-0.229036,-0.0374327,-0.155108,-0.159482,0.0328204,0.48148,-0.439509,0.429996,-0.110846,0.00136909,-0.385549,0.483181,0.183968,0.161563,0.428915,0.401949,-2.44289 +3411.98,0.998203,0.0912059,5,1.50846,0.838057,-0.49665,0.0702855,0.113496,-0.203575,0.195985,0.592283,0.442966,-0.437966,0.225462,0.100939,0.199108,0.753786,0.161091,0.877466,0.446769,0.145319,-0.207099,-0.121585,-0.140628,-0.687116,-0.670216,0.0728487,0.424314,0.0237565,0.489222,-0.177743,0.144451,0.150147,0.759858,-0.207619,-0.176705,0.604773,0.0621626,0.0689431,-0.330254,0.30843,-0.0309505,0.00580064,1.08151,0.354299,0.105568,-0.12998,0.253096,-0.462798,-0.254473,0.421789,0.74483,0.164518,0.621851,0.122083,0.444534,-0.109975,0.967296,-0.716817,-0.115155,-0.654556,0.491418,-0.176911,0.24266,0.462432,-0.679293,-0.477784,0.184454,-0.0763966,-0.335026,-0.150835,0.0371074,0.152344,0.00618424,0.0730983,0.624327,-0.362299,0.409141,0.207069,-0.102003,-0.0416777,-0.542671,0.162388,0.54789,0.138468,0.447898,-0.593856,0.0739845,-0.552218,0.00972662,-0.364067,0.457625,-0.137427,-0.0935969,0.541187,-0.368403,-0.36202,0.436831,-0.459171,-0.761944,0.427151,0.221562,0.37624,0.0537519,-0.0979382,-0.26691,-0.20466,0.698653,-0.56741,-0.70345,-0.184185,0.275122,-0.234719,0.209372,0.0527232,-0.089176,0.553647,0.0265053,-0.184051,0.071688,0.160516,-0.11674,0.38848,-0.333714,-0.047039,-0.946198,-0.270473,-0.391349,0.00172498,0.327433,0.408473,0.0342533,-0.646416,-0.122597,-0.123099,-0.249887,0.508624,-0.156208,-0.0704581,0.148483,-0.122068,0.650572,-0.47214,-0.433163,0.0792672,-0.488736,-1.16291,0.390338,0.282578,0.114855,-0.0107509,-0.0959583,-0.377546,-0.465472,0.105128,-0.122632,0.549591,0.379073,0.275424,-0.0291388,-0.206614,0.236556,-0.0662334,0.217228,-0.16006,0.646613,-0.0876671,-0.715142,0.107163,-0.140078,-0.363497,-0.10516,0.0118828,0.227797,-0.110085,0.162283,-0.33244,-0.0426399,0.459986,-0.0617864,-0.174448,0.305045,0.774846,0.586402,-0.380656,0.210048,-0.258227,-0.0326817,0.0251709,-0.182124,0.0571489,0.173948,-0.00773084,-0.0943177,0.123834,-0.275283,-0.68289,-0.269781,0.213308,0.409354,-0.712384,-1.47687,-0.0197689,0.0935278,-0.35686,-0.192272,-0.160483,0.0295239,-0.551228,-0.704369,0.998191,0.0101947,0.382311,-0.287334,-0.236652,0.217943,0.572663,-0.0916375,0.265229,0.226993,0.16646,0.285919,-0.452978,-0.242901,-0.212568,0.590536,-0.427342,-0.462305,0.204674,-0.450755,-0.478731,-0.0988691,-0.267595,-0.0891445,0.198407,-0.0240248,-0.415261,0.0564876,0.523591,-0.0547703,0.32433,0.729956,-0.252479,-0.0661126,-1.17982,-0.0483096,-0.483508,0.592817,-0.133365,0.399926,0.361979,0.0237776,-0.312889,-0.257906,-1.43306,-0.0146654,-0.0324414,-0.00472577,0.593857,-0.399567,-0.0628975,0.673643,0.378578,0.0629793,-0.00709343,-0.293247,-0.200332,0.222816,-0.360798,-0.0929063,0.403718,0.459349,-0.0962734,-0.0986845,-0.910282,-0.155743,0.702667,-0.334142,-0.104612,-0.014007,0.0400833,0.0494823,-0.123824,-0.641269,-0.091245,0.506138,-0.172094,-0.111397,0.436266,-0.256337,0.557175,-0.0052988,-0.493522,0.307507,0.510367,0.480325,0.317977,-0.379506,-0.157972,0.0733631,0.232322,-0.593505,-0.324888,-0.243333,0.137082,0.168905,0.370246,0.41098,-0.104784 +3425.56,0.864445,0.0912059,4,1.46902,0.865297,-0.849237,0.304623,0.63708,-0.223578,0.19851,0.194122,0.613815,-0.0197195,-0.0333561,-0.0378799,0.161204,0.439559,0.0642345,1.01192,0.523615,0.341319,0.183941,-0.195018,0.0763344,-0.464642,-0.81294,0.176008,0.0575358,-0.0511365,0.15309,0.026859,-0.0621837,0.0379347,0.737274,0.0820129,-0.0513312,0.66141,0.296115,0.0015813,-0.533299,0.132761,0.0918186,-0.391302,1.09069,0.739081,-0.077044,-0.120348,0.155336,-0.448192,-0.0557574,0.442805,0.735166,0.0124236,0.447399,0.23693,0.262509,-0.0580153,0.755261,-0.393702,-0.014166,-0.717547,0.516474,-0.0863752,0.224831,0.492409,-0.467743,-0.828974,-0.0428007,0.0155299,-0.0302462,-0.354662,0.27845,-0.372728,0.132511,0.448256,0.416314,-0.734521,0.11001,0.0795772,0.0852828,-0.28712,-0.216432,0.109081,0.335858,0.16259,0.487259,-0.104029,0.124483,-0.415598,-0.125576,-0.457309,0.473876,-0.118591,-0.124779,0.331078,-0.394934,-0.331647,0.0345372,-0.805839,-0.412313,0.215752,-0.166319,0.536728,0.183489,0.0832726,-0.220044,-0.260556,0.366442,-0.30706,-0.677102,-0.242939,0.379395,-0.392454,0.200163,0.0146507,-0.250949,0.560494,-0.232784,-0.102078,0.0145033,0.0354135,-0.333264,-0.158846,-0.0884465,0.211593,-0.564196,-0.0760685,-0.36372,0.147021,0.236253,0.229696,0.182106,-0.380998,-0.120989,-0.066323,0.140456,0.254018,-0.77087,-0.316641,0.346567,-0.300947,0.504954,-0.282528,-0.253384,0.178148,-0.375992,-0.876538,0.377164,0.080459,0.305599,0.147868,0.124199,-0.50086,-0.772667,-0.0911017,0.141111,0.130734,0.221385,0.35632,0.126452,0.132484,0.390381,0.0469101,0.415325,-0.278027,0.660977,0.210017,-0.763744,0.0697763,-0.135448,-0.38907,-0.100529,0.0240746,0.178789,0.289741,0.0490424,-0.0561517,0.085366,0.471753,-0.39637,-0.0178683,0.0214872,0.803765,0.486088,0.062001,0.459941,0.188129,0.128011,0.183645,0.0297601,0.229835,0.148574,-0.368507,-0.212763,0.441666,0.13028,-0.611527,-0.35972,0.190174,0.261022,-0.837109,-1.23745,0.22125,0.141648,-0.494768,-0.393163,0.0169399,0.289139,-0.58118,-0.323784,0.883576,-0.16945,0.19929,-0.241593,-0.087469,-0.179736,0.0117255,0.0700417,0.0646681,0.248511,0.21271,0.154296,-0.0595994,-0.0944841,-0.252825,0.506175,-0.250845,-0.246525,0.146556,-0.720486,-0.528082,-0.418244,-0.315607,-0.187333,0.176029,-0.428857,-0.232714,-0.0708947,0.594053,-0.241056,0.29438,0.754388,-0.747053,-0.113135,-0.633413,0.332314,-0.370896,0.593806,-0.0222728,0.430683,0.292133,0.0711459,-0.353897,-0.293872,-0.997492,0.272059,0.128505,0.0345584,0.713935,-0.193767,-0.153593,0.283702,0.409933,0.0420865,0.0331795,-0.274905,-0.17866,-0.180038,-0.200467,0.147077,0.389387,0.365957,-0.0771973,0.0609398,-0.526796,-0.553079,0.626725,-0.310858,-0.202522,-0.0288525,-0.0796939,0.268458,-0.21255,-0.5944,0.373555,0.49627,-0.237921,-0.513255,0.127785,0.112542,0.366651,0.162108,-0.283034,0.0639987,0.362034,0.348893,0.150262,-0.27783,-0.259721,-0.218347,0.42292,-0.2876,-0.381279,0.118386,0.141409,0.139189,0.376043,0.37308,-1.96254 +3445.96,0.870064,0.0912059,4,1.61283,0.791602,-0.596459,0.152238,0.358901,-0.255795,0.190148,0.164588,-0.334021,0.219526,-0.118322,-0.163341,-0.373526,0.427841,-0.25048,0.998609,0.277649,0.134167,-0.607591,-0.0729675,-0.110037,-0.541135,-0.743523,0.363088,0.122425,0.307924,-0.102582,0.39817,-0.237035,0.105392,0.626955,-0.949116,0.068883,0.207914,0.0232861,-0.0875436,-0.0160851,0.145833,0.522356,-0.213208,1.0801,0.422266,-0.165186,-0.508159,0.0955478,-0.162054,-0.750548,-0.133226,0.761214,0.0162517,-0.0470039,-0.29877,-0.04281,-0.760099,0.941183,-0.148756,-0.194583,-0.81926,0.206548,-0.52912,0.0223342,0.521425,-0.595479,-0.854399,0.0154609,0.0273221,-0.484684,0.228303,0.175483,-0.143987,-0.0210292,0.112826,0.396954,0.0670478,0.465815,0.304788,-0.139904,0.136294,-0.161738,0.0286509,0.334217,-0.245838,0.0468679,-0.242943,-0.481366,0.151356,0.269684,-0.117407,-0.426486,-0.392308,0.164361,0.0145184,0.103338,0.13169,-0.272237,0.156924,0.671831,-0.618179,-0.0444057,-0.156907,-0.496227,0.306163,-0.99226,-0.47569,0.0482594,-0.498399,0.228491,-0.482987,0.314483,1.02675,0.303557,-0.126904,-0.373402,0.316169,0.384453,0.148903,-0.525426,0.372883,0.562592,0.290952,-0.89447,-0.484025,0.42527,-0.714791,-0.804294,0.0808799,0.144992,0.0938334,0.365939,-0.19238,0.0460756,-0.235286,0.0666458,0.309515,0.0303631,-0.302977,0.0465433,0.381277,0.246614,-0.52272,-0.136508,-0.0981615,-0.141358,-0.54402,-0.233768,0.175543,-0.389712,0.424478,-0.250445,-0.0179604,-0.262715,-0.0757444,0.168133,-0.236831,0.0973914,0.563484,-0.160422,0.130609,-0.130785,-0.642167,0.607925,-0.0332048,0.519273,-0.0517659,0.507115,0.021624,-0.110256,0.204025,-0.588486,0.129028,0.178472,0.102391,0.110437,0.393261,-0.104464,-0.437884,-0.110754,-0.156348,0.376541,0.915807,-0.319192,0.279888,0.118205,-0.365452,-0.321784,-0.493046,-0.712105,-0.503322,-0.0958905,-0.611338,-0.084808,-0.291482,-0.688677,-0.807175,0.0947798,0.401537,0.119385,0.150951,-0.622051,-0.0648774,-0.066084,-0.403151,0.252113,-0.101509,-0.205027,0.1828,-0.531747,1.19361,0.2647,0.145334,-0.145528,-0.494672,0.205186,-0.370206,-0.798388,0.189146,-0.414681,0.040898,-0.382661,-0.244182,-0.0963099,-0.454069,-0.336356,0.321278,-0.37184,0.295973,-0.283451,-0.0713492,0.786911,0.590285,0.0762844,0.197196,-0.129471,0.0317089,-0.461119,0.498321,-0.276068,-0.33398,0.512677,-0.0110169,-0.21479,0.187192,-0.34755,-0.0652286,0.277326,0.244818,0.711151,0.119081,0.0153528,-0.302649,0.168628,-0.314112,0.138907,-0.52096,-0.328503,0.35451,-0.0960858,-0.119741,0.232699,0.0892724,-0.216137,0.145108,0.55227,0.00578419,0.391988,-0.0311396,0.16371,-0.333543,-0.223748,0.0561208,-0.558532,0.226209,0.223446,-0.0826236,0.29986,-0.222862,0.322447,-0.0639885,0.092537,0.22815,0.554577,0.31687,-0.855464,0.0538292,0.273106,0.511029,-0.324372,-0.171769,0.11643,-0.113225,0.220055,-0.0522149,0.190044,0.723474,0.257051,-0.315369,-0.302056,0.122417,0.0528321,-0.236671,0.0532671,0.131018,0.292899,0.361964,0.541201,-0.745192 +3412.12,0.873085,0.0912059,4,1.56412,0.804709,-0.542695,0.103085,0.187568,0.0704625,0.0451128,0.446989,0.439891,-0.347052,-0.156108,-0.215661,0.306129,0.69579,0.0880601,0.564081,0.469677,-0.125055,0.0489787,-0.135319,-0.226308,-0.79464,-0.500444,0.115407,-0.585314,-0.145445,0.242285,-0.0919154,-0.146009,0.0276905,1.02438,-0.593422,-0.376997,-0.073699,0.128678,0.0738297,-0.849585,0.186521,0.40679,-0.49598,0.692387,0.780436,0.0228362,-0.137771,-0.189902,-0.795662,-0.457534,-0.364698,0.561701,-0.476069,0.0181222,0.0699587,0.16022,-0.593564,1.26579,0.0876563,0.0916346,-0.485434,0.566805,-0.0394521,0.279248,0.815242,-0.506738,-1.0848,-0.172952,0.397201,-0.32132,-0.2982,-0.29409,-0.273482,-0.484075,0.19513,0.253887,-0.4766,0.368279,0.335994,0.673975,-0.352175,-0.399101,-0.0635872,0.645324,-0.825621,0.487379,-0.0552791,-0.335084,-0.436779,-0.284256,-0.427022,-0.029067,-0.305222,0.553002,0.372122,0.504775,-0.133331,0.323536,-0.586396,-0.353626,-0.253031,-0.0741348,0.88816,0.2865,0.305528,-0.148986,0.34385,0.474518,-0.256647,0.552908,-0.134604,0.578509,0.512887,-0.175185,0.290303,0.652166,0.464708,-0.3535,-0.030683,0.0573336,0.0138402,-0.221297,0.0276735,-0.507534,-0.0410991,-1.06694,-0.0049381,-0.234259,-0.00435198,0.570409,0.508772,0.524567,-0.0963009,-0.589461,-0.367013,0.134283,0.287099,-0.377447,-0.301501,0.0383684,-0.246447,0.62274,-0.341432,-0.0600907,0.139247,0.0999361,-0.405781,-0.134165,0.084989,0.128399,0.392552,-0.0467261,0.164721,-0.181597,0.81381,0.251843,0.503554,0.0569871,0.17638,0.00553744,0.11391,0.149594,-0.321234,-0.273297,-0.320057,0.69812,0.397397,-0.466747,0.590125,-0.143293,0.396599,0.417405,-0.441149,0.158204,0.781279,-0.192643,-1.23623,0.502555,0.044008,-0.304719,-0.170816,-0.345764,0.681413,-0.231891,0.0357633,0.532514,-0.302873,-0.247817,-0.459673,0.13282,0.16374,0.453341,-0.106018,-0.377355,-0.153477,0.278503,-0.700028,0.192424,0.17983,0.310372,-0.507391,-0.959446,-0.128424,0.148381,-0.154032,-0.511851,-0.231901,0.085882,-0.435856,-0.074301,0.624343,0.115087,0.263066,0.613669,0.0280733,-0.106005,0.343817,-0.0205189,-0.0353611,-0.805785,0.331329,0.0732569,-0.991401,-0.333096,-0.425784,0.24372,-0.068434,0.359767,0.528013,0.0394078,0.0808058,-0.730171,-0.203813,-0.269822,-0.203764,-0.290957,-0.814478,0.106278,0.533644,-0.0149047,0.0571193,0.71064,-0.382081,-0.0834401,-0.185713,0.117567,-0.928325,0.421158,-0.326165,0.386286,0.125237,-0.0470754,-0.63499,-0.143567,-0.723559,0.226379,-0.319719,0.137645,0.34388,-0.277482,-0.537487,-0.306723,0.0391672,0.627324,0.0514567,-0.361093,0.223565,-0.152371,0.119639,-0.186802,0.217482,-0.571692,0.377938,-0.349958,-0.525038,-0.614285,0.369195,-0.721039,0.36785,0.110899,-0.055088,0.121966,-0.00141518,-0.464413,0.11565,-0.316978,-0.046024,0.0736752,0.330192,0.563497,0.371682,0.0186324,-0.619434,-0.171125,-0.178396,-0.199281,-0.234014,-0.0664707,0.046979,-0.606619,-0.0727287,0.165699,0.211044,-0.583809,0.140191,0.185372,0.374421,0.430549,-0.311483 +3380.23,0.897076,0.0912059,4,1.62719,0.800695,-0.303474,0.0507016,0.241714,0.0320693,-0.136005,0.363391,0.399318,-0.568586,-0.241947,-0.178648,0.0476669,0.903339,0.226276,0.578907,0.287246,-0.264242,0.298987,-0.270752,-0.108443,-0.819394,-0.376745,0.225529,-0.506909,0.00412323,0.474373,0.0336538,-0.109447,0.0130394,0.974775,-0.421719,-0.318866,-0.0588871,0.262292,-0.0163696,-0.853665,0.284766,0.426633,-0.435195,0.69477,0.427066,0.205776,-0.279394,-0.23277,-1.04617,-0.431427,-0.247728,0.576587,-0.36624,-0.205137,0.495604,0.440489,-0.387511,1.13239,0.0325605,-0.0552616,-0.582297,0.616674,-0.308269,0.0335877,0.982366,-0.827354,-1.29357,-0.307612,0.451593,-0.339864,-0.0912346,-0.350387,0.0380391,-0.131659,0.300656,0.362553,-0.56871,0.536647,0.395752,0.53409,-0.154842,-0.638325,-0.113581,0.39577,-0.578981,0.377122,-0.0859088,-0.148299,0.00470218,-0.275767,-0.313117,-0.201495,-0.333008,0.78973,0.272273,0.508917,-0.325933,0.5607,-0.78916,-0.385987,-0.208438,0.314878,0.978992,0.159554,0.202389,0.0494573,0.193421,0.32741,-0.221912,0.429785,-0.287372,0.625866,0.491232,-0.09026,0.31603,0.739887,0.428238,-0.391956,0.193385,-0.257196,0.208681,-0.305841,0.260262,-0.026785,0.136547,-1.08536,0.224299,-0.225869,-0.233349,0.568361,0.492208,0.377764,-0.184273,-0.462744,-0.192749,0.394299,0.324194,-0.322833,-0.240962,0.119166,-0.139179,0.78159,-0.305236,0.122005,0.380308,0.384928,-0.422945,-0.238129,0.20903,0.0564554,0.729101,0.109284,-0.0826142,-0.416122,0.923326,0.284335,0.211311,0.177687,0.216032,-0.302386,-0.0258115,0.261233,-0.363184,-0.180525,-0.397054,0.52504,0.480184,-0.469196,0.614791,-0.262863,0.369172,0.347819,-0.352584,0.0216483,0.790883,-0.0787333,-1.31075,0.231931,-0.133326,-0.431692,0.0194925,-0.503038,0.643678,-0.2471,-0.202375,0.282821,-0.367654,-0.416192,-0.486941,0.437518,0.071326,0.735074,-0.318196,-0.261481,-0.00507209,0.294002,-0.764366,0.194815,0.0938637,0.325804,-0.636884,-0.890142,-0.321595,0.124785,-0.145398,-0.524463,-0.132682,-0.19937,-0.562703,-0.444298,0.758641,0.106394,0.298134,0.528648,-0.0609271,-0.278186,0.779152,-0.161379,-0.112271,-0.622736,0.335563,0.103411,-0.983135,-0.00072182,-0.513502,0.436662,0.206418,0.307893,0.719745,0.154982,0.199891,-0.660041,-0.399166,-0.286976,-0.0795093,-0.400244,-0.58588,-0.10189,0.517374,-0.406535,0.14971,0.843542,-0.116056,0.19506,-0.334041,0.237484,-1.36599,0.505944,0.0638102,0.307989,0.135971,-0.362662,-0.428479,-0.251771,-0.399032,0.038184,-0.249078,-0.162432,0.359052,-0.0127981,-0.523226,-0.252629,0.166608,0.44865,0.0618476,-0.539055,0.0833722,-0.174583,-0.0797878,-0.259129,-0.00433334,-0.524981,0.277656,-0.137512,-0.395541,-0.634333,0.543391,-0.720025,0.373983,0.0484791,-0.412231,-0.102708,-0.0930199,-0.531847,-0.200044,-0.54925,-0.262074,-0.0354327,0.343774,0.36485,0.623215,0.00724685,-0.487863,0.0409238,0.0946516,-0.120381,-0.253528,0.114791,0.309564,-0.551458,-0.0995512,0.249837,0.235822,-0.176403,0.172161,0.204648,0.414923,0.45238,-0.48749 +3394.24,1,0.0912059,4,1.57,0.926171,-0.15211,-0.0897802,0.0705524,0.0219398,-0.253086,0.678261,-0.274467,0.136658,-0.0664446,-0.491229,0.167623,0.441436,0.160945,0.693545,0.371743,0.0958161,-0.317387,0.0924777,-0.390516,-0.55998,-0.660209,-0.0121706,-0.245745,0.123148,0.529426,0.0144746,0.183109,0.231922,0.752609,-0.484445,-0.0556842,-0.120196,0.0177749,0.201518,-0.018294,-0.297938,0.640586,-0.466924,0.726718,0.647436,-0.230745,-0.154984,-0.212693,-0.0111307,0.0750084,-0.0870268,0.666007,-0.239545,0.357688,-0.579337,0.58374,-0.801204,1.39114,0.0787572,0.0427822,-0.296492,0.915379,-0.0633254,0.0984882,0.475596,-1.04322,-0.848725,-0.619192,0.45747,0.19439,0.580884,0.0741486,-0.00564178,0.0686977,0.0223285,0.423456,-0.299518,0.800703,0.502853,0.441646,-0.278629,-0.551908,0.271256,0.755221,-0.0563289,0.708271,-0.538704,-0.885792,-0.520424,0.137144,-0.291833,0.0759268,-0.246872,0.115096,0.555654,-0.0240193,-0.361794,-0.0651593,-0.575255,-0.0603037,-0.0666065,0.332697,0.463004,-0.14276,-0.00980747,-0.276406,-0.153915,0.576712,-0.220021,0.640274,0.0448166,0.663766,0.303238,0.166459,-0.402129,0.174208,0.0863959,0.179014,0.393584,-0.678054,-0.103855,0.414172,-0.00218081,-0.545,-0.13402,-0.9486,-0.52287,0.25735,-0.119108,0.681503,0.312299,0.476709,-0.27429,-0.173483,-0.0892244,0.36752,0.0878251,-0.41823,-0.194052,-0.217398,-0.281758,0.607477,-0.232943,0.184943,0.0694992,0.152264,-0.77807,-0.347415,0.115384,-0.462463,0.396082,-0.286358,-0.149428,-0.233304,0.00228552,0.231261,-0.249548,-0.0594697,0.251514,0.0687708,0.190671,0.223427,0.205578,-0.279671,-0.180479,1.10099,-0.236335,-0.149391,0.655402,0.0136634,0.517847,0.0658963,-0.430912,0.292368,0.0885314,-0.161821,-1.03505,0.0840641,-0.122316,-0.40434,-0.550784,-0.175209,0.857177,0.528885,0.116315,0.643983,-0.1468,-0.28427,-0.291148,0.129757,-0.173698,-0.013833,-0.136903,0.0355058,-0.502534,0.208395,-0.906221,0.500243,0.334009,0.564355,-0.267166,-1.03021,-0.00686433,0.181683,-0.445304,-0.37519,-0.308908,0.52359,-0.478696,-0.742256,0.941929,0.268542,0.70629,0.455344,-0.076038,0.00792052,0.371252,0.183656,-0.21707,-0.330143,0.881962,0.504444,-0.816622,0.0382409,-0.54938,-0.164643,-0.248029,0.808984,0.557785,-0.513497,0.290808,-0.0762889,-0.089944,-0.280618,-0.0250955,-0.425363,0.0375208,0.0428187,0.0802954,-0.0356414,-0.0550873,0.574116,-0.660247,-0.223408,0.297637,0.158762,-0.47478,0.523375,-0.0945657,0.508872,0.175166,-0.50227,-0.621032,-0.408251,-0.604772,0.362749,-0.257105,-0.9441,0.528684,-0.428906,-0.557569,0.0634028,0.253028,0.314961,0.101613,-0.602152,0.346078,-0.175133,-0.415595,-0.120707,-0.0162941,-0.37973,0.125567,-0.158277,-0.0120734,-0.430405,0.239052,0.117787,-0.140483,0.495665,0.171841,-0.0959388,-0.107266,-0.29811,-0.506129,-0.542259,0.315976,-0.198668,-0.169543,0.232367,0.0167196,-0.620689,-0.571533,-0.448128,0.276953,0.378882,-0.146313,-0.0825333,-0.055261,-1.11641,-0.444435,-0.000181427,0.45367,0.131254,0.173166,0.272928,0.416132,0.522425,-0.142062 +3412.89,0.912262,0.0912059,4,1.59039,0.869147,-0.335829,0.0516474,0.342585,0.0462252,-0.427852,0.455888,-0.0559514,0.224185,-0.348988,-0.140648,0.461915,0.560206,-0.134161,0.796755,0.378735,-0.377458,-0.0216937,-0.0269116,-0.40917,-0.967954,-0.669115,0.0131517,-0.298843,0.0172433,0.696955,-0.0280155,0.340924,0.306914,0.73523,-0.421677,-0.0375861,0.37427,0.0324694,0.0582683,0.0176627,-0.328406,0.425301,-0.191203,0.67146,0.19564,-0.317534,-0.0672406,-0.199595,-0.173133,-0.379023,-0.796485,0.635023,-0.200843,0.146683,-0.259136,0.617179,-0.250512,1.34829,0.304372,-0.398297,-0.0891947,0.580597,-0.960205,0.489815,0.845403,-0.785989,-1.21147,-0.341573,0.311943,0.260089,-0.0256704,0.00260421,-0.215902,0.23005,-0.182039,0.567522,-0.0848286,0.785654,0.0040071,0.358268,-0.175737,-0.40727,0.643945,0.731902,-0.194817,0.467596,-0.107728,-0.216145,-0.821988,0.237563,-0.0905649,-0.115911,-0.154774,0.229185,0.295312,-0.0455449,-0.242758,0.0691921,-0.495776,0.538412,-0.766954,0.00986029,0.464892,-0.2125,0.450854,-0.831485,0.23391,0.176233,-0.677098,0.58723,-0.364958,0.386601,0.271158,-0.276616,-0.702899,0.364102,0.261091,-0.065942,0.351728,-0.117183,0.0243227,0.534783,-0.771902,-0.285357,0.0853623,-0.559811,-0.313406,-0.0237972,-0.301255,0.452152,0.0621805,0.323389,-0.587123,-0.467134,-0.0668172,0.166125,0.369742,-0.0162734,-0.224406,-0.0939727,0.174644,0.562077,-0.505552,-0.085042,0.0896923,0.519056,-0.644193,-0.0506993,0.327445,-0.250641,0.312145,-0.299416,-0.586821,-0.181567,0.36444,0.204286,0.0382345,0.015091,0.628194,-0.125912,0.549652,0.341145,0.0135842,0.410832,-0.0312203,1.06057,-0.707639,-0.51448,0.296781,-0.0887237,-0.123433,-0.332311,0.0533869,-0.0112238,0.61899,-0.227195,-0.531284,0.0856472,-0.187069,-0.601134,-0.847925,-0.190459,0.855063,0.209048,0.562036,0.623119,0.0684437,-0.0815777,0.00242987,0.210525,0.0434319,0.135009,-0.316107,0.120158,-0.629606,-0.106495,-0.898493,0.19357,0.163774,-0.388838,-0.179948,-0.541013,0.439707,0.339786,-0.49706,0.150606,-0.313388,0.512702,-0.252742,-0.57241,1.06369,0.467993,0.210425,0.000752446,0.388704,-0.215527,0.0588789,0.463011,0.265242,-0.88026,0.267331,0.286299,0.109693,-0.0765287,-0.262139,0.152057,0.129064,0.173766,0.563463,-0.299738,0.338285,0.22245,-0.699173,-0.242734,-0.245321,0.384628,-0.206528,0.268041,0.24614,0.0315292,-0.122208,0.520941,-0.228377,0.0727377,-0.137163,0.190549,-0.502835,0.572752,-0.162539,0.421901,0.143233,-0.317432,-0.00376714,-0.332291,-0.374722,0.0124479,-0.0340891,-0.585565,0.0462788,-0.0982506,-0.504626,0.158668,0.216211,0.516107,-0.0424649,-0.175524,0.338513,-0.329005,-0.73538,0.242174,-0.355744,-0.346481,-0.0637506,-0.223553,-0.208394,0.188369,0.775019,-0.217541,-0.29885,0.460081,0.484354,0.560975,-0.0664894,-0.189295,-0.259864,-0.313423,0.13329,-0.42704,0.22247,-0.176921,0.335497,-0.0459971,-0.460658,-0.23514,-0.450805,0.357895,-0.0157555,-0.11324,-0.464812,-0.0569104,0.167991,-0.171732,-0.0902627,0.408962,0.137735,0.224431,0.371126,0.473741,-0.967617 +3436.61,0.996834,0.0912059,4,1.55898,0.879421,-0.652765,0.147895,0.0673665,0.0349267,0.105755,0.390464,0.128322,0.406773,-0.0182715,0.0614764,0.39974,0.484623,-0.00909305,0.535815,0.1511,-0.189558,-0.0801565,0.307955,-0.497519,-0.861592,-0.863875,-0.110692,-0.133779,-0.328598,0.492973,0.0253092,-0.0678189,0.123795,0.69417,-0.224858,-0.042124,0.0238961,-0.0876468,0.338995,-0.341743,-0.188915,0.427886,0.0543322,0.786992,-0.101083,-0.505647,-0.524969,-0.131551,0.0884769,0.0917585,-0.218887,0.690178,0.104546,0.349708,0.292652,0.677683,-0.743676,1.14863,0.153373,-0.0547277,-0.484904,0.647324,-0.0362366,0.517743,0.573218,-0.696563,-0.94223,0.0555439,-0.225566,0.367864,-0.292474,0.475744,-0.570377,-0.218067,-0.0111134,0.476654,-0.105983,0.724411,0.476803,0.082991,0.468169,0.175989,0.423024,0.510092,-0.296036,0.813749,-0.363043,-0.400844,-0.546274,0.0150189,-0.425279,0.131152,-0.416797,0.23645,0.121115,-0.0519724,-0.0175232,-0.0068138,-0.179998,0.307398,-0.438322,0.0972752,0.411676,0.153612,0.110329,-0.0397359,-0.268308,0.484216,0.087425,-0.157351,-0.367498,0.0910789,0.388049,-0.249408,-0.163695,0.179387,0.23077,-0.0918676,0.618456,0.0311956,0.0986174,-0.19818,-0.504379,0.0418162,0.514019,-0.391431,-0.563403,0.291464,0.0974415,0.305121,-0.00570636,0.491327,-0.551707,-0.252355,-0.222871,-0.121834,0.231735,-0.145738,-0.13186,-0.306605,-0.227222,0.812922,-0.473446,-0.838167,0.246474,0.336578,-0.262481,-0.154773,0.159177,-0.253776,0.447005,-0.237501,0.0123671,-0.581081,0.189668,-0.278021,-0.405683,0.0673966,0.183888,0.206999,-0.147238,0.421357,0.0956049,0.764416,-0.087659,1.07148,-0.323802,-0.55598,0.278281,0.0795942,0.0704376,-0.125388,-0.207875,-0.0509234,0.513141,-0.12239,-0.973574,-0.13881,-0.235323,-0.412972,-0.585044,-0.177815,0.607525,0.256632,0.0574101,0.570945,-0.633214,-0.510756,-0.713855,0.0541395,-0.152879,0.450228,-0.814056,-0.0905777,0.354675,0.409457,-0.41989,0.0350585,-0.199155,0.210354,-0.205717,-0.47577,0.712078,0.459843,-0.584493,0.219766,-0.791027,0.195973,0.0332655,-0.669295,1.0195,0.321208,-0.204108,0.236224,0.0694889,0.0243278,0.0377966,-0.319389,0.240566,-0.355422,0.380696,0.102391,-0.37676,0.364149,-0.260687,0.213775,0.378585,0.179248,0.483412,-0.550734,-0.270914,0.168866,-0.575494,-0.245066,-0.0309536,-0.22646,0.263804,-0.0581958,0.387061,0.0298316,0.143168,0.670104,-0.284135,0.204787,0.0445011,0.226297,-0.312122,0.0789709,-0.382571,0.539154,-0.0822001,-0.288894,-0.26591,0.0677464,-0.393869,0.121504,0.172179,-0.00237215,-0.0671765,-0.0213376,-0.202208,0.017747,0.238688,0.119826,0.111258,-0.182599,0.224078,-0.187197,-0.334053,0.104745,-0.38632,-0.22584,0.0735231,-0.630267,-0.306355,0.147855,-0.122576,-0.123426,-0.0370606,0.571301,0.579672,0.638461,-0.31319,-0.143297,-0.594638,0.0522543,-0.391048,-0.112174,-0.101338,-0.392882,0.258658,0.0206861,-0.155554,-0.349798,-0.398119,-0.273077,-0.172526,-0.0514929,-0.177785,-0.104157,-0.138301,-0.330172,0.0387712,0.334852,0.131771,0.169797,0.363003,0.412064,-0.0254505 +3436.61,0.483418,0.0912059,4,1.55898,0.879421,-0.652765,0.147895,0.0673665,0.0349267,0.105755,0.390464,0.128322,0.406773,-0.0182715,0.0614764,0.39974,0.484623,-0.00909305,0.535815,0.1511,-0.189558,-0.0801565,0.307955,-0.497519,-0.861592,-0.863875,-0.110692,-0.133779,-0.328598,0.492973,0.0253092,-0.0678189,0.123795,0.69417,-0.224858,-0.042124,0.0238961,-0.0876468,0.338995,-0.341743,-0.188915,0.427886,0.0543322,0.786992,-0.101083,-0.505647,-0.524969,-0.131551,0.0884769,0.0917585,-0.218887,0.690178,0.104546,0.349708,0.292652,0.677683,-0.743676,1.14863,0.153373,-0.0547277,-0.484904,0.647324,-0.0362366,0.517743,0.573218,-0.696563,-0.94223,0.0555439,-0.225566,0.367864,-0.292474,0.475744,-0.570377,-0.218067,-0.0111134,0.476654,-0.105983,0.724411,0.476803,0.082991,0.468169,0.175989,0.423024,0.510092,-0.296036,0.813749,-0.363043,-0.400844,-0.546274,0.0150189,-0.425279,0.131152,-0.416797,0.23645,0.121115,-0.0519724,-0.0175232,-0.0068138,-0.179998,0.307398,-0.438322,0.0972752,0.411676,0.153612,0.110329,-0.0397359,-0.268308,0.484216,0.087425,-0.157351,-0.367498,0.0910789,0.388049,-0.249408,-0.163695,0.179387,0.23077,-0.0918676,0.618456,0.0311956,0.0986174,-0.19818,-0.504379,0.0418162,0.514019,-0.391431,-0.563403,0.291464,0.0974415,0.305121,-0.00570636,0.491327,-0.551707,-0.252355,-0.222871,-0.121834,0.231735,-0.145738,-0.13186,-0.306605,-0.227222,0.812922,-0.473446,-0.838167,0.246474,0.336578,-0.262481,-0.154773,0.159177,-0.253776,0.447005,-0.237501,0.0123671,-0.581081,0.189668,-0.278021,-0.405683,0.0673966,0.183888,0.206999,-0.147238,0.421357,0.0956049,0.764416,-0.087659,1.07148,-0.323802,-0.55598,0.278281,0.0795942,0.0704376,-0.125388,-0.207875,-0.0509234,0.513141,-0.12239,-0.973574,-0.13881,-0.235323,-0.412972,-0.585044,-0.177815,0.607525,0.256632,0.0574101,0.570945,-0.633214,-0.510756,-0.713855,0.0541395,-0.152879,0.450228,-0.814056,-0.0905777,0.354675,0.409457,-0.41989,0.0350585,-0.199155,0.210354,-0.205717,-0.47577,0.712078,0.459843,-0.584493,0.219766,-0.791027,0.195973,0.0332655,-0.669295,1.0195,0.321208,-0.204108,0.236224,0.0694889,0.0243278,0.0377966,-0.319389,0.240566,-0.355422,0.380696,0.102391,-0.37676,0.364149,-0.260687,0.213775,0.378585,0.179248,0.483412,-0.550734,-0.270914,0.168866,-0.575494,-0.245066,-0.0309536,-0.22646,0.263804,-0.0581958,0.387061,0.0298316,0.143168,0.670104,-0.284135,0.204787,0.0445011,0.226297,-0.312122,0.0789709,-0.382571,0.539154,-0.0822001,-0.288894,-0.26591,0.0677464,-0.393869,0.121504,0.172179,-0.00237215,-0.0671765,-0.0213376,-0.202208,0.017747,0.238688,0.119826,0.111258,-0.182599,0.224078,-0.187197,-0.334053,0.104745,-0.38632,-0.22584,0.0735231,-0.630267,-0.306355,0.147855,-0.122576,-0.123426,-0.0370606,0.571301,0.579672,0.638461,-0.31319,-0.143297,-0.594638,0.0522543,-0.391048,-0.112174,-0.101338,-0.392882,0.258658,0.0206861,-0.155554,-0.349798,-0.398119,-0.273077,-0.172526,-0.0514929,-0.177785,-0.104157,-0.138301,-0.330172,0.0387712,0.334852,0.131771,0.169797,0.363003,0.412064,-0.0254505 +3440.56,0.862214,0.0912059,5,1.5515,1.09666,-0.176281,0.0126924,0.256367,-0.00152914,0.0738022,0.444393,0.891777,-0.00212511,-0.12912,-0.170018,-0.389407,0.308605,-0.449089,0.977447,0.067282,-0.27155,0.0129604,-0.178212,-0.489988,-0.715666,-0.673325,-0.0920934,-0.208138,0.109521,0.237282,0.499498,-0.532872,0.302041,0.477213,0.0433736,0.0963987,0.266738,-0.56724,-0.32535,-0.512022,0.850926,0.0381458,-0.670782,0.565962,0.826864,0.340496,-0.808995,-0.0215836,-0.436552,-0.851182,0.0154994,0.411429,0.0264726,-0.243773,0.218863,0.190548,-0.462932,0.77986,0.0689401,-0.317617,-0.503779,0.165172,-0.228842,0.234933,0.786416,-0.4683,-0.760014,0.55943,0.57413,-0.455946,0.590627,0.316029,0.188696,-0.0704593,0.319898,0.529162,0.492849,0.955522,0.382846,0.51476,-0.392547,-0.658051,-0.282832,0.372563,-0.500627,0.112249,0.535918,-0.107394,0.317239,0.13714,0.679188,-0.189206,-0.0836314,-0.361101,0.557466,0.0123519,0.214764,0.186108,-0.0322277,-0.15054,0.258286,0.654492,0.628686,0.394546,0.409767,-0.172506,0.019337,0.531515,-0.528542,0.20508,-0.0910352,0.424217,0.848255,-0.0349544,-0.670859,-0.44164,0.312762,-0.190249,-0.159198,-0.140925,0.278143,0.33677,0.0352815,-0.741677,-0.0891625,0.298541,-0.560201,0.0681125,-0.206296,0.0254056,0.50037,0.018335,-0.214744,0.238801,0.133277,0.766061,0.470677,-0.164916,0.244975,0.22374,-0.0011678,0.139887,-0.599807,-0.370713,0.254029,0.301983,-0.763029,-0.0161648,0.182299,-0.241192,-0.0535778,0.233785,-0.0568875,-0.0635539,-0.093689,0.725714,0.111171,0.413898,0.152259,-0.164612,-0.237498,0.293969,-0.0117649,0.070154,0.32162,0.251465,-0.198361,-0.21766,0.657738,-0.0116477,-0.368106,0.0923388,0.12322,0.140177,-0.0592482,-0.118057,0.058935,0.0245236,-0.227298,-0.212084,-0.0748908,-0.113973,0.979931,-0.0275928,-0.74193,-0.00454066,-0.0554715,-0.0284681,-0.173109,-0.265771,-0.0167788,-0.0131456,0.184247,0.000703829,-0.466182,0.195856,-0.261518,0.458368,0.372336,-0.114237,0.00249486,-0.372369,0.334577,0.0888331,-0.09425,0.169599,0.302545,0.146249,0.256982,-0.304114,0.980737,-0.194148,0.466468,-0.0986201,0.15876,0.482443,0.312255,0.0784834,0.436772,-0.284133,0.513874,0.188063,-0.311149,-0.382123,-0.0177281,-0.24494,-0.63093,-0.404075,0.282519,-0.0388136,0.0518224,0.452314,0.153496,0.0256696,-0.00935503,-0.0293383,-0.264841,-0.461249,0.544451,0.137693,-0.247645,0.336376,-0.67749,0.0629425,-0.494814,-0.139256,-0.346129,0.28035,0.445886,0.235213,-0.0141963,0.109973,-0.417678,0.155427,-0.559195,0.471253,-0.184451,-0.830314,0.266549,-0.109511,0.0843024,0.0821507,0.165332,-0.159758,0.547298,-0.0224993,0.214707,0.770673,0.162309,-0.125379,-0.370571,0.0503153,-0.20862,0.312964,-0.604863,-0.474438,0.189174,0.133397,0.0237028,-0.0708,-0.188468,-0.0833141,0.242802,-0.218652,-0.412031,-0.623267,0.492366,0.0519195,0.114246,0.380859,-0.399976,-0.481579,-0.523204,0.0320162,0.196206,0.356974,0.264018,0.0811849,-0.450028,-0.0892277,0.0323343,-0.284206,-0.158862,-1.10309,0.129691,0.262024,0.360126,0.511883,-1.15747 +3416.83,0.574067,0.0912059,4,1.63563,1.05292,-0.201027,0.0133704,0.223941,-0.143451,0.511557,0.547814,0.097902,0.749219,-0.170127,-0.246868,-0.0730549,0.431064,0.174527,1.00169,-0.492226,-0.216263,0.295336,0.0449462,-0.0773101,-0.668698,-0.833147,0.022135,-0.762418,-0.496718,-0.106545,0.507259,-0.398477,-0.380397,0.66239,0.28536,-0.15609,0.0771676,-0.783342,-0.163423,-0.420219,-0.0839443,0.463696,-0.668914,1.24113,-0.508217,-0.0578862,-0.818589,-0.308746,0.339736,0.0822367,-0.276238,0.492206,-0.170554,-0.278964,0.204167,0.0834615,-0.815955,0.900608,-0.543617,-0.231048,-0.813687,0.311303,-0.558746,0.179479,0.929632,-1.13049,-1.52731,0.0861414,-0.00220564,0.137623,-0.208372,0.136688,-0.842927,0.114224,0.852255,0.728947,-0.317791,0.146893,0.824808,0.440188,-0.126815,-0.151816,-0.232232,0.176752,-0.00345097,0.628138,0.0265237,-0.0337126,-0.000627827,-0.17009,-0.164522,0.152935,-0.234049,-0.148291,0.165539,0.086061,0.0179686,0.0482141,-0.175303,-0.10657,-0.22003,0.0707369,0.00164268,0.612067,-0.112156,-0.0635468,-0.0562415,0.218514,-0.259226,0.136964,-0.448691,-0.0659588,0.928921,-0.629818,-0.0826407,-0.0752448,0.159796,0.0420968,0.0417186,-0.254395,0.0800145,0.379556,-0.19126,-0.561402,-0.113971,-0.44042,-0.0110837,0.089948,0.00730215,0.254446,0.47419,0.540851,0.244064,0.735217,-0.101238,0.181946,0.569488,0.283107,-0.125063,-0.145634,0.124478,0.0888704,-0.640023,-0.468774,-0.0119571,0.528948,0.136352,-0.0792247,0.103926,-0.0462036,1.10399,-0.222507,-0.475574,-0.667797,0.315846,0.281262,-0.151468,0.270402,0.0101283,-0.362357,0.730875,-0.0714947,0.177443,0.203967,-0.000150743,0.777924,-0.482235,-0.597167,0.453018,-0.738593,-0.135336,-0.0150313,-0.618922,-0.139751,0.419931,-0.272753,-0.240163,0.119501,-0.176044,-0.190877,-0.705763,0.0748031,0.275016,-0.0655755,-0.26789,-0.586322,-0.111432,-0.0633203,-0.0934114,-0.335791,-0.341743,0.431726,-0.535945,-0.0821268,-0.810924,-0.0478583,-0.158838,0.0911681,-0.169551,-0.190267,-0.675349,-0.789917,0.072419,0.209583,-0.088442,0.669421,-0.0991038,0.12553,0.600527,-0.282215,1.05182,-0.115287,-0.474115,-0.111695,0.449265,-0.143764,-0.0820431,-0.273031,-0.080574,-0.204679,-0.259501,0.527267,0.0325255,0.489727,-0.7647,0.237651,0.103644,-0.6992,0.251885,-0.196034,-0.121283,-0.0153269,0.00232805,-0.403122,-0.168145,0.0369862,0.108353,-0.0898694,0.54844,-0.0154475,-0.536748,0.208829,0.012451,-0.237843,0.622424,-0.0625641,-0.0755731,0.271395,-0.341836,0.261926,0.293756,0.0251206,-0.11904,-0.30211,-0.164169,0.709897,0.223658,-0.169804,0.315771,-0.556233,-0.22666,0.428733,0.324922,0.668642,0.355292,0.712127,0.318041,0.251801,0.492512,0.0192091,-0.0547203,-0.15091,0.0476281,0.182219,0.0703714,-0.565922,0.0949338,0.246003,0.43275,0.22493,-0.324914,0.665333,-0.14799,0.0386772,-0.439199,-0.0238667,-0.0137715,-0.222514,0.121554,0.103153,0.608362,0.304665,0.278735,-0.308531,-0.017521,-0.0441552,-0.0382787,-0.321776,-0.472155,-0.0828676,-0.102702,0.775436,0.520937,-0.305679,0.139311,0.249308,0.373244,0.499307,-0.840518 +3420.13,1,0.0912059,4,1.64722,0.972592,-0.31151,0.0928527,0.153586,-0.119297,0.874601,0.347865,0.328701,0.5003,-0.218232,-0.294553,-0.0381255,0.172199,0.194687,0.922399,-0.330357,-0.162834,0.334053,-0.0227231,-0.0761749,-0.729313,-0.920092,-0.249306,-0.639701,-0.520117,-0.241626,0.794151,-0.318054,-0.432357,0.768424,0.422005,0.140856,0.0185672,-0.718237,-0.281022,-0.104734,-0.0709996,0.381988,-0.724086,1.15795,-0.379134,-0.00091497,-0.736429,-0.71566,0.145303,-0.00409713,-0.191823,0.635986,-0.234758,-0.13363,-0.239177,0.0276012,-0.816466,0.785701,-0.632776,-0.391802,-0.722986,0.317288,-0.369622,-0.0235614,1.13006,-1.55439,-1.11081,0.0789087,-0.123318,0.0984941,-0.0653867,0.561281,-0.633448,0.18248,0.65152,0.771886,-0.156072,0.366416,0.609445,0.563538,-0.121772,-0.237125,-0.338997,0.117477,-0.292662,0.63546,-0.194568,0.280365,-0.00810996,-0.168994,-0.309765,0.532451,-0.285491,-0.158414,0.0402549,0.0130873,0.203065,0.0975042,0.146841,-0.176062,-0.458347,0.00716046,-0.0582146,0.775924,0.181532,-0.169667,-0.174651,0.268787,-0.58145,0.0633132,-0.34164,-0.20864,0.845577,-0.570152,-0.340981,0.100238,0.171765,0.477111,-0.0203311,-0.159802,0.161228,0.25587,-0.0664417,-0.713705,0.362559,-0.538325,-0.0538952,-0.0385107,-0.056825,0.194806,0.438923,0.551796,0.1756,0.546993,-0.122066,0.081782,0.546425,0.434913,0.0300963,0.20853,-0.00171855,0.226099,-0.626374,-0.354843,0.251103,0.564201,-0.339615,-0.274494,0.227856,-0.0994585,1.02804,0.0873631,-0.577715,-0.668563,0.458289,0.703363,-0.192749,0.14846,0.344515,-0.352438,0.717657,-0.167811,0.209178,0.217329,-0.00207358,0.908037,-0.351305,-0.57203,0.557566,-0.483292,0.0420003,-0.354366,-0.777104,0.17777,0.35643,-0.0517954,-0.238465,0.232838,-0.263534,-0.238439,-0.619833,0.272632,0.357088,0.202193,-0.186244,-0.212633,-0.346733,-0.0943292,-0.212071,0.0549857,-0.403011,0.00808795,-0.656141,-0.0516193,-0.767561,-0.210158,-0.0746647,-0.296226,-0.038466,-0.457838,-0.69897,-0.713602,0.0272601,-0.0394442,-0.328048,0.479575,-0.188536,0.012478,0.543424,-0.141324,0.925883,-0.225826,-0.404225,-0.0593169,0.283403,-0.0805183,-0.244987,-0.251717,-0.230496,0.0151098,-0.340797,0.365011,-0.121542,0.43557,-0.845483,0.393639,0.296426,-0.132743,0.0898642,-0.216803,-0.100577,0.0452757,-0.0852121,-0.147472,-0.212386,0.146034,0.146051,-0.355807,0.499431,-0.229892,-0.420814,0.372318,0.0997247,-0.329003,0.411083,-0.561964,-0.0857181,0.284334,-0.172943,0.446228,0.645636,0.134388,0.00285235,-0.427118,-0.110379,0.92406,-0.165184,0.0312794,0.0125863,-0.479464,-0.217311,0.205069,0.373108,0.37787,0.23554,0.851624,0.174346,0.0302938,0.494049,0.300599,-0.421239,-0.404975,0.217913,0.137227,-0.115996,-0.783778,0.0185233,0.223168,0.136156,0.0676586,-0.303155,0.511552,-0.052016,0.0616679,-0.143299,-0.380498,0.20049,0.0293097,0.101423,-0.227487,0.500901,-0.171532,0.0487984,0.0107122,-0.0974233,0.333015,0.00133049,-0.306499,-0.304722,0.222858,-0.0826782,0.161161,0.580767,-0.451394,0.135372,0.281004,0.367929,0.530098,-0.476706 +3421.74,0.937306,0.0912059,4,1.64858,0.95723,-0.342806,0.110375,0.176988,-0.1367,0.787045,0.373522,0.296369,0.58741,-0.260084,-0.310558,-0.0223063,0.22127,0.145042,0.871548,-0.353217,-0.201314,0.293,-0.0525206,-0.119585,-0.75275,-1.00256,-0.311499,-0.680783,-0.445497,-0.246855,0.793805,-0.308695,-0.465018,0.779383,0.432406,0.106545,-0.0155617,-0.680873,-0.272084,-0.102623,-0.0615001,0.34759,-0.70351,1.12976,-0.376118,0.0537961,-0.715449,-0.685583,0.084689,-0.0576729,-0.072939,0.680263,-0.311645,-0.090276,-0.172228,0.0348095,-0.77025,0.808471,-0.62721,-0.334373,-0.718903,0.251098,-0.40597,0.0474897,1.14782,-1.54535,-1.14989,-0.0159127,-0.115504,0.0220152,-0.0743241,0.524055,-0.589323,0.123483,0.64198,0.735701,-0.132121,0.428975,0.612307,0.516183,-0.0956718,-0.25277,-0.297022,0.130349,-0.280541,0.645926,-0.17854,0.273479,-0.0593561,-0.185609,-0.387492,0.556846,-0.297421,-0.19031,0.126533,-0.017041,0.222092,0.120654,0.165083,-0.157727,-0.440689,-0.0629092,0.0276448,0.713338,0.103658,-0.150631,-0.180826,0.285535,-0.586822,0.0705625,-0.244015,-0.245391,0.827589,-0.533976,-0.328091,0.0916273,0.180484,0.453897,0.080342,-0.246474,0.180789,0.220515,0.0333543,-0.67804,0.314997,-0.575834,-0.00732245,-0.0598338,-0.0334913,0.159802,0.453179,0.59084,0.135243,0.561621,-0.114452,0.0855169,0.524406,0.395201,-0.00957527,0.242124,-0.0265121,0.222675,-0.697827,-0.302087,0.265968,0.557141,-0.249735,-0.299824,0.243532,-0.0598151,1.01593,0.0768897,-0.684947,-0.638201,0.400475,0.70073,-0.233143,0.109326,0.304654,-0.28009,0.709012,-0.156224,0.239186,0.156202,0.0452934,0.894012,-0.259103,-0.572091,0.538643,-0.403923,0.107893,-0.387876,-0.718686,0.378518,0.294945,-0.0864009,-0.236956,0.239815,-0.129069,-0.210277,-0.709438,0.390739,0.34639,0.19968,-0.134627,-0.167281,-0.400318,-0.154754,-0.181993,0.0613833,-0.434662,-0.00300092,-0.695795,-0.0835154,-0.748606,-0.277963,-0.102336,-0.303254,-0.0225225,-0.432017,-0.664054,-0.680747,0.0872281,-0.0183379,-0.356204,0.42266,-0.168961,-0.0491562,0.630054,-0.164779,0.872387,-0.240887,-0.377032,-0.028839,0.276059,-0.0467553,-0.285573,-0.258827,-0.223205,-0.0112343,-0.283985,0.410742,-0.113221,0.376634,-0.860216,0.365543,0.182591,-0.154984,0.0949672,-0.257294,-0.102013,-0.0679388,-0.0276953,-0.197633,-0.274953,0.173366,0.181735,-0.217319,0.489269,-0.166898,-0.414094,0.360483,0.095297,-0.278314,0.361156,-0.504332,0.0674018,0.419674,-0.181543,0.456388,0.625171,0.07311,-0.00160381,-0.411476,-0.0151633,0.939831,-0.177026,0.130217,0.0243412,-0.429322,-0.250043,0.249302,0.395731,0.387879,0.224592,0.792663,0.165352,0.00852621,0.452534,0.308415,-0.375059,-0.321077,0.198674,0.123057,-0.129924,-0.756285,-0.0304558,0.09142,0.111227,0.055783,-0.375778,0.501993,-0.0813202,0.0105127,-0.132625,-0.340163,0.273002,0.0555637,0.184241,-0.258153,0.49823,-0.189074,0.0816567,-0.0407592,-0.0543593,0.335589,-0.0588972,-0.256308,-0.330722,0.2626,-0.0945039,0.20176,0.497239,-0.502087,0.131375,0.305906,0.362457,0.553087,-0.521709 +3421.25,0.633054,0.0912059,4,1.66426,0.947776,-0.645936,0.306386,0.312811,-0.118946,-0.056821,0.181089,0.405417,-0.0438174,-0.0200088,-0.719648,0.0276176,0.172866,-0.133147,0.673894,0.19944,0.15261,-0.20683,-0.0568969,-0.12139,-0.472359,-0.96214,-0.340386,-0.0151575,-0.214925,-0.0650634,0.325532,-0.111065,-0.22643,0.521934,-0.376949,0.144085,0.289492,-1.00587,-0.289607,-0.699978,0.380101,0.643962,-0.442257,0.821309,0.288628,-0.161093,-0.999275,-0.320762,-0.320511,-0.548484,-0.301783,0.257659,-0.31686,-0.000848787,0.000861505,0.016787,-0.341655,0.582261,-0.269486,-0.298329,-1.27249,0.0850988,-0.505485,-0.356772,0.668467,-0.696422,-0.830928,-0.0362662,0.19833,0.0606747,0.176838,-0.124068,-0.319857,-0.191861,-0.176602,0.812262,-0.49104,0.94487,0.312305,0.220664,0.0659902,0.0637397,-0.299563,0.0929363,-0.838479,0.377724,0.608885,-0.00505415,0.300638,-0.638701,0.206595,0.18922,-0.146742,-0.462721,-0.323922,0.192192,0.0516492,-0.113864,-0.237428,0.389911,-0.308969,0.15811,-0.120972,0.233621,-0.384416,-0.41137,0.179533,-0.247576,-0.828583,0.101784,-0.510224,0.124403,0.473142,-0.186635,0.0674732,0.400198,0.13905,-0.185686,0.275285,-0.295872,0.261598,0.0091416,0.124538,-0.583642,0.192294,0.0564416,-0.232713,0.0197158,0.133503,-0.256062,0.211255,0.12692,-0.474477,-0.226428,0.184826,0.359428,0.69311,-0.118946,-0.19092,-0.400722,-0.242735,0.277375,-0.22153,-0.517849,0.22487,-0.109956,-0.155371,0.429242,-0.306796,-0.496867,0.83059,-0.316152,0.0572494,-0.219187,-0.448116,0.556937,0.650593,0.108664,0.384161,-0.348279,-0.176512,-0.0175894,0.171259,-0.160992,-0.350152,1.03223,0.465157,0.0851158,0.823272,-0.586587,-0.30129,-0.314508,-0.250905,0.447842,0.0794101,-0.428639,0.323717,-0.618381,0.388552,-0.335387,-0.697986,-0.630538,0.444508,0.394485,-0.193828,0.721563,0.0117394,-0.538345,0.251968,0.455989,-0.352498,0.144559,-0.0461468,0.446637,-0.178812,0.0957704,-0.557272,0.122848,0.172302,0.446966,-0.262519,-0.232562,-0.159118,0.352491,0.106648,0.247264,0.316015,0.0334784,0.0732904,-0.235227,1.10793,-0.129661,0.45076,0.370762,-0.463093,0.0658976,-0.0789844,-0.385857,0.0518217,0.389667,0.280089,0.669324,-0.0624081,0.158442,-0.49786,-0.170958,-0.876883,0.120339,0.278031,-0.00345628,0.206457,0.0819463,-0.443099,-0.436626,-0.176026,-0.261987,-0.370188,-0.498415,0.449193,0.461754,-0.162139,0.605324,-0.248416,-0.46913,0.0494789,0.51855,0.13974,0.814759,-0.213415,0.32846,0.574449,-0.412094,-0.159296,-0.00668823,-0.430108,0.42861,-0.128879,-0.56212,0.447703,-0.311758,-0.110307,0.461127,0.586317,0.0741392,0.355161,0.32883,0.146282,0.0746287,0.313297,-0.146159,0.177418,0.294599,-0.167091,0.292887,-0.469224,-0.418716,0.181243,0.12256,0.189219,-0.313366,0.136926,0.322843,-0.0124045,-0.446063,-0.311072,-0.209867,0.489371,-0.0490394,0.114145,-0.410904,0.456311,-0.142751,-0.346704,-0.287036,-0.363886,0.222398,0.432767,-0.125367,-0.413645,0.510041,-0.388612,0.220589,0.0545762,-0.059173,0.138153,0.223226,0.371689,0.472468,-0.971269 +3418.29,0.914328,0.0912059,4,1.56349,0.717572,-1.08763,0.495471,0.47307,-0.241902,-0.154007,0.0167339,0.207376,-0.1398,0.33295,0.229128,0.0174718,0.394237,-0.0174563,0.439325,0.29002,0.203837,0.190824,0.051889,0.216086,-1.13892,-0.280881,0.345428,-0.527235,-0.30013,0.0434915,0.43958,-0.667351,0.480706,1.07575,-0.325906,0.288625,0.48267,-0.0212601,-0.444937,0.13985,0.23388,0.276776,-0.561923,0.881086,0.640464,0.604203,-0.745281,-0.365306,-0.413094,-0.323774,-0.107951,0.628127,0.134145,0.145331,0.769098,-0.043567,-0.258092,0.518403,-0.448715,-0.203122,-0.652446,0.125982,-0.0361246,0.117771,0.914757,-0.629208,-0.792851,0.162122,0.359142,-0.179274,-0.246736,0.56557,-0.201736,0.0803251,-0.0351691,0.771139,0.0999771,0.229913,0.375288,0.243681,0.0383196,-0.329674,0.106071,0.981223,-0.154682,0.495519,-0.263849,0.345221,-0.329117,0.450949,0.0110452,0.0485769,-0.639164,-0.226438,0.107342,-0.359754,-0.212608,0.247053,-0.317479,-0.0555829,-0.145054,0.208849,0.320852,-0.174852,0.0669104,-0.526809,-0.0640323,1.10342,0.0345124,0.639012,-0.357527,0.121109,0.366082,-0.0896532,-0.549829,-0.104251,0.35639,0.445355,0.0827907,-0.0821854,0.31218,0.0583414,-0.409599,-0.749818,-0.551719,-0.385479,0.133705,-0.0301813,0.116409,0.264549,0.317184,0.097089,-0.3011,-0.0356236,0.186955,-0.0228909,0.227184,-0.326233,-0.40879,0.472346,0.210221,0.072905,-0.524489,-0.0593288,0.242697,0.335957,-0.301321,-0.289625,0.0426351,0.234437,0.0509619,-0.121928,-0.289157,-0.396542,0.59497,-0.532679,-0.690091,0.34406,0.0789624,0.325958,0.410114,0.103128,-0.189797,0.166408,0.388498,0.616994,-0.402903,-0.534877,0.0282289,-0.130149,-0.0215739,0.00881258,0.18214,-0.0279836,-0.655757,-0.267475,0.0262403,0.0101599,0.144417,0.0316929,0.0952306,0.58512,0.5568,-0.056985,-0.34741,-0.369753,0.187977,0.119394,-0.302842,-0.319006,-0.172429,0.359365,-0.508655,0.113718,0.0624709,0.17734,-0.474477,-0.182193,0.042399,-0.0947357,-0.419184,-0.0925068,0.504979,0.0650952,-0.176131,0.231627,-0.230421,-0.087259,0.102132,-0.43868,0.618451,0.312126,-0.478159,-0.392337,0.0588176,0.173112,-0.176535,-0.388579,0.185201,-0.837772,0.00946833,-0.532541,-0.698855,0.0680794,-0.290001,-0.00731067,0.900968,-0.861421,-0.203714,-0.315561,-0.723345,-0.898952,0.240338,-0.302266,-0.0359064,-0.205392,0.167123,-0.486176,0.916188,-0.576147,0.573862,0.0818462,-0.766113,0.311452,-0.147013,-0.19385,0.177642,-0.421019,0.547247,0.497911,0.128435,0.528792,0.00241918,0.0245,-0.711972,0.251595,-0.0215474,-0.0132393,0.17416,-0.373273,0.307389,-0.237417,0.178408,-0.373712,0.669505,0.00394521,0.0373083,0.648468,-0.139479,0.104384,-0.262093,-0.748763,0.338051,-0.719186,-0.0850195,-0.522204,0.504687,-0.577456,-0.0186443,0.6327,-0.144128,0.372221,0.621963,0.0967394,0.206589,-0.10899,-0.0173852,-0.181332,0.233567,0.198218,-0.147602,0.256403,0.387739,0.173787,0.473277,-0.0192169,0.471378,0.574317,-0.207413,0.188423,0.160424,-0.160878,0.0391293,-0.668016,0.139829,0.244823,0.373937,0.494796,-1.11359 +3439.42,0.943439,0.0912059,4,1.59867,0.734142,-1.2072,0.454069,0.281266,-0.16087,-0.190317,-0.48375,0.227713,0.156307,0.0910777,-0.367568,-0.0621187,0.215592,-0.222902,0.669723,0.200548,-0.0315919,-0.348133,0.0926424,0.116553,-0.789327,-1.06709,0.169501,-0.552069,-0.406328,-0.0302709,0.0330191,-0.143152,0.132919,0.938373,-0.114947,0.472676,0.374136,-0.285565,-0.192717,-0.132762,0.275069,-0.0760483,-0.671889,0.700731,0.774502,0.648719,-0.782688,-0.261894,0.143525,-1.01927,0.284281,0.435236,0.0697084,-0.200577,0.682255,-0.0275285,-0.328959,0.772879,-0.30814,-0.123548,-0.72049,-0.136353,-0.357289,0.267243,1.24114,-0.632236,-0.659646,0.295104,0.114652,-0.113185,-0.115361,-0.400033,-0.470429,0.0820697,0.117791,0.732322,-0.30465,0.41892,0.505347,0.470805,0.336327,-0.136929,-0.20617,0.744399,-0.236899,0.414613,-0.273348,0.408895,-0.55665,0.0263063,-0.217323,-0.250369,-0.389078,-0.322976,-0.697975,0.0782009,-0.121193,0.395529,-0.0148406,0.217869,0.0906477,-7.53936e-06,0.67809,-0.144643,-0.389916,-0.291472,-0.0741521,0.47328,0.0640585,0.177543,-0.319993,0.132097,0.498991,-0.0512618,-0.205466,-0.370519,0.173562,0.115828,0.123166,-0.315739,0.416229,-0.0918608,-0.295461,-0.759262,-0.0166638,-0.0961215,-0.0169548,-0.286087,0.214212,-0.0867103,0.565328,0.254688,-0.370012,-0.220669,0.0201675,0.23284,0.125578,-0.074479,-0.414332,0.43795,-0.22828,0.14405,-0.301722,0.0146691,0.023997,0.595902,-0.57056,0.121647,0.15399,-0.157981,0.515078,-0.129385,-0.407459,-0.0400344,-0.0222149,0.0906691,-0.346733,-0.280056,0.640643,0.00304518,0.241903,0.0764663,-0.258863,-0.383017,0.393236,0.459598,0.855845,-0.512405,0.161288,-0.0201071,0.27752,0.262201,0.171647,0.389079,0.0504036,-0.184446,0.0935459,-0.17962,0.24242,-0.0145482,-0.2179,0.605579,0.328797,0.302558,-0.768875,0.0216001,0.144882,-0.213874,0.0999525,-0.318611,-0.171232,-0.0941826,-0.237074,0.0296847,0.569814,0.0107658,-0.0798512,0.142371,-0.171039,0.142318,0.0806978,-0.844569,0.552737,0.177254,-0.171611,0.689501,-0.0840182,-0.151617,0.0908387,-0.675705,0.867065,0.124108,-0.221913,-0.320702,-0.125508,0.674399,-0.248041,0.216459,0.424213,-1.02991,0.206201,-0.152311,-1.07574,0.293575,-0.396847,-0.0695007,0.29316,-0.164669,0.175672,-0.51965,-0.533203,-0.247383,0.187054,-0.406019,0.0219947,-0.234463,-0.345012,0.272333,0.767464,-0.360085,0.227928,0.208015,-0.68824,-0.126684,0.081809,-0.449539,-0.159259,0.154182,-0.284123,0.011467,-0.697529,0.374262,0.153124,-0.144892,-0.382431,0.508934,-0.149493,-0.0141521,0.453819,-0.799114,0.210577,0.182911,0.103489,0.300536,0.326709,-0.0583664,0.216873,0.341726,0.0265985,-0.00506643,-0.479231,-0.588016,0.0382531,-0.169811,-0.414035,-0.575258,-0.0979402,-0.257582,-0.106515,0.0100322,0.141085,0.684614,0.417831,-0.334437,0.373359,0.109982,0.385396,0.303057,0.0364108,0.141239,0.0297853,0.329361,-0.272921,-0.100744,0.24291,0.451425,-0.223358,0.410867,-0.0280561,-0.13734,-0.182418,-0.076884,-0.381814,-0.660319,0.118501,0.17456,0.34424,0.417803,-0.389128 +3441.98,0.767645,0.0912059,4,1.70343,0.779507,-1.40732,0.523081,0.493998,-0.141778,0.0322854,0.178843,-0.190778,0.255043,0.165796,0.0138598,-0.00743205,0.264815,-0.337904,0.738999,-0.247547,-0.0546089,-0.46216,-0.255684,-0.0203303,-0.830902,-0.80427,0.21025,-0.135218,-0.119901,-0.283781,0.314762,-0.490922,-0.5088,0.787118,-0.208554,-0.341668,0.27376,-0.18273,0.0889163,-0.46255,0.0382349,0.0725545,-0.240108,0.940285,0.529987,0.0716746,-1.13859,-0.0173068,-0.540066,-0.437736,0.109848,0.493295,-0.0590738,-0.0861738,0.444071,-0.00347282,-0.505134,0.484223,-0.367441,0.0135945,-0.48796,0.130125,-0.239404,0.185926,0.956377,-0.348224,-0.699696,-0.528273,-0.396894,-0.343682,0.561591,-0.0827668,-0.684329,-0.195728,0.209412,0.589204,0.211167,0.455531,0.434304,0.187651,0.408485,-0.303675,-0.476283,0.505085,-0.885716,0.111121,-0.139657,0.0789554,-0.0184654,0.105933,-0.442611,-0.0314427,-0.447848,-0.306185,0.0589359,-0.12723,0.0187193,0.0664568,0.229821,0.0170093,0.164766,0.119803,0.336353,-0.123392,-0.575711,-0.114154,-0.628179,0.339139,0.0289006,0.32887,-0.259131,-0.129135,0.73042,-0.166714,0.189907,-0.333185,0.314607,0.442221,0.0904388,-0.694627,0.49107,-0.120852,-0.0216652,-0.481136,-0.526548,-0.254361,0.498345,-0.203807,0.415965,0.0823586,0.00155621,0.250701,-0.304595,-0.344876,0.119486,0.000571965,0.274236,-0.300938,-0.24169,0.349753,-0.0898607,0.0865852,-0.0765916,-0.356243,-0.147867,-0.284062,-0.857183,0.176425,-0.19629,-0.334167,0.646034,-0.554828,-0.492525,-0.0224217,-0.390905,-0.114039,-0.125073,-0.138413,0.533674,0.560967,0.0543939,-0.0637705,0.169906,0.283717,-0.0374318,0.881075,0.176229,-0.527093,0.265241,-0.235977,0.235743,-0.0283182,0.0193065,0.248818,-0.153819,-0.260606,-0.329262,-0.408788,-0.0683528,0.103957,-0.346176,0.138901,0.754383,0.528867,-0.728668,0.186189,-0.57301,0.254168,-0.436777,-0.404926,-0.255896,0.386541,-0.195323,0.0486803,-0.280262,0.0838628,-0.485386,0.269117,-0.879669,0.0500577,-0.266881,-0.110685,0.756894,-0.334049,0.00786183,0.280198,-0.053978,0.177147,-0.409859,-0.524152,0.779411,-0.412951,0.441949,-0.1759,-0.484931,-0.505521,-0.425496,-0.15562,0.404588,-0.269838,-0.000824493,-0.0528365,-0.256471,0.545378,-0.746695,-0.208135,-0.00727631,-0.115713,-0.10345,-0.717154,-0.415615,-0.214483,-0.0273048,-0.762332,0.0350127,-0.152262,-0.177658,-0.0239348,0.448931,-0.200198,-0.115147,0.147305,-0.341561,-0.0204061,0.0757877,-0.0899545,0.0367708,-0.249799,-0.521749,0.146418,-0.683566,0.246857,-0.179892,0.0206969,-0.373311,0.715268,-0.42099,-0.0305417,0.0196854,-0.6837,-0.0010051,0.21113,0.072652,0.396246,0.156321,-0.259539,-0.251374,0.0784483,0.297845,-0.0518079,-0.0280923,-0.219614,0.0560443,-0.275255,-0.193883,-0.126137,-0.418202,0.384528,-0.0176797,0.0100191,-0.0412766,0.431854,0.342821,-0.262395,0.506452,0.645403,-0.157719,-0.260992,-0.0969264,-0.0906188,-0.00984608,0.0450407,-0.0230987,0.199931,0.0440392,-0.195172,0.0489026,0.248454,-0.471878,0.270796,-0.389002,-0.0231003,-0.13897,-0.0234989,0.13303,0.19778,0.364732,0.444725,-1.03587 +3449.68,0.772225,0.0912059,4,1.63746,0.790363,-0.781156,0.230528,-0.0946415,-0.0942284,0.174099,-0.467686,0.236097,-0.130689,0.088622,-0.278661,-0.450823,0.225497,0.0867468,0.576257,0.290058,-0.147445,-0.0812854,0.0670788,-0.225626,-1.37346,-1.03956,0.253094,-0.491456,-0.564255,-0.435574,0.0492294,-0.432908,-0.125895,1.12924,-0.437984,-0.0587502,0.128109,-0.178404,0.0081359,-0.449998,-0.140308,-0.338994,-0.314226,1.22527,0.424057,-0.115632,-0.644553,-0.0508852,-0.704624,-0.874359,0.192757,0.642696,0.152867,0.0059866,0.394134,-0.191782,-0.0334995,0.999412,-0.144329,-0.284652,-0.52406,-0.0986839,0.113345,0.258783,0.845762,-0.908668,-0.460369,0.436015,0.489006,-0.0461563,-0.305062,-0.204484,-0.611924,-0.212943,0.386927,0.897025,-0.293734,0.341154,0.25555,-0.171572,-0.218516,-0.355238,-0.0104095,0.910504,0.380949,0.170086,0.0270851,0.400384,0.191231,-0.248102,-0.194386,0.361887,-0.513545,0.0335454,-0.261904,-0.177027,0.185774,-0.195087,0.0287497,0.0356054,0.192616,0.37015,-0.148682,0.283785,0.263168,-0.126299,0.0608711,-0.0897068,0.163503,0.7021,-0.32012,0.34178,0.642171,-0.0720381,-0.0828114,0.144223,0.30023,0.170282,-0.0877326,-0.100308,0.220941,0.327101,-0.438754,-0.706422,-0.397109,-0.0508641,-0.286988,-0.368016,-0.1458,0.301565,-0.154342,-0.234394,-0.591655,0.124734,0.143095,-0.239188,0.513827,0.100302,-0.149328,-0.172753,0.29458,0.32277,-0.154264,-0.223585,0.16129,0.431289,-0.722661,0.817366,0.217535,-0.21644,0.878904,-0.109733,0.0865826,-0.15781,0.11503,-0.0589854,0.00430358,0.373708,0.384003,0.738784,-0.0733205,-0.0599164,-0.320509,-0.195389,0.103179,0.200968,0.528837,0.52246,0.141124,-0.142266,-0.0865448,-0.119326,-0.062174,0.124515,0.108499,0.000430817,0.274242,-0.180875,0.206693,-0.00105822,-0.421839,-0.0305302,0.734987,0.834369,-0.347994,-0.0784103,0.0498051,-0.121994,-0.478275,-0.361908,-0.265671,-0.0264089,-0.344533,0.265898,-0.0125847,-0.259866,-0.319289,0.340196,0.324925,0.178051,-0.225451,-0.437644,0.0572347,0.0880536,-0.39063,-0.221539,0.000995006,-0.0546503,-0.0479417,-0.603444,0.585193,0.0808747,-0.221553,0.158765,-0.369494,0.363484,0.121606,-0.386399,0.21268,-0.555127,-0.195281,0.487193,-0.168271,0.194811,0.041998,0.0337403,-0.54546,-0.378694,0.442411,-0.587495,0.398939,0.187859,-0.014041,-0.208215,-0.0472293,0.323036,0.151478,-0.661978,0.815801,-0.417108,-0.294053,0.390915,-0.0462625,-0.127826,-0.240431,0.030393,-0.16484,0.715712,0.465854,0.139892,0.112664,-0.298368,-0.153759,0.0461131,-0.486389,0.298559,-0.225096,0.064905,0.132906,-0.00696742,0.489558,0.214809,-0.222325,0.053312,-0.116959,-0.0151655,-0.308505,-0.201554,0.570565,-0.349696,0.0294758,-0.0517409,0.0417821,-0.371737,-0.226071,0.105238,0.343853,0.470258,0.422104,0.0743829,0.57996,0.127114,0.208799,-0.0259023,0.217407,-0.267321,-0.171212,-0.309458,-0.136884,-0.144384,0.115386,0.711994,0.0537823,-0.188008,0.471052,-0.200598,-0.219243,0.402539,-0.85866,-0.168384,-0.130608,-0.00376912,-0.359577,0.090172,0.111391,0.234765,0.333752,0.484525,0.769689 +3443.49,0.953423,0.0912059,4,1.66347,0.659591,-0.888743,0.285046,-0.202691,-0.0944313,-0.297298,-0.0386819,-0.0146381,0.21431,0.111969,-0.306663,-0.496146,0.556736,0.303511,0.586519,0.633647,0.0753831,-0.3832,0.288158,-0.180449,-1.19279,-0.866691,0.549627,-0.243997,-0.385865,-0.4155,0.171465,-0.197623,-0.489327,1.14161,-0.161123,-0.0342241,0.242701,-0.261998,0.155137,-0.37182,-0.243819,-0.347792,-0.336652,1.2096,0.443293,0.292675,-0.656171,0.06217,-0.777918,-0.765837,0.236769,0.602005,0.240658,0.0414712,0.243549,-0.154115,0.164518,0.968933,-0.364078,-0.228968,-0.359376,0.0649492,0.0107717,0.274107,0.990898,-1.06481,-0.91774,0.327268,0.366806,0.10656,-0.445299,0.0889569,-0.255651,-0.458986,0.553953,0.944998,-0.196053,0.183233,0.285291,-0.160982,-0.221815,-0.246843,0.393689,0.798022,0.146804,0.450378,0.185589,0.575062,0.0471476,-0.231913,-0.389875,-0.15731,-0.656983,-0.219372,-0.404351,0.0450814,-0.0819185,-0.420498,0.114073,0.27361,3.76531e-05,0.334079,0.00668781,0.138038,0.167688,-0.203337,0.217831,-0.12716,0.125721,0.216155,-0.0760891,0.593123,0.912593,0.0355525,0.0561846,0.0207443,0.361534,-0.223255,-0.0602591,-0.239012,0.175513,-0.0976008,-0.560909,-0.799722,-0.264835,0.149059,-0.405983,-0.331417,-0.163453,0.238489,0.21313,-0.0134366,-0.518026,0.0749016,0.211177,-0.264196,0.588523,-0.274723,-0.23981,0.161284,0.0171736,0.172281,-0.518912,0.0659973,-0.0821597,0.607761,-0.287522,0.41734,0.155792,-0.323758,0.427044,-0.228616,0.227258,-0.355254,0.0509629,0.237156,0.304989,0.0498321,0.480425,0.616596,0.338373,-0.0713931,-0.444555,0.0210557,-0.203586,0.106005,0.397721,0.0848377,0.100469,-0.249079,-0.0614531,-0.0750167,0.464205,0.358148,0.246315,-0.196417,-0.0257562,-0.303814,0.115139,0.236762,0.0730915,0.191039,0.427159,0.253476,-0.424147,0.0177939,-0.272082,-0.218226,-0.572027,-0.305758,0.10807,0.355302,-0.28855,0.07675,-0.276103,-0.237644,-0.404497,0.307217,0.342599,0.18201,-0.150809,-0.420005,0.078797,-0.238361,-0.63483,-0.0393704,0.0388436,0.0191484,-0.18253,-0.574233,0.386465,-0.0813639,-0.046509,0.189688,-0.184642,0.198843,0.0490236,-0.313812,0.24607,-0.485835,-0.138354,0.543321,-0.362906,0.644806,-0.0219939,0.350066,-0.0114047,-0.424531,0.495337,-0.584329,0.304291,-0.012998,0.218113,-0.256844,-0.229622,0.0807788,-0.184448,-0.246106,1.00647,-0.306787,-0.0620844,0.484474,0.44674,-0.0621797,-0.361702,-0.19299,-0.105861,0.175011,0.493985,0.226283,0.282624,0.0197899,-0.176263,-0.160825,-0.310079,-0.0255383,-0.479071,0.11824,0.18982,0.0742569,0.358066,0.00690034,-0.0647006,0.0579321,-0.243208,0.0852598,-0.204691,0.318868,0.570427,0.0360897,0.220692,-0.272921,-0.112533,-0.345756,-0.121407,-0.172942,0.687858,0.440444,0.597937,-0.463082,-0.0734881,0.115778,0.418048,-0.318317,-0.211641,-0.262594,0.235553,-0.165465,0.0971635,0.269735,0.0428035,0.251068,-0.109811,0.0927304,0.399805,-0.558046,0.0487198,0.252876,-0.654184,-0.0151277,0.0990629,-0.40777,-0.614965,0.0483337,0.0944477,0.250494,0.307323,0.500494,1.39047 +3446.75,0.853398,0.0912059,4,1.65607,0.668524,-1.13482,0.50617,0.596298,-0.102515,0.133713,0.129645,0.0308977,0.0343012,0.482417,-0.251901,0.121942,0.650621,-0.525517,0.774886,0.171422,-0.264005,-0.149413,0.0852051,0.0532388,-0.457582,-0.901633,0.471834,-0.646022,-0.158345,0.407166,-0.477886,-0.673137,0.508234,0.937418,-0.897832,-0.337248,0.512245,-0.767782,-0.239097,-0.201701,0.629304,0.529329,-0.617852,0.987391,0.286986,0.146764,-0.472311,-0.254026,0.236827,-0.396648,0.274814,0.355793,-0.219309,-0.0765788,0.0769196,0.391385,-1.27174,0.519401,-0.362534,0.183,-1.05092,0.486506,-0.775629,0.074889,0.609916,-0.598853,-1.2165,-0.26063,-0.106512,-0.456654,0.436696,-0.0373672,-0.555168,0.370463,-0.228519,0.270553,0.155176,0.505004,0.433447,0.747302,0.378551,-0.0596583,-0.36681,0.057815,-0.3325,-0.249573,-0.19078,-0.629852,-0.394065,0.432352,0.150557,0.19243,-0.278436,0.256243,0.447215,0.0263727,0.230412,0.524605,-0.956981,0.0803055,-0.0869408,0.0502042,-0.0811888,0.0931164,-0.10578,-0.345473,-0.601689,0.207538,-0.604703,-0.112095,-0.581881,-0.292844,0.260599,-0.345678,-0.494635,0.170356,0.400447,0.536131,-0.168317,-0.140854,0.165063,0.333015,0.149836,-0.292482,0.281378,-0.107731,-0.119614,0.175638,0.0662555,0.000563534,-0.102954,0.247337,-0.00263899,-0.00891803,-0.206956,0.38116,0.0391851,-0.132943,0.0755511,-0.0755455,-0.0831175,0.579348,-0.136986,-0.315947,-0.10579,-0.231415,-0.783425,-0.339238,0.0517231,0.163379,0.15052,-0.228192,-0.595544,-0.00279537,0.0977232,0.186384,-0.346169,0.13216,0.379918,-0.17458,-0.447127,-0.316825,0.357668,-0.0122366,0.231127,1.07899,-0.109756,-0.148303,-0.294548,-0.0843339,-0.152146,0.0159702,-0.640962,-0.136901,-0.262996,0.19173,0.224093,-0.204261,0.0482582,-0.429893,-0.732816,0.0730649,0.829409,-0.00533852,-0.0536381,0.287172,0.0821364,-0.113013,0.205466,-0.344659,-0.676244,0.02183,-0.450501,0.00879576,0.454915,-0.0343444,-0.626363,-0.196205,0.149053,0.0312487,-0.343657,-0.274015,0.134752,-0.0554328,0.431156,0.13232,-0.110909,0.173857,0.102076,-0.324262,1.00203,0.070206,0.0662292,-0.251814,0.181255,0.0816648,-0.042959,0.0477892,0.329175,0.160604,-0.137176,-0.0174738,-0.113629,-0.555452,-0.702558,-0.305947,0.229318,-0.319973,0.013504,-0.204897,-0.556505,0.33279,-0.254373,-0.493889,0.174568,-0.184688,-0.39925,-0.178651,0.0845125,0.309009,0.122373,0.415892,-0.463831,-0.0679194,0.29553,0.362901,-0.0748623,0.512241,-0.312115,0.438659,0.176677,-0.14013,-0.243739,-0.0233375,-1.02317,0.565449,-0.0309129,-0.229739,0.336637,-0.464128,0.0188539,0.42448,0.098629,0.430531,0.95178,0.0759608,0.359375,-0.0403896,-0.327259,-0.265041,-0.28046,-0.20912,0.107498,0.379751,-0.335275,-0.36443,-0.203131,-0.337722,-0.287136,0.167095,0.314669,0.00624906,-0.37545,-0.00442753,0.291895,-0.0991186,-0.331234,0.0735372,0.338476,-0.245357,0.41564,-0.127531,-0.0840241,-0.0854403,-0.198979,0.241593,0.359513,-0.165213,-0.173098,0.175569,-0.0968258,0.137504,0.299646,0.15739,0.108727,0.372432,0.329737,0.610272,-1.36358 +3432.45,0.866438,0.0912059,4,1.59661,0.787507,-0.826882,0.380977,0.426391,-0.231397,0.0366162,0.0615716,0.348961,-0.289505,-0.047235,0.169361,-0.0375163,0.512216,-0.417956,1.01313,0.163157,0.0616602,0.172987,0.122129,-0.0678802,-0.860794,-0.905897,0.434687,-0.232859,0.247075,0.0279856,0.571286,-0.0835798,-0.0465375,1.00976,-0.436713,0.0498632,0.466692,-0.133412,-0.350594,-0.633373,-0.235815,0.526374,0.049462,0.733851,0.24904,0.00225097,-0.494689,-0.362214,-0.578015,-0.22332,0.684753,0.269231,0.0966444,-0.0722325,0.105585,0.133287,-0.232163,0.482221,-0.161065,-0.0844665,-1.00169,0.626906,-0.184895,0.0434167,0.715256,-0.730198,-1.48437,-0.27743,0.41524,0.213204,-0.165216,0.535453,-0.27401,-0.552364,0.163988,0.573664,0.403059,0.0810561,0.587281,0.0562771,-0.30704,0.0170902,0.598648,0.58212,-0.0444228,0.29211,-0.217523,-0.330901,0.0731431,-0.214524,-0.491404,0.00838281,-0.236024,-0.199536,-0.006942,0.132811,0.289129,-0.140052,-0.0450381,0.102387,-0.785375,-0.167966,0.359771,-0.262549,0.543694,-0.620711,-0.0669146,0.287737,-0.0755867,-0.303708,-0.0422686,0.171245,0.793829,0.657316,-0.0125678,0.282771,0.463636,-0.440524,-0.179061,-0.146846,-0.271197,-0.276177,-0.474794,-0.139426,-0.0907165,0.0600541,-0.0713231,-0.604779,-0.214937,-0.105022,0.199246,0.149304,-0.398818,-0.303464,0.0326694,0.253278,0.548083,0.0411344,0.00443766,0.0821384,-0.391742,0.19817,-0.340968,0.211988,-0.175371,0.166451,-0.0159542,0.016406,0.184318,0.169483,0.0824217,-0.14136,0.139445,0.479061,0.10763,-0.0278885,0.553129,0.0439888,-0.107013,-0.34923,0.0411911,0.0901207,0.0468489,0.420406,-0.169831,0.330276,0.119502,-0.352792,0.0442427,-0.125191,-0.142534,-0.483026,0.152902,0.0226361,0.0598539,-0.112728,-0.135754,-0.729261,0.240911,-0.459665,0.503937,-0.0532918,0.558225,0.246773,0.0614608,-0.300528,-0.182007,0.108572,-0.832255,0.267138,0.207805,-0.0374433,-0.221204,-0.165333,-0.00439375,-0.55801,-0.375446,0.490632,-0.0179706,0.120402,-0.300326,-0.367995,0.18435,-0.279309,-0.31217,0.154415,-0.305593,-0.223813,0.105239,-0.768036,0.74644,-0.145614,0.303664,-0.40182,-0.410921,-0.25221,0.273918,0.0927142,-0.125938,-0.193146,0.498968,0.218188,-0.478086,-0.287238,0.130115,0.451905,-0.442807,-0.824736,0.474428,-0.493444,0.379882,-0.0843655,-0.493626,0.393395,0.0729491,0.173239,-0.241539,-0.0947606,0.424812,-0.16762,-0.16662,0.672049,-0.160641,0.112643,0.204018,-0.325228,0.26207,0.448352,0.316429,0.610438,0.200107,0.029407,-0.741486,0.482227,-0.19184,0.454465,0.0773618,0.121539,0.126158,-0.0376413,0.224134,0.0248063,-0.204764,0.39366,-0.42034,-0.0819484,-0.0678302,0.33907,0.636934,0.259656,0.358247,-0.142744,-0.0162383,0.0905197,-0.0981293,0.556492,0.915007,0.270155,0.183527,0.124583,0.056466,0.32769,-0.201825,0.0497972,-0.281273,-0.858721,-0.0783905,0.139814,0.41022,0.133484,0.551308,-0.171818,0.280711,0.43917,0.132831,-0.51282,-0.142395,-0.0838431,-0.392564,0.0156249,0.161267,-0.368629,0.281736,0.184961,0.131748,0.219845,0.362971,0.468877,-1.08019 +3440.23,0.90668,0.0912059,4,1.61946,0.834838,-0.616404,0.311013,0.636393,-0.269417,0.541366,0.0286018,0.400152,-0.0397099,0.236277,0.162499,0.0273843,0.157197,-0.251492,0.620435,-0.071037,0.131734,0.21056,0.0164122,-0.169215,-0.643986,-0.760231,0.615836,-0.29545,0.551545,0.0114472,0.615118,-0.322555,0.0995449,0.897755,-0.147215,-0.0946803,0.651438,-0.510242,-0.546125,-0.3343,0.273342,0.389757,-0.110586,0.494179,0.391712,-0.148928,-0.404868,-0.183406,-0.985244,-0.835028,0.273035,0.331908,-0.116509,-0.177914,0.120115,0.25889,-0.579176,0.581602,-0.34494,-0.0589639,-0.550011,0.19109,-0.700899,0.160321,0.823963,-0.849039,-0.881146,-0.188569,-0.23745,-0.511744,-0.270719,0.00452001,-0.451997,-0.675908,0.136399,0.815043,0.36864,0.676704,0.881822,0.392959,-0.0837227,0.0500965,0.0749792,0.386081,-0.127115,-0.122914,0.192571,-0.513822,-0.241494,-0.223662,-0.207751,-0.0949462,-0.408905,0.195741,-0.224926,-0.24581,-0.034612,0.109268,-0.238658,-0.453901,-0.953298,-0.303568,0.467561,0.0853675,0.125676,-0.375796,0.0330743,0.361324,-0.773699,-0.276733,-0.444934,0.331299,0.581833,-0.117247,-0.247799,-0.122445,0.32869,-0.0552004,-0.427538,-0.387512,0.189667,0.130582,-0.0341861,-0.109418,0.0048332,-0.0331644,0.250837,-0.996036,-0.273172,-0.43953,-0.0817464,0.552658,-0.652442,0.17086,0.148874,-0.055545,0.498439,-0.183766,-0.46125,0.133514,0.0422619,0.252359,-0.415871,-0.0112429,-0.02383,0.202692,-0.636439,0.0424678,0.20186,0.194841,0.625139,-0.302077,-0.124786,-0.427579,-0.135494,0.352779,0.313676,0.24523,0.515815,0.623941,-0.410405,0.283072,0.210182,0.456289,-0.115957,0.693656,-0.469978,-0.0745327,-0.174293,0.0085983,-0.263634,-0.0410265,0.023759,0.0113371,0.193635,-0.0783715,0.0784624,-0.483806,-0.0879433,-0.273095,-0.402143,-0.0659403,0.270018,0.361825,-0.327501,0.370829,0.21118,0.117469,-0.393433,-0.48837,-0.383324,-0.106807,-0.395022,0.391353,0.00373031,-0.400745,-0.450841,0.12386,0.0290132,0.233606,-0.456773,0.158674,-0.0302986,0.0367836,-0.204773,-0.304294,0.224796,0.212834,-0.671984,-0.309807,0.958777,0.316388,-0.158654,-0.305315,-0.466819,-0.0730281,0.266537,-0.223967,-0.104012,-0.857004,0.336747,-0.112265,0.200731,0.109446,-0.0450671,0.0524321,0.26523,-0.624154,0.426254,-0.303151,-0.129554,-0.221521,-0.184662,0.317449,0.146307,-0.0627808,-0.268019,0.412254,0.245183,0.213578,0.0436166,0.309397,-0.145832,-0.115753,0.504397,-0.530363,0.0425807,0.484276,0.250975,0.23184,0.238129,-0.0249009,0.317513,0.532868,-0.136434,0.700966,-0.375182,-0.0550088,-0.199222,0.134013,0.41298,0.463553,-0.282802,0.353813,-0.207639,0.590838,-0.0293871,-0.501013,0.4267,0.0350391,-0.674323,0.0224288,-0.195598,-0.378729,0.152603,0.1166,-0.318759,0.0687353,0.0281255,0.637569,0.0872085,0.601672,-0.0439335,-0.257742,0.206791,-0.60462,-0.194883,-0.172555,0.183715,0.0189436,-0.0176975,-0.00863349,0.283301,-0.0963206,0.422242,0.370447,0.109587,0.227327,0.0384155,0.265812,-0.0401244,0.144715,0.0312239,0.178554,0.0984646,0.235477,0.313791,0.48526,-1.87291 +3447.57,0.912615,0.0912059,4,1.61957,0.728262,-0.947588,0.483712,0.31454,-0.212396,0.255614,0.235866,0.899447,-0.518946,0.190047,0.182893,0.294748,0.303273,-0.0176472,0.86366,0.310619,0.26915,-0.119555,0.248548,-0.177418,-0.591794,-0.724138,0.6003,-0.404957,0.249602,0.0249534,0.371846,-0.0538604,0.199677,0.939696,0.0920775,-0.219545,0.580337,-0.333944,-0.490974,-0.32138,0.449733,0.239218,-0.200838,0.539131,0.508591,-0.0407813,-0.700214,-0.488053,-0.674587,-0.904116,0.110283,0.155675,0.0410135,-0.345347,-0.199549,0.0335454,-0.464391,0.546375,-0.456077,-0.0922788,-0.663432,0.355726,-0.382458,0.166778,0.88892,-0.87641,-1.16981,-0.660862,0.368416,-0.584191,-0.0658379,0.154295,-0.665341,-0.403907,-0.0270831,0.393174,0.00517555,0.353181,0.441755,0.177031,-0.336971,-0.166278,-0.085891,0.396339,0.0389086,-0.10966,-0.0105454,0.13653,-0.293497,0.117489,-0.283989,-0.245341,-0.310676,-0.0646538,-0.15779,-0.158592,0.0427968,0.163602,0.0969167,-0.295607,-0.67866,-0.127671,0.367207,-0.360383,0.0220472,-0.56356,0.196658,0.509751,-0.261711,-0.217235,-0.424042,0.157204,0.368708,0.0193367,-0.196861,-0.268397,0.215884,0.181618,-0.158589,0.0921054,-0.12737,0.45618,0.112543,-0.332583,0.266995,-0.410841,0.349564,-0.944059,0.116035,0.0147986,-0.108156,0.480876,-0.512628,-0.20822,0.400338,0.199967,-0.141199,-0.116292,-0.490932,0.166645,0.0106764,0.544797,-0.386962,0.376485,-0.0997621,0.0584254,-0.430084,0.182622,-0.232169,0.0334092,0.0506742,-0.153774,-0.0487279,-0.113881,-0.0206111,0.120011,0.255145,0.103967,0.559446,0.0845933,-0.343461,0.189391,0.183949,0.309926,-0.169711,0.596693,-0.22361,0.0591862,-0.352275,0.442777,-0.289185,0.0997698,0.1697,0.0748736,0.467298,-0.24837,-0.0193696,-0.318222,-0.555952,-0.0174727,0.219119,0.00364952,0.109502,0.223624,-0.118539,0.0723901,0.256533,0.17976,-0.349849,-0.365036,-0.00952749,0.0482347,-0.434512,0.327588,-0.1003,-0.271368,-0.371104,-0.112557,0.256001,0.127448,0.0621384,-0.00965481,-0.0102081,-0.141974,-0.0854849,-0.245085,-0.430644,-0.0515291,-0.633055,-0.27109,0.886944,0.21757,0.534573,-0.603343,-0.000204623,-0.289014,-0.139172,-0.107967,-0.0482353,-0.459486,0.260458,0.345813,0.0881932,-0.000468175,-0.271618,0.0144931,0.521914,-0.706134,0.351277,-0.241617,-0.247422,0.0943471,-0.193922,-0.0322038,0.0262231,0.117931,-0.272919,0.103415,0.424083,-0.12938,-0.163537,0.294262,-0.161938,-0.0157554,0.643416,-0.0971127,-0.3201,0.333299,0.349553,0.539828,0.449571,-0.00322585,0.0918883,0.586091,-0.232037,0.619725,-0.579154,-0.545162,0.373468,0.207773,0.171758,0.479501,-0.127603,0.111826,-0.0899885,0.544679,0.252552,-0.218119,0.224451,0.196527,-0.785491,0.131547,-0.39333,0.0112029,0.595654,-0.0645979,-0.224563,0.55004,-0.00353792,0.493848,0.173075,0.317919,-0.661458,-0.16229,0.187414,-0.518951,-0.304289,0.122644,0.18106,-0.241951,0.0252318,-0.107632,0.345957,0.161962,0.615468,0.161304,0.108122,0.0461974,0.0128149,-0.0850199,-0.0910284,-0.101406,-0.305552,-0.118941,0.112844,0.180795,0.335923,0.4252,-0.619923 +3438.9,0.687607,0.0912059,4,1.5488,0.928102,-1.17023,0.471044,0.2516,-0.107254,0.0862737,0.240909,-0.0046581,-0.0881402,0.00813988,0.15314,0.0603206,0.252673,-0.372035,1.20781,0.241427,0.198893,0.109076,-0.32366,-0.0748003,-0.988534,-1.30951,0.357741,-0.145012,0.147584,0.325023,-0.0409893,0.343109,0.16821,0.706992,-0.743961,-0.0614677,0.248095,-0.780708,-0.13011,-0.00822575,0.237617,0.206205,-0.35966,0.622665,0.440927,0.605258,-0.644877,-0.390346,-0.101662,-0.189241,0.560426,0.337347,-0.194935,0.216045,0.51598,0.0443329,-0.654702,0.32814,-0.330626,-0.314135,-0.26428,0.0859842,-0.65875,0.397357,1.19626,-0.914018,-0.487724,0.204137,-0.0140712,-0.275968,-0.0534134,0.206888,-0.410368,-0.320233,0.475658,0.819782,-0.0282799,0.208282,0.377066,0.432023,-0.100876,-0.0805128,-0.134033,0.144409,-0.276191,0.219221,-0.0756316,-0.599121,-0.644057,0.148649,-0.432586,0.258068,-0.393525,-0.182276,0.146087,-0.0434069,-0.135387,-0.0359975,-1.09669,-0.432502,0.197226,-0.00115878,0.651153,0.333071,-0.138447,-0.332672,0.0168263,0.0678503,-0.353549,0.401455,-0.53676,0.395589,0.662334,0.289904,0.397417,0.166316,0.470195,-0.0870673,-0.150067,-0.796457,0.18099,0.465583,-0.34768,-0.745905,0.00844058,-0.180633,0.311907,-0.043453,0.301816,-0.183382,-0.0284688,-0.0837171,-0.192262,-0.2275,0.121767,-0.156685,0.269048,-0.144139,-0.228043,0.0927523,-0.105235,0.275415,0.0791854,-0.245313,-0.192481,-0.0766236,-0.170519,-0.0986474,0.223348,-0.474063,0.27721,-0.20743,-0.232001,0.276228,0.450442,0.194834,0.0477134,0.52561,0.601631,-0.162266,0.429022,0.489317,-0.158203,0.694203,-0.145474,0.672734,0.00221667,-0.0273435,0.142484,-0.109139,-0.0347681,0.0989509,0.213702,-0.0564708,-0.0107259,0.142941,0.209024,0.175932,-0.286626,-0.256163,0.449978,0.520428,0.277432,-0.0721254,0.229141,0.251087,0.0619553,0.0196474,-0.37227,0.126188,-0.36482,0.0506134,-0.575912,-0.261727,0.108264,-0.0270528,-0.467981,-0.192595,-0.164058,0.216821,-0.05791,-0.383245,0.381048,-0.120536,0.107074,-0.280666,0.209094,0.204124,-0.0753273,-0.78969,1.03982,0.0508538,0.163443,-0.0423546,0.103167,-0.183543,-0.179554,-0.209712,0.200217,-0.137706,-0.195357,0.146051,-0.108528,-0.129496,0.00652467,-0.456991,-0.104156,0.18024,0.528667,-0.624586,-0.391082,0.377464,0.183023,-0.482664,0.0465536,-0.34509,0.00231998,-0.895325,0.13155,-0.338654,-0.121856,0.397169,-0.200116,-0.330385,-0.172031,-0.110146,-0.366856,0.0166141,0.585624,0.461528,-0.51982,-0.0331414,-0.374161,0.15904,-0.598728,0.149889,-0.235788,0.103249,-0.0586775,-0.27755,0.0609398,0.565014,-0.290299,0.686614,0.447499,-0.543461,1.16596,-0.174537,0.159416,0.121769,0.00602676,0.0753765,0.157221,-0.127254,-0.192635,0.202144,-0.0538204,-0.0168813,0.17015,0.306025,-0.499529,0.299334,0.192656,0.365524,0.356598,0.0075352,-0.578354,-0.38074,0.379793,0.116995,-0.0306684,-0.435895,0.0936338,-0.01704,0.269746,-0.304678,0.100275,0.0677818,-0.35599,-0.321181,-0.598213,0.048699,0.182838,-0.0822699,0.105687,0.266948,0.325096,0.51667,-0.732344 +3450.04,0.953529,0.0912059,4,1.63264,0.8096,-1.22114,0.543824,0.563585,-0.146527,0.144891,0.0315556,0.389174,0.13599,0.0580193,0.0406899,-0.166726,0.409106,0.105278,0.940505,0.211082,0.0960956,-0.104682,-0.169064,-0.0286894,-0.701469,-0.879232,0.34356,-0.252802,0.108605,0.0647877,-0.049281,-0.00947705,0.0577597,0.975198,-0.69697,0.345504,0.118368,-0.545104,0.0310192,0.239031,-0.0759414,0.447433,-0.250527,0.512905,0.429716,0.436847,-0.858798,-0.277002,0.11466,-0.373284,0.095766,0.302587,-0.246469,-0.018481,0.26301,-0.266878,-0.423127,0.192749,-0.35031,-0.222378,-0.284355,0.521708,-0.50219,0.276739,1.35684,-0.576645,-1.36781,0.308872,0.45671,-0.182453,-0.0457113,-0.0628089,-0.316933,-0.757687,0.540265,0.703842,0.176884,0.204742,0.138842,0.376061,0.0544527,-0.0340927,0.25609,0.35782,-0.481813,-0.00405806,-0.0259919,-0.645171,-0.258446,-0.115758,-0.6737,-0.00567777,-0.14278,-0.15319,0.636471,-0.109801,-0.174158,-0.00365072,-0.856946,-0.217776,-0.200223,0.104107,0.59591,0.268356,-0.327913,-0.17491,-0.170606,0.0129315,-0.367479,0.665251,-0.524832,0.213032,0.25321,-0.0125097,0.132354,0.436154,0.503606,0.115809,-0.00082206,-0.728251,-0.0545544,0.695325,-0.23691,-0.558733,0.247447,-0.113078,0.303926,0.229277,-0.16093,-0.44845,-0.0976682,0.0408354,-0.599707,0.248876,0.170543,0.0193169,0.614928,-0.208371,-0.115772,-0.310881,0.226691,0.436712,-0.173628,-0.669999,0.121253,0.139799,-0.232761,-0.372554,0.372342,0.0542391,-0.0495959,-0.0266773,-0.201948,0.171372,0.198584,0.190583,-0.21944,0.0344944,0.887929,0.0553864,0.407419,0.332973,0.079624,0.382748,-0.135165,0.701568,0.323973,0.00234601,-0.196213,-0.22616,-0.192786,-0.0408031,0.253629,-0.201273,0.279095,-0.0210793,0.221133,0.0381302,-0.3204,-0.465539,-0.1256,0.438924,0.356783,-0.0283361,0.250657,0.0454437,-0.22861,0.126877,-0.682379,-0.0950645,-0.388757,-0.0703817,-0.29121,-0.118287,0.204942,-0.0627047,-0.321568,0.0492476,0.227415,0.193137,-0.115868,-0.562229,0.143693,0.16786,0.0686076,-0.39283,0.0379312,0.506699,0.147288,-0.718298,0.930781,-0.123779,-0.0968457,-0.278087,0.0929531,-0.47482,0.0466107,0.069018,0.306267,-0.498981,0.248002,0.239014,-0.566499,-0.114114,0.058227,-0.554063,0.0886812,0.485522,0.288358,-0.0847019,-0.45274,0.248644,-0.136468,-0.394653,0.192091,-0.0939717,0.0303814,-0.921022,0.284868,-0.333275,-0.0987729,0.149237,-0.363928,-0.548643,-0.166418,-0.0267448,-0.0966963,-0.289425,0.654522,0.622957,-0.470047,-0.34021,0.132645,0.39996,-0.542535,0.148434,-0.305118,0.382953,0.355265,-0.0801723,-0.00400651,0.404763,-0.0483161,0.320034,0.1504,0.0233183,0.477362,0.213516,-0.163459,-0.440598,0.208334,-0.023706,0.0539102,-0.0843398,-0.128434,-0.325176,0.0963242,0.194113,0.284853,0.62879,0.0576019,0.245492,0.161267,-0.0988897,0.236802,-0.358348,-0.187456,-0.0974867,0.794839,-0.0212125,0.155913,-0.519333,-0.0776533,0.131743,0.264263,0.0460764,0.276116,-0.0225615,-0.123209,-0.390361,-0.312191,0.0828114,0.0470015,-0.390916,0.109476,0.242858,0.330871,0.492807,-1.50718 +3438.43,0.919152,0.0912059,4,1.61775,0.823257,-1.07647,0.444749,0.775877,0.0108515,0.0514625,0.152882,-0.0385493,0.0603125,-0.0287009,-0.0961332,-0.399871,0.203825,-0.699746,0.61268,0.350274,-0.276926,0.0839764,-0.237545,0.161701,-0.945133,-0.9897,0.347524,-0.0589203,-0.174155,0.0648286,0.20648,-0.382056,0.513072,1.07071,-0.558417,-0.624755,0.427665,-0.219977,-0.315395,0.134172,0.546397,0.520302,-0.366504,0.560251,0.556824,0.532213,-0.715746,-0.146639,-0.000790704,-0.663917,-0.296458,0.413589,-0.055371,-0.146533,0.20862,0.18954,-0.468729,0.290004,0.175003,-0.310791,-0.729536,0.131574,-0.500879,0.0163507,0.705726,-0.769535,-1.03116,0.155385,-0.479134,0.264729,0.312843,0.0794855,-0.220224,0.463049,0.413323,0.747816,-0.111639,0.85345,0.350195,0.308338,-0.315055,-0.0540884,-0.289115,0.650571,0.189196,0.199917,-0.237215,-0.149404,0.320646,-0.585247,0.0990812,-0.0300939,-0.423837,0.373896,0.231235,0.162328,-0.200306,-0.0258735,-0.638618,0.398771,-0.209644,-0.0727715,0.629285,0.0858818,-0.208984,0.0113868,-0.543045,-0.0308662,0.0983597,0.434585,0.109856,0.114469,0.794859,-0.169223,0.171138,0.160388,0.57458,-0.22627,0.174948,-0.585766,0.0748649,0.194697,-0.64526,-0.424098,-0.212195,-0.38014,0.0225586,-0.681824,-0.353521,0.737772,-0.239661,0.610922,-0.37523,0.226954,-0.055333,0.0869763,-0.223441,-0.149417,0.362643,0.303808,0.267204,0.0296165,-0.274812,0.40005,0.00980807,-0.306305,-0.11344,-0.132612,0.255248,0.11591,0.21678,-0.30944,0.617386,0.12158,0.106636,0.145859,-0.113393,0.109553,0.456642,0.318004,0.150111,0.0647083,-0.142494,-0.227848,-0.0995007,0.545661,-0.586215,0.265221,0.253729,-0.219608,0.0935018,-0.336244,-0.404529,0.293614,-0.339259,0.288319,-0.477431,-0.216678,0.170087,0.109146,-0.292861,0.206134,0.743643,0.223446,-0.0797964,0.117287,0.411367,-0.0783675,0.531238,-0.151128,-0.0274455,0.387891,-0.190464,0.336095,0.275393,0.0727148,-0.428924,0.103488,-0.53177,-0.181769,-0.300877,-0.160138,0.0400477,-0.369676,-0.323251,-0.265092,-0.139803,0.0223476,-0.0929078,-0.267104,0.644992,0.177627,0.246481,0.382505,-0.184313,0.594814,-0.715839,-0.0486298,0.210755,-0.0978098,0.73307,0.331826,-0.0648632,0.433679,-0.109114,0.244064,-0.198747,-0.275788,0.443569,-0.146758,0.0552685,-0.435435,0.352326,-0.204136,0.248174,-0.209865,-0.173833,-0.356151,0.582927,-0.0700202,-0.721707,0.422674,-0.344663,0.569293,-0.308403,0.233389,0.0332741,0.577658,-0.260222,0.0928905,0.379769,0.137679,-0.568012,-0.160919,-0.0961347,0.196335,0.255217,-0.424498,0.59675,-0.650341,-0.326698,0.118186,0.0671926,0.246161,0.301257,0.0341798,-0.243071,-0.172144,0.223603,-0.156693,0.0722139,0.149073,0.167559,0.132313,-0.329018,-0.293267,-0.417466,-0.0456392,0.0925824,0.0572429,-0.312264,-0.420911,-0.0614674,0.0515878,-0.338494,-0.211484,-0.203788,-0.236172,0.0633136,0.0538308,0.536391,0.220967,0.366434,0.184016,0.127172,0.00296583,-0.195707,0.0123907,-0.577036,-0.209423,-0.113588,-0.530143,-0.0105888,0.0615038,0.133096,0.204716,0.364823,0.452455,-2.27238 +3415.27,0.725419,0.0912059,4,1.6325,0.812934,-0.947583,0.332877,0.287196,-0.131714,-0.607362,0.225337,0.346349,0.058903,-0.0268236,-0.707295,-0.24168,0.519794,0.289653,0.929602,0.0586195,-0.37225,-0.334932,-0.236237,-0.0779701,-0.299168,-0.981151,0.21601,-0.155458,-0.051604,-0.363826,0.381523,-0.640622,-0.524,1.13483,-0.556702,0.0236495,0.0954243,-0.444927,-0.394566,-0.110161,0.414313,0.241496,-0.00463455,0.891328,0.485502,0.727085,-0.934483,-0.240929,0.457809,-0.341322,0.31259,0.260637,-0.162674,-0.0655926,0.378514,0.00890215,-0.268571,0.422477,0.129123,0.0614693,-0.5624,0.368551,-0.328337,0.137434,0.947119,-0.269274,-0.409916,0.315296,0.175319,-0.260615,-0.281957,0.260328,-0.261035,0.281792,0.558068,0.736379,-0.0757575,0.0806534,0.326381,0.245032,-0.121712,0.20706,0.110773,0.331024,-0.556441,0.19797,-0.198293,-0.323406,0.623206,-0.0316391,-0.1183,0.417898,-0.560496,-0.517299,0.28036,0.213302,0.38465,0.137125,-0.176349,-0.0789101,0.665222,-0.379119,0.412198,0.28496,-0.353501,0.0693081,-0.162381,-0.735766,-0.449025,0.634971,-0.640991,0.185622,0.734036,0.189205,-0.307352,-0.336806,0.597834,-0.224354,-0.145657,0.0470855,0.131646,0.0617308,-0.0134265,-0.613557,-0.542714,-0.0153337,-0.170188,-0.174806,0.00946502,0.454305,0.422763,0.273867,-0.453059,-0.0729425,0.169692,0.272421,0.152809,-0.291306,0.214992,0.1316,0.457404,0.382234,-0.854395,0.161759,-0.188451,0.118186,-0.272312,-0.00658262,0.0705027,0.0409198,0.361536,-0.502253,-0.416774,0.0681376,0.0451053,0.510011,-0.197298,0.25419,0.050229,-0.439101,-0.0652243,0.396407,0.103027,-0.577189,0.284866,0.915376,-0.51576,0.464556,0.246395,-0.16859,0.20612,0.0491424,-0.386111,-0.260175,-0.124078,0.0558872,-0.107075,0.163698,0.00905705,-0.0464723,-0.204117,0.433984,0.922434,-0.182705,-0.293348,0.363154,0.217427,0.024898,0.296399,-0.230481,-0.173051,0.806276,-0.448956,-0.00129743,0.106535,0.182122,-0.377603,0.244909,0.366984,0.480104,0.193448,-0.112656,-0.119273,0.167684,-0.667148,0.187744,-0.253828,0.333038,0.112902,-0.575351,0.731987,0.380433,0.248017,0.0699113,-0.310906,0.626357,0.0294429,-0.141874,-0.135758,-0.510435,0.137366,-0.142335,-0.599582,-0.14364,-0.101681,0.255653,-0.275863,-0.350134,0.483277,-0.0983039,0.133857,-0.0711046,-0.237555,-0.615397,0.286828,-0.562815,-0.187096,-0.576244,0.418125,0.322301,0.144433,0.47584,-0.308133,-0.0378345,0.0672891,-0.541431,-0.244422,0.0718109,0.0677739,0.706841,0.339553,0.00692021,-0.254057,0.552868,-0.201199,0.697384,0.440147,-0.062777,0.0753033,-0.0739764,-0.438644,0.0537746,0.262573,-0.00101923,-0.298379,0.142382,0.131491,0.201542,0.393835,-0.168972,0.239042,0.907067,-0.621642,-0.321315,-0.165388,0.0392896,-0.185679,-0.414139,-0.89045,-0.00515458,0.0532147,0.403693,0.655265,-0.119343,-0.19147,-0.0537898,-0.524886,0.270205,0.140519,-0.273882,0.199434,-0.231731,0.0453742,0.179541,-0.0992491,0.0854128,0.52115,-0.138863,-0.377073,-0.0251803,-0.634383,0.00803975,-0.458794,-0.057188,0.112553,0.213294,0.33549,0.461838,-0.543041 +3425.46,0.993275,0.0912059,5,1.56688,0.765946,-1.15236,0.486473,0.226867,-0.0898452,-0.376616,0.193078,0.38137,0.102745,-0.108226,-0.690752,-0.409367,0.487403,0.17472,1.1565,0.0627805,-0.435043,-0.296692,-0.224115,-0.133302,-0.383327,-0.961608,0.327391,-0.0146175,-0.0338113,-0.34865,-0.12525,-0.41882,-0.454546,1.05629,-0.744122,-0.276128,0.160792,-0.556755,-0.442157,0.0053978,0.167479,0.0375272,0.0132704,0.768829,0.497848,0.597002,-0.951211,-0.344261,0.398981,-0.236913,0.422915,0.351953,-0.140055,0.0591787,0.553376,0.0510494,-0.275078,0.383693,-0.0640029,-0.214061,-0.671201,0.368694,-0.516627,-0.371332,0.915228,-0.155314,-0.799641,0.112906,0.513098,-0.376575,-0.284848,0.34499,-0.474927,0.176504,0.563524,0.820016,0.0759101,0.226944,0.47181,0.267471,-0.149247,0.264604,0.252189,0.303222,-0.245733,0.223344,-0.0748691,-0.461563,0.275435,0.0621465,-0.162868,0.389551,-0.462957,-0.333131,0.25455,0.151351,0.448467,0.0288857,-0.0840762,-0.0141434,0.635984,-0.604665,0.42527,0.484414,-0.416674,0.0640987,0.0141735,-0.58806,-0.353907,0.511662,-0.501822,0.225058,0.471087,0.071411,-0.0506336,-0.351289,0.461669,-0.10385,-0.192611,0.138939,-0.0593115,0.45649,0.0655192,-0.579174,-0.34233,0.0175547,-0.0666114,0.0580892,-0.00700239,0.589905,0.279606,0.223517,-0.609664,-0.0973795,0.0339711,0.221329,0.366049,-0.238386,0.286798,0.212365,0.294838,0.500722,-0.795448,0.420209,-0.101225,0.054962,-0.259071,-0.215515,0.43699,-0.0350177,0.483326,-0.450183,-0.0946318,-0.0154704,0.267242,0.460268,0.0207893,0.217574,0.0514561,-0.182142,-0.285991,0.265495,0.313822,-0.668096,0.0146651,0.841033,-0.496539,0.44308,0.26344,-0.169849,0.380069,0.112609,-0.093882,-0.296758,-0.339884,0.140862,-0.300965,0.398608,-0.127587,-0.0613457,-0.283075,0.696399,0.802206,-0.37396,-0.188839,0.323951,0.0212001,-0.179845,0.115983,-0.187122,-0.18151,0.788314,-0.571052,-0.126318,-0.0830383,0.0797864,-0.576304,0.189623,0.359477,0.361606,0.038609,-0.343975,0.025619,0.164809,-0.350965,0.0482731,-0.201982,0.0972128,0.11528,-0.736361,0.564692,0.374836,0.169088,0.0944316,-0.103303,0.593425,0.0737485,-0.206805,-0.554788,-0.516108,0.128859,-0.322371,-0.42993,-0.0256192,-0.0950569,0.182493,-0.152888,-0.455693,0.412993,-0.239036,-0.204485,-0.214774,-0.106766,-0.377809,0.324731,-0.36196,-0.0614264,-0.558552,0.366065,0.192781,0.208144,0.432567,-0.419429,-0.266398,0.0492641,-0.461056,-0.0764441,0.0191959,0.219062,0.573729,0.364472,-0.0968562,-0.363249,0.444346,-0.384535,0.589799,0.350908,-0.0896614,0.512936,-0.0561393,-0.457604,0.129626,0.164095,0.0766075,-0.271036,0.0708188,0.137382,0.278915,0.355585,-0.0602431,0.20857,0.852955,-0.53841,-0.366588,-0.224263,0.425681,-0.0407925,-0.322737,-1.04167,0.319662,-0.144218,0.201276,0.552665,-0.104887,-0.198137,-0.133285,-0.836085,0.388106,-0.0732363,-0.216805,0.274807,-0.268736,0.00812422,0.331099,-0.115697,0.0106032,0.700387,-0.0374547,-0.220726,-0.237768,-0.638744,-0.394862,-0.248784,-0.00977245,0.14233,0.195807,0.377266,0.442501,-0.373851 +3424.85,0.558302,0.0912059,4,1.57361,0.901056,-1.27012,0.386536,0.492623,-0.107323,-0.299594,-0.12622,0.0318346,-0.169733,-0.198257,-0.385063,-0.144028,0.186784,-0.932271,0.301871,0.0352055,-0.129749,-0.634459,-0.333699,-0.608017,-0.637159,-0.864936,-0.0838184,-0.628239,-0.127217,-0.0157265,0.394487,-0.0552833,0.0686195,0.656888,-0.45529,-0.0736145,0.125151,-0.439745,0.244917,-0.327512,0.768756,0.972507,0.00677182,1.01288,0.476995,0.708535,-0.562198,-0.201553,-0.186176,-0.57511,0.121246,0.338318,-0.138134,-0.153327,0.36463,0.393056,-0.378508,0.430443,0.160962,-0.255172,-0.742113,0.368193,-0.049225,0.496967,0.936656,-0.586867,-0.789544,0.118551,0.278795,-0.187839,-0.469532,-0.161085,-0.344846,0.0787409,0.194752,0.564337,0.197088,0.153026,0.398187,0.155322,0.372632,0.0945439,0.151757,0.0274975,-0.467241,0.312426,-0.0369086,-1.25545,-0.156169,0.188977,0.18825,0.31309,-0.367984,-0.390058,-0.222431,0.016634,-0.367865,0.300774,-0.372843,0.261478,-0.544342,0.257951,0.152874,0.432146,0.118243,-0.295406,0.0457676,0.0913578,-0.599119,-0.125477,0.373437,0.260635,0.799888,-0.467835,-0.0953207,-0.10992,0.634774,0.332445,0.519417,-0.464054,0.276845,0.584996,-0.049374,-0.492511,-0.403349,0.128013,-0.44544,0.10482,0.0572307,0.138091,-0.0269701,0.393639,0.137871,0.564962,0.246093,0.438471,0.234793,-0.186493,0.459204,0.242152,-0.424598,0.760884,-0.581524,0.18991,0.00807156,-0.723761,0.0762555,0.354718,0.349148,-0.44034,0.550908,-0.118608,0.163692,-0.144675,-0.00507361,-0.0731817,-0.366733,0.155676,-0.223792,0.0810453,-0.221084,0.252295,0.255788,-0.175077,-0.204635,0.760104,0.376427,0.525077,0.181323,-0.104551,-0.0902864,0.301979,0.338108,0.147887,0.079756,0.129805,-0.257294,-0.0110049,-0.124436,-0.539766,-0.183954,-0.0966697,0.800501,0.0218975,-0.262655,0.298764,-0.383391,0.0296532,-0.0375101,0.0395039,-0.414367,0.452068,0.167001,-0.0800553,0.153189,0.345556,-0.43209,0.15759,0.111191,-0.161268,-0.196261,-0.730884,0.0997707,-0.14965,-0.43296,-0.0498773,0.217363,0.22673,0.106412,-0.1702,0.910409,0.0133859,-0.0288992,0.368071,-0.0676261,-0.1317,0.175532,0.362938,-0.0319747,-0.397256,0.0737844,0.374806,-0.245205,-0.0438833,-0.309905,0.552682,-0.495101,-0.450067,0.40582,-0.906414,0.0550847,-0.121062,-0.152759,-0.124183,0.0777743,-0.512713,-0.46645,-0.304609,0.281334,-0.0378434,-0.122411,0.229061,-0.0382081,-0.465493,0.340567,0.394314,-0.167464,0.555844,0.355607,0.604871,0.61031,0.0898639,-0.450266,-0.428046,-0.177147,0.409956,-0.263636,-0.187713,0.589833,-0.204118,-0.434969,0.537186,0.11906,0.855814,0.524156,0.338672,-0.0362935,-0.277182,0.376065,-0.229894,0.177326,-0.104839,-0.0058661,0.467483,-0.574403,-0.0723196,0.0614021,0.217628,-0.257882,-0.108285,-0.72045,0.469631,-0.216419,-0.0619515,0.130846,0.403148,-0.102212,-0.224267,0.496172,-0.166298,0.192529,0.193014,-0.530075,-0.0208387,0.230042,-0.301129,-0.157552,0.0340227,-0.568919,0.214301,0.154809,-0.0979904,-0.996662,0.119885,0.115276,0.24806,0.339523,0.498056,-1.32722 +3442.46,0.987643,0.0912059,4,1.61799,0.952956,-0.903618,0.342724,0.597946,-0.114218,0.170055,0.185518,0.378926,0.0427919,-0.118069,-0.404602,-0.377472,0.252872,0.190104,0.564316,0.25383,0.172757,-0.00215038,-0.189134,-0.0818763,-0.837412,-0.703957,0.221973,0.0451796,-0.0488854,-0.201735,0.109662,-0.689418,-0.410641,0.593734,-0.883739,-0.0213306,0.364326,-0.449677,-0.345117,-0.19168,0.469593,0.211092,-0.621752,0.911519,0.460605,0.0502959,-0.482226,0.340942,0.199791,-0.486996,0.0411194,0.3817,0.16279,0.134774,0.884859,0.141863,-0.359383,0.831454,-0.513237,-0.0538935,-0.65199,-0.0156856,-0.505322,0.0144361,0.980141,-0.774741,-1.03254,0.0761662,0.113216,0.0762197,0.380613,0.282818,-0.0960947,0.103735,0.320708,0.680741,-0.13168,0.429613,0.233479,0.452513,-0.225471,-0.321364,-0.154387,0.36204,-0.224769,-0.119058,-0.021271,0.576861,0.000802298,0.0942203,-0.401872,0.247084,-0.155849,0.500651,0.40808,-0.0720489,0.270149,-0.437634,-0.0240532,-0.26648,0.108288,-0.0311614,0.203301,-0.265296,-0.135421,-0.413639,-0.551881,0.160717,0.0354492,0.699319,-0.759127,0.286293,0.377374,-0.00624183,-0.266013,0.431876,0.166948,-0.401304,-0.213651,-0.036936,0.158685,-0.186277,-0.14723,-0.621278,0.198182,-0.171318,-0.0879297,-0.333222,0.18099,0.374313,0.398093,0.303559,-0.555612,-0.113757,-0.248433,-0.307211,0.367768,-0.216689,-0.674548,-0.109957,0.427083,-0.0811446,-0.79354,-0.430447,-0.100588,0.736486,-0.811251,-0.363501,-0.197,0.217963,0.629369,-0.0181244,-0.411746,-0.171125,0.158561,0.311529,0.145875,0.303387,0.698838,0.294029,0.136865,-0.269972,-0.198074,0.513348,0.0211413,0.361858,-0.528311,-0.351034,0.248778,0.0434269,0.0527679,-0.391542,-0.622735,-0.00863037,-0.0957458,-0.431972,0.0316616,0.0482814,0.00803955,0.339412,0.166126,0.346196,0.485637,0.0501484,0.206937,0.262378,0.279542,-0.182202,-0.375489,-0.346856,0.148918,0.20132,-0.615223,0.218992,-0.02922,-0.565063,-0.606025,-0.120168,0.405038,0.464153,-0.331661,-0.692171,0.280764,-0.0916575,-0.231353,0.0071486,-0.37379,-0.0400636,-0.189112,-0.545152,0.874663,-0.211899,0.333629,-0.405664,-0.227492,0.155829,0.0770267,-0.657372,0.631109,0.0948716,0.0681605,0.370568,-0.107403,-0.17189,-0.479828,-0.439068,0.81539,-0.106771,0.29472,0.157161,-0.300238,-0.280007,0.0989535,0.0694358,-0.177709,0.0831326,0.238197,-0.214347,0.803224,0.0779922,0.274023,0.673306,-0.465342,0.373012,0.116674,-0.177925,0.0889765,0.142782,0.136113,0.430233,-0.093318,-0.0990908,-0.0411926,0.23103,-0.774284,0.208256,-0.150107,0.0098827,0.117163,-0.365796,0.169495,-0.336632,-0.0993167,-0.531562,-0.257701,-0.301012,0.334219,0.411515,0.209768,0.186985,-0.422017,0.105466,-0.03835,-0.900789,0.00805475,-0.189833,0.20926,-0.237083,0.529291,0.0280062,0.90934,-0.143046,-0.00893448,-0.423653,-0.190126,-0.525697,0.192688,0.306265,-0.030582,0.0509959,-0.0646318,-0.148298,0.320059,-0.410648,-0.222863,0.282665,0.328615,0.0508596,-0.112153,-0.1102,-0.22183,0.196226,0.442199,-0.218436,0.114216,0.187288,0.337959,0.432768,-1.87354 +3414.86,0.516357,0.0912059,4,1.54689,0.823524,-1.33181,0.491567,0.546208,-0.123455,-0.0523637,-0.345093,0.211967,0.0547187,-0.155101,0.245405,0.231749,-0.117642,0.0176903,0.91606,0.0446642,-0.0447906,-0.327162,-0.531774,-0.273386,-0.568581,-0.415216,0.624964,-0.746586,0.015881,0.0785197,0.624853,-0.50482,-0.0445664,0.766213,-0.44248,-0.342781,0.239504,0.0914619,0.148685,-0.500275,0.384403,0.527079,0.264752,1.32447,0.786548,0.398043,-0.625346,-0.0997326,0.0214197,-0.997858,-0.0214413,0.431675,-0.181273,-0.0258446,0.32564,-0.070739,0.630042,0.861926,-0.533132,-0.478381,-0.434929,0.090447,0.101495,0.411576,0.62235,-0.253333,-0.797076,0.338748,-0.231233,0.389041,0.0694162,0.491879,-0.327502,-0.717783,0.196186,0.702284,-0.381843,0.667935,0.056449,0.129919,0.200639,-0.362539,0.211519,0.657127,-0.219835,-0.159625,-0.215701,0.0234299,0.0144215,-0.151956,-0.117541,0.506469,-0.105735,-0.00335794,0.551988,0.0542604,-0.389551,0.49225,0.0227882,0.195466,-0.359377,-0.076011,-0.113427,0.48316,-0.796488,-0.0622061,-0.209888,-0.166639,-0.545723,0.398497,-0.146065,0.301881,0.608719,0.217201,0.380179,-0.25752,0.0487346,0.126472,0.272325,-0.483819,0.637826,0.207741,0.598014,0.070129,-0.415577,-0.0154356,0.083863,0.386473,-0.168623,-0.52377,-0.299554,0.165047,-0.685822,-0.0557225,0.217329,-0.452689,0.586205,-0.164243,-0.34174,0.323436,0.639303,0.474715,-0.686924,-0.231542,-0.327358,0.204125,-0.673932,0.253566,-0.358998,0.00423624,0.769413,-0.0781796,0.146191,0.245551,-0.0381287,-0.125872,-0.133868,0.357312,-0.384476,0.599232,-0.11576,-0.0344835,-0.708592,0.415041,-0.0551224,0.519285,-0.410929,0.20861,-0.0151274,0.100441,-0.319174,-0.02115,-0.169057,0.37288,-0.267847,-0.223914,0.163846,-0.0374503,-0.233134,-0.239971,-0.151979,-0.218269,1.16766,-0.0340232,0.428473,0.2292,-0.113701,0.132888,-0.730706,-0.293737,-0.51667,0.0211634,-0.400018,0.283191,-0.0629546,0.122838,-0.317816,-0.0343626,0.124032,0.112422,-0.0814667,-0.624005,-0.0823107,-0.237687,-0.00787742,-0.0556738,0.200156,-0.234231,0.409261,-0.26834,1.0969,-0.0995507,0.324442,-0.0869515,-0.060806,0.103677,0.286198,-0.106066,0.298185,-0.217873,0.130882,-0.0227983,-1.18054,-0.491629,-0.476785,0.178757,0.130775,-0.526546,0.406553,0.148297,0.358208,-0.544308,0.038544,-0.340081,-0.305178,-0.336685,0.0133278,-0.50296,0.655428,0.239944,0.274165,0.267782,-0.745098,0.300031,-0.2198,0.1933,-0.536171,0.380225,0.384086,0.611757,0.266743,-0.032078,0.231007,-0.149638,-0.547349,0.689888,-0.211471,0.123859,0.615517,-0.230246,0.348065,0.351284,0.0860106,0.368488,-0.66454,-0.41581,-0.40009,0.580573,-0.172121,-0.0729702,-0.509461,-0.0889379,-0.157795,-0.76577,-0.289687,0.240673,0.355828,0.363338,-0.0815392,-0.219006,-0.117254,0.361586,0.218256,0.0838929,-0.454951,0.0769855,0.589283,-0.109512,0.315167,0.0595116,-0.314322,0.371683,-0.0806298,-0.0851605,0.346186,0.20773,0.51261,0.224216,-0.160503,-0.404121,0.0946709,-0.0521344,-0.48403,-0.117182,0.137525,0.189077,0.370844,0.43483,-1.45792 +3439.85,0.734973,0.0912059,4,1.54761,0.940051,-0.991861,0.27854,0.646578,-0.32568,0.459756,-0.293002,0.52152,0.271264,0.102297,-0.111449,-0.532262,0.230689,-0.0075006,0.564525,-0.102773,0.182253,-0.289851,-0.426536,-0.346593,-0.54044,-0.949076,-0.0228636,-0.424687,-0.3786,0.0936211,0.521859,-0.24266,-0.238906,0.566844,-0.633766,-0.00846198,0.345205,-0.176389,0.0611522,-0.138,0.7486,0.0312664,-0.210329,1.05911,0.446658,0.0952121,-0.182889,0.104732,0.818117,-1.11207,-0.0764222,0.255413,0.512832,-0.0448685,0.934798,0.132048,-0.0852122,0.979308,-0.243664,-0.386895,-1.18165,0.366525,-0.286749,0.639566,0.881924,-0.397373,-0.950879,0.283364,-0.161487,0.182998,0.0615363,-0.327211,-0.658763,-0.790642,-0.229166,0.703775,-0.329802,0.5613,0.578105,0.301229,0.20653,0.20194,-0.016596,0.106092,-0.434647,0.0675011,0.363236,-0.172413,-0.40926,0.00173133,0.165009,0.220225,-0.652243,0.170722,0.307494,-0.457781,0.34599,-0.204589,0.269171,0.194891,0.159786,-0.282899,-0.019184,0.420506,-0.174774,-0.816818,0.116056,-0.0489239,0.391021,0.250905,-0.361006,0.10383,0.426852,0.151179,-0.195066,0.307374,0.112262,-0.247314,0.502793,-0.334895,0.14692,-0.188602,0.0964925,-0.358915,0.0108813,0.100162,-0.147587,0.0914417,-0.117493,-0.0902942,-0.106266,0.112775,-0.5627,-0.067762,-0.0248584,-0.242126,0.248694,0.21696,-0.128839,0.560222,0.365181,0.349188,-0.863289,-0.358975,-0.388983,-0.432736,-0.550595,0.365708,0.204033,0.289787,0.453812,-0.420653,-0.183901,-0.389974,0.00818995,-0.0185173,0.0139913,0.123966,0.37085,0.652348,0.266603,-0.205716,-0.113702,0.130664,-0.264819,0.259496,-0.384543,-0.0442652,0.510457,-0.064057,0.0100581,-0.220658,-0.0320141,0.321262,-0.17726,-0.45561,0.136193,0.325306,0.0829356,-0.0815486,-0.275887,-0.405857,0.738506,0.171231,0.081584,0.0128519,-0.288808,0.292056,-0.35156,-0.163514,-0.305637,0.173752,-0.377643,0.442616,-0.0145659,-0.0902113,-0.646622,-0.0485295,0.379556,-0.0372686,-0.211284,-0.444455,-0.674912,-0.27365,-0.119964,0.315,-0.150711,0.0556702,0.0593453,-0.30446,0.771402,0.369142,-0.21401,-0.136684,-0.0366928,0.173104,0.153725,0.21035,0.387009,0.0563276,-0.207164,0.481553,-0.35324,-0.115191,0.0646543,-0.0439355,0.695924,0.141018,0.569095,-0.267085,0.172002,-0.527833,0.22051,-0.207718,-0.135706,0.255964,0.0639682,-0.163351,0.589143,-0.374405,-0.337789,0.767224,-0.131449,0.434746,-0.262278,0.160607,-0.374427,0.364148,0.426419,0.609705,-0.356722,-0.317892,-0.267448,0.200926,-0.639711,0.479485,0.161211,-0.169192,0.277059,-0.0328308,0.109881,0.0447717,-0.0665999,0.133621,0.0533979,-0.000856588,-0.028992,0.122834,0.57531,0.336405,0.06291,0.215412,-0.473254,-0.302487,-0.0197247,0.00492605,-0.355054,0.199831,0.0172156,0.090246,-0.212646,-0.0290106,0.0751329,-0.103958,-0.32852,-0.378277,0.325247,0.27355,0.123083,0.214842,0.180879,0.639528,0.119815,-0.214257,0.683624,0.31595,0.179768,0.533033,-0.681996,0.160842,0.258612,0.248573,-0.156485,-0.0716743,0.10705,0.256502,0.327185,0.50646,-1.92245 +3409.25,0.906343,0.0912059,5,1.54532,0.922668,-1.01105,0.443882,0.457219,-0.240478,-0.429508,0.298314,0.489571,0.0240611,0.387928,-0.151397,0.582536,0.635648,0.190811,1.02059,0.3706,-0.136082,-0.0644916,0.15085,-0.0471167,-0.638639,-0.303346,-0.0424223,0.0307571,0.203172,-0.301223,0.283403,-0.864509,0.294411,0.884333,-0.613431,-0.0221285,0.314403,-0.174063,-0.194283,-0.876551,0.489588,0.774914,0.0532407,0.919396,0.541948,0.151248,-0.708696,-0.493232,-0.814475,-1.0156,0.0958221,0.0679871,-0.0369014,-0.15324,0.112629,-0.0565418,-0.957567,0.170787,-0.375806,-0.0212392,-0.479849,0.337572,0.0915215,0.26206,0.919938,-0.649291,-1.45576,0.360687,0.574958,-0.231976,-0.599462,0.273314,-0.67351,0.229235,0.215764,0.53325,-0.113772,0.453675,0.393063,0.147141,0.0581926,-0.572986,-0.373658,0.30177,-0.376048,0.0635894,-0.615695,-0.135845,0.483145,-0.374059,0.208706,-0.20128,-0.455581,0.240437,-0.0282781,-0.0427208,-0.254966,0.0749041,-0.558964,0.0982392,-0.570411,0.00357626,0.286959,-0.126679,0.414947,-0.420701,-0.587338,0.0376002,-0.0573882,0.36331,-0.18437,-0.0180977,0.556698,0.0744634,-0.0604972,0.110161,0.474977,0.572556,-0.583436,-0.160272,0.240454,0.280191,-0.343272,-0.459511,-0.584006,0.180724,-0.447304,-0.102819,0.204528,0.068755,0.105742,-0.00306062,0.0674081,0.341273,0.230139,-0.475533,0.377839,-0.363492,0.284363,0.144962,-0.529497,0.20235,-0.41604,-0.027613,0.121394,0.543711,-1.03664,0.115308,0.0960742,-0.260308,0.186538,-0.148113,0.0516264,0.654101,-0.0687155,-0.193893,-0.28654,0.629603,0.101661,-0.100876,-0.270053,0.380237,0.0488458,0.374253,-0.365529,1.03659,-0.130177,0.857387,0.185667,0.213047,-0.384814,-0.369568,-0.0872615,0.0772418,0.54571,-0.0287613,-0.536205,-0.225669,0.115254,-0.171056,-0.124633,0.230683,0.49682,-0.399927,0.548071,-0.272113,0.136118,-0.0430482,-0.0365829,-0.0972305,-0.475499,0.130618,-0.876903,-0.437521,-0.534072,0.173526,-0.495273,-0.522177,-0.5311,-0.180614,-0.231355,-0.542535,0.447572,-0.0225432,-0.431969,0.134342,0.127292,-0.0670378,0.339233,-0.586261,0.616958,-0.0102205,0.137961,-0.140294,-0.198056,0.00868413,0.556643,-0.663718,0.105101,-0.668246,0.354803,-0.121967,0.55199,-0.366458,-0.658262,0.00697569,0.0781992,-0.530984,0.197763,-0.889499,-0.64278,0.0450671,-0.0562298,-0.190989,-0.0272976,-0.539392,-0.19005,-0.169647,0.523003,-0.508596,-0.274996,0.232224,0.0357139,-0.42614,0.273503,0.155362,0.644796,0.176379,0.375299,0.333016,0.173133,-0.431439,0.0668003,-0.275304,-0.709492,0.598395,-0.263445,-0.361629,0.379025,-0.294017,-0.617432,0.307216,0.398863,0.235037,0.615362,0.519176,0.0184689,-0.194311,0.00303219,-0.309206,0.563205,0.10512,0.346814,0.299476,0.0188871,0.508125,0.175725,-0.282973,-0.048232,0.353247,0.764704,0.523445,0.118938,0.32137,0.487344,0.434378,0.107051,0.318486,0.0660311,0.0145389,0.406974,-0.344999,0.0117166,0.36869,-0.0247414,0.107985,0.51341,-0.180076,-0.91495,-0.149877,0.0798894,-0.088164,0.10077,0.295523,0.146179,0.302659,0.382334,0.550145,-1.4334 +3411.61,0.998605,0.0912059,4,1.52627,0.942139,-1.02458,0.453301,0.475196,-0.224639,-0.341829,0.262844,0.427427,0.0902804,0.389565,-0.151154,0.535909,0.685911,0.247141,1.09449,0.356346,-0.0315893,-0.0922996,0.103922,-0.083836,-0.621291,-0.322646,-0.0536027,-0.0207726,0.234846,-0.241818,0.257177,-0.740726,0.246768,0.876121,-0.621323,-0.0593921,0.270173,-0.171863,-0.187506,-0.76893,0.502882,0.854075,0.145735,0.860095,0.492945,0.0607282,-0.743873,-0.558852,-0.685048,-0.983952,-0.000401493,0.102693,-0.00296627,-0.0420013,0.132608,-0.111279,-1.01027,0.173634,-0.333071,-0.106262,-0.488071,0.380486,-0.0134703,0.264887,0.891336,-0.615681,-1.39093,0.258769,0.628621,-0.203922,-0.554676,0.27618,-0.731414,0.207402,0.136513,0.509783,-0.183979,0.456908,0.444141,0.272837,0.0280876,-0.584168,-0.400358,0.304411,-0.350902,0.118707,-0.650275,-0.135785,0.47734,-0.40681,0.285696,-0.195168,-0.485577,0.247189,-0.0350834,-0.0756919,-0.239295,0.0700764,-0.622518,0.0661159,-0.564605,0.0634014,0.219547,-0.101476,0.467062,-0.401414,-0.534656,-0.0896878,-0.107408,0.39957,-0.193354,-0.0723091,0.591,0.143359,-0.101567,0.081867,0.479765,0.621302,-0.526933,-0.132555,0.274641,0.225126,-0.310528,-0.447885,-0.512601,0.169027,-0.543276,-0.183132,0.170433,0.0874573,0.149647,0.0146653,0.070141,0.271647,0.191539,-0.475987,0.332778,-0.383962,0.291114,0.164023,-0.531075,0.195136,-0.416542,-0.0880776,0.154046,0.630868,-0.998493,0.121893,0.109356,-0.197696,0.141039,-0.129551,0.114572,0.637536,-0.0192236,-0.17247,-0.287182,0.596845,0.112781,-0.201142,-0.223279,0.356304,0.0824637,0.444956,-0.368429,1.01253,-0.119339,0.788469,0.132648,0.249733,-0.409804,-0.329971,-0.0382403,0.0834369,0.617783,-0.0486233,-0.567789,-0.172693,0.169927,-0.118583,-0.0906233,0.248966,0.596745,-0.392562,0.482096,-0.28056,0.0735004,-0.0794408,-0.0788892,-0.140734,-0.464762,0.184171,-0.791265,-0.430921,-0.545285,0.111664,-0.500653,-0.524265,-0.518861,-0.150641,-0.190743,-0.537505,0.36439,-0.0211177,-0.396819,0.284522,0.176321,-0.0882054,0.265214,-0.509582,0.591314,0.0392591,0.160021,-0.127706,-0.258382,0.0168059,0.557239,-0.72692,0.121691,-0.717582,0.323995,-0.144497,0.529493,-0.390408,-0.656986,0.0511741,0.0439093,-0.423753,0.17923,-0.870867,-0.562288,-0.0416846,-0.0506489,-0.150475,-0.00519473,-0.577982,-0.174386,-0.167708,0.536233,-0.451017,-0.199927,0.228614,-0.0555005,-0.522074,0.223937,0.150017,0.795033,0.243854,0.305468,0.301641,0.252618,-0.465476,-0.0991393,-0.248092,-0.677468,0.604516,-0.270645,-0.390995,0.394738,-0.349543,-0.573483,0.245845,0.433832,0.146625,0.66192,0.549361,0.0628233,-0.220165,0.030555,-0.370569,0.601798,0.121274,0.292253,0.379191,0.0304917,0.461462,0.165954,-0.273981,-0.0691398,0.314421,0.798658,0.472764,0.18189,0.344955,0.4681,0.306283,0.200354,0.307568,0.140222,-0.0484233,0.457412,-0.308058,0.0466379,0.388603,-0.163049,0.206156,0.432436,-0.173674,-0.924358,-0.146193,0.0550658,-0.0704587,0.0892681,0.367094,0.144067,0.311903,0.379562,0.558483,-1.55234 +3415.6,0.998313,0.0912059,4,1.53567,0.960656,-0.955608,0.419822,0.43895,-0.214027,-0.340376,0.303581,0.406048,0.158226,0.469294,-0.154777,0.60174,0.624346,0.249572,1.02466,0.277925,-0.0630518,-0.059776,0.14864,-0.0774455,-0.661816,-0.332802,-0.0577298,-0.108138,0.261493,-0.301494,0.284461,-0.704663,0.183652,0.8915,-0.611909,-0.0828322,0.272197,-0.266736,-0.158133,-0.764639,0.529002,0.747432,0.140584,0.836673,0.47691,0.0912539,-0.662536,-0.583781,-0.656472,-0.978752,0.0542607,0.212125,-0.0739426,-0.0307668,0.0777533,-0.0711313,-1.0632,0.129105,-0.292616,-0.0962105,-0.492351,0.331289,0.00351484,0.146631,0.916176,-0.60213,-1.46598,0.289809,0.511075,-0.248585,-0.623748,0.280835,-0.788151,0.144814,0.213172,0.473716,-0.175678,0.480659,0.402713,0.223888,0.0111467,-0.555605,-0.348764,0.246336,-0.349226,0.116525,-0.782392,-0.144748,0.474812,-0.283962,0.17433,-0.238987,-0.446387,0.183136,0.0373731,-0.109029,-0.261248,0.0882461,-0.550937,-0.00491849,-0.502501,0.0265543,0.202836,-0.141015,0.451697,-0.462538,-0.698188,-0.0960877,-0.128089,0.452587,-0.178459,-0.0891922,0.57949,0.180755,-0.0587134,0.0686805,0.517446,0.606044,-0.488891,-0.0808489,0.27547,0.279005,-0.331925,-0.450241,-0.507034,0.214466,-0.553102,-0.0417663,0.172701,0.124109,0.0445729,0.00980227,0.027722,0.329747,0.198992,-0.532121,0.364692,-0.396595,0.318826,0.183173,-0.566507,0.244778,-0.414856,-0.0892497,0.136401,0.776572,-0.999803,0.182795,0.191024,-0.303112,0.10778,-0.112745,0.124217,0.550503,-0.0288903,-0.190796,-0.188553,0.56647,0.0173992,-0.0988342,-0.230721,0.405481,0.0521832,0.438898,-0.489116,0.98926,-0.107024,0.815256,0.129436,0.246718,-0.411269,-0.377539,-0.128525,0.0477154,0.580923,-0.1437,-0.526495,-0.161626,0.116892,-0.0495778,-0.0155152,0.299049,0.535292,-0.400742,0.476529,-0.258576,0.105841,-0.0913422,-0.053242,-0.166556,-0.463688,0.185055,-0.703209,-0.403907,-0.487796,0.0686307,-0.490625,-0.530411,-0.60821,-0.1684,-0.195333,-0.501922,0.368468,0.0122548,-0.369176,0.218723,0.121495,-0.0241046,0.211359,-0.549164,0.637784,-0.0624491,0.171648,-0.0962628,-0.225567,-0.0311979,0.590649,-0.690941,0.162576,-0.635952,0.229738,-0.0907769,0.435275,-0.488461,-0.65008,0.032403,0.041176,-0.384701,0.220074,-0.848792,-0.490023,-0.105475,-0.113845,-0.188143,0.0145625,-0.518563,-0.179764,-0.17846,0.492374,-0.409784,-0.113295,0.220221,-0.11467,-0.399582,0.149239,0.193021,0.737328,0.239829,0.376401,0.303381,0.221877,-0.488939,-0.0775842,-0.320259,-0.712803,0.56916,-0.286704,-0.37209,0.363094,-0.328025,-0.651174,0.236012,0.379833,0.206135,0.57639,0.522668,0.0393623,-0.20275,-0.00667389,-0.363545,0.751339,0.15725,0.261839,0.312243,0.0555739,0.482771,0.15949,-0.262684,-0.137575,0.231771,0.732907,0.540163,0.297669,0.317309,0.357371,0.305127,0.269665,0.310024,0.138077,-0.0024495,0.39101,-0.311225,0.0398101,0.35894,-0.118706,0.252744,0.524099,-0.195612,-0.937575,-0.0535861,0.0882685,-0.0916228,0.126057,0.410555,0.140267,0.283173,0.374522,0.53214,-1.46249 +3421.91,0.998082,0.0912059,4,1.59292,0.945641,-0.874465,0.36714,0.153159,-0.223437,-0.266136,0.275755,0.218893,-0.0489299,0.133157,-0.21323,0.356666,0.547516,0.357954,1.11102,0.369765,0.114994,-0.224929,-0.132217,-0.115598,-0.487894,-0.600789,0.0761209,-0.0688533,0.26686,-0.279861,0.540942,-0.777132,-0.0200829,0.89545,-0.483135,-0.0226905,0.249368,-0.412692,-0.147591,-0.647768,0.59965,0.721187,-0.131893,0.800801,0.324648,0.0234163,-0.758683,-0.447361,-0.545439,-1.11379,-0.0156088,0.231641,-0.335591,0.0357732,0.0254017,-0.0780369,-1.30561,0.268049,-0.357448,-0.230293,-0.554569,0.0600929,0.0587324,0.127503,0.926533,-0.578431,-1.5031,0.365141,0.515462,-0.292003,-0.321302,0.304226,-0.938446,0.167565,0.0582455,0.545855,-0.093113,0.547414,0.339011,0.183934,-0.0968774,-0.595587,-0.161457,0.322945,-0.0384139,0.0664123,-0.803024,-0.178058,0.268038,-0.262955,0.280145,-0.426486,-0.320043,0.326355,-0.119604,-0.185325,-0.30643,0.280276,-0.791114,0.147365,-0.443282,0.0141046,0.132691,-0.108642,0.448367,-0.43553,-0.756715,0.161038,0.0502941,0.386572,-0.0249884,-0.0750669,0.589771,0.375206,-0.227522,0.0974648,0.509868,0.291443,-0.554331,-0.0191446,0.15673,0.182596,-0.457125,-0.675206,-0.314587,0.307465,-0.319157,-0.0591172,0.206276,0.11095,0.0398594,0.178717,-0.0271768,0.2113,0.171915,-0.404891,0.575877,-0.270557,0.408441,0.147807,-0.564484,0.183503,-0.644628,-0.0525652,0.176596,0.703262,-0.892742,0.257272,0.186775,-0.347378,0.121361,-0.18768,-0.0761124,0.41417,-0.0342514,-0.0456012,-0.178134,0.283823,-0.164689,-0.189498,-0.274369,0.250952,0.230724,0.318915,-0.470867,0.97319,0.271183,0.699513,0.298491,0.145295,-0.159822,-0.282154,-0.210981,0.2424,0.660241,-0.251391,-0.492924,-0.0564494,0.134018,-0.212063,-0.0526276,0.526353,0.416017,-0.163813,0.314878,-0.350647,0.234897,0.0612612,-0.0717033,-0.274604,-0.498314,0.297483,-0.692708,-0.264877,-0.549155,-0.0393423,-0.622042,-0.36497,-0.6208,-0.143671,-0.217876,-0.433141,0.397992,-0.0816365,-0.443343,0.220547,-0.077668,-0.304337,0.416941,-0.211388,0.649093,-0.052375,0.223297,-0.124031,-0.140752,0.133237,0.386768,-0.568907,0.170456,-0.615485,0.147846,0.124023,0.546339,-0.516994,-0.706475,0.069585,0.0358558,-0.377309,0.188292,-0.925683,-0.449946,0.0823806,-0.0643464,-0.0704609,0.0696118,-0.512096,-0.114123,-0.0311273,0.437966,-0.234717,0.0246239,0.302508,-0.0424438,-0.310297,0.171582,-0.00731932,0.671823,0.00352518,0.310355,0.461774,0.276149,-0.334931,0.116763,-0.254116,-0.79077,0.37117,-0.13442,-0.0425937,0.357365,-0.23915,-0.38486,0.373464,0.270548,-0.0993454,0.448043,0.127691,0.0495129,-0.265434,-0.0433768,-0.25235,0.833038,0.379634,0.489518,0.0200013,0.292595,0.37376,0.0993352,-0.34478,-0.118565,0.357061,0.71881,0.369643,0.328896,0.554685,0.0327812,0.115284,0.292404,0.331493,0.359182,-0.361247,0.404242,-0.33966,0.1267,0.317986,-0.167541,0.0616392,0.70845,-0.245561,-0.935394,-0.254772,0.176734,-0.0533045,-0.099254,0.33809,0.13698,0.30211,0.370109,0.549645,-0.420245 +3420.63,0.908192,0.0912059,5,1.56322,0.93275,-0.770081,0.348863,0.0448681,-0.21638,-0.266919,0.115264,0.106666,-0.0236885,0.0588201,-0.287171,0.489097,0.614808,0.31347,1.33041,0.269535,0.256107,0.121653,0.0320827,0.0357008,-0.466929,-0.905938,0.241265,0.143438,0.151588,-0.11411,0.468019,-0.730357,-0.144416,1.03983,-0.608469,-0.249086,0.347754,-0.390666,-0.224775,-0.693767,0.314797,0.447142,-0.418689,0.773415,0.306168,-0.0465965,-0.665359,-0.603279,-0.779247,-1.06091,0.159976,0.281755,-0.295602,0.055786,0.247501,-0.0509226,-1.14757,0.287837,-0.468378,-0.0600646,-0.439316,0.211849,-0.19195,0.202809,0.953567,-0.783218,-1.4311,0.260263,0.752897,-0.0908367,-0.213223,0.287223,-0.86693,0.0787751,0.00902733,0.571395,-0.277339,0.673274,0.337326,0.369501,-0.287572,-0.35861,0.0718093,0.437952,-0.124882,-0.0540023,-0.694636,-0.0525516,0.450587,-0.291582,0.104554,-0.358371,-0.332585,0.332394,-0.339112,-0.301328,-0.336185,0.509682,-0.380301,-0.134945,-0.431283,-0.0318051,0.181712,-0.00615368,0.265964,-0.371238,-0.754019,0.262779,0.113448,0.600156,-0.102816,-0.332204,0.645459,0.324679,-0.257548,0.262638,0.458158,0.160437,-0.425142,-0.0255395,0.0123654,-0.042214,-0.439766,-0.631438,-0.251744,0.0561381,-0.118644,-0.0853317,0.0131491,-0.00466335,-0.0143369,-0.0145384,-0.0218209,-0.0189519,0.200187,-0.256345,0.264198,-0.41455,0.404357,-0.114921,-0.146754,0.220128,-0.589856,-0.0822811,0.00462309,0.653013,-0.783406,0.23292,0.0373636,-0.404331,0.180158,-0.239417,0.185757,0.244236,0.188724,-0.173156,0.0141743,0.547931,0.00396025,-0.315217,-0.260805,0.0709411,0.435075,0.382179,-0.430511,1.0577,0.126762,0.699831,0.278414,0.145741,-0.236782,-0.304959,-0.236998,0.10204,0.791438,-0.0541023,-0.432746,-0.00883933,0.165832,-0.318035,0.364197,0.741399,0.658535,-0.44607,0.353401,-0.478679,0.105079,0.274899,0.0906548,-0.438126,-0.42192,0.568037,-0.423926,-0.320303,-0.583045,0.090943,-0.450667,-0.325899,-0.41255,0.117333,-0.214283,-0.491952,0.391564,0.0338623,-0.548324,0.0183699,-0.159174,-0.275172,0.270071,-0.178971,0.668896,0.186157,0.0987974,-0.153346,-0.112329,0.0287751,0.525426,-0.737216,0.170126,-0.561201,0.251426,-0.10316,0.576657,-0.426066,-0.493955,0.137683,0.251269,-0.413757,0.150927,-0.713433,-0.329432,-0.0488182,-0.161708,-0.215592,-0.0973596,-0.690235,-0.104432,-0.189543,0.391847,-0.252169,-0.0639852,0.362243,0.178145,-0.585521,0.313551,-0.265593,0.602614,-0.324019,0.38446,0.446404,-0.040281,-0.345979,0.0010442,-0.260547,-0.556461,0.228923,-0.265866,-0.0810531,0.480971,-0.488336,-0.382036,0.194119,0.295681,0.116161,0.238948,0.00494519,0.131414,-0.170631,0.0756184,-0.291346,0.637837,0.300324,0.367278,-0.00464274,-0.094796,0.342877,-0.0127426,-0.229748,-0.0952353,0.440035,0.514776,0.305456,0.317687,0.329202,0.086292,0.218154,0.45322,0.227271,0.592746,-0.635532,0.244079,-0.474081,-0.0362591,0.173239,-0.0618035,-0.0415599,0.406616,-0.105743,-0.80651,-0.35261,0.342702,0.178124,-0.324003,0.183199,0.13336,0.322869,0.365184,0.568216,-0.10693 +3428.94,0.982016,0.0912059,4,1.58362,0.742048,-1.01051,0.475978,0.175774,-0.199697,-0.15026,-0.210353,0.562169,0.328396,0.393803,-0.206722,0.307307,0.640871,-0.140913,0.876843,0.531962,-0.0868688,0.195052,0.175281,-0.0729236,-0.224429,-0.445627,0.51854,-0.0389887,0.177953,-0.478942,-0.121178,-0.231006,0.264384,1.26323,-0.776558,0.124893,0.112356,-0.367154,-0.181962,-0.982378,0.830764,0.41225,-0.337734,0.826727,0.421613,-0.0861486,-0.747859,-0.227308,-0.222214,-1.08081,0.0443797,0.272632,0.0249847,0.381125,-0.0691861,0.303204,-0.720687,0.625158,-0.512695,-0.605872,-0.424841,0.199878,-0.276938,0.374184,0.736468,-1.13229,-0.899769,0.190168,0.259085,-0.125222,-0.477642,0.461874,-0.399074,-0.09872,-0.0518004,0.277187,0.241428,0.0734048,0.420471,-0.00550347,-0.222953,-0.0343823,0.253397,0.04645,-0.393355,0.0117779,-0.0625622,-0.0709923,0.331601,0.0588103,-0.154687,-0.392791,-0.559614,0.413128,-0.172009,0.287914,-0.175608,0.00215192,-0.40236,-0.114946,-0.204661,-0.162305,0.327128,0.0940185,0.0020973,0.206771,-0.370288,0.0780717,0.205012,0.144112,0.193406,0.0754673,0.426518,0.237538,-0.555354,0.0691562,0.176713,-0.221328,-0.461687,-0.655502,-0.175688,0.195676,0.0781139,-0.872066,-0.156351,-0.33718,-0.245344,-0.0192612,-0.0888865,-0.181218,0.507979,0.323352,0.206094,-0.0908386,-0.135776,0.0537886,0.44629,-0.34654,-0.521548,-0.288973,-0.299624,0.371561,-0.675945,-0.0872721,0.054393,0.364476,-0.392338,0.286694,-0.212668,0.142961,0.653719,-0.178346,0.517749,-0.188954,-0.251484,0.0411024,0.215089,0.204553,-0.211673,0.179753,-0.181325,0.286151,0.134748,0.797502,-0.287437,0.862243,-0.57669,0.812588,-0.124132,-0.18616,0.135131,-0.191935,0.270887,0.392071,0.0917537,-0.231622,0.148795,-0.0982881,-0.332883,-0.0137024,0.427094,0.115316,0.744734,-0.102121,-0.247408,0.386665,-0.197106,0.274008,0.460701,-0.141883,-0.273113,0.572411,-0.177481,0.0533948,-0.513045,-0.404184,-0.427504,-0.155342,0.586898,0.392057,-0.586181,-0.627423,0.413955,0.0556433,-0.525084,-0.0113157,0.335652,-0.0432677,-0.0876706,-0.252304,0.63059,0.564578,0.128478,0.139276,-0.135211,-0.0869788,0.590738,-0.425673,0.134743,-0.592153,-0.0345822,-0.091302,-0.120188,-0.251081,-0.299153,0.384244,0.225903,-0.156759,0.619722,-0.569668,-0.350398,0.261563,-0.0923634,-0.0407775,-0.143625,-0.368821,-0.0151237,-0.0701887,0.498301,0.489048,-0.231572,0.646209,0.564459,-0.460586,0.0301268,-0.18613,-0.215679,-0.28512,0.67488,0.137225,-0.276608,-0.262657,-0.0334365,0.392137,-0.587774,0.25695,-0.268216,-0.172061,-0.0835645,-0.918225,0.340923,0.181725,0.109635,0.24355,0.359044,0.107057,0.302811,-0.0602251,0.661921,-0.257194,0.16121,0.325005,0.514564,-0.242542,0.10954,0.341482,-0.103177,0.354378,-0.0323946,0.212035,0.350977,1.06087,0.163603,0.313635,-0.0899189,-0.154095,-0.273669,0.110614,0.376503,-0.198622,0.337061,-0.0950768,-0.168041,-0.122429,0.132944,-0.0934184,0.213878,0.372541,-0.909738,-0.130372,-0.00374924,-0.415722,-0.266259,-0.260703,0.11266,0.19098,0.335649,0.437013,-0.182351 +3435.84,0.75976,0.0912059,5,1.61715,0.968967,-0.696658,0.143223,0.820679,-0.113083,-0.369658,0.0541157,0.0247127,0.676997,-0.44407,-0.18145,-0.714509,0.144898,-0.334946,0.43671,-0.338241,-0.428823,-0.201253,-0.410937,-0.479949,-1.19858,-0.482739,-0.248259,-0.311753,-0.215012,0.33149,0.293245,-0.381744,0.0961886,0.538353,0.224419,0.41453,0.393294,-0.181927,0.0703232,0.219936,-0.185883,0.693234,-0.568584,1.2183,0.538411,0.658222,-0.531851,0.042678,-0.104909,-0.0257887,0.115537,0.598311,0.214362,-0.159971,0.692426,0.142114,-0.355771,0.835995,-0.166209,-0.388572,-1.06572,0.638152,-0.176275,0.193212,1.22602,-0.698163,-1.46351,-0.11386,0.282376,-0.942376,0.105101,0.331107,-0.493633,-0.0756446,0.163525,0.42996,-0.519387,0.241397,0.527461,-0.304777,0.102656,-0.369932,0.306624,0.856179,-0.0127985,0.0579998,-0.195203,0.0896498,-0.0423871,0.0680446,-0.672897,-0.0667527,-0.356806,-0.133672,0.400727,0.090872,0.00100457,0.0390184,-0.507962,0.290654,-0.147258,0.0946396,0.246711,0.241376,-0.199115,-0.0410968,-0.176082,0.0755421,-0.64351,0.120448,-0.392193,0.349924,0.766411,0.00647103,0.0284685,0.124035,0.401902,-0.230137,0.538503,0.012642,-0.262461,-0.0400572,0.383953,-0.769555,0.451178,0.0939097,-0.277633,0.0057655,-0.0307335,0.445681,-0.0892848,0.401606,-0.204603,0.62549,-0.188651,-0.126551,0.317257,-0.428804,0.336739,-0.0255928,0.0555349,0.429308,0.0214685,-0.480646,0.149341,-0.135977,-0.342421,-0.0487189,-0.411861,0.114588,0.176648,0.12419,0.000709441,-0.388681,-0.537214,0.109465,-0.0493295,-0.444134,0.741542,0.304376,0.258176,-0.0843705,-0.0368757,-0.211192,0.126494,0.358577,-0.0813987,-0.288559,0.171155,0.0895701,0.62498,0.101967,-0.0852416,0.387006,-0.394761,0.000444077,-0.220023,-0.439685,-0.0871842,-0.175894,-0.0351183,0.337085,0.373716,-0.561194,-0.0149103,0.147922,-0.143731,-0.310469,-0.737663,-0.247508,-0.223381,0.283111,0.235214,0.158451,0.0513665,0.222412,-0.576752,0.317529,0.517297,0.132338,-0.0297859,-0.324049,0.300533,0.0356603,0.156377,0.546715,-0.784672,-0.189394,-0.23904,-0.449515,0.932636,-0.503295,-0.183063,-0.00719429,0.189657,0.189471,0.543193,0.00752555,0.498,-0.271868,-0.138699,-0.000472911,-0.132261,0.285694,-0.561139,0.690918,0.230493,-0.178498,0.14328,-0.345249,-0.665761,-0.0567068,0.240908,0.21915,0.194188,-0.04828,-0.395432,0.0648051,0.242078,-0.0132926,0.0709947,0.502838,-0.276239,-0.0815552,-0.122232,-0.163391,0.174945,0.133646,-0.407427,0.420327,-0.669259,-0.288705,-0.209287,-0.25358,-0.00291483,0.433403,0.0523953,0.185167,-0.0711874,-0.295043,-0.135076,0.287286,0.377087,0.40445,0.0877717,-0.444418,-0.432401,0.416759,0.0182909,-0.000327147,-0.453947,-0.019402,-0.316541,0.074684,-0.255578,-0.615157,0.197264,0.11223,0.0128748,-0.187648,0.0735642,-0.560139,-0.141554,0.0612877,-0.489379,-0.0414166,0.00220502,-0.377105,0.0322723,-0.0660545,0.231212,0.177798,-0.128213,-0.00757891,0.248768,-0.0710337,0.232509,-0.277733,0.164035,-0.311994,-0.168271,-0.0134387,-0.248107,-0.0362834,0.100747,0.195732,0.317406,0.442416,-2.56194 +3443.94,0.986746,0.0912059,4,1.65359,0.85251,-1.00212,0.288226,0.0307522,-0.183006,0.144785,-0.251117,0.516311,-0.647343,-0.136644,-0.406891,0.203939,0.56588,-0.679659,0.721659,-0.052783,-0.22008,-0.132642,0.00545239,-0.255225,-1.0163,-1.29765,0.0982111,-0.434151,-0.306124,-0.286907,0.103933,-0.732776,-0.269224,0.899848,-1.29244,-0.617877,-0.0532449,-0.255492,-0.625191,-0.563161,0.840857,0.298107,-0.114645,0.831059,0.371753,0.227023,-0.720629,0.216506,-0.539973,-1.12898,0.397524,0.321271,0.00197195,0.575159,0.0948723,0.376201,-0.412358,0.641961,-0.513389,0.0571787,-0.261422,0.30828,-0.652267,0.13454,1.06676,-0.331343,-0.446737,0.420888,-0.207894,0.928094,-0.123539,-0.170062,-0.162308,0.0713361,0.214861,0.42299,0.553317,0.410871,0.2379,0.957963,-0.121445,-0.083247,-0.0307133,0.0469325,-0.384752,0.543087,0.264298,-0.121229,-0.269,-0.112002,0.386107,0.118286,-0.287164,-0.0859468,-0.237247,-0.221975,-0.0423252,0.124058,0.0519053,-0.0379024,-0.0507407,0.15316,0.260133,-0.0766602,0.0586075,-0.321536,-0.512824,0.248586,0.268504,0.121239,-0.0335188,0.0953533,0.0881045,-0.150547,-0.191213,0.0347652,0.329172,0.354855,-0.311397,-0.350583,0.296263,0.175402,-0.326015,-0.187879,-0.572679,-0.227494,0.0534664,-0.179703,0.348997,-0.133398,-0.0152647,-0.215183,-0.243083,-0.449332,0.0118895,0.241604,0.217932,0.205089,-0.179209,0.00464672,-0.289605,0.443033,-0.437177,0.144313,0.0363056,0.335791,-0.367547,-0.127291,0.466278,-0.214303,0.160249,-0.462092,-0.234928,0.259162,0.601574,0.0935626,0.138988,0.546309,-0.0214607,0.0508445,-0.124602,0.234819,0.0477744,0.435089,0.0191495,0.244182,0.160757,0.265692,-0.0514034,-0.367846,-0.751932,-0.370286,0.0221149,-0.0714102,0.354461,-0.00651827,0.235367,0.314785,-0.00871145,-0.390415,-0.121203,-0.0911466,0.786627,0.526735,-0.246414,0.064957,-0.0709535,0.387216,0.228508,-0.0174712,-0.180908,0.0589111,-0.657199,-0.245364,0.132494,-0.457599,-0.174977,0.0460558,-0.251788,-0.100981,-0.197001,-0.142232,-0.0801919,0.0874464,-0.433826,-0.225649,0.369676,0.136556,0.123679,-0.184822,0.676661,0.338085,0.482364,-0.0993513,-0.427932,-0.0407542,-0.550948,-0.105502,-0.0696614,0.0390191,0.424306,0.415712,-0.235148,-0.142721,-0.348553,-0.558309,0.0141734,-0.247216,0.434381,0.0870406,0.201597,0.240671,-0.123767,-0.21561,0.0914248,-0.078435,0.182343,-0.490456,0.275734,-0.027859,-0.0371507,0.360293,-0.182292,-0.068542,0.155203,0.00487827,-0.0542259,0.340635,0.622701,0.273598,0.847199,0.118486,-0.449888,0.342349,-0.831033,0.198359,-0.120516,-0.417274,0.344904,0.0303801,0.30633,-0.107097,-0.116901,-0.133928,0.40104,0.386457,0.508245,-0.153577,0.0142404,-0.13439,0.132166,-0.0701765,0.217268,-0.349307,0.0347518,0.110699,0.096606,0.0105278,0.148236,0.30714,0.00642494,0.651501,0.271917,-0.520922,0.30983,-0.28613,0.0408239,0.375054,0.314651,-0.252597,0.101574,-0.0175453,-0.0789753,0.00265081,-0.106258,0.172121,0.0287461,-0.030883,-0.727193,0.297058,0.101932,-0.2098,0.151529,-0.029738,0.0846293,0.301557,0.290911,0.549142,0.34324 +3451.73,0.989516,0.0912059,4,1.62999,0.857134,-0.995576,0.260719,0.435739,-0.152614,0.160269,-0.333815,0.384316,0.0551753,0.0851232,-0.619619,-0.185885,0.426588,-0.615519,0.634149,-0.130587,-0.421262,-0.0335027,-0.00779295,-0.276907,-1.11339,-1.23477,-0.0833355,-0.281425,-0.419425,-0.176677,0.0574173,-0.759212,-0.282635,0.769559,-1.33976,-0.939885,0.108123,-0.253595,-0.273433,-0.3988,0.608553,0.307868,-0.10411,0.837726,0.589481,0.00447866,-0.751709,0.442996,-1.0183,-0.878052,0.518866,0.480371,0.0160533,0.351777,-0.0917317,0.153368,-0.33135,0.801336,-0.635308,0.115221,-0.558255,0.415265,-0.781841,0.310592,0.996047,-0.413298,-0.365048,0.233985,-0.225216,0.810607,-0.168419,-0.0358509,-0.141453,-0.00563915,0.247623,0.321005,0.380707,0.350524,0.357915,0.639971,-0.110662,0.0661161,-0.101341,0.510877,-0.452824,0.509291,-0.0872426,-0.125161,0.0908731,-0.0371012,-0.103649,0.242603,-0.215149,-0.139841,-0.222484,0.0141155,-0.243908,-0.0250812,-0.10136,-0.0881263,-0.286641,-0.24627,0.311432,-0.391869,0.131782,-0.235741,-0.616308,0.326555,0.179069,-0.239147,-0.0163591,0.335586,0.120599,0.034439,-0.147204,-0.254089,0.210908,0.25335,-0.496799,-0.355954,0.446637,0.620914,-0.290827,-0.789484,0.241134,-0.0554374,0.246689,-0.269478,0.147746,-0.048053,0.248959,0.230028,-0.376642,0.0363425,-0.0337029,0.398136,0.216804,0.0226469,0.0485327,0.0715023,0.0435112,0.233537,-0.538331,-0.0629278,-0.156232,0.132115,-0.0388876,-0.183813,0.266699,-0.44528,0.429909,-0.198095,0.0747637,-0.0383636,0.22338,0.403433,0.0312843,0.512511,0.201002,0.244585,-0.508898,0.226849,0.234526,0.194416,0.401827,0.0798615,0.0703296,0.434156,0.246502,-0.264202,-0.73011,-0.432298,0.156563,-0.0461259,0.462455,0.129876,0.107036,0.222835,0.154135,-0.206436,-0.183086,-0.175737,0.523783,0.139509,0.0359451,-0.439117,0.368243,0.501821,0.236558,0.0405888,-0.447464,0.10543,-0.570747,-0.171591,0.159294,-0.086805,-0.165343,0.24124,-0.188365,-0.0807272,-0.263275,0.170004,0.0645653,-0.0542501,-0.283393,-0.248244,0.27098,-0.00253045,0.344159,-0.0917216,0.644654,0.349601,0.484028,-0.224255,-0.550359,0.098549,-0.600645,-0.294787,-0.0647092,-0.196058,0.107156,0.277064,0.178551,-0.269874,-0.332655,-0.341697,0.159558,-0.394277,0.436832,-0.0558794,-0.22978,0.217197,0.0896395,-0.220399,0.196833,0.0565855,0.046188,-0.580151,0.480502,-0.211945,0.0269784,0.353206,-0.0190157,-0.0264705,0.231413,-0.0142542,-0.379409,0.359708,0.625021,0.290601,1.0907,0.0978529,-0.204485,0.232543,-0.676158,0.317463,-0.0869762,-0.307628,0.249706,-0.432161,0.253641,-0.315653,0.0246229,-0.135705,0.447645,0.319058,0.066805,0.111122,0.115597,-0.277568,0.531718,-0.130823,-0.0857953,-0.0641353,-0.051741,-0.410943,0.0921751,-0.0687099,-0.152714,0.256296,0.0928491,0.706572,0.315493,-0.402974,0.0752016,-0.255019,0.329521,0.21883,0.29358,-0.321383,0.060136,0.0887106,-0.151468,0.128414,-0.207291,-0.0295657,-0.166528,-0.20002,-0.398735,0.62468,-0.269468,-0.359473,0.325179,0.0321536,0.0923916,0.275418,0.30396,0.524803,-1.01795 +3440.54,0.921951,0.0912059,4,1.68017,0.854288,-1.13011,0.407866,0.316315,-0.109104,0.0543074,-0.433188,0.523125,0.653434,-0.0449616,-0.636207,-0.216727,0.384646,-0.438648,0.596589,0.0290265,-0.309739,-0.160987,-0.157607,-0.251482,-1.25864,-0.641982,0.180762,-0.489906,-0.411274,-0.223749,0.266226,-0.554443,-0.388804,0.890378,-1.29077,-1.01906,0.159521,-0.311957,-0.350161,-0.103525,0.548571,0.00659677,-0.331422,0.865545,0.794576,0.110814,-0.973651,0.164343,-0.683143,-0.744764,0.151035,0.342667,0.287034,0.158859,0.13562,0.189934,-0.276953,0.423488,-0.523074,-0.0552975,-0.722148,0.186264,-0.766713,0.530051,0.923837,-0.502918,-0.582806,0.308535,0.110442,0.473548,-0.0521397,0.108654,-0.141136,0.0873399,0.19002,0.409173,0.201203,0.594333,0.321444,0.454233,-0.0296665,0.16635,0.00399364,0.288469,-0.229241,0.310323,-0.21752,0.00736308,0.280652,-0.0628061,-0.0997517,0.214396,-0.164944,-0.184354,-0.248464,0.0505957,-0.0122271,-0.389467,-0.0707875,-0.288474,0.0608238,-0.170326,0.382025,-0.0353058,0.287906,0.0461793,-0.323431,0.624388,-0.316643,-0.423082,0.318511,0.362753,-0.0921145,-0.00589038,-0.0344303,-0.330302,0.301309,0.0866209,-0.313978,-0.432456,0.577832,0.509674,-0.275308,-0.920924,0.12479,-0.388108,0.306451,-0.126492,0.183559,0.127806,0.0727442,0.312799,-0.0622799,0.253574,-0.240868,0.459451,0.216398,-0.188198,0.403572,0.0441878,-0.121669,0.176285,-0.531634,-0.245463,-0.0583603,0.0135878,-0.031017,0.0483219,0.295682,-0.281563,0.519228,-0.0492459,-0.139714,0.27038,0.124707,0.361084,0.0390254,0.514231,0.404237,0.353337,-0.576658,0.0912898,0.539242,0.129715,0.0877039,-0.185448,0.311811,0.166625,0.0648881,-0.284037,-0.631295,-0.570003,0.0524194,-0.0702161,0.16221,0.131646,0.00783114,0.0198533,0.174855,-0.312908,-0.121683,-0.516554,0.422925,-0.186451,-0.274246,-0.638463,0.196738,0.448624,0.377787,-0.0559445,-0.591007,0.0885869,-0.529295,-0.187915,0.133242,-0.0579977,-0.257962,0.0492925,-0.0950564,-0.0247978,-0.300895,-0.0274231,0.0923522,-0.0489082,-0.407024,-0.263717,0.0151012,-0.135708,0.412291,-0.221458,0.646119,0.0740567,0.322861,-0.0254602,-0.214966,-0.0968324,-0.510074,-0.109585,-0.0569947,0.148925,0.0249423,0.0906968,-0.414827,-0.00795028,-0.22908,-0.323969,0.329352,-0.409472,0.434179,0.286757,-0.0372621,-0.0226145,0.213041,-0.239436,-0.0347089,0.288982,0.198513,-0.528749,0.284736,-0.36152,-0.14508,0.150024,-0.230142,0.00876105,0.223473,-0.0399684,-0.698181,0.222031,0.351153,0.114554,0.975822,-0.322403,-0.280169,0.418808,-0.677834,0.103506,-0.0358183,0.117314,0.259822,-0.42378,0.0806922,-0.40525,-0.0184919,-0.313616,0.575782,-0.0104254,-0.271973,0.0583574,0.300681,-0.26259,0.517864,-0.187667,0.0122006,0.194298,0.162962,-0.489464,-0.0720612,-0.117185,0.1227,0.285309,0.202409,0.335868,0.279366,-0.286287,0.170623,-0.280865,-0.0432771,-0.0816586,0.328359,-0.102873,0.158818,-0.00192476,-0.294941,0.104625,-0.187007,0.0855124,-0.0826834,-0.056239,-0.499209,0.249766,-0.0211783,-0.17746,0.0351889,0.0255071,0.0949747,0.360432,0.30818,0.60036,-0.646014 +3455.93,1,0.0912059,4,1.65889,0.822678,-0.690092,0.200237,0.512805,-0.037884,0.14775,-0.0442995,0.206871,0.151624,0.218134,-1.10227,-0.0856158,0.307848,-0.174855,0.694727,0.0635334,-0.18448,-0.524005,-0.182566,-0.0259854,-1.03812,-0.53035,0.174516,-0.275572,-0.0781765,-0.24143,0.69706,-0.873397,0.0200468,0.973677,-0.696287,-0.469736,0.0923055,-0.414096,-0.191494,-0.700128,0.399436,0.607261,-0.170912,1.07322,0.543768,0.00787592,-0.693249,0.477892,-0.705312,-0.90285,-0.219923,0.347888,-0.0127928,0.345296,-0.269418,0.113378,-0.216219,0.96479,-0.193644,-0.176348,-0.381489,0.213922,-0.458223,-0.283717,1.09969,-0.83343,-0.957022,0.142841,0.0765681,0.325241,-0.084003,-0.136751,-0.112091,0.430942,0.446544,0.647305,0.548727,0.407309,0.299826,0.127041,-0.004283,-0.257705,-0.00966257,0.805092,0.153997,0.182465,-0.22636,-0.0770716,-0.252977,-0.0286781,0.302165,0.0887785,-0.474219,0.148609,0.0947113,0.0923518,0.18971,0.157501,-0.327826,0.446305,-0.324549,-0.200982,0.245779,-0.131782,0.300271,-0.199373,-0.368402,0.708472,0.609107,0.190553,-0.312683,-0.359089,0.265891,-0.584634,0.111774,-0.160922,0.317544,0.128322,-0.369905,-0.35879,0.162264,-0.106456,-0.245137,-0.611908,-0.0992785,-0.336404,0.0877272,-0.0770633,-0.0975749,-0.3111,-0.216571,0.0298741,0.0871116,-0.324878,-0.1218,0.314221,0.23781,0.176288,0.375696,0.186826,-0.219728,0.339321,-0.471298,0.0762557,0.0413196,0.364171,-0.114117,-0.0209816,0.0940401,-0.36753,0.254924,-0.378681,0.225243,0.39379,0.239889,0.344511,0.235761,0.540161,0.371275,-0.0184851,-0.200692,0.0735907,0.123316,0.225583,0.248396,0.327733,-0.157827,0.227554,-0.282736,-0.600497,-0.422448,0.0168385,-0.238527,-0.153444,0.265712,-0.140438,0.0441473,-0.153212,0.177591,-0.516469,-0.0129724,-0.0865192,0.492907,-0.0623555,0.114268,-0.345111,0.038,0.367351,-0.176222,-0.10531,-0.304538,0.208558,-0.0571639,0.30732,-0.0428489,-0.298969,-0.213548,-0.153703,0.0840963,0.256128,-0.413517,-0.0769054,-0.0959378,-0.172819,-0.154246,0.174327,-0.230837,-0.567048,0.168949,0.19018,0.452894,0.109447,-0.0169649,-0.347633,0.0478841,0.276788,0.106629,-0.655363,-0.0195101,-0.12676,-0.115211,-0.0530634,-0.388664,-0.13425,-0.0939709,0.129201,0.236728,-0.163211,0.357481,-0.214539,-0.141438,0.339454,0.0949699,-0.166893,0.0585884,0.245615,-0.288965,-0.36152,0.694452,0.37616,-0.0191783,0.303764,-0.842212,-0.0924262,0.16098,0.534572,-0.362616,0.169959,0.29265,0.062933,0.617294,-0.257364,-0.357777,0.251619,-0.288558,0.237609,-0.234644,0.110783,0.12945,-0.192487,0.201675,-0.374175,-0.118835,-0.226056,0.0733509,-0.0132319,-0.106424,-0.159773,0.360592,-0.291851,-0.178656,-0.189045,-0.0141433,-0.326041,0.0215273,-0.151636,0.358929,0.197923,0.428611,0.118589,-0.0430291,0.200681,0.020058,-0.595372,0.129158,0.349183,0.0719927,0.125621,0.177561,0.108666,-0.00791955,-0.04366,-0.096119,-0.119969,-0.00476603,-0.148187,-0.26688,0.463113,-0.52868,0.0113057,-0.0986154,-0.60059,0.0102061,0.0789606,0.0740154,0.181536,0.272058,0.426071,-1.31581 +3465.24,0.939833,0.0912059,4,1.624,0.612338,-1.06952,0.406472,0.648008,-0.0641618,-0.196524,-0.269499,0.714655,0.168537,0.12943,-0.271413,-0.505416,0.604733,-0.460141,1.27545,0.196078,0.205212,0.205841,0.100022,-0.135856,-0.939805,-1.21572,0.591156,-0.256103,-0.322486,-0.375063,0.0789236,-0.106965,-0.0707859,1.06589,-0.78858,-0.151498,0.363123,-0.206209,-0.122927,0.0575321,0.129228,0.570854,0.0589835,1.1088,0.621031,0.49153,-0.508251,-0.223386,-0.232987,-0.97593,0.152779,0.597968,0.131926,-0.412733,-0.301859,-0.0247368,-0.623889,0.883111,0.0814102,0.234868,-0.813417,0.632101,-0.439584,0.273596,1.12017,-0.317127,-1.06781,-0.271827,0.0057036,0.293635,-0.28323,-0.0198536,-0.459715,-0.00543906,0.181613,0.531161,0.046374,-0.146685,0.474885,0.153238,0.144853,-0.0120251,0.277248,0.33419,0.0950884,-0.0763354,-0.530203,-0.0172528,0.123889,-0.308093,0.190182,0.0935807,-0.255812,-0.36892,0.0418476,0.217242,0.129003,0.163508,-0.161705,-0.105804,0.203471,-0.33354,-0.152924,-0.0362958,0.0154783,-0.130019,-0.157329,0.416085,0.0277367,0.0224238,0.0277513,0.408126,0.749291,0.235395,0.252944,0.118966,0.432716,-0.260817,0.117975,0.0113362,0.189509,0.178544,-0.0893784,-0.366945,-0.00919168,0.438076,0.190407,0.15592,0.0881491,-0.393975,0.105262,0.143147,0.25046,0.280248,0.00309474,-0.0551206,-0.197914,-0.274296,-0.0361031,-0.00247062,-0.0482717,0.115763,0.319881,-0.351017,-0.3183,-0.0141228,-0.38732,-0.276997,-0.369798,-0.220462,0.371207,-0.409152,-0.156315,-0.822284,0.190497,0.395056,-0.000514484,-0.157711,0.267283,0.0691779,-0.0839683,0.0634236,-0.0325622,-0.253733,0.318436,0.426489,0.0379203,0.336302,-0.343473,-0.0422066,0.389481,-0.137907,0.0725753,0.384776,-0.17381,0.107277,-0.34306,-0.0865177,0.2212,-0.188088,0.113271,0.398367,0.124374,0.108835,0.0420695,0.444556,-0.0394235,0.103144,-0.905111,-0.393861,-0.0643444,-0.255727,-0.187449,-0.15032,0.031846,0.0977783,-0.410256,-0.000774714,-0.094356,0.0799518,-0.0209862,-0.55519,0.100692,-0.0487943,-0.283544,0.233107,-0.233934,0.340794,-0.116742,-0.330102,0.728888,0.184839,0.28525,0.343674,0.0360833,-0.124679,-0.308607,-0.0643808,-0.0762155,0.185791,0.065361,0.0454664,-0.245081,0.00457159,-0.43527,0.0505439,0.341616,0.0131411,0.257013,-0.214507,0.428757,0.0168624,0.0306499,-0.0511845,0.0695523,-0.61475,-0.166799,-0.337989,0.568164,-0.386185,0.0947167,0.228879,0.523908,-0.593548,-0.0996179,-0.664905,0.27437,0.213708,-0.367643,0.280396,0.310739,-0.118262,-0.617476,-0.0583432,-0.54604,0.484081,-0.10281,-0.117335,0.146141,-0.242308,0.285529,0.275951,-0.142589,0.0953285,-0.123863,-0.313925,0.0645681,0.283158,-0.200342,-0.368313,0.484191,0.283537,-0.167204,0.0378482,-0.0795005,0.0551438,-0.0948322,-0.24191,-0.562206,-0.120874,-0.0514989,0.261685,-0.126808,0.155839,0.284347,-0.0539071,0.0673157,-0.00535084,0.190202,-0.347649,0.509023,0.622709,0.134922,0.130134,-0.329309,-0.140708,0.299036,-0.591151,-0.259707,-0.128852,-0.308887,0.0757101,-0.234178,-0.0591398,0.0782017,0.453542,0.279646,0.673456,-1.41732 +3440.93,0.779862,0.0912059,4,1.47462,0.873023,-1.13295,0.398816,0.675863,-0.06488,0.335009,0.0888324,0.755426,0.345943,-0.0552624,-0.391172,-0.871287,0.253004,-0.328554,1.13588,-0.0308416,0.376571,-0.356465,-0.232802,-0.229998,-0.580971,-0.959524,0.333401,0.385457,0.000436873,0.167102,0.501643,-0.673429,0.116702,1.09711,-0.0452563,0.278636,0.117674,-0.142246,-0.244909,-0.202764,0.639722,0.789191,-0.453638,1.28732,0.683479,0.19578,-0.705036,0.0270526,0.619694,-1.08935,0.243418,0.480921,-0.229065,0.196875,0.636338,-0.115081,-0.209378,0.434514,0.280674,-0.292702,-0.562294,0.805986,-0.267803,0.511661,1.3274,-1.33601,-1.40275,0.215447,0.303983,0.105034,-0.149336,-0.237323,0.319033,0.224773,0.356638,0.840265,-0.221017,0.135143,0.526073,-0.162817,-0.0525305,-0.19109,-0.198794,0.412527,-0.0686164,0.0205748,-0.409676,-0.184651,-0.130136,0.242754,-0.207801,0.154291,-0.614969,-0.463178,0.0223298,0.0174835,-0.0373471,0.085613,-0.139231,0.19193,-0.459914,0.651026,0.150202,-0.107035,0.0328131,0.153646,0.233879,-0.573132,-0.196266,0.0770651,-0.583057,0.254901,0.306049,-0.604023,-0.216648,-0.111729,0.580632,0.117779,-0.238316,-0.695356,-0.124567,-0.0672898,-0.214051,-0.631861,-0.170667,0.110292,-0.13351,-0.0432486,0.452881,0.0746843,-0.152765,0.331779,-0.438764,0.0950639,-0.0127802,0.431734,-0.0497771,0.223439,-0.487323,-0.321599,-0.0758017,0.434455,-0.436366,0.173891,-0.145277,-0.16344,-0.110304,0.0295671,-0.131356,-0.228586,0.169906,-0.246027,0.00690003,0.678886,0.0322257,-0.128995,0.3036,0.366632,0.104145,0.0147046,-0.0325822,-0.133857,-0.205555,0.58489,-0.232845,0.576862,0.0164333,0.0973252,0.0975011,-0.0997645,-0.027132,0.0419855,0.196961,0.600801,-0.342811,0.0967026,-0.622751,0.0425774,-0.479852,-0.352511,0.0605366,-0.319096,0.275263,-0.222242,0.0697661,0.2492,-0.0521988,0.0330533,0.260168,-0.207522,-0.0736603,0.554003,-0.442782,0.299343,0.177372,-0.488273,-0.349291,-0.468539,0.368347,0.188339,-0.373319,-0.339611,-0.0499458,-0.33501,-0.2249,-0.34711,0.609334,-0.192106,0.0933324,-0.129875,0.439875,-0.109385,0.18252,0.125773,-0.0760859,0.358958,0.496459,-0.0189244,0.181394,-0.498126,-0.222065,0.245883,-0.0346328,0.332049,0.327462,0.108935,0.364013,-0.5959,0.12906,-0.488625,-0.468792,0.103944,-0.0632152,-0.366452,0.309724,0.214084,-0.0684365,0.11062,0.131035,0.257016,-0.171392,0.301254,-0.519367,-0.549459,-0.0159628,-0.0721676,-0.152532,-0.452454,0.104515,0.320935,-0.183506,0.547719,-0.193123,-0.213635,-0.425514,0.394731,-0.0718234,-0.118368,0.188052,-0.378992,-0.0144387,0.150304,-0.178911,-0.200862,0.738859,0.340247,0.0671604,0.136317,0.742841,-0.231903,-0.510719,-0.123662,0.416281,0.284407,-0.00615474,-0.582425,0.228065,0.0910373,0.134318,-0.0345547,-0.160487,-0.224769,-0.182256,-0.149692,-0.356119,0.0274622,-0.110844,0.00623152,0.112257,0.604639,-0.0489298,-0.220279,-0.32998,0.179632,0.106044,0.123887,0.251472,-0.0851134,0.00385827,-0.0253209,-0.0343584,-0.0498505,0.111227,-0.346256,0.0976661,0.24397,0.312516,0.493933,-2.07929 +3439.98,0.931054,0.0912059,4,1.58274,0.971247,-0.78406,0.240213,0.824096,-0.191752,-0.20146,-0.0544973,0.156682,-0.00801278,0.299961,-0.0461026,0.260967,0.255574,-0.215026,0.986952,-0.269398,0.129984,0.0556334,-0.269447,-0.0422236,-1.26109,-0.37333,0.305156,-0.61916,0.389149,-0.333081,0.422809,0.261468,-0.227386,0.732808,-0.550404,-0.30125,0.116583,-0.293304,-0.0940856,-0.153007,0.0794227,0.454562,-0.125228,0.977982,0.155821,0.528606,-0.373299,-0.327286,-0.263529,0.166088,0.448586,0.48474,0.0219357,-0.0366656,0.0813584,0.0555876,-0.0915295,1.139,-0.649061,-0.298092,-1.19465,0.341148,-0.21704,0.22402,1.15381,-0.336686,-0.616794,-0.16896,-0.208326,-0.0046811,0.163055,0.258927,-0.873518,-0.25401,0.119998,0.408712,0.0813462,0.280515,0.553908,0.157649,-0.0198511,-0.0893632,-0.123437,0.384083,-0.359324,-0.21989,0.115569,-0.175862,0.0700956,-0.268646,-0.329544,0.0613299,-0.341426,0.171817,0.12829,0.24646,-0.0256103,-0.0063951,-0.343713,0.0468273,-0.227648,-0.476017,0.0271835,0.504486,-0.00416029,-0.571994,-0.423033,0.551069,-0.138423,0.115967,-0.0342702,0.705389,0.73918,0.721048,0.257955,-0.0160768,-0.259367,-0.0684726,0.368623,0.391177,0.292323,0.241694,-0.242404,-0.641545,0.0964815,-0.183895,-0.0999215,-0.134519,-0.20692,0.116938,-0.0735231,-0.0308646,-0.0683152,0.207584,0.171832,-0.299192,0.489633,-0.0766208,-0.0132217,0.344797,-0.229781,-0.155831,-0.0081758,-0.524334,-0.382636,0.20593,-0.681073,0.144703,0.257796,0.141824,0.627566,-0.404135,-0.428126,-0.626195,0.298552,0.380796,-0.309223,-0.0404708,0.381654,0.138911,0.128424,-0.0376127,0.359234,-0.238047,0.251705,0.717899,0.114965,-0.0317219,-0.203172,-0.136651,-0.314146,-0.16779,-0.295593,-0.0886409,0.269664,-0.254637,0.673114,-0.0317721,0.533942,-0.0467837,-0.316071,0.337238,0.215065,0.498054,-0.377377,-0.269264,-0.155562,-0.00990319,-0.705503,-0.185691,-0.3139,-0.0869584,0.169825,-0.0379726,0.0287688,0.172796,-0.242749,0.188376,0.148088,-0.0187045,-0.341082,-0.178567,0.237686,-0.239749,-0.256061,0.0249424,-0.48072,0.145668,-0.346407,-0.200478,0.90272,-0.00466247,0.0083624,0.151713,-0.0295401,-0.15389,-0.333887,0.188418,0.225824,0.228654,0.190888,0.180425,-0.207823,-0.367968,-0.73795,-0.247496,-0.1638,0.0201473,0.247076,0.287411,0.256272,0.300999,0.267632,0.163023,-0.329016,-0.40079,-0.187543,-0.14905,0.654924,-0.283934,0.0567469,-0.0643428,0.441781,0.48215,0.0977189,0.083323,0.132972,0.686154,-0.0318272,0.453644,0.281397,-0.464973,-0.146604,0.17579,-0.565612,0.63527,-0.438034,0.141292,0.320777,-0.289186,-0.162071,-0.323687,-0.175013,0.231104,-0.52233,-0.201983,-0.112845,0.073708,-0.398765,-0.210907,0.320583,0.342074,-0.117164,-0.368667,-0.208384,0.289262,-0.0970264,-0.00334499,0.116143,-0.0181846,0.28372,0.15894,0.0536341,-0.0863212,-0.0580985,-0.286298,-0.00232574,-0.0564703,0.332448,-0.642737,0.426261,0.638859,-0.0472474,-0.145541,-0.0333205,-0.0301906,0.212233,0.0156103,-0.584101,0.0472913,-0.413906,0.0500676,-0.177896,0.614113,0.102622,0.383362,0.320347,0.619162,-2.63811 +3442.67,1,0.0912059,4,1.60161,0.953448,-0.786252,0.260335,0.763154,-0.164916,-0.265315,-0.00740047,0.130106,0.0809599,0.240353,-0.127341,0.262276,0.197987,-0.140338,1.04822,-0.281698,0.0384347,0.116945,-0.10599,-0.0688405,-1.25058,-0.698255,0.26522,-0.594014,0.410907,-0.203007,0.476745,0.308875,-0.228303,0.764083,-0.444929,-0.210883,0.0918512,-0.248015,-0.0913931,-0.158894,0.0346996,0.329881,-0.0499498,1.03068,0.301322,0.500682,-0.441934,-0.331486,-0.343375,0.139931,0.440149,0.435086,-0.0386819,-0.0669309,0.0521944,0.00703927,0.0688736,1.03834,-0.601391,-0.266757,-1.26883,0.384822,-0.180844,0.146192,1.13311,-0.479391,-0.820912,-0.145736,-0.301317,0.0153979,0.197215,0.215239,-0.968219,-0.286413,0.0371949,0.389368,-0.00661535,0.252666,0.569227,0.121116,-0.0133223,-0.121294,-0.174937,0.292674,-0.365353,-0.189329,0.0300166,-0.121222,0.0252115,-0.348061,-0.342344,-0.0732423,-0.468633,0.103827,0.118686,0.26137,0.0125745,-0.0118149,-0.313536,-0.081943,-0.208007,-0.43393,0.0925397,0.498314,0.0658856,-0.596541,-0.404882,0.552088,-0.15488,0.121493,-0.0450857,0.812043,0.611552,0.713615,0.250489,0.157911,-0.269121,-0.0515431,0.426763,0.256923,0.261963,0.298626,-0.406298,-0.601386,0.107666,-0.0961849,-0.0914874,-0.130863,-0.261136,0.158876,-0.0255746,0.0798062,-0.0266191,0.372255,0.0629982,-0.364596,0.47105,0.0273851,-0.00813642,0.257197,-0.235043,-0.150803,-0.126006,-0.577982,-0.357344,0.287763,-0.637139,0.133494,0.214919,0.136217,0.61375,-0.28489,-0.320029,-0.650731,0.26349,0.42338,-0.302592,0.0136567,0.458046,0.152631,0.177285,0.00423726,0.395993,0.0523683,0.234778,0.647013,0.150394,-0.0466915,-0.240646,-0.19532,-0.298926,-0.0630149,-0.324139,-0.107463,0.316201,-0.234454,0.656569,0.0144317,0.680725,-0.121572,-0.386251,0.273618,0.199716,0.535195,-0.347541,-0.114125,-0.245548,-0.0304639,-0.51401,-0.144556,-0.332096,0.0215975,0.210424,-0.136148,0.0486888,0.0791066,-0.311023,0.130877,0.0968441,-0.0447725,-0.332258,-0.198947,0.0812691,-0.280345,-0.260727,0.0954788,-0.570762,0.15139,-0.201141,-0.247121,0.931086,-0.0438589,0.133511,0.1971,-0.0962015,-0.0724791,-0.483918,0.153156,0.321455,0.205701,0.114798,0.220262,-0.1423,-0.410423,-0.667497,-0.0743563,-0.254533,0.0208695,0.135142,0.257385,0.205449,0.158591,0.251262,0.227842,-0.350126,-0.426795,-0.11782,-0.231831,0.641947,-0.127315,0.0982071,-0.029238,0.398998,0.426352,0.128392,0.130484,0.137568,0.569976,0.0385468,0.491381,0.147883,-0.463949,-0.0232024,0.0996399,-0.518748,0.629965,-0.468921,0.160386,0.30151,-0.301197,-0.21355,-0.433442,-0.147275,0.255241,-0.434118,-0.197517,-0.0271285,-0.0570511,-0.40609,-0.0459027,0.311627,0.183582,-0.106857,-0.388402,-0.142227,0.326777,-0.0197876,-0.147403,0.0926023,0.00419498,0.225876,0.264535,0.116268,-0.17117,-0.0589282,-0.289243,-0.050942,-0.0646612,0.464589,-0.703498,0.409227,0.687073,0.000584169,-0.256984,-0.0233787,0.0331488,0.296478,0.102368,-0.528054,-0.019445,-0.419925,-0.0359301,-0.0373549,0.617564,0.101041,0.403363,0.317869,0.635108,-2.4101 +3464.27,0.999186,0.0912059,4,1.61762,0.848451,-1.25409,0.418704,0.747996,-0.102538,0.268923,0.209186,0.16998,-0.398283,-0.0341165,-0.310535,-0.611854,0.216033,-0.5046,0.698062,-0.0696122,-0.0846255,-0.498363,-0.130963,-0.125359,-1.08025,-0.748945,0.103368,-0.568001,-0.0688229,0.0216369,-0.0923087,-1.04046,0.0108511,0.757832,-0.55774,0.262984,0.456353,-0.162294,-0.0429994,0.0545831,1.01464,0.561134,-0.387393,0.953493,0.324873,0.316183,-0.627449,0.3023,0.133548,-0.479338,0.0644534,0.284574,-0.155889,-0.0974138,0.336442,0.119162,-0.613562,0.79181,-0.421125,-0.144432,-0.690278,0.246937,-0.185348,0.144866,0.942285,-0.401614,-0.732519,-0.0669391,0.139865,-0.300197,-0.11324,-0.0735988,0.262865,-0.0129928,0.61191,0.539553,0.114132,-0.0130845,0.3565,0.112282,-0.072657,-0.45025,-0.0701055,0.712618,-0.120996,0.072214,0.125056,-0.616611,0.137707,0.0152431,-0.0341684,0.320428,-0.248372,0.00129149,-0.330095,-0.0878709,0.206731,-0.0917558,-0.162902,0.0264644,0.342662,0.263666,0.136308,0.00648696,-0.199879,0.0155441,-0.0576019,-0.166139,-0.330882,0.00443033,-0.226853,0.254536,0.610241,-0.187498,-0.509551,0.217868,0.36424,0.300789,0.03922,-0.54729,0.256666,-0.539429,-0.0276833,-0.416799,-0.296403,-0.224236,0.211451,0.125619,-0.0651002,0.306948,0.530834,-0.00185368,-0.25376,-0.737421,-0.183942,0.170649,0.149502,-0.146829,-0.0718099,-0.154189,-0.047794,0.402465,-0.202446,0.197476,0.0310035,0.355034,0.0467,-0.0371232,0.00768971,0.0197631,0.276069,-0.0407422,-0.326028,-0.373031,-0.189135,0.0525844,0.0446648,0.450755,0.134692,0.0831007,-0.0768595,-0.143561,-0.510742,-0.166398,-0.0528147,0.540666,-0.334906,-0.472895,0.104619,0.192769,0.348933,-0.090967,-0.135784,0.53827,-0.124419,-0.452239,-0.0330513,0.178421,-0.0660807,0.221951,-0.0172034,0.171151,0.874648,-0.160434,0.105367,0.58519,-0.0165941,-0.0906279,-0.0432032,0.00821855,-0.333718,-0.199902,-1.0276,-0.111377,-0.186271,-0.303101,-0.639075,-0.0278463,0.173762,-0.121331,-0.421642,-0.124303,-0.142576,-0.145845,0.173493,-0.141483,0.347741,0.207937,-0.237412,-0.18179,0.847627,-0.297663,0.145901,-0.131146,-0.220084,0.322753,0.119531,-0.415594,0.363632,-0.182153,0.246501,0.307341,-0.184482,0.434104,-0.0781479,-0.166891,0.128977,-0.673206,0.372945,-0.349605,-0.323672,0.396745,-0.0262349,-0.600997,-0.155106,0.139023,-0.18291,-0.0908633,0.613032,-0.303681,-0.240081,0.590494,-0.691454,-0.427981,-0.140784,-0.149218,-0.215128,0.0415497,0.402391,0.302209,0.216677,0.667094,-0.461129,0.0553689,-0.834287,0.239556,0.0387594,0.0753688,-0.198426,-0.412253,0.443635,-0.0968791,0.021595,0.157765,0.383335,0.252424,0.541994,0.246737,0.209121,0.200455,-0.263335,0.0718135,-0.272435,0.195101,-0.380806,-0.69727,0.0522541,-0.16796,-0.00131208,0.218321,0.0754708,0.121812,0.0891515,0.32325,-0.134946,-0.466591,-0.028826,0.100452,-0.0887794,0.628258,0.242917,-0.35598,-0.286451,-0.101761,0.590178,0.23254,0.155567,0.325775,-0.14233,0.305327,0.125102,-0.1946,-0.135405,-0.308749,0.101242,0.140378,0.318185,0.37467,-2.07811 +3428.08,0.813138,0.0912059,4,1.5025,0.627668,-1.45416,0.540463,0.286866,-0.198795,-1.0776,0.0151115,-0.2683,-0.0721805,0.0375614,-0.505468,-0.421498,0.669337,-0.143389,0.683654,0.375277,-0.172578,0.4509,0.326521,-0.0181109,-1.07564,-1.09868,0.477115,-0.594172,-0.313476,-0.722804,-0.0959012,0.00678479,0.0757723,0.715692,-0.759194,-0.410094,0.470079,-0.457575,0.625807,-0.426002,0.62648,0.613579,0.186903,1.08961,0.640593,0.607943,-0.249097,-0.344333,-0.147352,-0.764237,0.00977308,0.652647,0.493496,0.237605,0.55525,0.257162,0.411294,0.879647,-0.172366,-0.0901171,-0.726231,0.360197,-0.623976,0.30426,1.02555,-0.340296,-0.892046,0.323426,0.255951,-0.587509,-0.188798,0.31261,-0.907549,0.369069,0.11897,0.503923,-0.321172,0.390838,0.466918,0.409853,-0.394581,-0.360555,0.144513,0.305509,0.0212871,0.291157,-0.191312,-0.0590409,0.058203,0.0745854,-0.214176,-0.193472,-0.074112,0.0845279,0.111697,-0.127158,0.23454,-0.291938,-0.635006,-0.125862,-0.837652,-0.11208,0.342537,0.252785,-0.00660569,-0.547743,-0.0437163,0.100621,0.133664,0.701976,-0.265847,0.176104,0.35062,0.105688,0.289663,-0.230172,0.346266,-0.261634,-0.157151,-0.0498824,0.191415,0.942219,0.258786,-0.564507,0.158378,-0.0167774,-0.626258,-0.105424,0.0385044,0.2966,-0.0162444,0.520386,-0.614292,0.99751,0.147411,0.0534931,0.469467,-0.176467,0.0141663,-0.240006,-0.661121,0.247308,-0.444589,-1.09101,-0.078466,0.0163112,-0.927309,0.27827,0.440751,-0.180453,-0.0760548,0.148016,-0.119465,0.0618404,0.270944,0.565094,-0.211417,-0.0937054,0.144018,0.226288,0.0930189,0.226295,0.499103,0.549439,-0.00216499,0.772584,0.210739,0.589391,0.27869,-0.336551,-0.603127,0.0374039,0.164221,-0.411466,0.0249993,0.0371497,-0.23989,-0.135547,-0.0897098,-0.381781,0.10372,-0.0340583,0.357656,0.220539,-0.16544,-0.15063,0.0526998,-0.240435,-0.358049,-0.433951,-0.00684561,0.697959,0.590209,0.00515313,0.153169,-0.00950839,-0.188888,0.346348,-0.229096,-0.308174,-0.112631,0.0566117,-0.0474549,0.0469346,-0.368866,0.640757,-0.405946,-0.299493,0.197727,-0.9381,1.32734,0.321152,0.0452046,-0.215379,0.318905,-0.335532,0.0984183,-0.260999,-0.0978703,-0.544273,0.0799509,0.478652,-0.789161,-0.6053,-0.49413,0.370039,0.323236,0.320559,0.220136,-0.155333,-0.0777932,-0.307446,0.0941303,-0.215932,-0.118456,-0.394633,-0.0989894,-0.0776422,0.56665,0.238425,0.207864,0.430999,-0.264217,-0.188097,0.149937,0.185946,0.0320292,0.236779,-0.310688,0.70004,0.188103,-0.64491,-0.0707944,-0.117749,-0.49775,0.541695,-0.124398,-0.432154,0.0875392,-0.096694,0.311367,0.440092,0.225712,0.426044,-0.0353818,-0.111516,0.101003,0.0121463,0.168955,0.212627,-0.0483152,-0.193197,0.291296,0.098313,-0.629682,0.42613,-0.230945,0.111936,-0.0802622,0.0704297,-0.0100084,-0.0393646,-0.123721,-0.282149,-0.388539,0.0622767,0.17902,-0.113337,0.260939,-0.787067,0.340985,0.517783,0.164544,-0.026683,0.0341732,-0.0814147,0.39116,0.0771405,-0.732753,-0.148297,-0.0466869,-0.0967277,-0.473895,0.452302,0.150944,0.430156,0.388515,0.655863,-0.258334 +3420.09,0.923314,0.0912059,5,1.5195,0.521947,-2.08304,0.801556,0.816775,-0.0880727,-0.488451,-0.160816,-0.070339,-0.0392759,0.331931,-0.292915,-0.876337,0.344389,-0.481271,0.337555,-0.303347,0.128604,0.00124893,0.373968,0.354983,-0.720457,-0.757126,0.521655,-0.619709,0.135368,-0.399231,-0.150087,-0.243878,0.207878,0.716728,-1.24521,0.112862,0.259693,-0.279746,0.234861,0.0665128,1.57812,0.589474,0.151181,0.863435,0.3522,0.318055,-0.0313928,0.245086,-0.197674,-0.637303,-0.0616212,0.774601,-0.00535589,0.488231,0.619169,0.227861,-0.548482,1.11617,0.104755,-0.0980454,-0.765123,0.652546,-0.31393,0.262084,1.57029,-0.837671,-0.664978,-0.461881,0.501192,0.300291,0.192934,-0.452853,-0.642377,-0.132529,0.241707,0.632549,0.0902139,0.686939,0.823173,0.222193,-0.380801,-0.365247,-0.359268,0.870993,-0.00845774,0.372387,-0.362216,-0.363522,0.214861,-0.362975,-0.556765,-0.09421,-0.359042,-0.532579,0.126934,0.136434,0.195319,-0.250497,-0.270744,-0.080816,-0.345606,-0.445771,0.683764,-0.468205,0.242253,-0.690351,0.416458,0.579522,0.104039,0.822617,-0.401904,0.43869,-0.135273,-0.125171,-0.224399,0.197417,-0.0312889,0.699702,-0.151637,-0.43665,0.281383,0.352872,-0.0356797,-1.01006,0.0390409,0.342861,0.000715321,-0.404243,0.0591835,0.125477,-0.00897087,0.208197,-0.445502,0.109845,-0.104073,0.45115,-0.0129833,0.193832,-0.0308863,-0.731894,-0.230373,0.258025,0.0590228,-0.331167,0.0443546,0.243665,-0.542721,0.252606,0.308165,-0.0818598,0.399996,0.273597,-0.371235,-0.942963,0.0168258,0.561956,-0.118236,0.245994,-0.413161,0.660868,0.083084,-0.0517443,0.149693,0.266884,-0.111814,0.539289,0.0893659,-0.146991,-0.0614414,-0.442784,0.124991,-0.249989,0.224803,-0.0476315,-0.385365,-0.576984,0.258535,0.0655692,-0.584716,-0.0264773,-0.181445,0.270734,0.444686,0.259457,0.489322,0.99814,0.424112,0.122518,-0.0992186,0.00662393,-0.0847147,0.162013,-0.0920582,-0.124047,0.207678,0.43226,0.0634219,-0.110389,0.275478,-0.577959,-0.344961,-0.152914,0.0504611,0.245339,-0.217627,0.0959144,0.452204,0.283878,-0.163107,-0.526919,1.11591,0.167812,0.0274741,0.421801,0.120919,-0.239847,0.334281,-0.757026,-0.0325046,-0.483833,0.246216,0.810652,-0.0242383,-0.279335,-0.22604,0.393502,0.692958,-0.0796322,0.013187,-0.608518,-0.204412,-0.642768,0.201802,-0.379638,-0.25985,-0.66603,0.0985828,-0.513647,0.39821,-0.18599,0.227223,0.290233,-0.695754,-0.512257,0.398066,-0.0316211,0.0194725,-0.0118082,0.148172,0.551551,0.232222,-0.722984,-0.349247,0.496773,-0.815774,0.487372,-0.198517,0.0601149,0.0505694,-0.140006,0.379625,0.592062,0.208686,0.524539,-0.142323,-0.477273,0.14832,-0.110765,0.231315,0.229643,-0.600514,0.0584198,0.0860791,-0.255156,-0.0489537,-0.534177,-0.268993,0.479663,-0.716671,0.396835,0.467847,0.536012,-0.358254,-0.163316,-0.0704141,0.0972329,-0.0682875,-0.0859676,0.423713,-0.0121654,0.320995,0.127734,-0.165079,-0.230144,0.204965,0.105926,0.638003,-0.139046,-0.242219,0.0698561,-0.159891,0.23956,-0.0507662,-0.180064,0.136191,0.259522,0.36904,0.509434,-1.75847 +3423.98,0.654227,0.0912059,5,1.50101,0.728986,-0.928695,0.39687,0.685943,-0.196028,-0.2206,-0.0732323,0.22609,-0.215227,0.414075,0.0721788,-0.051458,0.605044,-0.165273,0.537487,0.524835,0.288672,-0.133411,0.0671329,0.164516,-0.540452,-0.971021,0.563941,0.194958,-0.155329,0.201709,1.23309,-0.636374,0.30516,1.13505,-0.235823,-0.520607,0.415979,-0.1307,-0.454984,-0.570033,-0.273681,0.718196,-0.140796,0.912706,0.787158,0.0493624,-0.569798,-0.14502,-0.409099,-0.580522,0.265817,0.525781,0.0364404,0.33303,0.443824,0.1251,-0.133046,0.634823,-0.551695,-0.277403,-0.463352,0.85532,-0.700876,0.248959,1.16304,-0.364991,-1.42542,0.177642,0.125202,-0.507007,-0.320583,0.558236,-0.161298,-0.192436,0.388331,0.453006,-0.154951,0.472996,-0.144024,-0.00568832,0.295479,-0.244639,0.180493,0.246759,-0.306173,0.0943114,-0.0236766,0.131421,-0.512177,-0.0428016,0.13139,-0.0018084,-0.543751,0.317834,0.122817,-0.0645746,-0.0515743,0.134469,-0.257952,-0.156796,-0.130928,0.209313,0.0516501,0.491765,0.0200104,0.0620806,-0.919889,0.157201,-0.430015,-0.444676,-0.357868,0.210037,0.679028,0.047023,-0.00727013,0.168474,0.497093,-0.649867,0.472511,-0.289841,-0.359307,0.0205713,-0.184352,-0.450834,0.0942548,-0.622679,-0.128387,0.733525,0.246213,0.201552,0.0811054,0.129998,-0.422616,0.139704,-0.17197,-0.357285,0.915401,-0.609772,-0.490873,0.770001,-0.161268,0.26933,-0.79774,-0.0937755,0.0189768,-0.135489,-0.484221,-0.260362,-0.445716,-0.11387,0.0929884,-0.459987,0.0975924,0.819515,0.286655,-0.162128,-0.100226,0.270186,0.815126,-0.445152,-0.400446,0.318515,-0.213906,0.311037,0.147109,0.819485,0.199149,0.393128,0.383749,-0.051027,-0.123037,-0.42189,-0.276525,0.42159,0.285419,0.159924,-0.262569,0.0608861,0.540343,-0.633311,-0.141219,-0.116891,0.591477,-0.0103141,-0.782333,-0.531117,-0.351615,-0.254659,-0.539888,-0.478182,-0.500309,-0.0921977,-0.448184,0.0758288,-0.0449191,-0.384155,-1.06297,-0.131875,0.0908102,0.47753,-0.386943,-0.657846,0.236831,-0.333326,-0.406796,0.118293,-0.603888,-0.822282,-0.0766599,-0.304326,0.844039,-0.0716335,0.413055,-0.354232,-0.253668,0.360669,-0.114582,0.150612,0.427251,-0.193201,-0.0189782,-0.384889,-0.385326,0.29719,-0.547074,-0.344329,-0.190515,-0.470767,0.397092,0.0472043,-0.536582,0.428488,-0.106158,0.170605,0.21749,0.584677,-0.275727,0.0979993,0.328673,0.295592,-0.297696,0.388802,0.272193,0.343419,-0.119242,0.278397,-0.0337205,0.636334,0.0910126,0.305928,-0.0962099,0.67812,-0.22105,-0.367931,-0.120326,0.28824,-0.353145,-0.209754,0.381123,-0.414308,0.0188905,-0.238721,0.0838424,-0.256261,0.557099,0.527347,-0.161069,0.439359,0.0129665,-0.0521826,0.317331,0.181698,0.0888976,0.24893,-0.345916,0.334822,0.311791,-0.482383,0.389574,0.152215,-0.492604,0.364185,0.53162,0.0861746,-0.052271,-0.547924,0.250857,0.00504915,0.187088,-0.356243,0.163686,0.211579,-0.324088,0.42913,0.0124595,0.199893,-0.104966,-0.0533782,-0.232056,-0.0758076,-0.133156,-0.217562,-0.160361,0.309568,0.142192,0.46994,0.377083,0.685522,-1.9044 +3421.25,0.966884,0.0912059,4,1.57212,0.696478,-1.42871,0.603633,0.663099,-0.174604,-0.329172,-0.0753294,0.0528432,-0.178344,0.477878,0.184322,-0.279971,0.714783,-0.14046,0.591782,0.566593,-0.195811,-0.460839,-0.533994,0.0189069,-0.651065,-0.987923,0.448061,-0.0925641,0.0317006,0.411717,0.485897,-0.512132,0.334149,1.0093,-0.381788,0.287743,0.427066,-0.13048,-0.137568,0.119309,0.584998,0.147667,-0.417519,1.01156,0.758524,0.384384,-0.857504,0.354929,-0.000940884,-0.159974,-0.0742035,0.447372,-0.07219,0.247084,0.298422,-0.00301753,0.153678,0.611918,-0.371488,-0.237764,-1.07276,0.413828,-0.186622,0.574272,0.705432,-0.376722,-1.61629,0.0549757,0.145072,-0.276553,-0.0486115,0.856251,-1.15561,0.30305,0.171183,0.280785,0.0441999,0.718694,0.462515,0.00581554,-0.129591,0.00968679,0.0720955,0.216468,-0.0156959,-0.0597778,-0.152731,-0.165383,-0.447766,-0.332229,0.375184,-0.41636,-0.444818,0.327424,0.487688,0.198498,-0.00852065,0.225407,0.0490298,0.0482993,-0.284207,0.792155,0.18266,0.095654,0.0343628,-0.668165,-0.634909,0.394848,-0.885741,-0.0433085,-0.171347,0.630779,0.249171,-0.339436,0.154537,0.0190305,0.425783,-0.120431,0.302466,0.0253931,-0.399177,0.480764,-0.0948273,-0.230862,-0.046694,-0.192048,-0.145549,-0.400478,-0.0372216,-0.372545,-0.0786259,-0.0102761,-0.679809,-0.275944,-0.488105,-0.849244,0.630795,-0.373937,0.0707462,0.427607,0.330941,0.0803975,-0.269207,-0.182768,0.0218223,0.047752,-0.237702,-0.0391052,0.056178,-0.0252776,0.527411,-0.0761099,-0.266076,-0.227183,-0.105481,0.206028,0.0506365,-0.0109774,0.879613,-0.167166,-0.229685,0.319987,0.0426773,0.170198,0.0570361,0.482107,-0.36487,0.169162,0.412319,-0.312519,-0.0104959,-0.34475,-0.174559,-0.00327388,0.217948,-0.0123534,-0.185567,-0.00538111,-0.291581,-0.0427954,-0.255205,-0.225754,0.883775,-0.117563,-0.703629,0.0748556,0.548257,-0.664938,-0.401161,0.224872,-0.229731,0.206464,-0.42634,-0.0198742,-0.0316309,-0.465283,-0.607809,0.139857,0.124286,0.250351,-0.0993818,-0.239483,0.685171,-0.130702,-0.539368,0.536398,-0.25885,-0.839947,-0.148197,-0.627942,0.715559,0.142462,0.529732,0.14431,-0.468224,0.176464,-0.350112,-0.345299,0.150318,-0.419744,0.16665,0.0949054,-0.542032,-0.0254628,-0.861247,0.322795,0.246907,-0.11591,0.270001,-0.267492,-0.583421,0.292616,-0.0610501,0.114723,-0.00879691,0.132685,0.248515,-0.353603,0.475322,-0.0567539,0.211691,-0.0958265,-0.376787,-0.653463,0.213885,0.439945,0.181884,0.0870618,0.172136,0.0994433,-0.0435339,0.0694606,-0.50214,-0.39742,-0.816317,0.0253518,-0.0506046,-0.065562,0.923554,-0.216548,0.0667044,-0.200305,0.197161,-0.217916,-0.154557,0.0764659,-0.297,0.834302,0.397039,0.100379,-0.0401437,-0.14162,0.0973688,-0.172497,-0.110876,0.546911,0.0247565,0.119688,0.248683,0.0319783,-0.336138,0.451668,0.199567,-0.23756,-0.199853,-0.0203887,-0.154251,-0.191307,0.510543,-0.366271,-0.568325,0.119351,-0.601238,-0.0729623,0.294991,0.232657,0.659145,-0.424294,-0.771384,-0.382723,0.564137,-0.0161725,-0.862258,0.500796,0.129758,0.241247,0.36022,0.491169,-1.63871 +3424.17,0.909506,0.0912059,4,1.51333,0.540311,-1.3105,0.544371,0.634037,-0.198182,-0.0681262,-0.346131,0.321056,-0.360518,0.687551,0.141556,0.108922,0.648689,0.0319695,0.359186,0.281179,-0.0296555,0.0627894,-0.0366242,0.216446,-0.818391,-0.68226,0.668291,0.291128,-0.0362733,0.412872,0.625109,-0.386787,-0.0886639,1.07057,-1.24919,-0.332749,0.529729,0.00149706,0.000229525,0.020773,0.0504018,0.651428,-0.258088,0.749561,0.911618,-0.511893,-0.0421691,0.126804,-0.112705,-0.785619,0.492034,0.567812,0.0693934,0.449438,-0.566706,0.305761,-0.230722,1.00741,-0.441142,-0.331208,-0.830783,0.581622,-0.336437,0.650737,0.902051,-0.769743,-1.07208,0.190745,-0.279924,0.160979,-0.449207,-0.328091,-0.833685,-0.770733,0.121303,0.347489,-0.00856245,0.604564,0.0299984,0.216718,-0.177142,0.223035,-0.205916,0.747783,-0.223983,0.053987,-0.245496,-0.194301,-0.238618,-0.346543,-0.302779,-0.186578,-0.356308,-0.391539,-0.0612917,0.0149527,-0.0248796,-0.174492,-0.560776,0.316348,0.116249,0.413134,0.110451,-0.335641,0.471619,-0.67358,-0.697657,0.288508,-0.679751,0.266362,-0.221358,0.321658,0.14274,0.223385,0.108644,0.194196,0.335857,0.530142,0.108008,-0.560605,0.116573,0.0432666,0.0275259,0.102499,0.224464,0.29964,0.187371,0.38141,0.777277,0.347961,0.0304584,0.015146,-0.900686,-0.25937,0.144602,-0.176794,0.760255,-0.11458,-0.0518884,-0.0352947,0.300915,0.505563,-0.599396,-0.482317,-0.0760906,-0.381422,-0.479869,-0.190536,-0.0109619,-0.493923,0.427901,-0.174706,-0.409537,0.207853,0.216442,0.018276,-0.135421,0.313675,0.10336,0.370365,-0.307344,0.263188,0.0470054,0.245094,0.331085,0.38416,-0.402165,-0.225607,0.0014276,-0.246256,0.091744,-0.164131,0.00695493,-0.175165,-0.21341,-0.0115309,-0.0530987,0.134345,0.685394,-0.141658,-0.145959,-0.258962,0.829942,0.179464,0.0228246,0.814278,-0.389891,0.502117,-0.166582,-0.365443,-0.89153,-0.166191,-0.331997,0.127785,0.301403,0.0381184,-0.0696604,0.210521,0.312574,0.532458,-0.0349738,-0.913332,0.110237,0.167341,-0.818073,-0.0530545,-0.358497,-0.428273,-0.369344,-0.403662,0.874428,0.357438,-0.272334,-0.227222,-0.448313,-0.0169546,-0.0633782,-0.318501,0.460487,-0.298234,0.487873,-0.204234,0.0597052,-0.403339,-0.925915,-0.193729,0.535209,-0.217215,0.395021,0.314899,-0.228227,0.476534,-0.248368,-0.235271,0.0134216,-0.705132,-0.179107,-0.499179,0.299787,0.0873364,-0.484029,0.585279,-0.809706,0.778023,-0.375242,-0.117236,0.47414,0.252012,0.31016,0.41511,0.0647285,0.022333,-0.306313,-0.193344,-0.526858,0.480203,0.456179,-0.303596,0.597584,0.287714,0.156011,-0.228006,0.342976,-0.288227,0.155091,-0.686561,0.21587,0.487915,-0.0641205,-0.0455536,-0.0846361,-0.00916502,0.0595237,-0.00395866,-0.351423,-0.639351,0.192993,0.22247,0.35214,0.120543,-0.478191,0.678865,-0.140002,0.121175,-0.0786502,-0.509803,0.00848328,0.28271,0.0301416,-0.320424,0.551683,0.202782,0.133796,0.249078,0.296726,0.346361,0.491712,0.203623,-0.33999,-0.0784541,-0.252473,-0.183977,-0.499279,0.292345,0.127367,0.268558,0.356886,0.518226,-1.32494 +3434.25,0.798228,0.0912059,4,1.49886,0.703085,-1.6358,0.646017,0.807907,-0.324994,-0.132556,-0.388298,-0.350775,0.169262,0.30312,0.0700259,-0.179021,0.709027,-0.465476,0.466106,0.234375,0.161116,-0.243717,-0.207085,-0.110209,-0.203476,-0.593014,0.260575,-0.191011,-0.057637,-0.0751595,-0.238677,-0.229548,0.465017,0.756071,-0.340684,0.270628,0.43246,-0.0985592,-0.0568572,-0.0885679,0.628139,0.0892985,0.114298,0.831914,0.668021,0.700254,-0.392261,0.0529971,0.585136,0.10231,-0.315022,0.418677,0.109508,0.138212,0.864182,-0.0376758,-0.334003,0.751326,0.501294,0.412656,-0.875811,0.480284,-0.359845,0.217384,0.916668,-0.412629,-1.02073,-0.0899412,0.444492,-0.522942,0.363646,0.360952,-0.486443,-0.0549139,0.0931354,0.449172,-0.241884,0.619784,0.570154,0.289314,-0.25976,-0.245149,0.458775,0.0512252,-0.0308766,0.439302,-0.615069,-0.0983438,-0.360091,0.187697,-0.197141,0.31404,-0.213022,0.00437595,0.262341,-0.166173,0.225848,0.200315,-0.0259554,0.117703,-0.779956,-0.553545,0.345699,-0.0808045,-0.730214,-0.30417,0.437034,0.143209,-0.219102,0.426041,-0.277059,0.438462,0.342138,-0.0944311,0.251606,0.182339,0.396307,-0.312296,-0.162686,-0.166429,0.0804515,0.0392292,-0.845241,-1.03756,-0.123946,-0.116493,-1.01491,-0.612972,-0.0437178,-0.0253402,-0.221772,0.0454335,-0.533428,-0.0857989,-0.419645,0.0624072,0.392928,-0.0613332,-0.00463612,0.215548,-0.176387,0.599067,-0.18842,0.119691,0.252528,0.0941311,-0.598084,0.198083,0.154739,-0.245029,0.248826,-0.0442854,0.00544765,-0.88405,-0.0688516,0.510039,0.170024,0.134091,0.731195,0.477804,-0.205974,0.30736,-0.181758,0.453456,-0.540348,0.549954,0.260446,0.164185,-0.16213,-0.124282,-0.260501,-0.216205,0.0095283,-0.0145912,-0.0557796,-0.155282,-0.26767,-0.622984,0.465139,-0.253764,0.386291,0.352736,0.674315,0.493385,-0.277754,-0.156364,-0.100994,0.249332,-0.276222,-0.0430556,-0.0613675,0.26063,-0.480837,-0.340086,0.29012,0.39153,-0.766388,-0.00612914,0.259524,0.2121,-0.206201,-0.320205,-0.267425,-0.247821,-0.0262259,0.327983,-0.0797095,-0.298362,0.13737,-0.380278,0.93443,0.102286,0.215561,0.404464,-0.44372,0.306898,0.0228471,0.0975294,0.379709,0.117151,0.365872,-0.150321,-0.474115,-0.33437,-0.417822,-0.289897,-0.446746,-0.172858,0.507713,-0.460062,-0.453523,0.22309,0.130491,-0.469919,0.0228512,-0.623313,-0.443875,-0.0751613,0.291545,-0.12361,0.162154,0.301815,0.302462,-0.381411,-0.228343,0.182467,0.181814,0.0291418,0.415939,0.659659,0.115559,-0.0499863,-0.361521,0.374927,-0.512089,0.710531,-0.428223,-0.35991,0.548257,-0.278963,0.155939,-0.288321,0.316774,0.153579,0.224266,0.309223,-0.00260939,0.215034,-0.152951,0.298667,-0.12741,-0.0549062,0.246587,-0.259219,-0.698167,-0.282862,0.199109,-0.112176,0.270734,0.586459,0.0407687,-0.114601,0.207601,0.328097,-0.450734,-0.105218,0.0939033,0.0726299,0.495974,0.0686843,0.517575,0.426024,-0.267399,0.0294849,-0.354577,0.106279,-0.526225,0.168964,-0.16714,-0.350077,0.0517566,-0.38927,-0.114983,0.664555,0.114942,0.199451,0.33903,0.446599,-2.09817 +3435.26,0.683353,0.0912059,4,1.49817,0.702841,-1.5813,0.647705,0.789202,-0.287691,0.0708757,-0.239949,-0.26419,0.0482648,0.127623,0.238204,-0.204774,0.577812,-0.477939,0.461218,0.036966,0.180241,-0.319061,-0.328198,-0.118131,-0.374211,-0.641625,0.19652,-0.258619,-0.0361597,0.19747,-0.0531991,-0.111943,0.555226,0.850876,-0.32417,0.286296,0.46832,-0.335194,-0.213381,0.0600532,0.640939,-0.0520598,0.136927,0.759515,0.58543,0.688379,-0.429606,0.115214,0.29517,0.0701631,-0.042593,0.493102,0.0791988,0.0902905,0.73862,0.0357262,-0.239124,0.490755,0.222675,0.349693,-0.910872,0.398883,-0.47236,0.306837,0.918909,-0.348039,-0.792705,0.15415,0.31045,-0.354821,0.406029,0.511175,-0.240002,-0.0623834,0.153463,0.306336,-0.126447,0.517614,0.510758,0.337849,-0.0217065,-0.183179,0.302956,0.026633,0.000545268,0.392527,-0.408583,0.00781291,-0.34611,0.39954,-0.320137,0.293844,-0.320425,-0.0887886,0.50461,-0.243792,0.297321,0.319411,-0.030593,0.17595,-0.836626,-0.3684,0.375602,-0.219976,-0.951034,-0.337323,0.132278,-0.15492,-0.148932,0.62442,-0.166713,0.395979,0.445196,-0.149889,0.189008,0.319641,0.274078,-0.312611,-0.120586,-0.287085,0.160528,0.237047,-0.683821,-0.999577,-0.0990693,0.145522,-1.00875,-0.31618,0.0810109,-0.00128577,-0.224198,0.073704,-0.438664,-0.0795199,-0.563605,0.0167618,0.329237,-0.183642,0.267158,0.230108,-0.108863,0.489118,-0.160942,-0.0685231,0.288164,0.314975,-0.377095,0.203374,0.124812,-0.257857,0.0280284,-0.0651271,-0.0480982,-0.859758,0.0136958,0.580459,0.340428,0.200587,0.803996,0.322853,-0.152547,0.335405,-0.107046,0.514257,-0.548852,0.583005,0.128329,0.0953697,-0.144587,-0.212698,-0.271271,-0.14816,0.31763,-0.00790918,-0.118953,-0.147787,-0.412087,-0.608925,0.483537,-0.40972,0.323857,0.134361,0.757182,0.487239,-0.267905,-0.233635,0.0306561,0.197854,0.0218796,0.0470126,-0.0484327,0.264443,-0.367241,-0.112997,0.301937,0.503497,-0.840908,0.0216725,0.360617,0.266972,-0.230257,-0.344251,-0.341643,-0.194743,-0.0361702,0.155359,0.00488938,-0.184901,0.0404848,-0.447714,0.807891,0.117266,0.139295,0.403896,-0.338817,0.306986,0.0743802,0.0833346,0.395207,0.262401,0.419432,-0.136694,-0.366636,-0.169888,-0.260977,-0.105939,-0.242902,-0.278296,0.608809,-0.346588,-0.483415,0.059486,0.140054,-0.38383,-0.0415337,-0.579371,-0.380821,-0.0808315,0.289643,0.0976761,0.166898,0.309229,-0.00951331,-0.426488,-0.11176,0.186451,0.372903,0.0604719,0.661782,0.660757,0.201452,-0.0424968,-0.280438,0.425692,-0.523319,0.556305,-0.214576,-0.422079,0.709381,-0.245325,0.168313,-0.273127,0.329946,0.0366282,0.206634,0.247391,0.0524149,0.497667,-0.148681,0.154736,-0.515011,-0.0624599,0.323342,-0.329702,-0.682707,-0.55847,0.125502,0.149696,0.070822,0.550276,-0.0167556,-0.0542533,0.348598,0.575612,-0.352979,0.0437632,0.0696654,0.0151809,0.592214,0.108669,0.509208,0.51227,-0.286549,-0.0957938,-0.107688,0.169743,-0.376136,0.277587,-0.214572,-0.280448,-0.0324273,-0.309589,0.026418,0.742125,0.110957,0.213793,0.333102,0.462378,-2.07589 +3425.29,0.977441,0.0912059,4,1.56022,0.784552,-1.11133,0.435025,0.457708,-0.0539145,-0.267578,0.114571,0.624736,-0.027186,-0.000846997,-0.384689,-0.0874353,0.457454,-0.195172,0.595595,0.190092,-0.0829964,0.05901,-0.102792,-0.0814169,-1.0719,-1.05888,0.218685,-0.310577,-0.251672,-0.365027,0.733392,-0.604436,0.242092,0.799227,-0.831655,0.048951,0.187385,-0.0630281,-0.370373,0.0206872,0.0482699,0.274947,-0.646096,0.658707,0.323822,-0.241217,-0.511215,-0.45462,0.332276,-0.864643,0.114301,0.576789,0.0968417,0.285186,0.52453,-0.0126955,0.231522,0.660206,-0.0437655,-0.403784,-0.715126,0.493535,-0.161451,0.432635,0.845794,-1.07628,-0.830165,0.327211,0.143523,0.52271,-0.129041,-0.402454,-0.113558,-0.541551,-0.296305,0.616329,0.29832,0.681648,0.594855,-0.0158278,0.519751,0.265175,0.0792075,0.641916,0.280352,0.316983,0.126408,-0.193676,-0.0600574,-0.31254,-0.0339046,-0.624693,-0.200768,-0.139716,-0.673298,0.177436,-0.206175,0.0608281,-0.547768,-0.329936,0.440482,0.485685,0.648538,0.121664,-0.757526,-0.314658,0.0872566,0.358468,0.294362,-0.221776,-0.193109,0.0808062,0.385172,0.0163401,0.0070522,-0.506837,0.379877,0.187524,0.353693,0.116506,-0.0145185,-0.0187659,0.402116,-0.215099,0.745854,0.0789871,-0.178127,0.149881,0.184456,0.250149,-0.0267511,0.709066,-0.572689,-0.0369259,0.165794,-0.0384277,0.644175,0.0729196,-0.17152,0.127507,0.28727,0.373187,-0.0703896,-0.595697,-0.00782742,-0.118176,-0.739577,-0.00919077,-0.443548,0.443099,0.12098,-0.0718689,-0.312703,0.133214,0.474806,0.064373,0.0674994,-0.093511,0.333022,0.858865,0.422039,0.10239,0.272201,-0.0434877,0.111896,0.978558,-0.607789,-0.833093,-0.00590817,-0.295817,-0.0122643,-0.248842,-0.901238,0.356109,0.0597741,0.0761835,0.33733,0.137675,-0.0640262,-0.0513216,-0.87645,-0.142139,0.547493,-0.0495459,-0.502998,0.356387,0.104068,-0.216485,-0.215468,-0.57765,-0.673972,0.112504,-0.00783976,0.14402,0.0836648,0.093213,-0.14394,0.161845,-0.131312,0.258346,-0.537731,-0.0570315,0.377361,0.33998,-0.2647,0.282274,0.388496,-0.234907,0.102706,-0.415044,1.04673,0.254188,-0.090308,0.0223486,0.297228,0.283677,0.0884579,0.0140245,0.547475,-0.221893,0.207877,0.546033,0.0683469,0.200531,-0.643694,0.416214,0.702414,0.0248884,0.0953165,0.0682146,-0.270046,-0.448866,0.242978,-0.341386,0.13656,-0.109662,0.250029,-0.180219,0.376983,0.12325,-0.0412032,0.803621,-0.08215,-0.17352,0.133883,-0.207588,-0.464167,0.502756,-0.304012,0.547169,0.0569884,0.1266,-0.229019,0.0691576,-0.0607459,0.507196,0.167369,0.0281134,0.108975,0.11318,-0.198146,0.259735,0.200166,0.518847,0.580794,-0.104252,0.389649,-0.203994,-0.219688,-0.0678908,0.419798,-0.490227,0.0432597,0.285616,0.178757,-0.0395796,0.292251,0.445739,-0.277415,0.267739,-0.010652,0.496753,0.353079,-0.125308,0.108426,-0.103201,0.499345,0.144616,-0.0109377,-0.558212,0.0248743,0.122428,-0.916461,0.184913,-0.124849,-0.227489,0.43608,-0.0959564,-0.399657,-0.212482,-0.0711914,0.194792,-0.323487,-0.374891,0.134099,0.228449,0.366195,0.477964,-1.16149 +3422.77,0.708153,0.0912059,4,1.55063,0.813637,-0.832086,0.277095,0.483152,-0.0707753,-0.196158,-0.157195,0.270909,0.0944649,-0.0545458,-0.123067,-0.0379145,0.373933,-0.246753,0.711142,0.152475,-0.134047,0.322585,-0.365356,0.0489929,-0.917344,-0.881555,0.248507,0.0564068,0.0317866,0.256194,0.380511,-0.41122,0.443785,0.793384,-0.679977,0.308245,0.0329002,-0.37586,-0.197412,0.167048,-0.17197,0.182566,-0.35535,0.590801,0.459494,-0.402963,-0.412584,-0.42838,0.0812737,-1.31544,-0.0650487,0.503195,-0.00595752,0.272323,0.335956,0.0581802,0.158446,0.687174,-0.266885,-0.0930283,-0.589035,0.445675,-0.524856,0.263326,0.773117,-1.21021,-1.15367,0.0249624,0.0121368,0.366504,0.451235,0.154835,-0.169372,-0.589822,-0.0210285,0.655516,0.364077,0.854412,0.802328,0.186254,0.359994,0.257218,0.00864715,0.383,0.148093,0.338982,0.0359129,-0.0157651,0.00152204,-0.437532,-0.126491,0.15879,-0.244563,0.0487146,-0.10999,0.328909,-0.207226,0.202885,-0.147563,-0.234968,0.70152,0.0571274,0.680997,0.0247854,-0.604284,-0.678901,0.305669,0.637289,0.646379,0.0391764,-0.238676,0.214069,0.358255,0.350849,-0.455027,-0.497938,0.633743,0.0803337,0.222531,0.0867529,0.0034251,0.309841,0.545211,-0.354245,0.837827,-0.102855,-0.436301,-0.222093,0.268924,0.167734,-0.157584,0.556777,-0.0755009,0.140454,-0.0856629,-0.255687,0.587532,0.29473,-0.0824071,-0.202813,0.508057,0.504931,-0.00323282,-0.0554084,-0.230985,0.0462097,-0.535473,-0.0873103,-0.488843,0.152401,0.231809,-0.0611433,-0.868684,0.0950792,0.487346,0.144516,-0.0553562,-0.155553,0.145213,0.222488,0.307428,0.377156,0.295589,-0.0548368,-0.186844,0.9796,-0.406454,-0.46007,0.19406,-0.143423,-0.60434,-0.477598,-0.72284,0.119043,-0.253345,0.0497179,0.819661,0.305809,0.236942,-0.140138,-0.148324,-0.245704,0.724177,-0.0556294,-0.645563,0.323044,-0.0283483,0.0087406,-0.172124,-0.331156,-0.549165,0.201292,-0.41085,0.270387,-0.15596,0.229133,-0.228081,0.403672,0.175903,0.493699,-0.158855,-0.0720467,0.244432,0.24834,-0.40623,0.389815,0.336028,-0.469613,0.268878,-0.897166,1.15555,0.013605,0.0738384,0.0139365,-0.0911951,0.260248,0.0393125,0.152479,0.517868,-0.69293,0.665892,0.165403,-0.210369,0.0691381,-0.367317,0.159985,0.477492,0.331503,0.628786,0.0834729,-0.119215,0.0777201,0.767145,-0.277254,0.169446,-0.121468,-0.0491361,-0.182472,0.601911,-0.185619,-0.399302,0.859657,0.141572,0.250703,0.455552,0.362432,-0.181603,0.316241,0.0511231,0.386557,-0.0396135,0.123232,-0.312739,0.0682563,-0.110137,0.236929,0.167038,-0.195537,0.0253549,0.0233817,0.0134507,-0.15391,0.28152,0.379789,0.193073,-0.580392,0.429773,0.160074,0.0925911,-0.0926171,-0.196287,-0.475089,0.147817,-0.129974,-0.158799,0.128915,0.0947891,-0.130682,-0.309435,0.280183,0.020485,0.374249,0.276032,-0.235854,0.137625,-0.342717,0.208449,-0.311908,0.333889,-0.145757,-0.269746,0.0847981,-0.966367,0.228427,-0.338832,0.24262,0.181997,-0.128098,-0.459564,0.268265,-0.0664216,0.191926,0.0083447,-0.127267,0.125353,0.202315,0.354052,0.449794,-1.2997 +3438.08,1,0.0912059,4,1.55492,0.839824,-0.745717,0.251991,0.154929,-0.0782089,-0.00744716,-0.00225432,0.475134,0.0197342,0.136387,0.00446113,0.159617,0.530759,0.0223094,0.637786,0.130433,-0.393175,-0.00682803,-0.33284,-0.191926,-0.989096,-0.898119,0.238981,0.0155848,-0.0855604,0.350032,0.215083,-0.414968,0.246845,0.70443,-0.865241,0.349504,-0.0294149,0.0504145,-0.181478,-0.191789,0.142251,0.127215,-0.285793,0.693221,0.424307,-0.102929,-0.498121,-0.200791,-0.266196,-1.04589,0.205936,0.255628,-0.134655,0.410718,0.333533,0.183866,-0.0154255,0.655518,-0.0463569,-0.05847,-0.567822,0.471093,-0.233101,0.254473,0.840418,-0.786011,-0.945396,-0.0094743,0.14893,0.239174,0.446118,0.324414,0.0285398,-0.184686,-0.0740446,0.662167,0.458667,0.968314,0.585837,0.278669,-0.0746217,0.102013,0.55811,0.310454,-0.338512,0.476597,-0.341916,-0.429018,-0.313889,-0.203922,0.0617305,-0.251864,-0.442438,0.54666,-0.185691,0.139338,0.0019795,0.200947,-0.0378143,-0.0325504,0.0530624,0.552603,0.694102,0.728968,-0.685718,-0.757971,0.0977009,0.625574,0.443144,0.174359,-0.00383936,0.280197,0.587892,-0.127375,-0.289601,-0.292073,0.685911,0.102807,0.110523,-0.138131,0.182873,-0.0761673,0.427331,-0.603748,0.788444,-0.567634,-0.858786,-0.0107617,0.432967,-0.159859,-0.0377672,0.317694,-0.135212,-0.0698249,0.168504,-0.341837,0.525401,-0.47229,0.148052,-0.0484437,0.0422437,0.418793,-0.126255,-0.0345082,0.208379,-0.0593967,-0.664984,-0.0434071,-0.000787351,-0.276553,0.0594195,0.233765,-0.557313,-0.638639,0.524701,-0.164737,-0.167758,0.141771,0.293531,0.597903,-0.386787,0.322885,0.502263,0.112554,-0.0656647,0.798615,-0.360436,-0.515968,-0.156484,0.0986738,-0.449083,-0.0425565,-0.35008,0.167248,-0.270578,0.179638,0.570266,0.318803,-0.113717,0.00292486,-0.122349,0.363841,0.857031,-0.0104015,-0.38736,0.880157,0.00541289,0.433943,-0.466828,0.0637774,-0.682817,-0.00289135,-0.84183,0.0492913,0.168542,0.21811,-0.466743,0.39455,0.190048,0.591177,-0.353947,-0.355571,-0.102084,0.10251,-0.648243,0.389984,0.212726,-0.363999,0.122643,-0.506386,1.03699,0.27737,0.28252,0.125357,0.0166793,0.191441,-0.0792202,-0.0629737,0.583696,-0.777379,0.645573,0.490987,-0.198805,-0.309792,-0.549601,0.0779817,0.0761812,-0.505482,0.499889,-0.432563,-0.205365,0.348043,0.448327,-0.226959,0.238946,-0.172236,0.221835,0.152999,0.487232,-0.291785,0.107215,0.719544,0.336795,-0.141733,-0.0248944,0.0883497,-0.394534,0.225754,0.20094,0.62865,0.0514859,-0.00172119,-0.0360678,-0.0715607,-0.270592,0.507884,-0.255269,-0.637133,0.308206,-0.228034,-0.0413741,0.148214,0.244065,0.612902,0.00121746,-0.0507162,0.00292529,0.311967,0.326928,-0.0219687,0.124529,-0.15441,0.618014,-0.421227,-0.0104884,-0.0763769,-0.0681212,-0.0729701,0.0112005,0.12232,0.306399,0.271918,0.026222,0.169641,-0.039226,-0.172312,0.674254,-0.147749,0.150445,-0.0202188,-0.282243,-0.132992,-1.12793,0.308441,-0.464252,0.419015,0.354042,-0.217135,-0.168879,-0.0196053,0.107185,0.0847975,0.297325,0.18237,0.134053,0.18051,0.366132,0.424865,-0.271799 +3426.66,0.563166,0.0912059,4,1.55197,1.04893,-0.900454,0.241374,0.642094,-0.0477152,-0.173084,-0.542069,0.324059,0.263719,0.0464434,-0.0501022,-0.0656603,0.0928087,0.00297204,0.943666,-0.0396832,0.293927,-0.236632,-0.0347485,-0.618124,-0.537882,-0.434826,-0.254379,-0.119453,-0.115991,-0.0700276,0.34372,-0.370343,0.0348518,0.626264,0.0595191,0.115199,-0.00344861,-0.259844,0.126127,-0.138279,0.71597,0.203755,0.01619,0.680422,0.423002,0.524364,-0.701491,-0.275366,-0.20185,-0.813526,0.00501859,0.705865,0.386396,-0.190019,0.227341,0.0899999,0.0691084,0.175532,-0.556858,-0.0521769,-0.817766,0.189797,-0.0978399,0.143005,0.815493,-0.401712,-0.315915,0.363834,0.37674,0.316213,-0.266118,0.279267,-0.784494,-0.340439,0.215153,0.695007,-0.649558,0.150074,0.282063,0.0297134,-0.0655836,-0.198158,-0.226049,0.47661,-0.242053,0.243228,0.134602,-0.265984,0.126449,0.44611,-0.213906,-0.199322,-0.24155,-0.203966,0.087075,0.172247,-0.151698,-0.0345801,-0.120758,0.148188,0.442703,-0.0666415,0.510529,-0.071825,-0.15308,-0.107928,0.0668593,0.152246,-0.717897,0.685056,-0.321876,0.304805,0.836327,-0.172655,0.0263193,-0.59027,0.649131,0.379712,0.0641762,-0.0413389,0.166019,0.185245,0.051264,-0.437358,-0.451568,-0.00544713,0.199793,0.473312,0.51606,0.261588,0.204982,-0.24588,-0.675693,0.245043,0.0518128,-0.282139,0.729008,-0.278734,-0.0194341,0.538552,-0.118846,0.54218,-0.568347,-0.125465,0.168791,-0.227073,-0.123478,-0.089619,0.196329,-0.0993099,0.588277,-0.632582,0.354571,0.0695928,-0.0825421,0.338946,-0.0402524,-0.150595,0.359129,0.432782,-0.541532,0.335799,-0.99008,0.269353,0.211861,1.00879,0.153438,0.244614,0.717806,-0.0284329,0.298607,-0.465429,0.572495,0.326607,0.197145,0.311046,-0.319379,-0.320334,0.083022,-0.178661,0.00302602,0.0815914,0.838252,0.168987,-0.024218,-0.121395,0.646037,0.590222,-0.22646,-0.180243,-0.172509,0.113134,0.486399,0.222514,-0.344424,-0.143839,-0.404166,-0.098054,0.565996,-0.194723,0.252685,-0.774883,-0.60647,0.0796557,-0.47061,0.1167,-0.32496,0.32512,-0.217864,-0.650551,0.70531,0.0221804,-0.147468,0.30612,-0.324221,0.257994,0.173563,0.291499,0.556563,-0.642118,0.244002,0.607575,0.00673023,0.490932,0.201195,0.308257,1.00344,-0.131844,-0.00605354,-0.477319,-0.46836,-0.422465,0.0708409,0.342187,0.431498,0.373986,-0.50996,-0.444545,0.945422,-0.662413,0.197147,0.720702,-0.439013,0.442726,0.300861,-0.32028,0.640898,0.270204,0.0970749,-0.0520555,0.0781708,-0.287535,-0.234374,-0.067122,-0.78916,0.250541,-0.512413,-0.205578,0.27132,-0.158265,-0.19923,0.625833,0.24632,-0.288774,0.200854,0.18643,0.731738,0.271734,0.033477,-0.0719271,-0.287067,-0.0317704,-0.516141,0.0159294,-0.467748,-0.311765,0.539243,0.111277,-0.135898,0.577566,-0.54117,0.329682,0.351684,-0.332903,0.332525,-0.641142,-0.145713,-0.0571012,0.138468,0.257718,0.138798,-0.13539,0.0684567,0.32724,0.185853,-0.401556,0.493104,-0.0947238,0.188361,-0.287577,-0.205209,0.19265,-0.390285,-0.523312,0.15148,0.164997,0.389204,0.406198,-2.17797 +3447.5,0.878232,0.0912059,4,1.54422,0.916919,-0.979661,0.373118,0.807287,-0.164523,0.0364766,0.0572725,0.220852,0.0888581,0.012038,-0.113821,0.0689568,0.217687,-0.0197088,0.565266,-0.133488,-0.0750585,-0.0633068,-0.403475,-0.174536,-0.757132,-0.486536,0.247396,-0.150977,0.177522,-0.412223,-0.125025,0.0800115,0.0319803,0.562531,-0.305312,0.381882,0.268273,-0.464482,-0.338127,0.0828442,0.319574,0.417549,0.388256,0.81104,1.06221,0.368036,-0.634891,-0.207416,0.298662,-0.604257,0.25875,0.175869,0.241722,0.317854,0.817954,0.318783,-0.575171,0.37135,-0.266183,0.0775631,-0.381557,0.360279,-0.31077,0.348617,0.877927,-0.434896,-0.755787,-0.0605637,0.0692889,0.382961,-0.247419,-0.130059,-0.266924,-0.215082,0.137028,0.676646,-0.0998315,0.767121,0.622399,-0.0307941,0.120024,-0.235451,0.265512,0.225323,-0.490183,0.0667474,-0.496335,-0.587393,0.392357,0.492623,-0.244555,-0.0184603,-0.489162,-0.670397,0.0735008,0.132735,0.236544,0.259672,-0.256946,-0.43124,0.148487,-1.08473,0.241471,-0.100309,-0.487327,-0.533935,0.0959959,0.169811,-0.651737,0.486388,-0.22342,-0.169479,-0.0640451,0.520021,-0.619993,0.646542,0.594778,0.211687,0.287395,-0.646821,0.152138,-0.202318,-0.257219,-0.54642,-0.136938,-0.138235,-0.0127025,-0.222937,0.0635963,0.321349,0.405201,0.155172,0.0406164,-0.196263,0.0801967,-0.229465,0.684453,-0.131154,-0.255966,-0.254343,-0.0246012,0.656521,-0.466204,-0.525952,-0.27516,0.251448,-0.0723844,-0.0194545,0.157396,-0.0626363,0.53608,0.114643,-0.519576,-0.151522,0.445248,0.396556,-0.292819,0.145872,0.135955,-0.25657,-0.138346,0.289156,-0.0767615,0.261097,-0.155203,0.838445,0.425686,0.0794644,-0.142911,-0.266543,-0.467491,0.115054,-0.659166,-0.101776,0.696277,0.076913,0.531926,-0.483515,0.101696,-0.175187,0.137748,-0.0841568,0.951129,0.22619,-0.288844,0.6746,-0.161092,0.167523,-0.280999,-0.260967,-0.229925,0.0239612,-0.903951,0.102096,-0.466902,-0.175704,-0.641558,0.0766596,0.421877,-0.450251,-0.45134,-0.804823,-0.0630356,-0.0571118,-0.253617,0.250548,0.435019,0.101926,-0.288259,-0.37871,1.093,-0.348236,-0.376481,0.327343,0.320918,-0.00306711,0.306757,-0.216799,0.610508,-0.0833026,0.114645,0.0334165,-0.210534,-0.0410951,-0.374176,-0.47702,0.220231,-0.389101,0.543132,-0.206313,-0.260684,-0.213292,0.0722101,-0.174929,0.136551,0.225675,-0.0961522,-0.249937,0.234003,-0.130787,0.0540036,0.534632,-0.633557,-0.469109,-0.323051,-0.296238,-0.108396,0.242101,0.125826,0.61612,0.279553,0.283822,0.214999,0.111827,-0.426637,0.285936,-0.228986,-0.038076,0.361904,-0.348685,-0.56841,-0.340892,-0.098177,0.414056,-0.155735,0.445242,0.300081,0.21453,-0.0149781,0.277765,-0.281714,-0.125326,-0.16788,-0.0642711,-0.273724,-0.183069,-0.0653105,-0.243659,0.0830113,0.227612,-0.156816,0.266908,0.326816,-0.0785019,-0.619942,-0.373271,0.0523036,-0.195688,-0.439295,-0.00990789,0.636334,-0.0358159,-0.269785,0.0996425,-0.0616228,0.428311,-0.188003,0.110308,-0.565339,-0.0510606,0.0387898,-0.399713,-0.0933764,-0.381652,0.128095,0.156546,0.357903,0.395659,-2.55486 +3423.65,0.78553,0.0912059,5,1.54324,0.770407,-1.49925,0.725134,1.16236,-0.0733957,0.277578,0.0722117,0.432741,0.105954,0.103099,-0.214859,0.245147,0.34674,-0.289626,0.978302,0.223536,0.456393,0.12764,0.318008,-0.13604,-0.412204,-0.431369,0.413594,-0.652063,0.23773,0.195665,0.38209,-0.468213,0.268755,0.909961,-0.357153,-0.175034,0.449628,-0.614504,-0.113911,-0.239988,0.751556,0.569939,-0.250948,0.639561,0.0987397,0.36853,-1.12018,-0.17001,-0.218453,-0.0795388,-0.0831672,0.533013,0.237323,0.0545811,-0.118037,0.106951,-0.285356,0.101267,-0.50056,-0.160834,-1.15533,0.526477,-0.682391,0.138737,0.597749,-0.646803,-0.693281,0.207496,-0.102524,-0.7539,-0.390419,0.20109,0.172386,-0.288202,-0.255081,0.532691,-0.0636551,0.114555,0.0569865,-0.0346734,-0.1364,-0.61765,0.232572,0.632766,-0.575431,0.178653,0.261545,-0.0802004,-0.42612,0.203943,-0.15065,-0.250856,-0.121665,-0.0895952,-0.275229,-0.027017,0.360441,-0.398307,-0.480559,0.223936,-0.0875162,0.255107,0.462992,-0.49238,-0.0118873,0.212196,-0.241821,-0.586008,-0.115895,-0.239525,-0.815934,0.231305,0.365033,-0.126389,-0.2279,-0.301684,0.461642,-0.0345142,-0.309463,-0.0676365,-0.0920639,0.0636105,-0.258769,-0.515041,-0.166818,-0.141145,-0.156858,-0.213363,-0.126885,0.165361,-0.195206,0.510756,-0.526653,-0.171378,0.133224,0.0319899,-0.00322353,0.0116369,-0.298034,-0.497134,-0.165664,0.201625,-0.773019,-0.46741,0.108756,0.0323284,-0.51812,0.141428,0.198382,-0.4172,0.109083,-0.20049,-0.203235,0.0520406,0.215131,0.395039,0.115238,0.181725,0.538667,0.502929,-0.111695,-0.121901,-0.239006,0.0922599,0.31476,0.606981,-0.15879,-0.126075,-0.201573,-0.0412275,0.104654,-0.708855,0.819379,0.248095,-0.526195,0.162025,-0.206921,-0.243479,-0.0766531,-0.0745268,-0.172849,0.351981,0.967514,-0.421232,-0.236578,0.088726,-0.35277,-0.132231,-0.402179,-0.687525,-0.139664,0.127464,-0.198654,-0.0574718,0.241748,-0.0844809,-0.221852,-0.191158,0.178263,0.082868,0.175946,-0.0138006,0.0907704,-0.145271,0.352542,-0.41881,-0.058911,0.506186,-0.0964696,-0.448752,0.865924,0.44674,0.95899,0.139201,-0.22369,0.207133,-0.331599,-0.0748535,0.168046,-0.693001,0.24146,0.341396,-0.655492,0.656733,-0.358504,0.554373,-0.275797,-0.227772,-0.255681,-0.11296,-0.534818,0.0964912,-0.471212,0.254743,0.275405,-0.289874,-0.229653,-0.184866,0.446487,0.263431,0.0440817,0.744368,0.160262,0.257105,-0.251024,-0.0379374,0.130595,0.122522,-0.134539,0.7235,0.103285,-0.782241,-0.651217,-0.372341,-0.408542,0.258072,-0.0855181,0.0243283,-0.00249724,-0.10964,0.107709,0.332803,-0.167735,-0.28137,0.304618,-0.582306,0.302996,-0.101033,0.586068,-0.0785052,-0.239556,0.306991,0.16134,0.596069,-0.15593,0.484871,-0.124075,-0.0408761,-0.377383,-0.00697043,0.0185607,0.935719,-0.0104912,0.395052,0.443571,0.0392288,0.177494,-0.260253,0.0973096,-0.710536,-0.418132,0.1141,0.355636,0.19398,0.225263,-0.680011,-0.0215239,-0.514073,0.252013,-0.0849144,-0.091005,0.896573,0.515017,0.114437,0.130931,0.206721,0.361844,0.454665,-3.5592 +3418.18,0.77085,0.0912059,4,1.54745,0.727596,-1.52605,0.755556,0.919974,0.00507465,0.178124,0.229064,0.580214,0.165607,-0.0237213,-0.435637,0.0371609,0.250558,-0.308523,0.95979,0.344953,0.437741,0.0763879,0.166141,0.109731,-0.769237,-0.469557,0.426055,-0.531697,0.388407,-0.0345434,0.520081,-0.463803,0.289027,1.18727,-0.410041,-0.131229,0.420676,-0.412263,-0.239604,-0.203249,0.595662,0.403379,-0.404234,0.629839,0.655966,0.29537,-1.01989,-0.314077,-0.262444,-0.357416,-0.260996,0.608858,0.0571789,0.200449,-0.063428,0.0182114,-0.23957,-0.0359631,-0.388734,-0.171763,-0.796916,0.577249,-0.531219,-0.100174,0.464653,-0.646421,-0.759869,0.075806,0.0287333,-0.648266,-0.373902,-0.0288287,0.2044,-0.261208,-0.0292272,0.6453,-0.0178672,0.099793,0.229956,-0.0441721,-0.146977,-0.572935,0.194863,0.759532,-0.497926,0.287015,0.33818,-0.0560869,-0.258785,0.328402,-0.0888607,0.059488,-0.0180549,-0.0983393,-0.514315,-0.258883,0.384368,-0.458307,-0.298456,0.129657,-0.320292,0.427397,0.377402,-0.703162,-0.181288,0.252517,-0.299603,-0.519348,0.0645773,0.0838274,-0.604632,0.0918488,0.244465,-0.123528,-0.0133925,0.156931,0.448841,-0.204892,-0.208139,-0.164254,-0.211132,0.131587,-0.16634,-0.751458,-0.259613,0.0249793,-0.0347006,-0.315268,-0.0111173,0.1757,-0.185495,0.397435,-0.590618,-0.026957,-0.0797037,0.0504388,0.0421446,0.0133713,-0.248232,-0.60643,-0.339787,0.076209,-0.612736,-0.608276,0.112433,-0.104208,-0.470668,0.383771,0.18278,-0.635269,0.08465,-0.240219,-0.292977,0.129879,0.11098,0.161482,0.16041,0.151785,0.441015,0.608473,-0.0443948,-0.190453,-0.163461,0.268689,0.329153,0.673483,-0.136402,-0.304446,-0.427775,-0.173704,0.05986,-0.453727,0.579534,0.0146305,-0.315827,0.10401,0.0748088,-0.197056,-0.188812,0.20296,-0.214857,0.203899,0.945817,-0.178675,-0.214338,0.0913958,-0.144847,-0.331403,-0.515815,-0.412337,-0.228971,-0.0412882,-0.337279,-0.10662,0.427111,-0.0205414,-0.263081,-0.0429576,-0.11963,0.153741,0.228826,-0.0352918,-0.292335,-0.15322,0.212372,-0.518069,-0.0606957,0.308184,-0.129603,-0.625851,0.778844,0.38147,1.02542,0.212865,-0.319086,0.203241,-0.247481,-0.204376,0.157807,-0.51704,0.167245,0.149728,-0.728608,0.394474,-0.44273,0.703834,-0.0224434,-0.543841,-0.273189,-0.107827,-0.633697,-0.0443383,-0.576809,0.0201357,0.175176,-0.377092,-0.293632,-0.225674,0.378592,0.180479,0.0189111,0.985386,0.129987,0.202879,0.00803545,0.0775322,0.139773,0.122734,-0.494729,0.825072,0.342822,-0.830986,-0.521729,-0.301788,-0.540195,0.174497,0.0795122,0.127256,-0.124249,-0.180236,0.200599,-0.0623187,-0.27662,-0.0393137,0.373586,-0.542703,0.304053,-0.303814,0.402837,-0.269893,-0.578694,0.18177,0.0913944,0.134388,-0.174906,0.355979,-0.0330624,0.090306,-0.0913272,0.113727,0.0453237,0.84561,0.100313,0.199038,0.30207,0.228614,0.0716643,-0.302143,-0.106359,-0.76587,-0.203292,0.20805,0.327738,0.229056,0.311278,-0.677041,-0.049149,-0.347743,0.202721,0.374453,0.116108,0.736075,0.322296,0.423796,0.12913,0.194217,0.359347,0.440701,-2.70901 +3433.86,0.898642,0.0912059,4,1.6626,0.734858,-0.626687,0.183154,0.400886,-0.228998,-0.114381,-0.520806,-0.0836903,-0.130058,-0.235449,-0.160867,-0.170404,0.198647,0.229715,0.557486,0.0332933,-0.136921,0.218541,0.243875,0.11415,-0.555198,-0.968965,0.735033,-0.48924,0.0219128,0.182189,-0.00722109,-0.401168,0.0143988,1.01526,-0.638348,-0.0736002,0.166104,-0.238638,-0.601547,-0.465739,0.435395,0.0798764,-0.170119,0.743777,0.160089,-0.163927,-0.347639,0.161887,-0.0154962,-0.45991,0.269433,0.471408,0.0488123,0.204238,-0.392854,-0.032143,-0.590359,0.950342,-0.361561,-0.266504,-0.87851,0.352624,-0.430573,0.0048039,0.740914,-0.708191,-1.18492,-0.247887,0.142376,0.15216,0.15907,-0.0422048,-0.339987,-0.248682,0.123827,0.543542,-0.212859,0.671357,0.677513,0.2115,-0.0630891,-0.272466,-0.231094,0.1521,-0.107332,-0.383201,0.340798,-0.494792,0.1877,-0.429929,0.0679867,0.101904,-0.8493,-0.517808,0.303538,0.107027,-0.166374,0.671814,-0.460589,0.118429,-0.297493,-0.412507,0.157586,0.539969,-0.0813458,-0.652847,-0.270764,0.152245,-0.466286,-0.0553568,-0.553298,0.334223,0.286327,-0.087653,0.185093,0.422718,0.631954,0.536279,0.395587,-0.0271874,0.437022,0.207096,0.12377,-0.356319,-0.0616399,-0.115363,0.169507,-0.259918,0.545912,0.168596,0.408754,0.594283,0.00588071,-0.035361,0.00600378,-0.416311,0.634573,-0.410497,-0.202757,0.0637051,-0.111118,0.682516,-0.431801,0.017048,-0.553975,0.381114,-0.543414,-0.445369,0.072846,0.203323,0.716795,-0.0848113,-0.0249325,-0.658939,0.278176,0.263425,0.445629,-0.367083,0.0146001,0.171093,0.487671,0.0803426,0.272096,0.17559,0.132085,0.647663,0.22633,0.427003,0.21925,-0.210213,-0.0667747,-0.397079,-0.463783,0.435783,-0.319465,0.00767938,0.19184,0.19508,0.463531,-0.526591,-0.204,-0.0274508,0.754735,0.162261,0.116882,0.173291,-0.0623552,0.602637,-0.00801474,0.311227,0.36138,0.858717,-0.144162,0.348913,-0.500835,-0.0614115,-0.757559,-0.0638939,-0.00487032,-0.320233,-0.437065,-0.678601,0.437811,-0.389897,-0.195529,0.21898,-0.239825,-0.326404,0.235765,-0.639402,0.968239,-0.3957,-0.234888,0.368457,0.116131,0.456423,0.0646534,-1.0607,-0.000375047,0.139196,0.144414,0.0922627,0.330608,-0.126608,-0.208575,0.0679123,-0.430757,-0.114947,0.502075,-0.771281,-0.161108,-0.0778107,0.446419,-0.125538,0.174887,-0.0231357,0.237122,-0.674034,0.586501,-0.101292,0.345252,0.330529,-0.643847,-0.0406864,-0.486201,0.0540494,-0.114535,0.359061,0.1063,0.564671,0.0580179,0.515463,0.118574,-0.21582,-0.934396,0.587862,-0.124206,-0.51426,0.0608999,-0.0120918,0.0208124,0.512025,-0.0603654,0.373862,-0.128993,0.304004,0.0412068,0.550846,-0.0704612,0.204621,0.198827,0.205342,0.111419,-0.121926,-0.345696,-0.492963,-0.0851595,0.483853,-0.594241,0.153109,-0.0447388,0.307936,0.172737,-0.10804,-0.0993551,-0.252067,-0.0156349,0.125889,0.442482,0.174008,0.483701,-0.206671,-0.576138,0.00614384,0.0022124,0.402631,0.106141,0.0423009,-0.743657,0.0907899,-0.0626596,-0.277798,-0.210538,-0.347452,0.138689,0.266322,0.37241,0.516064,-0.75462 +3445.73,1,0.0912059,4,1.62547,0.743293,-0.549268,0.281671,0.338647,-0.124196,0.255238,-0.435022,-0.322208,-0.331025,0.0335321,-0.322896,-0.30213,0.399895,0.399253,1.11858,0.399566,-0.111077,-0.213808,0.186686,-0.0856019,-0.522492,-0.587606,0.890358,-0.725439,-0.0936281,0.304591,0.508034,-0.535185,0.0762566,0.726743,-0.463763,-0.0734914,0.481015,-0.373807,-0.727623,-0.261835,0.00452567,-0.0183687,-0.129334,0.932105,0.176537,0.161808,-0.814399,-0.155681,-0.288954,-0.362264,-0.0157029,0.190154,0.147856,0.224463,-0.535348,0.165394,-0.381306,0.741463,-0.382503,-0.395721,-1.07543,0.316574,-0.136894,0.13676,0.545564,-0.722697,-0.727289,-0.0167439,-0.181545,0.340408,0.517485,-0.176431,-0.534579,-1.06742,0.194912,0.897478,-0.0688767,0.228224,0.482648,0.615826,-0.0800195,-0.541892,0.134191,0.442822,-0.0208427,-0.215834,0.110631,-0.329356,0.0960228,-0.0418059,0.00800873,0.00354029,-0.291191,-0.253726,0.281853,0.224569,-0.075415,0.345042,-0.211095,0.306104,-0.182139,-0.479086,0.146563,-0.083924,-0.168579,-0.758011,-0.21434,0.431951,-0.372399,0.235494,0.0277814,0.201854,0.521014,-0.0280218,-0.358081,0.434741,0.117623,0.610069,-0.0818784,0.235321,-0.114655,0.199329,-0.0844798,-0.433195,0.293229,-0.20717,-0.28084,-0.0445584,0.954975,0.388884,0.0737362,0.338813,-0.0179977,0.104414,0.0425126,-0.630798,0.071899,-0.24536,0.0561297,-0.0782296,0.280274,0.286807,-0.815815,0.11329,-0.57807,0.250787,-0.417748,-0.499749,0.012264,0.371219,0.714391,0.0113071,0.261533,0.00440351,0.0159606,0.495526,0.400824,0.0370649,0.30145,0.180098,-0.0414492,-0.0541267,0.150754,0.903921,0.130279,0.730443,0.364924,0.368819,-0.0623716,-0.130604,-0.306023,-0.19488,-0.0323064,0.0713359,-0.386201,-0.0731341,-0.0103189,0.269966,-0.0891837,-0.250929,-0.447648,-0.165623,0.723945,0.0846697,0.0240795,-0.117586,-0.0769097,0.641825,-0.333564,0.344113,0.0656515,0.408639,-0.118895,0.357694,0.277687,-0.0894939,-0.773818,0.189712,0.343367,-0.102509,-0.621878,-0.491462,0.244332,-0.382459,0.15666,0.477604,0.344043,0.0193989,0.365137,-0.210616,0.937009,-0.122327,-0.162229,-0.0672971,0.153335,0.623636,-0.0633756,-0.725016,0.0689896,-0.393676,0.087675,-0.0499585,-0.124222,-0.49854,-0.624848,0.325462,-0.00798914,-0.464323,0.232724,-0.632696,-0.28691,0.0517073,-0.39513,0.0910389,0.0211855,-0.100073,-0.080828,-0.364389,0.406796,0.00719317,0.209935,0.355227,-0.284415,0.0171692,-0.240525,0.0491176,-0.179812,0.531408,0.207637,0.702149,0.248323,0.0158546,-0.0326073,-0.244215,-0.668379,0.506146,-0.204634,-0.459798,0.227038,-0.305595,0.0448463,0.330208,-0.0457427,0.376747,0.212959,-0.468602,0.188742,0.621509,-0.530776,0.0745474,-0.553774,-0.223122,0.18609,-0.0738699,-0.00795557,-0.601722,0.00274503,0.206366,0.149326,0.0673213,0.0918779,-0.00664454,0.246929,-0.308535,-0.564704,-0.228228,-0.28521,0.321124,0.207122,-0.365594,0.353432,0.0523739,-0.0934187,0.133704,0.031854,0.335225,0.371992,0.0526521,-0.619003,-0.560655,-0.258632,0.420036,-0.266163,0.015848,0.115207,0.209231,0.339421,0.457418,-0.760352 +3425.54,0.798405,0.0912059,4,1.57597,0.847261,-0.702811,0.302283,0.476327,-0.0483706,0.44181,-0.212736,0.143913,0.396065,0.174473,-0.156188,-0.1946,0.260089,0.435077,0.965133,0.0905861,-0.028215,-0.010824,0.285776,0.101477,-0.930765,-0.982401,0.663627,-0.669582,0.0320478,0.140122,0.241368,-0.510764,-0.137705,0.827676,0.0137139,0.245334,0.388798,-0.37555,-0.266072,0.145418,0.152814,0.423865,-0.160269,0.957346,0.385622,-0.0572177,-0.749388,0.000543025,0.127427,-1.02621,-0.131926,0.519786,0.0623981,-0.318223,0.00478692,0.0654767,-0.316657,1.01226,-0.621854,-0.371143,-0.631716,0.339563,-0.25214,0.0486041,0.899639,-1.38325,-0.176811,-0.187468,-0.0539898,0.268317,-0.186688,-0.92321,-0.948269,0.107478,0.372892,0.933658,-0.17705,-0.0637105,0.435846,0.313245,0.35885,-0.136988,0.0908997,0.512684,0.109908,0.101264,-0.103393,-0.496439,0.229019,-0.553209,0.0671619,0.519826,-0.132729,-0.310189,-0.19503,0.00751376,-0.123143,0.188285,-0.41502,0.286027,-0.0495407,-0.425213,0.272144,0.318803,-0.205383,-0.228479,-0.468943,0.304164,0.381635,0.349167,-0.27928,0.192819,0.493687,0.304033,0.0714981,0.53643,0.292505,0.359917,-0.229355,-0.216366,0.113512,0.024421,-0.0884817,-0.299788,0.151228,0.294364,0.0772357,0.226887,0.578882,0.643545,0.206525,0.52153,0.0586806,0.0597593,-0.103966,-0.423091,0.860197,0.183967,0.208587,0.190336,-0.343336,0.462312,-0.13774,0.315124,-0.610669,0.816175,-0.168646,-0.295075,-0.0126435,0.241232,0.404772,-0.08044,0.248983,-0.230182,-0.0311904,0.0689291,0.586696,-0.138957,0.122841,0.0162668,0.298269,0.00229729,-0.0557994,0.510583,0.753957,0.686531,-0.33987,0.433439,0.184543,-0.177453,-0.335426,0.155227,0.388266,0.10569,-0.117925,-0.330091,0.189015,0.0161179,-0.276521,-0.0667883,-0.65954,0.160628,0.559396,-0.0785918,-0.211413,-0.0646976,-0.155098,0.171926,-0.0731825,0.589723,-0.484693,0.330114,-0.0815781,0.0713988,-0.168571,-0.265485,-0.643293,-0.335505,0.130247,-0.275487,-0.227789,-0.319378,-0.021768,-0.515468,-0.309796,0.172852,0.507931,0.0510899,0.492487,-0.0522337,1.0196,-0.253378,-0.237464,-0.237301,-0.0965067,0.0224148,-0.164777,-0.488119,-0.0354777,-0.382761,-0.0233779,0.0776352,-0.253614,-0.451359,-0.297555,0.343032,0.0942374,0.253964,0.241552,-0.040471,-0.270657,0.212018,0.0340398,-0.0224668,-0.280703,-0.0881237,-0.220201,-0.290072,0.581229,-0.637679,-0.00849259,0.497669,-0.279423,-0.144103,-0.020907,-0.261691,-0.175618,0.115477,-0.0118388,0.413931,0.19919,0.124745,-0.134524,-0.315494,-0.810829,0.456625,-0.685426,0.264888,-0.00939574,0.0679156,-0.156401,-0.0502483,-0.178754,-0.140884,1.06002,-0.117339,0.310494,0.00944541,0.129022,0.500765,-0.551135,0.198177,0.039748,-0.2553,0.135782,-0.335491,-0.240573,0.438626,-0.266596,-0.277954,0.102345,0.467783,0.42606,-0.625119,-0.321823,-0.288529,-0.280149,-0.0406692,0.082705,0.222137,0.0329865,-0.19814,-0.272828,-0.388657,0.0677368,0.337094,-0.00489751,-0.15071,-0.289123,-0.155214,0.33491,-0.143786,0.194328,-0.455517,0.132093,0.269125,0.363447,0.518773,-1.40856 +3421.83,0.948429,0.0912059,4,1.6351,0.812866,-0.899694,0.394014,0.392986,0.0663663,0.0460846,0.0139085,0.376038,0.371516,0.0937482,-0.305599,0.200088,0.574158,0.293311,1.1985,0.0392769,0.299388,0.0538482,0.523857,-0.197479,-0.805642,-1.07834,0.926059,-0.2779,-0.314733,0.194733,-0.00307408,-0.112814,-0.271859,0.448354,0.125317,-0.461502,0.504046,-0.243251,-0.00374303,-0.0841122,0.161893,0.694002,-0.181931,0.864895,0.172631,-0.266199,-1.15496,-0.152705,0.171345,-1.14499,0.0473676,0.41163,0.058852,-0.122605,0.197831,-0.0721985,-0.178266,0.765015,-0.492642,-0.438635,-0.548209,0.144622,-0.466049,0.349105,0.99122,-1.00181,-0.448673,-0.286616,-0.19115,-0.0328482,-0.0535519,-0.959321,-0.694064,-0.183541,0.166797,0.71306,-0.285477,0.214645,0.872673,0.315048,0.30243,-0.487316,-0.166087,0.631266,0.0842525,-0.48967,-0.125214,-0.538665,0.223345,-0.534079,0.219017,0.436074,-0.184164,-0.47819,-0.10686,0.0623317,-0.35556,0.0850903,-0.163383,0.136968,-0.18984,-0.0582699,0.2562,-0.0106369,0.147095,-0.514606,-0.332691,0.399745,2.20947e-05,0.330415,-0.349292,-0.0216038,0.285276,0.11867,0.120678,-0.00164789,0.150595,0.414446,-0.133857,-0.13532,0.550082,-0.0976568,-0.320703,-0.291064,0.297929,0.241425,0.37964,0.131192,-0.0320846,0.673124,0.204289,0.420894,0.00682782,-0.318912,-0.335972,-0.355936,0.330536,0.189894,-0.230168,0.136736,-0.134572,0.696659,-0.195877,0.175526,-0.405649,0.580248,-0.304227,-0.430473,-0.0836967,0.191587,0.557543,0.100361,0.137928,-0.240002,-0.0814723,0.187303,0.439493,-0.531097,0.0918527,0.00512333,0.0793942,0.19659,-0.621364,0.422628,0.591624,0.612109,-0.233352,0.667183,0.169044,-0.137567,-0.219493,0.476794,0.414441,0.292916,0.128558,-0.116181,0.10965,0.17582,0.223834,-0.0327718,0.0171431,0.249479,0.39949,0.185849,-0.264055,0.331664,-0.484615,0.476104,-0.390901,0.427223,-0.335379,0.247949,-0.302464,-0.00233467,0.0565587,0.0250529,-0.415042,-0.147422,0.259425,-0.12773,-0.316887,-0.250894,-0.221042,-0.470176,-0.252091,0.302442,0.318822,0.125768,0.311064,-0.459202,1.08738,-0.210283,0.212205,-0.0964734,-0.0424128,-0.159756,0.0468189,-0.804642,-0.175811,-0.153958,-0.077225,0.10087,-0.289747,-0.585625,-0.344704,0.155009,-0.281619,-0.177149,0.0446347,-0.218399,0.225094,-0.193747,0.0877272,-0.181686,-0.120501,0.0429667,-0.068399,-0.452726,0.558558,-0.505646,-0.112659,0.56153,-0.0631004,-0.157707,-0.128621,-0.270773,-0.368666,0.00399892,0.140808,0.416761,0.324263,0.10479,-0.44223,-0.299438,-0.876425,0.287212,-0.566695,-0.208789,-0.139098,-0.154461,0.262322,-0.223787,-0.220142,-0.457888,0.805362,-0.0248878,0.0792507,0.375224,0.493693,0.495367,-0.580749,0.0301911,0.240359,-0.275498,-0.112303,-0.275767,-0.113069,0.30399,0.0428036,0.00421104,0.173262,0.454806,0.488804,-0.426432,-0.864974,0.129246,-0.3203,-0.257925,0.215865,0.138585,0.118253,-0.399209,-0.0944496,-0.381046,-0.398858,-0.138991,0.175257,-0.176093,-0.10733,-0.136071,-0.239778,0.110299,-0.014321,0.0274588,0.103617,0.200047,0.321896,0.447266,-1.02418 +3437.7,0.906111,0.0912059,4,1.50159,0.918667,-0.735246,0.301863,0.320268,-0.244602,0.264872,0.698656,0.526505,0.564258,0.226386,0.0568205,-0.0919839,1.14054,-0.0249797,0.885869,0.356061,0.266774,-0.249025,0.210117,-0.170282,-0.448239,-0.435546,0.663391,-0.107319,0.21677,0.269421,0.963014,-0.0242493,-0.0358883,0.652608,-0.513533,0.233951,0.233309,-0.139618,-0.352427,-0.374262,0.735652,-0.0740993,-0.987958,1.04307,0.750855,0.142297,-0.535496,-0.0173157,-0.14428,-0.380273,-0.175159,0.500242,-0.232141,-0.0966589,-0.168007,-0.335087,0.00323433,0.86348,-0.0553457,-0.188224,-0.808486,0.326961,-0.204459,-0.10418,0.663754,-0.523638,-0.811529,0.433123,0.319436,-0.20966,-0.180446,0.313818,-0.244768,-0.338648,-0.129873,0.0716869,0.305917,0.533244,0.117882,0.175665,0.257993,-0.415639,0.408037,0.195112,-0.435179,0.158384,-0.17783,-0.264741,-0.29569,0.510041,-0.617834,0.381242,0.0356741,0.0923119,0.165371,0.228883,0.0572249,-0.0293604,-0.61733,-0.0340651,-0.19994,0.105088,-0.0424792,-0.385462,-0.0162708,0.235371,-0.240246,0.139406,-0.488332,0.602514,-0.509403,0.473262,0.625464,-0.0702078,-0.191108,0.148934,0.168297,-0.24465,0.308205,-0.604553,-0.109751,0.203645,-0.326379,-0.407553,-0.242568,-0.437762,-0.726344,0.254628,0.0950647,-0.105903,-0.421614,-0.00810463,-0.221604,0.281836,-0.353717,0.194129,0.0679874,-0.0283346,-0.437439,0.141186,-0.317498,0.508227,-0.749565,-0.0705017,-0.254389,0.113252,-0.231125,0.281284,-0.278678,-0.517495,0.52093,0.0620739,-0.251646,0.062816,0.13861,-0.429243,-0.177682,0.577695,0.1441,0.325083,-0.588157,-0.256987,0.234777,-0.187412,-0.158409,0.551144,-0.323924,-0.296901,-0.178795,-0.13712,0.177987,-0.210854,-0.0713115,0.468644,-0.320602,-0.398082,-0.0402508,0.330882,-0.203538,-0.0820487,0.190688,0.51852,0.664711,-0.0916856,-0.433255,0.476123,-0.0399261,-0.540591,-0.297355,-0.675033,-0.102968,0.239802,-0.133852,-0.334701,-0.148773,-0.0505616,-0.165739,-0.143968,0.208301,0.0756022,0.0338228,-0.326656,0.293177,-0.445447,0.0102775,0.25364,-0.588668,0.0773541,-0.734695,-0.188054,1.05106,-0.186552,0.147335,-0.0284745,-0.24957,0.229377,-0.00378304,0.307098,0.439032,0.0209887,-0.156768,0.389482,-0.269454,0.216678,-0.401124,-0.399029,0.222071,-0.161266,0.407298,-0.401548,-0.246326,0.639684,0.379806,-0.245413,-0.22325,0.151057,-0.0156966,0.290862,0.458136,0.147971,0.311064,0.402032,-0.0798909,-0.331115,0.328408,0.206492,-0.0262087,0.714626,-0.604978,0.270892,0.0410753,-0.378753,-0.448378,0.00172344,-0.451141,0.331239,-0.137121,0.115904,0.018119,-0.0755963,-0.113157,0.334141,-0.332773,0.865037,-0.0830668,0.030066,0.244681,-0.164112,0.17203,-0.13142,0.290885,0.14002,0.0664316,0.111502,-0.542186,0.126972,0.502526,-0.0435471,0.532719,0.141283,-0.0344488,-0.297759,-0.415737,-0.187679,0.0338098,-0.750072,0.485608,0.0253079,-0.0279254,0.0908689,0.364096,0.975145,-0.665213,-0.0216864,-0.148103,-0.0356821,0.0392022,0.121664,-0.421742,-0.360679,0.225145,-0.362206,-0.0555196,-0.192013,0.114517,0.269805,0.338404,0.519427,-1.0246 +3443.85,0.890347,0.0912059,5,1.5854,0.715489,-0.931062,0.55903,0.565626,-0.0980683,-0.0934447,0.260314,0.140825,0.452944,0.547851,0.156421,-0.0704684,0.576037,-0.353592,1.15299,0.567483,0.407603,-0.0998031,0.435468,-0.140398,-0.413081,-0.581934,0.886825,-0.361146,-0.0358565,0.201006,0.327118,0.456093,-0.203901,1.06031,-0.436602,0.213991,0.632479,-0.33162,0.100541,-0.466859,-0.10931,0.493365,-0.421607,0.80827,0.825493,-0.31038,-0.678923,-0.151562,0.28816,-0.660316,-0.348632,0.29235,0.177264,-0.0352819,0.090381,-0.0295219,0.201238,0.457184,-0.460479,-0.265267,-0.987946,0.00409524,-0.558157,0.286446,0.956656,-0.879857,-1.29398,-0.181942,-0.293792,0.143193,-0.228696,-0.0228974,-0.560827,-0.0759746,0.485978,0.205104,0.0993017,0.15173,0.362786,0.00214895,-0.157762,-0.310922,-0.0188894,0.184727,-0.385381,-0.45391,-0.233226,-0.214999,-0.143521,-0.179082,-0.00301187,0.399307,-0.0518054,-0.0441168,0.111561,0.0757382,-0.532392,0.0611301,0.193211,-0.157505,-0.0722153,0.14171,0.0371261,-0.195861,0.109991,-0.359979,-0.518952,-0.121357,-0.373453,0.253,-0.27658,0.0637152,0.494253,-0.118868,-0.180532,-0.440147,0.18308,-0.24517,-0.292506,0.0746967,0.285286,0.0890417,-0.0422625,-0.379609,-0.124784,0.104333,-0.240178,0.581879,-0.114073,0.21678,0.481671,0.0272743,0.204049,0.37116,-0.336625,-0.200949,0.326133,-0.58314,-0.374324,-0.0748448,-0.298712,0.297703,-0.615376,-0.308919,-0.338225,0.384575,-0.146596,-0.185619,0.112525,-0.641587,0.329749,-0.297222,-0.213724,-0.302387,-0.155121,0.107617,-0.262667,0.152587,0.584441,0.0492699,-0.137818,-0.0142509,-0.176061,0.340424,-0.435834,0.561957,-0.258438,-0.346018,-0.0330454,-0.257574,-0.283611,0.00313615,0.0095416,0.442178,-0.452415,-0.167139,0.365348,-0.152339,-0.173434,-0.0327069,-0.023701,-0.29432,0.704361,0.111348,-0.0948101,-0.607708,-0.00906672,-0.559792,-0.163119,-0.221342,-0.248276,-0.0725063,0.0744382,-0.298148,0.334225,-0.0982737,-0.793541,-0.226357,0.585012,-0.152546,0.217266,-0.238108,-0.0531277,-0.216496,-0.15423,0.0818866,0.0452803,-0.524514,-0.125473,-0.332722,0.917113,-0.12993,0.188036,-0.159856,-0.223097,0.115807,-0.241623,0.136091,0.518711,0.237842,0.390825,-0.155995,0.214489,-0.700106,0.0124136,0.16965,0.159319,-0.0670723,0.160832,-0.789631,-0.0186959,0.239776,-0.0394743,-0.193908,-0.0140227,0.176807,-0.113264,-0.0444318,0.467781,0.0222092,0.306143,0.392066,-0.0151558,-0.559974,0.333752,-0.468685,-0.186046,0.328431,0.266027,0.0169676,-0.107383,0.152702,-0.189222,0.153729,-0.198411,0.254767,-0.379518,0.389766,0.19547,0.115415,0.178167,0.05765,-0.308073,0.578757,0.0249924,0.114675,-0.211795,-0.149286,0.168284,0.401587,-0.293184,-0.199847,0.336675,-0.205646,0.294017,0.207822,-0.546425,-0.109961,0.599402,0.0856133,-0.54526,0.732922,-0.286953,0.0462295,0.46214,-0.589888,0.53565,-0.0728868,0.26491,-0.551227,0.551066,0.0343119,-0.424222,-0.163757,0.186494,0.240319,0.216984,0.264695,-0.115981,-0.0469957,-0.166826,-0.369976,-0.223819,-0.144416,0.0900014,0.215141,0.300002,0.463833,-1.57376 +3440.9,0.994613,0.0912059,4,1.47896,0.767902,-1.0728,0.53852,0.336805,-0.171048,0.201848,0.381187,0.285811,0.160899,0.419899,-0.00773103,-0.07982,0.952275,-0.322613,0.938589,0.544764,0.203403,-0.0689881,0.319866,-0.0448136,-0.21762,-0.46982,0.980456,-0.483277,-0.0475508,0.0902066,0.612719,0.223211,-0.313861,1.01894,-0.678578,0.264727,0.350204,-0.263514,-0.216317,-0.00741477,0.454458,0.340888,-0.955205,0.649626,0.981864,0.0485799,-0.522473,-0.201434,0.140471,-0.682259,0.159022,0.350952,0.270482,0.132072,0.379784,-0.170432,-0.194228,0.485047,-0.257356,0.0178702,-0.727028,0.15482,-0.546385,0.0562744,0.822746,-0.467025,-1.08322,0.160131,-0.151762,-0.378453,-0.169359,0.0930164,-0.444615,0.041192,0.688942,0.285319,0.277339,0.53392,0.22632,0.342785,-0.140231,-0.122143,0.0380044,0.137309,-0.191122,-0.440206,-0.281855,0.0799305,0.0704239,0.16234,-0.56257,0.234491,-0.296968,0.0932139,-0.23798,-0.112654,-0.149514,0.0898569,0.266241,-0.373901,-0.153506,0.552373,0.0700783,-0.287623,0.194719,-0.496873,-0.340459,-0.299479,-0.155322,0.163966,-0.262064,0.193739,0.528323,-0.310161,-0.504438,-0.131772,0.125139,0.348419,-0.341718,0.19833,0.0060339,0.298389,-0.0740564,-0.295202,0.387119,0.23799,0.00907169,0.40778,0.113022,0.566739,0.505868,0.265181,-0.0531872,0.782004,-0.150253,-0.160407,0.534666,-0.117787,-0.238668,-0.0768965,0.123181,0.088833,-0.620896,-0.303553,-0.257839,-0.0941615,-0.0599775,0.130624,0.145783,-0.516539,0.15647,-0.412688,-0.3985,-0.358441,-0.27434,-0.0175559,-0.224053,0.239202,0.475096,-0.345036,0.121605,0.0427307,-0.0908233,0.356266,-0.227728,0.165295,-0.282926,0.570722,-0.086586,-0.590396,-0.46216,-0.0345501,-0.0553607,0.0395737,-0.723964,-0.160035,0.320908,0.000534777,-0.244977,0.0854593,-0.0258588,-0.325205,0.676094,-0.399815,0.00233768,-0.615966,-0.105496,-0.740623,-0.284282,-0.45601,-0.361639,0.0922962,0.0889194,0.194547,0.0326082,0.0629483,-0.686155,-0.122206,0.232117,-0.0971209,0.222139,-0.311819,-0.0263244,-0.528846,-0.385281,0.117073,-0.280716,-0.168306,0.19786,-0.0849964,0.753696,0.0940315,0.289414,0.16188,-0.272953,-0.0480855,-0.364241,0.409927,0.345315,-0.135684,0.324592,0.127025,0.182036,-0.507798,0.0664025,-0.0331293,0.173153,0.111425,0.157839,-0.533378,-0.386394,0.519652,0.203214,-0.0450396,-0.0886201,-0.00984954,0.272393,0.310792,0.386865,0.00321691,-0.0242999,0.635067,-0.128792,-0.057996,0.58545,-0.185274,-0.0453493,0.377122,0.255156,0.151517,-0.23832,0.0122583,-0.451751,0.308856,-0.202098,0.358014,-0.235153,0.296314,-0.140343,-0.222895,-0.0771519,-0.126405,-0.233171,0.793954,0.105964,0.0359428,0.185165,-0.173405,0.338671,0.0109586,-0.361426,-0.0776695,0.350823,0.00473447,0.185933,0.311613,-0.310562,-0.156895,0.0466521,0.106839,-0.480977,0.28447,-0.247837,0.136648,0.165134,-0.430241,0.560326,0.0129351,0.339782,-0.297286,0.495957,0.0476045,-0.281383,-0.166816,-0.127165,0.300464,0.258186,0.391781,-0.343804,-0.0772167,0.335209,-0.167317,-0.269473,-0.409846,0.100523,0.290817,0.317054,0.539275,-0.901052 +3430.65,0.846918,0.0912059,4,1.42294,0.675131,-0.905096,0.432394,-0.0515004,-0.0568706,-0.159049,-0.154574,0.254745,0.179348,0.629232,0.19337,-0.311915,1.10757,0.0694118,1.01516,0.482653,0.331224,0.221431,0.299947,0.0281953,-0.729955,-0.597615,0.734496,0.665897,-0.142763,0.23469,-0.0591781,-0.249984,0.563569,1.29003,-0.317643,-0.530376,0.535012,-0.382724,0.262068,-0.422509,0.384994,0.416416,0.474104,1.11421,0.361433,0.403633,-0.276452,-0.223335,0.0825746,-0.84631,-0.0226843,0.454733,-0.366759,0.494985,0.56835,0.609306,-0.0620387,0.789925,-0.0899584,-0.240986,-0.395415,0.361325,0.210465,0.339041,1.06444,-1.09097,-0.962412,0.19495,0.729619,0.189282,-0.247739,0.193828,-0.318309,-0.66568,-0.2001,0.719066,-0.0483228,0.213348,0.60701,0.106423,-0.21425,-0.614689,0.186145,0.523515,-0.34788,0.414471,0.273804,-0.233821,-0.15508,-0.111971,0.301044,-0.123267,-0.492678,-0.036824,0.548443,0.0936479,-0.0122392,-0.103429,-0.753506,0.135846,-0.261025,-0.458574,0.283463,0.356807,0.0548534,-0.430909,-0.0184084,0.479418,-0.252934,0.338905,-0.141413,0.201857,0.342353,-0.134494,-0.0744225,-0.0111389,0.407733,-0.16855,0.190278,-0.602336,0.398139,-0.072782,0.341511,-0.713082,-0.0796181,-0.380718,-0.360691,-0.399348,0.286013,-0.0747497,-0.170252,0.0866054,-0.543792,-0.485872,0.040024,0.665121,0.156702,-0.00890478,-0.195648,-0.297129,-0.480308,0.672663,-0.313248,-0.213986,-0.173832,-0.58734,-0.522966,-0.17955,0.0498801,-0.164181,0.733685,-0.0283737,0.418518,-0.0804595,0.270124,0.170675,-0.0556769,-0.296472,0.45368,0.572962,-0.512174,-0.0577229,-0.0106873,-0.218372,-0.351611,1.2838,0.314811,0.016929,0.344445,0.304552,0.399234,-0.186491,-0.0212255,-0.0960186,0.455992,-0.0187851,-0.253439,-0.175563,-0.534168,-0.4576,-0.315706,0.438918,0.3748,0.211011,0.247228,0.544548,0.0519666,0.65458,0.0641075,-0.0234738,-0.375948,0.166383,-0.249319,-0.216185,0.428493,-0.301176,-0.389911,0.0196069,0.106652,0.169869,-0.416306,-0.318068,0.159486,0.0804727,-0.210162,0.294048,0.164592,-0.124589,-0.526936,-0.420336,0.618291,0.143058,0.00421109,-0.13732,0.0938817,-0.0484368,-0.0717918,-0.510882,-0.118054,-0.169821,-0.19959,0.0922111,-0.210573,-0.0213365,-0.615577,-0.0578188,0.336131,-0.253128,0.479136,-0.081091,0.186877,-0.624338,-0.539798,-0.622208,0.155319,-0.21061,-0.845236,-0.910473,0.779961,-0.208663,0.108518,0.143574,-0.0491031,-0.0604528,-0.220916,0.280074,0.171467,-0.0662908,0.143015,0.484837,0.322245,0.177689,-0.232526,-0.0853116,-0.662241,0.415202,-0.209501,-0.237493,0.33807,0.0588653,0.212369,0.314109,0.0572357,-0.617493,0.380277,0.217347,0.0346814,0.599822,0.295764,-0.176859,0.367373,-0.0370152,-0.359094,-0.331443,-0.568572,-0.624409,0.243723,0.234458,-0.378042,0.0275536,0.340099,-0.47183,-0.00972306,0.0540851,-0.0831322,0.0938336,-0.389728,0.104309,-0.0493921,0.162454,-0.203321,-0.485424,-0.117725,0.0340453,0.203442,-0.289605,-0.2298,0.002371,-0.400415,0.0533481,-0.356226,-0.116638,0.176548,0.379075,0.115123,0.245739,0.339298,0.49572,0.480013 +3443.47,1,0.0912059,4,1.51043,0.606811,-1.37677,0.664763,0.371064,-0.123647,0.0338794,-0.0655205,0.316325,0.168516,0.234381,0.0614967,0.0475492,0.962086,-0.119395,1.0481,0.683696,0.262945,0.0804377,0.310897,0.501698,-0.485644,-0.889578,0.799128,-0.386906,-0.311799,-0.0900678,0.615259,0.0573451,0.267526,1.25245,-0.352035,0.00578704,0.588382,-0.331751,0.274131,-0.188713,0.62121,-0.196374,-0.567047,0.869199,0.158585,0.374567,-0.550647,-0.520874,-0.0944461,-0.489864,0.37719,0.0411596,-0.0635584,-0.17059,0.104562,0.0112673,-0.958877,0.431184,0.106474,0.355357,-0.435452,0.247613,-0.351151,-0.420102,1.02892,-0.443141,-0.67604,-0.212284,-0.122612,-0.0959576,0.2222,0.342787,-0.210161,0.18966,0.422139,0.257394,0.265706,0.204152,0.146261,0.361002,0.0873047,0.156246,-0.0559999,0.487515,0.0356473,0.170561,-0.310359,-0.0786828,-0.169152,0.0982593,-0.374519,-0.519381,-0.328123,-0.3803,-0.147443,-0.100547,0.0872671,-0.311148,-0.244336,-0.0923155,0.410231,-0.119835,0.307871,0.434816,-0.318475,-0.591186,-0.0233485,-0.322234,0.305069,0.249168,0.110514,0.0327421,0.317768,0.56997,0.0417953,0.830621,0.414116,-0.0941917,-0.44273,0.120596,0.125961,0.153374,0.513621,-0.585265,0.458099,-0.381223,-0.181801,-0.673608,-0.0638875,-0.448687,-0.0975598,0.107189,-1.00627,0.705428,-0.224454,-0.161806,-0.0974336,-0.257421,0.109183,-0.279921,0.0474306,0.0117525,-0.411666,-0.104788,0.336319,-0.369456,0.0492201,-0.122093,-0.10397,-0.323071,-0.393062,-0.487702,-0.566363,-0.303989,0.0572038,0.196881,-0.512195,0.15237,0.231142,0.286503,0.149083,0.109639,0.512215,0.3005,-0.146703,0.646857,-0.0530836,0.373115,-0.0847235,0.0569569,-0.00728319,0.0296961,0.0730681,0.0431743,-0.201425,0.0452531,-0.0638889,-0.16172,0.115542,0.103906,-0.189057,0.227392,0.584559,0.150864,-0.0702586,-0.058689,-0.0666054,-0.0827296,-0.358904,-0.107406,-0.0315755,0.212744,-0.164044,0.195065,0.0149307,-0.121273,-0.403361,-0.488767,0.139528,0.221914,-0.597201,-0.115611,0.253705,-0.0406923,0.00844651,0.283941,-0.0843045,-0.284763,0.0396598,-0.559287,0.856695,-0.227578,0.164725,-0.00774671,-0.315421,-0.0302338,0.18852,0.188759,0.237763,-0.289238,0.623693,0.611973,-0.0061873,-0.35203,-0.0275398,0.000916577,-0.0963002,-0.211935,0.548712,-0.00413381,-0.593325,0.0933761,0.177527,0.0159178,0.0540138,-0.244128,-0.152345,0.108679,0.2471,0.0730259,0.346191,0.55044,-0.0523928,-0.293385,-0.279361,0.212815,-0.267333,-0.157152,-0.22896,0.28154,-0.00273671,-0.0979102,-0.464442,-0.258066,-0.52119,0.301062,-0.268904,-0.444047,0.290804,-0.372785,0.324938,0.50805,0.0724206,0.445345,0.507201,0.143633,-0.0154116,-0.0693142,-0.0720863,-0.0840787,-0.0147425,-0.220558,0.399688,0.422789,-0.516357,-0.00378066,0.199199,-0.35366,0.0867049,-0.0839201,-0.220145,-0.148436,-0.135686,-0.360615,0.415876,-0.821268,0.144242,0.352522,0.811899,0.0297131,0.615177,0.0290281,-0.0362126,0.127302,-0.301477,0.189283,-0.0937105,-0.467378,-0.12879,-0.138684,0.0751215,0.461468,0.0470322,0.0315619,0.111129,0.254296,0.333359,0.504278,-0.670383 +3444.39,0.48119,0.0912059,4,1.52552,0.681301,-1.15135,0.573737,0.662165,-0.0443824,0.168106,0.272471,0.202121,0.0521796,0.344439,-0.0643215,-0.568431,0.854321,0.260207,0.73631,0.528762,0.195373,0.438636,0.147473,0.268387,-0.381309,-0.896737,0.536834,-0.123206,0.0627927,0.0527905,-0.0975865,-0.381782,0.606355,1.10964,-0.126444,0.205417,0.458609,-0.586779,-0.0847062,-0.609629,0.190053,0.481471,0.367537,0.983889,0.446394,0.553761,-0.656866,0.0398405,-0.0670466,-0.264988,-0.022667,0.152504,-0.223153,0.408711,0.617783,0.321732,-0.0663643,0.722736,-0.555754,-0.290674,-0.765413,0.264784,-0.148019,0.254198,1.08319,-1.13473,-0.836258,0.330564,0.287964,-0.532329,-0.495605,-0.639865,-0.322542,-0.0687368,-0.118189,0.483723,-0.0835662,0.348931,0.50717,0.240019,-0.315364,-0.582764,-0.102975,0.138589,-0.649444,0.485683,0.0882997,0.215326,-0.0713293,-0.1211,0.127483,-0.0432523,-0.607297,-0.0469934,-0.0237004,0.140464,0.127897,-0.0541052,-0.306452,0.00693849,-0.220129,-0.000270154,0.292361,0.143935,0.153267,-0.0328063,0.0908876,0.0663501,-0.718263,0.256467,-0.333256,0.464747,0.306733,-0.362816,-0.292224,-0.782482,0.110256,0.363496,0.297344,-0.478183,-0.0967366,0.143113,-0.333931,-0.498827,-0.316191,-0.525928,-0.508814,-0.226395,0.108796,0.395293,-0.000448937,0.329228,0.381816,-0.302676,-0.104647,-0.361086,0.134848,-0.128923,-0.0690005,-0.447787,-0.499322,0.37598,-0.472533,-0.191713,-0.0533614,0.582734,-0.643791,0.167124,-0.218307,0.157595,0.356423,0.161964,-0.543656,-0.547084,0.120688,0.423449,0.263195,0.542792,0.594072,0.445728,-0.114988,-0.187723,-6.47993e-05,0.161063,0.0684008,0.69534,0.155203,-0.136627,0.185248,0.253719,-0.129375,-0.147142,-0.37609,-0.15285,0.0809774,-0.205256,0.151527,-0.490269,-0.618959,-0.671633,-0.122851,0.533084,0.406903,0.0378495,0.158312,0.639632,-0.0443978,0.0288076,0.215162,-0.121971,-0.0974692,0.158618,-0.226793,-0.332727,-0.370435,-0.581044,-0.270752,0.387809,-0.327942,0.0489622,-0.134538,-0.420912,-0.105368,0.0113264,-0.000589292,-0.0669091,-0.0374854,0.269363,-0.0234547,0.0106057,0.720583,0.289165,0.076217,-0.151259,0.066444,-0.246769,0.13327,0.014496,0.709951,-0.57942,-0.198171,0.00341015,-0.419961,-0.00602918,-0.693892,0.214641,0.245646,-0.363837,0.544549,-0.2134,0.017924,0.271975,-0.104545,0.0567936,0.103592,0.231957,-0.419754,-0.40968,0.376962,-0.127572,0.111347,0.390543,-0.0718401,0.198133,0.356284,-0.130853,0.185136,0.381669,0.475479,0.716755,-0.107359,0.214449,-0.456427,-0.00449105,-0.377169,0.191057,-0.477866,0.0331405,0.148503,-0.209171,-0.419327,-0.256288,0.254911,-0.0969651,0.320106,-0.0172097,0.187166,-0.0513997,0.0961229,-0.118763,-0.502927,0.0728181,-0.254153,-0.187485,-0.0230158,-0.71325,0.33569,0.32004,-0.189374,0.28646,0.489379,-0.213204,-0.0602125,0.379614,-0.31866,-0.314808,0.0262786,0.00926104,-0.287648,-0.352747,0.177766,0.0299274,0.0133322,-0.135075,-0.219772,-0.332017,0.273791,-0.183232,-0.619601,0.425502,-0.344753,-0.54279,-0.261545,-0.305889,0.110604,0.242737,0.332572,0.492684,-1.80532 +3437.29,0.927922,0.0912059,4,1.54635,0.735082,-1.4389,0.628456,1.18108,-0.156168,-0.034505,-0.279678,0.463139,-0.491607,0.307618,0.0753693,0.201601,0.381062,-0.00484687,0.711176,0.0990686,0.0928124,0.0908499,0.0832572,-0.130543,-0.788447,-0.039514,0.371033,-0.202726,0.0556712,-0.11197,0.613253,-0.358829,-0.177131,0.960113,-0.471469,-0.207429,0.334049,0.0128348,-0.179948,0.0519013,0.60578,0.620417,-0.232032,1.31846,0.605496,0.17601,-0.414118,0.0217531,0.700959,-0.26435,0.166712,0.241529,0.221298,-0.130342,0.360557,0.0364426,-0.275116,0.355323,-0.160138,0.306417,-0.942882,0.400167,-0.676212,0.0332033,1.16826,-0.225736,-0.698064,-0.159352,-0.263759,0.377101,-0.129722,0.639774,-0.197277,-0.218495,-0.190671,0.271278,-0.612088,0.533991,0.377867,0.5195,0.044821,-0.00761288,0.286596,0.79324,-0.300837,0.0336145,-0.628765,-0.223375,-0.130551,0.09213,0.152721,-0.123841,-0.223565,-0.503492,0.12441,-0.127252,-0.246296,-0.177191,-0.0166684,-0.126941,-0.543157,-0.239413,-0.10587,-0.029,0.213214,-0.425501,-0.575171,0.0902989,-0.0540528,0.342477,0.0683659,0.211632,0.44723,-0.124756,-0.316601,0.821586,0.561414,-0.476167,-0.400909,-0.275841,0.128095,0.396105,-0.232657,-0.435176,0.767494,-0.0191867,0.16088,0.262749,0.0510533,-0.0503679,-0.00450143,0.163378,-0.885313,0.35612,-0.164438,0.110367,0.47137,-0.0668802,-0.243755,-0.443417,-0.230016,0.471279,-0.422801,-0.538983,0.273572,-0.638167,-0.0534452,-0.3815,0.528958,-0.156568,0.292926,-0.558873,0.271618,0.406325,0.000465657,-0.255468,-0.200575,-0.416774,0.208188,-0.263915,-0.442416,-0.156298,-0.0241024,0.194004,-0.429297,0.294564,-0.628592,-0.446634,0.0312482,0.193412,0.0847588,-0.355732,0.0735249,0.150564,-0.311635,0.082896,0.309333,-0.0369536,0.143427,0.131786,-0.149954,-0.0994488,0.430381,-0.271211,-0.111456,-0.324421,0.0409361,0.0623089,-0.691704,0.241661,-0.100625,0.105616,-0.423014,0.188818,0.0257673,0.421806,-0.39855,-0.279636,0.227775,0.0463627,-0.117169,-0.167574,-0.239349,0.196887,-0.119321,0.0714654,0.193754,-0.257908,-0.106007,-0.559529,0.807875,-0.665986,0.431231,0.186957,-0.220721,0.404872,-0.25024,-0.311162,0.016632,0.153422,0.147771,0.102719,-0.337238,-0.0456456,-0.511093,-0.1552,-0.00799322,0.144788,0.30912,-0.553478,-0.605048,0.119435,0.23368,-0.727106,0.0676617,0.00993953,0.0526811,0.28653,0.337071,-0.0117962,-0.028512,0.150832,-0.55342,-0.127639,-0.42042,-0.217902,-0.148672,-0.188075,0.0923633,0.129583,-0.121318,-0.248449,-0.464611,-0.508509,-0.664318,0.381827,0.0276501,-0.484817,0.114017,-0.383226,0.214122,-0.140596,0.206993,0.343735,0.180089,0.348673,-0.148965,0.286159,0.0342549,-0.114414,0.157166,-0.244206,0.285037,0.0134876,-0.23491,0.226923,0.156464,-0.357578,-0.00561116,-0.567702,-0.195192,0.578935,0.107116,-0.696224,0.161505,0.271331,-0.0565059,0.397342,0.763186,-0.0941274,0.282789,0.0868108,-0.301502,0.178842,0.480381,0.158623,0.564732,0.112124,-0.149851,-0.0628917,0.187101,0.311159,-0.41401,0.0830848,0.104491,0.208055,0.323251,0.45613,-3.47512 +3433.22,0.703566,0.0912059,4,1.5119,0.540216,-2.04256,0.922354,0.697647,0.0869084,-0.369386,-0.434521,0.247102,0.0935915,0.478882,-0.392433,-0.838741,0.703229,-0.14134,0.526314,0.519414,0.0992836,0.357619,0.384425,0.152283,-0.656249,-1.16192,0.823218,-0.572286,-0.0695811,0.019134,-0.21018,-0.245934,0.482176,1.33905,-0.325195,-0.257457,0.533526,-0.288607,-0.58505,-0.387555,0.2919,0.910069,0.0758984,0.762602,0.867432,0.59444,-0.551728,0.386581,-0.1461,-0.615564,0.228541,0.156294,0.0491701,0.0559099,0.727297,-0.0454645,-0.136236,0.332744,0.406911,-0.367524,-0.864342,0.287456,0.236372,0.630963,1.08034,-0.828995,-1.07123,1.12347,0.580289,-0.0311637,-0.35089,-0.239859,-0.333233,0.16505,0.720237,0.577828,0.00546037,0.322499,0.327315,0.087121,-0.518702,-0.589049,-0.160198,0.174326,-0.128124,0.469012,0.338094,-0.374985,0.113091,-0.180678,-0.32861,0.164689,-0.573938,-0.134989,-0.00941758,-0.139118,0.309008,0.532101,-0.374673,0.606682,0.0768951,0.312474,0.527821,0.145502,-0.149351,-0.28661,-0.080803,-0.0489203,-0.365527,0.115026,-0.161537,0.0246305,0.573975,-0.0128189,0.215595,-0.2902,0.27889,-0.158605,0.324485,0.190237,0.14117,-0.322807,-0.213331,-0.873637,-0.775932,-0.296898,-0.570951,-0.296625,0.551037,0.106682,-0.001033,0.152595,0.361421,-0.389595,0.0611497,-0.122266,0.0547792,-0.294805,0.406506,-0.0960917,-0.131336,0.338662,-0.166182,-0.200734,-0.189733,1.01723,-0.389424,0.417105,-0.48317,-0.157908,0.172024,-0.0246012,-0.623045,-0.268063,0.235927,0.0841905,0.673971,0.290249,0.530489,0.28981,0.0151532,0.031333,-0.267535,0.218655,0.306804,0.313461,0.415809,0.573731,-0.0155259,0.0477965,0.0292134,0.110566,-0.0735324,0.249237,-0.0348444,-0.0437726,-0.519263,-0.039844,-0.361617,-0.425757,-0.138335,0.0831466,0.556286,0.0411564,-0.15923,0.300335,-0.208072,-0.177355,0.0748088,-0.369789,-0.32265,0.318137,-0.220783,-0.228492,-0.0854036,-0.274736,-0.513963,-0.0656057,-0.235886,-0.116254,-0.283406,-0.357211,0.150327,-0.128682,-0.274396,0.176117,-0.403261,0.0435508,-0.0393607,-0.194537,0.571288,0.268419,0.0686926,-0.184842,-0.041795,0.110215,0.551551,0.359563,0.222451,-0.490832,0.114858,0.104832,0.0182587,-0.327297,-0.600315,0.258421,0.165523,-0.956762,0.532084,-0.239614,0.311756,0.126918,-0.0882068,0.137433,0.0656124,-0.363637,-0.695695,-0.267134,0.517665,-0.00586053,-0.0128882,0.524853,0.0368475,-0.13674,-0.0610594,0.531035,0.531562,0.0934999,0.133225,0.286086,0.180223,0.159729,-0.20307,0.235597,-0.239843,0.222041,-0.547304,-0.184635,-0.126333,0.0861692,-0.0852892,0.0451678,-0.117187,-0.181755,0.160521,-0.454595,0.104842,-0.179643,0.0741133,-0.357082,-0.614871,0.181083,-0.274708,-0.152395,0.0902464,-0.500745,-0.130834,0.118809,-0.281533,0.551084,0.0935824,0.125893,-0.269989,0.0209765,-0.567712,-0.193446,-0.0989746,-0.151184,-0.683994,-0.000205722,-0.0918382,0.262779,0.0649534,0.0485474,-0.45973,-0.221456,-0.143032,-0.322587,-0.665264,0.342134,-0.276926,-0.437448,-0.0186447,-0.303022,0.102534,0.323582,0.320209,0.568843,-1.58247 +3420.71,0.911735,0.0912059,4,1.49186,0.65634,-1.74283,0.829744,0.846912,-0.223026,-0.366986,0.0843395,0.115532,-0.0100376,0.36276,-0.412811,-0.662873,0.424142,-0.346416,1.16098,0.466103,0.213232,-0.211905,0.230188,0.322743,-0.520934,-1.01206,0.890524,-0.398479,0.181632,-0.106681,0.428929,-0.0160801,-0.00103057,1.27463,-0.619003,0.236971,0.683373,-0.472561,-0.377832,-0.469053,0.991779,0.799213,-0.0929181,0.855206,0.940695,0.0576037,-0.781385,-0.483274,0.481441,-1.0292,0.455315,0.0434717,0.297782,-0.189532,0.688347,0.113834,-1.34576,0.184601,-0.0150956,0.030016,-0.537761,0.466675,-0.901909,-0.0387034,1.34399,-0.379012,-0.443606,-0.55177,-0.219457,-0.172272,0.133359,0.0133489,-0.194807,0.632895,0.398373,0.707843,-0.0678741,0.195798,-0.089888,0.443287,0.281318,-0.427092,-0.0213695,0.552142,-0.224129,-0.226348,0.405966,0.394556,0.02607,0.530071,-0.843738,-0.275229,-0.499392,-0.233654,-0.343217,0.187704,-0.384339,-0.0411991,0.00462255,0.0892305,-0.464961,-0.208842,0.231029,0.0313229,-0.511235,-0.709633,-0.429543,0.326776,0.326738,0.430386,0.0604354,0.0542669,0.424021,0.0351706,-0.0751364,0.0265497,0.610227,0.282799,-0.279951,-0.183718,0.0531459,0.545006,0.267965,-0.421282,0.56856,-0.090322,-0.115427,0.351942,0.30041,-0.00895211,0.321773,0.248495,-0.595432,0.469061,0.162872,0.108898,0.197194,-0.368788,-0.464548,-0.0916775,-0.0195094,0.0423414,-1.19921,-0.317596,0.170538,-0.193644,-0.626356,-0.293841,0.243143,-0.0275917,0.378619,-0.42871,0.273928,-0.32478,-0.20296,-0.300208,-0.0913249,0.542968,0.0821174,-0.10932,-0.517422,0.321879,-0.294074,-0.253263,-0.296279,0.467809,0.127559,0.163977,-0.58013,0.108389,0.0571643,-0.350591,-0.214691,0.0018561,0.304267,0.0698294,-0.443988,-0.344075,0.251671,-0.285562,-0.0203264,0.197209,0.360323,0.0893382,0.0208156,0.496431,0.217587,-0.387732,-0.482167,-0.855649,-0.550089,0.31283,-0.362084,0.563498,-0.346507,-0.443193,-0.553538,0.0984418,0.354704,-0.192488,-0.216821,-0.37918,0.011914,-0.19289,-0.238776,0.0383606,0.264444,0.0167881,-0.0711844,-0.714486,0.882531,-0.20764,0.330561,0.201962,-0.153279,0.375405,-0.229162,-0.797883,-0.278856,0.0942746,0.297366,-0.192073,0.143982,0.255261,-0.250295,-0.0860279,0.564896,0.158742,0.092356,-0.383523,-0.60982,-0.155355,0.0568707,-0.152377,0.0987629,0.0480476,0.611764,-0.300711,0.181346,-0.0714755,0.00499061,0.194854,-0.520166,-0.49761,0.0608615,0.0238909,-0.387419,0.499475,0.042922,0.688275,0.0424447,0.456725,-0.063316,0.0936039,-0.972995,-0.117072,0.189065,-0.334033,0.0690857,-0.685692,0.348554,0.482286,-0.0350327,-0.0803146,0.0993122,0.243973,0.134949,-0.0118214,0.175796,-0.0498935,-0.168163,-0.0883306,0.136292,-0.139913,0.0729389,-0.0679761,0.160734,-0.296249,0.542766,-0.143431,-0.264095,0.185104,0.0502555,0.140726,-0.11603,-0.07765,0.328905,0.159199,0.222549,-0.0183908,0.198206,-0.151682,0.209664,0.0740671,-0.0489614,0.10056,0.306735,-0.0201675,-0.518536,-0.0411249,-0.0999096,0.265772,0.0917861,0.300532,0.104804,0.34257,0.323735,0.585295,-2.29552 +3414.1,0.485682,0.0912059,4,1.56602,0.602691,-1.86042,0.838537,0.540753,-0.108716,0.0311645,-0.194679,0.246942,0.120471,0.121507,-0.287643,-0.452077,0.154831,-0.305438,0.570563,0.756411,0.0897486,-0.406992,0.343831,0.175725,-0.486239,-1.21692,0.549553,-0.639095,0.442266,-0.142951,0.375855,-0.145222,0.11899,1.1789,-0.544582,0.154656,0.495361,-0.442548,-0.182704,-0.255565,1.13859,0.922924,-0.585709,0.828766,1.45265,0.614493,-0.930257,-0.0721829,0.11123,-0.664117,-0.26278,0.494214,-0.109693,0.223373,0.484477,-0.255602,-0.82668,0.190561,0.0861393,-0.259636,-0.427856,0.601487,-0.246921,0.0779852,1.04256,-0.695668,-0.936781,0.136795,0.0119955,-0.0926218,-0.404097,0.278782,0.145966,0.327134,0.525506,0.713156,0.0352462,0.221624,0.253672,0.524606,0.299713,0.0109057,0.551497,0.868923,-0.139734,0.195608,0.418208,-0.103673,-0.0657077,-0.0228576,-0.701595,0.296995,-0.524982,0.290275,-0.0149711,0.22152,0.147017,-0.121051,-0.174429,0.331771,-0.197402,-0.32121,0.316588,-0.296,0.117069,-0.596729,0.15747,0.0424565,0.347699,0.140528,-0.487544,-0.0707904,0.0311833,0.41445,-0.0788604,0.265024,0.161626,0.0769034,-0.161152,0.0498368,-0.168416,0.719526,-0.0180647,-0.440866,-0.0172009,0.0101086,-0.209008,-0.200445,-0.0224136,0.315574,0.314473,0.0699823,-0.577292,0.163065,0.121472,-0.0172942,0.139751,-0.0611124,-0.389308,0.352402,0.194628,0.371087,-1.10574,-0.567553,-0.0585196,-0.168739,-0.75149,-0.586545,-0.619746,-0.288794,0.470391,-0.121632,-0.0416391,-0.276952,-0.094307,-0.0153916,0.0466173,0.433718,0.0840882,0.498008,-0.186025,0.343515,0.0680037,-0.059544,0.10541,0.647544,0.26841,-0.312271,-0.0575543,-0.00660256,-0.39244,-0.046772,-0.0818501,0.280773,0.396263,0.0903814,-0.611718,-0.279691,0.229504,-0.352176,-0.218403,0.352895,0.519159,0.236568,-0.0744307,0.449803,-0.263382,-0.155014,-0.22574,-0.904612,-0.428008,-0.307006,-0.45193,0.132998,0.135273,0.389224,-0.774568,-0.125338,0.0504539,-0.400069,-0.592638,-0.794669,0.0383719,-0.148513,0.00450185,-0.153581,-0.162065,0.771092,0.346686,-0.453014,0.436403,-0.455343,0.091872,-0.174257,0.159834,0.440124,0.202916,-0.827649,-0.206423,-0.0672432,0.0623594,-0.402616,0.241445,-0.0105276,0.23501,-0.304137,0.791035,-0.603248,0.2318,-0.448151,-0.422055,-0.245207,-0.175792,-0.165498,0.233097,-0.220591,-0.120456,-0.101288,0.207831,0.193694,0.0722865,0.162139,-0.509522,-0.130312,-0.109542,0.102584,-0.0467341,0.34409,0.00261973,0.727614,0.0534075,0.230868,-0.338331,0.128731,-0.735322,0.0890892,0.131828,-0.296414,0.0600553,-0.303581,0.166977,0.427328,-0.239724,0.0591233,0.0903906,0.346297,-0.0858132,0.246474,0.259427,-0.037737,0.0130262,0.0125924,0.112493,-0.204251,-0.234488,0.130635,-0.176345,-0.0153412,0.273797,-0.137073,-0.495001,0.253056,-0.297158,0.532614,-0.256453,-0.108838,0.354669,-0.0758214,0.0114893,-0.0436149,-0.0210159,-0.0601512,1.01296,0.244283,-0.106003,-0.140982,-0.192563,-0.342248,-0.127328,-0.46254,-0.0194936,-0.397095,-0.158504,-0.491871,0.11515,0.316288,0.339338,0.562395,-1.08526 +3434.01,0.542558,0.0912059,4,1.50149,0.752536,-1.63012,0.809772,0.28081,-0.0884024,-0.140775,0.078802,0.318518,0.151537,-0.0917846,-0.166572,-0.186594,0.571438,-0.267991,0.726444,0.159251,-0.251279,-0.36653,0.46015,0.0920398,-0.76733,-0.666888,0.798231,-0.325377,0.376203,0.229876,-0.256785,-0.0116313,0.232188,1.30569,-0.306588,0.138248,0.597947,-0.938308,-0.0759796,-0.413761,1.06717,0.861013,-0.232039,0.96607,0.890054,0.324569,-0.94997,-0.411729,0.610013,-0.932466,-0.787786,0.211704,0.00750778,0.0511871,0.647032,-0.292885,-0.299142,-0.0220354,0.179619,-0.237355,-0.69264,0.0170499,-0.155769,0.353243,1.00327,-0.698441,-0.706895,0.219659,0.449905,0.129537,-0.103402,0.54029,0.428657,0.285799,-0.0755508,0.660573,-0.0609116,0.598511,0.294461,0.477239,0.105075,-0.441266,-0.143787,0.842769,0.274376,0.264916,0.358441,-0.00407305,0.0759084,0.0714473,-0.22204,-0.0946496,-0.550999,0.0208417,-0.174785,0.226386,0.198994,0.0227527,0.0695565,0.0394835,-0.551365,-0.138628,0.404922,-0.137206,-0.114892,-0.575331,-0.185489,0.0604276,-0.0140865,0.368034,-0.528753,0.449335,-0.0293224,0.181644,0.294147,0.449109,0.56462,-0.380017,0.266561,0.278665,-0.256796,0.113241,-0.0461778,-0.640697,-0.209067,-0.279125,-0.616044,-0.184446,0.565023,0.27706,0.127425,0.38421,-0.279026,-0.0662818,0.00231432,0.151544,0.113301,-0.126784,-0.367913,0.236837,-0.546894,0.37828,-0.96642,0.22209,-0.154354,0.20316,-0.220237,-0.402846,-0.22072,0.156688,0.410339,-0.335399,-0.0236319,-0.356726,0.414972,0.0374804,-0.230478,0.141563,0.235336,0.30127,0.149413,-0.13005,0.127284,-0.137735,-0.281676,0.615344,0.498794,-0.0498558,0.442049,-0.148748,0.252892,-0.302202,0.0502417,0.650744,0.0608466,-0.0280182,-0.574882,0.22032,0.135592,-0.632969,0.158906,-0.166194,0.587967,-0.095981,-0.527309,0.550076,-0.0355104,-0.309677,-0.221123,-0.102208,0.128025,-0.0760688,-0.391097,0.273293,-0.200319,0.618196,-0.180384,0.143832,-0.411425,-0.355485,-0.0795178,-0.256715,-0.137229,-0.49505,-0.26668,-0.148695,0.337349,0.180254,0.169599,-0.433441,0.716771,-0.540147,0.29104,-0.384347,0.416182,-0.0492545,0.0974986,-0.379491,-0.0955815,-0.073619,-0.212006,0.0609362,0.446431,0.0474042,-0.324388,0.140679,0.639133,-0.303713,0.38041,0.324775,-0.20785,-0.0635933,-0.301162,-0.46912,-0.198873,-0.446356,-0.10413,-0.261113,0.684601,0.0979345,0.335079,0.0836638,-0.310443,-0.291397,0.049306,0.232608,0.455254,0.150939,0.0242859,0.485584,-0.0181306,-0.157813,0.12381,0.262159,-0.547221,0.1275,0.0603262,-0.324264,-0.176354,-0.217591,0.416374,0.436289,-0.1103,0.115123,-0.490723,0.493218,-0.209606,0.168366,0.174118,-0.244046,-0.0944125,0.205981,-0.0317435,0.0378123,-0.300105,0.303226,-0.207911,-0.218324,0.117663,0.195628,-0.0821901,0.0300802,0.128683,-0.221942,-0.415944,-0.133618,0.162047,-0.105483,-0.296824,0.206574,-0.0633381,0.314625,0.233436,-0.121835,0.119632,0.0371094,0.33454,-0.0500832,-0.356097,-0.487631,0.085413,-0.289643,-0.227085,-0.259325,0.0992079,0.280273,0.314973,0.529409,-0.650556 +3442.36,0.677092,0.0912059,4,1.53107,0.796136,-1.68427,0.780543,0.482305,-0.0204171,-0.141051,-0.40727,0.399793,-0.103586,0.0300499,0.140608,0.0338778,0.242428,0.322753,0.908221,0.327788,0.293761,-0.291727,0.126898,0.191847,-0.873357,-0.322294,0.697348,-0.222435,0.301659,-0.165922,0.308813,-0.710301,0.0976211,1.25427,-0.380284,0.0670286,0.461695,-0.481464,-0.382477,-0.195008,0.93399,0.696751,-0.220125,0.840719,0.905651,0.558565,-0.98387,-0.0935285,0.78412,-0.791654,-0.249353,0.330082,-0.549125,0.0707354,0.733157,0.0221171,0.169793,-0.316212,0.0631246,-0.347249,-0.915969,0.453843,-0.388826,0.454663,1.02643,-0.342832,-0.493689,0.408954,0.327034,0.262424,0.25005,-0.296509,0.0803109,-0.0227651,0.269217,0.47624,-0.39399,0.489322,0.211356,0.402018,0.402975,-0.422045,-0.348605,0.25527,-0.459874,-0.35144,0.218565,-0.174538,-0.303192,0.132397,-0.16516,-0.107552,-0.511009,-0.346061,-0.146333,-0.281841,0.113894,-0.0967005,-0.0659394,-0.0423761,-0.555834,-0.0686467,0.145186,-0.129075,-0.306711,-0.0581165,-0.209641,0.42278,0.378871,0.581658,-0.268009,0.723861,0.506719,0.157942,0.138373,0.089734,0.458111,0.00336814,-0.0734137,-0.691539,-0.125546,0.0743409,0.223424,-0.123148,-0.0699736,-0.12244,0.108241,0.580378,0.514305,-0.320302,-0.217605,0.196868,-0.0871007,0.329962,0.201016,-0.226129,0.22978,-0.195238,0.218314,-0.183967,0.205851,0.384006,-0.300707,-0.287177,-0.0598552,0.0528196,-0.00458459,0.172912,0.405357,0.0162743,0.282955,-0.471573,-0.758521,-0.261229,-0.476003,0.141168,-0.131561,0.356129,0.1652,-0.621238,-0.120796,0.0166393,-0.63781,0.569851,-0.22573,0.78134,-0.0110575,0.0569802,0.0456711,-0.148835,0.0207449,-0.0626281,0.0806606,-0.137804,0.324378,0.261477,0.084229,0.0948062,-0.299749,-0.327321,-0.300279,-0.303154,0.591126,0.0884461,0.0346273,0.125836,-0.0720096,-0.189174,-0.322264,-0.187799,-0.242247,-0.167902,-0.608885,-0.0626885,-0.00107272,-0.132296,-0.503133,-0.0209589,0.0516737,0.0388786,-0.368078,-0.115093,-0.411253,-0.128926,-0.180129,-0.338344,0.292985,-0.119676,0.109794,0.0468466,0.516187,0.309943,0.245635,0.110358,-0.270129,0.207526,0.525861,-0.15904,-0.124703,-0.365922,0.210896,0.139091,-0.367723,0.281194,-0.420933,-0.152475,-0.171184,0.457077,0.219716,0.126434,-0.373932,0.416421,0.273681,0.129032,0.614818,0.209589,-0.302688,0.0494045,0.362087,0.279052,0.16312,0.646838,0.11389,0.0953124,0.25658,0.344017,0.176704,-0.304279,0.0574776,0.482935,0.330576,0.00450999,-0.186437,-0.122406,-0.433812,0.550389,-0.128914,-0.399534,0.232737,-0.575344,-0.19852,-0.15993,-0.263681,0.449245,-0.232514,-0.467998,-0.308022,0.388072,0.157376,-0.378357,-0.74544,0.0764962,-0.108291,-0.545988,-0.328419,0.0778441,-0.0691854,0.124278,-0.0301887,0.0636757,0.325978,0.218086,0.243268,-0.607286,0.0191435,0.195894,0.250834,0.0293014,-0.0783591,-0.239349,0.327045,0.0499691,-0.577222,0.315101,-0.495579,0.143775,0.177878,-0.515875,-0.665514,-0.914498,-0.435175,0.223241,0.410743,-0.188206,0.0959866,0.286253,0.309817,0.535026,-1.3278 +3432.04,0.891817,0.0912059,4,1.51378,0.903053,-1.63966,0.781605,0.598543,0.0391478,-0.165352,-0.104549,0.596285,0.448506,0.294178,-0.292273,-0.690062,0.364105,-0.220817,0.898423,-0.108864,-0.292988,0.106582,-0.228361,0.00130276,-0.617789,-1.28239,0.687967,-0.520478,0.261436,0.550968,0.83474,0.0470664,-0.102582,1.07411,-0.492904,0.231155,0.499294,-0.570736,-0.305383,-0.67487,0.66967,0.756127,-0.380961,0.921161,0.897986,0.523159,-1.0425,-0.403533,0.486268,-0.416354,0.381947,0.154104,-0.349041,-0.0559402,0.762146,-0.172885,-0.683773,-0.359004,-0.11667,-0.38306,-0.569754,0.134568,-0.362409,0.621369,0.897146,-0.858906,-0.542518,-0.404989,0.0743362,-0.0518005,-0.168971,0.509696,-0.859119,-0.247309,0.241076,0.482805,-0.487766,0.267381,0.667855,0.181845,0.0357366,0.0191167,-0.0759143,0.395111,-0.153394,0.0814818,0.318232,-0.233283,0.00157094,-0.275175,-0.0616969,0.327973,-0.380936,-0.207734,-0.085866,-0.149375,-0.177886,-0.203535,-0.903456,0.627451,0.292966,-0.838021,-0.11418,0.297038,0.327278,-0.521173,-0.066307,-0.227999,0.114007,0.573871,-0.191567,0.538244,0.372686,0.12188,0.115994,0.0774635,0.681116,-0.0090009,0.256723,-0.443964,0.162205,0.606707,-0.264786,-0.8807,0.335752,-0.0269504,-0.0457295,-0.22792,0.0983241,-0.138202,0.18849,0.306401,-0.48173,0.201497,0.0505953,0.0848938,0.213593,-0.135619,-0.122382,0.401416,-0.41805,0.0867609,-0.23867,-0.0670865,-0.176287,0.0447231,-0.300543,-0.298748,-0.376185,-0.375521,0.8786,-0.381754,-0.0539577,-0.0574166,0.346908,0.21652,-0.0685296,0.242198,-0.0558436,0.214577,0.214174,0.351349,0.242014,0.210535,-0.170798,0.755528,0.117517,-0.366375,0.168816,-0.0761206,0.683933,-0.698244,0.126816,0.064095,-0.263933,0.0769789,0.0764224,0.262223,-0.224185,-0.581892,0.0689789,0.283671,0.508179,-0.113901,0.333412,-0.0372463,0.0678346,-0.185496,0.465383,-0.327597,-0.166793,0.637765,-0.522739,0.173794,-0.0376728,0.339291,-0.129942,0.431043,0.327308,0.140546,-0.494013,-0.485773,-0.0262346,-0.433299,0.337997,0.267473,-0.113555,-0.0252479,-0.458342,-0.233865,0.66877,-0.391626,0.301693,0.243765,0.159865,0.125077,0.038984,-0.0277088,0.0873709,0.298582,0.0168617,-0.172067,-0.710308,0.310399,-0.173586,-0.498059,0.412468,-0.456596,0.297723,-0.0824792,-0.186931,0.249664,0.0992206,0.0802266,-0.0781514,-0.0207698,-0.0862654,-0.263366,0.513693,-0.268999,0.0444501,0.582564,-0.182286,-0.00290992,-0.0451458,-0.200543,-0.00376299,0.200198,0.400448,0.243571,-0.506421,-0.317099,-0.284393,0.0318022,-0.590907,0.124788,-0.0938964,0.059606,0.227385,-0.101802,0.281834,0.354096,-0.392151,-0.21673,-0.389677,0.550882,0.0242384,-0.13173,0.0848448,-0.524165,0.171756,0.61397,-0.120801,-0.312553,0.107967,-0.433833,0.11382,0.118234,0.166897,-0.0268921,-0.471779,0.221917,0.320564,-0.226915,-0.139641,-0.245916,-0.134302,-0.0783356,0.570767,-0.276462,-0.268138,-0.115555,0.255474,-0.00946409,0.085206,0.0836865,-0.0361103,-0.341,-0.665635,0.00813392,0.0566766,-0.494378,-0.290571,-0.396946,0.106024,0.289529,0.325613,0.538079,-1.95934 +3434.42,0.521863,0.0912059,4,1.48996,1.08672,-0.897694,0.390006,0.947948,-0.0738434,0.381442,0.169722,0.12856,-0.268475,0.168877,0.0348672,-0.0608515,0.179076,-0.21151,1.03615,-0.041684,0.274023,-0.098261,0.215577,-0.575965,-0.897763,-0.380625,0.22493,-0.31504,0.664263,0.201165,0.440404,-0.246149,0.619114,1.00784,-0.355524,0.199839,0.569599,-0.549284,-0.109823,-0.305134,0.543872,0.500059,-0.123773,1.0659,0.665739,0.619366,-0.86003,-0.0416678,0.370562,-0.479591,-0.287203,0.119355,-0.156478,-0.409483,0.609814,0.181226,0.533441,0.153941,-0.746294,0.0828274,-1.17813,0.463473,-0.607171,0.0615423,1.43362,-0.24169,-1.14216,0.362389,0.0745406,0.0570973,0.358719,-0.155541,0.237836,0.141266,0.339824,0.596992,0.454059,0.660635,0.203592,0.401851,0.142872,-0.560331,0.117217,0.390736,-0.128009,-0.0612152,0.0298285,-0.243119,-0.379027,0.320566,-0.125676,-0.325803,-0.610662,0.0592562,0.301872,0.202075,0.375794,0.0400144,0.758322,-0.332071,-0.211532,1.15689,0.249841,-0.312104,-0.171892,0.216219,-0.0695114,0.328909,-0.246809,-0.0338669,-0.35259,0.0742495,0.404608,-0.166385,-0.324684,0.0993433,0.393542,-0.00435368,-0.179509,-0.141214,-0.269243,-0.413825,0.150971,-0.285535,-0.271629,-0.0863926,-0.277217,0.256803,0.447129,0.715254,-0.0983034,0.15579,-0.103145,0.375087,-0.0580753,0.0394843,0.435168,-0.104899,0.282637,-0.145678,-0.0722726,0.576426,-0.716914,0.0171502,-0.189043,0.429506,-0.712768,-0.000609365,0.424268,-0.0577234,-0.371471,-0.258865,-0.0603854,-0.00230506,-0.240322,0.0752206,0.0136559,0.319023,0.569374,0.110631,-0.202424,-0.332574,-0.690161,0.139183,0.343285,0.533127,-0.102056,-0.102056,0.220503,-0.304308,-0.278059,0.325731,-0.111186,0.251796,0.112537,0.0397363,0.153424,-0.43141,0.279643,-0.100526,-0.264105,-0.312977,0.376417,0.379802,-0.281524,0.53867,-0.0926303,0.296444,-0.755472,0.145492,-0.203256,-0.168784,0.405965,-0.213032,0.0966001,-0.316975,-0.405515,-0.139493,0.0372285,-0.276427,-0.00596911,-0.187633,-0.174639,0.0195078,-0.411243,-0.461504,-0.185425,-0.11439,0.22321,-0.616347,0.498127,0.63718,-0.00295527,-0.202626,-0.179281,0.0574206,0.363713,0.142695,0.0522509,-0.755473,-0.00233861,0.213432,-0.0819347,-0.0321075,-0.331095,0.279884,-0.0991711,-0.0315083,0.285564,-0.0311393,-0.197521,0.00464083,0.103144,-0.317045,0.113452,0.187401,-0.225616,-0.277438,0.0333641,0.411242,-0.134439,-0.0666732,-0.032674,-0.273498,0.304039,0.171692,0.208384,0.206193,-0.62943,0.517564,0.410249,0.157664,-0.197817,-0.194776,-0.141741,0.522549,-0.0451371,-0.240671,-0.00272752,-0.330678,-0.0654422,-0.047404,-0.0123341,0.451579,0.342686,-0.794298,0.00313541,0.160923,0.101369,-0.102262,-0.509791,-0.509919,0.0391643,0.180839,-0.710511,0.259426,0.0182734,-0.0135336,-0.167023,-0.0116679,0.258658,-0.0719558,-0.160744,-0.123391,-0.128842,0.0261247,0.299001,0.0858028,0.0288102,0.0365521,0.692584,0.188441,-0.0544903,0.198577,0.265528,-0.433309,0.0164787,-0.0829305,0.00211228,-0.175071,-0.28178,0.0769357,0.11512,0.239505,0.102303,0.343451,0.319849,0.586047,-3.45804 +3426.99,0.869499,0.0912059,4,1.46805,1.05851,-0.954809,0.429947,0.93604,-0.112225,0.448931,0.313436,0.430098,-0.392655,0.20761,-0.00647841,-0.0666104,0.245163,-0.110176,1.07854,-0.147903,0.177626,-0.229783,0.180769,-0.585254,-0.731365,-0.352226,0.0644729,-0.262403,0.48792,0.0600064,0.413488,-0.21342,0.580668,1.10639,-0.308691,0.136224,0.579613,-0.672713,-0.168477,-0.452355,0.484293,0.621856,-0.111088,1.12184,0.772785,0.517664,-0.80485,-0.0860704,0.334068,-0.622642,-0.245341,0.107691,-0.141067,-0.44702,0.678077,0.101388,0.58905,0.13784,-0.669568,0.141713,-1.08245,0.463546,-0.347237,0.0312732,1.39201,-0.375387,-1.3665,0.247816,0.0650968,0.0770458,0.405572,0.00597429,0.165051,0.124667,0.385166,0.61385,0.536605,0.445071,0.19766,0.435485,0.257057,-0.562083,0.00855568,0.498181,-0.17581,-0.0411542,0.155747,-0.279944,-0.293636,0.0233435,-0.108962,-0.0148366,-0.642508,0.156235,0.360806,0.112912,0.412274,0.0477636,0.589519,-0.271761,-0.258627,0.853778,0.193237,-0.178612,-0.285819,0.0467916,-0.278537,0.471092,-0.213563,-0.150403,-0.233915,0.0379313,0.426813,-0.270056,-0.268314,0.254472,0.409094,-0.0621093,-0.138105,-0.147772,-0.226446,-0.507885,0.0146686,-0.185136,-0.373918,0.16543,-0.203141,0.441052,0.343929,0.890653,-0.224775,0.146733,0.0402492,0.286858,0.0913746,0.244595,0.565428,-0.0141189,0.416402,-0.201082,0.00484339,0.452716,-0.737293,0.0357576,-0.192032,0.167888,-0.83542,0.0654153,0.44444,-0.0783754,-0.307874,-0.198194,0.0300609,0.0835338,0.0157711,0.0942347,0.056563,0.298891,0.730704,0.0522879,-0.205701,-0.317493,-0.794651,0.2794,0.157723,0.601902,0.0345739,-0.200983,0.202656,-0.305279,-0.246978,0.512519,-0.234437,0.242868,0.170052,0.155787,0.274668,-0.465437,0.210686,-0.0576786,-0.251425,-0.357028,0.260196,0.487496,-0.0434736,0.588405,-0.176926,0.133933,-0.53947,0.195596,-0.141376,-0.324322,0.422205,-0.308492,-0.0388499,-0.161434,-0.477383,-0.295078,0.0185575,-0.249899,-0.157796,-0.281232,-0.0652831,0.0790888,-0.350838,-0.483349,-0.2392,-0.0835622,0.231755,-0.694312,0.542156,0.601699,-0.079192,-0.13462,-0.20675,0.0139996,0.213018,0.117514,0.0301429,-0.775261,0.0286799,0.194358,-0.0249467,0.220423,-0.290575,0.105412,0.095146,0.0196387,0.290612,-0.0499239,-0.188331,-0.120975,0.197201,-0.146111,0.0572303,0.196432,-0.304634,-0.286162,-0.0148052,0.107968,-0.188563,-0.0856344,-0.0894272,-0.17462,0.391478,0.237238,0.247274,0.189962,-0.487709,0.551634,0.555639,0.182356,-0.241331,-0.310261,-0.312272,0.574994,-0.102154,-0.139498,-0.031617,-0.350127,-0.0591051,-0.476366,-0.0335725,0.214061,0.266277,-0.676331,-0.150212,0.0572088,0.0420598,-0.0480638,-0.530087,-0.61556,-0.0315838,0.303587,-0.781722,0.302146,0.0435819,-0.155628,-0.137437,-0.100352,0.319585,0.00623631,-0.247155,-0.384701,-0.14167,0.0201641,0.334009,0.110857,0.00941337,-0.02382,0.740204,0.248068,-0.227549,0.0970988,0.30904,-0.354321,0.11371,-0.0883657,-0.159192,-0.0927221,-0.250633,-0.0180343,-0.00835394,0.253641,0.0994383,0.363656,0.315338,0.603039,-3.38881 +3430.32,0.996436,0.0912059,4,1.47221,1.00431,-1.06381,0.542336,0.906193,-0.12973,0.656797,0.423606,0.653531,-0.314401,0.0972094,-0.0809131,-0.156755,0.326857,0.00341199,1.10406,0.0356795,0.184105,-0.294492,0.25375,-0.309857,-0.443656,-0.429327,0.287262,-0.297482,0.428902,0.208221,0.313864,-0.322295,0.533441,1.04076,-0.306918,0.207403,0.491566,-0.58285,-0.129789,-0.403916,0.721135,0.969888,-0.504096,1.18978,0.893747,0.408003,-0.811602,-0.254437,0.240555,-0.404128,-0.197315,0.127993,-0.219153,-0.333846,0.663551,0.0959935,0.62006,-0.0563739,-0.406945,0.114218,-1.00084,0.49715,-0.464873,0.16487,1.45312,-0.502976,-1.16026,0.249285,0.179518,0.325869,0.638221,0.324405,0.176542,0.122105,0.204364,0.58348,0.477304,0.693697,0.328301,0.508772,0.36273,-0.548866,0.0691921,0.630449,-0.337964,-0.0389764,0.186073,-0.082825,-0.485643,-0.0437665,-0.420588,-0.100538,-0.640553,-0.0833523,0.0312697,-0.00281215,0.488249,-0.347015,0.294181,-0.261052,-0.152585,0.724474,0.144135,-0.375206,-0.102191,-0.13108,-0.330043,0.60954,0.141869,-0.193331,-0.197486,0.100715,0.426972,-0.248678,-0.315709,0.0823528,0.641049,0.0681942,-0.0775274,-0.176194,-0.309028,-0.647657,-0.0218502,-0.154782,-0.0697549,0.117853,-0.104155,0.360992,0.535153,0.703218,-0.138748,0.278166,0.238943,0.221061,0.0507836,0.07072,0.500752,0.0411945,0.326539,-0.318832,-0.018002,0.584239,-0.718393,0.150357,-0.126245,0.335317,-0.821523,0.111593,0.470842,-0.268366,-0.101051,-0.446963,0.061526,0.359393,0.0599142,0.196326,0.0157127,0.100774,0.513631,-0.0510371,0.202103,-0.298183,-0.285823,0.166611,0.320094,0.631815,0.0864433,-0.106832,0.303576,-0.205084,-0.305443,0.576606,-0.152077,0.216872,0.0856524,0.222257,0.120356,-0.661622,0.217573,-0.134515,-0.339215,-0.310967,0.385524,0.35002,0.357743,0.606306,-0.269265,0.220027,-0.463447,0.11985,-0.0908721,-0.160357,0.303333,-0.327629,-0.190753,-0.204454,-0.443693,-0.472646,0.126222,0.0143796,-0.199806,-0.283418,-0.279713,-0.0626084,-0.32396,-0.228936,-0.16294,-0.180635,0.291251,-0.667303,0.703988,0.594368,0.0200118,0.0252856,-0.20306,0.00971018,0.0901164,0.114687,0.248764,-0.818437,0.0404289,0.149579,-0.0121781,0.186531,-0.581946,0.162748,0.0684027,-0.0534928,0.214117,0.273202,-0.31419,-0.220683,-0.0287115,0.0202071,0.238444,0.00919118,-0.477253,-0.349784,-0.0151171,0.0940042,-0.237858,0.083841,-0.126156,-0.206686,0.298799,0.180481,0.236664,0.289497,-0.189762,0.73408,0.559433,0.132323,-0.284396,0.0697282,-0.175182,0.718138,-0.223158,-0.353922,-0.255689,-0.418669,0.0251682,-0.0965517,-0.00165739,0.346476,0.340135,-0.298108,-0.0913626,0.341621,0.0380385,-0.0325314,-0.569084,-0.596328,-0.132975,0.0787323,-0.603604,0.27698,0.0328947,0.00303162,-0.148029,-0.0114224,0.389394,0.0797886,-0.533184,-0.114044,-0.0267365,0.164901,0.141122,0.282305,0.251433,-0.084206,1.09851,0.214053,-0.0966239,0.0286738,0.0825032,-0.45847,0.240109,0.0975668,-0.190154,0.0943152,-0.282442,-0.18636,-0.0349082,0.232679,0.0992856,0.293052,0.315096,0.541343,-3.23468 +3451.75,0.634434,0.0912059,4,1.57521,0.837733,-1.26931,0.578385,0.802392,-0.202524,0.0854127,-0.236421,0.373272,0.391626,0.0261211,-0.0672069,-0.108618,0.291435,-0.114509,0.824436,0.112861,0.1777,0.113545,-0.0334196,0.238343,-0.831175,-0.497574,0.393614,-0.186866,0.109077,0.231242,0.883708,-0.590544,0.427709,1.32784,-0.479048,0.6765,0.624622,-0.350599,-0.0800581,-0.715027,0.807004,0.743372,-0.0950572,1.06769,0.497719,0.502691,-0.660656,-0.191757,0.433797,-0.62005,0.0529528,0.291,0.00347356,-0.239737,0.152056,0.16098,-0.407,0.159319,-0.411811,0.281271,-0.972714,0.364454,0.0312919,0.284166,0.860939,-0.708614,-0.560609,-0.174103,-0.398641,-0.398012,-0.0547159,-0.140819,-0.332291,0.0360467,0.121365,0.353587,-0.349487,0.274232,0.775071,0.0138662,0.0440185,-0.217097,0.120254,0.306178,-0.357803,0.16146,-0.0777092,-0.0499292,-0.0419284,0.180002,0.262842,-0.269347,-0.616985,-0.0570123,0.417961,0.0874849,0.119669,-0.358466,-0.154834,-0.340114,-0.288263,-0.0547157,-0.422026,-0.207536,0.494191,-0.450642,-0.295658,-0.0540764,0.146678,0.450611,-0.207478,0.266505,0.723235,-0.193025,-0.0277275,0.281587,0.44623,0.73173,0.114894,-0.329882,0.205863,0.269755,0.0134848,-0.643924,0.268833,-0.259752,0.154936,-0.2676,0.170939,0.0393832,-0.0738272,0.289389,0.000545793,0.135119,0.0232459,0.317822,0.54209,-0.215315,-0.0406093,0.190171,0.0441653,0.256648,-0.355774,-0.28423,-0.110485,0.394241,-0.847438,-0.161364,-0.0374777,-0.0770089,0.152605,-0.522593,-0.247767,-0.75376,0.0809731,0.412958,0.268239,0.280671,0.393174,0.238439,-0.00966784,-0.0600814,-0.340638,-0.41042,-0.101243,0.703841,-0.228671,-0.324354,-0.0434812,-0.0471544,-0.171565,0.0455782,-0.0595564,0.290528,-0.162073,0.0531518,0.233146,-0.220566,-0.372871,-0.148539,0.133918,0.0780489,0.364537,0.384402,-0.288458,-0.00508555,-0.377317,-0.277143,0.564931,-0.0472925,-0.492875,0.234255,-0.278758,0.323074,-0.057582,-0.182816,-0.715023,-0.316137,0.275722,-0.192058,-0.34258,-0.485645,0.544385,0.0103737,-0.320157,-0.0203689,-0.283075,-0.11145,-0.0812358,-0.281439,0.435838,-0.0579843,-0.127952,-0.15424,-0.355398,-0.1745,-0.0300293,-0.219139,-0.0668384,-0.679209,-0.126326,-0.555805,-0.126299,0.177188,-0.245454,-0.303572,0.808272,0.00835753,0.355756,0.00227584,-0.122051,-0.0138322,-0.374157,-0.416058,0.251269,-0.310326,-0.719492,-0.879384,0.368163,-0.18044,0.0855467,0.314342,0.142637,-0.473436,0.0196597,0.0740462,-0.160848,0.091434,0.102574,0.666768,0.025484,-0.0181125,-0.408949,-0.207196,-0.497986,0.151751,-0.334795,-0.0791934,-0.160292,-0.486936,0.614625,0.376351,0.212539,-0.00881187,0.458848,-0.153433,0.359138,0.36094,-0.373775,-0.184229,0.474506,-0.0966972,0.0273127,-0.230821,-0.127276,-0.191955,-0.0927572,0.0509754,-0.525279,-0.0477621,-0.012566,-0.0539611,0.108536,-0.338466,-0.339326,0.345232,-0.509733,0.0835516,0.118969,0.0926479,-0.0939164,0.171513,0.749747,0.4555,0.367553,-0.00674229,0.0434225,-0.0735652,-0.22167,-0.27985,-0.0865074,0.405778,0.110956,0.0257341,0.112239,0.28424,0.335021,0.533142,-2.40061 +3447.29,0.999086,0.0912059,4,1.51946,0.918975,-1.05302,0.397784,0.785498,-0.195519,0.348075,0.545162,0.28014,0.0347631,-0.0063116,-0.0761506,-0.107384,0.376952,0.121999,0.950219,0.150574,0.311446,0.191824,-0.0855743,-0.0154857,-0.780359,-0.401896,0.216316,-0.343993,0.0293514,0.053243,0.667968,-0.459626,0.447103,0.970224,-0.478433,0.346473,0.553483,-0.27554,-0.343186,-0.462785,0.787066,0.625051,0.103714,1.16276,0.634084,0.75619,-0.851935,-0.150006,-0.0907489,-0.697683,-0.00433255,0.268884,-0.16611,-0.110086,0.362499,0.157347,-0.814779,0.455362,-0.699019,0.479382,-0.539958,0.0910938,-0.567377,-0.276885,1.06981,-1.13225,-0.360502,-0.0948387,-0.345184,-0.0148199,0.0324478,-0.207277,-0.270345,-0.232192,-0.278341,0.410627,-0.15033,0.227321,0.295749,-0.145373,-0.175396,-0.220754,0.0912457,0.321565,-0.614165,0.0938084,0.0892741,-0.119697,-0.277615,-0.230081,0.196832,-0.303995,-0.698826,-0.131782,0.399287,0.0311379,0.368742,0.322137,-0.0364494,-0.0555028,0.164705,-0.167373,-0.26851,-0.19469,0.118142,-0.248536,-0.539362,0.526251,-0.0196386,0.353698,-0.253446,-0.244816,0.540185,0.0629555,0.145891,0.487445,0.551398,0.333515,-0.0133967,-0.615361,0.151936,0.344862,-0.030551,-0.46211,0.303844,-0.219036,-0.0453555,-0.0557306,0.227031,-0.0923486,-0.046048,0.335884,-0.470067,0.148956,-0.00267354,0.0289358,0.487611,-0.409605,-0.592564,0.0797061,-0.0671285,0.0994071,-0.336194,-0.506959,-0.227286,0.388555,-0.597855,0.149465,0.170251,0.0784238,-0.0624642,-0.0947768,-0.57519,-0.169543,0.181056,0.574621,0.240499,0.506842,0.222219,0.121105,-0.253719,-0.0610992,0.00544591,0.0035618,0.121658,0.907828,-0.352328,0.0643603,0.0281562,-0.0867106,-0.139271,-0.207975,-0.240147,0.204976,0.116694,0.0500928,-0.219721,-0.404717,-0.234047,-0.177002,-0.0557634,-0.0975639,0.414774,0.392279,-0.224824,0.159187,-0.444093,-0.419113,0.260507,-0.266531,-0.374558,-0.0847367,-0.453577,0.295634,0.183322,0.0759546,-0.938308,-0.613764,-0.28462,0.639582,-0.48706,-0.307276,0.0805664,-0.285867,-0.17229,0.179845,-0.200725,-0.262914,-0.735624,-0.416147,0.593259,0.0341269,0.437775,-0.0623803,-0.542801,-0.0392046,0.162597,-0.230074,0.0392431,-0.48493,-0.381905,-0.147739,-0.234235,0.221511,-0.194929,0.0943019,0.253564,0.22689,0.321682,-0.255941,-0.337083,0.538322,-0.0575036,0.0417037,0.387741,-0.412398,-0.684047,-0.968526,0.381498,-0.2254,0.210047,0.806758,-0.0502719,-0.109135,0.422918,0.209423,-0.0759674,0.0136281,0.117737,0.84902,0.0376985,-0.216449,-0.263355,-0.67762,-0.0310796,0.405644,-0.353759,-0.0937794,0.207445,-0.332465,0.138458,0.376593,0.213155,-0.100663,0.79386,-0.0783994,0.285028,0.293879,0.0595044,0.0829011,0.0242964,-0.229858,-0.411813,-0.470411,-0.0286648,-0.221624,-0.0673226,0.294945,-0.521245,-0.179684,0.103176,0.127921,0.234222,-0.290938,-0.211248,0.148897,-0.577059,0.0671446,-0.159415,0.501044,-0.0106028,0.146476,0.114546,0.0885485,0.403189,-0.152779,0.265122,0.282824,-0.154438,0.492639,0.042334,-0.0153395,0.276711,0.398158,0.091772,0.216713,0.302939,0.465525,-2.48801 +3445.91,0.866481,0.0912059,4,1.57349,0.94503,-1.06063,0.413982,0.584493,-0.18523,0.194689,-0.17608,0.356857,0.367372,-0.184671,-0.095863,0.0932521,0.165918,-0.0254154,0.764663,0.199293,0.504931,0.0370197,-0.0916815,-0.180463,-0.783125,-0.633234,0.371841,-0.12757,0.187868,-0.142539,0.303597,-0.108661,0.19047,0.900229,-0.677182,-0.0475952,0.0998736,-0.463753,-0.0503441,0.115607,0.205805,0.509775,-0.236826,1.20668,0.674543,0.813314,-0.675025,0.0103418,0.398999,-0.449112,0.196335,0.351811,-0.426809,-0.210641,0.631744,0.0939742,-0.638064,0.245045,-0.365738,0.304986,-0.693698,0.328058,-0.800148,-0.228928,1.00288,-1.06943,-0.247346,-0.476893,0.177781,0.431046,0.0919646,-0.127284,0.00235713,0.0461717,-0.253876,0.213453,-0.226061,0.429737,0.392699,-0.0632884,0.00506571,-0.270292,0.305638,0.182875,-0.456191,-0.0666202,0.289064,0.160048,-0.112793,-0.0789689,-0.216162,-0.150102,-0.511911,0.306111,-0.0455602,0.341174,0.297686,0.173666,0.0499077,-0.111142,0.0726337,-0.0345805,-0.257646,0.187938,-0.0624783,-0.43827,-0.182234,0.167209,-0.156988,0.295088,-0.304381,0.122612,0.58982,-0.399765,0.270307,0.395987,0.366817,-0.0803067,-0.228007,-0.650425,0.451519,0.262278,-0.0254847,-0.509782,-0.0337924,-0.387921,-0.163923,-0.196552,0.152264,-0.178176,-0.260566,0.0624011,-0.410809,0.103269,0.103087,-0.100121,0.38028,-0.232353,-0.632486,-0.213669,0.0252636,0.223345,-0.325155,-0.323617,-0.0840637,0.32106,-0.61126,0.177658,-0.177726,0.377813,0.092106,-0.231732,-0.515038,0.301086,0.295684,0.305235,-0.236012,0.133518,0.0625974,-0.0237164,-0.212393,-0.27427,-0.0193566,0.108174,-0.0427268,0.9616,-0.359921,0.0785572,0.54743,-0.0799659,-0.252093,-0.11863,-0.556993,0.250056,-0.283886,0.0965034,-0.0181228,-0.0246373,-0.284365,-0.137605,-0.0917916,-0.181394,0.505887,0.390812,0.154693,0.146738,-0.0793187,-0.018727,-0.328834,-0.735239,-0.35359,0.246889,-0.492842,0.361365,0.265883,0.0888504,-0.653968,-0.624388,-0.160271,0.345625,-0.552028,-0.252945,0.170232,-0.182291,-0.305786,0.283891,0.0924722,-0.721701,-0.418246,-0.743339,0.743487,-0.199353,0.183308,-0.0939742,-0.131865,0.0443838,-0.0113393,-0.290766,0.184377,-0.214814,0.0408746,0.0808705,0.0410447,-0.0532569,0.141116,-0.677676,0.00942182,0.282121,0.113555,0.11641,-0.301091,0.452243,-0.00852837,-0.0897588,0.178612,-0.393521,-0.658515,-0.888811,0.270128,-0.109055,-0.0956178,0.744301,-0.082382,-0.174206,0.502114,0.266963,0.195818,0.0378855,0.140399,0.918062,0.320826,-0.165749,-0.0342541,-0.611966,-0.32021,0.433286,-0.466154,0.253321,-0.00550237,-0.288419,0.2839,0.121389,0.0177739,0.200368,0.949733,0.180402,-0.0908052,0.388166,0.255023,0.0522813,0.128395,-0.17678,-0.356688,-0.678403,0.183953,-0.0623605,0.053291,-0.00364134,-0.559487,-0.271143,0.290627,0.109543,0.135858,0.181848,-0.0294236,0.154171,0.143858,0.151717,-0.348828,0.255314,-0.310736,-0.191218,0.197354,0.24085,0.294956,0.152138,0.204106,0.345443,-0.0765675,0.208897,-0.0486623,-0.00979692,0.230438,0.32812,0.104275,0.194875,0.322916,0.441447,-1.82669 +3404.71,0.673665,0.0912059,4,1.50349,0.949907,-0.455941,0.123157,0.496864,-0.433388,-0.0772702,0.229823,-0.189113,0.297413,0.0837672,-0.155201,-0.26943,0.037845,-0.769034,0.737962,0.0503189,0.699081,-0.230306,-0.318551,0.108333,-0.877682,-0.633831,0.259851,0.107171,-0.158009,0.262755,0.506617,-0.673788,0.138488,1.2465,-0.35531,0.238652,0.501209,0.0218979,0.102377,-0.961911,0.750732,0.180892,0.0695225,1.2342,0.211442,-0.231663,-0.304759,-0.713326,0.0217709,-0.466455,-0.281552,0.446531,0.306926,0.407718,0.265019,0.150924,0.369082,0.703417,0.132449,0.0566234,-0.511532,0.455344,-0.211671,0.242169,0.758556,-0.498499,-0.881029,0.111317,-0.17344,-0.0716555,0.576631,0.264489,-0.54797,0.312579,0.683497,0.996096,-0.033878,0.443151,0.475108,-0.504529,-0.114994,-0.0450226,-0.26967,0.789915,0.253347,0.215209,-0.251568,-0.28975,-0.403989,0.0312329,-0.0305263,0.169543,-0.879635,0.539769,0.356501,-0.171359,-0.341489,-0.310647,-0.853366,-0.0382153,-0.343072,-0.240923,-0.0782603,-0.298453,-0.825802,-0.026077,-0.0141288,-0.618803,-0.0361021,0.116273,-0.125074,0.218541,0.354525,-0.169198,-0.43632,-0.196314,0.615306,0.105714,-0.408983,0.0386352,-0.0886922,-0.282061,0.142688,-0.862353,0.264824,-0.0604231,0.120572,0.388395,-0.0504508,0.0222629,-0.128459,-0.0587321,-0.415988,0.0535335,0.457348,0.0350158,0.641208,-0.110785,-0.373882,-0.00938205,0.130456,0.472476,-0.683306,0.123491,-0.157761,-0.251834,-0.776972,-0.149584,0.0983468,0.375304,0.515418,-0.421288,0.168681,-0.204065,0.233251,-0.148456,-0.257525,0.755647,0.543586,0.577064,-0.148588,-0.398809,0.355317,-0.0687102,0.0114161,0.814084,0.255172,-0.857975,0.38191,0.0970499,-0.0464158,-0.773878,-0.826715,0.0972423,0.243015,0.0768158,0.0883654,-0.418677,0.613723,-0.330842,0.208516,0.486847,0.688691,0.154011,-0.697478,0.397018,0.290194,-0.0338791,-0.19245,-0.152157,0.0882554,0.0429545,-0.0272795,0.234121,0.832586,-0.0368458,-0.528641,-0.4241,0.392202,0.46654,-0.560235,-0.200173,-0.307015,-0.190952,-0.155416,0.127034,0.128606,-0.055174,0.288908,0.0240227,0.395053,-0.247911,-0.136408,0.0227292,0.154407,-0.0316675,0.300823,-0.132277,0.00420307,-0.0899781,-0.289765,-0.0570531,-0.275153,0.0565563,-0.13694,0.141273,0.315477,-0.386292,0.510402,-0.461852,-0.145303,0.367044,0.298928,0.0963174,0.166317,-1.11474,-0.359212,-0.214674,0.684058,0.350291,0.558468,0.257455,0.182007,-0.191808,0.356346,-0.102885,0.13157,1.03683,0.325061,0.596837,0.284312,-0.346496,-0.117099,-0.0398186,-0.138929,0.565055,-0.465193,-0.0832639,0.579544,-0.142819,-0.206345,0.471131,0.517936,-0.447771,-0.443411,0.41995,0.777634,0.253186,-0.0710569,-0.122324,-0.785404,0.206391,-0.0559196,0.505864,-0.133973,0.282895,0.424815,-0.0949613,0.14193,0.251941,0.135856,-0.0129424,-0.0624934,0.0441774,-0.257184,0.13713,-0.00400429,0.282999,0.339123,-0.143224,0.206309,0.502954,-0.262556,0.439287,0.223743,0.224955,0.13041,0.295703,0.0395368,0.139224,0.425508,-0.301972,-0.26078,-0.0055132,0.142958,0.223214,0.378098,0.472455,-1.59427 +3399.08,0.873692,0.0912059,4,1.48151,0.887558,-0.617646,0.152926,0.533511,-0.400337,-0.128635,0.190307,-0.219876,0.104155,-0.0642624,-0.0752098,-0.308626,-0.0805213,-0.71609,1.02042,0.0577547,0.640872,-0.239497,-0.282663,-0.130159,-0.780196,-0.511517,0.223876,0.244211,-0.22409,0.212561,0.701329,-0.662095,0.176044,1.11792,-0.090986,-0.0658491,0.614708,0.0723802,0.0901597,-0.890448,0.935617,0.0826468,0.0206814,1.31513,0.120266,-0.276327,-0.280388,-0.720773,0.010021,-0.315932,-0.119063,0.358702,0.0464829,0.55351,0.398559,0.0152151,0.160849,0.759561,-0.00284794,0.0907708,-0.427089,0.538701,-0.346101,0.251064,0.741241,-0.694054,-0.809665,0.0775899,-0.245231,-0.255112,0.533906,0.122663,-0.395197,0.0551985,0.491814,1.02193,-0.0982826,0.18795,0.392638,-0.296063,0.0197388,-0.051747,-0.243244,0.616793,-0.0934879,0.0925215,-0.148055,-0.211585,-0.208802,0.0317116,-0.107546,-0.0554919,-0.954827,0.571624,0.106382,-0.209538,-0.454842,-0.445717,-0.908413,0.10118,0.114096,-0.365134,-0.202815,-0.311229,-0.559141,-0.200059,0.14953,-0.496046,0.0366197,-0.101219,-0.12277,0.528363,0.375034,-0.322453,-0.522828,-0.095309,0.605221,0.00288553,-0.506676,-0.289358,-0.100495,-0.123801,0.0810552,-0.990232,0.242607,0.107575,-0.133673,0.286196,-0.011499,0.250882,-0.00234124,0.178181,-0.653048,-0.00344462,0.524583,0.0684727,0.439083,-0.147785,-0.299284,0.0828208,0.129609,0.318377,-0.634121,0.220724,-0.21967,-0.140175,-0.693446,-0.126191,0.215655,0.274859,0.747325,-0.375764,0.225568,-0.185248,0.108388,-0.1288,-0.254632,0.913429,0.471855,0.678723,-0.233112,-0.465453,0.568893,0.0620243,0.0368827,0.732144,0.305931,-0.782414,0.237936,0.0782369,-0.00777937,-0.438081,-0.666683,-0.0841742,0.137975,0.201073,0.178542,-0.497641,0.540886,-0.497935,0.283493,0.041216,0.672517,0.38553,-0.843664,0.126535,0.0742808,0.0691036,-0.0710023,-0.0853383,0.172335,0.208327,0.0615427,0.0293869,0.841241,-0.0581122,-0.472863,-0.397071,0.4653,0.531637,-0.563612,-0.266566,-0.00611837,-0.13987,-0.0802555,0.221366,0.0201267,-0.104729,0.207366,0.0267946,0.452721,0.0666776,-0.0724009,-0.0526208,0.125752,0.413786,0.325123,-0.247888,0.0833646,-0.14398,-0.172424,-0.0725718,-0.296496,0.112947,-0.160832,0.0114301,0.136645,-0.333057,0.528686,-0.288546,-0.122504,0.246067,0.222267,0.162718,0.226592,-1.23502,-0.331168,-0.235289,0.572673,0.604674,0.417379,0.247635,0.197943,-0.37379,0.277246,-0.136961,0.164269,1.04633,0.151509,0.593002,0.284217,-0.302644,-0.220143,-0.344276,0.0511315,0.64382,-0.326259,-0.0654922,0.512821,-0.146999,-0.374583,0.511512,0.402573,-0.449698,-0.331271,0.484211,0.814754,0.44898,-0.277949,-0.0323932,-0.860155,0.0684633,0.0676147,0.533501,-0.220692,0.211338,0.297028,-0.108953,0.0308739,0.000293666,-0.03791,0.225026,-0.104742,0.157542,-0.0403617,0.493341,0.229668,0.32173,0.232076,-0.0242662,0.144665,0.300907,-0.311386,0.374083,0.455071,0.243809,0.0992032,0.295419,0.043262,0.0297807,0.351384,-0.0750065,-0.456663,-0.0149333,0.140057,0.24843,0.374242,0.498427,-1.57922 +3416.46,0.999791,0.0912059,4,1.54364,0.903434,-0.638452,0.184063,0.790488,-0.371709,-0.0778983,0.688571,-0.183059,0.4692,0.0135026,-0.1702,-0.256219,-0.125382,-0.374933,0.91458,-0.0309837,0.490229,-0.267871,-0.326338,-0.067172,-0.712539,-0.793025,0.257542,-0.158419,-0.0873999,-0.203797,0.591112,-0.78904,0.0980377,1.10747,-0.264038,0.143748,0.428993,0.0341178,0.055612,-0.445001,0.87245,0.138905,0.209668,1.2731,-0.120912,0.0142389,-0.433699,-0.472993,-0.0258783,-0.400988,0.00554298,0.377317,0.108661,0.279149,0.0657575,0.395552,-0.453687,0.806088,-0.0533906,0.0599116,-0.483103,0.626534,-0.242146,0.209239,0.753314,-0.497566,-0.838658,0.0275528,-0.33749,-0.202103,0.289537,-0.0253781,-0.29467,-0.109888,0.809468,0.835487,-0.204268,0.216397,0.352578,-0.233466,0.0424391,-0.317381,-0.10998,0.330564,-0.340661,-0.0533125,-0.168761,-0.135456,-0.341708,-0.396243,-0.13234,-0.286577,-0.691391,0.420803,0.113983,-0.0830567,-0.410068,-0.242421,-0.708953,0.0626624,0.0586084,-0.123908,-0.176118,-0.260466,-0.624283,-0.191857,0.031895,-0.409687,0.185812,0.000651432,-0.0978799,0.323701,0.54179,-0.107706,-0.213661,0.113125,0.32059,0.0580499,-0.273761,-0.104407,-0.131482,0.0434791,0.0413326,-1.00856,0.0343675,-0.220397,-0.367956,0.108566,-0.0952429,0.52397,0.00795654,0.355983,-0.958524,-0.113234,0.573171,0.368131,0.562691,-0.0319977,-0.157307,0.146525,0.00629088,0.0706781,-0.695752,0.165685,-0.255948,0.178846,-0.595802,0.00361776,0.259055,-0.0358787,0.737789,-0.768544,0.185176,0.0152834,0.171063,-0.0509186,-0.182132,0.550191,0.508404,0.46152,-0.338929,-0.375831,0.690493,0.17905,-0.0852699,0.866239,0.681251,-0.469595,0.221402,-0.0410355,-0.10792,-0.262825,-0.67095,0.0553725,0.123857,0.180093,0.0474516,-0.4052,0.5034,-0.606736,0.33576,0.133443,0.881449,0.520743,-0.948226,0.125906,0.0186923,-0.215323,0.0746908,-0.0178537,0.158902,0.112324,-0.293599,0.209888,0.829274,0.174994,-0.861141,-0.612074,0.626265,0.497712,-0.527047,0.0880033,0.0631345,-0.291161,-0.336396,0.237447,0.144419,-0.165832,-0.0829264,-0.111973,0.360773,0.165194,0.0431413,-0.167463,0.0638048,0.291219,0.110044,-0.370817,0.416226,-0.194436,-0.106076,0.0446792,-0.0681062,-0.0319035,-0.212984,-0.17725,0.179392,-0.301463,0.295972,-0.445682,-0.136504,0.254859,0.106401,0.110899,0.0509728,-0.638036,-0.477661,-0.31476,0.34749,0.367407,0.12642,0.216345,0.560533,-0.432612,0.588196,-0.157642,0.00724077,0.899223,0.125872,0.585658,0.142148,-0.346958,-0.418739,-0.0778416,-0.0749603,0.715248,-0.0614052,0.188414,0.609445,-0.106647,-0.21307,0.513238,0.469847,-0.443526,-0.169831,0.750602,0.685801,0.272252,-0.179562,0.0768142,-0.905894,0.126583,0.0464544,0.582766,0.0316246,0.245556,0.657795,0.163524,0.00733594,0.0998227,0.0349915,0.413985,0.0581786,0.187102,0.0990735,0.181123,0.32127,0.130771,0.145946,0.0830903,0.443873,0.473496,-0.410999,0.444755,0.682332,0.158126,0.364344,0.00650494,0.0124461,0.116965,0.454361,-0.147056,-0.216477,-0.103734,0.137057,0.269545,0.370212,0.519177,-2.42401 +3435.99,0.672955,0.0912059,4,1.64423,0.897864,-1.27972,0.419934,1.10352,-0.104244,0.352346,-0.594457,0.18953,-0.423339,0.195251,0.0489659,-0.429196,-0.241324,-0.301665,0.381563,-0.0110678,-0.274596,0.20093,-0.275166,-0.354139,-0.493698,-0.367209,0.061161,-0.216074,-0.0549786,0.11884,0.49008,-0.240034,-0.0406858,0.412039,-1.18989,0.229917,0.435219,-0.0439223,0.05652,0.0271919,-0.0801662,0.857138,-0.348222,0.803625,0.541009,0.391886,-0.392173,0.286684,0.00905273,-0.730128,0.064424,0.217896,0.239031,0.374701,0.550658,0.137849,0.0291475,0.585497,-0.110622,0.176241,-0.657118,0.691118,-0.710313,0.0959874,1.02429,-0.342269,-0.705403,-0.229616,0.207451,0.0138348,-0.00814913,0.246152,-0.478657,-0.282229,0.262041,0.486419,-0.369081,1.05773,0.22248,0.44334,-0.228125,-0.158896,-0.0101981,-0.0438063,-0.229318,0.117699,-0.303786,-0.0485032,-0.181535,0.11976,0.0326645,0.588061,-0.317184,-0.163523,-0.0258777,-0.211682,0.493973,0.0880952,0.337485,-0.0308009,-0.385557,-0.0464348,0.226735,0.368723,0.505885,-0.554292,-0.403801,0.834358,0.0716327,-0.437546,-0.401644,0.190094,-0.00487029,-0.265169,-0.255529,0.132062,0.475397,-0.093198,0.204023,-0.373175,-0.104026,0.39094,0.0189832,-0.115779,-0.0503849,0.188225,0.279784,-0.38508,0.549001,0.0380162,0.0836267,-0.0574945,-0.204466,0.229041,-0.329014,-0.264669,0.346906,-0.489628,-0.502027,-0.318362,-0.197003,0.330297,-0.522124,-0.95908,-0.0788537,-0.352211,-0.243426,0.362414,-0.341268,0.0104819,0.0478355,0.141983,-0.589671,-0.59279,-0.18309,0.352038,0.0106756,0.0991862,0.422176,-0.170264,0.269975,0.134225,-0.23634,0.535691,-0.0475761,0.359695,-0.564828,0.225199,-0.0845527,-0.117577,0.0505255,-0.201382,0.173125,0.300006,0.0109646,-0.074614,0.00566363,-0.0155977,-0.757419,-0.326853,-0.535256,-0.00992436,0.623416,-0.143347,0.194021,0.359775,-0.406035,-0.01473,-0.272698,-0.617791,-0.842448,-0.350769,0.0457294,0.0506171,-0.673118,-0.159422,-0.286813,0.382578,-0.170359,-0.32105,-0.41492,-0.941533,-0.208559,-0.112614,-0.336891,0.295493,-0.499229,-0.40408,0.13857,-0.624419,1.03206,0.176549,0.199571,-0.0520057,-0.0762413,-0.235404,0.343921,-0.158979,0.141684,-0.22465,-0.0119337,0.778975,-0.353939,-0.0883578,-0.59998,0.435438,0.54185,-0.0823172,0.357729,-0.395916,-0.614874,0.531424,-0.0421658,-0.355261,0.0382115,-0.053869,-0.201958,-0.506564,0.10802,-0.292823,0.227891,0.885319,-0.97582,0.386387,0.00928642,0.0226184,0.0144179,0.601762,0.489996,0.509357,-0.0513998,0.0758727,0.174874,0.130095,-0.237442,0.0386017,-0.575388,-0.191766,0.16605,-0.430772,-0.28281,-0.163154,-0.356416,0.486382,0.626808,-0.276089,-0.309679,0.112356,0.461444,-0.245781,0.912024,-0.200547,-0.0103374,-0.527897,-0.373484,-0.566352,-0.322965,0.226535,0.0414827,-0.00451178,0.569824,0.22018,0.174557,-0.254425,-0.13324,-0.592668,-0.0143082,0.153449,0.490388,-0.320344,0.366641,-0.0127673,0.0164171,0.0485253,-0.71971,-0.0387438,-0.0216988,-0.300977,-0.323209,-0.470686,0.10109,-0.382215,0.00674725,0.0309034,0.129942,0.196555,0.360474,0.443345,-3.3064 +3439.79,0.907395,0.0912059,4,1.66047,0.728997,-0.928737,0.365946,0.494832,-0.174591,-0.00866232,0.435667,-0.225313,0.200493,0.380816,-0.456907,0.0333555,0.0227187,-0.0667911,0.620164,0.264881,0.316177,-0.396545,-0.201791,-0.0239973,-0.687069,-0.835352,0.493015,-0.541609,-0.288965,0.148352,0.158537,-0.750274,-0.388668,0.759639,-0.645506,-0.030158,0.580797,-0.0494926,-0.168333,-0.544799,0.201625,0.636749,-0.0688053,0.693823,-0.197059,-0.15707,-0.455884,-0.0520907,0.488854,-0.199287,-0.292008,0.229621,-0.100443,-0.239335,-0.177163,0.135574,-0.402474,0.776108,-0.112966,-0.434699,-0.381461,0.741728,0.0204131,0.101502,0.472033,-0.476585,-0.648056,0.373663,-0.295633,-0.026751,0.172684,-0.0152521,-0.248614,-0.143041,-0.00915695,0.637112,0.122221,0.175929,0.301925,-0.085446,0.0305621,-0.478794,0.0108235,0.0511171,-0.207824,-0.0170659,-0.165559,-0.263932,-0.434319,0.109215,-0.324774,0.199129,-0.584772,-0.506498,0.116491,-0.277067,-0.528575,-0.291383,-0.784138,0.207379,-0.307787,0.0228508,0.477102,0.042536,0.103169,-0.505213,-0.105641,-0.0440252,-0.500882,0.892791,0.281971,0.320544,0.361914,0.3745,-0.403116,0.305306,0.267761,0.00877157,-0.0625789,-0.405063,-0.131264,-0.306243,0.0339897,-0.616572,0.0990239,-0.45475,-0.403539,-0.0216485,-0.236113,0.214997,0.0232676,0.027773,-0.0718961,-0.593491,0.459228,-0.410511,0.643303,-0.206033,0.121666,0.264155,-0.292915,0.276481,-0.777918,0.131759,-0.122718,0.513827,-0.199524,-0.632314,0.559989,-0.24765,0.0625927,-0.147379,0.134755,-0.239627,0.034594,0.136511,-0.14305,0.349063,0.786878,0.0932559,-0.011337,0.0463402,0.385345,0.0143633,0.236847,0.731622,-0.672579,-0.325822,0.384067,0.0639688,-0.235045,-0.114982,-0.716172,0.228585,0.0482324,-0.0413984,0.16577,0.104225,-0.429148,-0.563332,-0.380175,0.545673,1.04925,0.226154,-0.422547,-0.326981,-0.324241,-0.285763,0.112708,-0.133493,0.00576468,0.393819,-0.354937,-0.170292,0.153631,0.139615,-0.60222,-0.321434,0.404629,0.3297,-0.0886372,-0.340302,-0.222439,-0.171495,-0.506069,-0.023393,-0.0929183,0.021994,0.0241577,-0.289872,0.980155,0.0779991,0.204514,-0.0043415,-0.183174,0.167059,0.320855,0.0276664,0.0242198,0.211306,0.296583,-0.129641,0.243137,-0.281367,-0.140482,-0.708413,-0.041335,-0.0135014,0.640715,-0.296501,-0.242283,-0.461196,0.21607,-0.318139,0.122633,-0.337305,0.0167864,-0.194608,-0.0373961,0.0259698,-0.119306,0.464588,0.305816,-0.42891,-0.175656,-0.83087,-0.524872,0.33486,0.0201082,-0.126945,-0.030999,-0.158122,-0.362872,-0.313557,-0.235804,0.253073,-0.030724,0.114996,0.168031,-0.195149,0.492878,0.0151426,0.200636,0.0598103,0.105559,0.17072,0.419618,0.000100408,0.19718,0.513311,-0.5876,0.246156,-0.452526,-0.0199858,-0.172719,0.0458996,0.666508,0.00524353,0.0967121,0.387407,0.208989,0.494875,-0.209263,-0.191257,-0.238287,0.0582431,-0.453076,0.0886743,0.25072,-0.353255,0.144088,-0.100593,-0.305805,0.0316682,0.0615545,0.0903574,0.301449,-0.351667,-0.206863,-0.0914509,0.132902,0.46133,-0.644849,0.120096,0.103922,0.142388,0.322369,0.377343,-1.08652 +3461.12,0.598968,0.0912059,4,1.72438,0.669798,-1.35837,0.597641,0.747709,-0.00791742,0.332879,-0.190839,-0.237633,-0.318655,0.0573249,-0.169792,-0.247807,0.14133,-0.631512,0.507165,0.0974043,0.176571,-0.121388,-0.0641263,-0.189583,-0.669247,-0.517092,0.423937,-0.516605,0.472107,0.0153216,-0.238519,-0.313804,-0.0554577,0.775434,-0.508321,-0.147105,0.314764,-0.0599631,-0.16413,0.164737,-0.0177055,-0.0400433,-0.318441,0.258782,0.0473029,0.0644259,-0.796885,-0.00525405,0.17169,-0.701353,-0.453578,-0.381277,0.0270794,0.109724,0.553389,-0.0354888,-0.209718,0.540824,-0.202155,-0.159156,-0.500217,0.327419,-0.442811,-0.370093,0.907953,-1.00145,-0.540398,0.2437,0.00788606,-0.466727,0.420557,0.269644,-0.476949,0.224836,0.198923,0.612105,0.289123,0.0645088,0.409331,-0.0831015,0.0168297,-0.0814132,0.285668,0.246832,-0.0597301,0.28852,0.296508,-0.136555,-0.427593,0.0901272,0.0540073,-0.105929,0.0717606,-0.556188,-0.190219,0.134476,-0.0367505,0.0139832,-0.0027444,-0.241024,0.00182098,-0.0693586,0.67251,0.516125,0.074071,-0.184381,-0.14292,0.510545,-0.15294,-0.0102301,0.260587,-0.0647942,0.430263,0.0307883,-0.165396,0.512704,0.387686,-0.258451,0.457599,-0.365521,0.1419,-0.0486015,0.0329366,-0.419636,-0.346595,-0.00861724,-0.210947,0.164704,-0.193574,0.265349,0.179717,0.542469,-0.183078,-0.106495,-0.201877,0.235208,0.128069,-0.033462,-0.345651,-0.00911313,0.253745,0.482874,-0.8053,-0.380257,-0.393373,0.0340564,-0.333937,0.0779385,0.0471134,0.177369,0.579466,0.0571487,-0.0973433,-0.214353,0.131191,-0.0849992,-0.399823,0.0484799,0.0316432,0.195831,0.0170668,0.455824,-0.129374,0.369892,0.551725,0.413987,0.223954,-0.0968916,0.152555,0.129403,0.122181,0.0460479,0.244449,0.0724967,-0.36711,-0.258171,-0.144211,-0.285084,-0.183642,-0.0655843,-0.114096,0.297921,0.364237,0.2475,-0.304752,-0.0709317,-0.671773,0.0865229,-0.30127,-0.212617,-0.389373,0.177816,0.35438,0.293256,-0.311568,0.0471721,-0.487002,-0.0598619,-0.291579,0.159669,0.00232401,-0.50204,-0.0105131,-0.334088,0.261968,-0.2746,-0.0837739,-0.0834596,-0.101254,-0.741597,0.921616,0.568083,0.0619719,0.217635,-0.265169,0.174586,-0.545251,-0.316842,0.234888,-0.38511,0.483764,0.443561,0.131603,0.170088,-0.617214,-0.106441,0.476334,0.267475,0.741971,0.0781758,-0.0901996,-0.126331,-0.238447,0.00563073,-0.0341657,-0.0639757,0.222033,-0.306391,0.467783,-0.22131,-0.131927,0.467518,-0.126416,-0.146711,-0.0978547,-0.243884,-0.130643,0.456711,-0.339458,0.400548,0.474238,-0.316439,-0.0602269,0.105673,-0.336638,0.145536,-0.378941,-0.209755,0.188671,0.177844,0.12537,0.171643,-0.125104,0.162052,0.00128521,-0.205896,-0.0386493,0.391187,0.454519,-0.338963,0.152959,0.198167,-0.374984,-0.256785,-0.531859,0.102772,0.0207725,0.587125,0.0169065,0.506228,0.219028,0.0697698,0.138601,-0.337009,-0.169553,0.0445714,-0.103048,0.304079,0.386979,0.0192439,0.364392,0.17204,-0.602501,-0.070904,-0.0114981,-0.489321,-0.559385,0.0405445,-0.609086,-0.250614,0.220912,-0.0979959,-0.490705,-0.184579,0.103855,0.157531,0.322266,0.396902,-1.79311 +3447.46,0.889402,0.0912059,4,1.71053,0.65785,-1.4588,0.659291,0.861706,-0.0306557,0.360476,-0.365475,-0.203816,-0.382711,-0.0449377,-0.234724,-0.321027,0.212394,-0.685877,0.449193,0.0344717,0.232829,0.136602,-0.11012,-0.188801,-0.594201,-0.734239,0.433813,-0.607344,0.497418,-0.0567805,-0.133998,-0.273212,-0.0622139,0.804915,-0.204501,-0.132238,0.423289,-0.117014,-0.31756,0.0763263,0.0494516,-0.0441756,-0.224244,0.316207,0.105544,0.190788,-0.643861,0.115465,0.21806,-0.6966,-0.407407,-0.391283,0.179697,0.11072,0.574788,-0.0429521,-0.0421925,0.522313,-0.194608,-0.216878,-0.666294,0.351174,-0.340102,-0.460839,0.860278,-1.17886,-0.350258,0.176144,0.0318229,-0.385083,0.318268,0.10153,-0.843727,0.23023,0.188108,0.694877,0.277741,0.0949661,0.415616,-0.0358151,0.0942884,-0.137945,0.192548,0.22129,-0.107011,0.292054,0.393403,-0.0127282,-0.473893,0.356278,-0.125636,-0.0933482,0.0372797,-0.712937,-0.231663,0.0752623,-0.192491,-0.0933876,0.0209596,-0.0644911,0.15005,0.00936466,0.671519,0.348584,0.0312059,-0.20205,-0.125174,0.512676,-0.170954,0.0214359,0.330485,-0.172954,0.536853,-0.0405103,-0.0954612,0.491135,0.299673,-0.227855,0.367418,-0.089642,0.00477942,0.0708198,0.0481803,-0.59274,-0.432126,-0.118963,-0.152519,0.0550271,-0.301785,0.320997,0.301261,0.383435,-0.154412,-0.160605,-0.162342,0.257606,0.301014,-0.0163344,-0.276777,-0.181565,0.278882,0.433914,-0.933993,-0.520828,-0.406281,-0.0462354,-0.334698,0.130918,-0.115368,0.308082,0.551527,0.0344306,-0.059171,-0.347468,0.244429,-0.311463,-0.343575,-0.0543457,0.0925354,0.0114227,0.100282,0.498286,-0.124681,0.448156,0.439017,0.52635,0.381397,-0.20807,0.236083,0.126957,0.013226,0.101423,0.506546,0.0806579,-0.232985,-0.264155,-0.157128,-0.384709,-0.22788,-0.0844734,-0.262992,0.441478,0.307602,0.277933,-0.336907,-0.133151,-0.557079,0.0476405,-0.267674,-0.241237,-0.160381,0.347876,0.303217,0.201805,-0.37948,0.0412784,-0.615253,-0.0203287,-0.0814655,0.101086,-0.0669805,-0.480531,-0.0380101,-0.367124,0.255997,-0.357176,-0.0111209,0.0195681,-0.0766888,-0.78885,1.02412,0.621248,-0.0255181,0.338122,-0.269252,0.306365,-0.4534,-0.194755,0.163678,-0.339991,0.45418,0.224009,-0.0734518,0.179485,-0.622729,-0.108228,0.379601,0.382696,0.800777,0.0546493,-0.0812935,-0.224059,-0.319832,0.000711182,0.0065261,-0.153729,0.160092,-0.590555,0.361082,-0.327212,-0.127442,0.322054,-0.190665,-0.431449,0.01023,-0.232473,-0.203193,0.618562,-0.0474965,0.445252,0.263705,-0.303404,-0.26404,0.257479,-0.283806,0.277115,-0.289563,-0.459538,0.0276322,0.174748,0.082816,0.175226,-0.041238,0.192975,-0.122824,-0.185543,-0.0486658,0.625962,0.408205,-0.397468,-0.0375555,0.180569,-0.335212,-0.202648,-0.665045,0.0199923,0.129328,0.506152,0.0268587,0.332727,0.142836,0.0873287,0.156687,-0.435505,-0.123359,0.089272,-0.0741043,0.355403,0.455105,-0.250795,0.406262,0.247105,-0.449551,-0.100821,0.205892,-0.406394,-0.360432,0.00912487,-0.466876,-0.226218,0.14662,-0.163582,-0.267564,-0.144418,0.094213,0.173842,0.306941,0.416943,-2.1643 +3460.86,0.965126,0.0912059,4,1.59845,0.680165,-0.982117,0.391779,0.527734,0.0243331,0.0178407,0.0586817,-0.267727,-0.211689,0.384596,-0.39004,-0.287248,0.500582,-0.184201,0.685103,0.197644,0.456038,0.181398,0.138717,-0.0587978,-0.705798,-0.866943,0.754171,-0.387623,0.118233,-0.0148186,0.0735636,-0.592824,-0.183157,0.839218,-0.297433,0.127641,0.246622,0.151871,-0.0879954,-0.734323,0.225615,0.404505,-0.576389,0.42727,0.110358,0.214659,-0.783256,-0.112223,-0.407026,-0.760753,-0.41436,0.0414179,0.241906,-0.185278,0.642809,0.111347,0.207636,0.837391,-0.199017,-0.42202,-0.323479,0.446485,-0.552449,0.12937,0.965633,-0.89618,-0.351344,-0.0551139,0.0564147,-0.171945,0.704023,0.0468333,-0.188058,-0.0312105,-0.0608486,0.539888,-0.152294,0.547535,0.709107,-0.442882,-0.014484,-0.0659055,0.0119591,0.572673,-0.215095,0.0377422,-0.457033,-0.251311,-0.00869584,-0.443955,-0.0255068,0.303303,-0.386316,-0.549943,-0.21907,-0.0520641,-0.0822451,0.00260098,0.0697402,0.370681,0.144127,0.151188,0.611019,-0.138632,0.294033,-0.249281,-0.196516,0.465342,0.23413,0.298575,0.356594,-0.0429005,0.268393,-0.0311209,0.238426,0.280086,0.436118,-0.112841,0.376941,-0.414131,0.0580608,0.0152145,-0.386203,-0.600234,0.0342351,-0.0250639,-0.105524,-0.114075,-0.0915059,0.31827,0.236348,0.499016,-0.125255,0.223897,0.0464561,-0.0548893,0.298103,-0.198908,-0.12685,0.00895658,0.0687907,0.576148,-0.605165,-0.770898,-0.267758,0.29199,0.075283,0.281611,0.058877,-0.213766,0.422603,-0.0404934,-0.573701,0.288951,0.00684731,-0.286062,-0.0110879,-0.0522917,0.232177,0.321832,0.349697,0.747321,0.0936772,-0.258586,0.012655,0.570538,0.709858,0.135427,0.127377,0.450174,0.244572,-0.0160246,-0.36176,0.193756,0.0605216,0.228178,0.225167,-0.0780368,0.191565,-0.0676023,-0.19182,0.252602,0.464873,0.105627,-0.0235519,-0.0407583,-0.239955,0.188798,-0.337789,-0.479061,-0.0627284,0.213486,-0.361003,-0.0825712,-0.125264,-0.171713,-0.215788,-0.202012,-0.0738805,0.0156017,-0.042813,0.0853233,0.0482894,-0.235789,-0.343109,-0.0644654,-0.0131697,-0.107972,-0.0459738,-0.431222,0.939708,0.180661,0.223491,0.234371,-0.0378489,0.426301,0.282698,0.101283,0.412719,0.0600698,0.356056,0.577748,0.0227079,0.0668472,-0.305851,-0.389436,0.021645,0.352427,1.07866,-0.273871,0.310752,-0.099522,0.162224,-0.248743,0.0710085,0.229781,0.128169,-0.614879,0.388964,-0.249169,0.465625,0.603431,0.0345875,-0.132835,-0.253047,-0.297103,-0.0340217,0.217604,0.585266,0.113259,0.297755,0.0783771,-0.349509,0.0510928,-0.260375,0.163581,-0.558474,-0.634185,-0.255766,-0.111279,-0.0344698,0.197458,-0.0561893,-0.233805,-0.22094,0.238287,-0.356917,0.270489,0.15599,-0.371705,-0.4645,-0.357387,0.540222,-0.45739,-0.551917,0.419981,0.10488,0.172248,-0.128212,0.55429,-0.118416,0.192438,0.159148,-0.452316,-0.190354,-0.252937,0.136743,0.110619,-0.214457,-0.324774,0.241968,0.0802602,-0.472022,0.0214526,0.0970769,-0.164307,-0.429052,0.17158,-0.29329,0.279303,0.0620082,-0.159272,-0.287511,-0.210221,0.10971,0.172648,0.331225,0.41551,-1.21763 +3438.09,0.613878,0.0912059,4,1.59607,0.681708,-1.74848,0.761751,1.0049,-0.0120498,-0.194644,-0.361133,0.00263523,0.0716828,0.328605,-0.172892,-0.55015,0.235189,-0.442468,0.434684,-0.0954991,0.137666,-0.0028756,-0.0254234,-0.081883,-0.557883,-0.497774,0.41892,-0.575216,-0.325126,-0.0615725,0.0219981,-0.112203,0.111583,0.67365,-0.50133,-0.343677,0.310746,-0.242953,-0.346469,-0.127945,0.0464138,0.498519,-0.224982,0.470017,0.31349,-0.0163841,-0.334032,0.191995,0.212375,0.142885,-0.480511,-0.363424,0.161362,-0.167199,0.331634,0.184756,-0.605508,0.228504,-0.0640539,-0.332454,-0.849999,0.544155,-0.204578,-0.0431891,0.955719,-0.782941,-1.25527,-0.0332623,0.183234,0.445279,-0.0288686,0.217932,-0.414329,0.226108,0.418701,0.409512,0.0953563,0.243546,0.486171,0.1455,-0.444126,-0.488626,0.572451,0.359174,-0.208753,0.16222,0.0804644,0.255179,-0.00897867,0.588984,-0.112906,0.342978,0.0684042,-0.0357387,0.266452,0.280047,0.199766,0.145817,-0.306562,0.00341329,0.0875358,0.243423,0.469019,0.461307,0.126198,-0.271422,-0.304394,-0.59295,-0.476289,0.61471,0.0668952,0.493908,0.823569,-0.337446,-0.238795,0.00320171,0.664138,-0.0976745,-0.138085,-0.480675,0.0858021,0.0304447,-0.0197871,-0.586274,0.0334896,-0.0416404,-0.0897937,-0.304524,-0.524802,-0.0390701,-0.3487,-0.15023,-0.423906,0.284482,-0.024913,0.25468,0.341527,0.160202,-0.164117,-0.392779,-0.171344,0.572389,-0.101395,-0.0999048,0.211406,-0.0226397,-0.255235,-0.350037,0.228621,0.150944,0.481371,0.00507634,0.0215965,-0.0956521,0.573581,0.232988,0.190563,0.311109,0.390868,-0.485785,-0.34031,0.18952,0.330322,0.706991,-0.0417776,0.431341,-0.411191,0.338745,0.0835974,0.0465228,-0.322974,0.0889496,0.305261,-0.242683,0.204133,0.0223893,-0.421803,0.513601,-0.516821,-0.0202033,0.114853,-0.180385,0.427233,0.00714617,-0.339917,0.147551,0.238628,-0.00824277,0.125558,0.0387529,-0.31988,0.202213,-0.317115,0.18651,0.283796,0.0876619,-0.451526,0.258544,0.12558,0.330252,-0.214351,-0.975001,0.176262,0.158205,-0.287274,0.339045,-0.15216,0.136273,-0.15653,-0.14351,0.872053,-0.362545,0.235156,-0.163612,-0.447757,-0.24443,0.281805,-0.0701541,0.332744,-0.397867,0.52806,-0.647846,0.0630327,-0.177221,-0.325403,0.341503,0.106841,0.0712957,0.509922,-0.257391,-0.128621,0.121491,-0.0547913,0.317988,0.299168,-0.126918,0.139113,0.105537,0.0608784,0.237951,-0.339122,0.297811,-0.375405,-0.0758771,0.618886,0.357471,-0.0861007,-0.271524,-0.701431,0.565161,0.0398121,-0.285323,-0.17544,-0.0880876,-0.275085,0.623005,-0.141724,0.444576,0.266839,-0.213133,0.0227217,-0.284809,-0.315379,0.719492,0.298427,-0.216482,0.512559,-0.240451,-0.0139392,0.116543,0.0686551,0.045137,0.268518,-0.281607,0.071362,-0.278131,-0.144005,-0.33591,0.228206,-0.036034,-0.0316698,0.0533983,-0.00743533,0.215184,0.290699,-0.845651,0.134656,0.844127,-0.0673642,0.243414,-0.0549917,-0.151832,0.0765312,0.140106,0.0321867,0.518404,0.428365,-0.0365741,-0.203023,0.131334,-0.0352045,0.344005,-0.0118361,0.287266,0.113747,0.228219,0.337264,0.477723,-2.74592 +3428.21,1,0.0912059,4,1.52647,0.597178,-1.72503,0.734461,0.600678,-0.235786,-0.421214,0.0788156,-0.0910769,0.00260378,0.533662,-0.174889,-0.435792,0.401408,-0.280458,0.687437,0.360103,0.0912292,0.192387,-0.102283,-0.0431391,-0.697925,-0.977957,0.761425,-0.611094,-0.0517206,0.242432,0.127487,-0.13299,-0.0337285,0.989249,-0.646096,-0.150232,0.260073,0.0327365,-0.150139,0.199713,0.681634,0.837351,-0.482075,0.913923,0.778062,0.281139,-0.523461,-0.261657,0.0975765,-0.653883,-0.29061,0.299289,-0.245341,-0.364646,1.01109,0.381422,0.0621345,0.287268,0.00985231,-0.548221,-0.501314,0.513817,-0.817242,0.431007,1.2883,0.151087,-0.714639,-0.133154,0.460158,-0.190878,0.0861742,-0.300497,-0.585738,-0.073322,0.0732559,0.882965,0.0567048,0.748003,0.549666,0.248496,-0.135233,-0.447845,0.0427227,0.918573,-0.251929,0.108064,0.414716,0.224923,-0.41675,-0.517047,-0.26255,-0.385899,-0.37914,0.450284,0.178062,0.29075,-0.14502,-0.236332,-0.905375,0.0562923,-0.0609677,-0.289756,0.505796,0.112329,0.108865,-0.698788,-0.414354,-0.350822,0.11967,0.773365,0.203428,0.202995,0.556232,-0.227223,-0.25823,-0.220345,0.557733,0.265961,0.282245,-0.586462,-0.108416,0.529726,0.393171,-0.475956,-0.345184,0.125651,-0.169182,-0.0123848,-0.0873498,0.0887916,0.0651508,0.171547,-0.180494,0.161462,-0.0803913,0.067919,0.403994,-0.583915,0.131343,-0.153725,0.196822,0.696413,-0.704345,-0.462138,-0.373221,1.03514,-0.243932,-0.287358,0.0128923,-0.535279,0.456341,0.0689686,-0.0311392,-0.273508,0.209567,-0.0455497,0.16792,0.667671,0.406783,0.386508,0.0472595,0.0632013,-0.104975,0.422689,-0.029625,0.758753,-0.00346346,0.225687,0.220878,-0.102355,-0.0585985,-0.068608,-0.155452,-0.059739,0.744006,0.34765,0.11717,0.387385,-0.393553,-0.226319,-0.65176,-0.141472,0.401301,-0.288276,-0.0620449,0.0462729,-0.0891305,0.0651027,-0.0852001,-0.356981,-0.318246,0.170047,-0.460164,-0.00185846,-0.0469603,-0.585128,-0.282935,0.136339,0.238057,0.235714,-0.0852035,-0.391817,-0.307957,-0.326325,0.314604,0.729828,-0.479515,0.598909,-0.745714,-0.476109,0.932898,0.282143,0.653659,0.2698,-0.404674,0.482759,0.0501163,0.107009,0.296846,0.229192,0.383073,0.466798,-0.118158,-0.232529,-0.536541,-0.10521,0.100652,-0.469573,0.735632,-0.375553,-0.195668,-0.072145,0.0500878,-0.0689033,0.297926,-0.372813,0.0516351,-0.0353939,0.436739,0.219671,0.251951,0.237642,-0.543629,-0.324246,-0.0239207,0.217164,0.174033,0.515895,-0.1442,0.467268,0.103313,0.572635,-0.62108,0.412182,-0.0178381,0.385789,-0.24774,-0.324366,-0.0559813,-0.0892515,0.0335519,0.100213,0.537401,0.000420722,0.396206,0.322058,0.175677,0.190977,0.978605,-0.162208,-0.499152,0.534804,0.320835,-0.457011,0.00715549,-0.114714,-0.171057,-0.12541,0.163892,0.17359,-0.3176,0.116687,-0.286812,0.0851162,-0.491689,0.0827025,0.690675,0.214252,0.277772,0.315371,-0.455473,0.159281,-0.519725,0.393855,-0.181,0.320632,0.239589,-0.346323,-0.0896134,-0.00175309,-0.121655,-0.426338,0.534049,0.124556,0.129577,0.171366,0.359968,0.413963,-1.25466 +3399.71,0.898594,0.0912059,4,1.54797,0.526593,-1.85823,0.841594,0.886645,-0.177139,-0.201586,-0.415143,-0.142391,0.493916,0.726061,-0.0864204,-0.262843,0.464771,-0.398768,0.586947,0.623801,0.100539,0.111568,-0.0339873,0.323828,-0.56032,-1.36661,0.636012,-1.01702,-0.412252,-0.0946297,0.177759,-0.090233,-0.106963,1.13988,-0.237535,-0.616036,0.305213,-0.304338,-0.295491,-0.192936,0.443919,0.859503,-0.162882,0.856158,0.632168,0.68093,-0.289072,-0.157209,-0.128873,-0.630654,0.0860879,-0.132234,-0.20508,-0.0533298,0.698285,0.339998,-0.176173,0.278391,0.0245473,-0.272526,-0.347483,0.589186,-0.262238,0.320187,1.2076,0.0634059,-0.793586,-0.232753,0.403496,-0.812941,0.341283,-0.233809,-0.767472,-0.100514,-0.250282,0.77547,-0.137896,0.661504,0.142533,0.214944,-0.215651,-0.665676,-0.0353214,1.0465,-0.418975,0.233995,0.611874,0.0054445,-0.10063,-0.21653,-0.228821,0.163523,-0.585827,-0.17202,0.204697,0.558535,-0.0967424,-0.317974,-1.12588,0.465864,-0.0430277,-0.324989,0.595705,-0.26658,-0.00155773,-0.633061,-0.203528,-0.437227,0.0807661,0.34939,0.062774,0.229613,0.510362,0.337204,-0.291684,-0.032998,0.695281,-0.216949,0.357243,-0.259168,0.0875187,0.515515,0.0250599,-0.809939,-0.539562,0.328724,-0.40717,-0.258008,-0.23061,0.0577519,0.139946,0.160671,-0.355263,0.50288,0.230809,-0.0563713,0.41053,-0.592482,0.0974373,-0.346171,0.12969,0.41482,-0.789619,-0.312137,-0.105411,1.06467,-0.152757,-0.0418024,0.111809,-0.615945,0.674475,0.0902481,-0.0169738,-0.858548,0.370198,-0.10477,-0.159384,0.561753,0.560404,0.393402,0.0997144,0.200286,0.176192,0.154682,0.302736,0.73486,-0.439851,0.434711,0.512899,0.0239643,0.207032,-0.458237,-0.332124,-0.431326,0.523944,0.162842,0.182383,0.0128769,-0.237099,-0.358431,-0.378632,0.0785105,0.29042,-0.53082,0.42415,0.180551,-0.817644,0.178334,-0.118324,-0.523807,-0.0347484,-0.0300515,-0.3228,0.0328426,0.143783,-0.496724,-0.655998,-0.31119,0.342673,0.330345,-0.338621,-0.451833,-0.188166,-0.365534,-0.197738,0.0953833,0.0122685,0.245399,-0.781688,-0.309029,0.743714,0.120422,0.839224,0.411648,-0.374138,-0.153718,0.0296169,0.192868,0.0180972,0.159266,0.0964945,0.443548,0.163815,-0.390129,-0.213795,0.0349568,0.13585,-0.143123,0.663244,-0.227356,-0.19686,-0.455637,-0.0921785,-0.277224,0.00533212,-0.839061,0.370034,-0.245099,0.340872,0.421273,-0.0325966,0.234557,-0.26299,-0.39195,0.0576288,0.393472,-0.17262,0.64069,-0.139276,0.328875,0.507397,0.64617,-0.798503,0.382963,-0.283391,0.395738,-0.159568,-0.143793,0.503902,0.175029,0.26921,-0.351658,0.54573,-0.473869,0.993307,0.0947827,0.289491,0.262207,0.433186,0.0580204,-0.660356,0.202705,0.218718,-0.442433,-0.530358,-0.408885,-0.0458999,-0.142091,0.175223,0.352826,-0.0137491,0.186396,-0.256416,0.30302,-0.117865,-0.156558,0.6146,0.331593,0.215701,0.383929,-0.329316,-0.00288062,-0.350182,0.450973,-0.319776,0.189955,-0.020566,-0.374532,-0.292469,-0.0945295,0.450131,-0.402747,0.638027,0.0430189,0.167905,0.197579,0.409762,0.444499,-2.104 +3400.02,0.99224,0.0912059,4,1.51795,0.596014,-1.7286,0.803255,0.654848,-0.298107,-0.19306,-0.360742,-0.0747015,0.137679,0.643112,0.117291,-0.282582,0.388315,-0.476239,0.582629,0.52415,0.186599,0.0733352,0.229249,0.48931,-0.66118,-1.07489,0.710107,-1.11202,-0.422686,-0.21931,0.278423,0.188573,0.101818,1.13734,-0.115961,-0.724877,0.251758,-0.320442,-0.320073,-0.614463,0.384644,0.960822,-0.155431,0.647492,0.641864,0.659996,-0.433444,-0.434595,-0.0379459,-0.321177,-0.247482,0.170404,-0.0798835,0.0495579,0.765954,0.382692,-0.17078,0.268109,-0.109364,-0.412413,-0.611684,0.373161,-0.323884,0.319932,1.09058,0.0219828,-1.14879,0.127369,0.325767,-0.473227,0.269866,-0.383522,-0.836635,-0.0842536,0.0271341,0.753292,-0.06578,0.615361,-0.0139901,0.283956,-0.336238,-0.592859,0.120626,0.945543,-0.410035,0.291559,0.657046,0.177424,0.0404353,-0.44748,-0.335704,-0.0143123,-0.363228,-0.407593,0.376198,0.673186,-0.281558,-0.298789,-0.777437,0.546505,0.022497,-0.109285,0.839391,0.0517093,-0.157979,-0.359836,-0.26558,-0.1642,0.0951613,0.0654633,0.0368105,0.293974,0.597325,0.248083,-0.31798,-0.370853,0.551299,-0.279864,0.193005,-0.433438,-0.124098,0.533052,-0.057246,-1.1105,-0.35904,0.308727,-0.450429,-0.18482,-0.191228,0.0917212,0.332657,0.213322,-0.728512,0.691383,0.10192,0.0652304,0.578609,-0.279173,0.0270341,-0.397972,0.341678,0.353737,-0.741831,-0.547195,-0.167734,1.00097,0.0352713,0.29566,0.122438,-0.536829,0.693048,-0.267198,0.327061,-0.573964,0.373092,-0.0126284,-0.143309,0.675842,0.742888,0.305048,0.018384,0.199325,0.0239386,-0.0119772,0.127718,0.613706,-0.573522,0.148373,0.348782,0.0221788,0.433265,-0.208736,-0.507401,-0.086646,0.801855,0.0697793,0.039265,0.0555321,-0.152518,-0.518696,-0.348852,0.0737881,0.507202,-0.105469,0.117574,0.523446,-0.77404,0.368219,-0.411001,-0.881399,-0.109494,0.159958,-0.111963,0.335605,0.230589,-0.449878,-0.360713,-0.237741,0.310755,0.264391,-0.412513,-0.426533,-0.161166,-0.133858,-0.174075,0.0576458,-0.203064,0.262343,-0.850948,-0.359168,0.626186,-0.578453,0.7052,0.23979,-0.0669398,-0.176481,0.0226024,-0.33797,0.0723256,0.205771,0.123325,0.565785,-0.112696,-0.276176,-0.331428,-0.0373986,0.582346,-0.470474,0.433584,-0.357416,-0.203938,-0.47713,-0.089636,0.0470721,-0.000182292,-0.813218,0.172778,-0.40024,0.562233,0.499673,-0.131189,0.10325,-0.448582,0.291177,0.238674,0.500237,-0.373491,0.643453,-0.364335,0.237338,0.658677,0.628838,-0.928031,0.260267,-0.238705,0.332336,-0.194835,0.15585,0.593104,-0.0519502,0.0672301,-0.111428,0.276746,-0.298273,0.794303,-0.183907,0.0586637,0.0495202,0.247164,-0.0414047,-0.649679,0.527531,0.127438,-0.499885,-0.524473,-0.270295,-0.210992,-0.12562,0.161921,0.217191,0.210749,0.171435,-0.180019,0.0535878,-0.144332,-0.162481,0.846243,0.335778,-0.0268049,0.408424,-0.602977,0.130269,-0.240859,0.25944,-0.125781,0.0380491,0.12074,-0.501388,-0.0890004,-0.394231,0.216056,-0.182172,0.469902,-0.0902097,0.161632,0.203404,0.402035,0.451003,-1.48875 +3398.34,0.7344,0.0912059,4,1.54665,0.699486,-1.22932,0.591783,0.828543,-0.097327,-0.0685548,-0.324425,0.468998,0.181438,0.335892,-0.00535134,-0.275039,0.610821,-0.485096,0.726584,0.315158,0.335719,0.295406,-0.025245,0.0563554,-0.944666,-0.0735333,0.623852,-0.756864,-0.114953,-0.0931816,0.385833,-0.030981,0.141735,1.01243,-0.378992,0.0751377,0.342318,-0.100559,-0.0680364,-0.593941,0.653525,0.508269,0.038144,0.616523,0.420644,0.182928,-0.598294,-0.44596,0.631738,-0.3633,-0.307151,0.282672,-0.138996,0.0744101,0.128927,0.378602,-0.0427574,0.358511,-0.185263,-0.489676,-0.286914,0.768006,-0.549945,0.120407,1.30272,-0.710167,-0.598548,-0.012424,0.582779,-0.655687,-0.250157,-0.149421,-0.915738,-0.210765,0.201861,0.239858,-0.10452,0.564245,-0.128002,0.157586,-0.360065,-0.723952,-0.0659557,0.52369,-0.718766,-0.071565,0.388496,0.248725,-0.351495,-0.603391,-0.034413,-0.0737878,-0.169491,-0.284587,0.0543474,0.322343,0.322517,-0.107096,-1.03684,0.424965,0.297223,-0.0409645,0.607886,-0.282581,-0.198066,-0.653315,-0.218274,-0.163452,-0.388119,0.23745,-0.24194,0.590303,0.124992,0.191632,-0.243652,-0.951236,0.431325,0.0496406,0.144416,-0.561723,-0.0486807,0.212538,-0.240336,-1.3595,-0.0725375,-0.167853,0.0719558,-0.203452,0.323815,0.755949,0.0895175,0.552486,-0.457452,0.238138,-0.0459501,0.185051,0.876827,0.24609,-0.0443496,-0.215707,0.204312,0.178109,-1.2818,-0.286233,-0.221313,0.721316,-0.0491997,0.22726,0.182028,-0.310264,0.721905,-0.217905,0.0959119,-0.532731,0.500196,0.154332,-0.377842,0.90579,0.432355,0.52922,-0.624383,0.300462,-0.0048715,-0.0180619,0.269667,1.22496,-0.475301,0.122796,0.498969,0.0263077,0.380168,-0.543118,-0.130404,0.0234034,0.328442,0.00967284,-0.0212992,0.303982,-0.102915,-0.479152,-0.410267,0.446505,0.219602,-0.219562,0.157308,0.237402,-0.33522,0.334353,0.149926,-0.0664051,-0.386176,0.308548,0.137823,0.0334834,0.49979,-0.475586,-0.448943,0.0656966,0.458867,-0.197603,-0.325394,-0.6754,-0.158453,-0.0663911,-0.227194,0.360111,-0.438147,0.188356,-0.908973,-0.522788,1.06018,-0.659885,0.257382,0.281518,-0.236764,0.546721,0.424337,0.295297,-0.273605,-0.577642,0.230557,0.691062,-0.239452,-0.647819,0.17628,-0.0953151,0.341811,0.0251232,0.323162,-0.236034,-0.287121,-0.282506,-0.173892,0.436204,0.158636,-0.704042,0.0487456,-0.37146,0.104612,0.285229,-0.30581,0.0378636,-0.500845,0.530187,-0.314769,0.190366,0.328837,0.35208,-0.220226,0.315393,0.30136,0.0309917,-0.426356,0.720488,-0.839881,0.288422,-0.0769179,-0.0812114,0.422451,-0.0336678,-0.408628,0.4499,0.15319,-0.0359016,0.738487,0.112688,0.22903,0.411471,0.22477,0.151381,-1.03,0.387508,0.436408,-0.837436,-0.465292,-0.303114,0.0145758,-0.122251,0.140675,-0.107242,0.122577,-0.389814,0.141039,0.663269,-0.667693,0.402537,0.609805,-0.288716,-0.163091,0.0990934,-0.533108,0.148472,-0.393884,0.322662,0.570617,0.200981,-0.264373,-0.322007,-0.342568,-0.143003,-0.182198,-0.0983299,-0.150273,-0.261961,0.182065,0.22052,0.42669,0.469595,-2.33158 +3406.39,0.951197,0.0912059,4,1.4833,0.72405,-1.02786,0.511936,0.774973,-0.157011,0.228705,0.00249907,-0.139149,0.205718,0.530752,0.45206,-0.141073,0.428608,-0.293142,0.98598,0.443749,0.0917359,-0.294949,-0.0814583,0.462625,-0.470992,-1.13623,0.608771,-0.451398,-0.0734808,0.370699,0.579174,-0.335063,0.333889,1.01673,-0.683595,-0.0541274,0.376678,-0.179572,-0.193226,-0.65429,0.130335,-0.0288456,0.0808214,0.909813,0.386669,0.648907,-0.22583,-0.259066,-0.199271,-0.0820206,-0.818243,0.329228,0.189629,0.0600311,0.874837,-0.2254,-0.127025,0.606125,-0.220926,0.0627442,-1.12475,0.578281,-0.225265,-0.133794,1.05539,-0.275237,-1.61717,-0.511951,0.263515,0.849398,-0.237943,0.0622618,-0.198731,-0.76636,0.256285,0.811662,0.557128,0.464487,0.146539,0.0607759,-0.0686367,-0.390053,0.033232,0.743134,-0.105064,0.171523,0.145161,0.0129981,-0.314635,-0.320827,0.376972,0.193297,-0.610646,0.520105,-0.495175,0.0712351,0.0295007,0.200696,-0.300897,0.210757,0.166621,0.00562403,0.404429,0.212161,0.0456131,-0.59536,-0.0465906,0.0998833,-0.319924,0.396209,0.0533263,0.18092,0.508933,0.83556,0.0220592,-0.178787,0.492902,-0.584507,0.0951295,-0.348717,0.174138,0.522921,-0.38939,-1.11132,0.614346,0.210116,0.900007,0.00281958,0.484576,0.38273,-0.293585,0.188187,-0.449328,0.457043,-0.0415668,0.815666,0.0899213,0.00289247,-0.393946,-0.14124,0.269636,0.361971,-0.409436,-0.642303,-0.429125,-0.191368,0.119787,0.388794,0.252688,-0.199498,-0.0877782,0.339514,-0.532155,-0.52233,0.390772,0.0460106,0.0602487,0.90098,0.16374,0.28989,0.0472144,0.0318001,0.482121,0.110432,-0.234029,0.772963,0.00780927,0.191925,0.711634,-0.337576,0.0180479,0.456896,-0.00212035,0.172473,-0.00891472,-0.0936384,-0.00608402,-0.291885,0.254954,-0.478911,-0.209023,0.311952,0.551968,-0.0647115,0.473988,0.344359,-0.0684457,0.470172,0.272612,-0.770031,-0.331236,0.0580625,-0.194882,0.155634,-0.27585,-0.102164,-0.416362,0.132521,0.960122,0.0463338,-0.300836,-0.508556,-0.258889,0.090812,-0.394855,-0.249713,-0.451505,-0.465029,-0.408091,0.0961932,0.992159,0.176349,0.607254,-0.0870927,-0.1186,0.159659,0.568503,-0.272198,0.518297,-1.01832,0.0402038,-0.14817,-0.856818,0.111098,-0.195898,-0.154702,0.0251422,-0.435621,0.576582,-0.217538,-0.45408,-0.226924,-0.117498,-0.663718,0.0459848,-0.3397,-0.108735,-0.348553,0.181763,-0.150309,0.291247,0.702945,-0.436985,-0.354745,0.582946,0.444857,0.725469,0.445606,0.299597,0.463959,-0.192716,-0.0851469,-0.0255952,0.169946,-0.479041,0.299245,0.314318,0.27944,0.725805,-0.267019,-0.321993,-0.13006,0.186344,0.501419,0.211988,0.37061,0.107406,0.209778,0.532489,-0.131312,-0.46593,0.0208968,0.285134,-0.150604,-0.347716,-0.152719,0.0528269,0.482966,-0.155297,0.47266,0.281694,0.205903,0.0650148,0.407539,-0.0107909,-0.396943,0.28309,0.0314194,0.129089,-0.0607033,-0.173461,0.338264,0.047331,-0.141932,-0.210342,-0.0741185,0.253354,-0.345306,0.134339,0.256043,-0.094442,0.296068,-0.406386,-0.109005,0.13049,0.236115,0.361234,0.485916,-2.27573 +3438.93,0.925825,0.0912059,4,1.48339,0.721334,-0.951051,0.41757,0.972545,-0.142852,0.0802129,-0.0671973,0.219486,-0.0322537,0.281236,0.211105,-0.197715,0.272562,-0.0885401,1.0989,0.478916,0.366648,-0.331081,0.0744854,0.0504527,-0.361351,-0.81147,0.619829,0.0292684,0.126861,0.134028,0.484598,-0.1951,0.0838323,1.03713,-0.63211,0.142304,0.536432,-0.062587,-0.258618,-0.347339,-0.118338,0.426537,-0.299635,0.880598,0.527173,0.115147,-0.122219,-0.119585,-0.0840031,-0.482324,-0.227726,0.234006,0.21849,-0.0723423,0.798089,0.235556,-1.03106,0.877047,-0.118252,0.147063,-0.825053,0.868324,-0.472749,-0.317259,1.18166,-0.297448,-1.5267,-0.351542,0.221407,0.483384,0.205088,0.192914,0.0183154,-0.501599,-0.304526,0.458593,0.214384,0.399545,0.360926,0.28858,-0.401342,-0.317168,0.0979432,0.247265,-0.0898504,0.230084,-0.151813,0.205897,-0.490753,0.101033,0.170809,0.376357,-0.286969,0.0591768,-0.396782,0.0533205,-0.1899,0.10571,0.0718961,0.207367,0.326844,0.364465,0.34626,-0.0294913,-0.215755,-0.775058,-0.379055,-0.421172,-0.365203,0.467395,-0.0730152,0.0915562,0.679684,0.0997087,-0.0440836,0.421825,0.553754,-0.701922,0.208929,-0.126689,0.135492,0.609113,0.239678,-0.6965,0.18171,0.185706,0.0937141,0.327856,-0.272129,0.910578,-0.216129,-0.323297,-0.847127,0.242605,0.127045,0.208696,0.108481,-0.115925,-0.615989,0.399172,0.0800445,0.161981,-0.528632,-0.774938,-0.124958,0.214258,0.138543,-0.134618,-0.196589,-0.220303,0.548309,0.038199,0.0515148,-0.318535,0.444626,0.279271,0.218728,0.582351,0.534621,0.148125,0.027147,-0.0988324,-0.199214,0.0744718,-0.180827,0.630392,-0.224612,-0.0191163,0.57295,-0.234399,-0.03059,0.0288553,-0.366864,0.424575,-0.149588,-0.00888788,-0.0593112,-0.161674,0.221241,-0.723412,0.11329,1.07639,0.756073,0.0966452,0.710468,0.411316,-0.426528,0.485765,-0.572395,-0.834422,-0.124851,0.227605,-0.203184,0.243258,-0.22995,-0.0118903,-0.293315,0.0993228,0.901133,-0.0586239,-0.141799,-0.35126,-0.276106,0.0744971,-0.222344,0.0141254,-0.468537,-0.320197,-0.461943,-0.405234,0.841623,0.504211,0.33771,0.0650966,-0.408291,0.108932,-0.0905752,-0.2922,-0.0151601,-0.249395,0.153973,-0.602741,-0.177497,-0.332587,0.155959,-0.07725,-0.393792,0.0161964,0.53325,-0.0635727,-0.380447,0.0309905,-0.055395,-0.135547,0.0140116,-0.175403,-0.331709,0.277832,0.276622,-0.378046,-0.0288217,0.0871152,-0.419589,-0.390374,0.341848,-0.142046,0.138264,0.647249,0.0281378,0.826792,0.126175,-0.0117341,0.0605505,0.0857717,-0.558184,0.113293,-0.35391,-0.287813,0.695882,-0.0855343,0.187807,0.23691,-0.0673546,0.291496,0.153715,0.380486,-0.291245,0.0473416,0.492971,-0.199018,-0.400706,-0.191742,0.260028,-0.220651,0.154976,-0.405163,0.159816,0.307761,0.233488,0.109848,-0.142154,0.363369,-0.0148406,-0.125089,-0.245846,-0.576053,0.35996,-0.0138758,0.366632,-0.111931,-0.741264,0.240553,0.0701229,0.111495,0.18156,-0.139417,0.265902,-0.260628,-0.321187,0.0436667,-0.350598,0.306818,0.500782,0.236126,0.145955,0.310972,0.38204,0.557649,-2.88113 +3436.83,0.8092,0.0912059,4,1.55966,0.675973,-1.21999,0.377763,0.372374,-0.0641614,-0.229358,-0.5931,0.281468,0.344842,0.247382,-0.0656544,-0.242417,0.344365,-0.262695,0.338601,0.310105,-0.0974439,0.0900122,-0.383614,-0.374556,-0.884715,-0.662568,0.640282,-0.412877,-0.35316,-0.536473,0.139182,-0.323851,-0.079599,1.03913,-0.577395,0.189872,0.398106,0.235945,0.102393,-0.302383,0.584249,0.2744,0.284582,1.12112,0.506316,0.417209,-0.558961,0.147292,0.0142007,-0.221037,-0.433515,0.781065,-0.0509169,0.205066,-0.137005,0.0169984,0.04672,1.16284,0.129817,0.0846849,-0.933649,0.803831,-0.207103,0.284841,1.00233,-0.8037,-0.936072,0.355563,0.0653358,-0.0735881,-0.242505,-0.0870518,-0.61061,-0.0240988,0.457366,0.833538,0.00471906,0.443212,0.436407,0.0800048,0.277024,-0.0293587,0.191143,0.549477,-0.502001,0.0189984,0.15986,-0.0608583,0.686795,0.0264463,-0.528077,0.200518,-0.390082,0.186415,0.239998,0.140903,0.0113197,0.139343,-0.195159,0.0595508,-0.452016,-0.463113,0.0925459,-0.136823,0.200643,0.221169,-0.161847,0.167679,-0.133009,0.0443202,-0.237736,0.41099,0.517495,0.0196717,-0.0817976,-0.313666,0.19487,0.682403,-0.370812,-0.00728966,-0.332271,-0.299766,-0.17692,-0.695529,-0.116665,-0.532471,0.0766228,-0.329638,0.91874,-0.587029,-0.0151876,0.582893,0.0754106,0.101924,0.0682724,-0.285794,0.71335,-0.275153,0.373613,-0.310116,-0.264536,0.691044,-0.203208,0.22875,-0.0367643,-0.206784,-0.76536,0.342676,0.0674991,0.212632,0.322539,-0.367341,-0.183911,-0.234702,-0.0567336,-0.362745,-0.00426536,-0.333306,0.373094,0.365072,-0.449388,0.266187,-0.0946326,0.243717,0.362753,0.721096,-0.0238258,-0.488805,0.30763,0.125881,-0.305048,-0.196476,0.0478686,-0.0627518,0.302067,-0.17346,-0.342328,-0.0323977,0.262816,-0.13908,-0.0453384,-0.357754,-0.0333466,0.023954,-0.263069,-0.0871504,0.380204,-0.102106,-0.0505263,-0.179729,-0.3824,-0.0842964,-0.155973,0.0789712,0.208272,0.0529017,-0.537997,-0.0800856,-0.340691,0.511013,-0.0512683,-0.287753,0.579713,-0.257646,-0.274473,0.347686,-0.200144,0.290624,0.248998,-0.13911,0.904807,-0.34403,-0.198986,0.0657224,0.0197834,0.285996,0.00583933,0.228581,0.507665,-0.386658,0.075319,0.731139,-0.460819,0.217325,-0.562774,0.174831,0.403103,-0.596907,0.219346,-0.312976,0.246733,0.41927,0.260066,-0.162421,0.0328124,-0.29171,-0.311924,-0.448117,0.19991,0.480099,0.465797,0.391012,-0.163995,0.0256786,-0.607302,0.192694,0.337403,-0.292982,0.260861,-0.152503,-0.181476,-0.287027,-0.361605,0.159456,-0.392667,0.550522,-0.331532,0.242311,0.124846,-0.363142,-0.251635,-0.110132,0.0132399,-0.0316464,0.386437,0.193297,0.388048,0.18647,0.287024,0.0687189,0.344278,0.00819811,-0.0393431,-0.381123,-1.02239,0.283542,0.10149,0.0590696,-0.180726,-0.0684842,-0.0469936,-0.00406299,0.000342592,0.0820994,0.22054,0.170842,-0.0993436,0.143014,0.306215,0.090283,0.516179,-0.0137623,-0.00402933,-0.25257,-0.480682,0.295582,0.150306,-0.19931,-0.357862,-0.382459,-0.0995575,-0.497424,-0.851853,-0.211789,0.128525,0.291314,0.358504,0.539735,-0.572843 +3448.87,0.690744,0.0912059,4,1.5515,0.755795,-1.44475,0.475127,0.283756,-0.0549332,-0.0479667,-0.0900391,0.190858,0.040681,0.236489,-0.16659,-0.379873,0.475876,-0.0731739,0.835155,0.38562,-0.157339,0.177535,-0.144904,-0.163064,-0.809557,-1.24098,0.486586,0.186998,0.0494082,-0.138845,-0.140811,-0.504921,-0.189456,0.829285,-0.421793,-0.390458,0.357118,-0.528143,0.401182,-0.647122,0.358692,0.406749,0.0114476,1.03372,0.398551,0.612323,-0.620552,0.381629,-0.718173,-0.49446,0.603101,0.463207,-0.036534,0.105823,0.0634751,0.472535,-0.656131,0.697465,-0.0261779,-0.109273,-0.0462427,0.479698,-0.283317,0.381546,1.14628,-0.447631,-0.913362,0.0986208,0.0473243,0.247482,0.0455773,-0.179231,-0.346021,-0.270844,0.484119,0.258722,0.100627,0.433311,0.479983,0.646547,-0.645754,-0.0201392,0.105387,0.500738,-0.812897,-0.168282,-0.651353,0.0818862,-0.524785,-0.0175732,0.218864,0.203992,-0.231183,-0.240696,-0.325017,-0.231511,0.2924,-0.356248,-0.736285,-0.317372,0.427866,0.133871,0.374148,0.129707,-0.187968,-0.592205,-0.784925,-0.131495,-0.0362773,0.57635,-0.480432,0.307365,0.515801,0.165836,0.128059,-0.192364,0.375673,-0.475925,0.122394,-0.580029,0.0290479,0.590707,-0.105006,-0.259709,-0.283632,0.716373,-0.249255,-0.36179,-0.331493,0.534989,-0.183893,-0.477581,-0.256596,0.0606844,-0.171603,0.101665,0.210019,-0.490788,-0.0710209,-0.120387,0.125031,0.322839,-0.324877,-0.553039,-0.254417,-0.0459785,-0.62756,0.370656,0.181007,-0.388873,0.629569,0.101676,-0.0440676,-0.129127,0.152535,0.66964,-0.370386,0.157166,0.609507,0.0494883,0.00230861,0.108812,0.247306,-0.295403,-0.228998,0.231741,-0.137161,0.0580329,0.132415,-0.106546,0.0823249,0.115406,-0.0733448,-0.00144472,0.14744,-0.163027,0.147814,0.156765,-0.0247189,-0.141388,-0.10721,0.336892,0.802668,0.248805,-0.0827931,0.183937,-0.178911,-0.108139,-0.160276,-0.505699,-0.637358,-0.195156,-0.187616,-0.106086,-0.155111,0.177264,-0.47765,0.0424048,-0.019779,0.322325,-0.405616,-0.482585,0.00446764,-0.243631,-0.472029,-0.308135,-0.0783453,0.105013,-0.273714,-0.328061,0.827498,0.200228,0.459095,-0.0177796,0.230303,-0.319125,0.617431,-0.389051,0.0665942,-0.169183,0.239158,0.146378,-0.505977,-0.226304,-0.605684,-0.0457261,-0.154729,-0.126417,0.389777,-0.143923,-0.650608,0.687365,-0.131139,0.198626,-0.228829,0.243446,-0.379692,-0.63557,0.310395,-0.211551,-0.364194,0.174019,-0.119924,-0.520338,0.150042,0.032902,0.0156645,0.0468888,-0.370835,0.229356,0.24195,-0.317882,-0.0980428,-0.2597,-0.935079,-0.0476626,-0.198962,-0.906595,0.847527,-0.12039,-0.0245095,-0.0175286,-0.289708,0.122357,-0.165628,0.172814,-0.551943,-0.1507,0.0155663,-0.230222,-0.36442,-0.0724038,0.081197,0.266786,0.0829359,0.0638373,-0.310364,-0.150006,-0.0324964,0.318463,-0.326441,0.389633,-0.242215,-0.549144,-0.0124652,0.00719793,0.0601279,-0.136974,0.427107,-0.0711109,0.24008,-0.0348403,-0.178899,-0.0616505,-0.173126,0.0913951,0.150717,-0.145617,-0.0953924,0.297619,-0.38187,-0.363938,0.474824,0.260536,0.107184,0.226922,0.32739,0.476363,-0.404476 +3430.13,0.934009,0.0912059,4,1.60037,0.774178,-1.40528,0.40527,-0.0758301,-0.175382,-0.0572867,0.0153029,-0.0566977,-0.191176,0.263205,0.101479,-0.690411,0.82462,-0.138113,0.515657,0.308614,-0.33578,0.235108,-0.585827,-0.491191,-0.989786,-0.10255,0.604057,0.176429,0.224212,-0.101461,-0.14003,-0.622153,0.0426878,0.769621,-0.405753,-0.0982775,0.0425357,-1.19802,-0.0631721,-0.110011,0.852054,0.730489,0.0779369,0.9008,0.16153,0.039349,-0.442185,0.204835,-0.450228,-0.294668,0.816743,0.924137,-0.249095,-0.0401714,0.512195,0.237165,-0.0561005,0.68845,0.0288256,-0.40767,-0.0633988,0.489186,0.0673792,0.124608,1.17808,-0.778891,-1.04109,0.548226,0.258406,0.149648,0.0957282,-0.0201074,-0.402569,-0.556051,0.538486,0.321585,-0.138554,0.305546,0.373818,0.285182,-0.00926592,-0.135096,0.189443,1.0022,-0.45895,-0.449355,-0.445388,-0.24817,-0.47125,-0.226573,-0.0472416,0.24216,-0.289242,-0.0869577,-0.497723,-0.0731558,0.186051,0.185401,0.0850728,0.236136,-0.253025,-0.0815123,0.188438,0.53569,-0.351898,-0.71034,-0.669478,0.209421,0.2789,-0.1677,-0.712199,0.518825,0.481558,0.265814,-0.0465669,0.386921,0.40411,-0.165115,0.0693004,-0.0729026,0.0313614,0.492907,0.169156,-0.249087,0.424235,-0.095558,-0.29324,-0.0184723,0.185866,0.262626,-0.118585,-0.343816,-0.297318,-0.026593,-0.218034,0.0539896,0.42331,-0.585299,0.177646,-0.163948,0.301991,0.394476,-0.471696,-0.42022,-0.0350671,-0.00481727,-0.531834,0.699218,0.0807868,-0.101305,0.588471,-0.226518,-0.207507,-0.0529315,-0.102688,0.699463,-0.0716129,-0.0772254,0.255517,-0.441002,0.0515439,0.508276,0.109984,-0.104947,-0.158357,0.780662,0.348492,-0.312414,0.138434,-0.252541,-0.0482136,0.108477,-0.350834,0.0743542,0.529402,0.0359722,0.0716367,0.368079,-0.111641,-0.194185,-0.0401913,0.484768,0.335115,0.396968,-0.345807,0.340549,-0.0704558,-0.289361,-0.0430024,-0.221097,-0.538235,-0.0298027,-0.403943,-0.239361,-0.222027,-0.0282276,-0.526577,0.204309,0.0376891,-0.128229,0.100458,-0.546963,-0.0230815,-0.216503,-0.684043,-0.475518,0.0832873,0.390835,0.192251,-0.301991,0.805463,0.2069,0.102663,-0.106441,0.034806,0.0249912,0.285062,-0.234924,-0.244495,-0.300902,0.47431,0.752295,0.106473,-0.264681,-0.340571,0.053314,0.240979,-0.297508,-0.00300334,0.181059,-0.317051,0.0550823,-0.284932,0.209479,-0.114015,0.107208,0.100412,-0.25735,-0.0332038,-0.00214231,-0.368362,-0.0894091,-0.17768,-0.0295372,0.228949,-0.096257,0.0568643,0.277144,0.0511422,0.184926,-0.0664792,-0.0765596,-0.303765,0.134736,-0.887646,-0.0754132,-0.21404,-0.357487,0.768576,-0.0577963,0.244837,-0.291301,-0.423663,-0.106915,0.053417,0.238752,-0.145377,0.200364,-0.295568,0.0296433,-0.323777,0.240216,-0.660747,0.09006,0.0815772,-0.0331042,-0.168704,-0.205734,0.0871927,-0.252934,-0.482976,0.647051,0.0729339,-0.356446,0.00496715,-0.211479,-0.267287,-0.083179,0.101836,0.219761,-0.224783,-0.181428,-0.0282488,0.112137,0.0975617,-0.150998,-0.0190607,-0.157998,-0.499552,0.617744,-0.243593,-0.184352,0.198658,-0.131148,0.120006,0.246141,0.346419,0.496126,0.881258 +3415.61,0.909393,0.0912059,4,1.65586,0.829871,-1.25253,0.404869,0.0508122,-0.181501,-0.36065,-0.445867,-0.079602,-0.341507,0.159878,-0.298221,-0.392368,0.49917,-0.337521,0.543343,0.386835,-0.313851,0.0367335,-0.490343,-0.65524,-1.0306,-0.175898,0.50689,-0.0581539,-0.242587,-0.191915,-0.0807568,-0.234029,-0.024781,0.86034,-0.327599,-0.250968,0.159529,-0.845553,0.0105766,0.177278,0.685604,0.683989,-0.13858,0.784091,0.210538,-0.0378076,-0.697159,0.154227,-0.412842,-0.921997,0.821786,0.64577,-0.22696,0.0539152,0.21064,0.257953,-0.323314,0.452678,0.264113,-0.156312,-0.193879,0.391861,0.262228,0.261037,1.07801,-0.995431,-1.59809,0.36313,0.36054,-0.569568,0.365367,0.243609,-0.409047,-0.288404,0.674074,0.41474,-0.119076,0.328171,0.122749,0.52019,0.0607428,-0.124458,0.244431,0.614176,-0.679422,-0.506127,-0.296206,-0.297611,-0.634614,-0.214028,0.288894,0.287511,-0.345525,0.159168,-0.53779,-0.018271,0.0100858,0.205987,0.0114793,0.0519018,-0.453818,-0.299173,0.386066,0.789937,-0.790579,-0.980556,-0.600406,0.16524,0.25226,-0.00594349,-0.419563,0.542046,0.728024,0.129293,0.0764457,0.346804,0.223926,-0.389993,-0.0199122,-0.149809,0.120579,0.36963,0.104424,-0.277014,0.551004,-0.592873,-0.010153,0.40116,0.334393,0.297969,-0.0408161,-0.333067,-0.164713,-0.249164,-0.208156,0.1376,0.587621,-0.399752,0.233325,0.199568,0.143998,0.53304,-0.458193,-0.157546,-0.151652,0.0412105,-0.404394,0.576174,0.0920959,-0.102931,0.265485,-0.217341,0.00130111,-0.147311,0.266556,0.691393,-0.0976619,-0.00319039,-0.359298,-0.406298,-0.0876066,0.306861,0.332185,-0.199539,-0.26279,0.626361,0.431803,-0.206532,-0.378172,-0.58002,-0.243842,0.204173,-0.432331,-0.0818041,0.387485,-0.0783293,-0.185291,0.426419,-0.297441,-0.473986,-0.21673,0.823727,0.230536,0.318131,0.0706508,0.529348,-0.278244,-0.0838763,-0.164905,-0.384506,-0.648481,0.281532,-0.402031,-0.254115,-0.101885,-0.174458,-0.782079,0.239261,0.310675,0.0589531,0.0673637,-0.383009,0.122865,-0.259827,-0.634618,-0.270951,-0.173206,0.291982,0.423918,-0.259305,0.86606,-0.142867,0.279563,-0.307769,0.0239911,0.194136,0.25283,0.0258108,-0.00718475,-0.280096,0.291362,0.768006,0.344997,0.507408,0.208537,-0.0891496,-0.13406,-0.756317,0.162657,0.153963,-0.14675,-0.150079,-0.115313,-0.0316608,-0.044735,-0.0794917,-0.173414,-0.500653,0.0350756,0.136952,-0.321245,0.433757,-0.611526,-0.204953,0.201519,-0.307989,-0.0941767,0.386056,0.219468,0.234751,0.0542559,-0.00692301,-0.205809,0.224825,-0.552587,0.131732,-0.271863,-0.0907266,0.345839,0.000566532,-0.13333,-0.42178,-0.194786,-0.502216,0.222417,0.574376,0.262194,0.00117887,-0.194806,0.317207,-0.245048,-0.0541816,-0.355294,-0.182238,0.0550177,-0.08934,-0.397537,0.0916344,0.123066,-0.593318,-0.145825,0.355369,0.188404,-0.240977,0.119417,-0.311306,-0.532527,-0.144635,0.0966311,0.0931415,-0.111741,-0.325848,0.157013,-0.0207078,-0.0149899,-0.271448,-0.293758,-0.154574,-0.705275,0.175305,-0.0384823,-0.20382,0.451301,-0.255542,0.106586,0.24614,0.326475,0.496125,0.339514 +3420.3,0.994608,0.0912059,4,1.54398,0.809546,-1.14061,0.414008,0.244397,-0.104002,-0.0948718,-0.135872,0.263681,-0.00985794,0.221212,-0.223006,-0.307151,0.543585,0.156882,0.924812,0.477799,0.116741,-0.132024,-0.0733457,-0.328044,-0.819124,-0.3579,0.39416,-0.0552466,0.507205,-0.234859,0.0991432,-0.357909,-0.414281,0.47304,-0.403416,-0.29185,0.377072,-0.58474,-0.0622819,-0.575653,0.443671,0.684137,0.0300092,1.16062,0.335901,0.95272,-0.806004,-0.172694,0.0833524,-0.866419,0.385439,0.842461,-0.449649,0.184208,1.27806,0.140049,-0.700591,0.605327,0.17326,-0.153428,-0.560601,0.564268,-0.184389,0.0671633,1.08102,-0.73117,-0.587977,-0.317644,0.191587,-0.432868,0.0156667,-0.145981,-0.329137,0.209515,0.268224,0.646671,0.13871,0.62985,0.446009,0.145195,-0.429199,0.165172,0.102783,0.382546,-0.688632,0.174126,-0.730596,-0.220664,0.359738,0.0059851,0.447207,0.124717,0.146978,-0.157495,-0.411372,-0.411902,0.346694,0.466974,-0.462267,0.21927,-0.763159,-0.277237,-0.227488,0.308982,-0.317288,0.102145,-0.375482,0.362123,0.0960437,-0.463405,-0.272176,0.348837,0.519281,0.081159,-0.113805,0.152677,0.501444,-0.0325424,0.260928,0.0461706,0.0780641,-0.12584,0.0795811,-0.89502,0.420074,-0.156703,0.0662629,-0.0716278,0.751541,0.340835,0.476742,-0.206353,-0.272265,0.119707,-0.0760932,-0.0764124,0.514399,-0.451789,-0.115321,-0.132438,-0.120986,0.43634,-0.793442,-0.199408,0.0362143,-0.184251,-0.587372,-0.135022,0.114586,-0.0926871,0.328523,-0.180701,-0.580254,-0.186265,0.351373,0.427137,0.0315651,0.0760137,0.178109,-0.110998,0.00691837,-0.0282355,0.622445,-0.14359,0.0587642,0.257988,0.0426647,-0.156572,-0.789254,-0.507703,-0.318997,-0.0670644,-0.297712,0.0752122,0.232936,-0.205858,-0.455265,0.381113,-0.350709,-0.235717,-0.382543,0.469112,0.547297,0.465982,0.219273,0.49366,0.135877,0.318467,0.196266,-0.260622,-0.209389,0.0378493,-0.185775,0.130293,-0.0613782,0.0944854,-0.605092,0.254847,0.104621,-0.224199,0.224758,-0.105284,-0.0689381,-0.292481,-0.276349,0.0833668,-0.0714059,0.420517,-0.0503866,-0.437552,1.13723,-0.240802,-0.285222,-0.040559,0.23269,0.0320442,-0.237302,-0.14556,-0.304731,-0.77251,0.519775,0.49956,0.141251,-0.317533,-0.383062,0.442417,-0.507295,-0.880403,0.0146528,0.532523,-0.267154,-0.061704,0.00615817,-0.0857014,0.0530521,-0.509747,-0.50115,-0.566485,0.179185,-0.096057,-0.167368,0.422225,-0.59369,-0.527686,-0.0637619,-0.0100721,0.349945,0.291769,0.0175162,0.486863,0.0588799,0.038984,-0.308504,-0.0975545,-0.814457,0.00454727,-0.42552,-0.275405,0.424363,0.515959,0.55817,-0.0940704,-0.308595,0.0482188,-0.0360477,0.600642,0.191347,0.564101,0.0939357,0.341436,0.115655,-0.450298,-0.0759025,0.210364,-0.0552717,-0.355103,-0.614813,0.327922,-0.119401,-0.180297,-0.30402,-0.0633738,0.137344,0.165166,0.302104,-0.328814,0.130006,-0.00499388,0.122408,-0.0511481,0.0854721,0.460517,0.169936,0.0709105,-0.225199,-0.339559,0.366691,0.158217,-1.07054,-0.122864,-0.486712,-0.324495,0.505717,-0.284557,0.141675,0.257908,0.376398,0.507846,-0.46594 +3415.93,0.791529,0.0912059,5,1.5611,0.826923,-1.15085,0.341876,0.384301,-0.100354,0.484989,-0.0226083,0.159083,0.204291,-0.204329,0.0956041,0.386475,-0.0180682,-0.300156,0.705124,0.00266093,0.0142266,0.194073,-0.105267,-0.209836,-0.526858,-0.823769,0.352687,-0.433897,-0.484894,-0.125358,0.00640121,-0.102108,-0.133179,0.817639,-0.445686,-0.132563,0.0223026,0.222729,0.245039,-0.210269,0.814265,0.2367,-0.197295,1.40906,0.789021,-0.382972,-0.922044,-0.170362,-0.271736,-0.276402,-0.264008,0.326675,0.621471,0.0950276,-0.483611,0.0533705,-0.267448,0.760845,-0.287031,0.0162712,-0.889323,0.513137,-0.461822,0.220611,0.662792,-0.0666231,-1.17839,0.409578,0.0082728,0.514685,0.00321312,0.552978,-0.261767,-0.331609,0.121735,0.585705,-0.193166,0.217735,0.366271,0.206291,0.228715,-0.682901,0.171836,0.515279,0.0924996,-0.137785,0.471778,-0.0607254,-0.425012,0.190898,-0.628761,-0.0718461,-0.63423,-0.00477721,0.593589,0.513159,-0.477377,-0.541203,0.0156185,-0.211459,0.251818,0.174961,0.284794,-0.276015,0.190409,-0.632945,-0.0776402,-0.125962,-0.562101,0.608265,-0.164813,-0.224575,0.59907,-0.388012,-0.237284,0.153304,0.478239,-0.189415,-0.208975,-0.637019,-0.0884295,0.507005,0.0461131,-0.174524,-0.528891,-0.0414072,-0.283209,-0.100526,-0.165179,-0.131028,-0.00942919,0.59993,-0.307317,-0.000459911,0.362251,0.145035,0.242945,-0.00150446,-0.28998,-0.0650983,-0.0697905,0.0818771,-0.0112268,-0.453294,-0.314931,0.352526,-0.234834,0.240282,0.233526,0.18883,0.126404,0.148943,0.316053,0.12896,0.0246417,-0.237421,-0.374628,0.260528,0.384204,0.281829,-0.256353,-0.312023,-0.810736,0.496219,0.0705795,0.98826,-0.0885936,0.204314,0.719564,0.359631,-0.271853,-0.113739,0.244071,0.0677996,-0.159773,-0.0895867,-0.189106,-0.665179,0.152739,-0.311307,0.241865,-0.134873,0.865255,-0.466845,-0.261771,-0.114743,-0.306248,-0.233988,-0.75093,0.125505,-0.163452,0.28248,-0.397517,0.288985,0.0934348,-0.199821,-0.47002,-0.486148,-0.0756737,0.397126,-0.50693,-0.633099,-0.15402,-0.225287,-0.00344397,0.00177555,0.0237631,-0.246917,0.191321,-0.338984,0.759989,0.226452,0.585845,0.125593,-0.525013,0.0291357,0.384189,-0.240336,0.550153,0.188893,-0.673374,-0.152841,-0.590909,0.443783,-0.426932,-0.444588,0.784331,0.169997,0.679212,-1.30477,-0.118734,0.0422451,-0.0656966,-0.0366029,0.104408,0.0155122,0.10577,0.029343,0.622586,0.1927,0.420426,0.474246,-0.0520052,0.304373,0.226018,-0.124483,-0.202795,0.188721,0.436667,0.334627,0.204108,-0.236445,-0.0383769,0.114202,-0.0615046,0.442533,-0.21825,-0.249271,0.0951695,-0.79015,-0.625061,0.0578835,0.0457229,0.195825,0.505094,-0.603873,0.234176,-0.0093298,0.14366,-0.177631,-0.350567,0.429141,0.213614,-0.477563,-0.529373,-0.0763021,0.636973,-0.502928,-0.24319,0.049875,0.25199,0.230727,0.0707115,-0.330392,-0.443287,-0.200968,-0.280057,0.163669,-0.149606,-0.000526877,0.297195,-0.562578,-0.259281,0.140091,0.149862,0.341439,-0.20703,-0.40685,0.511817,0.189523,0.445301,-0.0311672,-0.637559,0.321199,0.142681,0.195291,0.377732,0.441917,-0.871119 +3435.61,0.859734,0.0912059,4,1.56945,0.978229,-0.828222,0.272568,0.0330609,-0.0635021,0.00725632,0.254284,0.219908,-0.485396,-0.217161,-0.223761,-0.158311,0.608726,0.157347,0.883917,0.0528214,0.030648,-0.389919,0.109515,-0.123181,-1.04059,-0.754799,0.145104,-0.575912,0.172747,0.23655,0.228352,-0.0292229,0.354329,0.883095,0.0289327,-0.222975,0.0366078,-0.230317,0.203049,-0.500377,0.430264,0.452131,-0.0460759,0.831708,0.914026,-0.182289,-0.614287,-0.308731,0.109856,-0.81447,0.159313,0.0826754,0.205834,0.322546,0.380956,0.374951,-0.578587,0.480612,-0.112938,0.0926459,-0.463211,0.275219,-0.685646,0.419766,0.806219,-0.581555,-0.753334,0.0666993,0.510846,-0.0429125,-0.0795452,0.33122,-0.433977,0.226897,0.459734,0.60306,0.0160078,0.0241011,0.269089,0.663032,-0.669685,-0.45925,0.0754491,0.641071,-0.0860671,0.275574,0.39353,0.111859,0.119306,-0.513109,-0.429276,-0.0650188,-0.711707,-0.0420686,0.226065,0.265607,-0.305938,-0.372994,0.241845,0.165448,-0.361559,0.01422,0.184224,0.113484,0.276284,-0.380258,0.0350698,0.298069,-0.372057,0.67716,-0.331869,-0.088491,0.395975,-0.345094,0.19194,-0.624573,0.395659,-0.259941,0.0408329,-0.0444682,-0.10167,0.694724,-0.262114,-0.553325,-0.112848,-0.12343,-0.597158,-0.408338,0.673181,-0.220449,0.0274183,0.147588,0.18021,0.535699,-0.153438,-0.034121,0.31071,0.0621156,-0.640558,0.134453,-0.0220331,0.210621,0.0382218,0.0278922,0.0673236,0.351436,-0.0022912,-0.071701,0.433748,-0.0673555,0.0671007,-0.351271,-0.456724,-0.573159,0.0400567,-0.0132473,0.185782,0.299355,0.273857,0.142259,-0.0857569,-0.0259496,-0.250145,0.241434,0.0606408,0.671412,0.171795,0.0147146,0.689409,0.424131,-0.142559,-0.464164,-0.107191,-0.0781865,0.497748,0.122874,0.0654061,-0.102196,0.509548,-0.23006,-0.177059,-0.477188,0.764794,0.284684,-0.9298,0.0421072,-0.215428,0.429256,-0.881939,0.423618,0.128992,-0.0155261,-0.440405,0.0281894,-0.0248589,-0.150661,-0.37266,-0.186555,0.240674,0.264709,-0.277155,-0.578193,-0.06039,-0.34531,0.267491,-0.0624644,0.182235,-0.255064,-0.166835,-0.732864,0.572844,0.307052,-0.346697,-0.0347989,-0.180028,0.229921,-0.0624659,-0.257738,0.559025,-0.0672047,0.136797,-0.708606,-0.133428,-0.0850878,-0.131695,-0.494907,0.730709,-0.109682,0.767479,-0.761267,-0.295865,-0.421332,-0.111497,-0.342261,-0.0549271,0.257201,-0.358161,-0.367892,0.368389,-0.155038,-0.110661,0.854142,-0.0897233,0.353037,0.229017,0.220475,-0.105302,0.137322,0.0944372,0.535282,-0.109253,-0.364337,-0.536515,-0.275912,-0.385543,0.306201,0.34194,-0.383358,-0.186142,-0.302362,-0.136348,0.111976,-0.0702601,0.600228,0.449765,-0.516734,0.0519983,0.0433852,-0.156193,-0.0640562,-0.0618787,0.126269,-0.249615,-0.272625,-0.339455,-0.314187,0.420188,-0.205566,-0.395168,0.345957,0.399891,0.0422776,-0.333895,-0.461239,-0.174902,0.0511473,0.42088,-0.0264367,0.0310262,-0.468542,-0.340659,-0.00802951,-0.232162,-0.146572,-0.282165,0.0380062,-0.0899661,0.329862,-0.699414,0.316225,0.0225102,0.116704,-0.341869,0.00376683,0.115335,0.242022,0.33961,0.491957,-0.0772266 +3429.89,1,0.0912059,5,1.63955,0.939698,-1.02879,0.324565,0.137366,-0.00990569,-0.0790056,-0.376799,0.837082,0.390334,-0.108327,-0.468661,0.00700573,0.467744,-0.317116,0.684078,0.129326,-0.744997,-0.0216037,0.147545,-0.0351685,-1.07285,-0.795099,0.147519,-0.868069,-0.534082,0.109088,0.622183,-0.452568,0.362606,0.567581,-0.422929,-0.241237,0.0233135,-0.307886,-0.462304,-0.459441,0.645759,0.24324,-0.380202,0.989944,0.724072,0.428308,-0.733082,0.0494098,-0.367526,-0.684771,-0.00717551,0.448138,-0.0336466,0.265714,0.326936,-0.135176,-1.0032,0.402181,0.240707,-0.69673,-1.02793,0.113367,0.400763,0.239021,0.592732,-0.869399,-1.25419,0.283088,-0.0556566,-0.0189297,-0.214593,0.300945,-0.37843,0.26595,0.203187,0.363415,0.112683,0.650743,0.546586,0.515512,0.503827,-0.0228286,-0.362438,0.40539,-0.068887,-0.0362072,-0.323166,-0.134656,-0.441704,0.409283,-0.233831,-0.43845,-0.111951,-0.00738547,0.167777,-0.208267,-0.0648735,0.549803,-0.415613,-0.176297,0.0255627,0.52078,0.369275,-0.279693,0.0576059,-0.459601,-0.511831,-0.372632,0.148452,-0.0492451,0.0756483,0.292687,0.414421,0.371313,-0.500296,0.734921,0.466659,-0.0522064,0.41647,-0.187687,0.442794,-0.186489,0.338176,-0.790774,-0.101181,-0.0817816,0.301783,0.0942927,-0.541728,0.0466011,0.0168536,0.254333,-0.315469,-0.400305,-0.0683983,-0.423201,0.570696,-0.346708,0.0730721,0.00415577,-0.288186,0.149626,-0.201326,-0.153246,-0.280357,0.787779,-0.756711,-0.153341,-0.483253,0.218967,-0.0358032,-0.186798,-0.233948,0.105974,0.114543,0.27105,-0.31165,0.559134,0.0229661,-0.0264141,-0.0241173,0.155915,0.168591,0.29952,0.0722073,0.57547,-0.0811785,0.0993156,-0.319881,-0.314985,-0.113793,0.0731687,-0.137312,-0.0211933,-0.262718,-0.18453,0.0210737,0.154948,-0.498009,-0.238628,-0.382777,0.585661,0.898198,-0.233141,0.302507,0.0707784,0.223596,-0.112069,0.0683655,-0.198935,-0.204473,-0.124234,-0.378481,-0.0552213,-0.0817091,-0.0173601,-0.483306,0.288357,0.110817,-0.599395,-0.290737,-0.40965,0.194095,0.136849,-0.346036,-0.18281,-0.638668,-0.319019,0.0488509,-0.584483,0.864765,-0.365936,0.399391,0.0339786,-0.28406,0.229011,0.49119,0.256953,-0.214245,-0.204328,0.159695,0.25853,0.353483,0.349062,-0.436372,0.439763,-0.149289,-0.522353,0.3544,-0.247793,-0.485024,0.540692,0.302863,-0.0943825,0.0565185,-0.443342,0.293151,0.613158,0.811982,-0.647054,-0.122281,0.417739,-0.273148,0.249489,0.394438,0.234588,-0.190393,-0.0771015,0.382714,-0.0419829,0.408149,0.256494,-0.298536,0.110452,-0.511336,0.32655,-0.0400392,0.110342,0.229189,-0.447425,0.241279,-0.179989,-0.0172694,0.0118689,0.00813946,0.518572,-0.229736,-0.271794,-0.501619,-0.373896,-0.196874,0.30333,0.0986105,-0.223895,-0.0907638,-0.245951,0.127655,0.106386,-0.398937,-0.414098,-0.545709,0.0404045,0.0367716,0.193574,0.214775,-0.0430112,0.0895131,0.370173,-0.0746529,0.0043853,0.571594,0.0343601,0.191898,0.0572555,-0.1669,-0.0856051,0.312086,-0.207457,0.114333,-0.643335,0.413943,-0.303338,-0.41902,0.0977249,0.114655,0.299174,0.338608,0.546968,-0.242604 +3429.12,0.956754,0.0912059,4,1.63303,0.953114,-1.20914,0.461716,0.303578,-0.158479,0.152627,0.568455,-0.373384,-0.0863293,-0.271984,-0.364711,-0.0797009,0.685617,-0.123088,0.771007,-0.076235,-0.0795295,-0.27695,-0.410529,0.0551065,-1.31285,-0.931651,0.104146,-0.111865,0.609712,0.0846119,0.0563571,-0.296388,-0.0919691,0.589327,-0.930177,-0.472296,0.149111,-0.168703,-0.0208804,-0.793692,0.898097,0.474666,-0.129234,0.997771,1.006,-0.079666,-0.794976,-0.458245,0.312564,-0.845711,0.451835,0.437684,-0.187208,-0.403795,0.259954,0.163512,-0.131266,0.238475,-0.333234,-0.356082,-0.540963,0.00451623,-0.816364,0.0650619,0.880961,-0.939388,-1.13319,0.341239,0.205627,-0.05983,0.400691,-0.0653139,-0.326473,0.0294079,0.0362342,0.153495,0.142466,0.368057,0.260913,0.508974,-0.510336,-0.585775,-0.0118019,0.817034,-0.341151,0.148449,0.234652,-0.536725,-0.127651,-0.37393,-0.0612346,0.251487,-0.478563,0.219663,0.301537,0.167371,-0.348008,-0.19557,0.103332,0.0486018,-0.844154,-0.178462,-0.0503711,0.0644454,-0.224765,-0.081844,-0.369966,-0.0164095,-0.497167,0.601285,-0.395842,0.140211,0.339611,0.346574,0.0469962,-0.120068,0.352673,0.173831,0.00182987,-0.513813,0.103954,0.365793,-0.313635,-0.197471,0.279167,-0.307583,-0.0671715,-0.523943,0.540439,0.0182624,0.281981,-0.0672746,-0.3676,0.275566,-0.469799,0.28415,0.10507,0.209223,0.155676,0.188889,0.104285,-0.117385,-0.486314,-0.758377,0.179459,-0.314559,-0.43406,0.115063,0.433237,0.0169912,0.393179,-0.184749,0.0883026,-0.292219,0.126255,-0.321677,0.141777,-0.0561938,0.294672,0.262542,0.108634,-0.215701,-0.580639,0.297908,-0.151252,0.828037,0.210217,-0.792571,0.377781,0.171234,0.207074,-0.211652,-0.0722807,0.351656,0.373025,0.0308086,-0.257134,0.279009,-0.233414,0.05524,0.138056,-0.0859384,0.700292,0.101178,-0.263804,0.112998,-0.136022,-0.0719003,-0.179548,-0.0432657,-0.430764,0.492439,-0.275805,-0.476089,-0.0886295,0.220507,-0.117366,0.0473271,-0.196735,0.525315,-0.642319,0.204451,0.0941465,-0.384065,0.0301392,0.067918,0.189473,0.0108915,-0.0562844,-0.38466,0.78407,0.525848,0.179069,0.254017,-0.454822,0.0837519,0.346623,-0.55843,0.498791,-0.233415,-0.105006,-0.267793,-0.276393,-0.21282,-0.459834,-0.178921,0.410206,-0.311461,0.41962,0.0282469,-0.170096,-0.57005,-0.146843,0.164679,-0.0113444,0.0672777,0.0386328,-0.792454,0.521493,0.349159,0.187728,0.8208,0.252165,-0.235925,-1.06161,-0.308242,-0.107167,0.526163,-0.533374,0.632543,0.123933,-0.292647,-0.618131,-0.326975,-0.132467,0.333121,0.0965264,-0.706249,-0.131331,-0.497713,-0.150428,0.549219,0.0270101,0.452293,0.0712597,-0.332769,0.0831357,0.375966,0.392933,0.256664,0.0144452,-0.244134,-0.206424,-0.437344,0.0580735,-0.124877,-0.336789,0.138463,0.0912549,0.196417,0.204279,0.379192,0.0527716,-0.134375,0.116155,-0.245333,0.0147055,-0.0981557,0.0679329,-0.338884,0.050184,0.28502,0.294329,-0.0662733,0.12031,0.443971,-0.403145,0.343458,-0.600608,0.417588,-0.246921,-0.0884362,-0.148013,-0.386091,0.109869,0.330745,0.331465,0.575104,-0.822794 +3420.24,0.72476,0.0912059,4,1.60744,1.01071,-1.0009,0.262284,0.475381,-0.106301,-0.0915224,-0.3951,0.963893,0.20015,-0.402278,-0.259252,-0.414128,0.500516,-0.366336,0.912897,-0.391841,-0.253191,0.0476245,-0.0891237,-0.226438,-0.749416,-0.827392,0.0450177,-0.626759,-0.639491,0.0162016,0.456989,-0.45911,0.0306127,0.775767,-0.138217,0.0851739,0.120829,-0.458753,-0.337431,0.0717423,0.334258,0.54508,-0.599226,0.838229,0.592113,0.391203,-1.11,-0.0445373,0.374446,0.222671,-0.484713,0.321106,0.207097,-0.00258667,1.02282,-0.429867,-0.904866,0.484486,0.226261,-0.240442,-1.0508,0.42914,-0.269094,0.0834325,1.16392,-0.840718,-1.2857,0.30314,-0.0905685,-0.122585,-0.228453,0.102037,-0.107616,0.0335215,0.313401,0.24383,-0.224243,0.588916,0.844053,0.0306187,0.119252,0.191246,-0.395091,0.0992527,-0.320768,-0.00557393,-0.167821,-0.371388,-0.0258083,0.144871,0.0856635,0.0932794,-0.504641,-0.304591,-0.528309,-0.0402077,-0.115346,0.360391,-0.751077,-0.229424,0.0394547,0.16113,0.392723,-0.473722,0.00673595,-0.488326,-0.00405141,0.10113,-0.161952,0.196249,0.382513,0.288347,0.707736,-0.165068,-0.288155,0.447471,0.486,-0.107876,0.170585,0.242932,0.0713099,0.412084,0.267463,-0.835859,0.0702179,0.0849206,-0.744642,0.0286374,-0.586946,0.167397,0.201825,0.680742,-0.244248,-0.249361,-0.205676,-0.375493,0.753519,-0.172143,-0.151659,0.0493334,-0.42219,0.340537,-0.367658,0.178702,-0.467848,0.222502,-0.524945,-0.271962,-0.206898,-0.131678,0.146325,-0.329221,-0.322552,-0.329759,0.0229086,0.273249,-0.508734,0.500497,0.262565,-0.00717534,-0.219611,0.366246,0.275413,0.155032,0.508545,0.889319,-0.553639,0.272974,-0.283112,0.0337441,-0.715205,0.217054,-0.0907724,0.238249,-0.134122,0.0132238,-0.607238,-0.0485945,0.0103595,-0.465221,-0.296144,0.432182,0.500182,0.127065,0.221588,0.104018,0.240882,-0.00297161,0.0260948,-0.375803,0.0580051,-0.379889,-0.208903,-0.254829,-0.0524943,-0.0951806,-0.514072,-0.327512,0.472597,-0.340974,-0.250641,-0.513984,-0.0219163,0.0347621,-0.353839,0.0897231,-0.273982,0.132659,-0.0802778,-0.24109,0.586359,-0.227253,0.48051,-0.213174,-0.0102131,-0.0700622,-0.149784,0.298746,0.160507,0.146573,0.20405,0.321662,0.10789,0.486802,-0.0577881,-0.119521,-0.403163,0.0968086,0.671972,-0.51496,-0.163934,-0.0656585,0.279295,-0.0554881,0.280236,-0.539692,-0.414328,0.359342,0.381104,-0.151223,0.396875,0.0525272,-0.535104,-0.316519,0.595811,0.268602,-0.0523227,-0.252732,0.3281,0.415839,0.0168173,0.115932,-0.507257,0.233747,-0.662955,0.659211,-0.277855,0.00745954,0.440338,-0.285392,-0.102171,-0.0769173,-0.106501,-0.0460389,0.00547083,0.423995,0.28292,-0.549899,-0.487554,-0.535545,-0.0739665,0.459667,0.249844,-0.277337,-0.330605,-0.11304,0.455417,-0.402139,0.273142,-0.0229603,-0.59704,0.698415,-0.118646,0.200425,-0.2772,-0.494867,0.200795,0.611049,0.127613,0.258996,-0.218897,-0.0869852,-0.331,0.155145,-0.0970741,-0.0262567,0.760422,-0.369124,0.284578,-0.190327,0.177312,0.294577,-0.566348,0.344056,0.119518,0.244667,0.345713,0.494638,-1.45388 +3431.67,0.910924,0.0912059,4,1.614,1.04088,-0.774377,0.131853,0.479697,-0.152585,0.268382,0.340237,0.338037,0.305293,-0.731438,-0.133085,-0.0394209,0.0493814,-0.194771,0.588035,-0.10294,-0.0847183,-0.477723,-0.118224,-0.611501,-0.767961,-1.16151,0.166055,-0.509993,0.0446831,-0.322263,0.251443,-0.189288,-0.0867584,0.81602,-0.0161115,-0.0191556,-0.27007,-0.0663271,0.359268,-0.244876,0.572129,1.00639,-0.484394,0.844238,0.583985,-0.0718228,-0.800172,-0.310778,0.24877,-0.336569,-0.317835,0.123191,0.228866,0.0151949,0.34684,0.278502,-0.552203,0.534892,-0.129205,-0.0731427,-0.801575,0.509266,-0.378966,0.0274616,0.957519,-0.479359,-1.0011,-0.0021461,0.0439967,0.0064336,-0.349548,0.0199354,-0.277197,-0.505937,0.488392,0.55062,-0.517419,0.543702,0.273129,0.0290025,0.47563,-0.675626,-0.0226262,0.0621719,-0.0939888,-0.098611,0.385425,0.268011,0.158376,0.412556,-0.345317,0.112138,-0.423347,0.523743,-0.17151,0.205316,0.0683627,0.0895724,-0.228822,-0.508609,-0.348907,0.363563,0.724574,-0.039573,0.119442,-0.0948416,-0.0815778,-0.26239,-0.29452,0.32797,-0.0857419,0.547346,0.467234,0.047757,0.039882,0.113269,0.523101,0.558931,0.0991296,0.049196,-0.00443891,-0.270012,0.285927,-0.0432374,-0.661938,-0.200413,0.161215,0.335375,-0.312656,0.0964503,0.390555,0.342223,-0.227583,0.4528,-0.162847,-0.316523,0.432465,-0.162231,-0.00562556,-0.459444,-0.0802797,0.199474,-0.595259,-0.135056,-0.314482,-0.332826,-0.460763,-0.425781,-0.309152,-0.260358,0.332417,-0.197709,-0.269665,0.378529,0.235261,-0.19911,-0.14246,0.2865,0.534021,-0.27907,0.12865,0.3402,0.0511445,0.522384,-0.0949574,0.670017,0.0840653,0.458416,-0.314781,0.0354705,0.100033,-0.0608532,-0.555798,-0.047446,-0.00926794,0.136809,-0.237265,-0.0078275,0.514922,-0.076326,0.0574703,0.573267,0.78904,-0.0754974,-0.300031,0.187472,-0.0907864,0.095239,-0.236884,-0.349803,0.0135901,0.0875021,0.0852263,-0.0138554,0.339779,-0.130769,-0.24542,0.318082,0.308359,-0.167649,-0.271283,-0.45441,0.00581351,-0.446832,0.182102,0.314785,0.433959,-0.188265,-0.0629503,-0.0150272,0.659249,-0.0718417,0.0243287,-0.0493563,0.0934281,0.285023,-0.118631,-0.213059,0.0628109,-0.32495,0.266295,0.425404,0.226758,0.482947,-0.390795,-0.284566,0.237006,0.0966612,0.556713,-1.04683,-0.18025,-0.649262,0.573413,0.180865,0.0434195,-0.220692,0.375857,-0.533094,0.525131,-0.307063,-0.111033,0.0237638,-0.155228,0.533737,0.614877,-0.594449,-0.167015,0.374274,-0.0464165,0.831587,-0.0979121,-0.269129,-0.0647494,0.032127,-1.02226,0.567238,-0.144723,-0.550463,0.255275,-0.519499,-0.0711219,0.0559147,-0.462339,0.29238,0.209488,0.0301865,-0.0894202,0.0963952,-0.389957,-0.078872,-0.547288,0.565206,-0.133018,-0.00613444,-0.367322,0.216559,0.408185,-0.188767,0.409421,-0.0995799,-0.159647,0.631527,-0.0351569,0.0844172,-0.358982,-0.209684,0.348289,5.27497e-05,0.121747,-0.283786,0.240299,0.60666,0.207247,0.223451,0.115049,0.234058,0.291412,0.0125586,-0.388168,-0.335806,0.481412,0.0253461,-0.487608,-0.0436815,0.110194,0.299571,0.331955,0.54733,-1.49874 +3406.42,0.977086,0.0912059,4,1.60476,1.07839,-0.511287,0.0542076,0.345376,0.0231204,0.0849378,0.204164,0.492396,0.0201187,0.0759625,-0.17988,-0.516964,0.230712,-0.560067,1.08921,-0.0720396,-0.452719,-0.264155,0.00397382,-0.393687,-1.17025,-0.517646,0.215529,-0.028596,-0.176795,-0.275771,0.11456,-0.251616,0.0622534,0.784384,-0.479979,0.163187,0.144036,-0.368674,-0.0737489,-0.777557,0.500898,0.537129,-0.421196,1.18837,0.30945,0.243592,-0.0403948,0.0143443,0.109578,-0.113559,0.758318,0.676021,-0.0468592,-0.0151823,0.575078,-0.213901,-0.508973,0.792129,-0.174892,-0.554991,-0.66908,0.453033,0.181339,0.137213,1.24827,-0.519567,-0.605635,0.226334,0.206292,-0.420089,0.054606,0.230396,-0.349641,-0.247258,0.388737,0.586838,0.904125,0.752208,0.725934,0.275741,-0.57732,-0.380704,-0.377396,0.632582,-0.843162,-0.342936,-0.342484,-0.374339,-0.217966,0.10913,-0.0198499,-0.143107,-0.496662,-0.45571,-0.0777853,0.107348,0.236759,-0.13699,-0.142612,0.506501,-0.95084,0.126008,-0.283396,-0.179626,0.244344,-0.43883,-0.168694,-0.114851,-1.07501,0.0762132,-0.382199,-0.326869,0.595012,-0.47493,0.0605817,0.849966,0.486445,-0.194701,0.0485718,0.0222034,0.211916,0.0958364,-0.289458,-0.961597,-0.510415,-0.240423,-0.0571162,-0.550012,0.273902,0.110403,-0.0328061,-0.0286284,-1.14415,0.14183,0.0932987,-0.0066304,0.42811,0.00959056,0.136842,0.753556,-0.362485,0.0693251,-0.0931369,0.389362,-0.397069,0.290604,-0.594728,0.164519,0.961958,-0.717481,0.0408129,-0.492782,-0.557806,-0.64821,-0.0155102,0.506197,-0.249267,0.295627,0.282902,0.190136,-0.103225,-0.0995614,0.0471953,-0.0442863,-0.0176488,0.846295,-0.484723,-0.729078,0.0525493,-0.0992926,-0.0453621,-0.141449,0.205056,0.0773937,-0.113729,0.0217944,-0.454799,0.284747,-0.166923,-0.022934,-0.44967,0.295551,0.387479,0.28373,-0.496637,0.549698,-0.0720248,-0.223737,-0.651191,0.223656,-0.372922,0.150341,-0.530021,0.00576451,-0.246709,-0.0328644,-0.971995,0.294117,0.945789,-0.169542,-0.316281,-0.386239,0.0841879,-0.328862,-0.395167,0.133355,0.38965,0.612517,0.111195,-0.841326,0.901393,0.030756,0.388836,0.183614,-0.46692,-0.484777,0.0977308,-0.168893,0.0351428,-0.121256,0.0415277,0.550186,-0.43932,-0.233519,-0.00221736,0.43687,-0.406097,-0.447459,0.20755,0.257316,-0.465014,-0.0436944,-0.177087,-0.394121,0.0447411,0.102523,0.0325705,-0.317134,0.56315,0.0158902,0.191591,0.495948,-0.408004,-0.45167,-0.858555,0.412219,-0.131886,0.757741,-0.31736,-0.199459,0.341287,-0.912375,-0.506511,-0.0260043,-0.87187,0.033808,-0.143962,0.434976,-0.266931,-0.301631,0.0379937,0.602674,-0.414289,-0.0188494,-0.169736,0.31553,-0.0335706,0.282483,0.50235,-0.204981,-0.138564,-0.127602,-0.0619556,-0.0753325,-0.626531,-0.707835,-0.636182,-0.26492,0.311145,0.209992,0.0541158,0.400577,-0.332855,-0.131172,-0.0317239,-0.47523,-0.427802,0.0614461,0.024521,0.124909,0.357365,-0.159577,-0.296251,-0.0652387,0.245823,0.42186,0.279074,0.0378811,-0.40632,0.319095,-0.789968,0.243387,0.163156,-0.299641,0.177467,0.189918,0.421269,0.435796,-1.23691 +3442.73,0.432946,0.0912059,4,1.60893,1.11184,-0.693555,0.0927327,0.253898,0.00142842,0.252362,0.416823,0.483297,0.407419,-0.0967609,-0.104907,0.063213,0.0860362,-0.0142986,0.410559,-0.119063,-0.150943,-0.546332,0.0825282,-0.7569,-1.04278,-1.25324,0.0439194,-0.089116,-0.0933002,0.0720884,0.349945,-0.145055,0.0211797,0.466896,-0.0988061,-0.176578,-0.10014,-0.118874,0.29232,-0.26915,0.153975,0.688351,-0.106754,0.994695,0.210715,0.334127,-0.706045,0.0531536,0.265791,-0.534969,-0.124334,0.379751,-0.00177278,0.32776,0.652692,0.190599,-0.486893,0.590606,0.189513,-0.211124,-0.591175,0.171012,-0.656212,0.412518,0.898097,-0.35479,-0.389807,0.190137,0.177175,0.0432419,0.0938886,-0.471536,-0.578028,-0.112735,0.425304,0.672736,-0.0333982,0.377084,0.231253,0.378534,0.368231,-0.360979,0.199076,0.31164,-0.631892,0.0941335,0.540285,0.0644074,0.192118,0.317989,0.0365109,-0.301277,0.0285001,0.311277,-0.151971,-0.188406,0.0118998,0.368754,-0.258977,0.0606773,0.0166143,0.245105,0.563571,0.381873,0.269845,-0.589413,-0.24455,0.0313621,-0.595907,-0.0938539,-0.229657,0.287273,0.736851,-0.0958638,0.0351142,-0.0258875,0.434973,-0.0974124,0.495105,0.013466,0.281444,0.326765,-0.0703012,-0.67822,0.231995,-0.462334,0.240156,-0.24926,0.238995,-0.0667001,0.534805,0.0892603,-0.312432,-0.423531,0.158326,-0.206877,0.775765,-0.158191,0.0727879,0.181885,-0.30931,0.764833,-0.298045,0.0480037,-0.125324,-0.180133,-0.15845,0.662188,-0.0204679,-0.488377,0.167927,0.112495,0.395767,-0.240289,0.280935,-0.0763817,0.0463633,0.735026,0.710041,0.16884,0.279807,0.166836,-0.218089,0.477143,0.0743334,0.290469,-0.166717,0.154088,-0.139775,-0.129809,-0.158806,-0.134314,-0.0271043,0.450669,0.285904,0.0123789,-0.33916,-0.042825,0.270565,-0.0401494,0.275992,-0.366503,0.583595,-0.0756526,-0.185879,0.140433,-0.582099,0.0981122,-0.163582,0.197383,-0.330969,-0.411388,-0.994554,-0.241901,0.389187,-0.0508353,-0.388574,0.142737,0.124684,-0.194072,0.0367036,-0.297746,0.451539,-0.349342,-0.921902,0.162804,0.302977,-0.336082,-0.386953,-0.552389,0.825667,0.339035,0.466617,-0.131538,-0.181917,0.136011,0.459294,0.101242,0.156106,-0.0596439,-0.0659519,0.389424,-0.269501,0.0140493,-0.755797,-0.0224143,-0.234105,-0.642144,0.233817,-0.504539,-0.258223,0.261869,0.550732,-0.10316,0.220593,-0.95217,-0.119887,0.0622357,0.625474,0.255423,0.0853794,0.387752,-0.497653,-0.188633,-0.346219,-0.394988,-0.553851,-0.175936,0.223396,-0.0336792,-0.341494,-0.26206,-0.451034,0.15892,-0.462021,0.432988,-0.0327385,-0.674544,0.105714,-0.415619,-0.365349,-0.134732,-0.603961,0.14362,0.630911,0.0391888,0.289681,-0.00298733,0.0760733,-0.108392,0.3011,-0.0340849,0.0938102,-0.399036,-0.695307,-0.0324231,0.0534108,-0.335286,0.285593,-0.168932,0.455479,0.331821,-0.281807,-0.162855,-0.17376,-0.494962,0.172382,-0.046511,0.32057,-0.516394,-0.273566,0.327049,-0.36416,-0.0192953,0.338102,0.420874,0.105234,0.0024316,-1.19223,-0.172689,0.243348,-0.1625,0.110328,-0.0789974,0.116928,0.219816,0.341948,0.468845,-0.923537 +3420.35,0.622391,0.0912059,4,1.60087,1.17038,-0.60263,0.0787004,0.375705,0.0410478,0.111017,0.273035,0.781377,0.142987,-0.0784551,-0.0394105,0.574452,0.188998,-0.120751,0.830837,-0.107362,-0.495372,-0.187232,-0.318771,-0.834508,-0.792373,-0.67821,-0.0323425,-0.212378,-0.0907323,-0.00288963,-0.00386336,-0.41519,-0.0300451,0.314651,0.00120986,0.126076,-0.101198,-0.483609,-0.0998538,-0.286255,0.546375,0.0976566,-0.0663101,1.01,0.258336,0.0984875,-0.36479,0.383227,0.310598,-0.512554,-0.176376,0.648726,-0.0886014,-0.0733123,-0.124189,-0.231868,-0.164075,0.427465,-0.148861,-0.227607,-0.147292,0.0861002,-0.0819254,0.336337,0.96129,-0.590414,-0.345247,0.368546,0.0489811,0.108733,-0.239589,-0.476766,-0.179972,0.136164,-0.0561479,0.533208,0.0548257,0.694525,0.282405,0.127658,0.536183,-0.659211,0.523636,0.104519,-0.210016,-0.256652,0.121436,0.155084,0.512119,-0.358022,0.387747,0.0472402,-0.154155,0.14373,-0.118441,-0.151079,0.177537,-0.00136308,0.558616,0.501526,0.011205,0.293114,0.199821,0.369991,-0.240917,-0.452512,-0.209438,-0.136837,-0.295579,-0.146714,-0.0533629,0.436346,0.571085,0.255942,-0.0957332,-0.0140594,0.538653,-0.0519118,0.515719,-0.375096,0.518436,0.191436,0.28859,-0.535749,0.46329,-0.131399,0.365079,-0.103516,0.0563386,-0.0559377,0.236886,0.0234326,0.0473602,-0.193688,-0.189346,-0.275618,0.690976,-0.088299,0.169115,0.0561015,-0.411388,0.572387,0.120661,-0.580435,-0.0494396,-0.202688,-0.0658825,0.0597462,0.67592,-0.131343,0.296741,-0.00579178,0.200746,-0.101455,0.0908382,0.00670461,-0.118239,0.506523,0.557076,0.598538,0.407547,0.150213,-0.746432,0.464346,0.202676,0.20108,0.090576,0.149621,0.0347107,-0.48183,-0.24352,0.172476,-0.0806743,0.508604,0.0583317,-0.0596981,-0.439663,0.133684,-0.0801346,0.029024,0.0132671,-0.237096,0.73855,-0.314958,-0.0994884,-0.329781,0.0231041,0.033631,-0.507263,0.29843,-0.593977,-0.32651,-0.623956,-0.18758,0.592547,-0.304839,-0.424553,0.2497,0.191432,-0.330674,-0.10036,-0.688265,-0.00893155,-0.572077,-0.499618,0.237106,0.0861399,-0.0388815,-0.436425,-0.00690676,0.972542,-0.00565248,0.517286,0.235862,-0.234837,0.233211,-0.0242052,0.119605,-0.0990341,-0.507126,0.012649,0.293846,-0.724964,0.0636693,-0.987308,-0.298757,-0.0276838,0.358731,0.381045,-0.324232,-0.513788,0.351653,0.520687,0.0853028,0.388145,-0.66528,-0.0902423,0.19237,0.601494,-0.131854,-0.686036,0.63091,-0.279296,-0.62581,-0.19506,-0.213123,0.128418,-0.347233,-0.0193503,-0.0686633,-0.512504,-0.17136,-0.376182,0.356564,0.0639037,0.199646,-0.131766,-0.344966,0.476942,-0.318547,0.0991996,0.174492,-0.460841,0.396512,-0.0338546,0.282585,0.0244467,-0.409852,0.290894,-0.0364865,-0.29801,-0.251333,0.199215,-0.480564,-0.887232,0.162621,0.354289,-0.651702,-0.0329195,-0.172833,0.801204,0.426089,-0.046082,-0.262237,-0.077197,-0.419875,-0.040535,-0.0690792,0.365051,-0.601004,-0.116684,0.154878,0.228105,0.183192,-0.182864,0.350682,-0.284588,0.0789233,-1.0485,0.246567,-0.0436686,-0.501177,0.0753867,0.26566,0.124191,0.135528,0.352407,0.368142,-1.48383 +3436.2,0.903739,0.0912059,4,1.62961,1.02088,-1.15581,0.401815,0.730343,-0.0107939,0.650225,-0.315081,0.359647,-0.426733,-0.0572732,0.107327,0.0847779,0.276147,-0.685622,0.766918,-0.0785642,-0.404887,0.0778525,0.262126,-0.507882,-1.07499,-1.18101,-0.0866702,-0.00371626,0.0299425,0.223962,0.36308,-0.233991,-0.24823,0.333826,0.10037,0.153561,0.0363667,-0.333319,0.0559982,-0.361305,0.0870021,0.541251,-0.430064,0.767997,0.872086,0.742253,-0.947491,-0.269623,-0.447136,-0.440454,0.182834,0.191138,0.104107,0.027056,0.396277,-0.062505,-0.0842221,0.172509,-0.300345,-0.152606,-1.36562,0.0526515,-0.299167,0.560108,0.811623,-0.348657,-1.10806,-0.066605,0.0183692,0.195448,0.119443,-0.538434,-0.608356,-0.310465,-0.00246374,0.481373,-0.554989,0.421978,0.30029,0.443535,-0.0542957,-0.518504,-0.0851933,0.718156,-0.058216,0.2066,0.552639,-0.53627,0.0137635,0.342586,0.0725907,0.0495477,-0.086983,-0.340073,-0.00335584,0.32308,0.134031,0.212568,0.292011,-0.328721,-0.156225,0.370708,0.23587,0.727766,0.120671,-0.724829,0.0723199,0.626464,-0.21886,0.328508,-0.467126,0.0138102,0.645688,-0.523237,0.115826,0.0465673,0.611024,-0.214465,-0.177187,-0.118655,0.338942,0.330667,-0.15294,0.0373616,-0.114143,-0.114239,-0.241104,-0.198927,0.187087,0.308755,0.0716736,-0.0527048,-0.408298,-0.128819,-0.168264,0.128613,0.494436,-0.381577,-0.0692123,-0.10813,-0.255704,0.193639,-0.613331,-0.731839,-0.140687,0.27215,-0.657086,0.103147,-0.0774342,0.234411,0.442626,0.0826679,-0.569235,0.328942,0.122562,0.393864,0.00493418,0.193986,0.0654525,0.214374,-0.506746,0.289636,-0.197283,0.0405693,-0.0231793,0.471254,0.54585,-0.0608432,-0.228731,0.259434,-0.306381,-0.0267526,-0.0711302,0.700921,0.0690038,0.318717,0.418728,0.020956,-0.08151,-0.00985118,-0.223776,-0.124518,0.698689,-0.0668351,0.0445325,0.29187,-0.43291,-0.268148,-0.249202,-0.0956821,-0.534799,-0.206282,0.150378,-0.268427,-0.403717,-0.0280811,-0.219832,0.529483,0.273009,0.00281636,0.168367,-0.588669,-0.392921,-0.493394,-0.55663,0.0131058,0.0209013,0.451981,-0.15876,-0.748003,1.1902,-0.632077,-0.0660619,0.0426147,-0.0673298,4.82028e-05,-0.235745,0.0381176,-0.0858858,-0.0658077,0.30578,-0.294351,-0.514121,-0.111712,-0.741563,0.0217192,0.26993,0.148319,0.0953673,-0.100247,0.137307,0.181244,0.450746,-0.2348,0.0233261,0.0425883,-0.184189,0.0508634,0.732876,-0.220848,-0.0691132,0.429377,0.349192,0.26326,-0.171716,-0.0188749,-0.0477918,0.0935169,-0.0118864,0.18486,0.109613,-0.292717,-0.716749,0.05181,-0.355431,0.0725665,-0.202584,-0.392631,-0.391846,-0.409837,-0.120935,0.341013,-0.226044,-0.432381,0.60866,0.153276,0.0835813,-0.235006,-0.136324,-0.0930814,-0.53803,-0.83934,-0.0724372,-0.2032,-0.513293,0.0705595,0.52763,0.423702,0.0780912,0.168661,-0.194502,0.0178027,0.110772,-0.180404,-0.451848,-0.574903,0.183174,-0.174901,-0.0380433,-0.014274,0.433199,0.255647,-0.19649,0.103979,-0.134175,-0.0629821,-0.0977283,0.0126466,-0.526552,-0.251268,0.173482,-0.480773,0.00473832,0.203566,0.105131,0.267339,0.324239,0.517049,-2.37092 +3430.86,0.967918,0.0912059,4,1.61201,1.01373,-1.04242,0.328176,0.314527,0.0558088,0.573073,-0.147507,0.307082,-0.176888,0.23569,-0.145482,0.165666,0.378936,-0.493818,0.637556,0.125858,-0.345187,-0.00233492,0.345088,-0.531065,-0.94753,-1.10664,0.147514,0.170743,0.1072,0.00457411,0.262274,0.0410376,-0.175615,0.460807,-0.0493166,-0.0151025,-0.0410968,-0.511737,-0.0332068,-0.272765,0.265721,0.791776,-0.373287,0.658275,0.795054,0.845735,-0.770773,-0.144019,-0.758781,-0.401055,0.257232,0.296981,0.047644,-0.356137,0.375017,-0.135462,-0.128762,0.219375,-0.1797,-0.0457857,-1.41429,0.230442,-0.318434,0.329009,0.903264,-0.650003,-1.22914,-0.107522,0.134913,0.159188,0.462595,-0.461556,-0.464147,-0.364407,0.241699,0.436416,-0.400306,0.613996,0.375194,0.28751,-0.125816,-0.701674,0.0120019,0.619395,0.268096,0.0921601,0.555005,-0.592859,0.034376,0.631105,-0.0906429,-0.0891202,-0.175578,-0.302086,0.186689,0.304277,0.0336676,0.235251,0.40943,-0.426287,0.0999312,0.126656,0.234438,0.591901,0.123426,-0.516574,0.115669,0.591333,-0.060665,0.464772,-0.45007,-0.282963,0.534266,-0.383461,-0.0146626,0.161321,0.561176,-0.0432403,-0.19895,-0.165671,0.282606,0.418914,-0.181074,-0.194366,-0.070618,0.145424,-0.208703,-0.249863,0.151984,0.425488,0.068968,-0.157345,-0.379994,0.021072,-0.11083,-0.028718,0.339221,-0.267164,-0.0463875,-0.0930971,-0.294303,0.253088,-0.743492,-0.818367,-0.132222,-0.0200409,-0.468221,0.162619,-0.170072,0.25416,0.35933,-0.0166537,-0.64613,0.184399,0.40242,0.649405,-0.161889,0.0897345,0.0685117,0.348152,-0.539533,0.296682,-0.376156,0.429558,0.00985303,0.53107,0.47438,0.0207748,-0.0535147,0.224292,-0.373211,-0.205616,-0.0826673,0.492025,-0.0257098,0.304905,0.0574167,0.354962,0.13194,-0.133478,0.0594829,-0.0436594,0.632107,0.0630638,-0.146045,0.669195,-0.543411,-0.404859,-0.266901,-0.410201,-0.551271,0.0262513,0.0294509,-0.301596,-0.281684,0.0893291,-0.509016,0.488648,0.192649,-0.0245264,0.15348,-0.861483,-0.494605,-0.311613,-0.424234,0.266931,-0.138157,0.454191,-0.368594,-0.802997,1.07524,-0.684508,-0.104456,0.285204,-0.0596207,-0.120483,0.0648017,-0.115208,0.0754172,0.0752784,0.351109,-0.23619,-0.305426,-0.0640517,-0.590888,0.105931,0.230714,0.220717,0.322971,-0.29909,0.0783878,-0.148087,0.235912,-0.073597,-0.010929,0.148808,-0.0611599,0.141766,0.712218,0.06939,-0.154848,0.509249,0.461732,0.312087,0.00737381,0.0446766,-0.119975,-0.088156,-0.0274647,0.227451,0.107811,-0.0891457,-0.853055,-0.0272809,-0.493381,0.20935,-0.113713,-0.247363,-0.344857,-0.448592,-0.133532,0.244183,-0.305312,-0.0302877,0.433718,0.429625,-0.125612,-0.398552,0.149292,-0.0415031,-0.309318,-1.01151,-0.0914751,0.0411465,-0.566559,-0.123321,0.611873,0.185017,0.279389,0.0820641,-0.206426,-0.188142,0.112818,0.026764,-0.312816,-0.447369,-0.00906017,-0.0751118,0.117393,-0.0604306,0.117556,0.339224,-0.232767,0.0321637,-0.0223395,0.0858471,0.00193535,0.0310492,-0.775836,-0.470534,0.232552,-0.611385,-0.306524,0.475945,0.100549,0.260034,0.317095,0.509935,-1.00186 +3405.58,0.957614,0.0912059,4,1.67879,0.938316,-0.599756,0.251084,0.746084,-0.038749,-0.210873,0.235214,0.192941,0.603889,-0.435709,-0.490392,-0.492315,0.437655,0.156348,0.986354,-0.26515,0.307609,-0.493532,-0.241071,-0.290816,-0.884617,-0.369354,0.39957,-0.511994,0.176031,0.485277,0.0267404,-0.341072,0.309825,0.622907,-0.445618,0.770055,0.134845,-0.418036,-0.721826,-0.485211,0.395325,0.339364,-0.357231,1.0063,-0.0672457,-0.455186,-0.417129,-0.0774485,0.318766,-1.1889,-0.178821,0.358286,0.0285366,-0.214473,0.309287,-0.191055,-0.602568,0.510356,-0.648915,-0.347289,-0.409679,0.783899,-0.692857,0.263103,0.932785,-0.953926,-0.544769,-0.0966552,-0.0862705,0.158648,-0.319406,0.0950135,0.155685,0.436742,0.48345,0.339285,0.221179,0.191087,0.410868,0.242676,0.516872,-0.208205,0.0231181,0.69093,-0.213357,-0.209728,-0.708079,0.431089,-0.336663,-0.172381,-0.177248,0.283439,-0.229445,0.288826,-0.27498,-0.0293482,-0.0208713,0.0697886,-0.400424,0.304528,-0.386021,0.133993,0.211732,-0.221918,0.178402,0.156134,-0.44115,-0.0978488,-0.0720326,0.118605,0.0165817,0.226548,0.6484,0.245755,0.14486,0.477156,0.411947,0.316093,-0.323752,-0.476794,-0.18734,0.0513645,-0.0735514,-0.723897,0.120984,-0.0891183,0.439476,-0.313275,-0.0650184,0.00787111,-0.459595,0.770526,-0.24476,-0.0234915,-0.254573,-0.237661,0.404389,-0.0484547,-0.032606,0.448399,-0.254045,0.708863,-0.46156,0.322303,-0.321954,0.0399715,-0.334988,-0.0970299,-0.0523539,-0.38871,0.235438,-0.045121,0.263564,-0.703295,0.147808,-0.106369,0.304277,0.640394,0.641476,-0.239972,0.238229,-0.349089,0.319498,-0.260975,-0.166617,0.635971,-0.613555,-0.118192,-0.0929665,-0.256303,0.38793,0.200254,-0.0502769,0.173174,0.0543132,-0.154251,0.601389,-0.588726,-0.039497,-0.351131,0.0800878,-0.0859339,0.403089,-0.0727579,-0.0548698,-0.356597,-0.0277508,0.321989,0.0588241,0.119065,0.0189418,0.158501,-0.408551,-0.105033,-0.293683,0.14307,-0.685479,-0.691917,0.623767,-0.133284,-0.337956,-0.0714059,0.479793,-0.323229,-0.20001,-0.422858,-0.485134,-0.170342,0.123723,-0.277291,0.885153,0.420216,-0.12468,0.045882,0.291527,0.783986,0.374217,0.113512,0.0890206,-0.75812,-0.129854,0.787185,0.577678,-0.385187,0.119994,0.154755,0.482866,-1.0697,0.248163,-0.00457333,-0.42711,0.460001,-0.00604694,-0.214104,0.183688,-0.135388,-0.259566,0.130157,0.0445957,0.122166,0.112605,0.342982,-0.0931596,-0.236435,-0.254267,-0.0357393,-0.420971,0.936063,0.163341,0.495146,0.427555,-0.807736,-0.540908,-0.0990308,-0.331439,0.421134,-0.671285,-0.0459281,0.0470016,-0.235548,-0.173148,-0.117662,-0.27746,-0.339957,-0.633857,-1.11966,0.600049,-0.5904,-0.190017,-0.0408255,-0.209322,-0.340307,0.45733,-0.0922435,0.152911,-0.525835,-0.115026,-0.666285,-0.0588769,-0.293914,0.00864483,0.133432,-0.489886,-0.262795,0.015595,0.399398,0.289786,0.182963,-0.0411787,-0.0682789,-0.122504,0.221026,-0.121397,0.0157355,0.322822,0.229118,0.361636,-0.414455,-0.360575,-0.0179281,-0.392731,0.636773,0.352614,-0.209542,0.143928,0.252066,0.379378,0.502061,-2.37026 +3400.57,0.953653,0.0912059,5,1.66165,0.966629,-0.548062,0.202666,0.702722,-0.0408856,-0.232392,0.0727996,0.0327828,0.263866,-0.551877,-0.463958,-0.12038,0.568834,0.178158,0.955548,-0.210525,0.259231,-0.448799,0.0100841,-0.352931,-0.873175,-0.673432,0.213442,-0.615648,0.0893854,0.522494,-0.228578,-0.477076,0.184644,0.679632,-0.6716,0.701755,0.306122,-0.308462,-0.782647,-0.601647,0.330505,0.444042,-0.624488,0.953536,0.120858,-0.594134,-0.532504,-0.174544,0.169621,-0.988949,-0.326344,0.243225,-0.0949459,-0.284893,0.336934,-0.15226,-0.861236,0.582682,-0.414344,-0.284983,-0.559644,0.674229,-0.869738,0.0159153,1.28203,-0.838556,-0.413768,-0.0345513,-0.187549,0.424795,-0.15403,0.335932,0.0039065,0.278981,0.705059,0.254982,0.323599,0.33964,0.73042,0.101841,0.482805,-0.224574,0.171844,0.729237,-0.197023,-0.12912,-0.407742,0.601308,-0.377685,0.00395934,-0.326821,0.263611,-0.3244,0.0279096,-0.235748,0.136111,0.0140837,0.0602382,-0.64803,0.405653,-0.409028,0.26767,0.18781,-0.0696547,-0.10079,0.0699109,-0.255055,-0.147143,0.0311631,0.108749,0.160044,0.00774889,0.577939,0.192504,0.183662,0.479579,0.319316,0.211851,-0.358947,-0.406049,-0.270655,0.235037,-0.000507624,-0.974289,0.0871827,-0.271535,0.424313,-0.215788,0.139016,0.205426,-0.408727,0.659995,0.0385805,0.213254,-0.155233,-0.188602,0.530781,-0.0763318,-0.130275,0.426272,-0.395113,0.613591,-0.706002,0.372897,-0.347736,0.0558421,-0.354116,-0.128088,0.222127,-0.31176,0.296768,-0.000288137,0.369995,-0.45974,0.199805,-0.0685181,0.450679,0.602567,0.667554,-0.0369002,0.454358,-0.447726,0.224947,-0.0251627,-0.0614437,0.55225,-0.468068,-0.178707,-0.102998,-0.273323,0.349418,0.144874,0.160739,-0.047867,-0.0708482,0.0516038,0.640872,-0.621821,-0.0165944,-0.367234,-0.379535,0.0309047,0.604202,0.0228815,-0.251727,-0.245164,0.00348991,0.209274,0.047786,0.145088,0.170431,0.228016,-0.407991,0.0252875,0.118788,0.122548,-0.55467,-0.600495,0.635522,-0.330522,-0.292897,-0.375566,0.456175,-0.284086,0.0379845,-0.34888,-0.512468,0.204936,0.269158,-0.384588,0.966679,0.366095,-0.0914087,-0.0694796,0.0768954,0.842503,0.290257,-0.0761197,0.123364,-0.521123,-0.0408567,0.691253,0.521905,-0.593586,0.0372985,0.508415,0.206952,-1.15145,0.158369,0.0434257,-0.463458,0.659265,-0.0198709,-0.252675,-0.0546366,-0.188348,-0.211106,0.112033,0.0851325,0.0665633,-0.00201058,0.204205,-0.0250483,-0.356027,-0.24262,-0.034669,-0.410944,0.941354,0.100032,0.516651,0.309017,-0.774296,-0.3005,-0.112835,-0.740937,0.457926,-0.580444,0.0460226,-0.0269332,-0.285282,-0.213382,-0.207856,-0.3176,-0.378955,-0.296181,-1.19974,0.38663,-0.595505,-0.201058,0.0150783,-0.376257,-0.358971,0.509163,-0.395842,-0.110119,-0.400812,0.0407436,-0.652524,-0.0637076,-0.242037,0.164054,0.0295036,-0.48067,-0.23273,0.17584,0.574015,0.464108,-0.134413,0.0843062,0.117408,-0.28767,0.287289,-0.119368,0.219355,0.305546,0.139869,0.322651,-0.548452,-0.407592,-0.0104103,-0.399164,0.795058,0.255171,-0.15673,0.137757,0.205881,0.371157,0.453742,-2.27421 +3416.09,0.955912,0.0912059,4,1.62556,0.851721,-0.788952,0.358329,0.336742,0.0364316,-0.163003,0.186173,0.575544,0.526576,-0.231912,-0.27914,0.21725,0.389121,-0.556694,0.678806,0.394848,-0.177666,0.0441878,0.0334675,-0.245329,-0.900244,-0.878658,0.192461,0.0214894,0.233873,0.0350067,0.56023,0.0564244,0.242074,0.9125,-0.329109,-0.0352661,0.171483,-0.328452,-0.159025,-0.359949,0.286933,0.216918,-0.787176,0.965093,0.558451,0.340688,-0.818721,-0.318927,0.267709,-0.511843,-0.0382181,0.181497,-0.033956,-0.0650171,0.102648,0.0078364,-0.138271,0.584033,-0.357215,0.0636143,-1.13064,0.541964,-0.419737,0.438967,0.536397,-0.867026,-1.37746,-0.0646832,0.644346,-0.304581,0.396467,-0.308322,-0.105385,0.011034,-0.223427,0.864626,-0.0609767,0.561771,0.00781841,0.224707,-0.29095,-0.351638,-0.0489276,0.327522,-0.547039,0.139584,0.51869,-0.803671,-0.128213,-0.249626,-0.193839,-0.270542,-0.341245,0.372042,0.159822,-0.122364,-0.0950392,0.245776,0.143321,-0.230525,-0.0823021,0.494077,-0.1333,0.182066,0.361391,-0.545387,-0.077262,-0.215914,-0.374288,0.330633,-0.211544,-0.212912,-0.137823,0.180484,-0.328197,-0.498455,0.341034,-0.216963,0.252364,-0.26067,-0.0289554,0.579477,-0.44148,-0.0569011,-0.0975044,0.233446,-0.343685,-0.371982,0.37223,0.339597,0.360039,0.311299,-0.177382,-0.00705202,0.0939809,0.247962,0.555756,-0.182155,0.245411,-0.156999,0.344563,0.0191103,-0.100853,-0.251398,-0.00769671,-0.161708,-0.203399,0.144702,0.376309,-0.0362853,0.0469351,-0.155625,-0.175041,-0.127919,0.120376,0.173278,-0.0720524,0.221231,-0.228709,0.482119,-0.151552,0.30022,-0.133383,0.219951,0.0109594,0.542617,0.10467,0.291916,0.646958,-0.0400066,-0.237173,-0.614209,0.0361672,0.352887,0.500966,-0.0992548,-0.224417,-0.0146843,-0.238648,-0.611174,-0.0329903,-0.0348155,0.324111,-0.41035,-0.118381,0.676001,0.0123977,-0.267505,-0.279295,-0.548003,0.214577,0.395063,-0.0598117,0.188882,-0.209148,-0.0475663,-0.426641,0.349045,0.23508,0.295119,0.0572769,-0.282534,-0.127579,-0.223221,-0.278836,0.253453,0.384628,0.0344019,-0.147212,-0.401623,0.884119,-0.150534,0.176688,0.00859867,-0.640555,-0.408834,-0.174587,0.170017,0.0298528,-0.153431,-0.104183,-0.00619613,-0.305111,0.356386,-0.833406,-0.341552,0.460373,0.348303,0.671122,-0.954461,-0.148694,-0.725603,-0.0455615,0.190282,0.176297,-0.0266314,-0.439909,-0.669766,0.0556174,0.183128,0.100176,0.669127,0.0223809,-0.22683,0.0618415,0.505237,0.0198106,-0.653703,-0.573675,0.570339,0.130719,0.140905,-0.290252,0.131175,0.0756407,-0.0499689,0.201681,-0.300711,0.318966,-0.180916,-0.207428,0.581517,-0.130546,0.500034,0.00178137,0.844137,0.389442,0.741211,0.140815,-0.152822,0.440172,-0.102691,-0.764361,-0.494258,-0.0763719,-0.0280559,0.0902286,0.441665,-0.0444834,0.0592642,-0.17831,0.544983,0.458156,0.235812,-0.573069,-0.76317,0.110646,0.222779,0.148415,-0.692648,0.513572,-0.096627,-0.514517,-0.238587,-0.212324,-0.363298,0.219011,-0.262521,-0.179201,-0.275153,-0.0727346,-0.402281,-0.678732,-0.124724,0.114269,0.3131,0.338038,0.559553,-0.932557 +3419.28,0.958796,0.0912059,5,1.60219,0.952051,-0.881864,0.356348,0.256182,0.0118981,0.00743678,0.0527553,0.820397,0.307482,-0.257385,-0.38558,0.157106,0.108443,-0.400333,0.681743,0.338399,-0.147283,0.17899,0.200891,-0.297729,-1.00273,-1.2721,0.242411,0.210047,0.173862,-0.138958,0.363204,-0.280545,0.227868,0.776143,-0.425881,-0.123316,0.0453657,-0.522735,-0.103466,-0.414168,0.223527,0.279798,-0.629837,1.05297,0.448404,0.0381176,-1.21341,-0.428558,0.553369,-0.753299,-0.368044,0.209378,-0.000386546,0.122539,-0.0199956,0.0606593,-0.283456,0.333472,-0.225705,-0.0109531,-0.99403,0.464868,-0.26205,0.621991,0.673041,-0.932305,-1.30649,0.0962482,0.386314,-0.115681,0.381409,-0.372578,-0.278058,0.0661573,-0.0660402,0.787249,-0.118758,0.445335,0.165207,0.325183,-0.101973,-0.227793,0.0944847,0.359704,-0.716528,0.145413,0.478745,-0.92227,-0.166363,-0.318089,-0.501356,-0.239928,-0.474646,0.38954,0.0973324,-0.234557,0.145252,0.196007,0.261207,-0.361021,-0.169655,0.234934,-0.115848,0.00466689,0.0605068,-0.349941,-0.238284,-0.0581029,-0.106017,0.46156,-0.143152,-0.00998912,-0.262197,0.254836,-0.201422,-0.361691,0.196886,-0.545467,0.055402,-0.0298986,-0.0698644,0.488961,-0.329894,-0.32639,-0.32645,-0.0067534,-0.383284,-0.0597728,0.351849,0.137289,0.519418,0.47604,-0.21469,-0.325672,-0.0581844,0.299302,0.635232,-0.0443475,0.12371,-0.364092,0.283743,0.077894,-0.223668,-0.064239,-0.00989489,-0.208362,-0.472141,0.114561,0.363489,-0.202131,0.175234,-0.199876,-0.0531142,0.122005,0.0833155,0.295137,0.0470606,0.328701,-0.356644,0.747847,0.000897818,0.272771,-0.0370635,0.367671,-0.0548723,0.703896,0.00403688,0.240263,0.482838,-0.0407975,-0.238469,-0.697809,0.20015,0.390085,0.256269,-0.00689472,-0.0223621,0.0127892,0.113274,-0.574436,-0.103951,0.0495524,0.198088,-0.400851,0.0172753,0.70793,0.217778,-0.182643,-0.345425,-0.340114,0.191278,0.208469,-0.188343,0.244361,-0.0910438,0.052003,-0.485297,0.188358,0.336113,0.160886,0.113835,-0.292849,0.128254,-0.174577,-0.0626283,0.11212,0.0785473,-0.296611,-0.217183,-0.264879,0.784655,-0.0341125,0.688776,0.029533,-0.723046,-0.580328,-0.0387343,0.330516,-0.082367,-0.321197,-0.040463,-0.105302,-0.238145,0.306956,-0.804601,-0.187173,0.272868,0.369427,0.712962,-1.20285,-0.217595,-0.430018,-0.139497,0.291882,0.29141,0.00751888,-0.474681,-0.607386,0.177659,0.337794,0.0366605,0.78586,-0.324555,-0.146135,-0.103941,-0.0810306,0.198691,-0.400161,-0.653917,0.637131,0.0156027,-0.253725,-0.287972,0.251853,-0.0407638,-0.0972716,0.0734639,-0.508673,-0.0388975,0.00973804,-0.23986,0.431339,-0.254301,0.411922,-0.10276,0.736003,0.340168,0.488727,0.202324,-0.025381,0.540043,-0.162224,-0.641903,-0.433591,0.0171866,-0.15011,-0.0858861,-0.0055883,-0.00661479,-0.122509,-0.00689611,0.520655,0.422003,0.307092,-0.514479,-0.461126,-0.0542098,0.211978,0.31979,-0.725345,0.542958,0.0567928,-0.231646,-0.238621,-0.115601,-0.250055,0.474614,-0.370643,-0.0361799,-0.188657,0.116045,-0.569363,-0.574494,-0.0472847,0.110303,0.218194,0.332119,0.467113,-0.809033 +3433.19,0.997458,0.0912059,4,1.6747,1.03307,-0.698753,0.193356,0.435223,-0.010258,0.212063,0.298687,0.536394,0.746665,-0.47441,-0.151734,-0.160426,0.15976,-0.318291,1.06531,0.0828363,-0.100053,-0.184581,-0.41209,-0.556196,-0.77148,-0.995992,0.0148928,-0.840977,-0.101907,-0.0659972,0.351608,-0.500186,-0.141078,1.01171,-0.00334817,-0.281495,0.489678,-0.247133,-0.0244037,-0.0318744,0.882394,0.308012,-0.0663851,0.782046,0.646244,-0.221317,-0.809514,-0.173904,0.173172,-0.233349,-0.338705,-0.154317,0.106764,0.564926,0.319996,-0.170771,0.0365303,0.51558,-0.347333,-0.127675,-1.28308,0.256412,-0.445832,0.133819,0.853356,-0.307075,-0.532045,0.336241,0.565788,-0.409259,0.424958,-0.0971787,-0.596016,0.0727492,0.765604,0.86624,0.0515767,0.46228,0.187076,0.260211,-0.265427,-0.642495,0.0498852,0.502841,-0.615436,-0.048887,0.195239,-0.469443,0.187979,-0.599585,-0.40757,0.232413,-0.616895,0.0531173,0.0261208,-0.130742,-0.284932,0.0415326,-0.414025,-0.406433,-0.235938,0.279486,0.548005,-0.0378541,-0.499171,0.344105,0.128199,-0.312483,-0.055679,0.21595,0.27102,0.00131593,0.291813,-0.574321,-0.388631,1.0212,0.643372,0.278495,-0.149661,-0.0452662,0.0613853,0.275485,-0.0989322,-0.540361,-0.286142,0.0770104,-0.132654,0.25426,-0.0795677,-0.0477464,-0.0783411,0.271593,-0.334978,-0.296575,-0.0426836,-0.208764,0.337688,0.0155246,-0.229174,-0.612574,-0.374505,0.21673,-0.880653,-0.533864,-0.054476,0.0539305,-0.428154,-0.00823189,-0.106532,-0.243475,0.32062,-0.569406,-0.143083,-0.164636,-0.253445,-0.0610961,-0.0174422,0.106147,0.344469,0.208137,-0.0859,-0.127273,-0.176503,0.380955,0.114016,0.429014,-0.337952,-0.162123,0.0155611,0.118265,-0.0776566,-0.452712,-0.215479,0.815208,-0.16269,0.0473142,0.274042,-0.137547,0.496343,-0.45533,-0.0302892,0.214894,1.02678,0.294708,0.301059,-0.144165,-0.48746,-0.181653,-0.212482,-0.105147,-0.0989118,0.136104,-0.507616,0.122676,0.188496,0.0960327,-0.534116,0.138963,0.0654006,0.537497,-0.0630215,-0.512162,0.167641,-0.165593,0.299877,0.160337,0.0680354,0.112311,0.391131,-0.480507,0.447979,-0.0246961,0.182241,0.0678831,0.0273101,0.0985599,0.108089,-0.42008,-0.0164793,0.150148,0.0260712,0.263246,-0.495689,0.0270604,-0.423116,-0.0418478,-0.129804,-0.000459449,0.651188,-0.449103,-0.389442,0.0991009,-0.407072,-0.0193504,-0.226024,-0.0792978,-0.595271,-0.614659,0.453817,-0.0271845,-0.0492772,0.463636,-0.143001,0.108436,-0.598221,-0.254626,0.156047,-0.281125,-0.505827,0.442174,0.577345,-0.327663,-0.133215,0.266502,-0.402698,0.12479,-0.0591197,-0.398692,0.00155841,-0.244147,-0.401156,0.266365,-0.166931,-0.123975,0.452569,-0.0398861,-0.12828,0.201147,0.122948,-0.160571,-0.062869,0.368526,-0.266436,-0.383258,-0.326474,-1.06847,-0.0957256,0.121605,-0.0820987,0.044328,-0.335218,0.304658,0.0738715,-0.541369,-0.517812,0.314463,0.231968,0.359492,0.0918973,-0.608175,-0.22398,0.0345642,-0.406569,0.0975421,-0.00706937,-0.757114,0.226854,-0.413457,-0.197416,-0.101894,0.173698,0.0501767,-0.123063,-0.181567,0.125064,0.293116,0.353644,0.541402,-1.41024 +3442.03,0.995202,0.0912059,4,1.51806,0.918785,-0.757104,0.185842,-0.0287933,-0.102274,-0.00370785,0.0519565,0.0936625,0.0255843,-0.1187,-0.632601,0.120936,0.571847,-0.323499,0.852588,-0.0288049,-0.0186242,0.0666349,0.32773,-0.387496,-1.00577,-0.4363,-0.0501794,0.0484203,-0.390375,-0.0154587,0.530097,0.0456474,-0.29254,1.00298,-0.287674,0.103157,0.171908,-0.444341,-0.234093,-0.487094,0.00491306,0.689794,-0.306545,1.06807,0.519636,0.397035,-0.505129,0.288559,0.400504,-0.537736,0.392796,0.469222,-0.0896172,0.197677,0.637832,0.435152,-0.624827,0.787383,-0.461656,0.166808,-0.32313,0.298629,-0.050833,0.716235,1.07182,-1.2808,-1.18112,0.325502,-0.396043,0.295435,-0.25948,-0.0380641,-0.0109707,0.121817,-0.282776,0.197448,0.191185,0.0906726,0.782685,-0.138376,0.487431,0.0498218,0.192329,0.39208,-0.0581326,0.516036,0.151782,0.311356,-0.081666,0.544274,0.0711769,0.327517,-0.491075,-0.0316919,0.130538,0.0414466,0.36079,0.113185,-0.229918,0.410686,-0.00360305,-0.110413,0.0534879,0.24691,0.231676,-0.654355,-0.461602,0.0830564,-0.441722,0.534488,-0.274943,0.246125,0.298367,0.204873,-0.119275,-0.75829,0.250514,0.23574,0.149726,0.151076,0.278968,-0.105697,-0.100085,-0.360242,-0.322572,-0.153034,-0.382617,-0.162851,0.274281,0.576977,0.0394633,0.113503,-0.375306,0.381258,0.0256627,0.192111,0.252143,-0.0391038,-0.207866,0.0870727,0.0352855,0.598675,-0.159234,0.120705,0.105643,0.342314,-0.376925,0.17586,-0.0373814,-0.202548,0.607929,-0.211408,-0.150265,-0.426627,0.10181,0.429021,0.304507,0.401383,0.414305,-0.0301023,-0.158122,0.442855,0.30852,0.22085,-0.264982,0.596886,0.0835295,-0.451704,0.0138474,0.242071,0.0172598,-0.334876,-0.132772,-0.516081,-0.016496,-0.185462,0.361188,-0.117666,-0.211306,0.239815,-0.406228,-0.132498,0.276235,0.156854,-0.38446,0.427677,0.297218,-0.247863,0.239895,-0.430899,-0.350784,0.596126,-0.318517,-0.00215512,0.289784,-0.259074,-0.318039,-0.279387,0.183765,-0.233965,-0.260561,-0.695532,-0.192883,0.224858,-0.190891,0.109408,-0.122269,-0.133049,-0.488429,-0.0294188,0.736962,-0.437531,0.37615,-0.186109,0.0370896,0.16721,0.00989007,0.191746,0.241165,-0.494651,0.4959,0.247749,0.261532,0.489772,-0.5357,-0.495039,0.0911908,-0.505783,0.588949,-0.109145,-0.176309,0.171737,0.316051,-0.145461,0.327034,0.506185,-0.215348,-0.0364488,0.492387,0.290719,-0.150656,0.485779,-0.656588,-0.221201,0.161876,0.24035,-0.222155,0.393227,0.62921,0.364333,-0.173085,0.135456,-0.356803,-0.118233,-1.16127,0.646202,-0.417605,-0.18756,0.164282,0.0694601,0.446929,0.148481,0.218035,0.264806,0.230504,0.41065,0.0372755,0.122863,0.629447,-0.604463,-0.266496,-0.806447,0.168029,0.464282,-0.0465038,0.416697,0.177916,-0.455576,0.1104,0.31299,0.0490643,-0.255916,0.163716,-0.0561326,0.0936414,-0.208017,0.145183,0.21188,0.365264,0.170486,0.74139,-0.20218,-0.200742,0.024195,0.141321,0.24717,0.319705,0.288315,0.00485009,-0.284695,-0.154965,0.493144,-0.0461202,-0.131508,0.115643,0.249259,0.340064,0.499259,0.236397 +3418.55,0.726785,0.0912059,4,1.45998,1.0487,-1.1213,0.374651,0.182961,-0.133988,0.406931,0.0684394,-0.0127412,0.459277,-0.156878,-0.167451,0.187554,0.413519,-0.355807,1.24963,-0.174904,0.259488,-0.325826,-0.0672844,-0.215561,-0.605634,-1.18847,-0.118948,0.16428,-0.282185,0.329456,0.467194,-0.156056,-0.194861,0.891567,-0.0647603,-0.172695,0.265778,-0.454828,0.0337485,0.11674,0.748603,0.107258,-0.298081,1.03282,0.905047,0.628472,-1.11597,-0.123617,-0.224444,-0.223991,0.33881,0.272215,-0.14754,0.412931,0.628194,0.235449,-0.73642,0.267516,-0.43601,-0.238976,-1.09818,0.139609,-0.134104,0.18222,0.934336,-0.986247,-0.268141,0.200889,0.234409,-0.0228643,-1.13253,0.124827,-0.225546,-0.0168437,0.351265,0.746861,-0.00224951,0.557374,0.538978,0.0704998,0.0825209,-0.458722,0.24656,0.274594,-0.584587,0.168428,-0.784215,0.153228,-0.687213,-0.0772456,-0.245197,-0.0560444,-0.649407,-0.194967,0.385375,0.00888906,-0.120696,0.291967,-0.000576209,0.373042,-0.656158,0.125118,0.529801,0.0258695,0.476962,0.519933,-0.509589,0.596629,0.132888,-0.0710229,0.01549,0.354096,0.496748,-0.351681,-0.343471,-0.149019,0.463045,0.220337,0.141561,-0.0433712,0.327791,0.657886,-0.117325,-0.0164085,0.337999,0.353441,-0.139283,0.0142401,0.112691,-0.0546186,-0.194141,0.176385,0.106968,0.234918,-0.565999,0.00431401,0.59978,0.0346557,-0.443743,-0.00306972,-0.332046,0.0621957,-0.639475,-0.106925,0.176968,-0.293024,-0.1623,-0.00981975,-0.423561,-0.2309,0.680041,-0.464111,-0.124182,-0.164454,-0.347967,0.165603,0.194237,-0.148509,0.501126,0.255291,0.258095,-0.0479712,-0.140453,-0.0750075,0.348138,0.497344,0.449165,-0.246883,-0.224206,0.16655,-0.127071,-0.496185,0.203518,-0.0125972,0.415088,0.0857247,0.38525,-0.11112,-0.558441,-0.0335533,0.175898,0.328997,0.820864,0.577996,-0.486276,0.0572859,0.200845,-0.331923,0.250443,0.0561486,-0.0839542,0.51899,-0.45055,-0.120855,-0.0301891,0.0235864,-0.0576477,0.319429,0.448747,-0.0954676,-0.307465,-0.383235,0.608604,0.198748,-0.0811168,0.223775,-0.107931,0.471886,-0.397161,-0.0470436,0.635195,-0.141262,-0.00664015,0.0281342,0.231132,0.125926,0.593782,-0.31211,0.572409,0.107151,-0.0943286,0.12073,-0.595373,0.195324,-0.0485397,-0.0936557,0.18346,0.667354,0.432008,-0.135641,0.140383,0.262265,-0.177593,0.67845,-0.279423,-0.179745,-0.0715172,-0.323355,0.863123,-0.323518,0.515156,0.558229,-0.234045,-0.582843,0.4967,-0.682128,0.0695428,0.713337,0.025177,0.453688,0.423145,-0.655443,-0.51319,0.045714,-0.725614,0.505667,-0.0125312,0.1441,-0.141107,-0.422202,0.0558218,0.0293898,0.319733,-0.752137,0.354021,0.363463,-0.346807,0.147551,-0.165407,0.352179,-0.145647,-0.0932321,0.130761,-0.148269,-0.138616,-0.293653,-0.0111568,-0.0624183,0.494443,-0.247519,0.137176,-0.350854,0.0942024,-0.0662604,0.242466,0.0108769,0.458101,0.164153,0.27509,-0.310864,-0.0843838,0.16974,0.519068,0.0612742,0.370045,-0.0224967,0.847052,0.12701,-0.139035,0.0011989,0.198195,-0.00472211,-0.148434,0.0266205,0.120119,0.305634,0.346582,0.552842,-0.73413 +3407.47,0.884907,0.0912059,4,1.54918,0.933735,-1.44459,0.497167,0.571717,-0.155581,0.29528,0.146843,0.355359,0.215657,-0.201216,-0.529935,0.135945,0.105666,-0.0526999,0.618634,-0.19557,-0.0991604,-0.41992,0.231214,-0.444824,-0.82858,-0.855795,0.0774429,-0.0387925,-0.0515316,0.00772104,0.253887,-0.00458744,0.0608319,0.490896,-0.442169,0.0760279,0.118117,-0.512355,-0.0978469,-0.401024,1.11426,0.516928,-0.647455,1.01253,0.700638,0.0990886,-0.754205,0.104048,0.269008,-0.112491,-0.0704948,0.209779,0.15831,0.0768997,0.932505,0.322195,-0.728011,0.371907,-0.394475,0.162152,-0.845779,0.0890724,-0.473328,-0.160811,1.39289,-0.696928,0.0840051,0.715341,-0.178755,-0.0702361,-0.616185,-0.613608,-0.745408,0.152369,-0.17406,0.494232,-0.179523,0.451604,0.507343,-0.173303,-0.400141,-0.0570925,0.130425,0.20967,-0.392526,0.387652,-0.672006,-0.447975,0.0785438,0.454328,0.084584,0.00710055,-0.144527,0.385895,0.243021,0.0359558,0.464404,-0.270669,-0.482,-0.540832,-0.135997,0.472147,0.581237,0.409172,0.838664,-0.00434063,-0.877866,0.426642,-0.591981,0.397709,-0.162505,0.262935,0.404579,-0.462745,-0.267694,0.816762,0.24972,-0.198849,0.00219458,-0.522542,0.253885,0.0866259,-0.204431,-1.18231,0.541646,-0.280323,0.589917,-0.252741,0.389879,0.0535207,0.481441,0.380245,-0.0222641,0.368063,0.0185584,0.0564424,0.373212,0.219696,-0.236423,0.174338,-0.213144,0.498067,-1.28465,0.0283485,-0.364198,-0.042176,-0.275675,0.311022,0.531229,-0.125116,0.308023,-0.293307,0.176147,0.352121,0.574796,0.0186439,0.00102717,0.322286,-0.0939031,0.496771,0.457394,-0.140665,-0.316376,0.297093,0.100244,0.739707,0.0740861,-0.21097,0.423901,0.0198833,0.152435,-0.216989,-0.257333,-0.0936953,0.227041,-0.235377,-0.0992299,-0.376072,-0.0899092,0.138891,-0.190662,0.268551,0.456937,0.818059,-0.408526,-0.391177,0.00666065,-0.27223,0.0429645,-0.168159,-0.150218,-0.0447437,-0.915079,0.0732387,0.0523689,-0.179515,-0.431537,-0.550538,0.198158,0.210814,-0.250914,-0.567268,-0.370168,0.0748981,-0.355434,-0.0524472,0.158659,-0.783872,-0.074025,0.0844839,0.995136,-0.643704,-0.344206,-0.0949243,0.0367855,-0.227916,0.102996,-0.344452,0.401949,-0.285345,0.160695,-0.00799912,-0.0218183,-0.229659,-0.387079,-0.100269,-0.249028,-0.716577,0.517441,-0.331525,-0.900657,-0.146566,-0.0264331,0.425321,0.26677,-0.304215,-0.624781,0.00653582,0.462621,-0.349625,0.707081,0.209459,-0.367367,-0.342599,0.347125,-0.530838,0.517069,0.177804,-0.133352,0.738242,0.477943,-0.212326,-0.224356,-0.193263,-0.352468,0.885274,-0.204111,-0.191321,-0.341455,-0.114438,-0.0488939,0.0274862,0.209311,0.542354,0.587345,-0.0356279,0.166116,0.0998608,-0.229533,-0.240884,-0.477162,0.218846,-0.0664758,0.127962,0.0140119,-0.385387,0.154669,0.557284,0.690016,-0.13567,-0.558668,0.231692,0.202863,-0.0890997,0.113568,-0.257127,-0.208204,0.483623,0.708509,-0.194926,0.638884,-0.0752389,0.225027,0.0401277,0.00516769,0.0651079,0.212552,0.227324,-0.0731001,0.80367,-0.310755,-0.224887,0.0165554,0.612337,0.158169,0.253843,0.397705,0.503828,-1.67318 +3377.05,0.998957,0.0912059,4,1.53526,0.906146,-1.29877,0.541375,0.75069,-0.249778,0.0523295,-0.0889916,0.0495315,0.121004,-0.358398,-0.35966,0.0052018,0.268982,-0.0894222,0.947615,-0.17692,0.419648,0.279393,-0.419987,-0.395481,-0.488893,-0.554144,0.146796,-0.173188,-0.0301647,-0.088233,0.0645949,-0.407228,-0.0508354,0.775309,-0.488366,0.0571242,0.0759033,-0.256095,-0.211843,-0.134767,0.905877,0.608059,-0.716674,0.930747,0.647875,0.111138,-0.887106,-0.370188,0.208816,-0.531722,0.327946,-0.0207496,-0.18475,0.461229,0.30074,0.103799,-0.742592,0.514533,-0.167337,0.176113,-0.771055,0.225075,-0.469118,0.116579,1.54921,-1.0708,-0.6589,-0.663527,-0.179657,-0.27954,0.0516545,-0.506966,-0.752215,0.641479,0.000317661,0.516266,0.305582,0.236934,0.584671,0.304775,-0.270114,-0.767524,0.23718,0.532254,-0.255302,-0.109141,-0.0469659,-0.637444,0.546232,-0.100437,-0.135884,0.266773,-0.134874,0.218521,0.0690784,0.157631,-0.0481327,-0.504171,0.348737,0.169198,0.00442775,0.644407,0.274287,0.165783,0.308974,0.25251,-0.548493,-0.310082,-0.583932,0.557026,0.501188,0.288791,-0.0364358,-0.284138,-0.216352,1.16582,0.339847,0.132573,-0.20399,-0.674776,0.36222,0.438003,0.162273,-0.991901,0.993452,-0.301208,0.0954293,-0.272353,0.671945,0.575782,0.0519316,0.622121,-0.417787,0.238163,-0.31214,-0.270296,0.663134,-0.0713782,-0.156693,0.383042,-0.254034,0.482571,-1.02731,0.115083,-0.394304,0.192727,-1.11895,-0.0500315,0.335361,0.261771,0.105201,-0.0303516,-0.281732,-0.589186,0.330323,-0.217984,0.138481,0.372184,0.094543,0.17355,-0.111744,0.111563,-0.574548,0.923232,0.0294349,0.707171,0.637595,0.208078,0.081335,-0.213503,-0.335969,-0.295766,0.165616,-0.170302,0.693615,-0.264949,-0.500961,-0.0405387,-0.114031,-0.23568,-0.352146,-0.0436617,0.0315173,0.0651537,-0.885843,0.229355,-0.324516,-0.47783,-0.0843611,-0.240304,-0.280878,0.631958,-0.532554,-0.252008,-0.304086,0.52218,-0.472675,-0.197379,-0.0344001,0.337955,-0.398461,-0.350207,-0.0372267,0.126244,-0.263583,0.102225,0.563192,-0.579467,-0.160464,-0.0450677,0.89519,-0.506376,-0.199138,0.0644482,-0.709794,0.415246,0.25853,-0.379939,0.858389,-0.597524,0.110787,-0.0534992,-0.139576,0.0742252,0.0688699,0.438833,-0.812419,-0.939899,0.515636,-0.596346,-0.00189452,-0.5435,-0.318254,0.268809,-0.359547,0.0326831,-0.439367,0.0273175,0.440505,0.329898,0.535355,-0.0796842,0.120278,-0.593673,-0.102212,-0.344528,0.578542,0.728394,-0.00236699,1.07172,0.285998,-0.259161,0.380143,-0.43557,-0.321798,0.413313,-0.602344,-0.271624,-0.232298,0.28084,0.0161538,0.025962,0.194085,0.156648,0.646267,-0.00434072,0.0231148,0.262786,0.182142,0.0788372,0.451727,0.288107,0.16062,0.000967872,-0.0156499,0.0172017,-0.434251,0.0523638,0.53793,-0.314553,-0.148771,0.551779,-0.0350971,-0.231547,-0.534518,-0.323197,-0.394364,0.199541,0.181247,0.174579,0.36965,0.203337,0.150321,-0.0646204,0.583406,-0.560411,0.753165,0.296586,0.190742,0.627629,-0.261037,-0.154117,0.280055,-0.0849995,0.164863,0.211857,0.406034,0.460279,-2.32748 +3418.74,0.763871,0.0912059,4,1.59324,0.898605,-0.911547,0.282455,0.318603,-0.0145267,0.214572,0.0939906,-0.0707416,0.16706,-0.23209,-0.598305,-0.377229,0.571265,0.129819,0.691581,0.0169287,-0.412902,-0.397035,0.516047,-0.210975,-1.6071,-0.93772,-0.00171573,-0.376629,0.0620297,-0.114915,0.352711,-0.61316,0.10824,0.931229,-0.713076,0.0398023,0.204094,-0.243153,0.350686,-0.485239,0.512935,0.154132,-0.000572631,1.03101,0.696801,0.373939,-0.263754,-0.0389879,-0.12143,-0.42718,0.535312,0.408035,0.00905668,0.120186,0.295596,0.21291,-0.22608,0.669652,0.018365,0.0600083,-0.707687,0.620336,-0.623592,0.172215,0.641178,-0.410713,-0.74922,0.937786,0.167088,-0.17156,0.0151035,0.361868,0.283416,-0.50798,0.581885,0.216328,-0.519006,0.557893,0.188483,0.012721,-0.0758828,-0.153556,0.177839,0.608383,-0.38048,0.430848,-0.207844,-0.0436357,-0.194938,0.27629,0.0205438,-0.12683,-0.624076,0.205641,0.301959,0.0940467,-0.354204,-0.129593,-0.559899,-0.20783,-0.34418,0.06638,0.0534429,0.148902,-0.454105,-0.826745,0.273708,0.43174,0.157075,-0.392239,-0.840279,0.272277,0.722253,0.116959,-0.266984,-0.534662,0.416951,-0.447211,-0.141565,-0.0427349,-0.309746,0.322535,-0.351482,-0.401134,-0.439232,0.02815,-0.458517,0.0778204,-0.0749549,0.314468,-0.0178386,-0.0237845,-0.124003,0.0805958,-0.0913048,-0.290918,0.332923,-0.211679,-0.234432,-0.471429,-0.528628,0.466792,0.378794,-0.421188,0.289164,-0.131036,-0.583242,-0.0209369,0.0197703,-0.205836,0.325396,-0.310289,0.345754,0.0406866,0.0501723,-0.150011,-0.463723,0.135315,0.00813033,0.313161,0.00895087,-0.148137,-0.0676527,-0.172585,-0.536039,0.705919,-0.209391,-0.391789,-0.520481,0.25653,-0.173696,-0.505029,-0.0311139,0.1137,0.014707,-0.241781,0.118799,-0.567112,-0.337302,-0.269362,0.407718,0.182657,0.950578,-0.0263914,-0.326984,0.0180832,-0.386814,0.402778,0.370547,0.0688687,-0.0611552,0.0168685,-0.157595,-0.137744,-0.0739292,-0.614899,-0.548638,0.0495517,0.358147,-0.531032,-0.0688965,-0.308829,0.0410912,-0.277619,-0.031737,0.168773,-0.416743,0.326613,0.201827,-0.57743,0.895145,0.304078,0.336866,-0.133162,0.00681759,-0.467015,-0.15321,-0.234649,-0.0662405,0.171094,0.0280229,0.151941,-0.329045,-0.12938,-0.801537,-0.466385,1.00789,-0.380667,0.265449,-0.359379,-0.557159,0.79784,0.0754064,-0.248443,-0.0626332,-0.425445,-0.116375,-0.595193,0.355788,0.123821,-0.0799218,0.831244,-0.635824,0.283618,0.0893921,0.00975138,-0.533071,0.161273,0.112815,-0.00649351,0.560418,-0.00173458,-1.35035,-0.167228,-0.674418,0.283822,-0.104798,0.0959255,-0.0187753,-0.423324,0.452784,0.250945,-0.0645057,0.0960026,-0.10829,0.0180112,0.12553,0.469688,-0.0173301,-0.172205,-0.492056,-0.429835,0.0562466,-0.464807,-0.41576,-0.33649,0.148536,0.115705,-0.650485,0.291145,0.112411,0.0452188,0.0119277,0.0930815,0.475429,-0.185141,0.222653,0.0132104,0.496428,-0.681151,0.143906,-0.185075,-0.0311299,-0.016369,-0.345936,0.0761933,-0.0236058,-0.493543,-0.637329,-0.493396,0.0430148,-0.173377,-0.559362,0.0234225,0.105018,0.316352,0.324065,0.562452,-0.838436 +3414.23,0.995303,0.0912059,5,1.60356,0.796325,-1.21543,0.432943,0.371912,-0.023833,0.368824,0.0333021,0.411731,-0.0436,-0.0158607,-0.178877,-0.334558,0.675363,0.0709169,0.64769,0.179119,-0.453607,-0.547075,0.300027,-0.213982,-1.40437,-0.912106,0.127598,-0.53845,-0.279977,-0.0889576,0.574904,-0.745928,-0.0464759,0.753362,-0.655823,-0.032182,0.351992,-0.164319,0.47488,-0.405973,0.472147,0.0460581,-0.105226,1.3012,0.891045,0.706561,-0.323152,-0.218321,-0.146333,-0.325918,0.518,0.388387,-0.0647505,-0.0663864,0.260757,0.104754,-0.550772,0.699147,0.176901,-0.0499719,-0.900569,0.572976,-0.766993,0.196578,0.468425,-0.045927,-0.966948,0.581771,0.408885,0.257201,-0.0553927,0.360815,0.195805,-0.312032,0.763106,0.205056,-0.427591,0.6055,-0.059293,-0.0445838,-0.225316,-0.443597,0.204238,1.09813,-0.449011,0.503012,-0.165481,0.188754,0.119384,0.0632565,0.0135545,-0.31594,-0.652696,0.278078,0.0565239,-0.0551465,-0.293365,-0.205249,-0.298817,-0.0603778,-0.42908,-0.00725041,-0.0557501,-0.00550971,-0.344373,-0.90599,0.409872,0.524072,0.0489467,0.0870373,-0.678575,-0.035584,0.905451,0.362921,-0.182537,-0.380162,0.379604,-0.357148,0.0377271,0.0129002,-0.129819,0.520328,-0.169211,-0.477433,-0.351143,-0.0866437,-0.317613,-0.458548,0.0725636,0.0249072,0.232706,0.100743,-0.0774748,0.0734464,-0.233314,-0.192132,0.229346,-0.387788,-0.269154,-0.0562842,-0.280821,0.192721,0.286158,-0.385973,0.208093,-0.0943978,-0.695362,-0.218627,-0.233405,-0.26341,0.345256,-0.368107,0.105027,-0.0200942,0.299836,-0.310361,-0.497065,0.368092,0.133083,0.417218,0.285902,0.00873065,0.0149353,0.267847,-0.546041,0.910899,-0.214172,-0.49115,-0.43481,0.179047,-0.446586,-0.510785,-0.0472814,-0.168914,0.0125936,-0.161574,0.289107,-0.330998,-0.00709293,-0.339005,0.354484,0.0730588,1.07052,-0.478239,-0.436079,0.210682,-0.217639,0.299837,0.235673,-0.260514,-0.179912,-0.0958187,-0.00956118,-0.238759,-0.0246263,-0.891922,-0.512269,0.355334,0.277622,-0.477095,-0.0303601,-0.405939,0.0997252,-0.261704,-0.178384,0.243178,-0.197435,0.316564,0.214293,-0.635195,0.925366,-0.0328882,0.154081,-0.187532,0.105904,-0.512258,-0.189688,-0.59148,-0.230328,0.37629,-0.00919039,-0.123922,-0.431965,-0.112543,-0.764262,-0.409935,1.27591,-0.193509,0.326598,-0.465385,-0.465942,0.562342,-0.00692422,0.0649184,-0.0469312,-0.594022,-0.000893508,-0.805229,0.397683,-0.0612291,0.0908606,0.937024,-0.5848,0.291341,-0.0484852,-0.0253586,-0.298669,0.387285,-0.0576103,0.271139,0.70978,-0.444534,-1.15973,-0.077801,-0.416604,0.351762,-0.170697,-0.129951,-0.173405,-0.252254,0.4679,0.0180942,0.0694348,0.302798,0.31839,-0.166905,0.0462915,0.405628,-0.0857986,-0.0152913,-0.41214,-0.255886,0.164676,-0.551398,-0.259453,-0.178392,0.185575,0.0186001,-0.401259,0.242652,0.136937,-0.418392,-0.172413,-0.252686,0.518974,-0.333079,0.255194,-0.0216988,0.314769,-0.444829,0.0683436,-0.0424058,-0.210384,-0.160729,-0.278486,0.172153,-0.346189,-0.126503,-0.379504,-0.867989,0.29327,-0.285191,-0.389244,-0.0444844,0.131563,0.286275,0.362716,0.535047,-0.804993 +3411.15,0.940305,0.0912059,5,1.62632,0.680796,-1.43535,0.584648,0.743834,-0.03957,-0.120245,-0.103754,-0.15496,-0.285717,0.142739,-0.503467,-0.619549,0.361997,-0.120316,0.0950882,-0.185577,-0.279713,0.141992,-0.474804,-0.240185,-0.354857,-0.688068,0.381214,-0.408395,-0.00517591,-0.461909,-0.22997,-0.133929,-0.0800489,0.691227,-0.848118,-0.423646,0.541048,-0.342215,0.0166779,-0.114609,0.316314,0.94518,0.0547945,0.983627,0.0230341,-0.331504,-0.155755,0.119883,0.188743,-0.533276,-0.233091,0.346962,-0.162955,-0.165466,0.477445,0.00725589,-0.259638,0.741256,-0.56383,-0.467576,-1.30282,0.575278,0.0302648,-0.0587956,1.41879,-0.821581,-0.677598,-0.0433117,-0.0378649,-0.589032,0.0229344,-0.13343,-0.929061,0.514562,0.0224533,0.498818,0.161485,0.226194,0.611202,0.305413,0.457929,-0.108444,0.115675,-0.0454542,-0.204197,-0.224969,0.347539,-0.369502,-0.21335,-0.0832491,-0.361432,0.574878,-0.0837339,-0.493997,0.0724263,-0.017935,0.272155,0.097662,-0.324396,0.159141,-0.202041,-0.189074,0.56544,0.267882,0.142601,-0.34735,-0.975207,-0.404022,-0.468445,0.390117,-0.1035,0.501834,0.249058,-0.369252,-0.0799534,0.513658,0.240865,0.470457,0.0150654,-0.631004,0.161125,-0.230029,-0.0286786,-0.984396,0.119617,-0.127661,-0.38702,0.35809,0.00379624,0.35518,0.140479,0.304752,-0.50306,0.290192,-0.34989,0.318104,0.592339,0.0796222,-0.156333,0.386379,-0.00453884,0.68094,-1.09289,-0.167144,-0.13583,0.466685,-0.230661,0.32332,0.445882,0.183452,0.558225,0.065168,-0.618578,-0.114569,0.0496222,0.514762,0.146402,0.000816305,0.5398,-0.159311,-0.452194,0.0561298,0.0289017,0.0539123,-0.176616,0.414376,0.117646,0.439701,0.536928,-0.54336,0.132887,0.227592,0.0943974,0.454553,-0.153037,-0.365396,-0.359876,0.16041,-0.0476305,-0.326871,-0.593664,-0.0156037,-0.0254853,0.445548,0.344172,0.21315,0.143986,-0.587067,-0.501694,-0.290105,-0.28141,0.732458,-0.517933,-0.153434,0.0209078,0.730212,-0.514006,-0.498939,0.459286,0.585804,-0.318235,-0.56586,-0.128171,0.0388535,-0.232769,0.185491,0.101674,-0.457299,-0.347139,-0.0296764,1.10568,-0.424582,0.264386,0.127401,-0.496769,0.429354,0.064813,0.310489,0.523166,-0.869496,0.0868205,0.765859,-0.125703,-0.632884,-0.144799,0.408779,-1.03171,-0.499924,0.197459,-0.109687,0.0885108,0.0425589,0.0715026,-0.331699,-0.166492,0.127699,-0.389657,0.284916,0.397407,0.0209545,-0.142335,-0.0666489,-0.280922,-0.599292,0.186836,-0.102341,0.06356,0.370286,0.296058,0.54195,-0.327511,0.313937,-0.000584031,0.0133811,-0.770289,0.287631,-0.602808,0.0381178,0.528175,-0.119751,-0.356156,0.190569,-0.010656,0.142668,0.295374,0.25988,0.159789,-0.125425,0.43947,-0.123551,-0.150516,0.0920173,-0.289983,0.0201656,-0.608024,-0.361523,-0.1151,-0.119143,-0.0200532,-0.100344,-0.140095,0.490598,-0.609743,-0.000948104,-0.76144,-0.010309,-0.22054,-0.107768,-0.0927701,-0.0154596,0.528349,0.121791,-0.261403,-0.203824,0.403035,-0.24817,0.659642,-0.357722,-0.511409,0.5115,-0.670468,-0.1096,0.161047,-0.0469279,0.132579,0.203048,0.364114,0.450609,-1.83707 +3414.7,0.977056,0.0912059,4,1.58922,0.683272,-1.46358,0.624569,1.0426,-0.176555,-0.242676,0.0442452,0.17262,0.497425,0.0939154,-0.0603613,-0.505042,0.08375,-0.62836,0.631827,-0.0378623,0.238776,-0.566264,-0.141335,-0.0280799,-0.27131,-0.547517,0.638502,-0.424547,0.0267248,0.0616375,0.673306,-0.122117,0.236125,0.385604,-0.332577,-0.128742,0.49129,-0.315297,-0.764135,-0.117521,0.69431,0.564382,-0.380342,0.534912,0.297073,0.995269,-0.244569,0.0809239,-0.505824,-0.609583,-0.150383,0.239859,0.219289,-0.0947805,0.266611,0.0378732,-0.103501,0.568598,-0.726631,0.125926,-1.01157,0.634975,-0.656134,0.213286,1.40929,-0.419881,-0.313741,-0.010402,0.283608,-0.098917,-0.242505,-0.358593,-0.481917,0.11349,0.511888,0.570703,-0.404619,0.699292,0.520087,0.494458,-0.0320837,-0.0847324,0.321395,0.187642,-0.234468,0.160064,0.0889216,0.178105,-0.112499,-0.252083,-1.09438,-0.431573,-0.0956055,-0.365516,0.424501,-0.17477,0.0784838,0.158067,0.292118,0.567019,-0.279564,0.168187,0.289496,0.532316,-0.33144,-0.499183,-0.414596,-0.116116,-0.452437,-0.136236,-0.650128,0.0605294,0.534863,-0.503682,-0.0184044,0.345816,0.269311,0.256604,0.0856875,-0.16162,-0.494292,0.216098,0.065936,-0.428379,0.0345369,-0.141539,-0.415325,-0.0228386,-0.137011,0.387076,0.279791,0.557136,-0.485417,0.431407,-0.313711,-0.113571,0.542014,-0.161958,-0.239131,0.121022,-0.0880229,0.292351,-1.0551,-0.296346,-0.252065,-0.107545,-0.65579,0.101167,0.182394,-0.448192,-0.276099,0.497992,-0.787721,-0.063155,0.133514,0.230461,0.0363204,0.422597,-0.114733,0.192231,0.0389708,0.36986,0.447377,-0.125562,-0.601951,0.66929,0.555055,0.352682,0.211774,-0.0926462,0.293353,-0.325156,0.749517,0.411728,-0.598891,-0.0211232,1.0091,0.166946,0.665497,-0.123842,-0.0126515,0.0491334,0.321689,0.0171003,-0.252071,-0.169734,-0.236857,0.556114,0.0705422,-0.969645,0.036353,0.215887,-0.824941,0.084539,-0.505148,0.213882,-0.248129,-0.0208119,0.439908,0.29674,-0.296703,-0.174936,-0.307299,-0.498378,-0.653888,0.319146,0.730453,-0.135118,-0.510115,-0.140482,1.32887,0.10376,0.382799,-0.286575,-0.150299,0.322022,-0.237688,-0.671717,0.226049,-0.138547,0.25332,0.605523,-0.241231,-0.134572,-0.972215,0.195111,0.101609,0.226235,0.515935,-0.131469,-0.0551362,0.0946852,-0.254261,-0.679417,0.0355934,-0.0490907,-0.081046,0.188702,0.474452,0.0473435,0.011088,0.0761447,0.181971,-0.199093,0.10129,-0.0617876,-0.331003,0.11804,-0.496772,0.63753,-0.149842,-0.0126808,-0.322439,0.337733,-0.873919,0.704664,-0.0435385,-0.00330677,-0.0596295,-0.155954,-0.557178,0.555385,-0.206639,0.0715334,0.281529,-0.35026,0.550202,0.251926,-0.363604,0.269442,-0.413036,0.127449,-0.127792,0.110889,0.350718,-0.317126,0.193457,0.197646,0.0362483,0.486341,-0.214684,0.326885,-0.425329,-0.24511,-0.386421,-0.0909906,0.10888,0.256773,0.356783,0.0311412,0.440187,0.398988,-0.522784,0.0823671,0.613144,0.366646,0.311099,-0.330798,-0.663129,0.193054,-0.0790564,0.130551,-0.865462,0.00288843,0.173348,0.2383,0.416351,0.48816,-2.85916 +3371.23,0.526411,0.0912059,4,1.49801,0.757595,-1.73138,0.735404,1.32551,-0.188198,0.140988,-0.25678,0.234977,-0.0107128,-0.0987417,-0.158146,0.0250271,-0.0392255,-0.369325,0.471021,-0.143176,0.172056,-0.0100245,-0.182509,-0.153323,-1.02886,-0.924443,0.656966,-0.139891,0.13495,-0.229119,0.102204,-0.32366,0.511898,0.641472,-1.09241,-0.496031,0.652044,-0.0452994,-0.121568,-0.178667,0.937871,0.531988,-0.446861,0.895066,-0.0760507,1.06009,-0.442422,0.180289,0.0185383,-0.0940564,-0.226363,-0.0523172,-0.0166898,-0.217618,0.644296,-0.051103,-0.221723,0.656517,-0.208404,-0.268446,-1.06942,0.585758,-0.874634,0.467773,1.07707,-0.0786602,-0.676018,0.261524,-0.370109,-0.181591,-0.496709,-0.372936,-0.365128,0.00627233,0.513419,0.629493,0.168348,0.0517777,0.324983,0.348859,0.717725,-0.54023,0.0871218,0.946675,0.0964316,-0.478851,0.296805,0.227356,0.126063,0.41254,-1.16617,-0.806468,-0.296116,-0.101755,1.08975,0.268249,-0.012669,0.316628,0.559193,-0.68157,-0.14787,-0.151423,0.597424,0.129006,-0.659605,-0.422673,-0.465053,0.691253,-0.438038,-0.0398203,-0.511238,0.0315724,0.548299,0.522205,-0.0749089,0.0379779,0.312631,0.626279,-0.0877961,-0.291087,-0.206236,0.244398,0.0390561,-0.678887,-0.495635,0.106789,-1.28326,0.442497,-0.332866,-0.545201,0.119961,0.445076,-0.557595,0.0192727,0.429393,0.216917,0.656094,-0.131082,-0.291659,-0.31009,-0.0495866,0.476787,-0.92058,-0.149857,-0.248327,-0.0198709,-0.660386,-0.650995,-0.300446,-0.412911,-0.0674474,-0.194981,-0.285146,-0.354077,0.0726333,-0.308416,0.101506,0.811494,-0.263874,0.484353,0.420511,0.370906,-0.128007,-0.484168,-0.270074,0.741743,-0.103468,0.14975,0.331098,0.16917,-0.414309,-0.486682,-0.208922,0.0507254,0.267163,-0.283608,0.00659843,-0.457287,-0.0195164,-0.130447,-0.0351336,0.354964,0.677729,0.350445,-0.299634,-0.149886,-0.180438,0.121874,0.536208,-0.978663,-0.137107,0.358106,-0.830773,0.290845,-0.252953,0.437849,-0.139385,-0.256074,0.649696,-0.0262489,-0.148584,-0.630696,-0.423926,-0.262036,-0.104275,0.260845,-0.114856,-0.15056,0.119654,-0.0358891,1.25895,-0.0110694,0.524457,-0.240262,-0.248165,0.580908,0.0875715,-0.309561,0.48813,-0.336622,-0.193246,0.88363,-0.638603,-0.535047,-0.392012,0.180695,-0.00718756,-0.178502,0.569297,-0.405566,-0.0949117,0.644753,0.762484,-0.893285,-0.102521,-0.553779,-0.0777537,-0.272583,0.24393,0.424949,-0.252731,0.303741,-0.468324,-1.06687,-0.0770925,0.29208,0.512033,1.27611,-0.609279,1.23613,-0.514478,-0.49245,-0.312101,0.371533,-0.788022,0.570684,-0.312894,-0.365782,0.566561,-0.00926258,-0.0609293,0.767005,-0.245147,-0.0295775,0.654182,0.28321,0.382332,-0.547721,-0.0147111,0.237612,-0.197573,0.745567,0.25022,0.403871,-0.455348,-0.578096,0.197977,0.586218,0.662102,0.166768,0.202513,0.220831,-0.0605962,-0.417775,-0.811084,0.398801,-0.435456,0.349824,0.583015,0.134189,-0.188013,0.413743,0.072206,-0.12844,0.474001,0.140544,0.0738801,-0.167163,-0.107301,-0.42531,-0.0818568,-0.608795,-0.61325,-0.0807535,0.187879,0.256657,0.43345,0.506614,-3.98248 +3385.99,0.990816,0.0912059,5,1.57306,0.653164,-1.49631,0.604455,0.733578,-0.157719,-0.484111,-0.321872,-0.0954464,-0.00383094,0.501297,-0.171355,-0.749003,-0.184666,-0.877088,0.57963,0.164957,0.0310387,-0.219108,-0.502916,-0.149585,-0.894891,-0.839153,0.607537,-0.271143,-0.279744,0.0475071,0.0208839,0.181286,0.361932,1.08709,-0.210021,-0.122602,0.648644,-0.157647,-1.16386,-0.0770118,0.273701,0.423373,-0.314267,0.977047,0.60394,-0.17958,-0.158712,0.190612,0.301378,-0.728733,-0.0342616,0.260361,0.497902,0.347283,-0.0639915,-0.0266075,-0.17392,0.860196,-0.74747,-0.464073,-0.32333,0.280349,-0.22423,0.0743172,0.986882,-0.343217,-0.466027,0.442248,0.467188,0.0612957,0.0848031,-0.0456803,-0.194317,0.00053829,0.733663,1.31364,0.259116,0.392905,0.493704,-0.127179,-0.336795,0.286359,0.115737,0.97838,-0.516175,0.157354,-0.280245,-0.298795,0.173557,0.190772,-0.521759,0.00101993,-0.414809,-0.614637,0.125436,-0.479865,0.00228414,0.227043,-0.546891,-0.207588,-0.592102,0.460511,0.0556005,-0.00685079,0.724912,-0.833248,-0.0876444,0.340067,-0.163999,0.263292,0.000764531,0.343121,0.485991,0.45911,0.0535664,-0.136985,0.114572,-0.301697,0.759486,-0.354683,0.424109,0.194063,0.208145,-0.971067,-0.160749,-0.256375,-0.0935364,-0.171219,0.653714,0.597232,0.315537,0.0471244,-0.265544,-0.149533,0.235083,0.514285,0.583473,-0.250678,-0.121821,0.0147728,-0.029854,0.383146,-0.0488173,0.36224,-0.276793,-0.0934221,-0.477554,-0.13963,0.147471,-0.409953,-0.0111619,-0.0535161,-0.0749327,-0.325286,0.0370947,0.115815,0.796354,-0.104148,0.587112,0.399973,-0.176926,-0.141698,0.24194,0.948153,-0.0950143,0.436817,-0.175547,-0.0788508,0.348588,-0.00150803,-0.0559941,-0.0274023,0.593754,0.347767,-0.167094,-0.227422,0.67153,-0.280755,-0.228187,-0.242507,-0.0466809,-0.291291,0.4284,-0.614088,-0.717724,0.163918,-0.0933183,0.389267,-0.714279,-0.332429,-0.869665,-0.0508436,-0.385072,0.589114,0.31755,0.0738733,-0.845074,0.768768,0.0855724,0.244638,-0.232313,-0.810812,-0.335866,-0.227387,-0.884346,0.352799,-0.723275,0.79408,-0.524915,-0.822075,0.641011,-0.167573,0.480794,0.0923687,-0.220133,0.680861,0.187515,-0.514039,0.0168764,0.403468,0.385238,0.422386,-0.333859,-0.196392,-1.56654,-0.534089,0.0415879,-0.523835,0.495412,-0.621873,-0.902248,0.276129,0.00344036,-0.161846,-0.134428,0.501436,0.161775,-0.48308,0.747039,0.0225378,-0.323984,0.446136,-0.295353,-0.999691,0.0191311,-0.0741205,0.0138299,-0.41425,0.422622,-0.209403,0.282789,-0.453869,0.61703,0.37737,-0.155908,0.354182,-0.490141,-0.157396,0.458089,-0.644126,0.588073,0.336618,0.0112957,-0.396725,-0.23278,-0.243725,-0.0729285,-0.267343,-0.207782,-0.16071,0.288214,0.423611,-0.349078,-0.729052,0.428377,0.012946,0.15106,0.665031,-0.0456935,0.269414,-0.152761,0.205538,0.385296,-0.748699,0.313626,0.0984894,0.430457,0.0228123,-0.0823357,-0.238365,0.552822,-0.103541,-0.204746,-0.157756,0.720053,0.457489,0.275603,0.250217,-0.826207,0.391843,-0.574335,0.555449,-0.950327,-0.366889,0.199071,0.200575,0.446174,0.447856,-1.76465 +3373.55,0.954841,0.0912059,4,1.56025,0.652819,-1.51183,0.610711,0.791105,-0.189208,-0.567305,-0.313357,-0.0715901,-0.0771542,0.479697,-0.217984,-0.626869,-0.22779,-0.790051,0.445008,0.303769,0.0793369,-0.0707286,-0.37836,-0.153279,-0.765935,-1.00757,0.559306,-0.135866,-0.313794,0.224329,-0.0926326,0.327947,0.375125,1.08005,-0.182854,-0.0988845,0.676906,-0.127438,-1.17022,-0.282522,0.108195,0.385226,-0.391485,0.950813,0.464671,-0.115735,-0.241179,0.344376,0.155541,-0.755414,-0.0693933,0.349544,0.557595,0.245372,0.126122,-0.0543361,-0.115921,0.90154,-0.826179,-0.467654,-0.299694,0.241444,-0.157462,-0.050657,0.929606,-0.450303,-0.596299,0.457796,0.369645,0.0908281,-0.154675,-0.309104,-0.0700124,0.0969024,0.909378,1.32551,0.269583,0.333311,0.539904,-0.144952,-0.401175,0.29422,0.0110777,0.998277,-0.461886,0.183436,-0.482711,-0.252486,0.342411,0.226477,-0.51568,-0.0371741,-0.424913,-0.754919,-0.0148226,-0.357058,0.203088,0.191011,-0.676863,-0.23453,-0.702846,0.499082,-0.0379144,0.112557,0.434994,-1.04702,-0.056698,0.320758,-0.228296,0.00523466,-0.0989897,0.320428,0.47762,0.52056,0.139061,-0.124659,0.138173,-0.163598,0.830261,-0.483749,0.511304,0.102848,0.186204,-1.00538,-0.0553583,-0.460051,0.0871352,-0.246439,0.685148,0.524393,0.271695,0.016734,-0.201418,-0.246092,0.415512,0.510714,0.842469,-0.303572,-0.00687892,-0.0360504,0.110619,0.407465,-0.00551532,0.366672,-0.38528,-0.0407729,-0.502734,-0.176912,0.0118689,-0.158067,-0.0744375,-0.21796,-0.0155483,-0.394433,0.132377,0.0886695,0.725558,-0.0907798,0.639808,0.56367,-0.104438,-0.041662,0.211059,0.904184,-0.317812,0.232971,-0.190204,-0.08114,0.176681,0.00658968,-0.0185774,0.00825368,0.548464,0.383805,-0.178833,-0.189408,0.607962,-0.0439601,0.0682339,-0.368421,0.0238988,-0.102172,0.329635,-0.502438,-0.876148,0.181882,-0.163968,0.382995,-0.812663,-0.27874,-1.08181,-0.0159543,-0.175543,0.416325,0.338754,0.0513408,-0.843317,0.65669,0.170764,0.213723,-0.0642817,-0.671502,-0.424281,-0.158996,-0.855412,0.311264,-0.681756,0.769805,-0.380357,-0.870158,0.673058,-0.329255,0.538569,0.0500832,-0.155413,0.739365,0.170228,-0.348243,-0.0284329,0.524046,0.425192,0.458434,-0.183534,-0.177634,-1.51778,-0.449992,0.281883,-0.425093,0.359946,-0.597075,-1.13507,0.319159,0.0517084,-0.060258,-0.209362,0.413099,0.355517,-0.31459,0.737429,0.087565,-0.412956,0.450964,-0.292271,-0.920274,-0.0902965,0.0433749,0.100315,-0.469467,0.378642,-0.266703,0.198227,-0.521935,0.50421,0.240368,-0.177222,0.397564,-0.548512,-0.438242,0.412886,-0.562636,0.49921,0.270344,0.0349706,-0.24119,-0.100409,-0.0533647,-0.0904169,-0.28327,-0.248328,-0.178666,0.294163,0.430526,-0.214722,-0.450238,0.414665,-0.313695,0.0681436,0.769602,-0.0343457,0.184507,-0.413674,0.215492,0.480715,-0.735604,0.25373,0.175148,0.467466,-0.0216739,-0.193854,-0.11237,0.569391,-0.0445025,-0.369182,-0.106565,0.711602,0.498185,0.192945,0.193102,-0.803234,0.581429,-0.665978,0.597137,-0.810175,-0.243524,0.200964,0.206448,0.44829,0.454365,-1.95773 +3384.44,0.981309,0.0912059,4,1.60723,0.664607,-1.47968,0.633672,0.782735,-0.0961054,-0.692117,0.113421,0.00139225,-0.137813,0.60428,-0.385428,-0.683349,-0.0722838,-0.831527,0.32606,0.234549,0.1266,-0.0294742,-0.647201,0.153139,-0.70325,-0.74692,0.63247,-0.00724654,-0.399887,0.124313,0.000518585,0.323274,0.186018,1.06392,-0.12986,-0.157414,0.647649,-0.0418503,-1.12884,-0.328246,0.329378,0.471083,-0.370087,1.02815,0.561265,-0.246551,-0.397482,0.547845,0.27216,-0.596845,-0.125094,0.0843631,0.538542,0.129633,0.00524753,0.275533,-0.284797,0.817038,-0.700264,-0.551965,-0.561149,0.26267,-0.577135,-0.197707,1.20748,-0.674695,-0.971731,0.137314,0.499431,0.338199,-0.00109205,-0.257043,-0.469896,0.464599,0.88094,1.08473,0.411805,0.515839,0.48196,0.0290471,-0.386637,0.333848,0.0860206,0.903569,-0.286512,0.186211,-0.401227,-0.0693676,0.475217,0.141666,-0.653654,-0.255541,-0.419706,-0.66356,0.187634,-0.108565,-0.0773573,0.302494,-0.524841,0.0480634,-0.788185,0.651803,0.06861,-0.199889,0.218486,-1.02613,-0.250686,0.174436,-0.0793756,0.180505,-0.0644842,0.0253361,0.405295,0.972034,0.023122,0.054183,0.0769775,-0.0946755,0.507893,-0.299222,0.322311,0.332661,0.143461,-0.984176,-0.111028,-0.315067,-0.1262,-0.316973,0.60729,0.550212,0.281781,0.0217231,-0.397852,-0.20475,0.229698,0.198352,0.675141,-0.14318,-0.050354,0.166784,0.508743,0.479784,0.0366782,0.134997,-0.649051,-0.358409,-0.665228,-0.114844,0.411755,-0.131406,-0.15193,-0.466874,-0.00870642,-0.242512,0.175757,0.181087,0.71021,0.490667,0.774384,0.609146,-0.119235,0.0683549,0.323299,0.532289,-0.128429,0.283236,0.0422737,-0.115154,0.0973361,-0.0629534,-0.33851,-0.277362,0.68589,0.537803,-0.328744,-0.306062,0.531484,-9.27251e-05,-0.376474,-0.604601,-0.24756,-0.232645,0.444517,-0.177462,-0.688469,0.216732,0.15853,0.184342,-1.02648,-0.39683,-0.949635,0.195755,-0.17416,0.493145,0.295487,0.215394,-1.01509,0.366356,0.259073,0.411726,-0.367986,-0.507348,-0.522861,-0.207264,-0.706774,0.356836,-0.69422,0.764451,-0.492244,-1.04047,0.630432,-0.106808,0.190254,0.0628538,-0.195048,0.764326,-0.219268,-0.0149619,-0.44873,0.223047,0.482723,0.760281,0.185174,-0.276009,-1.17868,-0.321606,0.440225,-0.720437,0.470857,-0.853698,-0.945333,0.147057,-0.0951781,-0.367732,-0.241274,0.65255,0.221302,-0.63914,0.722121,0.303716,-0.116864,0.165693,-0.144306,-0.920411,0.132436,-0.200554,0.354928,-0.476119,0.426106,-0.0527708,0.291175,-0.139202,0.303871,-0.0884491,-0.533439,0.394602,-0.15217,-0.738728,0.493445,-0.418264,0.548716,0.0706968,-0.0298734,-0.302285,-0.0178851,-0.112043,0.133628,-0.224236,-0.0545522,-0.0812031,0.175187,0.0277292,-0.286062,-0.6336,0.538547,-0.381273,0.0223559,0.133509,0.0160778,0.158527,-0.164272,0.391392,0.327945,-0.670955,0.264299,-0.1742,0.774327,-0.117472,-0.0306313,-0.466791,0.427111,-0.0439959,-0.175631,-0.304524,0.582002,0.546024,-0.0592586,0.384641,-0.659782,0.503589,-0.733094,0.517153,-0.187073,-0.10264,0.186141,0.179343,0.43144,0.423489,-1.96575 +3381.98,0.925788,0.0912059,4,1.57436,0.709079,-1.10912,0.451165,0.644155,-0.134499,-0.689662,-0.0770659,0.097732,-0.132593,0.830882,0.0915518,-0.74392,0.0985667,-0.492336,0.392163,0.293236,0.185896,0.30636,-0.304906,-0.0543988,-0.649437,-0.773748,0.412192,0.00684643,-0.394124,-0.23945,-0.174263,0.383942,0.377653,1.06782,0.0154927,-0.238742,0.468113,-0.242712,-0.794191,-0.0679921,0.355554,0.461457,0.0861557,0.847748,0.595872,-0.254461,-0.450646,0.438258,0.11078,-0.784833,-0.445474,0.319647,0.367018,0.292435,0.0627763,0.117315,-0.176257,1.04204,-0.747894,-0.428355,-0.30568,0.299767,-0.509744,-0.0221088,1.05413,-0.892055,-0.435841,0.099162,0.719778,0.488557,0.252288,-0.249237,-0.238402,0.344416,0.739511,0.949113,0.498472,0.431994,0.497349,0.230239,-0.38853,0.293759,0.0593646,0.791111,0.00913388,0.349004,-0.412268,-0.0128599,0.248735,0.110586,-0.728046,-0.0357034,-0.443902,-0.452626,-0.0250975,-0.173654,0.0984043,0.142704,-0.340713,0.450494,-0.774549,0.610193,0.308781,-0.194605,0.36079,-0.694061,-0.285577,0.12508,-0.298458,0.112884,0.133549,-0.131218,0.152423,0.693905,-0.56735,0.320009,0.0937049,0.010155,0.384872,-0.347132,0.390289,0.88379,-0.0169536,-1.0013,-0.335347,-0.0100152,0.347157,-0.170049,0.336641,0.702749,0.501542,-0.248256,-0.550151,-0.0683899,0.101732,0.239285,0.527305,-0.211257,0.0221387,-0.0367259,0.330007,0.238645,0.481738,-0.0455877,-0.461271,-0.0855051,-0.74042,0.00847672,0.0197736,-0.0886392,-0.187105,-0.424302,-0.067001,-0.645407,0.0410906,0.137309,0.597052,0.463464,0.873735,0.34613,-0.115075,-0.0410473,0.415564,0.594069,0.224554,0.560394,0.00984421,-0.0493071,0.0916808,-0.145917,-0.43437,-0.108596,0.934983,0.386364,-0.172228,-0.369862,0.421837,0.00161077,-0.340976,-0.529176,-0.294283,-0.228799,0.572125,-0.028167,-0.818328,0.496956,0.0172969,0.00444853,-0.958426,-0.636449,-0.836132,0.097533,-0.202945,0.310968,0.432798,0.343734,-0.847608,0.0267803,0.227028,0.161273,-0.159941,-0.541694,-0.22744,0.0407183,-0.390818,0.345302,-0.368956,0.595567,-0.794825,-1.2889,0.682315,0.210612,0.00705621,0.137903,-0.260601,1.00798,0.0495407,-0.200144,-0.442663,-0.00943012,0.515886,1.04815,0.134001,-0.212797,-1.15883,0.0317538,0.34537,-0.967727,0.683221,-0.856934,-0.778525,0.36678,0.0559944,-0.655927,-0.226373,0.638737,0.173449,-0.685286,0.769249,0.263535,-0.0491312,-0.164399,-0.493964,-0.769328,0.062551,-0.397608,-0.160409,-0.0202038,0.627514,0.151977,0.203163,-0.287624,0.285988,0.302787,-0.725545,0.252936,-0.359443,-0.65264,0.574626,-0.0877959,0.567619,0.191411,0.0207809,-0.509159,0.224553,-0.0449203,0.196276,0.206438,0.135219,-0.11201,-0.0128203,-0.0729875,-0.163635,-0.699136,0.510032,0.149277,-0.145065,0.0455266,0.0926273,-0.0142125,0.0237016,0.426574,0.360272,-0.606851,0.0164869,-0.26347,0.537427,-0.0540961,0.150127,-0.20064,0.415011,0.2819,-0.351552,-0.121338,0.370914,0.440297,-0.0805445,0.0928542,-0.509967,0.323923,-0.672121,0.705237,-0.38707,-0.00217192,0.201808,0.361291,0.44923,0.601075,-1.62921 +3399.58,0.874748,0.0912059,5,1.56759,0.89604,-0.773351,0.228857,0.760415,-0.117106,0.267616,0.513402,-0.0663276,0.31165,-0.265227,-0.130386,-0.271595,0.637285,0.0253178,0.871994,-0.0537715,-0.118635,-0.169556,-0.0385525,-0.391248,-0.439803,-0.224424,0.037547,-0.508736,0.0559232,-0.0354119,0.528516,-0.684214,-0.378695,0.5273,-0.606712,-0.429773,-0.109558,-0.0198135,0.135311,-0.481753,0.704827,0.0923836,-0.608413,1.13913,0.979107,0.9626,-0.698564,-0.335079,0.0885696,-0.745799,0.0664389,0.254249,0.0227903,-0.286637,1.08066,0.263797,-0.406993,0.871921,0.415035,-0.0192207,-1.17078,0.544068,0.0993693,0.194705,0.266226,-0.439596,-1.34757,-0.0187596,-0.420919,-0.372404,-0.304563,0.245142,-0.362296,-0.505373,0.161424,0.258263,-0.441981,0.226401,0.771787,0.50869,0.516006,-0.189942,-0.374881,0.766095,-0.500643,0.358129,0.127163,0.0261119,-0.335843,-0.0787658,0.516929,0.169595,-0.29823,0.416284,-0.0838374,0.468139,-0.149956,-0.0175386,-0.0679737,-0.280551,0.278823,-0.119599,0.176993,0.419783,-0.273619,-0.187749,0.0364739,0.132172,-0.547526,0.192476,-0.63137,0.295608,0.781719,-0.645103,0.341147,-0.0251592,0.305507,0.386087,-0.0787839,-0.341823,0.00549097,-0.267479,-0.40042,-0.437445,0.361269,-0.208505,-0.594961,0.0201847,0.17409,-0.450771,-0.246248,0.31887,-0.0292558,-0.0502754,-0.196298,0.0745356,0.385602,-0.527787,0.133381,0.0229205,-0.330916,0.619424,-1.21166,-0.556044,-0.224572,0.195635,0.0365945,0.297593,-0.152339,0.00650151,0.68287,-0.210738,-0.335569,0.232019,0.45585,0.260769,-0.522376,0.0100571,-0.0882488,-0.06916,0.381457,-0.208361,-0.33259,-0.20204,-0.00990304,1.11595,0.0491256,-0.160494,0.143121,-0.129335,0.037963,-0.0267498,-0.729384,-0.0392343,0.150135,-0.0428455,-0.19475,0.0202098,0.0179816,0.022704,0.00305361,-0.223987,0.723811,0.37105,0.590351,-0.116135,-0.227242,0.17437,0.384626,0.117533,0.42787,0.212234,-0.394506,-0.423475,-0.235691,-0.639735,-0.412528,0.216915,0.138658,0.696116,-0.0833947,-0.176058,0.319875,0.0299845,-0.0952789,0.0813028,0.397661,-0.594489,0.610443,0.269121,1.06219,-0.164131,0.25836,0.400275,-0.522757,-0.0639839,0.24425,-0.217287,0.658071,-0.14934,-0.330789,-0.218608,-0.412384,0.558511,0.268995,0.0728033,-0.0713049,-0.167774,0.46171,0.0585734,0.186152,-0.0568413,0.0542447,0.37036,0.0999226,-0.605891,0.0364533,0.175024,0.309453,-0.226503,-0.308575,1.28204,0.100504,0.618279,0.16178,-0.0723939,0.252894,0.44623,-0.353001,0.48656,0.400069,0.132377,-0.554391,-0.138209,-0.322476,0.48474,0.0402728,0.549668,-0.0842343,-0.394369,-0.0407917,-0.0658786,-0.0750497,0.61965,0.621832,-0.175095,-0.0155522,0.0725305,0.182465,0.31699,-0.192562,-0.158987,0.490136,0.301542,-0.698506,-0.551446,0.215782,-0.693121,0.241184,0.133986,0.0153934,0.153647,0.0944519,0.327683,-0.209686,-0.578454,-0.162385,0.0610029,0.0837159,-0.0182707,0.254756,-0.237502,0.154965,0.102183,0.180166,-0.170583,0.384194,-0.102304,-0.279189,-0.51816,0.34209,-0.796396,0.0813363,-0.17102,0.133355,0.286541,0.365179,0.535295,-2.32241 +3401.85,0.984902,0.0912059,4,1.55723,0.88812,-0.871392,0.257409,0.412084,-0.0974141,-0.129896,0.401514,-0.346676,0.475081,-0.170033,-0.0711508,-0.33924,0.542106,0.298343,0.851047,-0.0797737,-0.210332,-0.511311,-0.0977493,-0.0998407,-0.768356,-0.335832,0.396641,-0.309268,0.226644,-0.0775512,0.500555,-0.467429,-0.432088,0.532988,-0.483236,0.00510726,-0.0514999,-0.133394,0.0704171,-0.416481,0.686128,0.0208235,-0.429914,1.37797,0.739929,0.769348,-0.732218,-0.489695,0.102252,-0.592238,-0.341971,0.485577,0.0746591,0.00321577,1.05721,0.265262,-0.627254,0.756887,0.109238,-0.218237,-1.21653,0.452899,0.149551,0.234864,0.445524,-0.545333,-1.28493,-0.223665,-0.544993,0.0430842,-0.0093009,0.0678882,-0.0480739,-0.739374,0.377822,0.265555,-0.315363,0.12703,0.775487,0.650033,0.427765,-0.170043,-0.347028,0.846114,-0.150451,0.248882,-0.146692,-0.271097,-0.0681511,0.0775994,0.325834,-0.025298,-0.496714,0.517228,-0.0337929,0.456693,0.0514703,-0.153481,-0.0443522,-0.412491,0.348225,0.136383,0.0723687,0.526439,-0.0633794,-0.083206,0.128019,0.267888,-0.621072,0.0676411,-0.451294,0.502348,0.899172,-0.744995,0.151183,-0.0152746,0.396859,0.333732,0.0208583,-0.355658,0.241558,-0.27362,-0.584589,-0.154403,0.469691,0.159863,-0.413717,0.0759948,-0.0363422,-0.218206,-0.336393,0.640615,-0.252081,-0.0717878,-0.27466,-0.407226,0.247117,-0.406999,-0.0996832,-0.206967,-0.218645,0.507397,-1.22285,-0.479212,-0.102251,-0.089091,0.0210878,0.0681836,0.176068,-0.024783,0.697369,0.0119809,-0.265294,0.0867375,0.515459,0.15979,-0.355639,0.121647,0.376907,-0.154984,0.305078,-0.226512,-0.109487,-0.22369,0.189023,0.939228,0.124606,-0.220912,0.323941,0.116475,0.159836,0.00450971,-0.591908,0.145961,0.378689,-0.0788427,-0.470676,0.222888,-0.00745899,0.0721271,-0.199361,-0.225808,0.722841,0.363926,0.438563,-0.277839,-0.325272,0.152218,0.239942,0.0755067,0.269698,0.0672432,-0.417259,-0.517701,-0.0519959,-0.673217,-0.338195,0.173012,0.259833,0.49176,-0.0366928,0.0165086,0.192777,0.100318,-0.383792,0.00535853,0.403379,-0.903157,0.388442,0.291974,0.994893,-0.0775821,0.45316,0.305907,-0.240039,0.0866566,0.283749,-0.325383,0.626444,-0.309288,-0.255962,-0.0754797,-0.852663,0.302577,0.0756053,-0.19184,-0.203397,-0.616092,0.301847,-0.0552663,0.131909,0.0836135,-0.0903943,-0.0848182,0.178974,-0.212344,0.115915,-0.238417,0.350568,-0.0865841,-0.689906,1.17051,-0.178062,0.581824,0.0777544,-0.24086,0.159973,0.463974,-0.255458,0.513319,0.214733,0.255644,-0.801797,-0.504968,-0.537047,0.228241,0.141283,0.495431,6.74209e-05,-0.38703,-0.0809541,0.163479,-0.115025,0.72114,0.767116,-0.175203,0.0336113,-0.228408,-0.0344886,0.402658,-0.308616,-0.0738123,0.403559,0.433034,-0.584819,-0.518079,0.363781,-0.258839,-0.0798735,-0.0580349,0.209892,0.102785,-0.183649,0.357144,-0.329118,-0.716861,-0.244654,0.327845,0.00865872,0.0383095,0.144859,-0.0530616,0.106613,0.105539,0.39641,-0.341608,0.509783,0.0631585,-0.00907337,-0.685559,0.436437,-0.429604,0.146694,-0.0450863,0.122033,0.285505,0.349333,0.534327,-1.14287 +3439.42,0.964298,0.0912059,4,1.66883,1.00982,-1.18056,0.427952,0.681062,-0.0583984,0.0370446,-0.114235,0.500352,0.209368,-0.462938,-0.169311,0.0575642,0.141847,0.00895836,0.806181,-0.257092,-0.210292,0.155274,-0.280819,-0.527055,-0.992218,-0.43009,-0.134435,-0.217704,-0.377611,-0.0927496,0.726165,-0.46444,-0.179124,0.507226,-0.743445,-0.208772,-0.0961223,-0.21414,0.0765227,-0.045822,0.662231,0.400217,-0.558248,0.902408,0.161367,0.474758,-1.04746,-0.448107,0.0095647,-0.28254,0.137385,0.360968,-0.0287958,-0.259013,0.24942,-0.0985463,-0.524449,0.0946689,-0.365546,-0.264938,-0.312759,0.352814,-0.85445,0.657666,0.744891,-0.629749,-1.15343,0.44989,0.330794,-0.226733,0.447792,0.0844725,-0.0500244,0.241839,0.462877,0.271637,-0.201,0.44407,0.554389,0.306861,0.0590574,-0.35171,-0.0768929,0.164076,-0.779045,0.107501,-0.116345,-0.0152767,0.0412062,0.0116353,0.0834713,0.519459,-0.298265,-0.148448,0.312977,0.300174,-0.103156,0.0920833,-0.456485,-0.0620613,-0.242963,0.699575,0.0849683,-0.046657,-0.14048,-0.0682402,-0.0978253,0.13226,0.0860839,0.574753,-0.255376,0.072601,0.248222,0.106482,-0.3354,0.0715879,0.498575,0.208413,0.184967,-0.194117,0.442936,0.498338,-0.645059,-0.369316,-0.276957,-0.0533491,-0.00683974,0.00832221,0.196017,-0.560138,-0.212853,0.51659,-0.0754268,-0.139412,0.236471,-0.328245,0.534954,-0.320107,0.348544,-0.184672,0.162184,0.44549,-0.173727,-0.366946,-0.162107,0.0228175,-0.18625,0.333165,-0.224108,-0.0256337,0.472093,0.0251372,-0.0296305,-0.218018,0.57458,0.0938744,0.0218744,0.423296,0.26144,0.260058,-0.184021,-0.168004,0.0797946,0.403837,0.572956,1.01155,0.409027,0.0479846,0.30078,-0.424957,0.30709,0.0756769,0.393346,0.0343287,0.115136,0.189681,-0.0157863,-0.489079,0.0447763,-0.645525,-0.298521,0.283802,0.96493,0.0384636,-0.315177,0.156574,-0.128562,0.19056,-0.315376,-0.678291,-0.167805,0.239543,-0.582581,0.214156,-0.334813,0.175395,0.0553106,-0.351465,0.102981,-0.178778,-0.304268,-0.576072,0.103875,-0.246066,-0.298987,0.674138,0.190298,-0.111501,-0.0500532,-0.828637,0.909317,-0.0434711,0.665152,0.169645,-0.371275,-0.458833,0.608693,-0.292398,0.200404,-0.257628,-0.0723376,0.198434,-0.0573243,0.240687,0.564821,-0.340453,0.426963,0.0426932,-0.203444,-0.698876,-0.242298,0.432018,-0.0653904,-0.155029,0.0468067,-0.50924,-0.561512,-0.960998,0.426793,0.014214,0.00112038,0.716114,0.117998,-0.0463525,0.224683,-0.213654,-0.631671,0.758028,-0.0313692,0.832759,0.0453044,0.187009,-0.288822,-0.289724,-0.00781858,0.696638,-0.108587,0.101641,0.0830989,0.317541,-0.0782969,-0.429699,0.154039,-0.322517,-0.295359,0.561092,0.297681,0.10083,0.138043,-0.0556465,0.377754,0.162133,-0.00610261,-0.317664,-0.278798,-0.608321,-0.0837751,-0.248294,0.05527,-0.0583999,-0.234725,-0.263118,0.773377,-0.0101661,-0.238347,-0.0182497,0.28056,-0.165909,0.21103,0.116105,0.45253,-0.0432132,-0.484983,-0.037618,-0.140959,0.64466,0.23427,-0.177482,-0.199812,-0.134292,0.198101,-0.0383082,-0.35397,-0.309346,0.132007,0.217429,0.363328,0.466293,-2.14843 +3431.11,0.943206,0.0912059,5,1.61699,0.805579,-0.632821,0.208904,0.776622,-0.0359074,0.213043,-0.315814,0.293663,-0.338045,0.672006,-0.431115,0.0448982,0.241662,-0.127567,0.560268,0.219487,0.105666,-0.261665,0.055399,0.0198741,-0.579311,-1.11419,0.3802,-0.599965,0.166153,-0.100242,0.234693,-0.204725,0.115138,0.705986,-0.195,-0.0173739,0.490667,-0.0239597,-0.498818,-0.386181,-0.0796993,0.381405,0.351202,0.695645,0.0749931,0.105393,0.189249,0.358956,0.414515,-0.467703,0.0504257,0.381521,0.21343,-0.0100513,0.625925,-0.0220355,-0.433421,0.454098,-0.264261,-0.26725,-0.77518,0.496502,-0.197317,-0.0352852,0.927237,-0.775155,-0.786504,-0.145911,0.0592725,0.111687,-0.542676,0.0861212,-0.606824,-0.0354472,0.00778688,0.501547,-0.498546,1.04231,0.430322,0.163504,-0.0373934,-0.416815,0.0869578,0.273266,0.0518008,0.357636,-0.00264479,-0.210111,0.0192131,0.0983075,-0.509502,-0.373871,-0.187971,-0.0400113,-0.0920818,-0.466385,-0.201367,0.0798168,-0.0165031,0.308838,-0.121762,-0.799061,0.351525,0.0882405,0.112136,-0.490925,-0.182807,0.0979757,-0.621136,0.0473958,-0.512578,0.152983,0.635217,-0.0251158,-0.010538,0.016307,0.91698,-0.382015,0.192024,-0.280284,-0.154138,-0.346453,0.530144,-0.687513,0.0617577,-0.369054,-0.403678,-0.0229359,0.132182,1.10525,0.278487,-0.0492544,-0.300398,0.261537,-0.211656,-0.327928,0.753781,-0.194757,-0.604029,0.245005,-0.5903,0.313151,-1.07985,-0.343801,-0.21546,0.202376,-0.643815,-0.19489,0.633357,-0.225448,-0.0390865,0.0615606,-0.351202,0.0194909,-0.0346813,0.17312,0.162764,0.0804101,0.600236,0.287705,-0.0534986,0.314459,-0.259048,0.00117324,-0.61983,0.38164,-0.311804,-0.0155659,0.114714,0.0431641,-0.709557,-0.51666,-0.380946,0.263546,-0.291485,0.545386,-0.344658,0.571062,-0.111593,-0.0190688,-0.0188988,0.037277,0.664397,-0.118065,-0.0897178,0.152165,0.137223,-0.231776,-0.0504166,0.101817,-0.246311,0.417182,-0.111759,-0.214645,-0.162425,0.079573,-0.959988,0.418478,0.154797,-0.0315664,-0.301647,-0.627187,-0.223736,0.0775282,-0.0551266,-0.39638,-0.11614,0.173938,-0.156191,0.0229359,1.22017,-0.12697,-0.391165,0.0333607,0.0834369,1.10439,-0.360838,0.0968849,0.288556,-0.374567,0.181053,0.293026,-0.434816,-0.499836,-1.21482,0.257716,0.056532,-0.573143,0.735327,0.00876373,-0.318192,-0.134693,0.120598,-0.297859,0.463389,-0.0223568,0.271044,0.481776,0.50066,-0.0932334,0.0554761,0.58796,-0.89252,-0.278496,-0.178426,0.263657,0.453514,0.0454286,0.116803,-0.146172,0.578351,-0.420306,-0.496456,-0.26291,-0.792783,0.420798,-0.354198,-0.406768,0.0140433,-0.914885,-0.181933,0.449496,0.144216,0.606736,0.804759,-0.398512,0.0706119,0.0648436,0.144371,-0.0343265,-0.692388,-0.103531,0.177175,0.043071,0.0757285,0.253086,0.355857,0.208004,-0.253801,0.311853,0.280243,0.654821,-0.649182,0.0523005,-0.0625178,-0.380919,-0.0400241,0.183648,0.0771181,-0.182386,0.0603599,0.233663,0.10922,0.392051,0.00942589,-0.372786,0.112999,-0.034765,-0.594324,0.0794038,-0.112029,-0.334214,0.0681848,0.246066,0.173589,0.175351,0.41664,0.41875,-2.2421 +3412.91,0.86155,0.0912059,4,1.50344,0.841498,-1.12196,0.34322,0.760541,-0.0336681,-0.00295172,-0.0959668,0.147569,-0.172527,0.0504453,-0.231695,-0.0831017,0.566587,-0.0599532,0.360074,0.264054,-0.0765997,-0.0221647,-0.0012194,0.207361,-0.610339,-0.465854,-0.0153472,-0.806878,-0.367834,0.226109,0.471689,-0.47643,-0.194331,0.490841,-0.0743372,-0.109784,0.212167,0.184236,-0.642746,-0.645089,0.357937,0.706876,0.0268277,0.852255,0.304777,0.350249,0.0956214,0.415048,0.116423,-0.289664,-0.121023,0.365009,0.137047,0.0478077,0.825169,0.264491,0.421664,0.905988,0.318624,0.00304714,-0.249872,0.708065,-0.429236,0.0292399,0.642373,-0.185055,-0.96425,-0.395717,-0.011973,-0.393408,-0.434342,0.211181,-0.362833,-0.110006,-0.129082,0.429066,-0.191754,1.05021,0.0110901,0.126263,0.0144915,-0.40433,-0.259937,0.491958,0.427221,0.387238,0.0702705,0.157021,-0.738268,0.204824,-0.348189,-0.194633,-0.0333598,0.202567,-0.0260374,0.278109,0.426768,0.828992,0.100648,0.734709,-0.240149,-0.504382,0.949216,0.142942,0.176911,-0.929225,-0.733679,-0.0792807,0.00251551,0.0260416,-0.113772,0.471227,0.978538,0.419941,-0.12326,0.703938,0.49844,-0.272191,0.256201,-0.115281,0.29399,0.47837,0.415199,-0.503935,0.263019,-0.0707364,-0.335219,-0.156156,0.594712,0.261088,0.03756,0.218551,-0.45371,0.287092,-0.21209,-0.138185,0.391548,-0.259517,-0.237796,0.023539,-0.172539,0.0632405,-0.806129,-0.0684451,0.0856747,-0.0251183,-0.262156,-0.00081289,0.0967782,0.967605,1.05388,0.0238399,-0.427793,-0.156581,0.332748,-0.0494169,-0.0571977,0.525771,0.351046,0.527905,-0.0493611,0.00778879,0.214927,0.475986,-0.619808,0.303132,0.339014,0.156081,0.0652096,-0.0408341,-0.0470348,0.195107,-0.599864,0.0542133,0.391468,-0.0967966,-0.0735052,-0.101587,-0.156203,-0.0969608,-0.171051,0.196552,1.11049,-0.090374,-0.104495,-0.065734,-0.228918,0.424102,-0.826905,0.498525,-0.325347,0.377988,-0.307871,-0.436953,-0.197087,0.300159,-0.618249,0.00376027,-0.0599209,0.470262,-0.157202,-0.135727,-0.190965,0.102467,0.17765,0.10664,-0.340574,0.0128078,0.0510613,-0.154159,1.09203,-0.0362167,0.636973,-0.00466201,-0.442563,0.462725,0.6252,-0.0357166,0.145373,-0.412054,0.186741,0.519627,-0.283062,-0.0747527,-0.488055,-0.45597,0.342154,-0.321068,0.289601,-0.438254,-0.0284035,-0.27345,0.0780229,-0.534812,0.250745,0.414292,0.134488,-0.0613698,0.0884558,-0.0561414,-0.0549903,0.751389,-0.506819,0.201769,0.529002,-0.183555,0.371938,0.266516,0.303881,-0.170597,0.108395,-0.610004,-0.461742,-0.265806,-0.694396,0.0626012,0.00131357,-1.06644,0.0757193,-1.04009,0.0416749,0.222052,0.195415,0.414893,-0.0507876,-0.352657,-0.39178,0.189186,0.0751607,0.338179,-0.212596,0.4445,0.1908,-0.218163,0.325568,-0.207291,-0.203784,0.0723959,-0.0359674,0.300843,0.207335,0.268133,-0.377088,-0.492429,-0.611848,-0.392894,-0.485183,0.266333,0.407698,-0.272113,-0.270681,-0.0547969,-0.762979,0.105762,0.506211,0.471244,-0.243777,0.221357,-0.430711,-0.322343,-0.0892849,-0.264947,0.454873,-0.179066,0.126281,0.211966,0.355361,0.460398,-2.2367 +3394.71,1,0.0912059,4,1.57762,0.752708,-1.32768,0.488782,0.456664,-0.00167892,0.213929,0.0432602,0.474472,-0.0474628,0.107185,-0.224435,-0.178312,0.504529,0.00832194,0.518845,0.238519,-0.184796,-0.0149788,-0.308152,-0.0863045,-1.14319,-0.865445,0.131966,-0.440482,-0.250691,0.313,0.442626,-0.351897,-0.148445,0.699565,-1.15255,-0.20521,0.119081,-0.132086,-0.453298,0.0550739,0.480053,0.440489,0.120207,0.446057,0.268195,0.186514,-0.529002,0.0938098,-0.464639,-0.277656,0.780078,0.372129,-0.112863,0.0754615,-0.139321,0.506328,-0.516697,0.574796,-0.207551,-0.135351,-0.438719,0.0776718,-0.337793,0.311779,0.861957,-0.752582,-0.520152,0.388647,-0.327129,0.262081,-0.225552,0.269373,-0.157104,-0.187201,0.181056,0.41711,-0.392301,0.688702,0.461917,0.785817,-0.453469,0.137974,0.00258895,0.387746,-0.676633,0.267355,0.129283,-0.0783715,-0.790702,-0.255354,-0.325141,0.256424,-0.412844,0.275924,0.320631,-0.0334163,-0.414375,0.245398,-0.678854,-0.0461927,-0.0702302,0.384767,0.608236,0.574426,0.313137,0.188859,0.0213897,0.30119,-0.588153,0.119495,-0.18485,0.48189,-0.0125654,-0.366248,0.00111253,-0.561755,0.451184,-0.420945,-0.0913804,-0.779876,0.335431,0.430392,-0.113632,-0.202567,0.0933546,0.0519275,0.151594,-0.444362,-0.247007,-0.287797,0.324065,-0.0632073,0.0425299,0.0191564,0.00500985,0.113418,0.717543,-0.273508,-0.203934,0.0522186,0.0762213,0.329337,-0.526413,-0.608712,0.198348,0.048075,0.00228733,-0.423566,-0.103506,-0.150001,0.16354,0.043054,0.397499,-0.187306,-0.206887,0.379644,1.16023,0.0353042,0.611469,-0.107631,-0.700322,0.357955,-0.349324,0.374908,0.155262,0.616848,-0.163355,-0.0166822,-0.147295,0.0141438,-0.10078,0.108145,0.719111,-0.545015,-0.455172,0.111385,-0.011143,-0.0330175,-0.38305,-0.678167,-0.200734,0.456738,0.753691,0.196311,-0.903821,-0.0906246,0.441767,-0.385021,-0.847249,-0.315208,-0.180132,0.108356,-0.0291193,0.170811,-0.183331,-0.103514,-0.699297,0.077721,0.484922,0.0528324,-0.49956,-0.0246026,-0.530045,0.189275,0.200661,0.69329,0.195004,-0.640922,-0.303907,-0.56751,1.01388,-0.1323,-0.47081,0.538625,-0.257898,0.395072,0.250779,0.553488,-0.186075,-0.687638,0.612296,0.704543,-0.238539,-0.625677,-0.892959,0.389054,-0.20351,-0.256839,0.526559,-0.115319,-0.23091,-0.72615,-0.175312,0.67103,0.0232866,-0.512027,-0.386325,-0.361066,1.21485,0.356301,-0.437161,0.637433,-0.02412,-0.575122,-0.584383,-0.180221,-0.660245,0.460019,0.26306,0.518577,0.13542,0.0906923,-0.288104,-0.0256525,-0.00288012,0.0255436,0.0344182,-0.297583,0.533548,-0.116559,0.419387,-0.00437139,-0.0553076,0.224541,0.195076,-0.00746787,-0.465943,-0.229293,0.516244,-0.221559,0.365087,-0.0599669,-0.188553,-0.960761,0.402332,0.344065,-0.00975871,-0.322935,0.0925214,0.93061,0.432454,0.3436,-0.597229,-0.120938,-0.878663,-0.0104249,-0.0174872,0.0863144,0.210053,0.368095,0.0455501,-0.349141,-0.251512,-0.0227393,-0.809714,-0.201744,0.101053,0.190958,-0.739237,0.247219,-0.0744245,0.0285544,-0.139613,-0.300307,0.191844,0.153944,0.438,0.392357,-1.03469 +3389.91,0.738372,0.0912059,4,1.57966,0.773695,-1.43062,0.520238,0.140955,-0.0294204,0.113219,0.0745143,0.275145,-0.0398247,0.091853,-0.117265,-0.143659,0.448109,-0.0543561,0.532323,-0.00140369,-0.269847,0.0423582,-0.312139,-0.0339491,-1.16198,-0.867971,0.142139,-0.42486,-0.326773,0.385789,0.525487,-0.243779,-0.0839729,0.775306,-1.19923,-0.159231,0.186902,-0.162651,-0.57924,0.0149922,0.539612,0.301931,0.197797,0.487594,0.399849,0.279023,-0.456221,-0.0111234,-0.259133,-0.29985,0.979586,0.335611,-0.06116,0.0868359,-0.0576442,0.564429,-0.668314,0.438378,-0.223867,-0.027057,-0.436601,0.0238972,-0.55747,0.392803,0.982097,-0.875648,-0.627444,0.372172,-0.208837,0.387966,-0.237095,0.394699,-0.205995,-0.227601,0.190049,0.460771,-0.341195,0.750412,0.450255,0.784236,-0.346678,0.0593286,0.071858,0.413619,-0.612657,0.262139,0.201163,-0.0720155,-0.765287,-0.165838,-0.33142,0.327329,-0.302329,0.403447,0.199661,-0.0301263,-0.417219,0.0341823,-0.686104,-0.245152,-0.366734,0.436583,0.527893,0.600573,0.0627814,0.368832,0.075028,0.318438,-0.703454,0.144043,-0.149669,0.653584,-0.0668263,-0.311786,0.074516,-0.431776,0.445553,-0.299775,-0.0416621,-0.823932,0.282961,0.510692,-0.120863,-0.201032,0.130482,0.0351226,0.0277715,-0.562867,-0.132775,-0.369959,0.272623,0.0041283,0.0343168,-0.0542858,0.168072,-0.0325385,0.825031,-0.407973,-0.176144,0.07666,0.00350785,0.286583,-0.641711,-0.476926,0.142649,0.129668,-0.0714384,-0.324339,-0.0610789,-0.0370556,0.227676,0.0696678,0.255008,-0.0573308,-0.168413,0.422725,0.892966,0.00164727,0.484535,0.0818977,-0.746644,0.479436,-0.227834,0.399458,0.234874,0.552053,-0.114791,0.0534165,-0.18467,0.018664,-0.134065,0.107551,0.336106,-0.461995,-0.510021,0.161425,-0.104177,0.19483,-0.261538,-0.780648,-0.115986,0.378608,0.544574,0.240812,-0.9255,-0.0201009,0.490601,-0.243858,-0.858295,-0.301697,-0.19857,-0.0270606,0.11009,0.272701,-0.197317,-0.198623,-0.740853,-0.0347636,0.395101,0.0033833,-0.42121,-0.205401,-0.433473,0.135969,0.345415,0.658338,0.104198,-0.55662,-0.300394,-0.613604,1.05579,-0.046081,-0.41701,0.560069,-0.246039,0.372187,0.206483,0.456154,-0.233543,-0.602611,0.685711,0.769803,-0.337475,-0.593603,-0.781497,0.379137,-0.152026,-0.245362,0.444041,-0.180655,-0.127446,-0.536423,-0.163976,0.600058,0.000775789,-0.500189,-0.313854,-0.429149,1.22996,0.266422,-0.341878,0.54606,-0.0562651,-0.593533,-0.498199,-0.252389,-0.57884,0.323999,0.386102,0.604212,0.299189,0.103882,-0.293941,-0.0549609,-0.078357,0.261502,0.132569,-0.339548,0.590753,-0.0915833,0.569269,-0.0508501,-0.0900102,0.249667,0.194412,0.120802,-0.558892,0.0157075,0.667629,-0.234963,0.243506,-0.0332275,0.0273866,-0.969987,0.515454,0.225477,-0.00621301,-0.451789,-0.0689552,0.798772,0.413033,0.168923,-0.631467,-0.119479,-0.919478,-0.0343066,-0.0777951,-0.0735711,0.265093,0.278327,0.0339694,-0.228604,-0.0157843,0.046966,-0.750049,-0.152344,0.0844262,0.173406,-0.845651,0.155292,-0.059873,0.167834,-0.0193356,-0.320223,0.19104,0.171763,0.437081,0.414443,0.00951499 +3427.64,0.503399,0.0912059,5,1.61193,0.777935,-1.19115,0.439081,0.692763,-0.0404355,0.166395,0.27168,0.128188,-0.17706,-0.181522,0.0452196,-0.248794,0.337207,-0.0262834,0.167826,-0.143552,-0.176231,-0.168855,-0.0232838,-0.055796,-0.485234,-0.367189,0.280989,-0.351318,-0.134,-0.279983,0.205087,-0.0322016,0.174893,0.564596,0.224484,0.0220871,0.272975,-0.234027,-0.207813,-0.351759,0.0668303,0.630858,-0.306329,0.765242,0.267611,0.030096,-0.650881,-0.246344,0.267054,-0.269818,-0.815724,0.440739,0.110029,0.153834,0.689586,0.100999,-0.0989061,0.867701,0.220583,-0.0770623,-0.768838,0.345758,-0.0641525,0.318892,0.749622,-0.128234,-0.597832,-0.130716,0.0777331,-0.472507,-0.0186953,0.183588,-0.279766,0.0054574,0.451514,0.787902,-0.404804,1.01434,0.255926,0.10095,-0.141132,-0.300721,0.0137399,0.719245,0.286019,0.0096101,0.028066,-0.280567,0.613689,-0.155464,-0.471577,-0.13537,-0.136124,0.0348687,0.0448536,0.131139,0.310832,0.540447,0.0634547,-0.237318,0.214989,-0.474962,0.633074,0.00545657,0.104376,-0.987522,-0.247607,-0.230089,-0.285168,0.323141,-0.376723,0.111633,0.76527,0.266695,-0.446715,-0.204682,0.197714,0.0985541,0.22322,0.0839081,0.436046,0.088945,-0.0441512,-0.960904,0.0384981,-0.367056,-0.442764,-0.217322,0.0758114,0.61874,0.478596,0.553926,-1.14929,0.185615,-0.0645104,0.117063,0.196919,0.0933491,0.460572,-0.0659164,0.301695,0.450097,-0.237087,-0.365021,-0.222753,0.100191,-0.0285611,0.0105676,-0.0160984,-0.11375,0.519015,-0.104218,-0.911225,-0.10535,0.167899,0.29229,-0.148922,0.398239,0.764876,0.440625,0.646912,0.477853,0.178012,0.132271,-0.438538,1.02265,0.235051,-0.391762,0.00965765,-0.172939,-0.0496637,-0.491293,-0.0378878,0.571617,0.14068,-0.283564,-0.0615272,-0.247244,0.191707,0.13881,-0.188514,-0.371601,0.605866,-0.141024,0.292217,0.534772,-0.618116,-0.57538,0.136205,-0.478924,0.0880472,-0.0824133,-0.59951,-0.223733,-0.221572,0.109775,-0.232819,0.273636,0.183835,0.0948302,-0.433801,-1.04596,0.161897,-0.259558,-0.189049,0.125235,-0.45694,0.0852529,-0.0533383,-0.332326,1.0249,-0.378969,0.800374,-0.101596,0.124718,0.291548,0.13748,-0.031141,0.538245,-0.0525209,0.470674,0.110241,0.543465,0.229581,-0.39257,0.244201,0.416672,-0.0899454,0.267434,0.0475449,-0.617996,0.151497,-0.124782,-0.139608,0.0683337,0.164388,-0.21189,-0.51417,0.204489,-0.445905,0.0548331,0.581629,-0.425821,0.131956,0.426299,-0.0380327,0.0560364,0.279832,-0.438477,0.277887,-0.185846,-0.350166,-0.262145,-0.31317,-0.384082,0.191416,-0.138221,-0.278746,-0.0288387,-0.213663,-0.545675,0.074528,0.0173011,-0.0315038,0.056598,-0.143919,0.362594,-0.340907,-0.565187,0.281267,-0.494008,-0.149665,0.0517506,0.403608,-0.137772,-0.662215,0.357117,0.0742935,-0.157151,0.063978,0.0661768,0.105612,0.434624,0.0269016,-0.439673,-0.217761,0.363326,-0.0615077,-0.227525,-0.728324,0.265406,-0.551887,0.199562,-0.239078,0.480705,0.01632,0.503968,0.0456606,0.0691846,-0.282184,0.214017,-0.105401,-0.511956,0.595659,0.156099,0.161751,0.395093,0.402183,-1.84369 +3430.75,0.854138,0.0912059,4,1.56593,0.869907,-1.04106,0.378045,0.828258,-0.0534783,0.143372,0.0732608,0.256475,0.00118401,-0.140759,0.121533,-0.244355,0.140941,-0.0731027,0.389786,0.0141507,-0.113209,-0.169557,-0.106433,-0.136065,-0.586674,-0.828263,0.231623,-0.509696,-0.186872,0.00993138,0.196146,-0.295632,0.0508398,0.616366,0.449189,0.188353,0.317613,-0.524315,-0.4132,-0.08518,0.164605,0.456766,-0.499911,0.640054,0.0801853,-0.0574935,-0.492463,-0.290614,0.030286,-0.780444,-0.460187,0.620914,0.0473614,0.146586,0.917997,0.167015,-0.797783,0.720893,-0.101635,-0.180159,-0.736553,0.434853,-0.0794823,0.228089,0.820721,-0.305181,-0.468549,-0.277597,0.42363,-0.374287,0.135916,0.113024,-0.143484,-0.42728,0.463633,0.554015,-0.659538,1.18767,0.513019,0.221771,-0.13133,-0.359297,-0.165068,0.431719,0.0369719,0.260119,-0.341848,-0.181904,0.460697,-0.0600042,-0.384928,0.015885,-0.409492,-0.114159,0.557341,0.0761641,0.640322,0.320951,-0.0173606,-0.222367,-0.151836,-0.162746,0.632438,0.209159,-0.0234531,-0.702667,-0.179842,-0.365413,-0.50969,0.721621,-0.11006,0.370275,0.800104,0.226664,-0.233842,-0.463106,0.340884,0.0877082,0.256628,0.274874,0.513837,0.718381,-0.0768014,-0.978685,-0.15183,-0.561178,-0.155087,-0.197508,-0.00529289,0.466507,0.641335,0.746113,-1.07404,-0.129459,-0.122749,-0.0570618,0.0818068,0.216822,0.199446,-0.0863128,0.0154673,0.363707,-0.36314,-0.603883,-0.150128,0.250459,0.0148591,0.144273,0.493588,-0.397256,0.488241,-0.0423494,-1.06703,0.090099,0.135297,0.332617,0.00871774,0.662179,0.566935,0.712826,0.586035,0.393981,-0.0180349,-0.288324,-0.517688,0.953749,0.0816216,-0.203425,0.108402,-0.383573,0.098847,-0.487851,-0.257578,0.749168,-0.0547903,-0.0963903,-0.0874091,-0.0567585,0.00145793,-0.0394717,-0.228705,-0.00515205,0.672041,0.15044,0.203723,0.497261,-0.52655,-0.493133,-0.176899,0.0418199,0.0425154,0.309318,-0.548954,-0.242651,-0.210499,0.018909,-0.234915,0.0891677,0.267604,-0.22295,-0.115548,-0.943211,0.328027,-0.102127,-0.131723,0.134686,-0.613742,0.131226,-0.00184703,-0.223938,0.964826,-0.499451,0.532777,0.400823,0.246262,0.309539,0.424997,-0.207393,0.410332,-0.167492,0.541915,0.346171,0.231821,0.450943,-0.0564217,0.11728,0.33192,-0.127143,0.340306,0.157988,-0.0268969,0.200868,0.100299,-0.1996,-0.0132863,-0.0496298,-0.327522,-0.445914,0.354032,-0.377842,0.00104662,0.467888,-0.203772,0.325576,0.267172,-0.19506,0.277463,0.252348,-0.205695,0.351384,-0.219446,-0.0714443,-0.71275,0.0242637,-0.349936,-0.161494,-0.529083,-0.296073,0.0386251,-0.251947,-0.35652,0.246111,-0.206075,0.0646991,0.576812,-0.00907768,0.260346,-0.21205,-0.238295,0.216685,-0.312969,0.166186,0.069276,0.26921,0.0297882,-0.774921,0.338614,0.254484,-0.0810988,0.12008,0.0462107,-0.179989,0.320947,0.129794,-0.484623,-0.381468,0.290437,-0.171157,0.0119727,-0.238126,0.313729,-0.68965,0.156809,-0.0446415,0.337893,-0.365363,0.629737,-0.0117034,-0.0958316,-0.513901,0.131036,0.306334,-0.533563,0.66111,0.141246,0.143897,0.375827,0.379337,-2.51982 +3414.46,0.515805,0.0912059,4,1.5695,0.963355,-0.931939,0.386051,1.01532,-0.0652914,0.350789,-0.140238,0.289628,-0.194402,0.210635,-0.306552,0.114153,0.332803,-0.390027,0.969725,0.128086,0.0930367,-0.117322,-0.0311267,-0.222912,-0.699596,-0.574312,0.211745,-0.158979,-0.0254756,-0.250412,0.369166,-0.0603638,0.521183,0.713455,-1.09657,0.131777,0.480877,-0.410167,-0.243306,-0.255405,0.976712,0.1768,0.39806,0.839362,0.366931,0.6847,-0.345356,-0.215849,0.345608,-0.332541,0.181516,0.206602,-0.0419579,-0.0374492,-0.267955,-0.0593334,0.199842,0.797557,-0.454581,-0.153237,-0.981387,0.040424,-0.622696,0.119093,0.854281,-0.469116,-1.05061,-0.0621947,-0.266666,-0.0234538,0.0530079,0.484277,-0.545025,0.0436042,-0.136889,0.131399,0.405547,0.416549,0.285318,0.475631,0.507831,-0.326374,0.208476,0.387559,-0.615248,-0.181975,0.407893,0.0027553,-0.388663,0.369149,-0.142458,-0.336592,-0.156776,-0.0621393,-0.766589,0.242376,-0.395487,-0.00485002,-0.714387,-0.348814,0.0168989,0.238886,0.271635,0.179046,0.0532632,-0.063839,-0.112444,0.00289514,0.160551,0.349821,-0.502015,0.513911,-0.0326444,0.00287316,-0.160689,0.801172,-0.0503783,0.213864,0.142007,-0.806167,0.0956171,-0.4693,-0.0149381,-0.691615,-0.0168228,0.151725,0.311597,-0.317662,-0.00231926,-0.163889,0.198772,-0.0521467,-0.0620624,0.0682187,-0.270247,-0.0391467,1.02665,-0.624924,-0.159118,0.16395,-0.447253,0.33743,-0.84954,0.100342,-0.112106,-0.203197,-0.432053,0.313643,-0.00726958,-0.0654601,-0.0221404,-0.107308,0.432227,0.0511768,0.319405,0.377321,0.140998,-0.157242,0.153438,0.337301,-0.733756,0.0462643,0.214144,0.603873,0.0817946,0.753214,0.108888,-0.0351792,0.34139,0.222659,0.0350721,0.282061,0.33902,-0.342762,0.0807103,-0.222942,-0.407987,-0.143959,0.0390834,0.144277,0.254332,0.0380047,0.450809,-0.660465,-0.14898,0.227639,-0.0357969,0.435162,-0.425107,-0.50158,-0.185405,-0.180145,-0.217707,-0.0693371,0.343434,0.393364,-0.948847,0.0215043,0.283217,-0.0184198,-0.432753,0.0265853,-0.0844757,-0.223098,-0.260445,0.239164,0.793924,0.344868,-0.257006,-0.710327,0.995414,-0.301177,-0.507602,-0.410823,-0.168408,0.101959,-0.0891718,0.0141497,0.649531,-0.507835,0.0963748,0.117965,-0.713586,-0.555057,-0.576737,-0.535224,0.241958,-0.418843,0.316488,-0.561346,-0.300525,-0.0688254,-0.169787,-0.089885,-0.169849,0.23189,0.192898,-0.0276847,1.05623,0.198078,0.4329,0.286083,-0.356458,-0.436476,0.05874,-0.0319852,-0.291566,0.66154,0.667888,0.594229,0.320689,0.165283,-0.309279,-0.0323333,-0.548181,0.61353,0.155284,0.0924053,0.0135684,-0.296199,0.478906,-0.101627,-0.0563703,0.0462477,-0.236767,0.379414,-0.332764,0.0288741,0.254547,-0.291239,-0.121471,-0.788648,-0.00645037,-0.321632,-0.190251,0.370023,-0.432462,-0.139212,-0.628976,0.197035,0.00848355,0.257478,-0.522001,-0.0132243,-0.0193218,0.249444,-0.130178,0.0849574,0.428184,-0.0183464,-0.135587,0.774859,-0.398058,-0.321197,-0.0663017,0.371988,0.061545,0.0425731,-0.860794,0.0463432,-0.629184,-0.296614,0.356153,-0.203641,0.140675,0.191359,0.375067,0.437446,-3.36445 +3428.06,0.757354,0.0912059,4,1.55459,0.879573,-0.858313,0.334543,0.735591,-0.120454,0.414393,0.329679,0.27996,0.158,0.038666,-0.237292,-0.11673,0.479828,-0.599507,0.519597,0.118681,-0.152969,-0.487072,-0.0301952,-0.457737,-0.657421,-0.785591,0.322946,-0.288919,-0.077394,0.359259,0.356841,-0.421668,0.170839,0.822954,-0.382996,-0.215927,0.208866,0.178988,-0.540568,-0.287722,0.669004,0.540781,0.27226,1.18863,0.251435,0.591326,-0.265592,0.0211523,0.36225,-0.945392,-0.108251,0.107343,-0.0693729,0.0357225,0.278146,0.0395019,-0.365415,0.959719,-0.249815,-0.219416,-1.03616,0.162419,-0.196823,-0.0288415,1.24753,-0.788119,-1.06366,-0.10229,-0.0778875,-0.305017,0.28069,0.509746,-0.371814,0.350797,-0.0721335,0.626705,0.387056,0.431785,0.539013,0.502726,-0.362785,0.0599698,0.436443,0.516713,-0.101202,0.192177,0.095322,-0.183216,-0.165501,-0.00769629,-0.175995,-0.168786,-0.202874,0.12112,-0.59141,0.308731,0.131388,0.11355,-0.887093,-0.12008,-0.108635,-0.279224,-0.0937615,-0.13128,-0.547037,-0.174857,-0.0295002,-0.00142462,-0.145658,0.256205,-0.37041,0.719048,0.585041,-0.207399,0.0476105,0.219258,0.132243,-0.156016,-0.299259,-0.0514287,0.389531,0.101399,-0.056525,-0.438163,-0.269753,-0.323617,0.237112,-0.233613,0.0658352,-0.346531,0.377438,0.406668,-0.290339,0.327507,-0.485874,0.482174,0.504785,-0.227271,-0.199216,1.07231,-0.46889,0.704675,-0.224129,-0.271367,-0.144314,-0.165968,-0.28713,0.0987872,0.124591,-0.0294014,-0.0223713,-0.294105,0.162987,-0.317748,0.377241,-0.13982,0.462051,0.382836,-0.278498,0.558547,-0.485767,-0.159409,-0.23794,0.088009,-0.512588,0.662463,-0.156198,0.053009,0.0675655,0.342988,-0.114478,-0.0474602,0.0832076,-0.0741992,-0.198754,-0.423736,0.143433,-0.131422,-0.260648,-0.0930963,-0.01028,0.0262536,0.415745,0.235336,0.108735,0.591829,0.0507074,-0.270536,-0.0720995,-1.12122,-0.171691,0.539221,0.0147056,-0.141253,-0.212192,0.0839323,-0.796902,0.457714,0.682417,0.423802,-0.175359,-0.247941,0.484048,-0.253808,-0.593291,0.084562,0.337938,0.698288,0.34328,-0.382445,0.833533,-0.00708077,-0.0336641,-0.182672,-0.154125,0.130606,-0.612892,-0.0957903,0.856739,-0.205365,-0.00877214,-0.0194148,-0.538788,-0.310885,-0.723299,-0.620583,0.0236201,-0.958339,0.306826,-0.377411,-0.175562,-0.140011,0.307718,0.431512,-0.229353,0.012276,-0.233468,0.264507,0.858799,0.0292923,0.390837,0.670141,-0.208449,-0.334369,-0.0278049,0.13228,-0.284717,0.511887,0.438225,0.452504,0.146075,0.29713,-1.07092,0.474187,-0.361922,0.17054,0.126701,0.0317928,0.0386463,0.119238,0.591359,-0.352988,-0.167286,0.219594,0.0940068,0.0952382,-0.182067,0.173448,0.185977,-0.198789,-0.186155,-0.175632,-0.276499,-0.263952,-0.206097,0.16221,-0.201109,0.0226435,-0.485042,-0.24891,0.179962,0.255454,-0.409462,-0.229277,-0.0914815,0.00823128,-0.525208,0.131012,0.695095,-0.216922,0.413061,0.526589,-0.0534716,-0.379127,-0.190052,-0.0205711,0.516559,-0.117696,0.13983,0.282167,-0.6532,0.0211896,0.410957,0.0300074,0.129623,0.268171,0.360031,0.517853,-2.27864 +3419.06,0.921763,0.0912059,5,1.55785,0.875232,-1.02479,0.405478,0.986848,-0.089907,0.3995,0.280639,0.319174,0.185018,0.106093,-0.266622,-0.10431,0.308501,-0.506255,0.57768,0.247485,-0.101747,-0.332773,0.0562161,-0.423691,-0.604123,-0.673684,0.322598,-0.14799,-0.0882863,0.444471,0.376839,-0.60508,0.034634,0.739186,-0.426954,-0.21962,0.377625,0.152847,-0.502726,-0.184194,0.610939,0.659033,0.319448,1.22932,0.184784,0.62716,-0.406657,-0.0980409,0.329086,-0.935502,-0.0405666,0.254277,-0.0374962,0.051724,0.25467,0.144535,-0.372991,0.941106,-0.14416,-0.355564,-1.13929,0.310503,-0.211155,-0.206149,1.20267,-0.863907,-1.19508,-0.0963452,-0.0239885,-0.337072,0.349827,0.594102,-0.316124,0.396582,0.176464,0.662051,0.417927,0.386549,0.56976,0.411929,-0.417891,0.111681,0.328206,0.594701,0.158859,0.377641,0.0897502,-0.112648,-0.232981,-0.162425,-0.172133,-0.23932,-0.295473,0.16524,-0.610522,0.202384,0.00596516,0.0133122,-0.609217,-0.118223,-0.240501,-0.393891,-0.174466,-0.173583,-0.367981,-0.302475,-0.0794895,0.196399,-0.285858,0.384817,-0.339625,0.504209,0.459921,-0.120371,0.0308111,0.380144,0.191727,-0.088885,-0.233679,0.146726,0.425016,0.285154,-0.0612045,-0.35747,-0.156019,-0.491319,0.197532,-0.304347,0.0123498,-0.518673,0.338458,0.572459,-0.237275,0.237985,-0.46255,0.396524,0.420907,-0.142206,-0.112063,0.785542,-0.482818,0.604198,-0.0563222,-0.299997,-0.112423,-0.165104,-0.326651,0.17055,0.0446602,0.00239971,-0.0698715,-0.341309,0.124399,-0.330385,0.418724,-0.115056,0.3873,0.560079,-0.253288,0.316403,-0.463721,-0.261142,-0.132509,-0.0881839,-0.457113,0.628545,-0.20489,0.00282797,0.0340535,0.204192,-0.0936821,-0.0648808,0.226755,0.0516476,-0.212985,-0.344481,0.114604,-0.249963,-0.392065,-0.140176,-0.0563153,-0.00326682,0.517056,0.46488,0.119193,0.418127,-0.0733389,-0.451866,-0.199897,-1.06357,-0.221295,0.411758,-0.049341,-0.284194,-0.139839,0.113418,-0.81312,0.659863,0.688283,0.345702,-0.141596,-0.179289,0.590465,-0.297794,-0.613588,-0.00802193,0.426552,0.628378,0.325176,-0.493224,0.897916,-0.0461712,0.0349251,-0.209507,-0.179434,0.0494347,-0.635836,-0.0871049,0.941178,-0.0267161,-0.107177,0.0785515,-0.656522,-0.422701,-0.693324,-0.697558,-0.100046,-0.883113,0.334014,-0.369403,-0.285972,-0.133897,0.255011,0.444173,-0.120215,-0.0135294,-0.303774,0.363904,0.836109,0.138924,0.237341,0.600893,-0.0571427,-0.361643,-0.0448844,0.370489,-0.138784,0.469399,0.41975,0.682781,0.391286,0.237737,-1.07196,0.527363,-0.375598,0.140326,-0.146575,0.00117773,0.0901794,-0.110516,0.610949,-0.226049,-0.140462,0.145919,0.0738255,0.000485132,-0.0147562,0.277409,0.2159,-0.180391,-0.192429,-0.114202,-0.274994,-0.278721,-0.25878,-0.194025,-0.157733,-0.064534,-0.315995,-0.230971,0.0731083,0.306454,-0.292579,-0.457912,-0.0541383,0.0141423,-0.436887,0.0198962,0.594607,-0.164143,0.316273,0.572919,0.051019,-0.471257,-0.216842,0.0350481,0.323701,-0.248707,0.197172,0.217828,-0.56313,-0.0906437,0.319009,-0.0120517,0.12989,0.254487,0.360403,0.504467,-3.08927 +3423.94,0.810248,0.0912059,4,1.52408,0.947601,-0.784015,0.371952,1.03018,0.0132706,0.25497,0.195661,0.57496,0.488488,-0.0241971,-0.206877,0.0701975,0.435028,-0.46366,0.595298,0.0459024,0.215452,-0.222099,-0.0763943,-0.158232,-0.830625,-0.619161,0.199421,-0.0295161,-0.0869975,-0.0519257,0.591447,-0.154742,0.31517,0.91831,-0.593581,-0.0407581,0.599067,-0.109284,-0.186641,-0.00985057,0.49849,0.496365,0.285511,1.00889,0.675868,0.692393,-0.224061,-0.271589,0.0669149,-1.01789,0.0861009,0.270577,0.0614332,-0.199092,0.237311,0.131311,-0.53521,0.814242,0.0498718,0.0291726,-1.40894,0.0479332,-0.481233,0.163916,0.946289,-1.08251,-1.37773,0.0934266,0.241773,-0.0647657,0.48196,0.307865,-0.0652611,0.224674,0.0820884,0.446582,0.441733,0.613474,0.36418,0.301066,-0.538395,0.173788,0.267042,0.659783,-0.0234995,0.0073849,0.284039,-0.224181,0.0213738,0.029501,-0.221083,-0.00924417,-0.172461,0.0430937,-0.494243,0.0895698,-0.539342,0.41948,-0.787454,0.321657,0.372251,-0.272928,-0.0818216,-0.52777,-0.208429,0.0291735,0.00280271,0.482452,-0.448504,0.0904693,-0.362913,0.712814,0.211562,-0.0728378,-0.0259644,0.271988,0.0199914,0.00129838,-0.0728355,-0.0274779,0.630719,0.0243397,0.139983,-0.620802,0.395423,-1.04337,-0.0999762,-0.198242,0.0223135,-0.62479,-0.157919,0.621077,0.0377451,-0.0329146,-0.0689775,0.00140323,0.434964,-0.255078,-0.177181,0.767239,-0.63507,0.89742,0.0465108,0.157286,-0.0824317,-0.494068,-0.712356,0.363639,0.175075,-0.369018,0.0784603,-0.187849,0.0649453,-0.395543,0.36161,-0.128595,-0.150413,0.604929,0.052335,0.03471,-0.438603,-0.415164,-0.10333,0.283541,-0.219447,0.461068,-0.0205001,0.2676,0.184722,0.367605,-0.0370796,0.185155,0.259698,-0.0562622,-0.270179,-0.188285,-0.00210251,-0.573468,-0.531858,-0.374493,-0.0968915,0.255616,0.580793,0.225592,-0.191078,0.484359,-0.224969,0.0248168,-0.31034,-0.712545,-0.146724,0.0697494,-0.193414,-0.168058,-0.200283,0.0199495,-0.784002,0.398666,0.396949,0.0111329,-0.216187,0.0621539,1.00236,0.108364,0.0458407,-0.245417,0.204947,0.29755,0.137457,-0.253668,1.01278,-0.187535,0.204481,0.0243798,-0.122574,-0.083508,-0.267851,-0.06508,0.773444,-0.382334,-0.321808,0.297282,-0.817061,-0.199414,-0.37383,-0.756158,-0.0609425,-0.562937,0.185456,-0.077862,-0.0850549,-0.208203,0.0355765,0.70012,-0.150754,-0.0732226,-0.248069,0.010286,0.8991,-0.0500198,0.300005,0.430058,-0.146062,-0.719651,-0.220669,0.410319,-0.0636294,0.279202,0.377312,0.62035,0.0794149,0.430418,-0.908713,0.249364,-0.261563,0.203953,-0.197744,-0.139273,0.325449,-0.057216,0.223938,-0.20675,-0.148107,0.28809,0.238889,-0.250135,-0.248699,0.284081,0.0907992,0.0252272,-0.539829,-0.107038,-0.24811,-0.317075,-0.337383,0.0129853,-0.494029,0.270205,-0.390212,0.0121746,-0.00970263,0.518404,-0.0256869,-0.383302,-0.0980409,0.0850297,-0.298991,0.0561058,0.219567,-0.185775,0.159576,-0.172561,-0.124757,-0.3766,-0.394196,0.0971749,0.422495,-0.279239,-0.500486,0.187749,-0.324345,0.114416,-0.159063,0.00626907,0.135477,0.269635,0.368073,0.519264,-3.51532 +3417.22,0.616842,0.0912059,4,1.56372,0.875318,-0.976361,0.355918,1.10543,-0.265906,-0.187798,-0.166432,0.292458,-0.617265,-0.130928,-0.0629245,-0.203907,0.140828,-0.480482,0.744301,0.0278207,0.113837,-0.028592,-0.0835956,-0.466298,-1.45693,-1.13165,0.0443364,-0.606139,0.398955,-0.00236062,0.0666502,-0.375453,-0.0994397,0.98476,-0.468926,0.792504,0.307985,0.129016,-0.370837,-0.239369,0.373113,0.43047,0.213758,0.879174,0.412228,-0.306708,-0.841828,-0.0160783,0.0995746,0.0716674,-0.274665,0.0600085,-0.491341,0.127751,0.627854,-0.233722,-0.354012,1.10888,-0.397232,-0.335714,-0.654255,0.542628,-0.367209,0.0622302,0.879892,-0.085598,-0.687398,-0.457464,0.184283,0.304743,-0.207463,0.268773,-0.254436,-0.579952,0.113058,0.368301,-0.0140419,0.569838,0.154122,0.215377,0.565194,-0.193542,0.554328,0.984974,0.023175,0.245579,-0.103858,0.0683283,0.119781,0.471255,-0.401084,0.0893528,-0.700675,-0.113908,0.143022,-0.0180601,0.11968,-0.251129,0.374864,-0.255356,-0.26814,-0.169018,0.279398,0.125761,0.0256952,-0.668428,0.12524,-0.0703788,0.373627,0.143849,-0.170146,-0.0744775,0.355615,0.0909324,0.0228026,-0.55122,0.0361674,-0.00781603,0.183399,-0.02404,-0.10501,-0.172924,-0.290093,-0.527609,0.112726,0.260389,-0.00510431,-0.373731,-0.186259,0.4665,0.542658,0.160982,-0.296626,0.417914,-0.14617,0.41306,0.628003,-0.190919,-0.216222,-0.345106,-0.126304,0.405761,-0.264977,-0.226615,-0.107341,0.441548,-0.467735,-0.664672,-0.550149,-0.0594217,0.789972,-0.240213,-0.0580973,-0.370428,-0.228567,0.0469417,-0.171872,-0.28411,0.00875968,0.0122884,-0.904513,0.0171083,-0.642979,0.292459,0.212613,0.873143,-0.152784,-0.021272,0.0755264,-0.227095,0.537546,-0.575755,-0.813812,0.558361,0.244378,-0.476397,-0.669989,0.40479,0.30135,0.00425854,-0.345858,0.0176415,0.870393,-0.105418,0.742481,0.0163951,-0.0653691,0.336331,-0.126463,0.256817,-0.0142722,0.128693,-0.802556,-0.063581,0.21782,0.092748,-0.499131,-0.366025,0.543772,-0.0845271,-0.0601677,0.412325,-0.0984613,-0.274319,-0.198974,0.270085,0.108444,-0.00494771,-0.000958863,-0.207898,0.767357,-0.0467858,-0.192821,-0.147389,-0.30023,0.429828,0.343028,-0.10562,0.0875961,-0.932771,0.19703,0.0333985,-0.306428,0.176226,-1.03301,0.06195,0.121835,0.0892489,1.03708,-0.248784,-0.264977,0.0593409,0.148226,-0.259204,-0.335055,-0.323458,-0.18791,-0.115913,0.177098,0.0531718,-0.597778,0.345434,-0.78663,-0.522674,0.454444,-0.203757,0.0200592,0.507797,0.000574094,0.695574,0.100959,-0.373595,0.0549392,0.176781,-0.326666,0.244416,-0.0466121,-0.261809,0.246781,0.456507,0.161258,0.295807,0.180361,0.168137,0.422028,0.484353,0.390781,0.0215986,0.0960753,0.00581189,-0.195808,-0.0812023,0.105916,-0.197638,-0.136271,-0.806224,0.485304,-0.0151738,-0.174394,-0.165762,-0.536823,0.353138,0.230105,0.131402,0.188343,-0.854035,0.437184,0.239474,0.309174,-0.326248,-0.308256,0.422328,0.508099,-0.225003,0.220924,0.154274,0.348286,0.0639451,-0.697202,-0.366709,0.295255,-0.0633261,-0.0843825,0.334392,0.14746,0.22085,0.384006,0.469947,-3.41165 +3390.13,0.927269,0.0912059,4,1.63154,0.665443,-0.9529,0.375659,0.546338,-0.244428,0.0416645,-0.123352,0.0916684,-0.05826,-0.325766,-0.640066,-0.746072,0.392624,-0.396939,0.419022,0.0927092,0.0913212,-0.273627,-0.179123,-0.531431,-0.840828,-0.385287,0.348494,-0.0900704,0.201753,0.120783,0.315651,-0.345398,-0.0361877,0.868311,-1.36614,-0.238937,0.729429,-0.432702,-0.122351,-0.543841,0.306567,0.116318,0.0744131,1.24491,0.756139,0.470783,-0.313562,-0.0922129,-0.0819125,-0.999709,-1.07971,0.42854,0.171182,0.238115,0.17381,-0.176485,-0.399247,1.18522,-0.511938,-0.108512,-1.09813,0.492893,-0.020114,-0.0531197,0.545071,-0.901775,-1.10539,-0.0518059,0.282003,-0.218565,-0.544335,0.535565,0.130791,-0.2047,0.583562,0.658162,-0.0575571,0.20329,0.610213,0.0274066,-0.0114829,-0.423184,0.576201,0.966759,-0.095199,0.160751,0.326852,-0.878181,-0.124748,-0.173284,0.442277,0.292204,-0.261363,0.0505979,-0.342193,-0.400454,0.245798,0.466097,-0.574305,-0.0658061,-0.29117,-0.345002,0.0894894,-0.490055,0.257682,-0.898651,-0.296015,0.367103,-0.607603,0.524231,-0.113214,0.479856,0.304485,-0.0671496,0.261877,-0.300193,0.0866069,0.764474,-0.0170247,-0.62886,-0.118355,0.117216,0.229355,-0.505368,0.167629,-0.398692,-0.166469,0.406351,0.0996148,-0.157478,0.0257159,0.845803,0.232432,0.173032,0.00961286,-0.0668444,0.730793,-0.0754254,-0.345805,-0.474202,0.124711,1.14162,-0.345248,-0.277959,0.0618165,0.0402032,-0.920044,-0.389258,0.358423,-0.814885,0.421962,0.0927697,0.690438,-0.347446,-0.116794,0.402296,-0.21506,0.769268,0.493957,-0.073421,-0.00677145,-0.457173,0.407868,0.239312,0.140095,0.338197,0.109935,-0.613546,0.21936,0.0156215,0.0576927,-0.201363,0.188783,0.621672,-0.420151,-0.294526,-0.348141,0.229024,-0.263163,0.0196972,-1.21853,0.125774,0.615038,0.0998162,-0.214497,0.389915,0.062097,-0.531496,0.410439,-0.544439,-0.0289791,0.217037,0.56777,-0.111597,0.0763022,0.357427,-0.65325,0.363152,0.0584912,0.306417,-0.377109,-0.107226,0.245166,0.155797,-0.308802,-0.710233,-0.121409,0.349867,0.0924407,-0.310883,0.972809,-0.176714,-0.358337,-0.488092,-0.197003,0.220605,0.159923,0.0530703,0.0335754,-0.903439,-0.451297,-0.216496,0.000533725,0.421565,-0.281385,-0.0561987,0.283185,-0.294033,-0.202615,-0.230108,-0.336524,0.270684,0.186601,-0.428797,-0.244924,-0.358081,-0.424687,0.420663,0.507478,-0.502356,0.364508,0.351946,-0.463601,-0.032536,0.513409,0.0957463,-0.251837,-0.099351,0.372352,1.01287,0.955144,0.711656,-0.156096,0.766776,-0.754246,0.815917,0.0818164,-0.223604,0.78577,-0.297787,0.139073,-0.230903,0.162189,0.532812,0.235352,-0.0560938,-0.158543,0.165377,-0.00787115,0.109642,0.281858,0.32496,-0.173138,-0.294953,-0.0816571,-0.110885,0.320903,0.210484,-0.256894,0.105742,0.314298,0.259742,-0.323304,-0.176044,-0.20879,-0.251661,0.172801,0.183684,0.585459,-0.0749844,0.136467,0.0158932,0.432537,-0.0329698,-0.404184,-0.105808,0.71421,0.0309835,-0.330249,0.419987,0.101989,0.0651033,0.729174,-0.260377,0.153202,0.308259,0.39141,0.555211,-1.15314 +3393.03,0.968468,0.0912059,4,1.58489,0.796597,-0.583155,0.242894,0.458987,-0.28577,-0.124917,-0.0115733,0.399269,-0.560073,-0.174286,-0.1756,-1.02216,0.594139,-0.401366,0.42797,-0.0466044,0.0993955,0.231182,-0.0740791,-0.447813,-0.951721,-0.618364,0.387356,0.181025,0.233537,0.364299,0.173367,-0.242321,0.151204,0.798924,-1.29652,-0.333361,0.807526,-0.068143,-0.197873,-0.238085,0.517782,0.197968,0.34294,1.12848,0.461536,0.355268,-0.40019,0.256022,-0.140088,-0.956012,-0.39961,0.48193,-0.152341,0.20634,-0.1613,-0.0638845,-0.892944,1.07189,-0.67217,-0.325404,-0.949195,0.42308,-0.274244,-0.100509,0.703876,-1.32932,-1.61679,-0.164007,0.243866,0.00762343,-0.533345,0.212239,-0.0823469,-0.374064,0.995724,0.46556,-0.194147,0.63913,0.922637,0.182395,0.395714,0.200013,0.422336,0.47548,0.189379,0.379088,0.0668821,-0.0780735,0.241581,0.0469016,0.295435,0.142948,0.00255437,-0.479106,-0.108879,-0.503626,0.251106,0.484605,-0.730632,0.0921507,0.04606,-0.934677,-0.139463,0.036315,0.120202,-0.46188,-0.789167,0.363975,-0.765421,0.551849,-0.119556,0.07341,0.0937609,0.319166,0.254964,0.19243,0.180965,0.543133,0.479438,-0.261372,-0.217566,0.094125,0.499372,-0.418485,0.145202,-0.312874,-0.867905,0.387906,0.120878,0.0907799,0.0359396,0.386592,0.205106,0.122506,0.118417,0.0915324,0.7401,-0.144143,-0.54866,-0.527568,-0.109193,0.956136,-0.141419,-0.890117,0.100428,-0.347956,-0.195934,-0.15559,0.225627,-0.496436,0.388652,-0.0509313,0.340127,-0.422794,-0.203623,0.322556,-0.287173,0.517002,0.250609,0.165918,0.249906,-0.353062,-0.305632,0.184244,0.32435,0.665804,0.0839168,-0.456643,0.255045,-0.167453,0.265505,-0.334157,0.0572289,0.475675,-0.20304,-0.377701,0.138339,0.12309,-0.0291428,-0.285545,-1.00853,0.167119,0.485061,0.16252,-0.130515,0.123586,0.128965,0.0680102,0.337739,-0.323382,-0.541773,-0.160887,0.680507,-0.0892457,-0.351771,0.166651,-0.552529,0.122787,-0.0663036,0.173251,0.16763,0.0822326,0.0338745,0.0557128,-0.433804,-0.672724,0.128433,0.23821,0.276515,-0.169174,1.05399,-0.173896,-0.56448,-0.244712,0.0455964,-0.501284,0.156338,-0.345106,0.691666,-1.04957,-0.585099,-0.603158,-0.0601449,0.0773511,-0.632313,-0.162772,0.0881706,-0.0122133,0.0218435,-0.0764486,-0.388671,0.544724,-0.115443,0.218298,-0.227193,0.251152,-0.407566,0.052508,0.643461,-0.623597,0.168646,0.489951,-0.468852,0.540704,0.429037,-0.0119156,-0.0466084,0.611441,0.408009,0.987203,0.36219,0.436868,-0.188415,0.347337,-0.366997,0.810189,0.157654,-0.284703,0.456024,-0.367847,0.410452,0.319833,0.250103,0.215715,0.0494851,-0.35804,-0.259888,0.275946,0.0270071,-0.0996841,0.186325,0.499213,-0.183251,-0.144904,-0.0681167,-0.089237,0.21538,0.23358,-0.0738866,0.314546,0.188896,0.2051,-0.331081,0.0694042,-0.349398,-0.317514,-0.210032,-0.0150839,0.496365,0.0941983,0.000151554,0.0433657,0.525506,0.0461497,-0.411712,-0.0595448,0.551586,0.113179,-0.360284,0.252282,-0.311176,-0.163549,0.683816,0.3428,0.151798,0.38875,0.389612,0.623498,-1.19971 +3392.87,0.744214,0.0912059,4,1.5808,0.772397,-0.565275,0.248185,0.533794,-0.325936,-0.132196,-0.00903289,0.379473,-0.442989,-0.104083,-0.104897,-0.936302,0.579856,-0.337501,0.616966,-0.0990047,0.0521857,0.298812,-0.00334132,-0.476231,-0.855149,-0.769198,0.332621,0.233058,0.138198,0.420175,0.0842251,-0.421695,0.228787,0.732595,-1.33916,-0.291516,0.689493,-0.263796,-0.203304,-0.062836,0.456308,0.24778,0.284065,1.0918,0.665599,0.416071,-0.165454,0.276936,0.169908,-0.966508,-0.559405,0.482197,-0.180964,0.279572,-0.287727,-0.135221,-0.880565,1.05863,-0.559033,-0.256051,-1.01458,0.407824,-0.211055,0.156743,0.639213,-1.29512,-1.85636,0.116668,0.202699,-0.078639,-0.452305,0.40232,-0.0123549,-0.392795,1.04535,0.443191,-0.288554,0.53527,0.717408,0.252045,0.358533,0.20583,0.407231,0.474711,0.0213033,0.385708,0.226859,-0.0358624,0.168006,-0.207069,0.279631,0.120347,-0.0250832,-0.416853,-0.164328,-0.483547,0.276213,0.44044,-0.572015,-0.0149348,0.0259129,-0.981731,-0.0382604,-0.214956,0.130055,-0.468332,-0.648838,0.261367,-0.62933,0.646455,-0.181119,0.254302,0.244117,0.239597,0.330795,0.074879,0.218986,0.478396,0.581824,-0.121153,-0.0948731,0.0351423,0.387704,-0.344859,0.270201,-0.448758,-0.733115,0.312912,-0.0161013,0.139949,-0.0466373,0.301214,0.191915,0.0203373,0.133564,0.0920191,0.738061,-0.097381,-0.502396,-0.508049,0.125125,0.971227,-0.225302,-0.874481,0.1609,-0.407611,-0.223062,0.018403,0.109768,-0.490643,0.303269,0.0206191,0.306946,-0.56183,-0.174514,0.212858,-0.452134,0.381074,0.255503,-0.00551003,0.175684,-0.269906,-0.246271,0.0162233,0.339007,0.643784,0.160354,-0.421298,0.257235,-0.145641,0.2991,-0.118513,0.0430943,0.470237,-0.0416488,-0.308183,0.370302,0.252072,-0.0338326,-0.294466,-0.986867,0.320809,0.414109,0.256356,-0.134326,0.300172,0.10146,0.0509587,0.383165,-0.129231,-0.35317,-0.274768,0.586528,-0.00727308,-0.289878,0.152066,-0.649706,0.17461,0.0721733,0.0106816,-0.104117,0.113955,0.0815547,0.0793115,-0.389732,-0.419106,0.030051,0.113444,0.191136,-0.131283,1.06822,-0.0496293,-0.661686,-0.226444,-0.0284803,-0.367365,0.242578,-0.294792,0.76115,-1.01696,-0.59622,-0.669531,-0.147475,0.101299,-0.804735,0.0224841,0.171675,-0.0247831,0.066783,0.0699406,-0.210406,0.488998,-0.132219,0.153372,-0.182812,0.232962,-0.525696,-0.0283243,0.405353,-0.657778,0.229871,0.380432,-0.570327,0.513513,0.429475,-0.032613,-0.217975,0.63912,0.54917,0.941926,0.31867,0.345115,-0.193872,0.475997,-0.306366,0.715355,0.147092,-0.222754,0.571324,-0.519125,0.423064,0.320602,0.282634,-0.121095,-0.0513065,-0.253353,-0.010652,0.311142,0.0257877,0.0567711,0.506726,0.693963,-0.0490681,-0.167106,0.0353615,-0.196518,0.280301,0.297596,-0.142654,0.340859,0.108929,0.295225,-0.362961,0.154889,-0.052345,-0.567751,0.059527,-0.0232047,0.462161,0.0223363,-0.0644768,0.130438,0.42331,-0.0512626,-0.490277,-0.0131551,0.190287,0.0351935,-0.642409,0.346031,-0.30195,0.010479,0.682937,0.192316,0.146,0.393707,0.382099,0.62746,-1.41372 +3415.85,0.721871,0.0912059,4,1.70833,0.807589,-0.577382,0.0175231,0.696038,-0.0819041,-0.381404,-0.348125,-0.40276,0.421421,-0.257628,-0.35803,-0.216226,0.0362716,-0.17431,0.49882,-0.263963,-0.41119,-0.58012,-0.506771,-0.311917,-1.0753,-0.843207,0.37295,-0.570055,-0.603565,-0.98069,0.187661,-0.376022,-0.0931102,0.936338,-0.115295,0.471445,0.421875,0.359148,0.225347,-0.762641,-0.217289,0.280569,-0.596713,1.31015,0.489285,-0.366319,-0.386194,0.3398,-0.663729,-0.315375,0.15022,0.602423,-0.154213,-0.0406067,0.544565,0.21979,-0.66141,1.24844,-0.683174,0.0193089,-0.662366,0.766943,-0.239767,-0.512676,0.939321,-0.185198,-0.791931,-0.601009,0.214345,0.102057,0.130676,-0.194438,-0.437774,0.158695,-0.225858,0.692782,-0.0800927,0.579941,0.209484,0.509308,-0.640325,-0.529168,-0.195901,0.365407,-0.606311,-0.331647,-0.606674,0.0675449,-0.29499,-0.161671,-0.541451,-0.346152,-0.692855,-0.0983965,-0.147162,-0.0304773,-0.012996,-0.506522,0.033409,0.222711,-0.217594,0.677001,-0.110682,-0.0322634,-0.331931,-0.255076,0.0133443,-0.332126,0.0999062,-0.0857058,-0.324435,0.782697,0.837986,-0.644977,-0.363739,-0.169757,0.390883,0.0920083,-0.360819,-0.326608,0.0415244,-0.156785,-0.444723,-0.776638,-0.187307,0.231829,0.226684,-0.212182,0.370192,0.222433,0.0513843,0.336425,-1.05115,0.320992,-0.177225,-0.138049,0.139283,-0.123131,0.333769,0.385454,-0.276339,-0.106936,-0.293781,0.31871,-0.53164,0.284189,-0.734491,-0.0940453,-0.00808191,0.00327964,-0.0961368,-0.350904,-0.375308,-0.0419404,-0.0661773,0.390743,0.202699,-0.0892699,0.442198,0.393394,-0.468283,-0.168294,-0.0722118,0.182484,-0.43121,0.423596,-0.190561,0.106939,0.111228,-0.180812,-0.150199,-0.113601,-0.111934,-0.066739,-0.120876,-0.0757392,0.0800806,-0.0919642,0.351487,-0.27721,0.349717,0.168997,0.716284,0.02793,0.18658,0.0115015,-0.0807172,0.109876,-0.569272,-0.347612,0.125775,0.318738,-0.935749,0.0324335,0.348594,-0.063907,-0.208447,-0.0778048,0.131594,0.1662,-0.202651,-0.974365,0.0987837,-0.465366,-0.285592,0.641694,-0.0933368,-0.18107,-0.266534,-0.990195,0.617175,0.220864,0.475181,-0.263281,-0.0810113,0.362975,-0.266645,0.266983,-0.103021,0.0351614,0.223675,0.729171,-0.166088,-0.159701,-0.307168,0.0474116,0.186706,-0.538292,0.374338,-0.411501,0.0132272,-0.473992,0.245287,0.0487881,0.17342,-0.236146,0.136377,-0.43986,0.287284,0.157857,0.0353302,0.445078,0.00321086,-0.362398,-0.290643,0.374642,0.439459,0.159013,-0.29726,0.256587,-0.228569,-0.174267,-0.181144,-0.389617,-0.369962,0.145088,-0.141834,-0.00336751,0.10806,-0.0161325,0.0517847,-0.236553,-0.289561,0.12457,0.705451,0.55082,0.2568,0.0271831,0.0197928,0.0127685,-0.617702,-0.669066,-0.196628,0.238697,-0.402354,0.110934,-0.0403953,0.0168081,0.292186,-0.517726,-0.341903,-0.0572269,0.534482,-0.425807,-0.353553,0.283748,0.128255,0.0936663,0.35936,0.113007,0.223327,0.315074,-0.374648,0.155278,0.89602,0.273681,0.389224,-0.159134,-0.349824,-0.0109852,0.232796,-0.0880619,-0.726842,0.0480947,0.111272,0.287869,0.333575,0.536534,-1.72291 +3435.68,0.626632,0.0912059,4,1.70303,0.874932,-0.501576,-0.0381759,0.549842,-0.0242602,-0.432303,-0.2419,-0.253505,0.470282,-0.176396,-0.412647,-0.0671098,0.0462308,-0.137688,0.498531,-0.245575,-0.550612,-0.424678,-0.318159,-0.283165,-1.05018,-1.04919,0.347969,-0.370139,-0.661894,-0.706112,0.184919,-0.392034,0.216116,0.635552,-0.348072,0.558064,0.181077,0.0733453,0.00716378,-0.726481,-0.118997,0.375125,-0.434818,1.28385,0.44096,-0.404355,-0.0352781,0.090303,-0.351613,-0.430774,0.078838,0.739356,-0.0657713,0.303636,0.0909713,0.349922,-0.774877,1.26301,-0.553475,0.148235,-0.587304,0.705169,-0.324109,-0.159734,1.0053,-0.245471,-0.793504,-0.820505,0.590547,0.0553242,0.0755967,-0.231692,-0.233911,-0.0213538,-0.353649,0.390221,-0.0189701,0.595101,0.31075,0.289705,-0.232638,-0.177979,-0.281215,0.473657,-0.425665,-0.321171,-0.455419,0.16546,-0.0119282,0.256245,-0.337372,-0.344411,-0.562434,-0.158452,-0.164438,0.145378,0.117201,-0.154665,-0.0429704,0.22274,-0.684077,0.413521,-0.21243,0.00876039,0.246958,-0.486931,-0.0733714,-0.504677,-0.381162,-0.39106,-0.569042,0.450777,0.774447,-0.417158,-0.235392,-0.0484514,0.476858,0.820386,-0.171694,-0.653965,-0.0182224,-0.259354,-0.296834,-0.580702,-0.0284361,0.372335,-0.125401,-0.291702,0.171946,-0.0389055,0.010342,0.200422,-1.07074,0.373041,-0.168367,-0.283952,0.151134,-0.0597452,0.138808,0.276218,-0.236467,-0.090877,-0.453307,0.309587,-0.381685,0.146878,-0.71228,0.0279366,-0.263342,-0.139096,-0.0845901,-0.44732,-0.580352,-0.255639,0.0125615,0.115925,-0.0849232,-0.119775,0.444297,0.488732,-0.222755,-0.435017,-0.0422554,0.124017,-0.323565,0.324521,-0.16185,-0.122647,-0.118941,-0.173421,0.0116575,-0.0310188,0.197131,-0.0832739,0.46031,-0.120987,0.189848,-0.0545869,0.324181,-0.0796203,0.0770134,0.535894,0.690659,-0.467042,-0.0856352,-0.038643,-0.162385,0.441859,-0.681624,-0.26063,-0.154815,0.123363,-0.805361,0.113819,0.221143,0.223826,-0.538293,0.0263878,0.201681,0.249583,-0.291297,-1.13779,0.148537,-0.542193,-0.417611,0.711457,-0.193674,0.136691,-0.16024,-0.953157,0.735783,0.0382946,0.0768194,-0.383832,-0.0506184,0.20843,0.218801,0.24478,0.0127905,-0.0243656,-0.0537752,0.631504,0.0633032,-0.195308,-0.305584,-0.178319,0.027813,-0.358625,0.433925,-0.32355,-0.150433,-0.324722,0.146785,-0.0976821,0.214995,-0.187749,-0.186696,-0.131752,0.374901,0.112466,-0.069043,0.181302,-0.064678,-0.189633,0.0199155,0.310873,0.542943,0.169779,-0.0702316,0.128229,-0.206441,0.00668968,-0.174761,-0.599583,-0.226962,0.213714,-0.429496,0.182107,0.262707,-0.0140055,0.470394,0.0544382,-0.0274322,-0.00348232,0.365548,0.27749,0.256117,-0.277999,0.249491,-0.574847,-0.4555,-0.113328,-0.033614,0.00680258,-0.246965,0.268164,-0.00265711,-0.0790575,0.518927,-0.262862,-0.170324,0.0666823,0.399257,-0.0848831,-0.245241,-0.0058602,-0.09022,0.0679546,0.55905,-0.110714,0.309004,0.420862,-0.129574,-0.172867,0.505198,0.296187,0.566174,0.0730089,-0.57048,-0.302539,0.296671,-0.494248,-0.827398,0.103692,0.116607,0.35184,0.341478,0.593161,-1.36335 +3435.12,0.946405,0.0912059,4,1.67937,1.08713,-0.517515,0.107352,0.86633,-0.243602,-0.069665,-0.0970979,0.440805,0.0632793,-0.490954,-0.404658,-0.206903,0.0779362,-0.116462,0.676351,-0.178041,0.237017,-0.0750275,-0.376316,-0.533002,-0.978674,-0.679595,-0.132224,0.0272607,-0.0458546,-0.16228,0.129074,-0.248569,-0.10954,0.488428,-0.360707,0.45139,0.156923,-0.132949,-0.00217907,0.233923,0.371357,0.84815,-0.601518,1.26574,0.476064,0.185189,-0.684007,0.23471,0.343957,0.0404906,0.144347,0.379868,-0.326281,-0.155314,0.636171,0.0366633,-0.225101,0.756597,-0.507008,-0.45499,-1.11745,0.509811,-0.631577,0.446769,0.859863,-0.703739,-2.0118,0.0921391,0.0834305,-0.0413533,-0.207783,-0.0501927,-0.291792,0.106396,-0.126374,0.335161,0.143373,0.648368,0.281903,0.184239,0.682636,-0.221693,0.223953,0.0361711,0.0386616,0.147049,-0.410648,-0.160247,0.217991,-0.44562,0.164769,-0.0331534,-0.554523,0.116303,-0.619863,-0.276373,0.0906106,-0.126286,-0.181005,0.472949,0.406095,0.139082,0.175687,-0.759779,-0.440189,-0.152138,-0.543581,-0.2128,-0.298975,0.472029,-0.347279,0.788271,0.336889,-0.324282,-0.109019,-0.172011,0.114024,0.0113303,0.701659,0.0376776,0.0549115,0.130001,-0.450388,-0.603876,-0.250176,-0.217835,-0.493067,0.31909,0.131635,-0.0601173,-0.188532,0.622602,-0.0943323,0.249582,-0.272893,-0.150405,0.665546,0.0396651,-0.0671704,-0.337786,0.143245,0.22294,-0.523366,0.0945419,-0.22562,-0.256022,-0.313429,0.197082,0.0915345,-0.489916,-0.20357,0.109375,-0.319803,0.239523,0.0907614,0.24216,-0.142882,-0.0259899,-0.109564,0.0110266,0.509084,-0.220311,0.131582,0.281626,-0.149121,0.556303,-0.323191,0.0635835,0.266476,-0.22669,0.412395,-0.521904,-0.350204,0.213749,-0.112483,-0.103825,0.605181,-0.123069,-0.247245,-0.304512,0.010353,0.0180114,0.675037,0.0313115,-0.174395,0.156597,0.468605,-0.291098,-0.759225,-0.516076,-0.105088,0.452184,-0.0546147,-0.296904,-0.542277,0.216991,-0.566449,-0.0725042,-0.154629,-0.516862,-0.591631,-0.366393,-0.148999,-0.370228,-0.324989,0.16205,0.227923,0.397531,-0.0199879,-0.181699,0.759164,-0.417596,-0.118296,0.134316,0.116319,-0.355539,0.303552,-0.19196,-0.166992,-0.243028,-0.2877,0.0906522,0.0755193,0.28441,-0.805806,-0.00398588,0.149387,-0.339478,0.199026,-0.00361094,-0.209424,0.237482,0.300177,-0.283013,-0.257033,-0.412108,0.218945,-0.219818,0.396561,0.176614,0.180976,0.63672,-0.0483259,-0.0774992,-0.114121,0.499429,-0.116162,0.383396,-0.0543011,0.827986,-0.402253,-0.109913,-0.709016,-0.438328,-0.410067,0.532361,-0.025054,-0.150103,0.29138,-0.147505,0.470632,0.274267,-0.248619,0.0928421,0.477345,1.0372,0.160987,0.0423858,-0.134349,-0.0715397,-0.324352,-0.17279,0.0164069,-0.193517,0.138184,-0.466185,0.344619,-0.0924454,0.647606,-0.171069,-0.408711,0.728094,-0.0945742,-0.281285,-0.114446,-0.353736,-0.644304,-0.362901,0.364668,-0.209668,0.0411334,-0.304593,-0.354374,0.108529,0.398801,0.171203,0.0903739,0.128247,-0.337855,0.280593,-0.421696,-0.242494,-0.264768,0.0879128,0.110179,0.208422,0.331931,0.456532,-2.88766 +3423.82,0.555677,0.0912059,4,1.5814,1.21271,-0.580446,0.0339534,1.1726,-0.204862,-0.330873,0.0656406,0.749145,-0.423728,-0.533103,-0.387168,-0.734383,0.0422558,-0.301427,0.950558,-0.493421,-0.0764026,-0.0666289,-0.114745,-0.62737,-0.796737,-0.46291,-0.356417,-0.331488,-0.00937071,-0.234124,0.472564,-0.321424,0.114825,0.494692,0.161937,0.0506816,0.195886,-0.0474603,-0.351541,-0.257441,-0.0259251,0.54103,0.0451586,0.865896,0.947363,-0.227234,-0.385166,0.133359,0.283389,-0.176658,0.0256841,0.581979,-0.607324,0.418465,0.862705,0.0847269,-0.264487,0.952298,-0.684705,-0.453213,-1.49458,0.725686,-0.693208,0.0672625,0.902608,-0.401943,-1.54348,-0.589341,0.368026,0.218246,-0.178425,0.704361,-0.481282,-0.0289857,0.17099,0.311246,0.0407118,0.713273,0.292401,-0.0402445,0.277585,-0.423751,-0.0907959,0.236552,-0.144506,-0.0444586,-0.289245,-0.557698,-0.140109,-0.202563,-0.0332046,-0.078483,-0.315693,0.116215,-0.143313,-0.0517703,0.234695,-0.125279,-0.637019,-0.0930927,-0.0244828,-0.150633,0.0507318,0.0671756,0.0790848,-0.213393,-0.384582,0.558492,-0.441073,0.237913,-0.708224,0.33158,0.211179,-0.419598,-0.0623393,0.657894,0.194601,-0.493384,0.46411,-0.21663,-0.161307,-0.0490931,-0.119874,-0.201159,0.117671,0.0777936,-0.0134745,0.281854,0.249183,-0.221496,0.224135,0.674541,-0.0148681,0.0432783,-0.0338314,-0.0915795,0.622885,-0.283084,-0.368963,-0.0219743,-0.224314,0.145284,-0.768683,-0.0619054,-0.261195,-0.147416,-0.644046,-0.218464,0.103668,-0.110306,0.414967,-0.330611,0.236312,0.25258,0.038876,-0.115314,-0.0332698,0.176253,0.203985,0.130768,0.278689,0.142122,-0.355298,-0.0319541,0.187676,0.19162,0.345538,-0.195542,0.695748,-0.122301,0.267988,-0.335485,-0.273351,-0.0877589,0.489668,-0.252317,0.732354,-0.0582399,-0.246892,-0.428328,0.240463,0.0726559,0.453372,0.10977,0.0673164,0.490883,0.0898284,-0.0187698,-0.730717,-0.0355369,-0.200798,-0.28044,-0.90507,-0.189812,-0.873298,0.0254966,-0.642361,0.0175986,0.193119,-0.300478,-0.0307488,-0.395671,-0.215403,-0.0709467,-0.33447,-0.0114099,0.407217,-0.371007,0.0737096,-0.389363,0.729822,-0.329081,0.940661,-0.168179,-0.131157,-0.151628,-0.307529,-0.109299,-0.178358,0.0286694,-0.154063,-0.204315,-0.17514,0.390479,-0.577326,-0.0738023,0.541793,0.155934,0.233844,-0.10063,-0.492162,-0.513814,-0.248306,0.0766855,-0.0738314,0.288768,0.375878,-0.301786,0.347017,0.385893,-0.135611,0.386792,-0.365137,0.103648,0.152908,-9.71834e-05,0.131661,0.480179,0.346341,0.607011,0.206372,-0.099605,-0.542292,-0.44814,-0.585085,0.567393,-0.143273,0.0923934,0.216924,-0.244724,0.0242132,0.542238,0.100092,0.251039,0.28381,0.428614,-0.348298,0.0627762,0.13969,-0.16787,-0.06689,0.0322656,-0.0384682,-0.0206222,0.579208,-0.278563,0.424838,0.0965462,0.0614433,0.0950829,-0.0342333,0.767689,-0.118511,0.24639,-0.512248,-0.247066,0.326686,-0.335931,0.610249,0.12668,0.62288,-0.164113,-0.538221,-0.0873974,0.0733844,0.682461,-0.081385,-0.414195,0.413363,0.501842,0.0715978,-0.159321,0.463553,-0.287847,0.118619,0.30978,0.344411,0.556579,-4.13143 +3435.52,0.885209,0.0912059,4,1.70951,1.04645,-0.457854,0.0745506,0.597706,-0.268731,-0.250878,-0.0896838,0.439425,0.0178759,-0.533435,-0.581169,-0.583196,0.133096,-0.231071,0.655943,0.115448,-0.0600727,0.0296355,-0.456947,-0.414977,-0.722332,-0.713559,-0.203044,0.0307914,0.107009,0.139069,0.363144,0.0270827,-0.320726,0.609748,-0.948477,0.26502,-0.0965365,-0.177856,-0.475444,-0.480623,0.407428,0.713922,-0.323999,1.16374,0.487726,-0.0620184,-0.843479,0.209988,0.221394,-0.949488,0.472707,0.642043,-0.545048,0.150685,0.751158,0.385801,-0.80064,0.701632,-0.168317,-0.546364,-0.442654,0.347084,-0.751941,0.407003,0.896525,-0.222823,-1.52764,-0.165484,0.425945,-0.332573,-0.547849,0.339254,-0.360614,0.165027,0.78206,0.535011,0.158985,0.788394,0.399443,-0.0218455,0.0538529,-0.4183,-0.176951,0.0952143,-0.507315,-0.102986,0.00943329,-0.554717,-0.339892,0.693056,-0.258526,-0.323208,-0.504471,0.274117,0.419618,-0.310768,-0.227645,0.107271,-0.00528254,-0.389532,-0.0119301,-0.0411923,0.108786,-0.0795191,0.0477901,-0.44074,-0.25986,0.416063,-0.244751,-0.339662,-0.37408,0.240949,0.0808418,-0.196117,0.145052,0.358634,0.366496,0.46164,0.558693,-0.060279,0.24772,0.427366,0.103232,-0.704837,-0.0352314,0.514732,-0.0374072,0.0703767,0.493019,0.0138903,0.382589,0.265777,0.0177414,0.198862,-0.0489517,0.187177,0.55481,-0.206317,-0.269271,-0.0968373,-0.175937,0.0395436,-0.810514,-0.342724,-0.206589,-0.00248547,-0.525454,-0.432137,-0.034548,-0.414124,-0.0564712,-0.227942,0.364125,0.0935934,0.344341,0.0659547,0.149612,0.0106622,0.705924,-0.489651,-0.254934,-0.0879765,-0.461161,0.20793,0.0411124,0.290085,0.249615,0.126161,-0.385032,-0.481775,0.0539813,-0.375472,-0.188339,-0.212951,-0.175806,-0.098113,0.0114197,0.105648,-0.340295,-0.452316,0.0207075,-0.0755784,0.769953,0.224683,-0.353735,-0.0264216,0.355497,-0.317611,0.101769,0.41219,-0.225033,-0.0277117,-0.306766,-0.236501,-0.248876,-0.387158,-0.462987,-0.109774,0.11513,-0.00662943,-0.283562,-0.573333,0.192825,-0.190362,-0.355097,0.0309277,-0.0868481,-0.202362,-0.695447,-0.549168,0.70781,-0.0772634,-0.0394698,-0.268638,-0.479234,-0.317242,-0.244098,-0.126603,-0.150691,-0.0318304,0.108137,-0.0231372,-0.407554,0.216694,-0.72572,-0.041778,0.68942,-0.954988,0.197565,0.196089,-0.51238,-0.457087,0.106175,0.173432,0.0853166,-0.106404,-0.162445,-0.141814,0.313843,-0.160109,0.134312,0.561871,0.0604217,0.17073,0.124593,0.348442,-0.0412359,0.472967,0.78191,0.736893,0.258151,-0.237679,-0.438491,0.367074,-0.19993,0.00453676,-0.488656,-0.363814,0.529877,-0.627289,-0.0600867,0.314314,0.106159,-0.553543,0.173524,0.42263,0.199032,0.41271,-0.00797848,-0.0365418,-0.215259,0.252755,-0.0722919,0.00551961,0.192342,0.148165,0.807472,-0.309212,0.236788,-0.0675441,-0.0623985,0.680085,-0.400485,-0.545637,-0.167102,-0.3826,-0.206935,-0.402289,0.930069,-0.196376,-0.0667679,-0.413216,-0.213572,0.279306,0.444593,0.0874199,0.105973,-0.214451,-0.0167936,0.258146,0.134409,-0.0149458,0.0468518,-0.516253,0.124627,0.318678,0.353026,0.564516,-1.88778 +3433.64,0.96792,0.0912059,4,1.48408,1.18682,-0.539163,0.0236002,0.454628,-0.133773,0.58758,0.806513,0.983809,0.392771,-0.270705,0.0990305,-0.0793219,0.171012,-0.650024,1.37095,-0.0596372,0.159027,-0.509641,0.108031,-0.478843,-1.22704,-0.656117,-0.195669,-0.256,-0.0903334,0.59665,0.248888,0.00284513,0.444627,0.609102,-0.76926,0.251247,0.287974,-0.563693,0.600365,0.405702,0.379661,0.506451,0.176388,1.10284,0.596176,0.652184,-0.449123,-0.0359664,-0.366698,-0.837157,0.562537,0.590366,-0.143402,0.102063,0.655067,0.0850524,-0.6587,0.740052,-0.716301,-0.0489138,-0.908422,0.531199,-0.295171,0.218462,0.744274,-0.93547,-1.1106,0.340965,0.0842353,-0.268275,-0.0644756,-0.35835,-0.167282,-0.20136,-0.0156567,0.424432,0.160883,0.303207,0.288275,0.0799695,-0.378087,-0.344287,-0.230163,0.469067,-0.350608,0.222232,-0.150629,-0.370892,-0.217309,-0.278583,-0.156375,0.0140762,-0.33071,0.49741,-0.557039,0.0585903,0.0789926,-0.347828,-0.632925,0.452284,-0.453737,0.13615,0.21493,0.0155182,-0.108287,-0.0117239,-0.259188,-0.459547,-0.272027,0.59525,-0.137505,0.706337,0.700958,-0.00107539,-0.519833,0.245808,0.369116,-0.0500047,-0.249915,-0.501605,-0.169067,0.336767,-0.457548,-0.34346,-0.244395,-0.327899,0.063151,-0.190891,-0.363408,0.0240922,-0.139707,0.259052,-0.603582,0.259602,-0.189953,0.0850531,0.480982,-0.314514,-0.283978,0.330045,-0.127988,0.208749,-0.0532929,0.0363818,-0.0563279,0.0222606,-0.377153,0.38535,0.674696,-0.100033,0.406287,-0.118035,0.166325,-0.728359,-0.180535,0.246727,-0.309755,0.139202,0.142328,0.378652,0.170804,0.0140104,0.413441,-0.008868,-0.125643,0.689292,0.130629,-0.262875,0.204795,-0.340644,0.289926,0.298226,-0.24078,0.430456,0.688136,0.110495,0.600356,0.257455,0.597946,-0.247552,0.262422,-0.151145,1.02983,-0.35856,0.551628,0.305546,-0.403192,0.37251,-0.694162,-0.65052,-0.306746,0.138544,0.2241,0.237294,0.421029,-0.424268,-0.593664,0.0610913,0.549873,-0.326733,-0.640466,-0.217953,0.0305631,-0.0960279,0.0290216,0.0940876,-0.231824,-0.0834811,-0.31041,0.0618263,0.956144,0.159276,0.454569,0.012648,0.231382,0.0637935,0.0429067,0.0114129,0.543842,-0.651145,0.0795275,0.417032,-0.290172,-0.163614,-0.259392,0.68428,-0.162161,-0.0172772,0.127633,-0.183436,-0.203687,0.219769,-0.156812,-0.206152,0.0500697,-0.183426,0.0946088,-0.128489,0.632408,-0.00774951,0.2006,0.559574,-0.358654,-0.29148,0.337308,-0.312711,-0.330177,0.301864,-0.330128,0.366832,-0.0788131,0.705312,-0.0793003,0.374129,-0.574212,0.712981,-0.276346,0.080272,-0.0818804,-0.0352409,-0.265193,0.173508,-0.0508564,0.584799,0.392488,-0.418251,0.296188,-0.117748,-0.0253609,0.108819,0.756532,-0.246001,0.193823,0.182442,-0.41196,-0.734576,-0.253394,0.156225,-0.350432,0.0607243,0.32041,-0.171886,0.545725,0.307171,0.272102,-0.260453,-0.302814,0.242366,0.334955,0.0495584,0.335869,0.215513,0.202142,-0.0318864,0.371403,0.235098,0.109426,-0.00270132,0.0865087,-0.17588,0.0298289,-0.0675466,-0.395329,0.0273999,0.132418,0.299551,0.363893,0.547313,-1.82909 +3446.67,0.982555,0.0912059,4,1.45538,1.23267,-0.36624,-0.0478047,0.320044,-0.121168,0.370671,0.658599,0.654536,0.41414,-0.253715,-0.293804,0.209,0.221245,-0.487605,1.50445,-0.195435,-0.142372,0.0802408,0.111017,-0.5373,-1.11601,-0.750413,-0.329756,-0.086802,-0.00804301,-0.103099,0.532794,-0.0165206,0.054831,0.448113,-0.402486,0.512734,0.100902,-0.121973,-0.0103754,-0.224748,0.922878,0.558073,-0.249053,1.1647,0.277347,0.273824,-0.615402,0.0966327,-0.153875,-0.394123,0.12234,0.518239,-0.267724,0.0621532,0.138195,0.526403,-0.436805,0.652065,-0.011137,0.0736532,-1.08338,0.64015,-0.272502,0.83697,0.779414,-0.219846,-1.36809,0.212782,0.481896,-0.521191,0.467252,-0.154114,-0.00901225,0.00309948,0.531825,0.589947,0.036025,-0.00584517,0.639645,0.265602,0.5369,-0.455302,-0.00561412,0.338103,-0.119385,0.241541,0.0777595,-0.420979,-0.195071,-0.0242198,-0.396167,-0.0777964,-0.154911,0.521211,-0.0781077,-0.124054,0.173365,-0.373511,0.204053,-0.131415,-0.210241,0.0515834,0.217408,-0.152503,-0.272565,-0.626876,-0.236321,-0.257566,-0.0688457,-0.265011,0.0160875,0.709321,0.222431,0.331107,-0.220107,0.115806,0.430668,0.0485997,-0.340555,0.0134429,0.119479,0.220312,-0.0170915,-0.242521,0.267825,-0.0323745,-0.366612,-0.242157,-0.356238,-0.19778,0.0892409,0.0179555,-0.370857,0.00569037,0.43055,0.477942,0.064923,0.163488,-0.0668324,0.254202,-0.165755,0.726294,0.28586,-0.466436,0.0577146,0.168714,0.00543436,-0.450633,0.403895,0.124328,0.084541,-0.298716,0.0158042,0.0731134,-0.0660746,0.298434,-0.26784,-0.219233,0.582252,-0.306001,-0.554268,-0.0383796,0.0471388,-0.131859,-0.457012,0.465247,-0.0823067,0.381447,0.342399,-0.397443,0.0537885,0.416457,0.251074,-0.239652,0.384956,-0.0585171,0.42835,0.0149823,-0.0933369,-0.0805038,-0.171716,0.410514,0.958132,-0.384448,-0.144189,-0.125977,-0.134169,-0.31391,-0.189042,-0.225411,-0.0378687,0.389386,-0.138581,0.0570001,-0.185333,0.157429,-0.109518,0.162282,0.335517,-0.148272,-0.192055,-0.234178,0.381974,0.186595,-0.342708,0.111954,0.113079,-0.0471661,0.00653976,-0.537741,0.94251,-0.365861,0.451918,-0.30376,0.0746779,0.0806713,0.216363,0.19962,0.301225,-0.268654,0.216644,0.705001,-0.0580975,0.151163,-0.725706,0.203512,0.439762,0.0271407,0.470846,0.200947,0.0242751,0.199421,0.0624489,0.134629,0.077626,-0.598332,0.0767887,0.397699,0.217527,0.0126931,-0.0294894,0.746012,-0.0567665,0.590714,0.0217807,0.129269,-0.496342,0.622672,0.22912,0.149784,0.326544,-0.159325,-0.106014,-0.117566,-0.546647,0.387997,-0.118172,-0.280604,0.156452,-0.500482,-0.422682,-0.225777,0.549202,-0.0429975,-0.170012,0.368631,-0.0389996,0.189173,-0.325287,0.0706363,-0.132736,0.19164,0.02154,-0.0751332,-0.213976,-0.50727,-0.327608,0.102357,-0.093516,-0.0319812,0.0948571,-0.100935,0.145929,0.0192402,0.483427,-0.805619,-0.170127,0.179989,0.596741,0.183647,0.638441,-0.087655,-0.0783399,0.163063,0.396342,0.160843,-0.00190339,-0.0470165,-0.5527,0.0514657,0.0456189,-0.179154,-0.0222474,0.273695,0.0951165,0.344345,0.30841,0.586809,-1.51834 +3440.38,0.991065,0.0912059,5,1.51451,1.23889,-0.19249,-0.0864488,0.635461,-0.192228,0.331353,0.677747,0.621689,1.02346,0.14975,-0.126904,0.189952,-0.0712757,0.0419981,0.756807,-0.26276,0.0145861,-0.0831409,0.0329592,-0.809891,-0.9489,-0.459908,-0.419,-0.184284,0.243898,0.532187,0.906408,0.00414967,0.221396,0.448092,0.29555,0.310052,0.254552,-0.319234,0.191947,0.263107,0.704318,0.502846,-0.316903,1.08438,0.365479,0.505412,-0.164468,0.0918689,-0.117521,-0.219002,0.116442,0.762042,0.017947,0.226762,0.0755572,0.0315418,-0.758413,0.619805,0.0119075,-0.0904641,-0.540327,0.48253,0.095713,0.0575534,0.846688,-0.338769,-0.626008,0.192074,0.154124,-0.392288,-0.0562979,-0.00208876,-0.538198,-0.197678,0.440588,0.656217,0.216956,0.582031,0.375655,0.673819,-0.101047,-0.720144,-0.112257,0.372027,0.0288257,0.052676,-0.19863,0.0552724,-0.407302,0.184925,0.223329,0.127399,-0.284274,0.22736,0.27788,0.030455,0.123423,-0.013196,-0.356531,-0.709226,-0.342895,0.151949,0.347861,0.0500545,-0.446686,-0.482919,-0.0965206,-0.0226047,-0.375441,0.0568126,-0.58743,0.405471,0.577316,0.0984993,-0.0618972,-0.105311,0.431158,0.116467,-0.0842377,-0.177846,0.198456,-0.124536,-0.0598326,-0.465824,-0.0905423,-0.397934,0.32206,0.197262,-0.235577,0.550175,0.107459,-0.565972,-1.06052,0.10314,0.0681483,0.0786346,0.281348,-0.0897629,-0.611919,-0.194776,-0.351142,0.445172,-0.388221,-0.594516,-0.0792126,-0.0910416,-0.201602,-0.421702,-0.0136868,-0.0395585,0.113336,-0.13896,-0.631986,-0.433931,0.0907725,0.380386,0.408434,-0.0374973,-0.274057,0.108289,0.176736,-0.275352,-0.0210483,-0.12196,0.251138,0.602463,0.00453462,0.291283,0.178646,-0.354166,-0.555276,-0.0633973,0.319355,0.342142,0.0785554,0.273164,-0.165983,0.0370587,0.0747171,-0.170706,-0.232796,0.0840194,0.98162,-0.276132,0.218467,-0.0739428,-0.250333,-0.628186,-0.266496,-0.224117,-0.53625,0.212153,-0.0135371,-0.302503,0.290039,0.016872,-0.264066,-0.107018,-0.0633739,-0.56478,-0.132785,-0.645472,0.516173,0.277051,-0.00984495,-0.278371,-0.00261379,0.451811,-0.715991,-0.877081,1.0903,0.0924341,-0.227563,-0.0869123,-0.272206,0.0231893,0.00224078,0.072565,0.136643,0.0951826,0.137479,0.101604,-0.137282,-0.383481,-0.119546,0.031574,-0.411134,0.0115122,0.255106,0.150721,0.100099,0.138149,0.0642052,0.0847097,0.330478,-0.247425,-0.468542,-0.272455,0.209911,0.344939,0.290915,0.409118,0.182118,0.139564,-0.237135,-0.472408,0.318761,0.579728,0.199327,0.0668328,0.060208,-0.243489,0.132688,0.434154,-0.248209,0.612205,-0.422544,-0.165138,-0.0545531,-0.0554744,0.297504,-0.169651,0.146888,0.215845,-0.278727,0.524575,0.372111,-0.0618142,-0.0417292,-0.142434,-0.15877,-0.157275,0.0573116,-0.456415,0.0411411,-1.07127,-0.106043,0.16564,0.0572963,0.117177,-0.554447,0.0397273,0.255048,-0.263541,0.677401,-0.480517,-0.00299087,0.0209114,0.329456,0.0972262,0.372993,0.148988,0.201573,0.235213,0.0995754,0.216743,0.0279939,0.256476,-0.271648,0.0540812,-0.397272,0.0217892,-0.374302,0.203992,0.122738,0.200005,0.35034,0.447219,-2.55421 +3440.61,0.946565,0.0912059,4,1.5173,1.11307,-0.110612,-0.113326,0.727286,-0.0332727,0.507324,0.0896789,0.264813,0.222404,0.144029,-0.310032,-0.0518215,0.321665,-0.376382,0.980479,-0.0457668,0.057201,-0.0653042,0.406598,-0.490851,-0.636076,-0.825899,-0.463767,-0.0246898,0.0299714,-0.00925227,0.469648,0.00254972,0.321849,0.714034,-0.563945,-0.019783,0.170659,0.283726,-0.0864783,0.0806935,0.51821,0.432712,0.0851824,1.03546,0.263379,0.139757,-0.588427,0.215978,0.349965,-0.621842,-0.0579137,0.783707,0.0284675,-0.108258,0.285497,-0.0133811,-0.531347,1.0294,0.267298,0.422955,-0.865612,0.594457,-0.624967,-0.199546,0.989458,-0.549287,-1.53602,0.382796,0.19544,-0.525553,-0.224082,0.107483,-0.338289,-0.52999,0.651907,0.435065,-0.0188414,0.624092,0.323967,-0.161899,0.226371,-0.503407,0.189056,0.38334,-0.567609,0.465592,0.0856343,-0.539807,0.319558,0.05986,0.170199,0.127672,-0.427377,0.150445,-0.239622,0.308967,-0.191837,0.0508445,-0.392715,-0.382818,0.544002,-0.172358,-0.0704948,0.46365,-0.709675,-0.183205,-0.296682,-0.319849,0.166852,-0.0216901,-0.467418,0.302045,0.673605,-0.143313,-0.280015,0.113479,0.541562,-0.115821,-0.16836,-0.160325,0.169465,0.343046,0.372103,-0.567195,-0.103477,-0.122295,-0.0981962,0.227588,-0.581653,0.373064,0.229257,-0.162304,-0.284155,0.151527,-0.222478,-0.0440022,0.322177,0.231363,-0.28511,0.230669,-0.525534,0.516993,-0.678654,0.00639361,0.150024,-0.00673639,0.0285285,-0.540777,-0.0420913,0.0453292,-0.178079,-0.154707,-0.173139,0.299358,-0.36687,0.177492,0.0639378,0.165424,0.112232,0.405504,-0.177447,-0.0213525,-0.183284,0.353169,-0.65714,0.690185,-0.219311,0.0184009,-0.207311,-0.608403,-0.315878,0.085372,-0.517649,0.594145,0.0339918,0.036344,-0.072143,0.196283,-0.232085,-0.156327,-0.205751,0.0700974,0.909469,0.389415,-0.0318524,-0.401151,0.296223,-0.110322,0.0591989,-0.554435,-0.318492,0.69041,0.0219436,0.0496836,0.127334,0.089077,-0.309678,-0.187159,0.116296,-0.623201,-0.00489996,-0.0976664,0.0654581,0.182143,-0.160908,0.401787,0.0248168,-0.16559,-0.370289,-0.451366,0.818119,-0.269115,-0.193105,0.0976881,0.0505027,0.0244582,0.0977864,0.0322689,0.0217412,-0.0837715,-0.00389859,0.532069,-0.227401,0.229234,-0.520997,0.114592,0.0613441,-0.440704,-0.00545475,0.227203,-0.355878,-0.163823,-0.289299,0.48381,0.0611514,-0.317361,-0.124539,0.219351,0.677147,-0.128034,0.610256,0.652869,0.171762,0.308446,0.302143,-0.502867,0.115848,0.0785994,0.563604,0.0506876,-0.175284,0.0539482,-0.15928,0.292235,-0.606521,0.121836,-0.175487,-0.137795,-0.225764,-0.0771488,0.0890337,0.161159,0.513669,-0.0607647,0.359854,0.254815,0.058741,-0.235325,0.0834489,-0.0597091,-0.116063,-0.393842,-0.283921,-0.371561,-0.168424,-0.419458,0.356187,0.165123,-0.010556,0.223815,-0.11132,0.0511501,0.00760207,0.10853,0.0757447,-0.85295,-0.116332,-0.183276,-0.00422004,-0.112464,0.0899077,-0.309683,-0.12082,0.0757548,0.0424064,-0.450174,0.862819,-0.145382,-0.829452,0.446398,-0.531597,-0.00735668,0.38717,-0.680268,0.0993337,0.215577,0.315172,0.464303,-2.69108 +3450.39,0.938603,0.0912059,4,1.55908,0.913409,-0.687581,0.229933,0.386049,-0.182493,-0.306061,0.47579,0.512649,0.303579,-0.0535461,0.0265245,-0.0381533,0.294794,0.0375003,0.644264,0.150349,-0.00262028,0.0471037,-0.0532697,0.198912,-1.26798,-0.473942,0.242553,-0.265834,-0.336649,0.278662,0.253477,-0.349983,0.234126,0.746391,-0.255269,0.16805,0.155203,-0.469227,-0.190481,-0.401735,0.462585,0.430812,-0.187602,0.999885,0.680125,0.213819,-0.541259,-0.11641,-0.345953,-0.363288,0.266035,0.0748975,0.273477,-0.149529,0.131108,-0.121192,-0.365253,0.616957,-0.23199,-0.303932,-0.935803,0.636475,-0.27197,0.236433,0.377105,-0.556374,-0.077555,0.159664,0.116385,0.348401,0.0247172,0.00134612,-0.608823,-0.0456522,0.0416747,0.776767,-0.347805,0.308805,0.476498,0.476313,-0.179104,-0.403832,-0.268223,0.415927,0.0232662,0.0370965,-0.104543,0.210969,-0.507872,0.245413,-0.854662,-0.341108,-0.224501,0.0556406,0.360421,-0.415518,0.182721,-0.103614,-0.0866987,0.329559,-0.826227,0.0603259,0.371972,-0.305643,0.682657,-0.442319,-0.511417,0.224438,-0.445049,0.163361,0.0337144,0.00611648,0.554189,-0.172288,0.471037,0.391401,0.549105,-0.242493,0.0624922,-0.0218028,-0.0584655,-0.108924,-0.170159,-0.337996,0.0262874,-0.110002,-0.338891,-0.0837467,0.182877,-0.0713969,0.0974736,0.127866,-0.252459,-0.132569,0.292072,0.156237,0.326085,-0.564618,0.134735,-0.118189,-0.206056,0.1406,0.0832684,-0.246523,-0.0213912,-0.0552822,-0.202348,0.582495,0.214254,-0.165607,0.392393,-0.144156,0.140612,-0.275804,0.356657,0.475489,-0.185595,-0.00115232,0.208755,0.0646137,0.027639,0.11818,-0.00174967,-0.0270062,0.351103,0.631231,0.20365,-0.0210647,0.314579,0.336259,0.170015,-0.00550491,0.551948,0.122991,0.213186,-0.0872183,-0.257133,-0.279807,0.539643,-0.2952,0.2561,0.447164,0.741789,-0.315156,-0.44215,0.181413,-0.365847,-0.200095,-0.205429,-0.148938,-0.443071,-0.417414,-0.618541,0.121602,-0.121513,0.00694187,-0.400579,0.232762,-0.0805965,0.219936,-0.441107,-0.708593,-0.156148,-0.104232,-0.391699,-0.0256082,-0.022384,0.0814034,0.449732,-0.346165,0.968598,0.534746,0.457854,-0.267845,0.0449514,0.0581687,-0.0618735,-0.423035,0.182365,-0.504777,0.179871,-0.237264,-0.35332,-0.34612,-0.402405,0.0529612,0.187366,0.0348335,0.57625,-0.955083,-0.00213975,0.149561,0.712285,-0.774632,0.05026,-0.0620037,-0.374408,0.0475267,0.0466495,0.41817,-0.472683,0.669112,-0.398062,-0.568796,-0.331323,0.264054,-0.0322127,0.574221,-0.45661,0.327802,0.426708,-0.307256,-0.227898,-0.195586,-0.218256,0.573812,-0.321381,-0.128064,-0.0286102,-0.27674,0.233488,-0.141478,-0.24716,0.424894,0.196364,-0.24812,0.161443,0.302694,-0.21584,-0.00583259,-0.10046,0.346133,0.19718,0.29444,0.01605,0.104004,-0.184067,-0.113613,-0.169476,-0.105199,0.266725,0.437842,0.0503466,-0.239747,-0.222264,0.585419,0.220261,0.172371,0.110803,0.0907095,0.187339,0.666483,0.0432158,0.082362,-0.196258,0.381899,-0.481194,-0.022697,0.51503,-0.242391,0.5907,-0.202843,-0.441983,0.116073,0.104612,0.182146,0.323437,0.426786,-1.14855 +3429.27,0.800441,0.0912059,4,1.57836,0.955439,-0.820832,0.337135,0.29675,-0.255207,0.684299,-0.439503,-0.0838782,0.242147,-0.0159294,0.110016,-0.141346,0.754454,0.0148583,0.710135,0.314565,-0.35957,-0.0521483,0.204932,-0.130437,-0.475769,-0.834107,0.250166,-0.103871,0.33564,-0.396868,0.232428,-0.0169181,-0.222646,0.782553,-0.288497,-0.523535,-0.212196,-0.265431,-0.497291,-0.45841,0.427565,0.46353,-0.0193868,1.10088,0.216639,0.234447,-1.06867,-0.00770576,0.176932,-0.589525,-0.0229246,0.380367,0.0848537,0.0508798,0.587887,-0.0343612,-0.437932,0.587527,0.00345562,-0.108812,-0.380655,-0.0189673,-0.816241,-0.207595,0.781109,-0.432912,-1.37175,0.265266,-0.256674,-0.552657,0.0665935,0.0484033,-0.256851,-0.341324,0.618418,0.103406,-0.0607023,0.617066,0.272751,0.17856,0.0643551,-0.102843,-0.0729683,0.430169,-0.0468856,-0.0616146,-0.135742,-0.86031,0.510154,-0.0689178,0.371245,0.608811,-0.44761,-0.52693,-0.127097,0.594056,-0.14082,0.165942,-0.135013,-0.127365,0.118045,-0.0924938,-0.0412418,0.487862,-0.859992,-0.0447807,-0.114234,0.177806,0.105042,0.312202,-0.434931,-0.0924358,0.684192,0.0658033,-0.659293,0.0962792,0.116887,0.099287,0.271296,-0.452577,0.253861,0.591017,0.316301,-0.613736,-0.479587,-0.0855026,-0.0863455,-0.280885,0.231157,0.552493,-0.0570566,0.00718813,-0.766544,0.389255,-0.566839,-0.397308,0.588963,-0.0103175,-0.32975,-0.208444,-0.169578,0.272201,-0.764421,-0.416184,-0.413068,0.45452,-0.450853,-0.40515,-0.123255,0.0635936,0.0612448,-0.162764,-0.74226,0.362626,-0.0476255,-0.210317,0.185882,0.10922,0.314259,-0.0539504,-0.266807,-0.237232,0.20952,0.0506435,-0.436293,0.450486,0.115462,-0.0447733,-0.446661,-0.425152,-0.785221,-0.0286992,-0.871161,0.335226,-0.130305,-0.337276,0.186583,0.22605,-0.479958,-0.10604,0.102071,-0.0813464,0.755524,0.227747,0.0889909,-0.116296,-0.00496437,0.346115,-0.481345,-0.464874,-0.313573,0.390062,0.0933304,-0.239328,0.127776,-0.144694,-0.488315,-0.0631231,0.264917,-0.242793,-0.253105,-0.145166,0.456042,-0.384599,0.00146165,0.148777,0.234227,0.0648973,-0.637614,-0.373147,0.866391,-0.587772,-0.0852822,0.523143,-0.125189,0.137341,0.600622,0.242309,0.217676,-0.175238,-0.114143,0.321316,-0.150526,0.374243,-0.376665,-0.0379997,-0.0144131,-0.469001,0.198286,-0.111648,-0.388581,-0.2313,-0.543069,-0.0298886,-0.115554,-0.12427,0.0533593,-0.323323,0.801237,-0.320682,0.674247,0.498427,-0.309733,0.330083,-0.00449932,-0.622386,0.107183,-0.0353278,0.444125,0.250963,-0.371997,-0.0602286,-0.548584,0.0188373,-0.574669,0.0945245,0.226317,-0.124852,0.432225,-0.377795,0.102763,0.380408,0.0681708,-0.109328,0.19976,0.597193,-0.0445842,-0.16743,0.686434,0.0100923,0.0799295,0.27715,0.0473623,-0.228465,-0.0947794,-0.292886,0.0709468,-0.191865,-0.578457,0.16884,-0.0389961,0.0486826,0.164071,0.018864,0.0783005,-1.33422,-0.112473,0.0824873,-0.133755,0.0108404,0.149288,-0.214793,0.0722188,-0.201048,0.0773545,-0.251862,0.405043,0.123174,-0.788425,0.178805,-0.402033,-0.283318,-0.0429907,-0.0222442,0.122562,0.221963,0.350089,0.47113,-0.920602 +3435.7,0.821883,0.0912059,4,1.59272,0.92835,-0.689843,0.329788,0.37937,-0.161697,0.313056,0.106033,0.248287,0.126798,0.0643877,0.321136,-0.0271126,0.822155,0.172924,0.825125,0.127801,0.137189,0.0273614,-0.171681,-0.115977,-0.667072,-0.363951,0.189547,-0.487129,0.497788,-0.193173,0.444696,0.366419,0.00362409,0.574713,-0.334833,0.311868,-0.0870064,-0.371742,-0.370233,-0.367277,0.550831,0.439734,-0.168681,0.986096,0.295522,-0.197062,-0.707102,-0.276173,0.0617734,-0.571716,0.182402,0.24449,0.0820439,0.0838916,0.571428,0.194855,-0.860311,0.432221,-0.191022,-0.133074,-0.413216,0.140701,-0.429543,0.168071,0.731605,-0.963008,-1.05611,0.479486,-0.439828,-0.387667,-0.042157,-0.486352,-0.347658,0.0157078,0.0746763,0.158987,0.152455,0.55308,0.393154,0.360558,0.259561,-0.48954,-0.238212,0.63047,0.251006,0.359366,0.204583,-0.462909,0.44311,-0.286256,0.238522,0.100558,-0.114333,-0.114233,0.355584,0.556991,-0.268188,0.240813,0.111831,-0.344048,-0.0211893,0.264778,-0.263608,0.228325,-0.666738,-0.595287,-0.583327,0.613977,-0.241375,0.13063,-0.0120767,-0.219651,0.556172,0.170918,-0.575766,0.0368488,0.18788,-0.122703,-0.0243311,-0.367377,0.374557,0.328169,-0.0180165,-0.703024,-0.424477,-0.316144,0.00407283,-0.247015,0.277679,0.781992,-0.224843,-0.166283,-0.93336,0.436951,-0.276836,-0.242415,0.566987,-0.0156306,0.176008,-0.164775,0.0237172,0.0852958,-1.042,-0.327196,-0.0846107,0.47563,-0.287208,-0.195064,0.0200407,-0.325895,0.604044,0.0275024,0.193795,0.0631818,0.502604,-0.267157,0.252799,0.492171,0.0696145,-0.0804673,-0.393261,-0.250131,-0.0295248,0.0178136,0.14652,0.627423,0.226597,0.173991,-0.351346,-0.305765,-0.619277,-0.0213868,-0.469554,0.0800449,-0.64454,-0.0507554,0.129178,-0.130338,-0.416859,-0.108483,-0.0181529,-0.220485,0.589249,0.119016,-0.169424,0.353588,0.412462,0.538348,-0.553292,0.137736,-0.156198,0.141707,0.328599,-0.237797,-0.0292455,-0.167432,-0.606445,0.304996,-0.119302,-0.0308441,-0.249551,-0.560853,0.467418,0.143392,-0.0606408,-0.0847429,0.255273,0.103242,-0.456512,-0.573491,1.02588,-0.488908,0.176473,0.617117,-0.0558423,0.523554,0.731455,0.167171,0.353256,-0.103915,-0.223908,0.264987,-0.193012,0.103303,0.0877713,0.0257903,-0.0377537,-0.478436,0.0499967,0.0150644,-0.472263,0.139107,-0.290499,-0.402299,0.123545,0.220937,-0.3888,-0.661385,0.45636,-0.0667543,0.664343,0.419294,-0.449221,-0.0900468,-0.0533582,-0.353799,0.169002,0.426326,0.379728,0.221826,-0.00569461,0.154057,-0.787302,-0.323313,-0.896266,0.680529,0.250569,0.017882,0.293594,0.0415771,0.277197,0.477676,0.0479428,0.116289,0.321653,0.220268,-0.272622,-0.0350454,0.70731,0.126549,0.0819041,-0.050871,0.497233,0.142187,0.150291,-0.343297,0.00613711,-0.240364,-0.21877,0.139842,-0.291703,0.0644349,0.0296809,0.215147,0.545737,-1.23136,0.0269263,0.150576,-0.101014,0.18295,0.25469,-0.0979539,0.470288,0.0657672,-0.0334333,0.0157346,0.047577,-0.0090918,-0.701782,0.0390882,-0.441312,0.0273606,-0.510639,0.0530284,0.130529,0.19427,0.361288,0.440761,-1.21787 +3423.45,0.794977,0.0912059,4,1.52577,0.993764,-0.883195,0.397589,0.379884,-0.130246,-0.313023,0.13139,0.098028,0.534598,0.157245,0.264492,-0.253298,0.839005,0.0599128,0.771868,0.210203,-0.236927,0.125212,0.216498,-0.101043,-0.801115,-0.1166,0.239067,-0.152868,0.515794,0.159879,0.538703,0.231199,0.374739,0.847623,0.021353,0.0113786,-0.19181,-0.695282,-0.604547,-0.299579,0.859913,0.294829,-0.383361,1.17253,0.518313,0.412729,-0.830057,-0.218872,-0.37739,-0.502082,0.312047,0.435174,0.19677,-0.11548,0.570623,0.300103,-0.492774,0.223729,-0.228941,-0.156989,-0.493858,0.150134,-0.30233,0.0618236,0.535374,-0.740283,-1.25778,0.996132,-0.25129,-0.313292,0.0818871,-0.338027,-0.392408,0.325753,-0.299913,0.192203,-0.321189,0.528578,0.426547,0.177121,-0.416932,-0.392724,-0.207429,0.294854,-0.0405569,0.129491,0.0251463,0.04876,-0.086559,0.395731,-0.3964,0.0151629,-0.119371,0.026419,0.0814422,0.390683,-0.213883,0.0403996,-0.32952,-0.518675,-0.28418,0.034145,-0.0530652,0.0783351,-0.336253,-0.638951,-0.489469,0.263111,-0.336943,0.0275755,0.158822,0.131058,0.348349,-0.369914,-0.323092,-0.0594874,0.375292,-0.50722,0.115204,-0.380415,0.346146,0.197833,-0.266312,-0.641347,-0.840545,-0.232911,-0.0680235,0.0327878,0.281541,0.35622,-0.7651,0.0230097,-0.783256,0.0745315,-0.552938,-0.418049,0.357831,0.169827,0.0107988,0.243583,-0.153177,0.0997669,-0.962404,-0.400887,0.0589364,0.102976,-0.24319,-0.225794,0.109967,-0.74826,0.365707,-0.0879795,0.202741,-0.0937162,0.511094,0.356931,0.0538501,0.051857,-0.193538,0.0580406,-0.135237,-0.330697,0.346756,0.0939944,-0.11336,0.594925,0.388498,-0.183358,-0.173662,-0.134747,-0.238418,0.0111725,-0.323696,-0.0868366,0.0595175,-0.0852019,-0.163242,-0.580622,-0.686019,-0.34004,-0.295173,-0.138205,0.795496,0.236773,-0.35533,0.234971,0.479218,0.336274,-0.794781,0.210649,-0.361902,0.136785,-0.459803,-0.39725,0.0251918,0.377795,-0.577386,0.125184,-0.0234235,0.0337317,0.030502,-0.79228,0.00204487,-0.433529,0.328088,-0.34188,0.333352,0.161229,-0.795365,-0.506653,0.977009,-0.401618,-0.0646038,0.558596,0.0945637,0.214846,0.456246,0.529715,0.294189,-0.309737,0.0129086,0.0262598,0.179657,-0.0363937,-0.490489,-0.255626,0.355998,0.145266,-0.0472435,-0.0640997,-0.231641,-0.0696413,-0.181139,0.0833368,0.0226187,-0.0420995,-0.639217,-0.578925,0.295316,0.0613992,0.703347,0.527588,-0.533748,-0.029984,-0.09013,-0.272656,0.296077,0.391039,0.446551,0.354262,0.116966,0.383056,-1.00712,-0.490449,-0.790997,0.353505,-0.109727,-0.0710507,0.349761,-0.130905,0.19831,-0.0472764,0.0568469,0.485525,0.277903,0.595964,0.392219,0.344889,0.0564137,0.0877177,-0.0687363,0.0711487,0.241263,-0.0457057,0.484792,-0.432638,0.172593,-0.514319,-0.323738,-0.257141,0.00914878,-0.31406,0.261042,-0.260917,-0.0531412,-0.922421,0.211155,0.0144496,0.32,-0.147302,0.145589,0.105398,0.254098,-0.000550362,-0.236158,0.194528,-0.207966,0.176116,-1.0992,0.206924,-0.509599,-0.144328,0.163984,-0.105815,0.126466,0.170012,0.355621,0.412326,-1.37274 +3429.52,0.64783,0.0912059,4,1.52996,0.891328,-0.803887,0.297796,0.220947,-0.198511,0.0479634,0.406906,0.859192,0.365387,0.113949,-0.0996606,0.306736,0.884756,0.190323,1.36202,0.0174535,0.0132467,0.253919,0.00884601,0.121606,-0.540523,-0.781736,0.441741,-0.604211,0.0108435,0.484222,0.190383,0.252728,-0.329115,0.667432,0.0865326,0.350848,0.0471619,-0.646184,-0.0528999,-0.300312,0.0653237,0.286365,0.0233149,0.841408,0.448775,0.169088,-0.683762,-0.23727,-0.135496,-0.0429276,0.392835,0.205187,-0.0338675,0.136112,0.259411,0.388786,0.262701,0.516801,-0.213289,0.00281508,-0.255122,0.357071,-0.262156,0.138151,1.13402,-0.608512,-0.710288,-0.10598,0.429209,-0.254518,-0.440578,0.227355,-0.354693,-0.0112668,0.314428,0.483684,-0.288293,0.191694,0.469421,0.16964,-0.433878,-0.122406,-0.0924766,0.580699,-0.476083,0.2128,0.285921,-0.241517,-0.476118,-0.302261,-0.238413,0.1551,-0.368607,-0.355708,-0.0995869,0.4114,0.388506,-0.274575,-0.186712,0.481878,-0.251571,0.285285,0.190912,0.398799,-0.156938,-0.860287,-0.37921,0.503146,-0.365098,0.0977048,-0.0227722,0.223266,0.582795,-0.209005,-0.610157,-0.080529,0.460556,0.276263,0.263017,-0.54615,0.147223,0.183638,-0.64897,-0.608438,-0.0979238,0.22353,0.0517769,0.150929,-0.248816,0.205048,0.197742,0.47756,-0.217495,-0.0404727,-0.352732,-0.2802,0.0789281,0.186292,0.298703,0.0924767,0.00444802,0.269924,-0.770408,-0.595625,-0.187484,-0.354687,0.175324,0.0421808,-0.439451,-0.541832,0.363537,-0.168498,0.0433217,-0.434783,0.457792,0.524064,-0.025677,0.18559,0.432517,0.254399,-0.456712,-0.201143,-0.0159881,0.495517,-0.0768025,0.874232,-0.52509,0.37289,0.192339,-0.333199,-0.57275,-0.433476,-0.393213,-0.573736,-0.246822,-0.0389978,-0.105798,-0.291905,-0.595729,-0.622282,0.325408,-0.136037,0.767213,0.278253,-0.477896,-0.00844013,-0.0791017,-0.345455,0.109931,-0.621354,-0.536366,-0.51228,0.116424,-0.281814,-0.315243,-0.0663085,-0.0688469,0.269348,0.104294,0.358693,-0.617797,-0.705529,-0.0113868,0.033246,0.447575,0.0460996,-0.353968,0.441087,-1.06671,-0.33428,1.07888,-0.364887,0.0907372,0.245742,0.018766,0.483394,-0.0379508,-0.20189,0.36058,-0.096975,0.166424,-0.278963,-0.692248,0.319383,-0.0401736,-0.2427,0.0753847,-0.534409,0.293774,-0.686765,-0.204454,0.162621,-0.252974,-0.220521,0.0779427,0.14503,-0.514233,-0.488658,0.509105,-0.51536,-0.395822,0.483261,-0.372482,-0.7091,-0.0789904,-0.280076,-0.120385,0.617064,-0.128484,0.079071,0.373545,-0.277573,-0.562274,-0.0995599,-0.700261,0.726274,-0.169259,-0.252878,0.00132005,-0.392022,0.150033,0.153628,-0.0654377,0.626365,0.179786,-0.123863,-0.111223,0.33735,0.0201584,0.346545,-0.270762,0.225079,0.250278,-0.00434302,0.250983,-0.224065,0.162924,-0.00513053,-0.358238,0.295003,-0.478877,0.043846,-0.0211358,-0.431854,0.186774,-0.443073,0.0492036,0.425992,-0.0478684,0.574486,-0.250033,0.115195,-0.656008,0.255548,-0.11063,-0.180776,-0.253977,-0.194732,-0.547371,-0.242172,-0.20454,-0.328978,-0.0374201,-0.326364,0.142286,0.319509,0.377208,0.565251,-0.589779 +3420.69,0.734289,0.0912059,4,1.52329,0.863389,-0.619431,0.276442,0.355284,-0.177504,-0.108177,0.28911,0.870907,0.349705,0.0442479,-0.0298432,0.288728,0.884069,0.319412,1.20897,-0.158762,0.0565079,0.279758,0.0386272,0.0580243,-0.355572,-1.12072,0.309442,-0.422073,-0.0364194,0.569975,0.431266,0.222813,-0.193696,0.635922,0.0853018,0.343389,0.133578,-0.592477,0.00391289,-0.416358,0.197487,0.318089,0.043605,0.97641,0.43518,0.383545,-0.687498,-0.370372,0.231728,0.0496968,0.617213,0.304679,-0.0470234,0.213572,0.0570951,0.359811,-0.000991598,0.639705,-0.229542,-0.00214197,-0.432654,0.337308,-0.503129,0.240658,1.03163,-0.44833,-0.656053,-0.217324,0.52688,-0.374481,-0.260583,0.265642,-0.369364,-0.308701,0.448435,0.241677,-0.266591,0.289395,0.606204,0.306316,-0.684205,-0.1595,-0.0474394,0.482954,-0.538611,0.209262,0.23676,0.0687628,-0.667338,-0.301149,-0.0645303,0.331043,-0.0629774,-0.207762,-0.0444617,0.292696,0.34186,-0.154841,0.123706,0.592151,-0.142706,0.0985707,0.0720511,0.587513,-0.0840203,-0.929171,-0.214687,0.323553,-0.211813,0.189969,-0.0850628,0.25879,0.360643,-0.0299393,-0.696586,-0.149708,0.334065,0.122017,0.42599,-0.463907,0.310143,0.233245,-0.496399,-0.69024,-0.170419,-0.0469722,-0.00636142,-0.0903441,0.00171883,0.217821,0.272199,0.696699,-0.14422,-0.0421527,-0.33346,-0.164758,-0.119188,0.21613,0.249369,0.104618,-0.192505,0.421933,-0.743489,-0.851532,-0.345325,-0.152833,0.157867,-0.136081,-0.484506,-0.711629,0.488913,-0.197162,0.291278,-0.36098,0.0408645,0.732504,-0.115258,0.0806361,0.432397,0.476777,-0.37035,0.0266354,0.0379854,0.800399,-0.046386,0.910533,-0.398516,0.31256,0.143642,-0.207097,-0.20427,-0.484397,-0.152858,-0.289982,-0.351187,-0.00627752,-0.188445,-0.282953,-0.787413,-0.45418,0.31188,-0.254319,0.761546,0.124323,-0.472503,-0.148792,-0.00229031,-0.572232,-0.0687819,-0.829109,-0.694483,-0.259344,-0.162771,-0.185205,-0.444127,0.00576814,-0.264978,0.510876,-0.0699381,0.254756,-0.553295,-0.605938,-0.135758,-0.113945,0.40129,0.048644,-0.194808,0.277264,-0.878815,-0.3029,1.24562,-0.399253,-0.110783,0.224285,-0.00759998,0.341279,0.0803146,-0.2078,0.190006,-0.10157,0.0640799,-0.509248,-0.741137,0.45132,-0.0912435,-0.375239,0.203843,-0.300239,0.520888,-0.620829,0.0820561,0.0959523,0.0841801,-0.295197,0.234717,0.12555,-0.196026,-0.640342,0.463203,-0.545231,-0.158803,0.57885,-0.334066,-0.651957,0.0846372,-0.129153,-0.097571,0.701734,-0.288935,0.12488,0.429961,-0.224239,-0.41941,-0.322865,-0.582787,0.638829,-0.294909,-0.306609,0.0120618,-0.221814,-0.0590885,0.0783043,-0.032841,0.949037,0.36287,-0.0168418,-0.0734313,0.341861,-0.0375001,0.382236,-0.24723,0.095124,0.576157,0.013159,0.357176,-0.293143,0.397497,-0.168259,-0.400844,0.251229,-0.469996,0.0532847,0.205176,-0.513835,0.118704,-0.333272,-0.019948,0.503152,0.0393244,0.0116608,-0.103592,0.0205449,-0.448444,0.28523,-0.315466,-0.032744,-0.310259,-0.235867,-0.476697,-0.28023,-0.146432,-0.320651,-0.126971,-0.200922,0.124614,0.273534,0.353007,0.523005,-1.07494 +3427.74,0.889672,0.0912059,4,1.511,0.898037,-0.656447,0.269988,0.346962,-0.151596,0.056373,-0.00169355,0.67651,0.284414,0.0651505,0.0442777,0.236601,0.524201,-0.136279,1.0794,-0.0109671,-0.334711,0.295869,0.192429,0.0264946,-0.429534,-0.552067,0.45261,-0.395503,0.202372,0.56136,0.470268,-0.0466729,-0.0930721,0.611247,-0.25411,0.26055,0.0635505,-0.651276,-0.21949,-0.661345,0.0615259,0.30664,0.0499104,1.12557,0.348496,0.436243,-0.975345,-0.376179,-0.163561,0.138054,0.522061,0.295514,-0.0577155,0.293124,-0.158649,0.524636,-0.0923574,0.589354,-0.19795,-0.0340901,-0.459187,0.435737,-0.385452,0.431475,1.07406,-0.397065,-0.850923,0.00399459,0.319302,-0.194967,-0.422751,-0.228178,-0.583194,-0.113001,0.414686,0.301332,-0.0675606,0.107953,0.613745,0.340446,-0.127307,-0.248386,-0.325861,0.484997,-0.303354,0.0841206,0.298792,0.053502,-0.118796,-0.0788175,-0.18827,0.335429,0.0802127,-0.132207,-0.250741,0.201017,0.113895,-0.409774,-0.382199,0.634682,0.0561466,0.234919,0.139832,0.158314,-0.273336,-0.580751,0.312794,0.305789,-0.0643216,-0.0089107,0.214238,0.294675,0.612844,-0.258538,-0.535636,0.106738,0.610816,0.063508,-0.0473401,-0.0640021,0.313598,0.333853,-0.317995,-1.06966,0.0200115,-0.201665,-0.00673799,-0.0041851,-0.33553,-0.221651,0.473858,0.342141,-0.286986,0.230704,-0.563984,-0.199742,0.153105,0.234202,0.235087,0.166876,-0.442571,0.547385,-0.693213,-0.701534,-0.0888223,0.131022,0.027621,-0.357731,-0.466839,-0.465388,0.804452,0.184155,-0.185269,-0.100162,0.102696,0.69048,-0.319084,-0.0870933,0.183266,0.250695,-0.317774,-0.0592814,0.179269,0.81221,-0.0345328,0.94518,-0.580721,0.280223,0.286554,-0.308859,-0.1512,-0.793138,-0.327812,-0.326977,-0.0461568,-0.0335143,0.21361,-0.40498,-0.575345,-0.255389,0.51144,-0.361491,0.763474,0.0837482,0.189802,0.147798,0.0504141,-0.347443,-0.346756,-0.741728,-0.547153,-0.175647,-0.151076,-0.112615,-0.25704,0.111783,-0.272714,0.364739,0.0270836,-0.210521,-0.455942,-0.563452,-0.188236,0.0483412,0.166807,0.239277,-0.307219,0.0755799,-0.489059,-0.344843,1.08287,-0.0179138,-0.042431,0.163667,-0.0109009,-0.00442193,-0.184304,-0.170202,-0.0174135,-0.088995,0.0600464,-0.57206,-1.12776,0.706045,-0.277287,-0.262316,0.221713,-0.172201,0.503504,-0.371286,-0.0397866,-0.33452,0.127856,-0.528627,0.150182,0.0456164,-0.0531275,-0.500771,0.425216,-0.304851,-0.158778,0.40944,-0.308454,-0.603807,0.39045,-0.291884,0.146442,0.392977,-0.16739,0.298841,0.415432,0.104229,-0.379532,-0.699155,-0.574904,0.596835,-0.132424,-0.478641,-0.15959,-0.563617,-0.118632,0.0315685,0.0306144,0.837304,0.418541,0.0673489,-0.276626,0.416466,0.296532,0.0856167,-0.141126,-0.067277,0.632456,0.171838,0.400726,-0.00465392,0.151593,-0.250583,-0.735465,0.0658289,-0.178596,0.0810162,0.0770946,-0.501611,-0.126366,-0.363886,-0.272041,0.563036,0.0849088,-0.0558166,0.0641386,-0.180447,-0.547071,0.0181762,-0.123393,-0.382555,-0.1953,-0.0208303,-0.73106,-0.230129,-0.397609,-0.0848884,-0.358577,-0.157151,0.134171,0.211684,0.366294,0.460092,-1.10177 +3408.86,0.517136,0.0912059,5,1.43925,0.824593,-0.62446,0.319662,0.353629,0.0430324,0.230761,-0.323425,-0.084414,0.319894,0.236289,-0.157312,0.155225,0.709957,0.697688,0.943943,-0.0921829,0.137113,0.188542,0.392984,0.13964,-0.33047,-0.0385679,0.616756,-0.421174,-0.106752,0.414242,0.645333,-0.196383,0.367213,0.894356,0.216674,0.241434,0.367346,-0.272445,-0.209173,-0.0598003,0.509098,0.368359,0.14726,0.924501,0.804514,-0.028408,-0.527462,-0.404423,0.135744,-1.26711,-0.237341,0.289096,0.395619,-0.033918,0.69868,0.162719,-0.358058,0.82608,0.152381,0.110208,-0.48435,0.176517,-0.198291,0.182571,0.913404,-0.114365,-0.284125,0.0835406,-0.0220201,0.678233,-0.0460749,0.409909,-0.26255,0.245868,0.284213,0.468802,-0.50166,0.65521,0.983492,0.663059,0.0752689,-0.680799,-0.0872848,0.290814,-0.856468,0.0952648,-0.482062,0.0869799,0.010554,-0.590973,-0.0159813,0.316023,-0.144773,0.0270628,-0.880433,0.574703,0.101685,-0.111968,-0.103695,-0.0880827,-0.0338706,0.183297,0.0658238,-0.268768,-0.253863,-0.0586172,0.108436,-0.357338,-0.167487,-0.231875,-0.370322,0.240462,0.166572,-0.611781,-0.218704,0.0558246,0.271094,-0.0436456,0.488249,-0.507255,0.162498,0.16118,-0.199464,-0.731491,-0.718421,-0.402878,-0.0221347,0.0826211,0.370053,0.506868,0.426068,0.179294,-0.0884419,0.183107,0.217844,0.103462,0.802763,0.353675,-0.34326,0.161262,0.0782505,0.342013,-0.772006,-1.35872,-0.305477,0.63377,-0.435387,-0.186268,-0.321698,-0.392453,0.369233,0.209952,-0.437634,-0.0158192,0.0868118,0.251441,0.492582,0.663576,0.306237,-0.200718,0.350757,-0.258153,0.282386,0.0403572,0.53659,1.32255,-0.654466,0.397665,0.533407,0.204344,-0.432036,0.0229336,-0.474926,0.13089,-0.349505,-0.0333808,0.00108698,-0.380361,-0.172264,-0.00424684,-0.0267811,0.604646,0.270922,-0.0653969,-0.611952,0.0156779,0.250095,-0.401606,-0.664414,-0.333582,0.215648,0.476155,-0.311593,0.41239,-0.185982,-0.508848,0.0776936,-0.158579,0.117648,0.239122,-0.277478,-0.471676,0.0729486,-0.151193,-0.348084,0.298571,-0.0364558,-0.107718,-0.073195,-0.645567,1.29082,0.447657,0.159974,0.344724,0.189419,0.222031,-0.571338,-0.198023,0.329666,-0.293591,0.228031,0.796342,-0.760095,0.127595,-0.323385,-0.29533,-0.304836,0.0879316,0.616815,-0.561202,0.0952021,-0.340477,-0.148486,-0.41451,0.090918,-0.0650101,0.0230046,-0.566035,0.602003,-0.250651,0.440304,0.680531,-0.804192,-0.792168,0.166454,-0.507877,0.0863629,0.266486,0.0922438,0.619605,0.632228,-0.0759011,-0.341026,0.133117,-0.350061,0.704254,0.13298,-0.384185,0.331099,-0.131547,0.322732,-0.457694,0.0261817,0.730977,0.400941,0.0509643,-0.551111,0.00710434,0.221701,0.184462,-0.310614,0.138152,0.0528356,0.129854,0.106352,-0.333705,0.403119,-0.206993,-0.12123,0.0322746,-0.34344,0.358149,0.212358,-0.490798,-0.694871,0.0504353,0.0750245,-0.243707,0.116048,0.0843617,-0.258969,-0.31942,-0.0829481,0.0108595,0.302718,-0.336939,-0.138866,0.28316,-0.205894,-0.723295,-0.0305879,-0.606411,-0.234992,-0.207435,0.155649,0.179085,0.394524,0.423184,-1.17838 +3390.11,0.801378,0.0912059,4,1.40762,0.83895,-0.562429,0.251566,0.408657,-0.030866,0.427724,0.39139,0.45799,0.38649,0.110421,-0.174303,0.390257,0.556256,0.421671,0.919316,-0.035837,-0.10461,0.135639,0.187688,0.279721,-0.629257,-0.0796511,1.00492,-0.432331,-0.314674,0.53203,0.462344,-0.288932,0.260019,0.763974,0.17717,-0.423536,0.376811,-0.407527,-0.468878,-0.233216,0.464531,0.299139,-0.478612,1.08157,0.445842,0.397313,-0.490895,-0.0633858,0.448654,-0.810453,0.257885,0.635158,0.131421,0.364549,0.527896,0.10517,-0.339791,0.910342,-0.833377,-0.00319776,-0.250398,0.252469,-0.568946,0.484286,0.815787,0.138816,0.346852,0.0616522,0.308045,0.45116,0.0780029,0.179307,-0.220816,0.213128,0.0458332,0.702935,-0.436614,0.71108,1.1497,0.174237,-0.058712,-0.887212,-0.0421455,0.527898,-0.962667,-0.0932779,-0.445953,0.336072,0.127534,0.15013,0.201903,0.350858,0.247813,-0.208213,0.0592358,0.00412493,0.422176,0.347684,0.147535,0.141455,-0.0297865,0.348307,0.271751,-0.794777,-0.528631,-0.640254,0.129223,0.0222837,0.40976,-0.363944,-0.480083,-0.0892206,0.0235467,-0.348061,0.241096,0.105012,0.462729,-0.386771,-0.243668,-0.255033,0.499768,0.624657,-0.274708,-1.01052,-0.00599755,-0.418351,-0.455999,-0.161379,-0.00344782,0.555302,0.606845,0.267558,-0.574214,0.242875,0.0296909,-0.416403,0.570808,0.0936427,-0.228866,-0.431649,0.225404,0.113096,-0.960283,-1.30105,-0.368417,0.688822,-0.254857,0.134629,0.128541,-0.189376,0.419066,0.0349456,0.196637,0.266805,0.4363,-0.2604,0.167555,0.930412,0.0885532,-0.423302,-0.147339,-0.267701,-0.131866,-0.0479107,-0.14092,0.694866,0.387135,0.516298,0.236453,0.0823369,-0.0910687,0.0152147,-0.471591,0.442797,-0.321669,0.0801125,0.00711704,-0.880681,-0.308136,0.272,-0.809085,-0.0487289,0.799736,-0.421798,-0.706162,0.27747,-0.0388362,-0.240998,-0.589387,0.197349,0.1198,0.3715,-0.474599,0.0249957,-0.325304,-0.579028,-0.244179,0.249731,0.250926,0.244621,-0.091021,-0.388714,0.0697293,-0.191811,-0.27305,-0.0596366,-0.152607,0.0314158,0.224551,0.173344,0.912859,-0.365242,0.380018,0.0635182,0.0972587,0.89515,-0.127052,-0.978701,0.305089,-0.492732,0.430109,0.0573409,-0.655112,-0.479476,-0.253221,-0.0121447,-0.089735,-0.231869,0.337046,-0.796384,-0.0465714,0.304311,0.602593,-0.305925,-0.00736688,-0.457422,-0.150224,-0.515468,0.563498,0.0111934,-0.410392,0.583266,-0.199402,-0.858597,0.546066,0.0483376,-0.214543,0.604285,0.381509,0.404952,0.597991,-0.384258,-0.34644,-0.33514,-0.460118,0.787415,-0.0705497,-0.135676,0.138167,-0.367222,0.0207144,-0.0844548,-0.186487,0.12622,0.498562,-0.244815,0.250898,-0.0456548,0.111508,0.204143,-1.154,0.136921,0.252267,0.0417799,-0.507729,-0.683158,0.0901908,-0.173396,0.204142,-0.104984,0.262717,0.21337,-0.347434,-0.176676,-0.10017,0.222704,-0.0183621,-0.126821,0.064786,-0.0555878,-0.387026,-0.548216,0.397932,-0.304494,0.727782,0.321089,0.231412,0.0235407,-0.599595,-0.236646,-0.0181416,-0.579931,-0.279576,0.147163,0.172017,0.222774,0.41475,0.471989,-1.36761 +3388.68,0.977161,0.0912059,5,1.45818,1.07387,-0.737684,0.193854,0.492572,-0.190546,-0.345083,0.0643994,-0.0758617,-0.174166,-0.192207,0.129434,0.273145,0.143737,0.537723,0.981447,-0.0245163,0.109848,0.311499,-0.213344,-0.465503,-0.867334,-0.510014,0.542136,0.107351,-0.0625358,-0.307941,0.355878,-0.0830845,-0.24364,0.497091,-0.779563,0.653511,0.150604,0.12382,-0.504203,-0.620711,0.915562,0.592922,-0.0022055,0.748188,1.29056,0.684811,-0.558472,0.200925,-0.155943,-0.558928,0.563613,0.55866,0.0514584,-0.186647,0.283153,-0.058493,-0.151156,0.675236,0.38239,-0.00325458,-0.820332,0.390555,0.349427,0.474446,1.39616,-0.671013,-1.5819,-0.172046,0.548117,-0.429803,0.329927,-0.0623604,-0.504421,-0.639828,0.250663,0.547114,-0.548413,0.541339,0.211108,0.68697,-0.0962124,-0.25386,0.0235525,0.570347,0.408193,-0.0431282,0.607593,-0.276714,-0.0335616,-0.0380728,-0.0500253,0.502542,-0.756637,0.185375,-0.0871627,-0.0285571,-0.377909,0.266951,0.221379,0.202645,-0.482117,0.180549,0.339502,-0.0290592,0.237999,-0.275107,-0.270406,0.576437,-0.98487,0.648223,-0.0595882,0.620101,0.962427,0.223669,-0.218728,0.490772,0.412792,-0.197428,0.211184,-0.238418,0.0248226,-0.344025,0.0641552,-0.222667,-0.232487,0.0363929,0.364115,0.214005,0.573095,0.239659,0.470504,0.33659,-0.292057,-0.425856,0.00919591,-0.433211,0.421418,-0.0446341,0.0205739,-0.346326,-0.151691,0.798508,-0.454017,-0.826549,-0.309447,-0.388149,-0.604416,0.106738,0.366253,-0.12963,0.458644,-0.15123,0.264887,-0.0756445,-0.176657,0.252489,0.12529,-0.0331502,0.232514,0.528875,0.174306,0.435714,-0.62826,-0.227681,-0.101028,0.0370675,-0.850994,-0.0694048,-0.0975034,-0.469526,0.0504161,-0.263643,0.341426,0.265462,0.0864146,-0.116817,0.540252,0.472189,0.114844,-0.591464,0.0431796,0.227433,0.280634,0.408449,-0.335304,0.230389,0.330265,-0.0764712,-0.320427,0.0620104,-0.49399,0.186371,-0.814153,0.155313,-0.647066,0.492064,-0.297082,-0.066512,-0.0876977,-0.297902,0.0154571,-0.953717,0.0353278,-0.717329,0.28692,0.637349,-0.0633381,0.336034,0.1052,-0.468017,1.03644,-0.0208574,0.224969,0.369473,-0.518679,-0.00246047,0.692927,-0.0195163,0.0553716,-0.212576,0.0762443,-0.488068,-0.566222,0.00821755,-0.266345,-0.669009,0.657752,-0.622874,0.257384,0.058169,-0.0497583,-0.0887312,-0.328565,0.208268,0.128191,-0.505894,-0.653631,-0.420112,0.491917,-0.548341,-0.511938,0.376305,-0.801402,-0.294939,0.3555,-0.0366594,-0.0266309,0.219408,0.0465306,0.300677,-0.373092,-0.318581,-0.0798571,-0.365589,-0.281038,0.318782,-0.0671264,0.051478,0.49685,-0.729232,0.444348,-0.674163,-0.21529,-0.167142,0.868929,0.890637,0.23108,0.0852403,0.244776,-0.101349,0.0361913,-0.425986,-0.223204,-0.054152,0.572858,-0.106131,0.142328,0.318643,-0.214968,0.464162,-0.266808,0.552171,0.595782,-0.116841,-0.492339,-0.0456784,-0.501959,-0.217778,0.373932,0.275267,0.109369,0.446947,-0.404988,0.2201,-0.14744,-0.22489,-0.0113819,-0.297479,-0.310582,-0.275241,-0.239647,0.0849879,-0.072277,0.107167,0.159021,0.220724,0.398775,0.469812,-1.82422 +3406.83,0.997671,0.0912059,4,1.46176,1.05929,-0.526068,0.106233,0.494142,-0.137914,0.00399368,-0.149271,0.328476,0.324771,-0.0439151,0.348795,0.469869,0.325949,0.331303,0.667859,0.0427342,-0.196063,0.18906,-0.117093,-0.544882,-1.21698,-0.501848,0.283497,-0.021089,-0.0949551,-0.380433,0.286596,0.0707781,0.0287743,0.877157,-0.972041,0.099897,0.620052,0.093914,-0.448403,-0.508633,0.698555,0.795352,-0.211424,1.09859,0.898722,0.643464,-0.532789,-0.0850623,-0.200294,-0.923605,0.348887,0.565225,0.0752252,-0.135005,0.323468,0.18302,-0.389909,0.950118,-0.0577346,-0.179292,-1.1012,0.841088,0.34139,0.476318,1.13638,-0.45043,-1.29712,0.0343715,0.670314,-0.172307,0.165104,-0.262189,-0.563369,-0.429224,0.232239,0.847692,-0.283556,0.800071,0.135088,0.585427,-0.44311,-0.318417,0.054871,0.472286,0.135138,-0.196553,0.42443,-0.298874,0.21577,-0.0554017,0.196344,0.474672,-0.765961,0.54486,-0.134864,0.348741,-0.336207,0.557079,0.267749,-0.014678,-0.518275,0.000251228,0.378588,-0.110775,0.262388,-0.0190141,-0.365626,0.399251,-1.00093,0.716817,-0.0788703,0.657842,0.870267,0.13304,0.111327,0.306874,0.284732,-0.453272,0.173006,-0.446525,-0.0650882,-0.456148,0.140722,-0.634643,0.11884,0.124989,0.000796332,-0.314624,0.619446,0.167895,0.635727,0.1774,-0.50884,-0.36436,0.00928746,0.0357946,0.194372,0.0355049,-0.129497,-0.00472954,-0.253267,0.619363,-0.756109,-0.454437,-0.20761,0.172453,-0.69445,0.219125,0.338725,-0.298643,-0.0868556,-0.126787,0.0813389,-0.162515,-0.145408,0.149495,0.064311,0.199051,0.050435,0.421414,0.492155,0.232304,-0.660737,-0.0462737,-0.183984,-0.12128,-0.626408,0.0149752,0.162259,-0.223559,0.249311,-0.296435,0.191555,0.109818,0.141039,-0.300117,0.225699,0.379909,0.230404,-0.413717,-0.130556,0.0339303,0.265167,0.311772,-0.105007,0.301198,-0.00573909,0.0669757,-0.284551,0.161347,-0.382374,0.328821,-0.381267,0.107214,-0.620558,0.465673,-0.382215,0.167526,-0.0360059,-0.387337,-0.124635,-0.683057,0.444215,-0.566351,0.380385,0.416909,0.0321677,0.398478,0.569929,-0.639862,0.990141,-0.056977,-0.157379,0.086266,-0.437975,0.611946,0.552952,-0.0731722,0.0420918,-0.485368,0.0963693,-0.113209,-0.322993,0.0118039,-0.367806,-0.393091,0.324523,-0.286407,0.396753,-0.00579004,-0.21043,0.434782,-0.589708,-0.102414,-0.07003,-0.667382,-0.44915,-0.197916,0.520341,-0.72736,-0.444364,0.155415,-0.236458,-0.27911,0.0981229,-0.0349998,0.107208,-0.175708,0.0307478,0.0574733,-0.174434,-0.491216,-0.0430174,-0.183326,-0.223559,0.560788,-0.0397996,0.269486,0.396857,-0.55039,0.318777,-0.308989,-0.372805,-0.159914,0.885274,0.161059,0.765014,0.105836,0.0264321,-0.00635221,0.0986,-0.499291,-0.176847,-0.0490377,0.364662,-0.291643,0.263834,-0.0789115,-0.259276,0.294555,-0.066501,0.473595,0.576315,-0.317928,0.129444,-0.391262,-0.338719,-0.205473,0.229303,0.385879,0.570434,0.154243,-0.566597,0.030833,-0.0018068,-0.307058,0.519005,-0.514559,-0.421501,-0.406,-0.0801919,-0.520918,-0.120687,0.247453,0.150807,0.368999,0.388339,0.607453,-1.84133 +3400.76,0.990428,0.0912059,4,1.4943,1.08055,-0.832125,0.244269,0.960755,-0.188091,0.331651,0.0605415,0.604365,0.489164,-0.0645288,0.251816,0.182349,-0.325146,0.169373,0.906605,-0.0547763,-0.0695418,0.0425495,0.136753,-0.47419,-1.05297,-0.919502,0.150292,0.17932,0.393156,-0.269833,0.860284,0.165944,0.125571,0.692559,-0.567617,0.0232798,0.301353,0.174292,-0.594123,-0.616721,0.427119,0.97077,-0.355512,0.894044,0.776884,0.0623818,-0.532673,-0.00839921,0.0988015,-0.735226,0.391814,0.593223,0.0511258,-0.277782,0.115202,0.466154,-0.417458,0.911855,0.198295,-0.169587,-0.550697,0.637174,0.0555345,0.584358,1.2615,-0.393299,-1.31178,0.240993,0.802653,-0.114244,0.343762,-0.0948966,-0.49536,-0.395773,0.591086,0.685585,-0.351118,0.548295,0.364458,0.579781,-0.0748427,-0.226341,0.0769072,0.77727,0.0945749,0.123025,-0.022557,-0.520638,-0.157035,-0.295043,0.024802,0.268259,-0.665946,0.523115,-0.0448077,-0.148419,-0.261278,0.556849,0.582678,-0.129293,-0.571833,-0.0662027,0.114995,-0.34456,0.207029,0.218114,-0.390113,-0.147687,-0.4414,0.835844,-0.243172,0.772058,0.43004,-0.225972,-0.0368388,0.174195,0.119314,-0.501725,0.234973,-0.497244,-0.108796,-0.485526,-0.265703,-0.949905,-0.441857,-0.128468,-0.327097,-0.254131,0.374779,0.409811,0.599459,0.456474,-0.896161,-0.257937,0.046297,-0.0583539,0.0144377,-0.270334,-0.217166,0.0432078,-0.104201,0.541829,-0.492267,-0.422974,-0.175016,-0.0709182,-0.86004,-0.0181451,0.201251,-0.999165,0.0888008,-0.173323,0.132952,-0.48617,-0.0177088,0.0885097,0.258969,0.127215,0.754264,0.08903,0.392175,0.273002,-0.536497,0.100001,0.0102321,0.162075,-0.00330967,0.607824,0.079841,-0.428602,0.0259618,-0.529757,-0.248152,-0.349846,0.457356,-0.531622,0.141611,0.374315,0.1467,-0.511606,-0.206421,0.050296,0.333027,0.701486,0.58412,-0.147801,0.348979,0.577531,-0.407578,-0.0571314,-0.263733,0.0970266,-0.296897,0.131018,-0.623549,0.964878,-0.781712,0.125134,0.495329,-0.0727409,-0.0408469,-0.801422,0.107328,-0.360531,-0.438205,0.442588,-0.200955,0.414386,0.321235,-0.253473,0.646863,-0.311609,-0.223826,-0.176838,-0.440951,0.516657,0.291315,0.0228379,-0.00619297,-0.3017,0.138091,0.00905495,-0.270298,0.232665,-0.32277,-0.271798,0.118369,-0.388485,0.107775,0.175288,-0.373761,0.453098,-0.229177,-0.33102,-0.0464449,-0.380018,-0.558204,0.215187,0.205725,-0.830901,0.0077363,0.687518,-0.227172,0.0820163,-0.237988,0.14794,-0.0393915,0.378216,0.315238,0.300589,-0.123139,-0.432992,-0.327627,-0.39573,-0.125099,0.647261,-0.016246,-0.110121,0.451631,-0.785054,0.192795,-0.193457,-0.152716,-0.160642,0.34529,0.147705,0.699014,0.165317,-0.093126,-0.152001,0.0457249,-0.519677,0.133883,0.362298,0.273499,-0.581673,0.121317,0.047186,-0.412835,0.180951,-0.243886,0.496769,0.626107,-0.208819,-0.0409302,-0.363342,0.0882673,-0.153088,-0.0191591,0.409973,0.269188,0.204199,-0.133942,-0.0587077,0.0664274,-0.133757,0.38685,-0.550127,-0.734432,-0.278523,-0.0484252,-0.417197,0.358941,0.485259,0.139212,0.344464,0.373112,0.58691,-3.35297 +3398.59,0.829339,0.0912059,4,1.50535,1.13849,-0.882566,0.337667,0.751982,-0.0818141,0.426362,0.308772,0.764203,-0.227943,-0.0213592,-0.141918,0.0682359,0.375828,-0.176482,0.684224,-0.244779,0.125042,-0.1618,-0.60151,-0.52219,-1.1411,-0.601916,-0.0649655,0.116805,0.180285,-0.288523,0.0579564,-0.345257,0.111368,1.03564,-0.920413,0.707699,0.432207,-0.361004,-0.904273,-1.11608,0.641122,0.746919,-0.264928,0.840055,0.907408,0.111431,-0.658554,0.317777,-0.836672,-0.592599,0.386943,0.336974,-0.197226,0.120487,0.697852,-0.0423207,-0.650737,0.357734,-0.231316,-0.272539,-0.629366,0.80942,-0.0956295,0.501521,0.761806,-0.134573,0.0148122,0.280046,-0.0412873,-0.107383,0.360826,-0.467113,-0.32165,0.116134,0.848602,0.451665,-0.305468,0.962533,0.615378,0.27456,0.288676,-0.0822858,0.0376286,0.900315,0.319173,-0.0924547,-0.277909,-0.102117,0.10246,0.385506,0.35213,0.222677,-0.552009,-0.156807,0.0328664,-0.316085,0.249976,0.355107,0.0302219,0.0981549,-0.399535,0.218286,0.372153,0.402943,-0.0838942,-0.488916,-0.76547,-0.0791811,0.189482,0.296565,-0.288204,0.771438,0.587205,-0.536225,-0.0990234,0.389786,0.225531,-0.123519,0.36054,-0.19672,-0.274655,-0.264775,0.744632,-0.699414,-0.109845,-0.577849,-0.134072,0.249034,0.148519,-0.00627236,0.852749,0.178277,0.0641605,0.0810761,-0.0204405,0.0565562,0.426303,0.203154,-0.0159317,0.00384648,0.367716,0.714802,-0.394445,-0.878888,-0.0177012,-0.421886,-0.595791,-0.348118,0.370933,-0.133846,0.259483,-0.126515,0.121471,-0.358839,0.217231,-0.162366,0.618459,-0.692928,0.602962,0.332635,0.215663,0.0610383,-0.532602,0.29693,0.208453,0.706879,-0.2803,0.237223,-0.0308191,-0.271832,-0.265624,-0.237259,-0.128863,0.111478,1.16561,0.023543,-0.142175,0.552426,0.249334,-0.15469,-0.171835,-0.00863915,0.481796,-0.0909633,0.237768,-0.0613776,0.120381,0.0445944,-0.546363,0.268792,-0.387395,0.190095,-0.144164,0.16606,-0.435439,-0.0803944,-0.675725,0.0981841,0.413898,-0.166503,-0.486616,-0.534611,0.0530938,-0.464844,-0.498049,0.380439,0.140699,0.344413,0.197812,-0.390357,0.582463,-0.00313056,0.549374,0.171018,-0.514064,0.615372,0.370993,-0.493388,-0.0704056,0.305517,0.156553,-0.0792157,-0.337126,-0.468264,-0.165443,0.095802,0.729602,-0.102252,0.195071,-0.0820991,-0.609412,0.596723,0.166533,-0.453446,-0.359557,-0.337523,-0.59436,0.0737022,0.0629286,-0.382022,0.104879,0.744121,0.209614,0.0257113,0.0870032,-0.211366,0.252655,-0.264176,0.358156,0.174014,-0.187656,-0.512635,-0.235001,-0.300517,-0.347548,0.294414,0.00970949,0.296478,0.232571,-0.243624,0.520181,0.121791,0.0155546,0.0233427,0.185302,0.248603,0.174272,-0.102303,0.41332,-0.432705,-0.00151611,-0.486812,-0.219864,-0.359148,0.224091,-0.0513598,0.494164,-0.148875,0.0602607,-0.0119401,0.39842,-0.127293,-0.0146933,-0.346308,-0.485409,-0.0272707,0.381009,-0.0681635,-0.17618,0.120871,0.0496974,0.0378143,-0.158121,-0.247428,-0.0803477,-0.0849955,-0.108487,-0.500032,-0.185961,-0.46657,0.0483213,-0.703548,-0.711292,0.30291,0.140235,0.254983,0.37448,0.504959,-2.83994 +3413.1,0.84461,0.0912059,4,1.54961,1.06183,-1.08669,0.363049,0.751141,0.0377331,0.208487,0.25062,0.45066,-0.04314,0.177492,0.0371818,-0.19192,0.0613959,0.273534,1.01717,-0.0706359,-0.066561,-0.542462,-0.0464891,-0.767932,-0.841382,-0.934228,0.12548,-0.0121506,-0.0599878,0.0322693,-0.185472,-0.142045,-0.0242945,0.810006,-0.876378,0.403041,-0.00775889,-0.315222,-0.452106,-0.358888,0.615929,0.703305,-0.130987,1.0077,0.807467,0.73921,-0.796348,0.126177,-0.689221,-0.99912,0.263376,0.567614,-0.0529939,-0.0405665,0.873994,0.134957,-0.73993,0.55362,0.300095,-0.24999,-0.997708,0.248502,-0.442093,0.395972,1.18948,-0.739074,-0.564465,0.501964,0.170671,-0.100805,0.769784,-0.0235096,-0.233983,-0.168691,0.728514,0.397859,-0.454234,0.808144,0.591178,0.378821,0.434304,-0.0824313,0.195741,0.468677,0.0562023,0.0193956,-0.180027,-0.433788,-0.274728,0.664951,0.102504,0.352338,-0.640118,-0.160814,0.428593,-0.348226,-0.0305168,-0.156596,-0.222848,0.366927,-0.0859578,0.477447,-0.0217138,0.381405,0.123913,-0.146386,-0.453851,-0.0550313,0.138957,0.241495,-0.208722,0.808246,0.591549,-0.504229,-0.133733,-0.397207,0.0698411,0.126817,-0.027722,-0.284019,0.128702,0.0517942,-0.276368,-0.762477,-0.720023,-0.292442,-0.334931,0.151865,-0.13644,-0.00463014,0.887981,-0.279443,-0.411355,0.338977,0.0617067,-0.340199,0.437717,-0.0907167,-0.116473,0.128754,-0.245859,0.465284,-0.216508,0.153732,0.0223172,-0.402505,-0.707222,-0.489831,-0.157556,-0.378737,0.341944,-0.448331,0.129997,-0.594922,0.394902,0.210035,-0.024796,-0.310712,0.206776,-0.204128,0.0316321,0.468215,-0.216951,0.162484,0.156974,0.366036,-0.199614,-0.230124,0.387517,-0.663463,-0.119528,0.154652,0.447436,-0.0135242,0.593604,-0.283005,0.132028,0.431302,0.182973,-0.282577,-0.0901261,0.127376,0.379414,-0.485025,-0.173602,-0.468129,0.324938,-0.457447,-0.151465,0.473846,-0.643273,0.411503,-0.396739,-0.243321,-0.470745,-0.0490769,-0.591478,-0.215415,0.680763,-0.164394,-0.486289,-0.689277,-0.529087,-0.85352,-0.142302,0.341077,0.188073,0.00389104,-0.0751728,-0.539141,0.596334,-0.0359027,0.255565,0.139717,-0.317204,0.219098,0.551255,-0.134518,0.044592,0.144308,-0.0865622,-0.220654,0.0842323,-0.12505,-0.141061,0.190524,0.805343,-0.338028,0.131152,0.0597599,0.0170133,0.575227,-0.208652,-0.151126,0.0671856,-0.0346336,-0.287177,-0.124492,0.312735,0.10556,0.314949,0.777027,0.319301,0.00270706,-0.0818993,-0.0807728,-0.0198187,0.321141,0.0713264,0.0302711,-0.0057547,-0.503278,-0.294881,-0.116869,-0.343781,0.247594,-0.43353,0.427185,0.404119,0.0295042,-0.121284,0.122081,-0.0100626,0.199948,0.202641,0.560906,0.0575614,-0.180066,0.426048,-0.565706,-0.2943,-0.698416,0.128398,-0.423056,-0.169407,-0.272994,0.126787,0.377532,0.576887,0.0542019,-0.0302511,0.550176,-0.0218248,-0.610521,-0.599686,-0.40248,-0.148051,-0.119225,0.0380558,0.0466123,0.529221,-0.105025,-0.590448,-0.279018,-0.102631,0.359848,0.153485,-0.219244,-0.213675,-0.411559,-0.0272029,-0.627342,-1.01452,-0.43316,0.124771,0.324868,0.353229,0.569972,-2.60405 +3422.74,0.99803,0.0912059,4,1.48059,0.998458,-1.08265,0.390236,0.323088,-0.0253975,-0.0788405,0.191975,0.565363,0.107891,0.170173,-0.107608,-0.336118,0.492002,0.377946,0.697618,-0.0575733,-0.064795,-0.32545,0.0143382,-0.250746,-0.887149,-0.792865,0.17535,0.0958122,0.120258,0.114652,0.193911,-0.232218,-0.0923657,1.09361,-0.639868,0.704136,0.171903,-0.408635,-0.603108,-0.520658,0.335556,0.709594,-0.20634,1.10034,0.919459,0.693651,-0.691634,0.395667,-0.84357,-1.20475,0.083625,0.5905,0.030792,0.15658,0.402047,0.367135,-0.413502,0.682719,0.188528,-0.22839,-1.09004,0.30609,-0.185674,0.433423,1.04438,-0.532863,-0.895249,0.427124,0.255724,0.11695,0.173657,-0.0305424,-0.413202,-0.0276671,0.453048,0.538579,-0.330002,0.836035,0.643122,0.368525,0.447083,-0.186946,0.572411,0.519675,-0.219166,0.252992,0.0445661,-0.292383,-0.199833,0.508122,0.522073,0.183308,-0.665899,0.286826,0.36798,0.141695,-0.126454,-0.208208,-0.134581,0.249971,-0.144051,0.285392,0.0671088,0.0804578,0.0873335,-0.317404,0.171376,0.26294,-0.231623,0.342876,-0.0710333,0.346771,0.569845,-0.248258,0.0597988,-0.0843466,0.138769,-0.286383,0.346658,-0.107628,0.275867,0.427775,-0.390145,-0.586207,-0.74382,-0.14942,-0.38175,0.0596532,0.308405,0.205606,0.665444,-0.325095,-0.125828,0.435621,-0.043908,-0.462019,0.657041,-0.0034275,-0.355807,0.0478164,-0.187512,0.327526,-0.537362,0.0113539,-0.202768,-0.0391137,-0.692767,-0.143514,0.108802,-0.356323,0.57917,-0.445231,0.103964,-0.392449,0.126476,-0.0365365,0.640528,0.381658,0.410495,-0.0240542,0.126951,0.0698702,-0.0464884,0.188773,0.0832462,-0.0682981,0.154903,-0.0021136,0.425842,-0.56171,-0.251632,0.0459574,0.13015,0.10264,-0.0224644,-0.105973,-0.12029,0.369965,0.160478,-0.239009,0.0725138,0.660725,0.4148,-0.521214,-0.071414,-0.396129,0.237131,-0.630353,-0.0891906,-0.218706,-0.409576,0.00646347,-0.0789855,-0.142845,-0.164317,-0.0544938,-0.511072,-0.339201,0.783803,-0.395364,-0.290094,-0.723573,0.0634163,-0.540119,-0.116743,0.15976,0.0535518,0.1831,-0.536559,-0.246111,0.627524,0.310769,-0.103509,0.208636,-0.0736091,0.111836,0.453489,-0.0527979,-0.0785187,0.3251,0.0262447,0.133709,0.276238,-0.172556,-0.165051,0.26192,0.899821,0.216981,-0.204312,-0.155577,-0.34337,0.723243,0.440028,0.152489,-0.310472,-0.0703053,-0.233235,0.227067,0.66904,0.0506718,0.0473221,0.692784,0.14301,-0.169506,0.000912978,-0.424992,-0.0685277,0.0791862,0.281659,0.559298,-0.0422131,-0.0283529,-0.564901,-0.52316,0.109986,0.0891122,-0.465541,0.445941,0.227597,-0.100687,0.44193,0.35615,-0.322192,-0.0606064,-0.420435,0.348357,-0.239159,-0.418744,0.250523,-0.25827,-0.47612,-0.707042,-0.163478,-0.339392,-0.436431,0.342697,0.401438,0.165398,0.186321,-0.212992,-0.0185117,0.675017,0.227101,-0.00372177,-0.764948,0.0784017,0.0665411,-0.105663,0.288703,0.0298314,0.709574,-0.14479,-0.225479,-0.454518,-0.070781,0.554953,-0.0795483,0.0863412,-0.39042,-0.208786,0.186815,-0.715804,-0.797809,-0.3995,0.113358,0.327063,0.336687,0.571894,-1.15212 +3437.25,0.763796,0.0912059,5,1.46803,0.957879,-1.20888,0.453286,0.674718,-0.0600743,0.0512528,0.501148,0.734939,0.150852,0.0259407,-0.319673,-0.195128,0.448854,0.364311,0.748631,-0.131494,0.0292996,-0.313084,-0.0313545,-0.392047,-0.634179,-1.02953,0.284497,-0.0310308,0.273715,0.279718,0.371665,-0.472417,-0.0476558,0.970961,-0.22308,0.75229,-0.0105701,-0.272152,-0.409265,-0.72993,0.517993,0.69637,0.000106305,1.05213,0.932447,0.844145,-0.652458,0.410526,-0.889894,-1.16022,0.286102,0.743435,-0.0865563,0.210762,0.0757535,0.362248,-0.554191,0.733095,0.297659,-0.00346864,-0.890335,0.441738,-0.314458,0.2568,0.981879,-0.469557,-0.877994,0.213643,0.346391,0.0691879,0.239769,-0.229825,0.0384442,-0.0210862,0.291343,0.480307,-0.190952,0.797354,0.733842,0.262778,0.434179,-0.29207,0.563462,0.396477,-0.0451071,0.0395905,0.249326,-0.234056,-0.05306,0.305708,0.528953,0.145602,-0.7313,0.531685,0.0876798,0.343632,-0.0937542,0.0351777,0.168687,0.112273,-0.0961271,0.0612914,0.207855,0.17662,-0.102712,-0.171019,0.0443227,0.11157,-0.629923,0.430892,-0.353442,0.11699,0.554077,-0.398487,0.0377609,-0.115821,0.105233,-0.185293,0.239098,-0.24871,0.038486,0.172567,-0.0855176,-0.582847,-0.587069,0.085751,-0.308511,-0.275677,0.0432465,0.223611,0.684316,-0.114231,0.140654,0.525403,-0.0356123,-0.62177,0.540376,-0.219197,-0.807131,-0.162887,0.168995,0.511638,-0.82201,-0.084609,-0.0260752,-0.0745408,-0.668024,-0.183635,0.122531,-0.0864975,0.441015,-0.441525,-0.22461,-0.095299,0.298774,0.176116,0.374377,0.478927,0.549843,0.136097,-0.331581,0.452505,-0.123383,0.0557308,0.151686,0.047421,0.0576537,0.00720587,0.0357123,-0.53909,-0.495682,-0.0926921,0.0581011,0.117545,0.0391485,-0.247135,-0.220678,0.0797135,0.222764,-0.0444275,-0.14246,0.372875,0.640096,-0.0541202,0.112498,-0.22466,0.186731,-0.313715,-0.295394,-0.0586367,-0.447513,-0.018457,0.0717545,0.0303006,-0.0598131,0.403788,-0.603731,-0.12979,0.821664,-0.0120457,-0.373109,-0.622576,0.194046,-0.0849291,-0.140448,0.194944,0.125218,0.266755,-0.259585,-0.327807,0.550635,0.19194,-0.107517,0.226889,-0.150802,0.138813,0.421045,-0.311057,0.0473707,0.288168,-0.16256,0.217168,-0.0125198,-0.0209919,-0.323095,0.288361,0.804342,0.155792,-0.15697,-0.200183,-0.256273,0.73519,0.276376,0.35639,-0.0853418,-0.262023,-0.244167,0.107472,0.480689,0.339633,-0.0146966,0.468868,-0.237211,-0.164417,-0.386075,-0.207704,0.289716,0.118768,-0.102515,0.441483,-0.143004,-0.124047,-0.503144,-0.52234,0.025559,0.46901,-0.439269,0.375401,0.170568,0.0126657,0.269133,0.0122564,-0.347331,0.0933685,-0.262962,0.390664,-0.351891,-0.367524,0.0542421,-0.278325,-0.586868,-0.77922,-0.0770403,-0.217096,-0.323274,0.431624,0.713037,0.451798,0.0156277,-0.116885,-0.147814,0.1231,-0.0938711,-0.171265,-0.607527,-0.117577,-0.622333,-0.129136,0.288791,0.272137,0.686221,0.257874,0.0142121,-0.37774,0.0534335,0.372373,0.12638,0.223506,-0.348283,-0.384931,0.0785787,-0.683068,-0.260344,-0.305222,0.131542,0.297376,0.362688,0.545322,-2.24507 +3437.04,0.951032,0.0912059,4,1.45776,0.885465,-1.22789,0.466217,0.621804,0.117841,0.211959,0.0633272,0.457928,0.129988,0.208711,-0.278945,-0.144456,0.288229,0.13001,0.616642,-0.0683857,0.0652851,-0.476631,0.0378133,-0.31621,-0.829886,-1.3084,0.313358,-0.119822,0.32738,0.232749,0.452877,-0.325671,0.357973,1.10869,-0.0326443,0.659617,0.12623,0.0279984,-0.188633,-0.708956,0.508127,0.67347,0.287987,1.14959,0.841167,0.564051,-0.959605,0.364859,-0.0467558,-0.837191,0.130215,0.881147,0.194353,0.0388946,-0.258822,0.145876,-0.685937,0.725303,0.170561,-0.165504,-0.62181,0.487308,-0.651033,0.464144,1.02828,-0.26939,-0.609174,0.0854726,0.479429,-0.472852,0.0953872,-0.308681,-0.471855,0.233329,0.700878,0.343946,-0.0106692,0.744118,0.336015,0.380109,0.416009,-0.527484,0.299082,0.0631749,-0.0256646,-0.0266936,-0.172527,-0.102566,-0.241296,0.0617341,0.400868,-0.00700543,-0.215151,0.085975,0.0453503,0.180022,-0.602957,0.213295,-0.190527,0.202216,0.135902,-0.148249,0.195326,0.0532779,-0.0115221,-0.282015,0.086593,0.147848,-0.285246,0.400742,-0.26736,0.10146,0.326783,-0.659968,-0.0533925,0.750062,0.269777,-0.554889,0.119035,-0.308141,0.0943947,0.380011,-0.00112121,-0.61429,-0.330428,0.412293,-0.233198,-0.206515,0.0646055,-0.108649,-0.0460905,0.472002,0.235134,0.180999,-0.298119,-0.442838,0.410182,0.153761,-0.513977,0.131677,-0.224668,0.623722,-0.353578,-0.086463,-0.175906,0.0480922,-0.378079,-0.0766006,-0.117523,-0.220318,0.357438,-0.586396,-0.466917,-0.447581,0.390026,0.199386,0.536127,0.58983,0.611448,0.374863,0.0496653,-0.0148662,-0.0524197,-0.383353,0.39212,-0.0128885,-0.014261,0.0260931,0.0349777,-0.555302,-0.0836288,-0.150615,0.775072,0.406398,-0.0112379,-0.450993,-0.446062,0.280083,0.290071,-0.191319,0.0875372,0.293543,0.514227,-0.311713,0.0491909,-0.236945,0.406878,0.268364,-0.178642,-0.224005,-0.436589,0.247109,-0.468255,0.0530205,-0.000867867,0.443459,-0.214797,0.0621205,0.862086,0.0637271,0.0296862,-0.398438,0.00531913,-0.0113277,0.20652,0.221328,0.21627,0.289663,-0.0708681,-0.380665,0.661431,-0.0505746,-0.239743,0.166912,-0.426597,0.137672,0.0445249,-0.481046,-0.150776,0.243051,0.0292024,0.148844,0.143587,0.0201205,0.108338,0.240208,0.420684,-0.0842782,0.138451,-0.519333,-0.322917,0.78677,-0.246317,-0.329953,-0.13505,-0.199102,-0.00876847,-0.158011,0.575868,0.261944,-0.373447,0.492131,-0.248593,-0.51872,-0.0806463,0.203733,0.0805156,0.270331,-0.241413,0.239489,0.159868,-0.211041,-0.538285,-0.701788,-0.143801,0.442996,-0.451919,0.334074,0.0831521,-0.177015,-0.113153,-0.00679237,-0.18886,0.3502,0.285722,0.394782,-0.27216,-0.198486,-0.189012,-0.104865,-0.140074,-0.452667,-0.0473703,-0.103309,0.0406808,0.314607,-0.157927,0.0813279,-0.114368,0.0886168,0.108309,-0.0669075,0.101857,-0.510331,-0.446272,-0.709068,-0.46295,-0.493056,0.306698,0.123982,0.216421,0.198025,-0.557722,-0.166592,0.249119,0.196686,0.53486,-0.152551,-0.155281,0.52278,0.139126,0.0550003,-0.283246,-0.29518,0.104854,0.394892,0.323811,0.628405,-1.9984 +3442.63,0.948258,0.0912059,4,1.45747,0.885295,-1.08954,0.390448,1.08531,-0.0748502,-0.108691,0.0300367,0.404733,0.370815,0.295799,-0.280493,-0.257686,0.603766,-0.172447,0.590508,0.0611228,0.115302,-0.290032,-0.28863,-0.414455,-0.801852,-1.18973,0.371858,-0.180325,-0.198174,-0.0761908,0.796251,-0.15498,0.469168,0.821408,-0.335337,0.442912,0.161104,0.284035,-0.322059,-0.455934,0.424018,0.764818,0.107483,0.976398,0.753016,1.06318,-0.742745,0.722022,-0.0251401,-0.724922,0.0878219,0.712368,0.550039,0.272995,-0.198103,0.00278933,-0.899645,1.0634,-0.146911,-0.173839,-0.87161,0.661812,-0.63738,0.21821,1.35713,-0.361835,-1.11203,0.131107,0.62102,-0.406491,0.115799,-0.38243,-0.190081,0.0404186,0.688454,0.240494,-0.306674,0.523778,0.62466,0.506336,0.164207,-0.454919,0.0791976,0.256804,-0.1545,0.158066,-0.70774,-0.129993,-0.542755,0.174299,0.188494,-0.112466,-0.334356,0.0342563,-0.117021,0.296181,-0.466538,0.266617,-0.363725,-0.130539,0.0613748,0.178462,0.134681,0.264018,-0.168524,-0.223283,-0.35541,0.422181,-0.36015,0.138702,-0.407667,0.301236,0.441993,-0.276061,0.125502,0.0786633,0.132314,-0.154744,0.438618,-0.0383731,0.16872,-0.0573653,-0.394255,-0.463829,-0.437303,0.3812,-0.163119,0.0282263,-0.335565,0.0862083,0.352424,0.197039,0.263421,0.00834605,-0.412075,-0.148488,0.54637,-0.0285366,-0.261973,0.257577,0.0318825,0.430587,-0.344476,-0.219421,-0.505791,0.27168,-0.52278,0.455783,0.0592851,-0.414266,0.295321,-0.55778,-0.486727,-0.468901,0.357029,0.0765235,0.418085,0.397792,0.669154,-0.115712,0.108184,0.135214,-0.237776,-0.195722,0.342958,-0.123965,-0.244791,-0.190838,0.393004,-0.777512,-0.0753167,-0.0695869,0.46341,0.480206,0.458729,-0.389627,-0.683552,0.252562,0.249974,-0.372484,-0.106185,0.397758,0.612991,-0.00221568,0.122742,-0.154819,0.0581738,-0.24642,-0.75921,-0.25144,-0.634343,0.694058,-0.513785,-0.0393685,-0.164563,0.335906,-0.423829,0.09739,0.582903,0.470027,0.0207191,-0.0744219,0.0624478,-0.187163,0.135768,-0.0676981,0.395009,0.109008,0.168206,-0.265515,0.672319,-0.130911,-0.172763,0.293435,-0.357035,0.10228,0.314067,-0.547855,0.150185,0.111305,0.216951,0.287459,0.0659209,0.174723,-0.614964,0.322326,0.235881,-0.117584,0.235964,-0.522266,-0.217014,0.597758,0.0499076,-0.164788,-0.218296,-0.462436,-0.166103,-0.232427,0.534906,0.201127,-0.605895,0.306505,-0.281195,-0.580143,-0.179289,0.0701743,-0.0307358,0.287946,-0.342097,0.0543636,0.320129,0.0948736,-0.440461,-0.269218,0.0126589,0.507245,-0.331768,0.241536,0.0550703,-0.123739,-0.331811,0.449642,-0.172145,0.173103,0.025768,-0.0421265,-0.217902,-0.230835,-0.228787,-0.114829,-0.276878,-0.152631,0.0913772,-0.10642,0.229869,-0.0646337,-0.105489,0.308638,0.138506,-0.28308,0.0670138,-0.0734828,-0.145538,-0.576994,-0.458043,-0.701711,-0.280994,-0.372358,0.427233,-0.459521,0.639295,0.354348,-0.229322,-0.417335,-0.0699195,0.228158,0.57599,-0.31519,-0.190715,0.270405,0.0135594,-0.357982,-0.0170319,-0.0137978,0.120399,0.362747,0.346986,0.602285,-3.48978 +3436.33,1,0.0912059,4,1.4804,0.863691,-1.05707,0.400814,1.08395,-0.0899763,-0.354412,0.016333,0.586015,0.261263,0.482476,-0.495913,-0.273714,0.328515,0.187697,0.827049,-0.0228503,0.0478996,-0.259172,-0.0561484,-0.115385,-0.826464,-1.16199,0.406831,-0.196507,0.122648,0.0528612,0.728999,-0.602793,0.319512,1.15459,-0.0910647,0.28434,0.554862,0.163458,-0.29958,-0.057124,0.531445,1.02346,-0.118162,1.28471,0.941657,0.914286,-0.747764,0.338816,-0.0200278,-0.419328,-0.123402,0.798973,0.210789,0.0232825,0.34933,0.0396789,-0.772314,1.25816,0.180713,-0.281954,-0.515402,0.646608,-0.796857,0.470837,1.15067,-0.708769,-1.1627,0.0814577,0.594298,0.352651,-0.0106199,-0.508153,-0.64257,0.0724443,0.45886,0.346638,-0.120912,0.93276,0.2871,0.435196,-0.086003,-0.122228,0.230279,-0.125052,-0.235011,0.243335,-0.45462,0.338823,-0.31195,0.59648,0.174267,-0.0801876,-0.303102,0.168413,-0.652393,0.260768,-0.324177,0.223587,0.048393,-0.14285,-0.107657,-0.0198151,0.0709391,-0.186788,-0.206874,-0.542694,-0.566703,0.530368,-0.0574755,-0.0354102,-0.463846,0.256967,0.438688,-0.325031,0.256007,0.15198,-0.115839,-0.238268,0.287702,-0.638618,-0.118126,0.0747034,-0.366984,-0.755642,-0.0823697,0.0895078,-0.0990185,0.409869,-0.0879893,0.0434643,-0.101928,0.0461434,0.101886,-0.482464,-0.0198131,-0.289604,0.545353,-0.0394238,-0.304626,0.0321548,-0.205639,0.0761338,-0.624892,0.132332,-0.133736,0.114878,-0.298926,0.054863,0.191818,-0.0780983,0.0525275,-0.318037,0.203095,0.27853,0.112979,0.175353,0.188847,0.208935,0.372245,-0.136571,0.461497,-0.13173,-0.418108,-0.536268,0.559321,0.291484,-0.205515,-0.0380313,0.171444,-0.577495,-0.378966,-0.152724,0.433372,0.400435,-0.336307,-0.241139,-0.664431,0.379433,-0.162489,0.0531964,0.123156,0.13296,0.718239,0.0457189,-0.0257315,0.0177662,0.330365,-0.354342,-0.460716,-0.427428,-0.368995,0.510334,-0.2943,-0.342371,-0.0965282,-0.210983,-0.654031,0.00504465,0.384861,0.169818,0.148481,-0.297581,0.117882,-0.311206,-0.51073,-0.0636632,0.481403,0.182661,0.485849,-0.832551,0.573348,0.42793,-0.11917,0.30537,-0.0542539,0.148862,0.384984,0.208703,-0.0385149,0.045044,-0.410225,0.173057,-0.42386,-0.127344,-0.364959,0.335549,-0.025875,0.0501144,-0.0802029,-0.572734,-0.262763,0.0276992,0.251179,0.176369,-0.503786,-0.591172,0.152636,-0.444534,0.365843,0.236087,-0.244641,0.224848,0.0812485,-0.920951,-0.0700835,0.268034,-0.342953,0.190973,0.829124,0.362816,0.295684,0.0221958,-0.703957,-0.0994255,-0.157681,0.34822,-0.172361,0.402946,0.203934,0.0293389,0.0335466,0.655703,-0.176843,-0.0162255,0.379238,0.0987219,-0.251168,0.169457,-0.0207741,0.130659,-0.368707,0.334312,0.175152,-0.461667,-0.0115603,-0.765823,0.128285,0.128766,-0.09219,0.0732703,-0.0564727,0.479927,-0.514502,-0.205727,-0.478978,-0.658508,-0.0632463,-0.221427,0.192064,-0.405588,-0.111253,0.0287039,-0.0661037,-0.328998,0.345324,-0.277111,0.213333,0.0103343,-0.261459,-0.533563,-0.34836,-0.295567,-0.0834845,-0.191487,0.108475,0.331842,0.329355,0.576057,-3.44726 +3424,0.438213,0.0912059,4,1.52151,0.812938,-0.765393,0.349366,1.3044,-0.117942,-0.0219501,0.373165,-0.0267309,-0.0515225,0.335022,-0.0919864,-0.199835,-0.114428,-0.377385,0.664581,-0.111371,0.318957,0.309713,-0.157142,-0.0975966,-0.46355,-0.446381,0.58145,0.337115,0.379632,-0.0459474,0.534948,-0.189634,0.259297,1.02295,-1.20241,0.429596,0.48873,-0.18556,-0.417675,-0.08053,0.866172,0.51536,0.14763,1.0567,0.340424,-0.39476,-0.334185,0.253597,-0.0629171,-0.140071,0.131668,0.25862,0.2727,0.127536,0.690394,0.154962,-0.0421641,0.913907,-0.221478,0.0513066,-1.04701,0.810776,-0.401841,-0.0966686,1.17981,-0.515104,-0.690252,-0.165508,-0.398426,-0.432482,0.134749,0.498363,-0.211816,0.154966,0.378357,0.604622,-0.110244,0.335169,0.611884,0.0996717,0.138366,-0.420779,-0.0863911,0.725407,-0.30393,-0.350782,-0.520774,-0.422225,0.42352,-0.838608,-0.56565,0.160468,-0.555733,0.0855017,0.530632,-0.188326,0.249477,-0.100189,-0.390133,-0.224992,-0.425762,-0.587351,0.206946,0.0141455,-0.133373,0.0948126,0.0297583,0.215355,-0.462471,0.391421,-0.248408,0.0840048,0.454699,-0.0569008,-0.220679,0.0165656,0.209163,-0.321911,0.138625,0.0340074,0.267026,0.378973,-0.077613,-0.68559,0.258833,-0.0703254,-0.291141,-0.557969,0.313627,0.760404,0.406792,0.290264,-0.473388,0.646228,-0.132962,0.139617,0.615604,-0.262305,0.264279,0.103704,0.0853908,0.687605,-0.194846,-0.0490144,-0.331009,-0.53605,-0.473862,-0.0351699,-0.00894713,0.0492562,0.392926,-0.163091,-0.359216,-0.143061,0.0436181,0.0667601,-0.00543129,-0.637219,-0.146782,0.363966,-0.530244,-0.00826444,0.0140259,0.40425,-0.282975,0.80511,-0.207915,0.139938,-0.423214,-0.0662573,0.219369,-0.0770042,-0.408504,0.288934,0.224142,-0.349697,0.238394,-0.588328,0.33126,-0.433764,-0.2961,0.22113,0.288866,0.136911,-0.34959,0.0598829,-0.110921,0.0171264,0.112112,-0.273489,-0.165496,-0.128974,-0.54917,0.292406,-0.324167,0.575395,-0.0328542,0.139838,-0.0600777,-0.0691411,-0.298353,-0.234418,0.0818021,-0.208456,-0.304787,0.0213578,-0.314787,-0.493808,-0.370498,-0.256035,1.03203,-0.444256,0.120853,-0.542669,-0.0305564,0.21754,0.123798,-0.68987,0.448332,-0.271697,0.29313,-0.740685,-0.303924,0.406836,-0.814891,0.0508626,0.107231,-0.433182,0.407526,0.205509,-0.261339,0.402979,-0.174512,-0.257045,-0.00719964,0.0155275,-0.303881,-0.281814,0.588545,-0.147585,-0.301412,0.475637,-0.24345,0.233519,0.326168,0.501563,-0.155002,0.574702,-0.922679,0.533118,0.471819,-0.051039,0.197524,-0.175368,-0.0872566,0.531795,-0.437706,-0.202206,0.388212,-0.444801,0.0293551,0.103734,-0.154603,-0.192844,0.207143,0.194319,0.57305,0.591051,0.323956,-0.272825,0.426545,-0.294492,-0.227793,2.38941e-05,-0.206982,0.588767,-0.229701,-0.236263,-0.285382,-0.216443,-0.143142,0.380338,0.0835098,-0.0510919,0.156302,-0.294712,-0.0732732,0.109803,0.213279,0.118742,-0.165537,0.24104,0.455501,0.114332,-0.338065,0.393679,0.0619586,0.00394241,-0.31029,0.570247,0.0573029,0.0939933,0.0920099,0.339929,0.125741,0.244868,0.3546,0.494842,-4.14575 +3424.75,0.539505,0.0912059,4,1.54159,0.774286,-0.977657,0.328563,0.956781,-0.175638,-0.221006,0.493397,-0.0506382,0.04208,0.354727,-0.0281533,-0.18382,0.0221442,-0.50838,0.574316,0.0355323,0.0484207,0.166267,-0.0251361,-0.0887312,-0.856663,-0.601626,0.55138,0.380107,-0.291986,0.1208,0.40265,-0.315854,0.0497161,0.623391,-0.646194,0.186516,0.663569,-0.338689,-0.0611168,-0.396855,0.40198,0.344321,-0.0380301,0.824329,0.0926069,-0.107209,-0.452605,0.111569,-0.0160585,-0.413463,-0.0563713,0.199434,0.244269,-0.232343,0.155676,0.399281,-0.326756,0.981945,0.0549056,-0.10184,-0.807322,0.47566,-0.848839,0.278366,1.394,-0.56706,-0.457289,0.122613,-0.128164,-0.501415,-0.259816,0.317555,-0.428177,0.15055,0.384411,0.796975,-0.0616793,0.0337329,0.481174,0.322153,0.17922,-0.427325,0.293495,0.261829,-0.161814,-0.236575,-0.769029,-0.360888,-0.0120676,-0.429803,-0.132898,-0.146318,-0.717438,-0.0974472,0.272562,0.000873578,0.31889,-0.25763,-0.583315,-0.425089,-0.406196,-0.0973785,0.518026,0.408401,0.019055,0.249468,-0.00740895,-0.206839,-0.357042,0.719722,-0.137848,-0.230893,0.321917,0.0456453,-0.37978,-0.155332,0.238277,-0.224893,0.397605,-0.259797,-0.0233054,0.68727,-0.368698,-0.738782,0.50678,0.296713,-0.0950252,-0.141022,0.109202,0.845167,-0.165576,-0.0374574,-0.634781,0.0213945,-0.102513,0.0249956,0.495801,-0.130004,0.324349,-0.612843,-0.425858,0.661415,-0.403028,-0.303169,-0.0726008,-0.0380562,-0.481831,0.0411003,0.106442,-0.118372,0.346601,-0.347802,-0.293732,-0.544546,-0.043417,0.406499,0.219623,-0.0620923,0.129817,0.649622,-0.10656,0.179608,0.257678,-0.162807,-0.334154,0.699344,-0.125285,-0.261611,-0.23342,-0.0929431,0.100191,-0.171756,-0.361151,0.1653,0.0428111,0.0201932,-0.0468233,-0.466997,0.143949,-0.219124,-0.00359618,0.623044,0.287795,0.0522541,-0.206697,0.0538398,-0.113496,0.0106055,0.129257,0.580375,-0.080477,-0.0816905,0.081636,0.331539,-0.210598,0.48326,-0.0736097,0.393168,-0.556376,-0.11589,-0.481101,-0.0052826,-0.417314,-0.250345,-0.377904,0.000313619,-0.336081,-0.43565,-0.095218,-0.198971,1.07439,-0.368002,-0.476843,-0.554723,0.444587,0.142803,0.629193,-0.517388,0.25733,0.13161,0.057222,-0.564922,-0.244588,0.198821,-0.418558,0.0742829,-0.134722,-0.283316,0.422878,-0.00370153,-0.622607,0.24404,0.0753075,-0.693475,0.100585,-0.470331,-0.182578,-0.411946,0.427182,-0.170059,-0.316377,0.20809,-0.516491,0.187332,0.154495,0.635321,0.0668217,0.247608,-0.226821,0.267635,0.317802,-0.574444,0.45199,0.23002,-0.18213,0.351051,-0.385523,-0.324206,-0.0675136,-0.419001,0.165825,0.0375932,-0.103616,-0.0755108,0.487707,0.380968,0.715188,0.561269,0.154517,-0.160671,-0.12047,-0.35964,-0.0726324,0.408764,-0.347274,-0.107982,0.106329,-0.223134,0.00873201,0.117436,0.199057,0.275933,0.253398,-0.203297,-0.126743,-0.195147,0.493932,0.431711,0.114185,0.0239104,0.146639,0.649857,0.249801,0.018166,-0.316237,0.502995,0.066588,-0.135689,0.0209597,0.33994,-0.0967459,0.0879186,0.418647,0.158785,0.11081,0.181738,0.332881,0.426307,-2.75763 +3396.03,0.848395,0.0912059,4,1.59664,0.814149,-2.03999,0.675248,0.890235,-0.132539,-0.269957,-0.667943,-0.26967,-0.639313,0.0447288,-0.330312,-0.509369,0.127926,-0.387719,0.645041,-0.295412,-0.462207,-0.420782,-0.461327,-0.0366658,-1.02613,-0.873681,-0.0996743,-0.774207,0.125041,-0.342452,0.350476,-0.372445,-0.280483,0.582895,-0.685032,0.0373163,0.12241,-0.259796,-0.263015,0.120341,1.22439,0.926383,-0.210234,1.08454,0.451801,0.914436,-0.646361,0.0169491,0.315634,-0.231311,0.305793,0.390079,-0.235259,0.256464,0.701346,-0.495688,0.145799,0.444811,-0.318927,-0.254633,-0.160368,0.423881,-0.225905,-0.217439,1.08097,-0.49629,-1.52997,0.343665,0.188204,-0.194087,0.286939,0.139321,-0.465075,-0.504679,-0.0989583,0.56237,-0.274554,0.352712,0.435174,0.685753,-0.207972,-0.0504914,-0.165916,0.445278,-0.219374,0.429913,0.0797921,0.0743011,0.313418,-0.261664,-0.390469,0.138239,-0.108158,0.275859,-0.568225,-0.09151,-0.300086,0.130248,0.298698,0.275321,-0.347528,0.166222,-0.0770426,0.151951,0.49657,-0.878522,-0.227876,0.641388,0.550757,-0.350717,-0.168099,-0.039849,0.402906,-0.0528714,0.12064,0.165865,0.342849,0.229706,-0.194572,-0.343241,0.235594,0.0995109,0.0957028,-0.600617,-0.269318,0.304808,-0.433215,-0.423592,-0.498518,-0.428561,0.264846,0.211385,-0.13186,0.332983,0.0139968,-0.0333282,0.255367,-0.017277,-0.42009,0.214795,-0.04148,0.0565245,-0.111078,-0.390769,-0.143913,-0.149806,-0.337103,-0.340019,-0.0931906,-0.632946,0.385217,-0.173914,-0.321587,0.195974,-0.0129413,-0.0540577,-0.252203,0.669764,0.161725,0.030754,0.441094,0.261985,0.236012,-0.0670552,0.677896,0.174075,0.424433,-0.151617,0.62766,0.0172999,0.448443,-0.169981,0.0282894,0.475795,-0.340234,-0.101422,0.0282497,0.436046,-0.660269,-0.490862,-0.438784,-0.213472,0.595523,-0.255183,-0.154749,-0.127807,-0.208708,0.21151,-1.03263,-0.730115,-0.476758,0.168408,-0.353854,0.0408272,0.0426172,-0.532582,-0.653507,-0.595326,0.934423,0.205087,-0.444645,-0.305067,0.178677,0.0511256,-0.783424,0.155498,-0.322138,0.0768655,-0.187817,-0.141131,0.275217,0.0796354,0.279402,-0.0928545,-0.171629,0.328794,-0.0398829,-0.622764,0.390118,-0.504198,0.183694,1.11332,-0.435622,-0.408625,-0.176918,-0.0134141,-0.0446657,-0.0838437,0.135631,-0.411377,-0.141257,0.100641,0.138451,-0.657811,0.0147553,-0.386484,0.046561,-0.0894141,0.330607,-0.18616,0.157205,0.30784,0.0508811,-0.343468,-0.2931,-0.195211,-0.588763,0.535195,0.197407,0.594088,-0.490029,0.0618841,-0.758399,0.100409,-0.550588,0.533859,0.242972,-0.12426,0.141787,0.0304104,0.0955086,0.166722,0.167402,-0.0317955,0.0542597,-0.521618,-0.718244,-0.366144,0.224293,-0.184229,-0.328494,0.166476,0.169839,-0.274711,-0.579408,-0.027587,-0.0615911,-0.114367,-0.0439262,0.13049,-0.401621,0.435719,-0.0122842,0.317982,0.121335,0.258085,-0.639829,-0.0241086,0.825481,-0.192314,0.360716,0.13595,0.212138,0.167579,0.592336,0.0439571,-0.330178,-0.355577,-0.24579,0.161146,-0.282446,0.0772119,-0.208578,-0.437423,0.119714,0.23022,0.345998,0.479812,-2.33352 +3405.97,0.982516,0.0912059,4,1.43289,0.991605,-0.939935,0.233096,0.607867,-0.119607,0.153919,0.431521,0.531116,-0.0418127,0.385995,-0.06558,-0.294814,0.456083,-0.196153,0.707259,0.168367,0.100696,-0.146701,-0.406114,-0.226341,-1.08306,-0.740764,0.360676,-0.166344,-0.289845,-0.0627113,0.323308,-0.288991,0.216147,0.630157,-0.707287,-0.236278,0.348891,-0.323744,0.327325,-0.297077,0.436165,0.617787,0.0250803,0.920373,0.945342,0.167119,-0.578284,-0.25405,-0.77129,-0.308797,0.191214,0.364653,0.171814,0.30393,0.492224,0.531596,-0.369492,0.934107,0.473568,0.171278,-0.730198,0.364698,-0.498526,0.729709,1.32166,-0.17728,-0.491157,0.485214,0.114067,-0.132119,-0.182962,-0.0167428,-0.139725,0.215071,0.512452,0.302957,0.183029,0.299559,0.289707,-0.329866,0.367691,-0.295879,0.363853,0.412483,-0.437282,-0.326052,-0.412907,-0.264835,-0.386661,0.0851058,0.0596648,0.160683,-0.804413,-0.155415,0.783271,0.0525573,0.248628,-0.15382,-0.623643,-0.196364,-0.370402,0.0226729,0.63175,0.0276108,-0.6722,0.357658,0.165002,0.0974755,-0.873486,0.686891,-0.192621,0.95693,0.374967,-0.236152,-0.131529,0.0381869,0.27314,-0.385057,0.36336,-0.505358,0.067619,0.303412,0.036424,-0.786074,0.12463,-0.504166,-0.370374,0.281894,0.401041,0.817029,0.140765,0.307669,-0.559539,-0.0761067,-0.21618,-0.275971,0.429007,-0.286296,0.0400419,-0.0647738,-0.108155,0.725066,-0.899108,-0.443881,-0.14417,0.298995,-0.720867,0.366177,0.250222,0.205173,0.398991,-0.252384,0.118436,-0.471773,0.322689,0.369438,-0.0954542,-0.331287,0.371051,0.267678,-0.341336,-0.133392,-0.174456,0.191174,-0.641246,1.45904,-0.259368,-0.037746,-0.235128,-0.0592646,-0.181883,-0.303807,-0.0568527,0.106263,0.244432,-0.344269,-0.25996,-0.267146,0.131486,0.237049,0.34405,0.661846,0.221941,0.271197,-0.146618,0.2376,0.0321137,-0.315183,0.38743,0.208933,0.0267606,0.0875356,-0.389904,-0.207743,-0.3047,0.352615,-0.363903,0.292163,-0.478969,-0.0881296,-0.193784,-0.280971,0.109937,-0.410371,0.243111,-0.20591,0.0690476,-0.142416,0.116166,-0.552466,1.12475,-0.128121,-0.116304,0.240425,-0.0255104,-0.213681,0.384433,0.351229,0.0912758,0.115185,0.139254,-0.474451,0.179989,0.484017,-0.443971,0.0200818,0.135653,-0.461805,0.629991,-0.0439876,-0.43946,0.56684,-0.0352468,0.315026,0.134732,-0.379302,-0.118967,-0.691677,0.68722,0.400376,-0.0848128,0.227504,-0.347868,0.418275,0.286403,0.0494417,0.427744,0.0835313,0.265268,0.455744,0.704386,-0.165018,0.069131,-0.00906115,-0.296468,0.222754,-0.64602,-0.00308962,0.434947,-0.319352,0.417667,-0.127154,-0.194256,0.31412,0.505806,0.551617,0.76665,0.306996,0.0040855,0.110677,0.0079554,-0.278187,0.115768,0.149451,0.191564,-0.336339,0.214547,0.223719,-0.109726,0.211108,0.341723,0.134653,0.0746897,-0.273437,-0.54182,-0.890254,0.664372,0.2677,0.0066928,-0.107255,0.235457,0.250606,-0.415938,-0.0176794,-0.271539,0.0158649,0.289564,0.529341,-0.250781,-0.0417568,-0.0588394,-0.283835,0.289987,0.201101,0.117755,0.274535,0.343154,0.523961,-2.03551 +3438.66,0.917498,0.0912059,4,1.43061,0.924842,-0.947458,0.257009,0.942897,-0.150949,0.191607,-0.0479624,0.569696,0.424879,-0.120614,0.19349,-0.167521,0.116428,-0.2586,0.651638,0.0289617,0.169913,-0.276502,-0.212426,-0.694836,-1.01652,-0.903235,0.440643,-0.112293,-0.210823,0.239601,0.0419956,-0.208599,0.0500118,0.699301,-0.457535,0.0377701,0.197589,0.108801,-0.038908,-0.541555,0.608671,0.766345,-0.447325,0.914289,1.07387,0.170673,-0.25055,-0.467309,-0.0177807,-0.0370973,-0.047741,0.495641,-0.00543761,0.602471,0.0582365,0.425868,0.603425,1.24474,0.287494,0.386021,-0.769612,0.737755,-0.68387,0.350193,1.35259,-0.46596,-1.14134,0.526881,0.110197,-0.0374047,-0.000495104,0.433609,-0.336082,-0.000757092,0.228358,0.343989,0.342488,0.447746,0.48405,0.14352,0.188221,-0.101085,0.428644,0.358471,-0.510248,-0.147286,-0.530145,0.12486,-0.362091,-0.00542875,0.0370368,-0.117528,-0.356431,-0.523911,0.447689,0.232062,-0.00158972,-0.0270229,0.413194,-0.021558,-0.137372,0.298306,0.790409,0.165783,-0.418918,-0.254052,-0.422165,0.301173,-0.681281,0.564336,-0.190452,0.530961,0.358352,0.0867876,-0.011983,-0.265297,0.24411,0.264707,-0.116269,-0.613371,0.0336639,0.380859,-0.0811408,-0.80203,-0.342524,0.0985472,-0.19756,0.636558,0.413925,0.78902,-0.0308592,0.151545,-0.39001,0.100397,0.0306117,0.237046,0.648725,0.0787853,-0.0356035,0.0968582,-0.0585601,0.781253,-0.668866,-0.027385,-0.40045,0.116952,-0.238288,0.322593,0.246262,0.220075,0.151359,-0.175833,0.192568,-0.117852,-0.368213,0.337992,0.0424374,-0.511317,0.538484,0.600475,-0.172334,0.188927,-0.419126,0.305354,-0.428132,1.16743,-0.163507,-0.17757,0.140675,-0.254915,-0.436413,-0.301804,0.644765,0.0790939,0.338462,-0.155106,-0.492459,-0.193913,0.0477374,-0.268381,0.619683,0.0433982,0.470755,0.230547,-0.406836,0.264354,-0.201091,0.0535136,-0.113663,-0.00417223,-0.0167165,-0.0449582,-0.473169,0.0139783,-0.123309,0.166248,-0.356705,0.333727,-0.198229,0.0138263,-0.199776,-0.370089,-0.00192048,-0.301356,0.0523557,0.186405,-0.393084,-0.172084,-0.0458197,-0.692643,0.963012,-0.0768304,-0.285694,0.151545,0.0606123,0.0955753,0.596408,-0.473126,0.209916,0.0893611,-0.150035,-0.428918,0.0766826,0.251109,-0.351744,0.366855,0.572066,-0.262436,0.6365,-0.445615,-0.310867,0.423331,0.023212,-0.0961677,-0.172642,-0.272115,-0.0456442,-0.291133,0.58768,0.428028,-0.126574,0.409015,0.02004,0.179956,0.289983,-0.412742,0.082312,-0.179164,0.253536,0.672945,0.502114,-0.321983,-0.358471,-0.236986,-0.227709,0.266507,-0.673769,-0.11321,0.0516086,-0.252132,-0.0818089,-0.120416,-0.0542387,-0.189692,0.464853,0.413741,0.72687,0.0520958,0.273252,0.339122,0.148812,0.157298,0.105253,-0.174189,-0.220891,0.552804,0.444236,-0.11411,0.17627,0.032839,-0.0838487,0.393569,-0.0866706,-0.0439832,0.177794,-0.674827,0.582565,0.0622268,0.19472,-0.268426,0.0989213,0.36085,-0.105052,-0.0836381,-0.452845,-0.347641,0.202842,0.258241,-0.259226,0.00710213,-0.103538,-0.0359677,6.99901e-05,-0.345508,0.141035,0.262266,0.375546,0.512119,-3.04287 +3438.97,0.755648,0.0912059,4,1.65128,0.672379,-0.793673,0.350864,0.150466,-0.076,-0.0103308,0.0281056,-0.056048,-0.0414774,0.55188,-0.351548,0.185732,0.703693,-0.219097,1.17645,0.482192,0.20534,0.210772,0.41106,0.340128,-0.301904,-0.645841,0.560746,-0.338414,0.268004,-0.0692624,-0.0296709,-0.641944,0.305411,1.2918,-0.722731,-0.0248976,0.550155,-0.0546242,0.0689729,-0.780107,0.399384,0.342213,-0.298786,0.736808,0.543027,0.304603,-0.783103,0.0288481,-0.500715,-1.31852,0.360735,0.696442,-0.272137,-0.281247,0.389638,0.343091,-1.472,0.72056,-0.26611,-0.405435,-0.300226,0.586601,-0.222897,-0.024796,0.89905,-0.62477,-0.744942,-0.11687,0.0780872,0.104083,-0.00494889,-0.272005,-0.579003,-0.0880145,0.153881,0.619736,-0.216408,0.383473,0.369363,0.414826,-0.236498,-0.663882,-0.409655,0.185131,-0.0267563,0.266934,0.142788,-0.425224,-0.0183792,-0.0211883,-0.401222,0.0787244,-0.320617,0.837937,-0.193051,-0.450249,-0.0731197,0.0470344,-0.564244,0.00306932,-0.610522,0.105915,-0.245613,-0.337832,0.273052,-0.439189,-0.0662805,0.231447,-0.111844,0.0519394,-0.415208,0.0978007,0.959582,-0.0949357,-0.631678,0.609561,0.396129,-0.32303,-0.0559082,0.0557157,0.230932,0.0749999,0.321534,-0.57688,0.131023,-0.265461,-0.23884,-0.876484,0.135694,-0.288053,0.0790815,0.0555996,-0.316229,0.0935586,-0.255003,-0.117295,0.0889913,-0.344423,-0.138257,-0.289156,-0.402929,-0.0236211,-0.423046,-1.10452,-0.00784222,0.0332939,-0.50699,-0.441673,-0.0867869,0.107742,0.18564,-0.247712,-0.235221,-0.120441,0.254864,-0.125865,-0.172327,0.895551,0.0165458,-0.546361,0.266452,-0.0155679,0.0400046,0.0979395,0.479009,0.232444,0.526042,0.420699,-0.150983,-0.0882984,0.152314,0.295134,-0.594886,-0.252519,-0.564449,-0.111419,0.288373,-0.252594,-0.286337,-0.229581,-0.566841,0.311334,0.5765,-0.0706297,-0.00168843,-0.215339,0.162986,-0.0442314,-0.213828,-0.422911,-0.635259,0.386169,-0.277059,-0.181622,0.312117,-0.356496,-0.526198,-0.17775,0.303263,-0.173207,-0.318439,-0.832759,0.21299,-0.0743857,-0.392819,-0.01247,0.143095,0.299589,0.149619,-0.127801,0.650801,0.276135,0.581442,-0.445866,-0.452074,0.0101278,-0.100514,0.057423,0.0437329,-0.264223,0.328107,0.499427,-0.559498,-0.242872,-0.354048,-0.0947162,-0.142054,-0.149666,-0.193911,-0.132878,0.151857,-0.265373,-0.397047,-0.509864,0.139664,-0.0517815,-0.5236,-0.126722,0.413596,-0.356268,0.192251,0.317572,-0.395895,-0.230767,-0.241346,0.205157,0.0351144,0.68036,0.160276,-0.0337827,-0.269886,-0.0405644,-0.317054,0.495165,-0.863577,0.561241,0.0549405,-0.326201,0.16262,-0.18017,-0.0519436,0.226823,-0.050339,0.516969,0.112605,-0.460869,-0.402245,0.452285,-0.089543,-0.328694,-0.131809,-0.109674,-0.20759,-0.0840515,-0.219005,-0.45833,-0.391475,0.0529282,0.0251244,0.215198,-0.0412024,0.0911382,0.246281,0.00843247,-0.363744,0.439746,-0.556514,-0.0881025,0.280778,0.318102,0.415741,-0.611882,-0.139163,-0.0489194,0.314735,0.26167,0.279809,-0.236068,-0.300714,0.0718126,-0.182249,-0.138185,-0.0504643,0.144908,0.140869,0.300945,0.375325,0.548585,0.0662897 +3434.62,0.704676,0.0912059,4,1.48301,0.593763,-0.984537,0.49218,0.895861,-0.00239473,-0.121352,0.28393,0.951278,-0.338608,0.313126,0.395461,-0.764035,0.427276,0.035499,1.03337,0.605072,0.21873,-0.16137,0.582459,0.511736,-0.518991,-0.742198,0.760127,-0.408946,-0.784837,0.309882,0.68458,-0.239986,0.280788,1.17929,-0.445649,0.0853467,0.609449,-0.235742,-0.512126,0.0342865,0.783271,0.76193,-0.435178,1.0085,-0.330337,0.316524,-0.481231,-0.214648,-0.187794,-0.983017,-0.32465,0.362537,0.185833,0.0625671,0.222421,0.164185,-0.0565504,0.429839,-0.304474,-0.027593,-1.14131,0.682214,-0.453395,0.116694,0.840775,-0.564508,-0.816773,0.298183,0.0486183,-0.337786,-0.511776,0.725647,-0.109121,-0.0800641,0.808033,0.546234,0.402942,0.0474131,0.427516,0.239156,0.249454,-0.438038,0.138276,0.357914,-0.277133,0.043899,-0.435625,0.133537,-0.254897,-0.52067,0.276376,0.34086,-0.445294,-0.230547,0.320474,0.263429,-0.0637767,0.349016,-0.208453,-0.356917,0.0497994,0.258557,0.457567,0.921001,-0.577236,-0.140452,-0.336311,0.0199688,-0.059492,0.483386,-0.117547,0.32774,0.645527,0.179497,-0.24144,-0.345491,0.914934,0.222279,0.513154,-0.549331,-0.0825196,-0.0222151,-0.247355,-0.745042,0.0311792,-0.321383,-0.196785,0.743332,-0.271421,0.183512,0.393357,0.109509,-0.171091,0.0691749,0.319964,0.164212,0.302816,-0.106761,0.113372,0.265616,-0.433509,0.398272,-0.360474,0.0576403,-0.0552007,0.487753,0.0390993,0.188385,0.458612,0.108734,0.378576,-0.207923,-0.139128,-0.217014,-0.0267415,0.473159,0.258255,-0.219381,0.304596,0.529028,-0.275304,-0.00251576,0.135251,0.113962,-0.198077,1.11984,0.0174957,0.603691,-0.252045,-0.204295,-0.174421,-0.148315,0.30815,-0.0185361,0.300746,0.536201,-0.0100506,-0.286202,-0.0142519,-0.259546,-0.0903352,-0.00103598,0.778177,0.390877,-0.44302,0.187262,0.0489178,-0.259015,-0.234102,0.266706,0.0773281,0.114083,-0.429742,0.342064,-0.313317,-0.0629572,-0.504044,0.273567,0.269328,0.112789,-0.426014,-0.540424,0.328483,-0.0639089,0.259793,1.22818,-0.178165,-0.069514,-0.210564,-0.688282,0.921601,-0.232558,-0.388475,0.506493,0.330068,0.456312,0.400396,-0.388744,0.109864,0.0393362,-0.0837925,0.250993,-0.370658,0.408689,-0.135702,-0.199347,0.512955,-0.48921,0.689959,-0.404944,-0.236346,-0.174919,0.0861019,0.183551,0.479944,-0.540474,0.423558,-0.342306,0.443388,0.0667299,0.0423586,0.692896,-0.370506,-0.34321,0.121972,0.142472,-0.144358,-0.443968,0.632038,0.676863,-0.199841,0.383309,-0.447201,-0.589939,-0.502818,-0.0861601,-0.294066,-0.0826156,-0.0976316,-0.553252,0.168525,-0.218217,0.00425453,0.289563,0.330634,0.557388,0.052066,0.384254,0.0586292,0.00822977,0.149323,0.455009,0.069242,-0.210126,-0.274699,-0.26452,-0.160346,-0.0460652,-0.077349,-0.18093,0.319903,-0.0812957,-0.408106,-0.0106179,-0.0380735,0.365802,0.656181,0.0073981,0.389806,-0.424798,0.161241,0.141425,0.0578981,0.579688,-0.184027,0.0513148,-0.00262904,-0.0736759,-0.785849,-0.218563,-0.105346,-0.593834,-0.555894,-0.474922,0.153711,0.32259,0.39206,0.56797,-2.48968 +3429.54,0.932699,0.0912059,4,1.4859,0.646631,-1.09612,0.514928,0.815082,9.52893e-05,-0.200898,0.3402,0.881136,-0.319453,0.286936,0.415544,-0.84667,0.308133,0.122072,0.899742,0.588707,0.256004,-0.142506,0.523108,0.386203,-0.392939,-0.766739,0.793442,-0.43442,-0.794297,0.204193,0.740394,-0.263131,0.305396,1.13208,-0.507412,0.0173783,0.563225,-0.368336,-0.41947,0.0348538,0.780819,0.64304,-0.485488,1.02064,-0.33164,0.292697,-0.434715,-0.262773,-0.185041,-0.876188,-0.258336,0.322775,0.174459,0.0606598,0.25309,0.343562,0.0488127,0.404705,-0.400412,-0.183396,-1.11063,0.627366,-0.246699,0.0260125,0.910005,-0.593011,-0.641981,0.409164,0.189747,-0.371311,-0.503647,0.676858,0.0308935,-0.055845,0.798735,0.478508,0.32481,-0.0286479,0.276835,0.214094,0.150173,-0.425156,0.104425,0.403763,-0.260624,0.00485045,-0.452438,-0.0245515,-0.33042,-0.480616,0.363848,0.296961,-0.46132,-0.374147,0.276289,0.30357,-0.013476,0.200097,-0.0155613,-0.186742,0.0107948,0.354439,0.443713,0.945114,-0.618871,-0.00229305,-0.286787,0.120018,-0.0396936,0.615233,-0.0849172,0.423941,0.703672,0.12487,-0.222922,-0.149441,0.943094,0.201222,0.378741,-0.569218,-0.0235152,0.102436,-0.263938,-0.726745,0.0494203,-0.275456,-0.282551,0.549191,-0.278523,0.194331,0.355363,0.205438,-0.204492,-0.00741284,0.370906,0.0854377,0.422151,-0.144296,0.192434,0.291072,-0.358757,0.478913,-0.38002,0.146071,-0.092409,0.353956,0.000809938,0.234385,0.519976,0.0244651,0.440197,-0.265178,0.00404418,-0.137639,-0.101958,0.528253,0.289058,-0.149221,0.23528,0.321198,-0.376962,0.00161399,0.225557,0.0242051,-0.231871,0.998509,-0.0157689,0.48765,-0.281282,-0.225276,-0.191171,-0.200572,0.401481,-0.0458236,0.103315,0.516506,-0.0644914,-0.380097,0.131555,-0.406682,0.0136131,0.0614072,0.781544,0.39211,-0.382462,0.179877,-0.0790943,-0.148454,-0.234882,0.335573,0.135677,0.177605,-0.566225,0.227686,-0.334713,-0.0226164,-0.544979,0.295194,0.229491,0.0524083,-0.304849,-0.500303,0.292772,-0.138741,0.201644,1.35397,-0.029953,0.0898065,-0.330656,-0.748651,0.983152,-0.231773,-0.41247,0.492082,0.355644,0.372565,0.228053,-0.433614,0.153071,-0.00280394,-0.196459,0.324135,-0.497579,0.478213,-0.183319,-0.130292,0.671681,-0.3965,0.710126,-0.408054,-0.360704,-0.175115,0.156715,0.151657,0.413918,-0.630371,0.507296,-0.345874,0.381739,0.0326608,-0.0351139,0.800786,-0.299183,-0.334982,0.0107926,0.303994,-0.0303248,-0.49292,0.445373,0.806923,-0.170731,0.454625,-0.499568,-0.7284,-0.483103,-0.134581,-0.215782,-0.0339545,-0.104954,-0.676279,0.261322,-0.145329,-0.00250691,0.402709,0.353028,0.434764,-0.0345444,0.346829,-0.076398,0.130657,-0.0207323,0.421525,-0.00580826,-0.129233,-0.275453,-0.350402,-0.100832,0.0925032,-0.136158,-0.193165,0.30255,0.00296714,-0.474231,0.0274399,-0.256798,0.414178,0.535687,0.0677564,0.250228,-0.49966,0.098715,0.175079,-0.0392176,0.476252,-0.188287,0.119372,0.0192285,-0.035701,-0.658522,-0.140139,-0.105879,-0.63254,-0.557998,-0.354126,0.146756,0.287328,0.383087,0.53603,-2.27565 +3395.63,0.682195,0.0912059,4,1.41196,0.715207,-1.23554,0.417576,0.557109,-0.0373671,-0.827404,0.406082,0.606479,-0.501272,0.0366938,-0.140707,-0.341638,0.68586,0.135815,1.19327,0.495188,0.108989,-0.0289597,0.475816,0.168935,-0.386903,-0.917367,0.483159,0.0764687,-0.383261,-0.17372,-0.10108,-0.320253,0.545614,0.961906,-0.743233,0.035392,0.216069,-0.0429677,-0.309061,0.0702344,0.650239,0.442902,0.387466,1.25383,0.291661,0.543764,-0.275216,-0.0784862,-0.0936914,-0.780185,-0.0287951,0.714946,0.404462,0.278378,-0.181926,0.0610436,-0.190174,0.639401,-0.00388086,0.0791269,-0.573113,0.982161,-0.246596,0.349736,0.773251,-0.532311,-1.07141,0.46338,0.434605,-0.0738189,0.0784186,0.286573,0.0400378,-0.0257657,0.274112,0.515025,-0.00718541,0.357697,0.523948,0.220003,-0.116049,-0.504102,0.263393,0.500395,-0.559135,0.222011,-0.842361,0.440429,-0.124631,0.312645,-0.116704,-0.398167,-0.0774172,-0.387119,0.799682,0.302248,0.146402,0.0283943,-0.501614,-0.272615,-0.104466,-0.268603,-0.0636441,0.678506,0.26862,-0.173538,-0.243406,0.819241,0.208826,-0.0431638,-0.359651,0.418643,0.529964,-0.273841,-0.0776921,-0.0377721,0.875437,0.514889,0.107565,0.164737,-0.28203,0.122494,-0.290231,-0.945049,-0.400721,0.0850565,0.112858,-0.150553,0.198341,-0.192702,0.104884,0.370993,-0.159778,0.415733,-0.145701,-0.345842,0.227917,-0.724131,0.0716376,-0.158816,-0.179831,0.192135,-0.472846,0.362865,-0.185651,0.00311378,-0.334527,-0.242477,0.171508,0.167641,-0.0761606,0.101733,0.560575,-0.303836,0.422171,0.319317,0.78398,0.712719,-0.198459,0.202851,0.322911,-0.152126,0.106518,0.0942519,-0.339293,0.811255,0.135646,0.267709,-0.086236,-0.484757,-0.525714,-0.730716,0.464209,0.241342,-0.0558624,0.37247,0.00703097,0.031931,0.0140168,-0.0517136,-0.89511,0.417547,1.14483,-0.0448093,-0.774592,-0.824526,0.272445,0.0169971,-0.103896,-0.0515812,-0.111985,-0.0792009,-0.317026,-0.109262,-0.0188785,-0.379762,-1.32682,0.41263,0.203486,-0.586254,-0.474248,-0.791724,-0.260694,-0.132305,-0.697376,0.501883,0.173485,0.140963,-0.354732,-0.189444,0.945819,-0.215227,0.16179,0.6,0.102249,0.344692,0.33389,-0.328689,0.864953,-0.99946,0.314998,0.209175,-0.124008,-0.361303,0.162867,-0.37125,0.00356638,-0.691656,-0.23991,-0.758421,-0.325815,0.594369,-0.0940771,0.104701,0.667037,-0.762669,-0.211201,0.368148,-0.239213,0.204793,0.386795,0.651108,0.230626,-0.343137,0.0840847,0.475466,-0.0359655,-0.101406,0.055508,0.560795,0.222967,-0.00151655,-0.510306,-0.344997,-0.918602,0.171164,-0.655444,-0.347198,-0.395203,-0.547788,0.371604,0.0936255,0.225968,0.373481,0.553305,0.194057,0.157891,0.214814,0.0550721,-0.219456,-0.357995,-0.122823,-0.193768,-0.0878042,0.0883377,0.0387969,-0.450611,0.0279181,-0.499216,-0.257108,0.0980105,0.724946,0.126877,-0.0334264,-0.19408,0.939929,0.378669,-0.126717,0.086996,-0.354315,0.478888,0.358155,0.418734,0.422592,0.0758555,0.138608,0.308133,-0.12493,0.24457,-0.121344,-0.131785,-0.197181,-0.175542,-0.333131,0.150369,0.264863,0.387774,0.514648,-1.43947 +3400.56,0.976972,0.0912059,4,1.47662,0.785325,-0.932907,0.411224,0.844259,-0.132117,0.596074,0.0590254,0.0518456,0.357078,0.257472,-0.0875494,-0.0281034,0.375611,0.101433,0.807711,0.568055,0.240396,-0.302453,0.0851251,-0.268579,-0.658397,-0.238215,0.460161,-0.0764491,-0.167578,-0.401171,0.288859,-0.274373,-0.0419561,0.977626,-0.694083,0.541298,0.472728,0.128836,-0.286502,-0.568075,0.845841,0.488463,-0.439318,1.00923,0.649936,0.197597,-0.29556,-0.18406,-0.378011,-0.836885,0.204092,0.254151,0.359573,0.463875,0.593887,-0.213242,-0.714939,0.566539,-0.160918,-0.137624,-1.28315,1.07742,-0.325297,-0.0562636,0.950069,-0.534787,-1.2257,-0.00975019,-0.0320667,-0.192263,0.607427,0.651452,-0.0124541,-0.492633,0.402524,0.612531,-0.0895932,0.640534,-0.0580332,0.767984,0.0519493,-0.812795,0.00219635,0.445688,-0.241004,0.256447,-0.0162281,-0.24239,0.393521,0.531005,0.164815,0.362085,-0.453832,-0.387256,-0.9264,0.379963,-0.148111,0.124061,-1.09076,0.244814,-0.000671046,0.327493,0.218396,-0.271175,-0.136591,-1.02051,-0.0506507,0.192201,-0.0398533,-0.00852442,0.16369,0.0572089,0.0900419,-0.144993,-0.152792,0.810223,0.602175,-0.32068,0.0449304,-0.353508,-0.22986,0.258101,0.278062,-0.327883,0.414712,-0.108265,-0.226344,0.720469,-0.441937,-0.327909,0.176005,0.466863,-0.212441,0.570875,-0.0534596,-0.107525,-0.0738913,-0.55984,-0.555335,-0.0131598,-0.132724,0.690961,-0.745758,-0.339234,0.0222209,-0.258471,0.206301,1.02602,0.275149,-0.239935,0.774021,-0.424802,-0.226572,-0.447357,0.0177771,0.262421,0.0445916,0.512997,0.0931767,-0.42529,-0.0805401,0.0522848,-0.905078,-0.0675369,-0.51617,0.967621,0.0257554,0.293699,0.331073,-0.180701,-0.394489,-0.392107,-0.0468767,0.700436,0.311655,0.220664,-0.160406,-0.0916595,0.267759,-0.758201,0.0842161,0.439268,0.683829,0.580571,0.472137,0.613658,-0.578911,-0.117915,-0.460772,0.0448053,-0.378658,0.743062,0.12767,0.427203,-0.269672,-0.14068,-0.568087,-0.381115,0.83071,0.235698,0.181188,-0.600283,-0.00286616,0.0203292,-0.733605,0.815426,0.97049,0.49361,-0.0977398,-0.553935,0.936555,-0.16236,-0.520303,-0.115688,-0.59116,0.307445,0.0725284,-0.0573865,0.494851,-0.204328,0.0496069,0.0449132,-0.599963,-0.136604,-0.376934,0.333054,0.050636,-0.330689,1.05614,-0.369391,-0.618547,0.0198705,0.63997,0.432171,0.149788,-0.110468,-0.375327,-0.327047,0.129578,-0.207708,-0.127212,0.565815,-0.304945,-0.438817,-0.0240932,-0.191075,-0.0698607,0.336334,0.415076,0.63405,0.234255,-0.572688,-0.173758,-0.161363,-0.0548412,0.0291639,-0.0563655,-0.00261643,0.332947,-0.121838,-0.155337,0.434966,-0.0126136,-0.0424426,0.533255,0.333756,0.100996,0.674768,0.425718,0.205905,0.39719,-0.163512,0.215699,-0.50671,-0.55683,-0.0303091,0.109047,-0.206291,-0.417872,0.139074,0.388592,0.156969,-0.117816,0.129489,-0.286082,-0.0414967,-0.472034,0.18958,-0.0390141,-0.345124,0.231371,0.623733,-0.66893,0.347458,0.00857747,0.272192,0.00808714,-0.384476,-1.03774,-1.04105,-0.130987,0.26146,-0.472307,-0.258399,0.158553,0.27007,0.398187,0.519683,-2.58135 +3399,0.945351,0.0912059,5,1.67477,0.591174,-1.84715,0.824238,0.426204,-0.148455,-0.487075,0.248571,-0.0576385,-0.256787,-0.0517856,-0.332433,-0.708438,0.205731,-0.0474815,0.615135,0.591294,0.112068,-0.0107824,-0.0248182,-0.0493833,-0.660943,-1.21487,0.589321,0.0630576,-0.446498,-0.535373,-0.25809,-0.660448,-0.191073,0.911646,-0.130951,0.534836,0.358362,-0.460271,-0.0300895,0.204386,0.350378,0.261649,-0.245111,1.05478,1.02547,0.829926,-0.655435,-0.382552,-0.120675,-0.700616,0.156592,0.0991873,-0.0267074,0.22094,0.194134,-0.400811,-0.228389,0.0539567,0.0526453,0.0209382,-0.256778,0.660621,-0.100139,0.000389196,0.796943,-0.689618,-0.53701,0.0105274,-0.376141,0.329603,-0.439997,-0.690281,-0.34882,0.0789302,0.494146,1.11285,0.0878847,0.517109,0.0758692,0.0524454,0.254606,0.0808929,0.340766,0.582096,-0.0694371,0.138292,-0.415706,-0.120903,0.0879987,0.16785,0.0112773,-0.0514801,-0.348894,-0.224688,-0.331026,-0.0290829,0.0117099,-0.01862,-0.813366,-0.293496,-0.441504,-0.193864,0.0695396,-0.0576182,-0.0520389,-0.807939,0.00930372,0.433993,-0.224506,-0.0124139,-0.331577,-0.136328,-0.0605864,-0.858653,0.934736,-0.0356924,0.561711,-0.197404,0.110195,-0.37873,-0.514339,-0.108637,0.303144,-0.68364,0.159224,-0.617223,0.467959,-0.131432,-0.676671,0.936412,-0.252123,0.2778,-0.684345,-0.0701074,0.399369,-0.214741,0.371075,-0.291698,-0.317204,0.199273,-0.119078,0.531891,-0.313215,-0.862196,-0.0765429,-0.10244,-1.15302,0.105218,0.253835,-0.467305,0.59398,-0.0386603,-0.869226,-0.261856,0.214333,-0.195723,-0.275394,0.0187725,0.811146,0.377511,0.00102578,-0.16836,0.0576522,0.295878,0.114428,0.837981,-0.19712,-0.236414,0.160092,-0.193671,0.142787,-0.349581,0.288695,0.474912,-0.196172,0.0688088,-0.275606,-0.664384,-0.345225,-0.743624,-0.270309,0.205847,0.926588,-0.448829,-0.659564,0.048745,-0.492289,-0.308701,0.056225,-0.150076,-0.544455,-0.0555098,-0.046155,-0.10305,-0.127716,0.115917,-0.962903,0.053896,-0.295705,0.186412,-0.177817,-0.289117,-0.130588,-0.237056,-0.78086,-0.227569,-0.0312785,-0.49499,-0.259021,0.190728,0.932114,-0.332906,-0.494726,-0.0530621,-0.3222,-0.0758676,0.253487,0.312053,0.739608,0.713354,-0.405942,-0.00939692,-0.561173,-0.0234092,-0.249967,-0.0169379,1.13378,0.289889,0.0202302,-0.411209,-0.308451,-0.11923,-0.0369063,-0.200046,0.28043,-0.243292,-0.105243,-0.366489,-0.0997149,-0.111727,0.275301,0.359367,0.101754,-0.428918,-0.162759,0.276397,0.205386,0.101934,-0.408957,0.38079,0.297861,-0.330899,-0.0844228,-0.0184682,-0.287471,-0.0271026,-0.366165,0.00133925,0.344026,0.199328,0.0546102,0.238621,0.210824,0.122791,0.537934,-0.1371,0.598611,0.556415,0.425023,0.0100079,-0.73378,-0.589706,0.190631,-0.218698,-0.0316575,-0.805368,0.0584848,0.167103,-0.901026,-0.499405,-0.567661,-0.332133,0.0686437,-0.188493,0.2616,-0.112111,0.345442,0.623285,0.556171,-0.0945138,0.525425,-0.0123231,0.240205,0.147727,-0.184357,-0.585107,0.446573,-0.620101,-0.636467,0.388219,0.211434,-0.504275,-0.481365,-0.0591349,0.148242,0.244974,0.385022,0.494948,-0.559344 +3408.99,0.812243,0.0912059,5,1.62293,0.612044,-1.91883,0.824627,0.548712,-0.109467,-0.349323,0.20598,-0.0861888,-0.307799,0.00593821,-0.469598,-0.41658,0.0497282,-0.167612,0.629665,0.461008,-0.0143524,-0.167808,-0.155818,-0.0246305,-0.690826,-1.01796,0.53942,-0.0929001,-0.373756,-0.159042,-0.339096,-0.541899,-0.146847,0.884879,0.279806,0.292126,0.367909,-0.467263,0.184108,-0.208853,0.249044,0.218117,-0.131243,1.14397,0.794622,0.624626,-0.747662,-0.155075,-0.329571,-0.526528,-0.0669541,0.25592,-0.0275885,-0.00155587,0.20765,-0.325304,-0.622348,0.180308,-0.107306,0.124527,-0.489137,0.586174,-0.196251,0.103574,1.07781,-0.311196,-0.403988,-0.145357,-0.3559,0.39984,0.154955,-0.426679,-0.579322,0.00146333,0.259504,1.04445,-0.0152004,0.274598,0.189056,0.311727,0.0615622,-0.00963082,0.299924,0.913033,-0.156894,0.156798,-0.157497,-0.0980599,0.157947,0.0213144,-0.0137385,0.11106,-0.397233,-0.239134,-0.165745,-0.0199989,0.216796,-0.261216,-0.75225,-0.298412,-0.383538,-0.0947764,-0.0205344,0.0597809,0.0577737,-0.601306,-0.0217956,0.63589,-0.146578,-0.509143,-0.362501,-0.0915076,-0.039019,-0.863977,0.822757,-0.0616408,0.431912,-0.188632,-0.20376,-0.324507,-0.568662,0.0898808,0.213341,-0.542735,0.277848,-0.812599,0.387507,-0.201884,-0.291257,0.849477,-0.266997,0.355131,-0.537631,-0.0809551,0.126683,-0.516918,0.328528,-0.348164,-0.240427,0.38861,-0.16022,0.482697,-0.382948,-0.664142,0.0468818,-0.0644273,-1.20377,0.241195,0.125737,-0.246235,0.692556,0.0622449,-0.350544,-0.076397,0.334044,-0.0799732,-0.245541,-0.129846,0.274899,0.397225,-0.187608,-0.180741,0.136587,0.242551,0.466568,0.724738,-0.0647211,-0.407042,0.0988515,-0.0402666,0.0756563,-0.299887,0.251362,0.383447,-0.127567,0.149626,-0.261861,-0.825682,-0.38497,-0.336143,-0.0454825,0.295669,1.01589,-0.0972212,-0.42916,0.092701,-0.169869,-0.194562,-0.107159,0.00290419,-0.179721,0.353095,-0.2562,-0.162467,-0.324439,-0.255321,-0.787856,0.11403,-0.0195522,0.0702399,-0.0266528,-0.399653,0.209084,-0.028635,-0.650556,-0.191049,-0.123725,-0.62319,-0.13361,0.0823959,0.939519,-0.211858,-0.622387,-0.147427,-0.54699,0.0257325,0.0920227,-0.0126671,0.780847,0.453058,-0.41034,-0.139934,-0.86844,0.165076,-0.192853,-0.241489,0.874126,0.159996,0.241051,-0.545688,-0.18262,0.107282,0.207071,0.235123,0.349286,0.0337286,-0.289771,-0.192976,-0.0634078,0.173494,0.140657,0.552253,-0.157306,-0.700632,0.0538158,0.450542,0.0584198,0.293448,-0.219736,0.354231,0.361241,-0.287373,-0.147606,-0.0865237,-0.39407,0.0532145,-0.367721,0.215718,0.431601,0.107346,0.154441,0.440328,0.204265,-0.00176854,0.343593,-0.160514,0.547528,0.514051,0.634606,-0.0334029,-0.586095,-0.802851,0.339181,-0.201573,-0.037617,-1.06131,0.133545,0.204993,-0.579977,-0.36626,-0.459237,-0.371104,-0.162572,0.272266,0.0694327,-0.132673,0.472011,0.484454,0.348977,-0.538905,0.367559,-0.20865,-0.186501,0.256035,-0.358043,-0.531883,0.0401524,-0.625621,-0.767978,0.367668,0.235596,-0.510039,-0.713918,0.21943,0.157264,0.208002,0.396565,0.456073,-1.02723 +3424.13,0.906165,0.0912059,5,1.56651,0.724431,-0.938025,0.407281,-0.242405,-0.148218,0.262874,-0.247475,-0.207576,0.59996,0.157741,-0.113719,0.068017,0.868304,0.131543,1.23363,0.532573,0.208378,0.136269,0.20089,0.0378286,-1.08704,-0.628429,0.343163,-0.108892,-0.0843338,-0.364755,0.380721,-0.344388,0.61024,1.08429,-1.04872,-0.606948,0.246482,-0.358783,-0.235485,0.0210897,0.60927,0.190854,-0.478903,1.18346,0.561927,0.285333,-0.522577,-0.332539,0.510805,-0.791929,0.557489,0.635435,-0.361703,0.308803,0.524615,0.0236838,-0.0475093,0.463442,0.146315,0.288818,-0.378739,0.107561,-0.177871,-0.0315797,0.471012,-0.611799,-0.489298,0.360378,0.543921,-0.826145,0.291685,0.321193,-0.0932126,0.214042,0.0365105,0.13093,-0.0491451,0.0543396,0.14616,0.0806512,-0.302019,-0.310479,0.134851,0.337116,-0.124072,0.57764,-0.299829,0.0940358,0.44909,-0.176289,0.112308,-0.306653,-0.321004,0.429458,-0.442906,-0.0871748,-0.174951,0.00429632,-0.304414,0.121099,0.0430313,0.225847,-0.127486,0.01574,-0.0147418,-0.235762,0.0785043,-0.148536,-0.149787,0.323632,-0.0336822,0.432873,0.920215,0.738484,-0.388001,0.424286,0.487667,-0.33928,-0.597578,-0.307484,0.166516,0.323446,0.179133,-0.498278,-0.213437,-0.116377,0.17635,-0.553544,0.388002,-0.217402,0.202227,0.0708311,0.0757187,-0.0790852,0.0481259,0.24854,-0.0193293,-0.23581,-0.344553,-0.708073,0.0313895,0.356794,-0.127523,-0.509664,0.358923,0.0524897,-0.486632,0.0610678,-0.0970978,0.201265,-0.518334,-0.181629,-0.46672,0.0429289,-0.372502,0.0113818,0.314451,-0.0523373,0.730374,0.099026,0.168633,-0.0198105,-0.0172052,0.323913,-0.838047,0.545973,0.16313,0.160715,-0.121083,0.0582988,0.0608427,-0.116414,-0.274646,0.205753,0.176324,0.0145363,0.333056,0.174139,-0.314152,-0.515711,-0.0523023,0.512862,0.833477,-0.293393,0.340305,0.470733,0.0600234,-0.124248,0.107199,-0.395929,-0.381239,0.233012,-0.422675,0.173485,0.0856558,-0.309545,-0.762834,-0.0715557,-0.116997,-0.119853,-0.344902,-0.45264,0.150788,0.387812,-0.0115163,0.484021,-0.106916,0.32498,0.384376,-1.16725,0.930781,0.0176929,0.725981,0.32865,-0.159935,0.310568,0.0432267,0.320325,0.368531,-0.607726,0.288451,0.455568,-0.0345726,-0.00710505,-0.186532,-0.132042,-0.007914,-0.822232,0.324236,0.447024,-0.518577,0.420044,0.418881,0.196031,0.177917,0.197445,-0.264616,-0.171521,0.415157,-0.665339,-0.169832,0.828969,0.0181029,0.0334488,-0.167368,-0.296474,0.143156,0.169694,-0.274998,0.375655,-0.0160146,0.0817365,-0.22249,-0.11079,-0.669349,0.0952012,-0.257449,-0.497454,0.32146,-0.853414,0.00583545,0.273124,0.345855,-0.0187289,0.363771,0.0561771,-0.00770851,-0.1401,-0.495264,-0.139543,0.1742,0.520417,-0.131842,0.0636002,-0.668022,0.0907035,0.121449,-0.0198305,0.19961,0.276965,0.417999,-0.00964262,0.0322262,-0.260183,-0.524697,-0.773,0.219943,-0.221534,0.459495,-0.076393,-0.137663,0.378607,-0.0585746,0.051136,-0.444494,-0.32215,-0.00667968,0.157727,0.169852,0.420754,0.275925,0.00809132,-0.103086,0.274835,0.116914,0.222855,0.341927,0.472075,1.23414 +3427.07,0.980048,0.0912059,4,1.48243,0.710486,-1.44896,0.577526,-0.273539,-0.139097,-0.00949458,0.0244075,0.524763,0.248043,-0.0959334,-0.174425,0.0556514,0.912017,-0.0766804,1.16249,0.453202,0.335196,-0.0438445,0.258632,0.201576,-1.05083,-0.500138,0.0269078,0.362299,0.0711208,-0.227017,0.0932291,-0.306575,0.821408,1.03012,-1.04063,-0.534598,0.503748,-0.362928,0.0994335,-0.143385,0.468489,0.5214,-0.775567,1.10186,0.419816,0.453233,-0.619951,-0.281153,0.111256,-0.637745,0.69597,0.559946,-0.0362935,0.333277,0.137606,0.0893734,0.0946074,0.534955,0.234045,-0.0427013,-0.488975,0.317622,-0.499057,0.109689,0.536983,-0.600272,-0.671411,0.488651,0.624331,-0.618991,0.196185,0.701028,0.0398789,0.149827,0.263137,0.183793,-0.226789,0.139703,0.251804,0.214541,-0.531418,-0.416612,-0.0422856,0.323713,-0.267025,0.651351,-0.239792,0.191247,0.454232,-0.305902,0.0565293,-0.344889,-0.384769,0.141598,-0.429411,0.0580576,-0.296755,-0.188128,-0.724905,0.192348,-0.425319,0.332214,0.129281,0.227005,-0.169746,-0.312778,-0.159864,-0.0697324,-0.169718,0.412753,0.36829,0.247469,0.88449,0.491158,-0.365783,0.454746,0.340152,-0.63115,-0.410157,-0.578509,-0.0113511,0.391257,0.376042,-0.285071,-0.222359,-0.121925,-0.0711559,-0.433593,0.347913,-0.189372,0.393796,0.138931,-0.193191,0.160767,-0.0302227,0.354811,-0.105912,-0.160899,-0.329364,-0.704526,-0.0272688,0.254386,-0.259939,-0.444192,0.35018,0.191858,-0.338519,-0.0798524,0.0787039,0.34228,-0.372725,-0.125149,-0.1905,-0.111955,-0.423626,-0.0253807,0.236094,-0.228859,0.204961,0.17065,0.0391772,0.142159,-0.231173,0.0938579,-0.762938,0.64476,-0.00301458,-0.15091,-0.29618,0.206328,-0.141461,-0.0470693,0.0273006,0.167075,0.101146,0.0452684,0.292871,0.103709,-0.0173561,-0.383854,0.0713425,0.383639,0.794031,-0.170309,0.309112,0.454167,0.0556768,-0.313087,0.28536,-0.22407,-0.60088,0.124685,-0.500407,0.164574,-0.156201,-0.109532,-0.594641,0.0153694,-0.270374,-0.176551,-0.295071,-0.566151,-0.150377,0.461416,0.082566,0.259491,-0.198288,0.178701,0.63971,-1.05127,0.840064,0.0557576,0.316492,0.337437,-0.265472,0.332451,0.198884,0.327941,0.289159,-0.280319,0.370422,0.333371,0.199011,0.127415,-0.288854,-0.179326,-0.307425,-0.753592,0.30534,0.114754,-0.577777,0.443259,0.256807,-0.24219,-0.00953794,-0.0588362,-0.287527,-0.606585,0.3427,-0.614228,-0.0126395,1.15497,0.213778,0.181816,-0.0608118,-0.255977,0.233299,0.487627,-0.176316,0.446085,0.172527,0.204661,-0.205122,0.00397519,-0.51222,0.292295,-0.125741,0.0257294,0.15043,-0.622579,0.416031,-0.155213,0.287255,0.0119962,0.365368,0.168283,-0.282999,-0.12355,-0.36276,-0.151223,-0.433158,0.445422,-0.366537,0.000682035,-0.40024,-0.159909,0.357683,-0.33572,0.141839,0.215292,0.268751,-0.0992216,-0.129609,-0.148568,-0.316242,-0.948317,0.184134,-0.089522,0.453901,-0.437207,0.0855066,0.0502502,0.0228522,0.0407396,-0.368629,-0.205083,0.208594,0.1216,0.109006,0.170224,0.0298042,-0.189236,-0.488714,0.286014,0.12125,0.232156,0.34821,0.481826,1.3828 +3427.7,0.621263,0.0912059,4,1.49069,0.754269,-1.19893,0.446698,-0.159292,-0.0010931,-0.0159627,-0.0365788,0.00962459,0.0871214,0.197045,-0.169099,-0.256478,0.719645,0.431098,0.712657,0.437044,-0.228495,0.0371544,0.557526,-0.124391,-0.755804,-0.0633411,0.196585,0.199214,0.0272624,-0.181946,0.0709863,-0.602859,0.256347,1.08084,-1.34699,-0.681042,0.362694,0.158898,0.119623,0.0069756,0.416061,0.318037,-1.03344,1.04928,0.651425,0.250475,-0.680453,0.0635087,-0.063949,-0.240538,0.530273,0.123637,-0.214336,0.0980589,0.441091,0.0553759,-0.0963451,0.488595,0.188998,-0.321774,-0.114861,0.122405,0.0381208,0.291167,0.809129,-0.737956,-0.611717,0.708701,0.18092,0.0185781,-0.368063,-0.0534416,-0.0993274,-0.318472,0.150897,0.744854,-0.155429,0.295011,0.651397,0.511037,0.119771,-0.630607,-0.0175337,0.679576,0.227067,0.492618,-0.388042,-0.346049,0.401918,0.104569,-0.162741,-0.330229,-0.388748,-0.080129,-0.0675803,-0.198027,-0.458292,-0.440036,-0.794154,0.620092,-0.259443,0.0591824,0.445066,0.0453563,-0.444913,-0.388506,0.250565,-0.00827004,-0.300604,0.650403,-0.268868,0.154086,0.935675,-0.292318,0.234077,0.348305,0.578996,-0.440203,-0.329985,-0.157861,0.37146,-0.259264,-0.201357,0.144673,-0.258316,-0.0694922,-0.411666,-0.114568,0.334925,-0.0972434,0.450712,0.194949,-0.413719,0.31144,-0.454071,0.356918,0.370123,-0.171457,-0.307348,-0.228474,-0.220733,0.365971,-0.364959,-1.16471,0.365267,0.0698578,-0.934834,0.0505777,-0.05871,0.731522,-0.338766,0.0225375,-0.0952159,0.0381386,-0.183028,-0.350175,-0.104023,-0.284208,0.593432,0.28676,0.635212,0.153125,0.324011,0.545612,-0.471949,0.252399,-0.0411773,-0.161778,-0.465475,0.422891,0.0352463,-0.284817,-0.0852781,0.530321,0.0798021,-0.161278,-0.213436,-0.0556982,-0.475318,0.00245756,-0.0688147,0.298413,0.64069,-0.0588441,0.0253143,-0.0848132,0.481131,0.292887,-0.140805,-0.553614,-0.602453,0.226633,-0.244835,-0.0232584,0.05272,0.164045,-0.552913,0.0842542,0.30028,-0.412023,-0.397201,-0.863535,-0.839824,0.184246,-0.511492,-0.266764,0.0683631,-0.000862266,0.341568,-1.33275,0.792765,0.0680807,0.292313,-0.106738,-0.564497,0.212966,-0.0233278,-0.0994207,-0.186683,-0.0267715,0.0958553,0.139778,-0.305923,0.0024807,-0.152754,-0.134498,0.0171693,-0.122622,0.624917,0.157673,-0.0890055,0.46758,0.0558085,-0.546109,0.335167,-0.377902,0.533366,-0.37893,0.623771,-0.0797882,0.438329,0.870651,-0.276565,-0.269168,0.111647,-0.0579381,0.180854,0.230854,0.430111,0.503135,0.0983938,0.516138,-0.220244,-0.137085,-0.509324,0.326516,-0.167807,-0.486728,0.417954,-0.050132,0.236738,0.195988,0.388415,-0.410037,0.241256,0.0308049,0.0963986,0.632524,0.0950612,0.011121,0.0662466,-0.0733031,-0.269525,-0.444113,-0.317898,-0.0504429,0.0938579,-0.0341303,-0.0868614,-0.332213,0.0414835,-0.0100175,0.0215644,-0.195258,-0.158687,-0.0840036,0.252926,0.52533,0.288996,-0.332729,0.294929,0.145386,-0.270105,0.0765361,0.109927,0.179256,-0.194191,0.227755,0.0537843,-0.148433,0.0877044,0.330835,-0.0875424,-0.231793,0.12843,0.278359,0.358371,0.527597,0.892575 +3422.03,0.89916,0.0912059,4,1.43932,0.740112,-1.31234,0.454892,-0.193394,-0.0911988,0.0221239,-0.221144,0.511559,0.0410709,0.236966,-0.493027,-0.155385,0.629578,-0.340968,1.0096,0.461643,-0.159024,-0.0427103,0.259604,0.0492473,-0.776138,-0.738305,0.127875,-0.0599224,0.00321173,-0.311851,0.0933944,-0.373421,0.620551,0.775449,-0.803179,-0.305785,0.477743,-0.326784,0.402213,-0.0472269,0.351479,0.46572,0.0022487,1.05909,0.549462,-0.112571,-0.34873,-0.0814332,-0.245867,-0.378413,0.527211,0.647535,0.0501391,0.44488,0.882552,-0.101371,-0.468293,0.439168,-0.0824155,-0.0155653,-0.224439,0.444393,0.208788,-0.0864152,1.04299,-0.258562,-0.807968,0.940946,-0.0405665,0.00796618,-0.161206,-0.151095,-0.541517,0.283831,0.0436356,0.613816,-0.0511884,0.0477038,0.305654,0.23578,-0.103924,-0.363836,0.0865216,0.182921,-0.116724,0.643912,-0.479224,-0.354557,0.477774,-0.265409,0.320105,-0.250229,-0.354512,-0.282221,0.0283129,-0.144562,-0.147754,-0.253642,-1.04952,0.129411,-0.630393,0.378562,0.165504,0.011288,-0.127105,-0.1841,-0.0117194,-0.0132066,-0.354929,0.400785,0.10465,0.548808,0.462449,-0.746759,0.34816,-0.152163,0.47918,-0.200371,0.080132,-0.552965,-0.190618,0.0286572,-0.164917,-0.473852,0.0271032,-0.166835,-0.916158,-0.24859,0.247822,-0.398521,0.443141,-0.184772,-0.52261,-0.264351,0.302615,-0.35197,0.460168,-0.266416,0.213598,-0.387037,-0.282134,0.489314,-0.57511,-0.229702,0.394691,0.0512409,-0.668263,0.603644,0.205759,-0.178537,0.441241,-0.364456,-0.323628,-0.124381,0.185748,0.373975,-0.293481,-0.0710631,0.288147,-0.199875,0.270055,0.0839246,0.3152,0.655798,-0.663182,0.411794,-0.617352,-0.0372223,-0.478528,-0.0511361,-0.137349,-0.0721449,-0.0401375,0.199586,0.507764,0.421097,-0.0286256,-0.303332,-0.0724239,0.16153,-0.496845,0.15657,0.462251,0.00650759,0.303962,0.0106346,0.342791,0.166609,-0.688521,-0.175558,-0.77629,0.919218,-0.499594,0.340201,0.545374,-0.267807,-0.435283,0.455732,0.494843,-0.110792,-0.0804802,-0.431623,-0.57827,0.405542,-0.060041,0.360612,0.108117,0.421957,0.21854,-0.399707,1.24555,-0.156144,0.187297,-0.25642,-0.285066,-0.0444755,0.242389,0.144304,0.602181,-0.04164,0.312815,0.373722,-0.0984355,0.141161,-0.294989,0.179092,-0.00509391,-0.264652,0.704541,-0.130764,-0.473905,0.21158,0.545045,0.326288,0.201911,-0.541916,0.164867,0.334293,0.493708,0.125528,0.261148,0.496305,-0.372043,-0.181394,-0.264836,0.130393,0.0763116,0.34556,0.404928,0.0954275,0.383494,0.392566,-0.250444,0.34509,-0.646156,-0.0819033,-0.0471545,-0.817576,-0.0707609,-0.359778,0.436408,-0.0649771,0.321282,-0.433087,-0.173028,0.273272,-0.407043,0.108999,-0.135807,-0.114067,-0.133259,0.0942252,-0.00362163,-0.140421,-0.16834,-0.394651,0.110284,-0.119218,0.280592,0.244709,0.12746,-0.137595,-0.113508,-0.31389,0.436265,0.195514,-0.65752,0.018313,-0.119319,0.000482747,-0.588434,0.0524588,-0.398705,0.194421,0.914072,-0.135183,0.171604,-0.050423,-0.39935,0.570672,-0.242087,-0.524097,0.409989,0.0936311,0.14736,0.205841,0.383875,0.453697,1.05379 +3430.33,0.919009,0.0912059,4,1.57031,0.724386,-1.19055,0.323352,-0.0763642,-0.149753,0.0802349,-0.387793,0.257281,0.0913622,0.199402,-0.222919,-0.00948989,0.506068,-0.815058,0.892593,0.460478,-0.409301,0.270306,0.348415,-0.310587,-0.729484,-0.464255,0.208806,-0.176583,-0.358949,-0.433149,0.267678,-0.487813,0.267876,0.754473,-0.311835,-0.445009,0.20731,-0.0333174,0.401994,0.0743924,0.665001,0.298831,-0.310192,1.24923,0.603069,0.498953,-0.18273,0.120919,-0.35962,-0.186507,0.483523,0.538187,0.0593701,0.282307,0.918513,0.130125,-0.5447,0.875635,0.00785581,-0.28551,0.141817,0.332222,0.087848,0.0039092,1.22867,-0.857845,-0.292073,0.825896,-0.0174192,0.178568,-0.289971,0.00460453,-0.28481,0.0980389,-0.248315,0.595898,0.153123,0.0494316,0.243568,0.149646,-0.681273,0.126593,0.159155,0.459902,-0.171217,0.309334,-0.00820276,-0.556751,0.388033,-0.390895,0.0869278,-0.0401341,-0.313438,0.159299,-0.282189,-0.344386,0.0863661,-0.129809,-0.713135,0.190815,-0.347901,0.560342,0.0855083,-0.0794045,0.0515886,-0.519071,-0.0398335,0.0451063,0.116843,0.259608,-0.0588712,0.455866,0.598589,-0.155896,0.27713,-0.0806829,0.609069,0.0481159,-0.055324,-0.386643,0.0669334,0.534428,0.282898,-0.405737,0.212086,-0.264146,-0.540966,-0.249512,0.362683,-0.131206,0.221892,-0.239992,-0.714248,-0.237679,0.166281,-0.349751,0.383402,-0.23884,0.0209285,-0.456667,-0.470263,0.622817,-0.724465,-0.517884,0.299911,-0.097278,-0.712553,0.400801,0.0809954,-0.641115,0.0839643,-0.0799386,-0.290415,-0.141273,-0.228525,0.152557,-0.493002,0.32587,0.241731,-0.324086,-0.0655632,0.0562337,0.0224969,0.0485301,-0.463022,0.211507,-0.0519342,-0.237215,-0.111531,-0.301134,-0.0153954,-0.136414,-0.194654,0.375861,-0.0393941,-0.125415,-0.163807,-0.134329,0.24614,0.169398,-0.163589,0.374971,0.498734,-0.405965,0.134152,0.42931,-0.480471,0.112247,-0.993464,-0.148581,-0.741721,0.894345,-0.427135,0.125929,0.533074,-0.338505,-0.198891,0.60189,0.116297,0.159355,-0.179891,0.024759,-0.461678,0.0774911,-0.346219,-0.099778,0.312079,0.112172,0.0877393,-0.569038,1.17158,-0.108784,0.3821,-0.427532,-0.120135,0.0754724,-0.2231,0.0334812,0.603877,-0.331361,0.0252803,0.331985,-0.266952,-0.436918,-1.01819,0.0410215,0.135277,-0.128501,0.300432,-0.519912,-0.182883,-0.294753,0.162831,0.289675,0.16872,-0.600604,-0.101268,-0.541499,0.458216,-0.394336,0.503288,0.483299,-0.354728,0.0291195,-0.397511,-0.315312,0.0679057,0.279286,-0.0423486,0.214928,0.306931,0.243508,-0.150163,0.372859,-0.696461,0.241644,0.168458,-0.319086,0.331888,-0.418475,0.145828,0.395637,0.283233,-0.169151,0.0715157,0.427959,-0.252946,0.364397,-0.326981,-0.337574,-0.562844,0.030768,0.0700594,0.0405168,-0.260967,-0.466806,0.00798997,-0.281034,-0.0202029,0.36494,0.113964,-0.405742,-0.209279,-0.178834,-0.255729,0.176549,-0.468084,-0.00387771,-0.288041,0.18903,0.107188,-0.096122,-0.425306,0.502247,0.305562,-0.0287271,-0.143818,0.189524,-0.372612,0.501261,-0.213714,-0.305428,-0.28764,0.168838,0.105205,0.304514,0.324353,0.551827,0.899465 +3417.1,0.956943,0.0912059,5,1.44406,0.796424,-0.933408,0.248444,0.610199,-0.0491728,0.339987,0.108065,0.32352,0.463939,0.053507,-0.485013,-0.348454,0.192954,0.0314612,0.874959,0.259837,-0.068945,-0.14053,-0.265642,0.0361178,-1.00109,-1.28465,0.161553,-0.744072,-0.0643422,0.175563,0.0421717,-0.124326,-0.0503543,0.798582,-0.645612,-0.350011,0.465469,-0.173316,0.396808,-0.406813,0.332439,0.561657,-0.511829,1.08935,0.870831,0.245124,-0.160142,0.920498,0.220176,-0.106823,0.288386,0.683485,0.206814,0.58915,-0.48093,0.179316,-0.53227,1.04502,-0.178308,0.342151,-0.940577,0.780608,-0.606583,0.447488,1.11707,-0.107726,-1.2996,-0.320373,-0.00909996,-0.193577,-0.503176,-0.0459955,-0.233498,0.0737275,0.609328,0.792697,-0.106742,0.645472,0.375366,0.626635,0.108121,-0.475409,-0.0934207,0.445791,0.395589,0.245322,0.312442,0.402335,-0.0869823,0.252555,-0.390746,-0.160531,-0.0867547,-0.257072,0.617164,0.100153,-0.249313,-0.0789447,-0.386434,-0.195164,-0.116889,-0.114764,0.271238,0.121282,-0.67561,-0.126065,-0.963109,0.0337461,-0.428755,-0.197241,-0.343358,0.404267,0.293726,0.402613,-0.49861,0.106023,0.459758,-0.014826,0.310719,-0.0904727,0.413009,0.172962,-0.324898,-0.532906,-0.00769967,-0.257147,-0.144008,-0.508016,-0.0815922,0.17775,-0.632476,0.453675,0.296193,0.500705,-0.108747,0.55798,0.0943017,-0.280311,-0.243344,0.109621,0.270289,0.192087,0.171499,0.248917,-0.0805042,0.494078,-0.278663,-0.401812,0.0591698,0.0518428,0.382281,0.00811763,-0.0410724,0.324523,0.0273269,0.233546,-0.170483,-0.236016,0.357317,0.793407,0.630326,0.307152,-0.486392,-0.218578,-0.0120589,0.258706,-0.123398,-0.40445,0.281417,0.137459,0.275113,-0.594473,0.722784,0.139049,-0.209501,0.127845,0.151714,-0.112763,-0.142705,-0.364701,0.275424,0.287195,0.599483,0.100419,0.160583,0.174807,-0.102371,-0.226893,-0.568361,-0.468231,-0.186663,-0.357331,-0.347815,0.145815,0.0670414,-0.129531,-0.930558,0.040305,-0.295531,-0.296969,-0.150758,-0.34608,0.361529,0.0441655,0.0401583,0.179563,-0.286826,0.0288854,-0.0957922,-0.239338,0.735974,-0.0123111,0.295349,0.031022,-0.0559565,-0.136968,0.198139,0.0625137,0.0300402,-0.0537772,0.149198,0.157534,0.0924418,-0.0106625,-0.62384,-0.611984,-0.173464,-0.239717,0.533801,-0.532948,-0.0283743,0.172442,0.306506,-0.0778662,0.116991,0.205715,-0.0667701,0.150559,0.69149,0.748391,-0.150709,0.246323,0.210714,-0.0722308,-0.0589707,0.216278,0.451591,0.363866,0.0297805,0.0818889,-0.0733248,-0.113629,-0.0937195,0.18835,-0.785074,0.172841,-0.283457,-0.113448,0.447257,0.0684179,-0.314218,-0.252902,0.184585,0.909154,0.388498,-0.244566,0.0706297,-0.221317,0.484501,0.271801,0.698384,0.223475,0.0109421,-0.476958,-0.43547,0.716098,0.251159,0.0155327,0.557954,-0.158183,0.00815285,0.64932,-0.245936,-0.757682,0.0277144,-0.883935,0.678025,0.315501,0.127695,-0.34766,0.0163512,0.50766,0.0506025,-0.176666,0.248899,0.216733,-0.120723,-0.00722282,-0.0967906,-0.296793,-0.161191,0.0134022,0.338662,0.127038,0.121602,0.214599,0.348715,0.463248,-1.7226 +3433.41,0.857568,0.0912059,4,1.66464,0.924265,-0.925577,0.375024,0.760326,-0.100316,-0.093533,0.0532058,0.0995878,0.412802,0.275566,-0.13205,-0.236673,-0.096509,-0.382691,1.12174,0.2109,0.123658,0.0376215,-0.104099,-0.44462,-0.449431,-0.762321,-0.0794959,-0.484119,-0.0566657,0.365469,0.793091,-0.0652471,-0.0235293,0.724914,-0.388245,-0.255149,-0.247739,-0.286799,-0.329057,-0.0942734,0.672167,0.488356,-0.237387,0.686292,0.286452,-0.114399,-0.929953,-0.403455,0.255518,-0.514689,-0.0524889,0.205772,-0.309477,0.273534,0.629605,0.167959,-0.715623,0.389914,-0.112954,-0.522136,-0.657794,0.400517,-0.578605,0.0159436,0.722722,-0.666313,-0.622074,0.452045,0.0933817,0.208726,-0.00215992,-0.403322,-0.485867,-0.294506,0.0926225,0.945752,0.0852693,-0.116841,0.209886,0.124321,-0.431334,-0.129892,0.153826,0.29126,-0.399754,0.15606,0.0586048,-0.0733204,-0.491465,-0.064164,-0.0405166,0.125366,-0.455082,0.791525,0.333462,0.213166,0.25297,-0.120962,0.501169,0.293429,-0.122371,0.460031,0.168625,-0.252053,0.142932,-0.503617,-0.0445379,0.0384462,-0.302773,0.489614,-0.231876,0.499194,0.163735,0.210232,-0.0211168,-0.164052,0.539223,-0.53415,-0.176546,0.02855,-0.145978,0.137296,0.339653,-0.619213,-0.0401544,0.360867,-0.777324,0.374314,-0.0384794,0.202841,-0.0298152,-0.0300897,-0.368451,-0.0362788,0.560969,-0.323806,0.23353,-0.196216,-0.231756,-0.0987179,-0.0685653,0.577024,-0.824208,-0.327287,0.287188,0.153434,-0.78289,-0.296524,-0.23745,-0.242519,0.386126,-0.256368,-0.207867,0.137026,0.25175,0.0429641,-0.181814,0.000119,0.0511551,-0.473291,-0.616781,-0.194956,0.157059,0.248259,0.146376,0.502439,0.225015,0.339352,0.0530384,-0.0126695,-0.507404,-0.164054,-0.470341,0.0153553,0.225905,0.020213,-0.150921,-0.160368,-0.300853,-0.107823,0.216004,-0.27041,0.667809,-0.310533,-0.0119377,-0.157883,-0.388312,-0.0793419,0.128655,-0.476063,-0.510257,0.839566,0.246244,0.297936,-0.510703,-0.372022,-0.3776,-0.188864,0.677369,0.749414,-0.129753,-0.565064,0.382471,0.117604,-0.0165739,-0.298039,-0.243729,-0.0726152,-0.306371,0.0813594,1.08253,-0.115583,0.388036,0.308934,-0.259951,0.18421,-0.438182,-0.229606,-0.133039,-0.0660153,0.179204,0.239079,-0.317103,0.283086,-0.708886,-0.255353,0.488556,-0.135373,0.289741,0.319853,-0.49306,0.360208,-0.202292,0.156681,0.115279,-0.43243,-0.394637,-0.435472,0.191487,-0.037002,0.292014,0.665159,-0.692928,-0.712765,0.0257133,-0.152588,-0.52141,0.445,0.0784516,0.298957,0.25412,0.0236016,0.125233,-0.3596,-0.596389,0.149402,-0.120155,-0.227041,0.25377,-0.649504,0.0331409,0.322749,0.0939767,0.0172968,-0.00678558,0.352211,-0.355647,-0.0649818,-0.0440475,-0.294965,-0.596273,-0.437431,0.335258,-0.450197,0.0320637,-0.777646,-0.209318,-0.0836197,-0.0406387,0.261992,0.0459289,0.167527,0.00258507,0.427423,-0.791561,0.100663,-0.712953,-0.217348,0.227325,-0.416601,0.374549,-0.235511,-0.470845,0.347246,0.12058,0.0817738,0.321223,-0.0089703,-0.0841239,0.170279,-0.0220549,-0.272434,-0.186736,-0.28902,0.114374,0.321578,0.338192,0.567078,-2.3378 +3431.34,0.873909,0.0912059,4,1.64929,0.958144,-0.872329,0.330031,0.314117,-0.0545178,-0.0257356,0.190869,-0.276163,0.595176,0.211755,-0.155308,0.0882327,-0.201611,-0.286892,1.0875,0.156092,0.195321,0.014763,-0.236736,-0.304915,-0.459689,-0.718121,-0.110561,-0.355536,-0.164588,-0.0100648,0.810356,-0.0615919,0.284814,0.75054,-0.642711,0.106038,0.0867041,-0.34209,-0.324348,-0.41466,0.475765,0.325114,-0.393619,0.697408,0.536453,-0.130257,-0.940378,-0.233457,0.676643,-0.497848,0.0221699,0.477065,-0.359632,0.172318,0.25682,-0.0751658,-0.83856,0.143366,0.146963,-0.260518,-0.645586,0.257504,-0.384896,0.0791418,0.77934,-0.416899,-0.978756,0.6014,0.15932,0.0764732,-0.139009,-0.605511,-0.535916,-0.176546,0.306593,1.08999,0.221551,0.090488,0.194953,0.139406,-0.299371,0.0123414,0.361511,-0.0038208,-0.33604,0.183021,-0.0871014,-0.0988362,-0.325212,-0.138748,0.032701,0.0865685,-0.575259,0.621308,0.07457,0.244153,0.124154,-0.161119,0.174544,0.323291,-0.0572664,0.456539,0.0428135,-0.473299,-0.136775,-0.659033,0.0560685,-0.256516,-0.451701,0.0921431,-0.359007,0.394232,0.248504,0.0438854,0.072673,-0.318548,0.588036,-0.377656,-0.462659,0.167068,-0.0960489,0.12363,0.170704,-0.50149,-0.111991,0.538688,-0.956579,0.401989,-0.179428,0.365607,-0.152569,0.295527,-0.114512,-0.350392,0.429979,-0.358811,0.301558,-0.134917,-0.34874,-0.197899,-0.303773,0.699058,-0.538751,-0.114969,0.287042,-0.045551,-0.879522,-0.28206,-0.105822,-0.253492,0.480751,-0.405685,-0.199438,0.152734,0.376071,-0.0349446,-0.263507,0.490032,0.167823,-0.171986,-0.320291,-0.334093,0.169741,-0.00231672,0.352753,0.546085,0.388286,0.289701,0.103463,-0.0366677,-0.326956,-0.176817,-0.114945,0.0689773,0.071648,0.00198145,-0.482114,-0.437966,-0.295033,-0.0748826,0.249915,-0.175873,0.882626,-0.252223,0.356158,-0.328423,-0.19847,-0.251427,0.112831,-0.38852,-0.424395,0.584184,-0.225774,0.398966,-0.468423,-0.163247,-0.593018,-0.0688274,0.44751,0.441885,-0.219805,-0.961962,0.332568,0.196967,0.243361,-0.271297,-0.589774,-0.284448,-0.186875,-0.0935924,0.983184,-0.0766626,0.442793,0.246256,-0.0419864,0.0898573,-0.608879,-0.0564253,0.0812224,0.0600668,0.394009,0.373654,-0.297861,0.444243,-0.443467,-0.335234,0.480468,-0.00366081,0.214139,-0.00372804,-0.484711,0.195822,-0.131296,0.050896,0.0861421,-0.0510382,-0.629539,-0.412691,0.20886,-0.0271473,0.187851,0.783102,-0.717966,-0.668178,0.0675334,-0.281439,-0.511176,0.53919,-0.272624,0.0763018,0.430955,-0.383771,0.0549211,-0.506671,-0.542722,0.288561,-0.15425,-0.175477,-0.00587443,-0.590595,0.112054,0.0327126,0.355376,-0.038598,0.00491701,0.225697,-0.508053,-0.0568447,-0.096475,-0.256225,-0.461305,-0.287572,0.106434,-0.322558,0.0401906,-0.446058,0.413581,-0.113762,-0.168402,0.384506,0.174292,0.295288,0.455399,0.467135,-0.312749,0.279435,-0.669239,-0.222891,0.1652,-0.214678,0.347267,-0.193536,-0.753648,0.243796,-0.127021,0.083916,0.324198,0.0509188,-0.267079,0.273302,0.257698,0.0568857,0.185203,-0.128111,0.132076,0.321121,0.363423,0.566676,-0.928491 +3435.35,0.918241,0.0912059,4,1.57286,0.763071,-1.55398,0.571161,0.131892,-0.0796323,-0.000436245,-0.0855631,0.00638871,0.320752,0.449847,-0.594837,-0.186545,0.0413141,-0.214906,0.586852,0.403047,-0.0185974,-0.252605,0.114768,-0.284884,-0.960752,-0.98857,0.206935,-0.213032,0.0942839,-0.0591845,0.107958,-0.446182,-0.0897881,1.10689,-0.321826,0.0680485,0.0869015,-0.483416,-0.21035,-0.113179,0.60745,0.788388,-0.245322,1.12987,0.796687,0.362944,-0.725603,-0.16718,0.150166,-0.915844,0.0590044,0.556646,0.328765,0.029502,0.401178,-0.134802,-0.0484436,0.355726,-0.0799452,-0.0432094,-0.690227,0.489393,-0.20392,-0.25788,0.575415,-0.494219,-0.691417,0.676766,0.0145954,0.36596,-0.0526143,-0.10241,-1.00355,0.20577,0.486263,0.877887,0.329215,0.825991,0.246608,0.442059,-0.262678,-0.477288,-0.0606239,0.110757,-0.654785,0.352215,0.57165,-0.343037,-0.757664,-0.543079,-0.20936,-0.026758,-0.390166,0.157559,-0.492659,0.155431,0.406493,0.57386,-0.226486,-0.0715359,-0.396249,0.308525,0.126308,0.294991,-0.189657,-0.58733,-0.76239,0.22752,-0.67158,0.00996603,-0.332788,0.00326238,0.808664,0.378614,-0.131251,-0.490334,0.330445,-0.320496,0.019965,-0.307203,0.133566,0.328129,0.188679,-0.373112,-0.315831,-0.15011,-0.285937,-0.172561,0.443102,-0.0228832,0.135375,-0.285596,-0.330864,-0.390485,0.309551,-0.0346587,0.174253,-0.239533,-0.240669,0.0664361,0.0613851,0.526034,-0.539752,-0.450598,0.328833,-0.521499,-0.358028,0.0410769,0.350099,-0.312094,0.175112,-0.338737,-0.319144,-0.191399,0.196132,0.178504,0.030658,0.0150595,0.576465,-0.345372,0.0638362,0.150102,0.57934,0.00203915,0.0491923,0.993054,0.186683,0.198989,-0.230931,-0.223494,0.281035,-0.290078,-0.176147,0.372656,-0.269054,0.0333279,-0.0759381,0.115296,-0.588004,-0.19857,0.0873973,-0.408741,1.03866,-0.284111,-0.177532,-0.306967,-0.289798,0.265783,-0.272344,-0.137094,-0.766198,0.602238,-0.701443,0.295779,0.0479451,-0.459134,-0.531746,-0.180031,0.308544,-0.0153897,-0.107991,-0.615365,0.356721,0.176233,-0.0531993,0.439281,-0.457456,-0.337541,-0.200502,-0.308563,0.821425,0.266707,0.244533,-0.00429257,-0.295162,0.375885,0.153576,-0.480388,-0.241673,-0.0945758,0.193128,0.0462048,-0.404886,-0.138204,-0.483972,0.196654,-0.288631,-1.05533,0.0213722,-0.114156,-0.173575,0.12411,0.0899093,0.239185,0.210774,-0.144935,-0.165428,-0.271758,0.39614,0.238927,-0.345217,0.385851,-0.270264,-0.102324,-0.618569,-0.375317,-0.00933518,1.11098,0.359376,0.025347,-0.193799,-0.265283,0.350998,-0.424657,-0.604812,-0.00680736,-0.36199,-0.194815,0.120628,-0.43813,-0.428844,0.337584,0.1372,0.535024,-0.274658,0.177982,0.086619,0.199278,0.233039,-0.25961,0.0380398,-0.285326,-0.0586846,-0.353234,0.220225,-0.281441,-0.171429,0.429167,0.197222,-0.104322,-0.647383,0.380478,0.0355603,-0.32883,-0.455797,-0.223634,-0.130943,-0.191268,-0.04323,0.00629593,0.24889,0.215451,-0.293555,-0.0865225,-0.453673,-0.470839,0.25777,-0.120598,-0.125607,0.618078,0.232974,-0.0638071,0.426485,0.0324983,0.139029,0.182641,0.372866,0.427366,0.0806581 +3434.07,0.992684,0.0912059,4,1.59164,0.72891,-1.49941,0.52643,0.299792,-0.00881454,-0.271489,0.163001,-0.243186,0.0832125,0.445733,-0.763667,-0.216686,0.2924,-0.223201,0.675711,0.507366,-0.0589792,-0.230434,0.128945,-0.273361,-0.63344,-1.1465,0.171132,-0.388027,-0.361689,0.0402501,0.0894635,-0.472757,-0.047416,0.91621,0.0799967,0.0942912,0.217326,-0.531929,-0.129003,-0.281721,0.728744,0.678622,-0.121297,1.17171,0.405954,0.46554,-0.365253,-0.208568,-0.104928,-0.737936,0.30241,0.628681,0.101639,0.0218965,0.0566668,-0.0189568,0.508656,0.56965,0.26204,-0.366485,-0.337824,0.447916,-0.364972,-0.409922,1.01036,-0.269209,-0.656204,0.415915,0.145131,0.302484,-0.0468438,0.323246,-0.724387,-0.00200678,0.396594,0.791592,0.0140952,0.468024,0.0615833,0.555751,-0.168431,-0.58624,0.301367,0.295977,-0.498318,0.317352,0.415717,-0.29299,-0.714649,0.00260249,0.613539,0.228253,-0.492122,-0.0519433,-0.377395,0.0342637,0.507446,0.496672,-0.34006,-0.178028,-0.54479,0.515299,-0.164589,0.468706,0.0726823,-0.162272,-0.466836,-0.156279,-0.622684,0.180436,-0.169946,0.0990503,0.843932,0.470194,0.070192,-0.201717,0.610433,-0.239122,-0.154554,-0.251665,-0.0326127,0.481522,0.294859,-0.301607,-0.54314,-0.309564,-0.23017,0.119758,0.28024,-0.0674853,0.195658,-0.17753,-0.466531,-0.185467,0.600276,-0.0612313,0.277908,-0.249878,-0.32029,0.0563545,0.107264,0.400614,-0.428399,-0.465774,0.381734,-0.136519,-0.352157,-0.159348,-0.0808351,0.0121687,0.247493,-0.210007,-0.225443,-0.325431,0.307822,0.227775,0.117098,-0.160107,0.692037,-0.0655872,-0.206394,0.120865,0.0495193,-0.558833,-0.0978946,0.970459,0.0583062,-0.0490864,0.17909,-0.423672,0.397937,-0.40378,-0.094108,0.560606,-0.174841,-0.0939444,-0.174839,-0.0482208,-0.433524,-0.175085,-0.197216,-0.0809338,0.683397,-0.068239,-0.00534251,-0.109897,-0.073097,0.019375,-0.130421,-0.0962597,-0.894668,0.62617,-0.528056,0.228756,0.000480671,-0.377273,-0.617536,-0.177393,0.389161,-0.109522,0.0403958,-0.645499,-0.105918,0.0979705,-0.152722,0.517963,-0.45016,-0.281972,-0.116839,-0.532665,0.800148,0.26807,0.0746673,0.100583,-0.254234,0.518128,-0.154934,-0.521697,0.010085,0.0614061,-0.0945785,0.17219,-0.244855,-0.247949,-0.506344,0.482622,-0.3645,-0.932881,0.0376511,0.0340037,-0.279745,-0.0376678,0.154535,0.519176,0.0145719,-0.148806,-0.0932691,-0.0211288,0.349871,0.482795,-0.310244,0.601273,-0.341521,-0.340348,-0.473792,-0.497929,0.245465,0.838895,0.395505,0.0020341,0.109281,-0.429628,0.259353,-0.330982,-0.657312,0.06205,-0.125445,-0.0975305,0.149683,-0.671679,0.114256,0.251505,-0.0191722,0.293837,-0.131014,0.105968,-0.210404,0.474669,0.261517,-0.195424,0.147072,-0.177764,-0.17386,-0.176912,0.354729,-0.554746,-0.174814,0.308958,0.396559,-0.0181072,-0.638112,0.612137,-0.121268,-0.183526,0.181576,-0.111675,0.0199331,-0.387126,-0.2023,0.128018,-0.0625564,0.254584,-0.0436303,-0.0734674,-0.401855,-0.433259,0.174478,-0.207969,0.0285464,0.731627,-0.079739,-0.19062,0.0879845,-0.0767938,0.138336,0.230718,0.371935,0.480331,-0.401506 +3423.48,0.989889,0.0912059,4,1.54755,0.795831,-1.51491,0.555331,0.872704,0.0916373,0.290786,-0.493136,0.407411,0.0767943,0.131758,-0.0616397,0.1122,0.155363,0.0317171,0.829712,0.0849912,0.0259704,-0.0256294,0.273344,-0.0670701,-0.697679,-0.235889,0.177868,-0.527224,0.0944412,0.153079,0.30306,-0.453943,0.161469,0.664379,-1.15877,0.102488,0.473504,-0.191109,-0.629918,0.371345,0.489666,0.429381,-0.430765,0.874339,0.374718,-0.0679248,-0.448214,0.0621601,0.372013,-0.0224625,-0.0010002,0.427152,-0.0233394,-0.102344,0.526311,-0.188333,-1.44846,0.306085,-0.0139571,-0.0762422,-0.746653,0.526896,-0.155141,0.737178,0.952932,-0.73099,-1.11205,0.231011,0.0712976,-0.529477,0.0999556,0.14422,-0.521891,0.02301,0.308283,0.767537,-0.157433,0.442768,0.417831,-0.0417137,0.167458,-0.804792,-0.144641,0.381069,-0.276899,0.266457,-0.308842,-0.850663,-0.328064,0.269096,-0.624718,0.245937,-0.368892,0.323506,-0.2428,-0.387795,0.0685216,0.447469,0.00621363,0.4061,-0.273236,0.32498,0.494109,0.213397,0.110697,-0.493632,0.289553,0.270394,-0.242225,0.407281,-0.503679,0.422969,0.672319,0.0491605,0.16342,0.296096,0.553216,-0.0713299,0.325816,-0.415787,0.132451,-0.375548,-0.15003,-0.55182,-0.105054,0.342546,0.0489479,-0.0444171,0.488181,0.318555,-0.455238,0.272155,-0.00845327,0.138179,-0.267684,-0.318169,0.492318,-0.0536341,-0.0732046,0.130365,-0.5776,0.315844,-1.14952,0.193313,-0.164248,0.647197,-0.356598,0.168207,0.328539,-0.0605896,0.311111,0.0296371,-0.093592,-0.156245,-0.239572,-0.174892,0.288575,0.110316,0.247996,0.371119,0.162898,0.1089,-0.0359348,1.07318,-0.168864,0.519293,0.429103,0.662819,0.355358,-0.241348,-0.457997,0.235449,0.191105,0.217995,-0.124731,0.382218,-0.231668,0.130484,-0.250435,-0.285388,0.211203,0.499442,0.572175,0.630246,-0.158309,0.222858,0.0216432,0.390416,-0.239114,-1.09676,-0.027141,0.323471,-0.474983,0.0716087,0.0229913,0.207913,-0.297911,0.284739,-0.136274,0.0138805,-0.379285,-0.323454,0.137842,0.0869647,0.17529,0.0624826,-0.311536,-0.0357311,0.144943,-0.972448,0.953831,-0.66402,-0.368187,-0.150982,0.282237,0.0532887,0.00668536,0.326853,0.505212,-0.239408,0.172699,0.985177,-0.40376,0.273068,-0.478396,-0.250106,0.773137,0.357524,0.197141,-0.140224,0.23728,0.52662,0.462678,0.158359,0.465381,-0.0673255,0.0731192,0.101582,0.398885,-0.626835,0.00871487,0.614342,-0.0133319,-0.0545432,0.38788,0.0746147,-0.458828,0.129722,-0.276551,0.336553,-0.005063,-0.350419,-0.679989,-0.261623,-0.611149,0.0855599,-0.00521647,-0.0655776,-0.485767,-0.0484155,0.0292045,-0.0710313,0.159902,0.128809,0.14351,-0.230106,0.194153,-0.0673847,-0.121801,-0.130903,0.0243716,-0.0901253,-0.31503,-0.204688,-0.516758,-0.02807,0.275452,-0.12806,-0.326383,0.0110625,0.567433,-0.244808,-0.480714,0.0652722,-0.331103,0.0834407,0.416581,-0.0963803,0.581472,-0.409827,0.277422,0.296417,-0.413503,0.280142,-0.0286291,0.623806,-0.130276,-0.635898,-0.500916,-0.467848,0.016422,0.12739,0.195618,0.160521,0.118669,0.181293,0.344484,0.425785,-2.51024 +3434.73,0.900468,0.0912059,4,1.55079,0.954898,-0.94101,0.376513,0.883582,0.0309661,0.21469,-0.0622298,0.520142,0.662654,0.0885446,-0.072583,-0.0945694,0.0963496,-0.257104,0.93013,-0.136791,0.248311,-0.180347,0.109276,-0.191439,-1.09735,-0.615389,0.0764204,-0.521644,0.128484,0.178382,-0.142188,0.0574545,0.158791,0.805074,-0.588707,0.319238,0.61959,-0.128723,-0.289122,-0.431956,0.233191,0.841141,-0.338057,0.892772,-0.353212,-0.651644,-0.279694,-0.054742,0.103695,-0.677699,-0.460284,0.380833,-0.393335,-0.150362,0.277505,-0.0170309,-0.590005,0.169888,0.165989,-0.336979,-0.752009,0.564596,-0.16378,0.559656,0.940468,-0.516373,-0.53775,0.0409654,-0.228147,0.303612,0.189586,-0.207319,-0.380229,0.471612,0.248517,0.653695,-0.105315,0.473656,0.428715,-0.141207,-0.351609,-0.587428,-0.107261,0.365532,-0.528509,0.185955,0.0262832,-0.30627,0.0365146,-0.0177308,0.176536,0.0410584,-0.531489,0.281845,0.574997,0.0957302,0.312665,0.306709,0.0112945,0.280963,-0.383381,0.36244,0.297832,0.186962,0.123761,-0.316219,0.0508986,-0.0396959,-0.370372,0.376268,-0.0674185,0.338468,0.393141,-0.0261586,-0.0916125,-0.078944,0.804224,-0.216714,0.114927,-1.00115,0.116887,0.157458,-0.537348,-0.169919,-0.0816509,-0.0474427,-0.509107,-0.066824,0.551637,0.43168,-0.275007,0.228907,-0.578272,-0.488141,0.028708,-0.20099,0.251668,-0.254964,-0.440538,0.0219679,-0.264398,0.409094,-0.130852,-0.676742,0.0743432,0.0376872,-0.0999187,-0.205716,0.534735,0.295969,0.114113,-0.161418,0.234504,-0.27819,-0.0349325,0.0384212,0.434855,-0.0745455,0.257783,0.2975,0.256739,0.123062,0.478283,0.602915,0.119277,0.810972,0.0135502,-0.0165866,0.746822,-0.371613,-0.523292,-0.0714436,0.397161,0.349826,-0.263133,0.367284,-0.135758,0.397507,-0.155042,-0.168006,-0.268155,-0.195061,0.809269,0.385212,-0.0654962,0.636772,0.238451,0.873499,-0.00359796,-0.212875,-0.0535758,-0.128082,-0.596982,-0.0939778,-0.135592,-0.292452,-0.280677,0.295604,-0.0264417,-0.280703,-0.23678,0.0997556,-0.0767284,-0.364484,0.0725275,0.384754,-0.233401,0.36502,-0.401265,-0.112768,1.02091,-0.00655774,0.572955,-0.30611,-0.249496,0.39959,-0.161196,0.0763273,0.705392,-0.290775,-0.19211,0.623691,0.385769,-0.219515,-0.747246,0.517349,0.39016,-0.243953,0.270195,-0.190171,-0.105873,-0.320438,0.39761,-0.315144,0.370804,0.0215099,0.184893,0.117881,0.474376,-0.0925676,-0.239639,0.281477,0.0402882,-0.443791,-0.320043,0.0307894,-0.114439,0.526917,-0.456014,0.455276,-0.14127,-0.0384638,-0.290681,0.371115,-0.390959,0.301986,-0.879369,-0.036261,-0.000965035,-0.0923905,0.0890536,-0.388295,-0.22356,-0.210509,0.875481,0.139685,0.0796422,-0.446972,0.13241,-0.342227,0.119934,0.468526,-0.362707,-0.302172,-0.203281,0.491776,0.156206,-0.310532,-0.0246293,-0.26882,0.689457,0.0981832,-0.292945,-0.129458,0.211811,0.325704,0.0103134,-0.249002,0.0345447,0.0872888,0.574469,0.264228,-0.130774,0.0944929,-0.376203,-0.00173712,0.351685,-0.390617,-0.391496,-0.61746,0.0870011,0.103409,-0.215578,0.272298,0.133968,0.220921,0.366016,0.470022,-2.94112 +3433.16,0.962954,0.0912059,4,1.54194,0.968584,-1.09683,0.386988,0.710094,0.117233,-0.0445772,-0.205797,0.413086,0.359999,-0.123135,-0.702246,0.139196,-0.0125976,-0.449828,1.12574,0.2977,0.213876,0.424372,0.092231,-0.164751,-0.575773,-0.783674,0.137357,-0.0809487,-0.605617,-0.0225072,0.479996,-0.319091,-0.0657223,0.703792,-0.790739,-0.219804,0.641372,-0.0164048,-0.763132,0.0199087,0.440071,0.548232,-0.487197,0.953215,0.475413,-0.241366,-0.617032,-0.272527,0.736976,-0.389515,-0.257461,0.325676,0.221183,-0.0599958,0.479622,-0.0411203,-1.14707,0.674044,-0.0209365,-0.0861712,-0.682123,0.203215,-0.313101,-0.0560503,0.962145,-0.598897,-1.03803,-0.0559422,0.349061,-0.00469476,0.116632,0.228587,-0.0233071,0.0263378,0.0273991,0.96297,0.0365179,0.399983,-0.0974415,0.187497,-0.059637,-0.259009,0.116015,0.135108,-0.556792,0.446669,0.180441,-0.374849,-0.124354,0.152331,-0.477345,-0.0799821,-0.0488875,0.00724132,-0.050068,-0.302706,-0.0080072,-0.531231,0.162048,0.25063,-0.52876,0.331879,0.640656,0.46715,0.180456,-0.384748,-0.0690322,0.0564022,-0.21381,-0.0208954,-0.183657,0.605989,0.683426,0.148113,0.0918968,-0.754084,0.211232,0.0918919,-0.355867,-0.558359,0.468439,0.141528,0.219083,-0.904123,-0.264553,-0.290342,-0.189293,-0.0186195,0.699865,0.172182,-0.186335,0.530401,-0.333909,-0.108808,-0.368306,0.0913605,0.26181,-0.44403,0.190365,0.174008,-0.240217,0.352887,-0.0466256,-0.00856172,0.00601206,0.202152,-0.361464,0.483912,0.27049,0.099458,0.25071,-0.221592,-0.144197,-0.660841,0.0971355,0.0504158,0.113266,-0.16165,0.767566,0.0786325,0.499542,-0.127695,0.0273878,0.427215,0.121499,0.813323,0.17046,0.361052,-0.104578,0.160419,0.0471881,0.0566833,-0.508697,0.0728307,0.175909,-0.118617,-0.0933305,-0.406464,0.0852393,-0.393408,0.121855,0.665517,0.810709,-0.404353,-0.398871,0.473825,-0.173849,0.0162149,-0.370831,0.228318,-0.0506543,-0.051569,0.0295046,0.19601,0.15616,0.0816158,-0.787451,-0.0628309,0.0538191,-0.190369,-0.615025,-0.0751058,-0.0615267,-0.0642437,-0.358185,0.243211,0.269931,-0.00400259,-0.375618,-0.0738886,0.815174,-0.159255,0.218347,-0.461052,-0.453626,0.606594,0.420015,0.385404,0.79561,-0.190044,0.0476151,0.635686,0.206604,0.153692,0.150306,-0.0872557,0.225234,0.533404,0.252734,-0.196767,-0.121528,0.242519,0.271086,0.476471,0.04267,0.180516,-0.219715,-0.434217,0.823567,-0.190919,0.605493,0.554712,-0.157237,-0.5146,-0.157233,-0.164429,-0.184823,0.540627,-0.0662224,0.364452,0.212935,-0.722265,-0.446188,-0.0284699,-0.504062,0.147114,-0.340809,-0.158103,-0.349674,-0.389765,0.32061,0.364716,-0.290447,-0.00311124,0.395572,0.358852,0.583667,-0.0836611,-0.105082,-0.0456066,0.0945688,0.248472,-0.605121,0.0536257,0.0465742,-0.681855,0.181616,-0.0520674,-0.0445987,0.0805492,0.700483,0.228879,0.0662104,0.189042,-0.692626,-0.162036,0.30852,-0.315037,-0.0717418,-0.265314,0.478335,0.0058017,-0.663375,-0.13786,0.0220162,0.0346268,0.0846253,-0.0786939,-0.363154,0.251139,-0.0178863,0.286347,-0.12496,-0.038603,0.108678,0.243163,0.329664,0.493115,-2.34785 +3433.42,0.701251,0.0912059,4,1.53096,0.909462,-1.10264,0.388014,0.594949,0.105839,-0.00799432,-0.17771,0.503512,0.268673,-0.233644,-0.761224,0.108362,0.0609208,-0.368742,1.11092,0.377733,0.241053,0.421263,0.112228,-0.178358,-0.610525,-0.882172,0.131766,-0.101264,-0.522538,0.0653927,0.554676,-0.322564,-0.067287,0.674679,-0.742623,-0.222344,0.686534,-0.0215439,-0.758137,0.0976809,0.510346,0.519453,-0.457704,0.959643,0.471301,-0.277937,-0.544915,-0.320897,0.786547,-0.504574,-0.242502,0.325374,0.211828,-0.0251359,0.544693,-0.0420378,-1.25611,0.636191,0.118042,0.00781074,-0.669799,0.200766,-0.339866,-0.05707,1.04048,-0.646233,-0.996851,-0.00453245,0.285716,0.0423536,0.0426888,0.207809,0.00111718,0.0451771,0.0526733,0.915724,-0.0229194,0.430829,-0.048371,0.239541,-0.00151109,-0.229096,0.09494,0.182792,-0.64209,0.454804,0.252716,-0.379721,-0.0560791,0.173934,-0.426168,-0.0861098,-0.0505815,-0.119123,0.0385628,-0.234383,-0.0412042,-0.520189,0.115524,0.194812,-0.541987,0.320175,0.651819,0.455041,0.266496,-0.299048,-0.0858235,0.0681615,-0.136757,-0.0547383,-0.219166,0.612577,0.746937,0.106882,0.133446,-0.775873,0.241614,0.0066466,-0.333663,-0.525042,0.437351,0.191395,0.220043,-0.91165,-0.302533,-0.181589,-0.190284,0.0028168,0.593156,0.138507,-0.193047,0.416691,-0.390775,-0.0889611,-0.354278,0.0981663,0.330655,-0.478389,0.128871,0.154974,-0.252545,0.451751,-0.134528,-0.0661059,-0.0124145,0.17527,-0.342729,0.434935,0.245942,0.148495,0.294339,-0.260502,-0.158159,-0.617529,0.189697,0.0175618,0.130064,-0.163423,0.713947,0.183596,0.546473,-0.125385,0.0928006,0.323572,0.124969,0.829153,0.204544,0.404285,-0.0581752,0.171996,0.019518,0.00158559,-0.550957,0.0146636,0.154308,-0.120607,-0.065136,-0.430935,0.183616,-0.424897,0.1909,0.673962,0.775884,-0.317563,-0.392269,0.456933,-0.0763095,0.0634666,-0.39146,0.24995,-0.0974728,-0.0804833,0.0694001,0.235141,0.054082,0.125326,-0.666926,0.0265564,0.0652557,-0.253445,-0.607573,-0.0679594,-0.0147904,-0.0131099,-0.32781,0.264931,0.265833,-0.0133721,-0.341458,-0.0209105,0.831861,-0.189898,0.150238,-0.394363,-0.457416,0.643696,0.417545,0.329202,0.71725,-0.234495,0.0597096,0.575567,0.194186,0.189566,0.0926638,-0.0578354,0.217151,0.566131,0.252535,-0.159576,-0.13167,0.233057,0.201088,0.513185,0.112159,0.170257,-0.208771,-0.360548,0.824923,-0.210751,0.567649,0.529692,-0.183206,-0.604574,-0.164783,-0.145627,-0.220081,0.53123,-0.0562212,0.33479,0.224264,-0.831569,-0.496502,-0.00481633,-0.599431,0.114039,-0.305438,-0.124861,-0.298236,-0.338501,0.272394,0.351008,-0.281703,-0.146305,0.405941,0.391883,0.58578,-0.0855467,-0.0894994,-0.00420927,-0.0201175,0.178701,-0.594343,0.0520057,0.0755558,-0.650364,0.073886,-0.0315322,-0.044972,0.0641154,0.768736,0.257565,0.165663,0.17811,-0.696288,-0.190769,0.313903,-0.227867,-0.104618,-0.198048,0.520224,-0.0208466,-0.559748,-0.188244,0.0112582,-0.0364825,0.0947311,-0.110028,-0.315951,0.3077,-0.0383757,0.238763,-0.127854,0.012124,0.113639,0.234597,0.337104,0.484352,-1.86712 +3418.71,0.996234,0.0912059,4,1.58299,0.858861,-1.30413,0.614034,0.801872,0.0367265,0.364008,-0.0930712,0.704863,-0.38784,0.0863729,0.364329,-0.312528,0.449644,-0.567001,1.13868,0.42147,-0.053883,-0.44218,-0.210508,-0.0335323,-0.920733,-0.618375,0.308462,-0.127763,0.348982,-0.481514,0.231203,0.193265,0.256335,0.797517,-0.877204,0.163129,0.235823,-0.252819,-0.221968,-0.268885,0.470421,0.840645,-0.245237,0.868536,0.0819848,0.780392,-0.883138,-0.0977084,-0.777669,-0.552888,0.275912,0.00715797,-0.306949,-0.344194,-0.0251159,0.107864,-0.155843,0.0959382,-0.312431,-0.0342328,-1.20683,0.176541,-0.375419,-0.0987444,1.17158,-0.625917,-0.401408,-0.204621,-0.201982,0.503127,0.251312,0.415655,-0.161515,-0.184548,0.444019,-0.0768473,0.31627,0.207235,0.306971,-0.0454519,-0.395552,-0.146014,-0.207181,0.533605,-0.206531,-0.0728517,-0.187455,0.316762,0.287726,0.307136,0.38458,0.325111,-0.398363,0.280035,0.307399,0.303589,-0.309389,0.484127,-0.41404,-0.198062,-0.18313,0.284503,-0.250278,0.166587,0.00515688,-0.314585,-0.64006,0.303568,-0.465278,0.170383,-0.231945,-0.0940435,0.428284,-0.126037,0.0152485,0.485984,0.507248,0.202457,0.0370587,-0.150032,0.173131,0.0172739,0.270778,-0.508542,0.423609,-0.160097,-0.306272,-0.723926,0.418684,0.241201,0.0817006,0.392404,-0.432412,0.270012,0.245581,0.17661,0.206916,-0.244393,-0.255511,0.170957,0.408755,0.41461,-0.84149,-0.229309,0.0774257,-0.586031,-0.168577,-0.0420567,0.0160182,-0.8937,0.592541,-0.0115272,0.356278,0.0722824,0.0583149,-0.235462,0.0491546,0.128357,0.427621,-0.00744112,-0.238219,0.322611,0.43705,0.315294,0.157734,0.665701,-0.43039,-0.0735193,0.250798,0.0672667,-0.366047,0.0492888,0.152725,0.418801,0.1864,0.100456,-0.113028,0.096935,0.569429,0.0516124,-0.303891,-0.0512547,0.100993,0.264708,0.324119,0.250093,0.162388,0.487637,-0.225424,-0.27932,-0.219687,0.251,0.118802,-0.357754,-0.166357,-0.547141,-0.60863,0.333051,0.466178,0.451903,0.228657,-0.811427,0.246539,0.0586278,-0.415582,0.420254,-0.136775,0.26153,-0.22652,-0.923875,0.979448,-0.120005,0.207006,0.227452,-0.0115428,0.115743,-0.00772524,-0.0341039,2.29713e-05,-0.278392,0.213189,0.356554,-0.313997,-0.108945,-0.339177,0.222997,0.105254,-0.279871,0.287974,-0.0758616,-0.0433743,0.103367,-0.177821,0.277919,0.0910287,-0.544561,-0.272217,-0.0544179,0.547423,-0.0666793,0.310269,0.337057,-0.474697,-0.139991,0.543652,0.325109,-0.481092,-0.430124,0.36287,0.673986,0.047856,-0.210051,-0.636602,0.0695542,-0.938134,-0.0832194,-0.00519464,0.324926,0.219724,-0.251374,0.109949,0.113184,-0.172627,0.429891,0.437178,0.584475,-0.101543,0.0308539,0.435157,-0.269799,0.373836,0.464874,0.363176,-0.848697,0.0179267,-0.243372,-0.348732,-0.0396242,0.411739,0.007458,-0.486699,0.439547,-0.780899,-0.328659,-0.43018,-0.13185,0.09398,-0.160728,0.245196,-0.200431,-0.0151845,-0.348025,0.416615,-0.0100178,-0.0228004,-0.481072,0.124622,-0.454806,-0.842364,-0.117948,-0.386369,-0.00018544,-0.285389,0.484549,0.124317,0.317266,0.352586,0.563264,-2.50377 +3438.74,0.973759,0.0912059,4,1.52705,0.925344,-1.13107,0.452581,0.629243,-0.0376022,-0.0542158,0.000574556,0.232758,0.40071,0.0768633,-0.151791,0.0847121,0.205797,0.00457474,0.947766,0.135305,0.187044,0.0943806,-0.146319,-0.389196,-0.673944,-0.600182,0.2316,-0.25175,-0.27549,0.0973063,0.859266,-0.140037,-0.0212463,0.894312,-0.0483511,-0.0541612,0.555335,-0.465657,-0.318299,0.0827084,0.531393,0.306244,-0.810209,0.803111,0.660316,0.517379,-0.118494,0.291564,-0.0737427,-0.292963,0.294492,0.128834,0.241971,0.154365,0.959242,-0.303265,-0.283861,0.527241,-0.0279106,-0.586104,-0.686117,0.237027,-0.619605,0.414714,0.936501,-0.354436,-1.11931,0.264108,0.0513931,-0.00348632,-0.0258581,-0.350873,-0.290524,-0.476945,0.257291,0.72651,-0.0167234,0.429722,0.0564697,0.476028,0.0531008,-0.39988,0.637368,0.493393,-0.413891,0.494047,0.191551,-0.356149,-0.338711,-0.0575124,-0.980316,-0.0115137,-0.110787,-0.376745,0.22747,-0.131997,0.189442,-0.536205,-0.140649,-0.267386,-0.0737313,0.698316,0.744466,0.199017,-0.616042,-0.371699,-0.152327,0.106119,-0.0101985,0.246364,-0.301763,-0.0481656,0.175383,0.0132642,0.0321028,-0.0962622,0.228129,-0.0905885,0.168038,0.0810373,0.106242,0.42386,0.0275088,-0.491765,-0.0552578,0.429232,-0.304456,0.430154,0.219469,-0.34312,-0.130988,0.136012,-0.152229,0.169226,-0.362352,-0.0933614,0.454543,-0.244467,-0.299058,-0.0738369,-0.122419,0.612719,-0.532695,-0.105801,-0.0531722,0.227554,-0.336841,0.545829,0.080345,-0.0242527,0.491732,-0.166218,-0.206793,-0.433313,-0.00112448,0.345263,-0.160006,0.302208,0.635711,0.0831749,0.495655,-0.047894,-0.198409,0.0358523,-0.48445,0.17127,0.667997,0.0208053,0.0471008,0.115527,0.27736,-0.0234064,0.0189,0.440336,0.458952,-0.157296,0.180595,-0.106886,-0.383758,-0.292799,0.0847677,0.45359,0.891211,-0.127129,-0.489815,0.292763,0.11521,0.02081,-0.0153211,-0.0877571,0.289845,-0.159021,-0.0235949,-0.23137,0.151744,0.237639,-0.662043,0.137621,0.393213,0.0995069,-0.128566,-0.0919446,0.65657,-0.195759,0.298642,-0.151361,0.723322,-0.239402,-0.105225,-0.545183,0.706732,-0.435075,-0.137433,-0.316981,-0.0396258,0.288254,0.499762,-0.0831304,-0.110469,0.218007,0.190755,0.421858,-0.030749,-0.170873,-0.713334,-0.390512,0.0643855,-0.529822,0.424297,-0.271619,-0.486707,0.221924,0.193037,-0.0522577,0.031585,-0.216112,0.172133,-0.0844709,0.38072,0.182216,-0.377279,0.458698,0.00262857,-0.465912,0.069686,-0.0681113,-0.232814,0.0459353,0.298101,0.168481,-0.454371,0.198967,-0.00617712,0.292235,-0.663331,0.523993,0.139467,-0.347767,0.151175,0.168858,0.213109,0.00676174,-0.048281,-0.0720751,-0.125157,-0.194959,0.129613,-0.0579148,-0.847833,-0.0802275,-0.100967,-0.327133,-0.164353,-0.101777,-0.714327,-0.351578,0.597392,-0.0222647,0.0445792,-0.111514,0.60813,0.0407854,-0.417751,-0.342801,-0.544724,-0.174929,-0.306681,0.139871,0.309203,0.110452,0.488954,0.367788,-0.614561,-0.121842,0.521539,0.000866053,-0.115443,-0.0713961,-0.0793692,-0.443704,0.178773,-0.0708593,0.0772156,-0.0997766,0.102756,0.154315,0.320556,0.39283,-2.02339 +3453.94,0.92307,0.0912059,4,1.53318,0.840942,-1.27515,0.442496,0.617253,-0.0273156,-0.406892,-0.011581,0.140338,0.286728,-0.0029145,-0.11499,-0.242851,0.378457,-0.247518,0.834765,-0.00474055,-0.253815,-0.416008,0.116122,-0.594421,-1.01305,-0.767088,0.210796,-0.49428,0.135069,-0.106965,0.509339,-0.659547,0.282802,0.7121,-0.402711,0.202796,0.197847,-0.164494,0.27474,0.182123,0.656129,0.323899,-0.391667,0.727779,0.194468,0.199613,-0.609385,0.205742,-0.037586,-0.674665,0.359884,-0.00682407,0.152597,0.0223283,0.482069,-0.0277567,-0.155115,0.69037,-0.392633,0.0551344,-1.20318,0.641691,-0.282224,0.0259632,1.08657,-0.63797,-0.356897,0.186542,0.651137,0.346923,-0.0101424,0.167377,0.265521,-0.102278,0.143588,0.439016,0.018088,0.417722,0.867637,0.467594,0.139402,-0.322057,0.236936,-0.219184,-0.211643,-0.0356713,0.26457,-0.482939,-0.0977476,-0.348647,-0.250952,-0.031117,-0.405618,-0.275576,-0.14189,-0.218245,-0.0226479,0.169111,0.0573323,-0.143097,-0.122225,0.0267419,0.498113,0.673517,-0.0487033,-0.361641,-0.33905,0.235177,-0.104188,-0.399142,0.149856,0.350847,0.294931,-0.0514392,-0.0630568,-0.129932,0.368895,0.254359,0.288498,-0.149712,-0.29928,0.556552,0.165849,-0.359655,-0.436223,-0.00185589,0.116276,0.113191,-0.325673,0.372428,0.155484,0.00515478,-0.486476,0.423762,0.114209,0.103257,0.269673,-0.0525224,-0.0566179,-0.246056,-0.307082,0.719672,-0.330044,0.21543,-0.110111,0.164672,0.00325792,0.0126883,-0.225016,-0.175323,0.273049,-0.372042,-0.518008,-0.276339,0.0180787,0.319611,0.202722,-0.0830135,0.124516,0.0341477,0.149895,0.136398,-0.402006,0.144011,-0.316668,0.19822,-0.12792,-0.341103,0.602137,-0.030147,-0.0472173,-0.2413,-0.529695,0.607343,0.153039,-0.037194,0.0130026,0.268849,-0.491243,-0.201758,0.178444,0.0068932,-0.0461136,-0.0125074,-0.292793,0.104903,0.14153,-0.104852,0.390318,-0.561793,-0.415477,0.308375,-0.517401,-0.0893857,-0.129398,-0.419992,-0.416863,0.085824,0.333897,0.238316,0.140982,-0.338148,0.373733,-0.00672167,0.266987,-0.0185817,0.0531303,0.07732,-0.484999,-0.189445,0.857176,0.0907071,0.481148,0.269861,-0.203338,0.211651,-0.320946,-0.128238,0.194997,-0.280541,0.370335,0.493277,0.133039,0.208482,-0.00448461,0.426734,-0.131039,-0.180508,0.844529,-0.411148,-0.25289,0.033697,0.178113,0.066883,-0.158591,0.210359,-0.329104,0.0241609,0.307084,0.221847,0.365334,0.644553,-0.257609,-0.370441,-0.294759,-0.193819,0.219274,-0.0269082,-0.338527,0.439733,-0.311991,-0.412147,-0.423487,0.156281,-0.107872,0.0265263,-0.278236,-0.0478564,-0.138723,0.0670047,0.434148,0.557754,0.0231472,0.42435,0.388825,0.0100963,-0.343052,0.106042,-0.272257,-0.0958222,-0.0743545,0.459575,0.111782,-0.12956,-0.610115,-0.361387,-0.0055649,0.449704,0.0669199,-0.093247,-0.133504,0.00107879,-0.0610735,0.101495,0.0701971,-0.515809,0.0793448,0.653342,-0.098618,0.199725,-0.124129,0.171493,-0.511556,-0.115138,-0.341741,-0.0706866,-0.339876,-0.106015,-0.545695,0.29718,-0.260378,-0.0158683,-0.415641,0.113052,0.0986724,0.247045,0.314122,0.497036,-1.74554 +3456.01,0.868974,0.0912059,4,1.58078,0.939324,-0.677382,0.261454,0.049729,-0.124673,0.13152,-0.257569,0.557642,0.0684866,-0.0645794,0.0467477,-0.284456,0.24685,-0.150152,0.710639,0.419292,0.13569,0.142602,0.11235,-0.272948,-0.360596,-0.792057,-0.108033,-0.507277,-0.44201,-0.141546,0.137192,0.346143,0.088906,0.850086,-0.476898,-0.554676,0.145103,-0.405369,-0.479947,-0.851646,0.594266,0.299818,-0.139665,1.12503,0.387847,0.42092,-0.917793,-0.174472,-0.379172,-0.320385,0.115844,0.530225,-0.251306,0.0216317,0.196623,0.394662,-0.445113,0.657525,0.0312315,-0.400417,0.152012,0.270083,-0.456227,-0.0569911,1.03256,-0.644379,-1.24488,-0.0966621,-0.182738,-0.188487,-0.0264049,-0.0914619,-0.821715,-0.073724,0.46696,0.879748,0.0884821,0.512232,0.0253885,0.19312,-0.0777999,-0.105331,0.0746116,0.589597,-0.290824,0.572905,-0.268064,0.195567,0.271845,0.133237,-0.152171,-0.112358,-0.229771,0.456242,0.34863,0.21198,0.121497,-0.0470621,-0.327218,-0.0259203,-0.142152,-0.093799,-0.15138,-0.266266,-0.189306,-0.00797891,0.21936,-0.134786,-0.311598,0.60805,-0.189697,0.256279,0.613739,0.0556247,-0.037129,0.162394,0.151632,-0.342961,-0.0528392,-0.449075,0.348213,-0.325535,-0.087536,-0.807702,0.416792,-0.207502,-0.21099,-0.0235851,0.611668,-0.272315,-0.0093323,0.430937,0.0243004,-0.303696,0.0456501,0.0265482,0.454643,-0.130809,-0.191596,0.270909,-0.0246284,0.164086,-0.44107,-0.419764,0.108534,0.247293,-0.597519,0.171932,0.168971,-0.0101636,0.022421,-0.0151257,0.359037,0.0682516,0.127111,0.0811399,-0.222653,0.3127,0.108161,0.258325,-0.340797,-0.1717,0.630288,-0.0643011,0.391019,1.0818,0.178065,0.180645,-0.504395,0.221551,-0.0867548,0.0239114,0.335742,-0.399716,-0.27688,-0.203081,-0.133328,-0.227899,0.1908,-0.335239,-0.201071,0.371143,0.756736,0.0323909,0.162929,0.278349,0.0575514,0.251785,-0.840943,0.0122705,0.0204604,-0.173655,0.286285,0.317786,0.114559,0.419406,-0.384604,0.0694755,-0.115929,-0.176499,-0.342532,-0.3266,-0.120078,0.0891079,-0.180872,0.331022,-0.0524311,-0.314699,0.0357592,-0.446683,0.779819,-0.116885,-0.307478,-0.304768,0.0112717,0.0138891,0.397404,-0.274095,0.261971,-0.0239599,-0.250401,0.235107,-0.597888,-0.0404415,-0.60468,-0.461646,0.352123,-0.343722,0.201382,-0.120352,-0.0804167,-0.0141758,-0.242366,-0.547483,-0.252228,-0.434715,0.117244,-0.510463,0.398827,-0.214666,-0.103011,-0.13032,-0.232674,-0.142552,0.33279,0.224021,0.0212054,0.284408,0.449891,0.260733,0.385133,0.404054,0.0320436,-0.31118,-0.621358,0.550624,-0.147142,-0.202888,0.393325,-0.365576,-0.404465,-0.40067,0.181039,0.0301922,0.0588948,0.143548,0.326118,0.0538542,0.274375,-0.0928555,-0.068431,-0.435579,-0.171925,-0.00356483,0.216086,-0.0612794,-0.108161,-0.439166,-0.000171229,0.0340684,0.301967,0.040961,0.219313,-0.255343,-0.159184,-0.0455721,-0.0940567,-0.295501,0.463845,-0.385857,0.347112,-0.0898708,0.0959046,-0.309431,0.278893,0.00100518,0.389534,-0.16454,-0.112427,-0.17653,-0.12162,-0.292792,0.10387,-0.241159,0.0972056,0.194167,0.311778,0.440643,-0.105869 +3434.49,0.811041,0.0912059,4,1.5725,1.0062,-0.247075,0.138646,0.323033,-0.168108,0.748411,0.215926,1.12976,0.0862497,0.00401597,0.0078238,0.239035,0.187875,0.464932,0.966157,0.0394553,-0.100654,0.0145085,0.0302172,-0.0613548,-0.720216,-0.163881,0.169591,-0.0484783,-0.200707,-0.0971711,0.595037,-0.18604,0.171568,0.776696,-0.689828,0.380364,0.359789,-0.36872,-0.146552,-0.674305,0.618273,0.443282,-0.636238,1.10749,0.204097,0.167358,-0.60389,-0.350502,-0.389496,-1.25808,-0.366905,0.414876,-0.271781,0.0641389,0.418863,0.127586,0.017544,0.7646,-0.377142,-0.00874531,-0.886402,0.358706,0.0457208,0.403919,0.828025,-0.566303,-1.13577,0.140741,0.0558662,0.15554,-0.0659334,0.639742,-0.0474688,-0.348782,0.347137,0.72137,-0.318793,0.652021,0.7792,0.283807,0.360232,-0.433326,-0.126573,-0.284291,-0.0548184,0.0416624,0.239027,0.0971695,0.389175,0.0229911,0.110801,0.109475,-0.348091,-0.183741,0.306018,0.0374774,-0.00729132,-0.0779943,0.30913,-0.443218,-0.339273,-0.0937331,0.049807,0.298867,-0.0511278,-0.3548,-0.086156,0.362349,-0.0553268,0.0121403,-0.140697,0.33056,0.487185,-0.0969633,-0.378351,0.370715,0.0636424,0.481962,0.0546695,-0.317938,-0.234594,0.307856,-0.0448942,-0.641823,-0.14975,0.402526,-0.509244,-0.497892,0.328841,0.296688,0.403875,-0.156015,-0.882818,0.0551704,0.195093,0.0647071,0.573192,-0.532173,0.339229,-0.423287,-0.295698,0.156985,-0.374087,-0.440228,0.313291,0.317426,0.375035,0.249138,0.439429,-0.522262,0.440704,-0.325931,0.666221,-0.34894,0.115419,0.187944,-0.0253417,0.0447883,0.47057,0.0446501,0.313482,0.0664957,-0.0675921,-0.259856,0.00811463,0.0394083,0.346222,-0.0306114,0.128335,-0.511019,0.151857,-0.166253,0.120172,0.285048,-0.467513,-0.388963,0.124874,-0.0144662,-0.418069,-0.276783,-0.106233,0.133202,0.434932,-0.164295,0.691662,0.252204,-0.00279405,-0.422013,-0.709721,0.0347316,-0.0828154,0.170506,-0.702318,0.0886821,-0.0176061,-0.0476143,-0.550584,-0.521661,0.145101,0.106522,-0.209251,-0.579401,-0.255785,-0.19228,-0.789027,0.272162,-0.147303,0.338596,-0.160047,-1.02618,0.860493,0.430435,0.57288,0.107454,-0.17046,0.749379,0.363276,0.12392,0.2382,-0.0396264,0.156655,0.461148,-0.398303,0.192248,-0.395948,-0.168368,0.409479,-0.118314,0.267732,0.0984237,-0.0701785,-0.0753768,-0.352094,-0.614214,-0.160785,0.212501,-0.0546452,-0.597684,0.240368,0.352794,0.0383675,0.645184,-0.575884,-0.153248,-0.148333,-0.446937,0.207843,-0.116939,0.283149,0.471321,0.27032,0.0966431,-0.143619,-0.167143,-0.446591,0.248378,-0.300376,0.269267,0.387274,0.00167136,0.0253917,-0.170573,0.467346,0.730806,0.503792,0.453043,0.255751,-0.492182,0.224304,0.257525,-0.0705853,0.305216,0.0163156,-0.358305,-0.104052,0.298845,-0.0199191,-0.307541,-0.121306,-0.219669,0.134141,0.187904,-0.697548,-0.33558,-0.129824,0.262515,0.355581,0.0986018,0.369808,-0.0984551,-0.0957389,-0.0154727,-0.312283,-0.0574741,0.0231027,0.0487348,-0.248081,-0.0844448,-0.739273,-0.312873,-0.171902,-0.646454,-0.190725,-0.10566,0.121422,0.293121,0.348457,0.541407,-1.23846 +3430.8,0.839288,0.0912059,4,1.54277,1.09318,-0.294358,0.143089,0.482167,-0.173824,0.582625,-0.0406087,1.29295,0.420127,-0.277263,-0.0338015,0.0797618,0.26418,0.464544,0.793098,-0.0261162,-0.0111056,0.121165,0.128095,-0.301999,-0.719241,-0.177159,-0.233284,-0.362687,-0.281985,-0.0419563,0.515573,-0.192687,0.0979685,0.803649,-0.676434,0.687762,0.405715,-0.609738,-0.439458,-0.572795,0.791531,0.424643,-0.453739,0.792274,0.350682,-0.189862,-0.587002,-0.169532,-0.373702,-1.441,-0.123075,0.397217,-0.312739,0.000973434,0.520489,0.180163,-0.0774989,0.670977,-0.77043,-0.264659,-0.745625,0.380203,-0.363064,0.321479,0.761983,-0.344579,-0.941645,0.217715,0.29218,0.271547,-0.0289802,-0.0867747,-0.00321438,-0.146323,0.338152,0.715766,-0.327887,0.584767,0.412732,0.742506,-0.277612,-0.128966,-0.172058,-0.118301,-0.408431,0.30135,0.410883,-0.0513688,0.524827,0.0163536,-0.218576,0.199379,-0.318731,-0.622901,-0.0942591,0.0123174,0.205289,0.185411,-0.109083,-0.460259,-0.0536378,-0.178111,0.169343,0.530139,0.0196137,-0.489454,-0.0424781,0.366046,-0.504675,0.230283,-0.189351,0.394091,0.346943,-0.129032,-0.327093,0.190543,0.0900464,0.464348,0.0853108,-0.493518,-0.445987,-0.143484,-0.0705434,-0.715283,-0.213482,0.533612,0.26866,0.116429,0.595683,0.0146963,0.507287,0.0366052,-0.892754,-0.162264,0.24812,-0.0493771,0.655666,-0.120782,0.0512815,-0.0812935,-0.488399,0.379087,-0.109742,-0.171763,0.248578,0.45401,0.129979,0.28831,0.263308,-0.20157,0.383572,-0.0635383,0.527902,-0.191212,-0.052713,0.121914,0.287721,-0.175724,0.00252721,0.141764,0.244985,0.0375702,-0.421385,0.348748,-0.00311365,0.218933,0.74398,0.353941,0.0793301,-0.404079,-0.0336814,-0.164132,-0.0907883,0.278085,-0.513351,-0.440454,-0.251562,-0.0884654,-0.418246,-0.165672,-0.387478,-0.0608136,0.478623,0.0646109,0.920111,0.225692,-0.175778,-0.0408519,-0.609269,-0.21674,0.217293,-0.209201,-0.813729,0.0231672,-0.168037,-0.0647742,-0.53347,-0.239766,0.207257,0.172187,-0.214966,-0.764682,0.0182706,-0.39584,-1.18768,0.161814,0.219095,0.49037,-0.588879,-0.845092,0.871843,0.72672,0.404315,0.210925,-0.0997351,0.205309,0.35085,0.283082,0.102718,-0.163846,0.0696977,0.611687,-0.474767,0.416597,-0.406935,-0.439529,0.624703,-0.2846,0.22002,0.0292447,-0.432747,-0.0306854,-0.462913,-0.521359,-0.223341,-0.0892656,-0.258372,-0.293487,0.358341,0.0927877,-0.0843986,0.594143,-0.601986,-0.727572,-0.215756,-0.175751,0.21419,0.201372,0.498036,0.59851,0.431288,-0.349252,0.0262518,-0.137127,-0.601199,0.384258,-0.600913,0.140255,0.416684,0.169188,0.065613,-0.172726,0.412007,0.229172,0.796416,0.19749,0.307395,-0.0553371,0.489167,-0.0731888,0.312286,-0.0613459,0.242901,-0.210463,-0.241657,-0.193133,0.00170421,-0.220601,0.0945316,-0.226168,0.275266,-0.00903288,-0.692483,-0.406152,-0.0908144,-0.395048,0.160066,0.0217622,0.235546,0.0806021,-0.248871,-0.180017,-0.123137,-0.0892879,0.0703937,-0.208582,-0.188221,-0.14352,-0.924289,-0.090093,0.0247532,-0.0598318,-0.444313,-0.349667,0.120665,0.259078,0.347369,0.508997,-1.92819 +3428.14,0.699253,0.0912059,5,1.62896,1.05891,-0.384294,0.264778,0.412065,-0.119066,0.372357,0.0261456,0.670621,0.789449,-0.236324,0.0755759,0.240626,0.140879,0.386886,1.17189,0.366114,-0.00311647,0.0361174,0.24628,-0.177491,-0.843716,0.0701732,0.000151556,-0.259277,-0.0502647,-0.0546743,0.452939,-0.00463447,0.0755975,0.951786,-0.601627,0.438537,-0.111846,-0.448833,-0.433109,-0.178804,0.34394,0.0527135,-0.432413,0.676098,0.448942,0.100089,-0.922787,-0.354835,-0.160267,-1.44425,0.125846,0.0418856,-0.324215,-0.120623,0.116657,-0.0444396,0.18932,0.405692,-0.563537,-0.0528653,-0.766572,0.153408,-0.509884,0.315902,0.825217,-0.258411,-1.33393,0.0273227,0.180867,0.0876362,-0.470097,-0.293271,-0.267423,0.273182,0.402456,0.696515,-0.364331,0.451621,0.532135,0.265127,0.0822267,-0.065686,-0.113432,0.20309,-0.0809311,0.384165,-0.07916,-0.194858,0.491535,0.00472634,0.451457,0.248155,-0.495634,-0.302479,-0.309725,-0.00447138,0.0271717,0.0789591,-0.341743,-0.232244,0.253078,-0.00087764,0.324229,-0.426027,-0.278909,-0.154166,0.275437,0.422318,-0.68568,0.0623306,-0.411487,0.578139,0.399538,0.198355,-0.157204,-0.0914683,-0.00802577,0.550288,-0.253604,-0.211618,-0.239386,-0.197306,-0.487078,-0.859009,-0.403268,-0.394746,0.395037,-0.258462,-0.0351082,0.00575958,0.301944,0.117922,-1.06261,0.39149,0.409876,0.130774,0.600793,-0.303413,0.205594,-0.412747,-0.121599,0.277847,-0.218102,-0.49848,0.0589169,0.294104,-0.212128,-0.0314433,0.504206,0.106217,0.393874,-0.474746,0.123798,-0.73328,-0.109005,-0.255294,-0.202055,0.15288,0.159321,-0.12554,0.33697,0.498209,-0.262504,0.00309431,-0.177451,0.452415,0.382231,0.293417,0.0295617,-0.0945961,-0.0278295,0.338843,-0.0290351,0.31341,-0.419991,-0.464439,-0.0133161,-0.496846,-0.865321,-0.53201,-0.202113,-0.184592,0.806093,0.51713,0.692986,0.371098,0.310613,0.128182,-0.716228,-0.142972,0.094912,0.0446288,-0.39307,0.239242,-0.313214,-0.0385194,-0.626236,0.1277,0.0356821,-0.120193,-0.728495,-0.937718,0.0326342,0.0607834,-0.834941,0.391468,-0.148954,0.365862,-0.10722,-0.509298,0.744218,0.578562,-0.260512,0.341176,-0.160701,0.173959,0.320338,0.254411,0.378784,-0.0474435,0.283088,-0.0221095,-0.473366,-0.0943377,-0.163107,0.221057,0.748375,-0.299303,0.596155,-0.0480612,-0.783576,0.258879,0.289587,-0.623304,-0.369835,-0.0922073,-0.0902391,-0.279997,0.496939,-0.203299,0.203327,0.481396,-0.0403976,-0.301702,-0.35223,-0.270766,0.209836,0.81488,0.47109,0.445819,-0.327624,-0.327385,0.0693142,-0.310427,-0.414742,0.350526,-0.294253,0.0620508,0.014831,-0.541357,-0.0597717,-0.0925617,0.373315,0.101209,0.481169,0.598803,0.30575,0.391591,0.142435,-0.294591,0.242301,0.18146,0.0756228,-0.0649435,-0.41155,-0.0354973,0.158096,-0.227684,-0.097475,-0.184491,0.0368419,0.00355917,-0.32496,-0.440983,-0.107221,-0.303177,-0.360806,0.187236,0.493064,0.156149,-0.41188,-0.236517,-0.0634551,-0.437229,0.498043,-0.19951,0.0943764,-0.19691,-0.795781,0.133612,-0.464059,-0.308182,-0.261386,-0.523206,0.13653,0.253152,0.369499,0.503142,-1.63053 +3428.24,0.965867,0.0912059,4,1.58529,1.04223,-0.530558,0.266941,0.651295,-0.128192,0.311916,-0.204596,0.628294,0.0291183,0.0632168,0.136681,-0.279618,0.265495,0.0620838,0.645261,-0.0463365,-0.032519,0.251987,-0.123538,-0.268306,-0.555302,-0.168671,-0.0796661,-0.0666858,-0.215664,0.311978,-0.0522818,-0.633769,0.173461,1.02752,-0.522345,0.481512,0.601432,-0.93435,-0.158012,-0.405642,0.583794,0.34797,-0.644088,0.784034,0.263263,0.178031,-0.880931,-0.348459,-0.0672142,-0.680641,0.204818,0.141946,-0.659941,-0.230779,0.130644,0.122034,-0.212278,0.591769,-0.368901,-0.188994,-0.310745,0.544985,0.0894948,0.476509,0.973836,-0.906431,-0.763817,0.171704,0.18264,-0.237102,-0.433141,0.349475,-0.369525,0.133363,0.216974,0.873848,-0.510008,0.222124,0.259621,0.103902,-0.0770195,0.0278834,-0.141236,0.584803,-0.318137,0.298984,0.267557,0.440329,0.192485,0.491534,0.245061,0.00652453,-0.459677,0.0941637,-0.439089,0.14328,0.153608,0.175402,-1.26008,0.212318,0.00571078,-0.0688084,0.063715,0.220101,0.170977,-0.649855,-0.124368,-0.00853704,-0.000106732,0.0868647,0.015313,0.107182,0.325515,-0.107302,-0.886803,0.197314,0.0887119,0.334407,0.136006,-0.676345,-0.331038,-0.391303,-0.609195,-0.746082,-0.211221,-0.0308583,-0.283768,0.11804,0.700585,-0.355514,-0.364562,0.375712,-0.138357,0.416199,0.00848569,-0.140125,0.264736,0.0440789,0.125712,-0.290411,0.140457,0.396603,-0.34942,-0.688476,0.140869,-0.1181,-0.111062,-0.0637876,-0.156854,0.23464,0.333406,-0.0786378,0.219921,-0.319458,-0.177483,0.280574,-0.000795196,0.202096,0.46993,0.473565,0.29956,-0.0441639,-0.304463,0.634396,0.372696,0.672726,-0.526984,-0.432801,0.373243,0.0862749,0.302906,-0.342377,-0.448175,0.328967,-0.386343,-0.264851,0.0596977,-0.0493271,0.0672564,-0.479841,-0.514763,-0.470574,0.25805,0.115775,0.50171,-0.000203138,0.0606959,0.452531,-0.189968,0.35569,-0.693359,-0.141776,0.258281,0.394742,0.104225,0.499296,-0.23648,0.152058,0.225828,-0.424,0.137802,-0.86003,-0.169737,0.0497482,-0.677686,0.786099,-0.221175,0.178926,0.0868854,-0.0322962,0.649386,0.0108288,0.410569,-0.292004,0.237268,-0.0777668,0.447789,0.0740869,0.21552,-0.0243088,0.00547662,0.342671,-0.428261,0.201988,-0.556198,0.00707631,0.439041,-0.419044,0.523214,-0.26187,-0.190518,-0.159788,-0.501176,-0.0175482,-0.213083,-0.273739,-0.174422,-0.229324,0.0717641,0.0428536,-0.0660756,0.403318,-0.386332,-0.0114603,-0.72443,-0.0507664,0.170968,0.28198,-0.0293941,0.45594,0.174645,0.129517,-0.222759,-0.323145,0.452,0.437299,-0.136434,-0.306541,0.391065,-0.17093,0.347872,-0.313868,0.278578,0.793286,0.286059,-0.0602382,0.498654,-0.0472888,0.221834,-0.113995,-0.0380336,0.440263,0.259791,-0.0890191,-0.318656,-0.570325,-0.0690875,-0.0828615,0.187726,0.208555,-0.330209,0.160196,-0.0453243,0.137955,0.116719,0.0042728,0.470068,-0.0435419,0.804593,-0.00363809,0.607432,-0.153811,-0.535445,-0.118528,0.269581,-0.21194,0.0761072,-0.233909,-0.430228,0.241397,-0.920584,0.0979459,-0.187196,0.0678295,0.116684,0.237267,0.34159,0.4871,-2.36183 +3426.61,0.916103,0.0912059,4,1.56864,1.01696,-0.591027,0.30689,0.535488,-0.147534,0.080338,-0.331392,0.773427,0.0723788,-0.131079,0.148625,-0.335576,0.175549,0.072119,0.84246,-0.0478587,0.0453875,0.236432,-0.279623,-0.144496,-0.476009,-0.210152,-0.00165018,-0.156883,-0.158238,0.305252,0.177049,-0.853312,0.0700982,1.05943,-0.606762,0.390884,0.493958,-0.658829,-0.0871593,-0.34485,0.32526,0.429617,-0.654287,0.874626,0.580548,-0.011513,-0.74479,-0.446164,-0.389519,-0.721398,0.172857,0.0397026,-0.450363,-0.187358,0.0856992,0.195787,0.19152,0.497023,-0.320811,-0.287484,-0.542071,0.561639,-0.0768477,0.641565,0.834199,-0.759034,-0.604107,0.0123036,-0.0491755,0.142059,-0.377075,0.476874,-0.1784,0.406931,0.266964,0.744032,-0.308514,-0.00244213,0.265549,0.04189,-0.150862,0.0279671,-0.149982,0.523039,-0.0638523,0.256281,0.228747,0.347508,0.123977,0.594673,0.332634,-0.246004,-0.480292,0.0133561,0.00995972,0.0322771,0.18893,-0.111218,-0.899841,0.51111,0.0120321,-0.0506811,0.174923,0.0335042,-0.0456202,-0.66389,-0.351803,0.0670799,0.142565,-0.0844911,-0.149732,-0.136788,0.331488,-0.158653,-0.83961,0.0382329,0.0783174,0.259905,0.257575,-0.294165,-0.126865,-0.247202,-0.443747,-0.881606,0.0274594,-0.027628,-0.415497,-0.0503701,0.728198,-0.343217,-0.103789,0.499787,-0.345079,0.381694,0.0601536,-0.431557,0.403723,0.00511768,0.117798,-0.553678,0.216189,0.358449,-0.539797,-0.71318,0.168014,0.0231682,0.0563663,0.224999,-0.134417,0.167057,0.291539,-0.15514,0.295286,-0.36451,0.00870297,0.180477,-0.0543898,-0.0185422,0.373411,0.488659,0.440127,0.00100561,-0.717434,0.346558,0.564233,0.755327,-0.729292,-0.436538,0.355668,0.0707147,0.0880398,-0.170337,-0.22122,0.444625,-0.238248,-0.191146,0.0215276,-0.147915,0.0421174,-0.710822,-0.336135,-0.0487775,0.4277,0.0408311,0.550923,0.085683,-0.0420872,0.236286,-0.200762,0.421209,-0.881393,-0.194237,-0.168626,0.243728,-0.00446286,0.442531,-0.0466423,0.191315,0.198617,-0.138002,0.0732116,-0.819625,0.0316357,0.166873,-0.674376,0.732501,-0.261387,0.131761,0.357299,-0.164288,0.554931,0.112353,0.316919,-0.129547,0.320326,-0.0395236,0.465909,-0.0351657,0.407873,-0.321612,0.00831498,0.36508,-0.428026,-0.159002,-0.513202,0.0857599,0.173271,-0.475666,0.556172,-0.253135,-0.0133259,-0.133645,-0.291822,0.142244,-0.0566166,-0.0179687,-0.397692,-0.171754,0.183451,0.13088,-0.0993511,0.431302,-0.635038,-0.4526,-0.480525,0.183157,-0.0584763,0.193217,0.0250004,0.650355,0.16705,0.0648978,-0.227472,-0.654864,0.290884,0.454098,-0.0718806,-0.18581,0.40747,-0.309155,0.338545,-0.458809,0.348202,0.964859,0.23492,-0.161636,0.495942,-0.100277,0.167924,-0.129763,0.0181169,0.440531,0.36167,-0.09981,-0.29388,-0.384072,-0.260013,0.118459,0.131973,0.25378,-0.291426,-0.0179653,0.0922956,-0.173433,-0.304574,-0.151294,0.341563,-0.203936,0.864843,0.0850365,0.792319,0.0358308,-0.284615,-0.225328,0.286132,-0.0643263,0.511288,-0.319351,-0.285563,0.0370642,-0.945132,-0.190251,-0.273061,0.422989,0.115714,0.208385,0.340168,0.456492,-1.95062 +3418.87,0.957876,0.0912059,5,1.67474,0.773708,-1.08091,0.522845,0.639718,-0.118906,-0.135365,0.10726,0.176698,0.079782,0.230214,-0.552939,-0.0149215,0.2689,0.160043,0.582809,0.0660432,-0.0739623,-0.093316,0.0163797,-0.364096,-0.957392,-0.71999,0.428146,-0.533323,-0.255551,-0.414697,0.657207,-0.101066,0.232258,0.664675,-0.410421,-0.275246,0.233064,-0.235546,-0.400605,-0.62551,0.369887,0.0224934,-0.437913,0.484449,0.262965,0.378584,-0.926715,-0.287498,0.633234,-0.530499,-0.03138,0.0289655,0.0854879,0.0427126,-0.450265,-0.120702,-0.869394,0.455425,-0.2254,-0.321379,-1.34718,0.449876,-0.774543,-0.308557,0.928938,-0.263006,-1.20638,0.0119278,0.378858,0.466677,0.221799,-0.0540302,-0.293119,-0.0315957,-0.587151,0.622155,-0.125658,0.915045,0.744781,0.187385,0.39594,-0.405685,0.659967,0.309706,-0.147424,0.176476,0.2491,0.484019,0.232947,-0.4306,0.477964,0.191722,-0.150258,0.431516,0.15903,-0.145938,-0.167525,0.224965,-0.111931,-0.204382,-0.0707658,0.250678,0.622098,-0.540072,-0.0611587,-0.0942909,0.461185,-0.412017,-0.383861,0.481122,0.0486846,0.136926,0.364557,0.247014,0.410266,0.273063,0.216937,-0.138294,-0.34159,-0.352243,-0.114475,0.424903,0.240461,-0.246904,-0.0886226,0.253004,-0.445393,-0.0700122,-0.289512,0.619992,-0.0971839,0.0480679,-0.397106,-0.225531,-0.000464713,0.196048,0.383296,-0.270648,0.0101939,0.0762355,-0.346755,0.588437,-0.314436,-0.256483,-0.0432846,0.148324,-0.707024,0.234638,-0.0466919,0.236185,0.359505,-0.251957,0.223153,0.203945,0.351645,0.268275,-0.346514,0.144922,0.332335,0.285564,0.534599,-0.0778172,-0.0557622,0.417722,-0.236619,0.886193,0.0621396,0.267741,0.119809,-0.0335886,-0.424081,0.204676,0.15117,-0.19935,0.390883,-0.207608,-0.170502,0.220337,-0.457862,-0.365959,-0.233274,0.333303,0.641462,-0.291035,-0.283729,0.129731,0.242261,0.155406,-0.698599,-0.954554,0.151979,0.380673,-0.340518,0.0912295,-0.61686,-0.146463,-1.09365,0.340049,-0.179686,0.304479,0.0842062,-0.374038,-0.358059,-0.12977,-0.265706,-0.036372,-0.0135152,0.0800382,-0.749141,-0.761321,1.23471,-0.451513,-0.193755,0.160225,-0.0673785,-0.075107,-0.211705,-0.277658,0.0103739,0.0591828,0.35799,-0.0406784,-0.92782,0.328422,-0.343478,-0.331133,0.24904,-0.110126,0.635448,0.179019,-0.245231,1.01073,0.137959,-0.30446,-0.137939,-0.516071,0.312575,-0.270654,0.397029,-0.0419758,-0.10112,0.460811,-0.379246,0.867995,0.334655,0.49777,-0.196412,0.382049,0.124196,0.466185,0.49836,0.649193,-0.151061,-0.238823,-0.461535,0.129874,-0.0376719,-0.0271593,0.411464,0.269879,-0.377441,0.152923,0.0667214,-0.203785,0.537254,0.309814,-0.343724,0.228603,0.213095,0.159585,0.0862537,0.256123,-0.183071,-0.322134,-0.331545,-0.336339,0.562245,0.390598,-0.26564,0.124248,0.444267,0.366998,0.414261,0.148747,0.122079,-0.174472,-0.874041,0.440492,-0.0416013,-0.719014,0.0456483,0.045728,-0.437973,-0.0190689,-0.313591,0.304645,0.108632,-0.381118,-0.208148,-0.251945,0.0428394,0.169775,-0.11334,-0.271675,0.142997,0.194383,0.37815,0.440889,-1.71506 +3412.32,0.785636,0.0912059,5,1.63553,0.829972,-0.987138,0.496225,0.64655,-0.0437422,-0.171002,-0.138547,0.201192,0.56732,0.035007,0.0856045,-0.290807,0.163026,-0.228853,0.397407,0.345879,-0.0420404,0.392635,-0.163186,-0.45126,-0.336747,-0.475464,0.494049,-0.252455,-0.10838,0.32873,0.565381,-0.452834,-0.0519161,0.724159,-0.376768,-0.247155,0.0865292,-0.357406,-0.225522,-0.40894,-0.122075,0.570499,-0.760495,0.782936,0.346339,0.114755,-0.606385,-0.447162,0.172367,-0.480411,-0.106047,-0.242355,0.0244345,-0.0659504,0.299262,-0.166986,-0.0148421,0.345147,-0.124756,-0.399707,-0.264159,0.180716,-0.24885,0.236168,0.708607,-0.610544,-1.06598,-0.0800179,-0.259995,0.247318,0.0392044,0.105124,-0.0813018,-0.00324238,0.397811,0.574783,-0.663393,0.589583,0.228211,0.638702,-0.305727,0.0322872,0.44654,0.759651,-0.135059,-0.0704656,-0.0420046,-0.0845581,-0.142835,-0.236086,-0.412641,0.0295954,-0.564322,-0.205954,0.534056,0.313836,-0.00964703,0.230825,0.0732754,0.0120831,0.192022,-0.0308476,0.410608,0.312649,-0.188504,-0.484218,-0.238111,0.00449787,0.0175372,0.946559,-0.0782602,0.202069,0.362764,-0.648126,0.116859,0.409205,0.332601,0.0582531,-0.104387,-0.53535,0.125731,0.44455,0.0749631,-0.811174,0.0106692,0.0717155,-0.0748495,-0.0444401,0.137098,0.247339,-0.315773,0.223327,-0.106862,-0.224819,0.42938,-0.00771649,0.0953606,-0.494192,-0.0529703,-0.343977,0.465681,0.848286,-0.511629,0.0261511,0.257166,0.696693,-0.669791,0.0852688,-0.245373,0.379458,-0.165587,0.183878,-0.0385455,-0.528625,0.728665,-0.101962,-0.244136,-0.177506,0.854988,0.227377,0.0517785,-0.118945,-0.437782,0.270073,-0.069947,0.96048,-0.383984,0.285142,0.788761,0.217327,0.301714,0.0116893,0.254276,-0.23479,-0.348437,-0.0635622,-0.498536,0.122684,-0.611666,-0.17685,-0.370321,0.458229,0.671258,0.00678904,-0.530856,0.556164,0.0428804,0.458908,-0.121842,-0.116207,-0.149278,-0.108157,-0.708871,0.440892,-0.495996,-0.0134709,0.0812247,0.127518,0.0980489,-0.0523271,-0.0561422,-0.186261,-0.299852,-0.0272587,-0.0153003,0.39527,0.0615342,-0.261139,-0.243388,-1.03662,1.125,-0.283238,-0.187482,0.29473,-0.400018,-0.0214368,-0.503666,-0.0484488,-0.291811,-0.239748,-0.231566,0.0914838,-0.908885,0.221793,-0.914178,0.139805,-0.433401,-0.289286,0.853709,0.0271115,-0.394692,1.00301,0.306928,0.0604851,-0.112678,-0.0192732,-0.0886703,-0.0272864,0.559177,-0.496721,0.21061,0.161341,-0.616452,0.633372,0.470598,0.103004,0.229988,0.293193,0.252619,0.393081,0.25922,-0.100144,-0.279925,-0.422843,0.0619965,0.496453,-0.317693,0.119542,0.516871,0.251032,-0.449364,0.0827437,-0.215326,0.265077,0.753348,0.474055,0.0338282,0.386824,-0.225227,0.00361796,-0.440952,-0.0361053,0.137592,0.0408183,-0.0314843,0.167925,0.416714,-0.0140832,0.335931,0.619115,0.048718,0.067719,-0.331326,0.12957,-0.60276,-0.543923,0.147708,-0.148131,-0.147488,-0.272904,0.703387,-0.139327,-0.312692,-0.247807,-0.0651552,0.41163,-0.126678,-0.256266,-0.209062,-0.242637,-0.143552,-0.207019,0.105295,0.0672348,0.130796,0.139449,0.361657,0.373428,-1.91923 +3418.79,0.904326,0.0912059,5,1.6244,0.739158,-1.49601,0.669365,0.463087,-0.0509325,-0.142439,-0.139347,0.23033,0.570893,0.148035,-0.248835,0.114813,0.240919,-0.207486,0.943158,-0.0145977,0.0453772,0.0223059,-0.33718,-0.63113,-0.442557,-0.872721,0.299264,0.0228742,-0.105742,-0.0535065,0.435553,-0.211372,0.0884512,0.735158,-0.120266,-0.331554,0.222577,-0.507203,-0.257909,-0.346824,0.194758,0.193787,-0.4585,0.650858,0.622362,0.268077,-0.934091,-0.399927,0.114562,-0.643198,0.187492,0.192868,-0.0957749,-0.0528536,0.111701,-0.105471,-0.118329,0.614306,-0.219866,-0.376097,-0.449961,0.15024,0.0440837,-0.127041,0.947731,-0.35058,-1.05147,-0.227089,-0.326612,-0.0496342,0.0802495,-0.112921,-0.390605,0.112873,-0.109814,0.7878,0.101823,0.604233,0.372058,0.45147,-0.173445,-0.398144,0.360457,0.43775,-0.00594962,0.22138,0.300891,-0.232258,0.0453938,-0.462571,-0.299599,0.386399,-0.257722,-0.415798,0.501618,0.611238,0.0744191,-0.150098,0.432616,0.0802125,0.360325,0.300085,0.637239,0.3002,-0.660632,-0.273273,-0.0987443,0.0475153,-0.382181,0.532544,-0.018865,-0.27392,0.151788,-0.477838,-0.480765,-0.00444003,0.0731822,-0.0244479,-0.0384173,-0.385382,0.0204044,0.237143,-0.0622332,-0.547984,-0.0450759,-0.355024,-0.324343,-0.245322,-0.192292,0.344145,-0.429267,0.460718,-0.207395,-0.513182,0.263532,0.407241,0.376152,-0.657807,-0.0273781,-0.300201,0.245464,0.943075,-0.484105,-0.0430461,0.057849,0.499713,-0.53228,0.226656,-0.17147,0.497315,0.0971302,0.0783339,-0.517258,0.0510725,0.253197,0.093211,-0.0798661,0.00611007,0.126443,0.109057,-0.194321,-0.224019,-0.018475,0.55905,0.267406,1.00317,0.269149,-0.07162,0.709461,0.115019,0.115665,-0.00903872,-0.0559463,0.0932759,-0.10479,-0.369423,-0.023506,-0.251672,-0.467466,-0.514203,0.19388,0.0647484,0.515542,0.326487,-0.593477,0.171824,-0.0462594,0.121206,-0.0953804,-0.199167,-0.37932,-0.0693923,-0.69829,0.350331,0.0886233,-0.0925124,0.0210088,0.0684889,0.369753,-0.37503,-0.208183,-0.231445,-0.330899,-0.240532,-0.0479624,0.216079,-0.319323,-0.353485,-0.457255,-0.686546,1.08732,-0.262791,-0.186851,0.559944,-0.079373,-0.132672,-0.473226,-0.539442,-0.474177,-0.336239,0.251741,0.302287,-1.25045,-0.0862854,-0.651589,0.256535,0.110917,-0.333408,0.605288,0.0993536,-0.56841,0.380779,0.242177,0.028387,-0.174626,0.132075,0.483842,-0.213929,0.417201,-0.573415,0.167979,0.241613,-0.0719774,0.323146,0.605778,-0.0181646,0.173756,0.096927,-0.128126,0.639551,0.205409,0.145203,-0.129305,-0.507144,-0.117982,0.17133,-0.58602,-0.27665,0.68707,0.041504,-0.494462,0.481081,-0.0375818,-0.323688,0.813608,0.033196,0.367331,0.547832,-0.339157,0.111777,-0.187415,-0.571189,0.378147,0.178047,0.0816759,0.155449,0.149197,-0.0430525,0.502757,0.159681,0.256196,0.412724,-0.132293,-0.0640176,-0.484849,-0.530765,0.0870636,-0.0978581,-0.118414,-0.453645,0.814266,-0.0302482,-0.0852176,-0.357381,-0.634074,0.226494,-0.0256039,0.0911925,-0.0613798,-0.368253,0.147328,0.344331,-0.0779986,0.45043,0.143458,0.156047,0.378758,0.395028,-1.05579 +3408.63,0.977593,0.0912059,4,1.59245,0.749073,-1.40513,0.65044,0.602593,-0.0359562,-0.203237,-0.192564,0.138602,0.657755,0.142548,-0.163497,-0.119916,0.143385,-0.203678,0.922039,0.146003,-0.0521208,0.0540019,-0.257329,-0.466601,-0.630464,-0.697095,0.480993,0.136609,-0.206094,-0.28344,0.323979,-0.0114938,0.313064,0.56661,-0.512123,-0.37149,0.257443,-0.283962,-0.167727,-0.158518,0.495233,0.173381,-0.498514,0.579585,0.460182,0.475654,-1.03972,-0.15759,-0.0450548,-0.593363,0.115506,0.109215,-0.0280915,0.0795239,0.0846693,-0.121714,-0.331886,0.389506,-0.0996457,-0.435068,-0.309634,0.264012,0.0727468,-0.0599176,0.820414,-0.636145,-1.06799,-0.309775,-0.399882,-0.00457354,0.455428,-0.126915,-0.134534,-0.0524551,-0.0943848,0.775657,0.082397,0.676874,0.355145,0.541995,0.245694,-0.0363827,0.251953,0.270337,-0.238078,0.262057,-0.131365,-0.106128,-0.045753,-0.260589,-0.450396,0.6414,-0.25146,-0.175986,0.139589,0.452116,0.0426729,0.116317,0.358163,-0.0429715,0.223097,0.458263,0.490757,0.242278,-0.63862,-0.323259,-0.117339,-0.20315,-0.522781,0.550169,-0.0337898,-0.414337,0.151709,-0.391434,-0.370709,0.031111,0.174341,-0.265293,-0.33059,-0.395699,0.0986582,0.0933967,-0.144558,-0.682956,-0.0474896,-0.219969,-0.261701,-0.227696,-0.106168,0.450789,-0.483908,0.445299,-0.117178,-0.540111,0.277234,0.315669,0.275108,-0.629582,0.00455889,-0.566028,0.498557,0.999289,-0.570808,0.0815363,0.109023,0.303067,-0.563868,0.388413,0.0766516,0.357584,0.15063,0.0814898,-0.354998,-0.0408756,0.112821,0.0483633,-0.461454,0.0823106,0.227758,0.0229291,-0.0218425,-0.275116,0.157928,0.907837,0.510767,0.70814,0.00880302,-0.297291,0.511913,-0.211838,0.187981,0.0164758,-0.0911831,0.312721,-0.317453,-0.353651,-0.0565234,-0.138753,-0.201646,-0.709715,0.0298249,-0.185632,0.635442,0.456582,-0.549679,-0.165526,0.0819318,-0.105973,-0.111542,-0.116925,-0.277101,0.105945,-0.370268,0.543032,0.0608142,0.093777,-0.0770849,-0.191939,0.132463,-0.538785,-0.141823,-0.251155,-0.544296,-0.0962874,0.250433,0.312974,-0.00668295,-0.405489,-0.508519,-0.70286,0.871881,-0.258268,-0.237369,0.436765,-0.431061,0.0330152,-0.311259,-0.503322,-0.220739,-0.330808,0.346466,0.329461,-0.942721,0.0255059,-0.571624,0.129765,0.291637,-0.594139,0.572779,0.0572999,-0.484603,0.3845,-0.0767285,-0.0237669,-0.0475058,-0.0765157,0.631667,-0.276595,0.604001,-0.692181,0.310893,0.0396759,-0.254909,0.204788,0.59462,-0.0861593,0.341986,0.0434472,-0.133126,0.510791,-0.108413,0.0278607,-0.0586853,-0.132383,-0.0333256,0.191164,-0.508639,-0.525831,0.683511,0.0653242,-0.596915,0.452615,-0.0836105,-0.433187,0.808599,-0.136347,0.333179,0.460388,-0.172103,0.187213,-0.176531,-0.536179,0.225099,0.0704096,0.0602423,0.0183011,0.115563,-0.0506239,0.622126,0.0671798,0.144183,0.39895,-0.15316,-0.0332308,-0.316641,-0.745454,0.0297904,-0.0200352,-0.153179,-0.359531,0.835406,0.166719,0.090445,-0.185172,-0.390013,0.491206,0.156394,0.154227,0.103077,-0.463428,-0.0043396,0.670701,-0.126156,0.488064,0.121886,0.143192,0.349122,0.378408,-1.60194 +3425.51,0.891224,0.0912059,4,1.58785,0.941058,-1.0581,0.376085,0.327698,-0.237654,0.393168,0.266939,0.401503,-0.105463,0.0300226,-0.318593,-0.116428,0.325858,-0.0381858,0.653671,-0.0465595,0.0800135,-0.114106,-0.598795,-0.521891,-0.807114,-0.577376,0.200482,-0.721546,-0.0519937,0.253904,-0.273232,-0.494294,-0.192502,0.537849,-0.31434,0.288124,-0.110323,-0.301998,-0.313838,-0.215738,0.27885,0.157243,-0.520865,0.610117,0.613234,-0.0774316,-0.591031,-0.254629,0.246667,-0.171611,-0.134219,0.364902,0.0235998,0.0960222,0.604849,0.147999,-0.11669,0.489063,-0.255203,-0.205201,-0.88731,0.0995486,-0.239264,0.29618,0.707875,-0.877729,-0.483971,0.429464,0.650289,0.0973084,-0.556139,0.215904,-0.807171,-0.0359158,0.488483,0.706298,-0.477746,0.458062,0.5202,-0.278488,-0.300039,0.116077,0.290087,0.401307,-0.265934,-0.0203305,-0.103083,-0.0216675,-0.0235105,0.471906,-0.054231,-0.674126,-0.257205,0.020011,-0.240469,0.0475812,-0.373157,-0.174842,-0.828795,0.445518,-0.4319,-0.234126,0.208012,0.0512059,0.596085,-0.411137,-0.057366,0.422921,-0.0962405,0.118961,-0.35387,0.494475,0.479405,0.546833,0.0846532,0.180833,0.195039,0.431824,0.583554,0.0213788,0.26752,0.140975,-0.27406,-0.372902,0.244056,0.0845621,0.123923,-0.222416,0.170922,0.0611513,0.39753,-0.319029,-0.33302,0.631845,0.040477,-0.299348,0.79347,0.286798,-0.365236,0.486947,-0.083716,0.223635,-0.237992,-0.591054,-0.214582,-0.0924415,-0.529079,-0.348889,0.303656,-0.273892,0.459681,-0.215787,-0.194627,-0.601036,0.543692,-0.0162311,0.319285,-0.0719051,0.430938,0.596924,0.361813,0.516921,0.00115357,-0.324924,-0.554154,0.740813,0.0722919,0.221865,-0.0268185,0.128896,-0.726604,-0.581742,0.0273019,0.0784591,0.231701,-0.274498,-0.0868631,0.122644,-0.118118,0.285119,-0.369073,0.295545,0.682493,-0.489009,0.33435,0.588788,-0.187716,0.109041,-0.385887,-0.37121,-0.352501,0.315752,-0.352521,-0.121332,0.179783,-0.00141057,-0.870875,-0.0156273,0.241983,1.12412,0.140287,-0.831632,0.347322,-0.080529,-0.493954,0.0212778,-0.09637,0.601852,0.285142,-0.209607,1.03077,0.395062,0.0994916,0.0338991,-0.0053134,0.0222767,0.340938,0.421137,0.865073,0.297051,0.120744,0.275774,0.406793,-0.179381,-0.403857,-0.192499,-0.318611,0.110716,0.188066,-0.761819,-0.202599,-0.293751,0.119302,-0.274475,-0.152723,-0.134676,-0.419,-0.575548,0.495554,0.478093,-0.293889,0.835368,0.0597522,-0.389553,-0.450575,0.145646,-0.330733,0.405911,0.170315,-0.00747238,0.715634,-0.0320704,-0.124154,0.221609,-0.636389,0.535536,-0.00932414,0.047018,0.285955,-0.137242,0.640791,-0.183532,0.116971,0.587552,-0.208075,0.410178,0.119776,0.0353203,0.386559,-0.0891408,-0.058119,-0.0940396,0.272948,-0.577148,-0.458442,-0.391024,0.409493,0.160756,-0.257008,0.263546,-0.0304338,0.201124,0.256106,0.00782922,-0.122269,0.136666,0.100826,0.147604,0.202975,-0.141793,-0.318586,-0.0154249,-0.601205,0.080017,0.482823,-0.0103502,-0.0166271,-0.0103798,-0.936883,0.268624,-0.102405,-0.675124,0.0774384,-0.434416,0.140282,0.19289,0.374542,0.439193,-0.905092 +3419.89,0.939465,0.0912059,4,1.64041,0.917579,-1.19742,0.437074,0.0215148,-0.0722098,-0.0205782,-0.271318,0.0665103,0.407636,-0.0185221,-0.270524,-0.287438,0.32826,-0.08869,0.561129,0.261162,-0.0322041,0.0251562,-0.550538,-0.279644,-1.01065,-0.649203,0.157122,0.161115,0.0542674,-0.0579248,-0.013234,-0.267682,-0.136577,0.751997,-0.116229,-0.526391,-0.282987,-0.277661,-0.144333,-0.316606,0.699687,-0.1476,-0.446043,0.949565,0.807697,0.335188,-0.80167,-0.247194,0.111815,-0.873406,0.105438,0.121903,-0.19291,0.333323,0.414934,-0.151023,-0.459394,0.250224,-0.673581,-0.459981,-0.55583,-0.0680089,0.281286,-0.265836,0.699507,-0.279351,-0.616158,-0.107897,-0.399376,0.0775807,0.0534219,-0.0388247,-0.318372,-0.0441712,0.45255,0.39354,-0.454381,0.0215332,0.304982,0.155106,-0.2309,0.706819,-0.117501,0.404648,-0.944711,0.0782931,-0.461521,-0.410441,-0.650762,0.121872,-0.189468,0.393697,-0.631548,-0.0713157,0.319258,0.237113,-0.390541,0.442307,0.0236073,-0.0544817,0.280788,-0.352653,0.225378,0.335008,-0.0518728,-0.305089,-0.357067,0.255007,-0.15472,0.890282,0.0986189,0.513965,0.136787,0.014017,-0.379854,-0.232,0.38199,0.88278,0.0788405,-0.164847,0.407368,-0.0640735,-0.207319,-0.0242728,0.153142,-0.271152,0.133486,-0.526537,0.372478,-0.019587,0.232956,0.472873,-0.116633,0.464454,0.125223,-0.315695,0.62862,-0.403253,-0.328581,-0.727843,0.108116,0.276931,-0.422686,-0.00809295,0.13885,-0.30444,-0.30719,-0.644762,0.793319,-0.0282392,0.545618,0.134434,0.417916,0.049383,0.433883,-0.0326954,-0.352551,0.573419,0.488088,-0.202765,0.289873,0.169419,-0.40533,0.63194,-0.33671,0.313309,0.12204,0.131318,0.336979,-0.694489,-0.5671,0.14299,-0.155237,-0.00686606,0.00469718,0.0432315,0.385839,-0.0498219,0.0430175,0.126765,-0.388036,0.340919,0.888028,-0.795507,0.112611,0.339784,-0.138971,0.237018,-0.100982,0.0411332,-0.361425,0.278766,-0.487957,0.132851,-0.267433,0.0554222,-0.716484,-0.300097,-0.523331,0.565559,-0.311196,-0.631115,-0.327231,0.00257081,-0.121055,-0.533432,0.0684193,-0.138804,0.0551935,0.0659556,0.760574,0.183981,0.112255,0.102794,-0.723098,0.110189,-0.508025,-0.42022,0.653485,0.0805493,0.22399,-0.179514,-0.0970134,0.159006,-0.566037,-0.0817224,0.42066,-0.766343,0.445778,-0.784152,-0.20049,0.216796,0.0128493,-0.324309,0.0184117,0.211664,-0.536946,-0.258007,0.676078,-0.120601,0.849807,0.580509,-0.0900136,-0.00841778,0.198958,-0.50391,0.231975,0.149771,-0.366585,0.162614,0.100711,-0.596715,0.00484922,-0.0442518,-0.495676,0.249997,-0.504363,0.0423396,0.502469,-0.416323,0.31196,0.33029,-0.23307,0.152846,0.522376,-0.332671,0.394122,0.69406,0.122298,-0.101856,-0.621139,0.526079,0.337877,-0.516323,-0.174083,0.0822694,0.276894,-0.170842,-0.367143,-0.118869,-0.108273,0.190991,-0.069933,0.185071,-0.519588,0.0751276,0.0163741,0.482379,0.416256,-0.280952,0.364374,0.196073,-0.0402954,-0.0692257,0.793233,0.292862,0.583709,-0.0349184,-1.34262,0.0654038,-0.43703,-0.151694,-0.319487,-0.0230709,0.149011,0.132104,0.386019,0.363461,0.179435 +3421.47,0.762912,0.0912059,5,1.64612,0.897578,-1.01763,0.371616,0.0269757,-0.0834104,0.267634,-0.0193261,-0.0691506,0.381354,0.109393,-0.281899,0.19161,0.123907,0.177535,1.08248,-0.0345293,0.122095,-0.382205,-0.605187,-0.22895,-0.753906,-0.194525,0.179078,-0.273712,-0.145242,0.129115,0.194808,-0.259802,-0.479266,0.625052,-0.505471,-0.689682,-0.22435,-0.280585,-0.118346,-0.43411,0.595251,0.240924,-0.649821,0.785217,0.757626,0.38639,-0.68929,-0.0756605,-0.169004,-0.747715,-0.387345,0.399329,-0.287009,0.142575,0.503271,-0.0521844,-0.144285,0.469633,-0.583449,-0.304149,-0.5546,-0.0623597,0.160221,0.102579,0.522759,-0.693627,-0.997734,-0.0174838,0.223369,-0.0666416,0.189917,-0.162538,-0.603637,-0.525283,-0.130075,0.795464,-0.134426,0.365696,0.260452,0.00762982,0.128025,0.347292,0.0413209,0.303738,-1.08327,0.187497,0.000808645,-0.313628,-0.440862,0.142072,-0.13296,0.632618,-0.268239,0.268647,-0.322599,0.450757,-0.0325699,0.202646,0.190401,-0.448722,-0.225491,0.279681,0.291386,0.194306,0.203775,-0.524292,-0.277406,-0.127856,-0.742553,0.510984,-0.138783,0.19867,0.324991,-0.154221,-0.0204249,0.134509,0.274372,0.473413,0.26115,0.360081,0.317653,-0.472722,0.272053,-0.311823,0.303607,0.216965,-0.00328775,-0.48747,0.375235,0.194828,0.148602,-0.440745,-0.187286,0.691472,0.153756,-0.0206615,0.495309,0.251711,-0.033609,-0.432698,0.0402876,0.278043,-0.756336,-0.192776,-0.00841817,-0.414865,-0.288865,-0.290588,0.120794,-0.115185,0.364729,-0.379795,0.204627,0.309206,0.681919,0.299952,0.2231,0.0884099,0.502333,0.364352,0.037637,0.228635,-0.605027,0.358572,-0.443923,0.611968,-0.17169,-0.502266,0.221989,-0.104325,0.0999013,-0.383595,0.190583,0.234301,0.569307,-0.195908,0.0359006,-0.217449,0.203948,-0.0914527,-0.239813,0.423198,1.18445,-0.54302,0.111057,0.265612,-0.410898,0.409258,-0.379332,-0.0973577,-0.273316,0.592335,-0.231931,0.238966,-0.174476,-0.473366,-0.236501,-0.124842,-0.3832,0.772571,-0.117014,-0.648279,-0.013417,-0.169189,-0.0952987,-0.501928,0.153788,0.000252348,-0.444398,-0.260313,1.0992,-0.153659,0.219667,0.152901,-0.184821,0.360165,-0.311232,-0.128402,0.739333,-0.173751,0.488307,0.410186,-0.145556,0.187661,0.00796413,0.227285,-0.0252977,-0.310009,0.448335,-0.728177,-0.14622,-0.252569,0.0726319,0.141937,-0.0263108,0.315355,-0.0647906,-0.658091,0.950733,0.0690019,0.377695,0.600805,-0.0976902,-0.0242406,0.443004,0.382229,-0.781242,0.0736238,-0.266782,-0.200592,-0.0417203,-0.519513,0.0336023,-0.613374,-1.14019,0.500434,-0.837845,-0.111609,0.338527,-0.298404,0.54051,0.411334,-0.185209,0.0599552,0.39165,-0.1894,0.306191,0.523366,0.239952,-0.0728108,-0.0955717,0.774968,0.183057,-0.503588,-0.353079,-0.145164,-0.108647,0.00765573,0.156721,-0.104592,-0.173052,-0.286529,-0.443441,0.228404,-0.101349,-0.455803,-0.0480031,0.233231,0.659689,0.0899702,0.595797,0.418418,0.147286,0.0607117,0.575467,-0.157227,0.429862,0.151352,-0.977749,-0.228649,-0.368865,0.172479,-0.154712,-0.881555,0.14496,0.230242,0.380736,0.479835,0.172802 +3442.7,0.815595,0.0912059,4,1.56484,0.933006,-0.831817,0.297872,0.470513,0.0502715,0.343424,0.075263,-0.0328621,-0.110497,0.125293,-0.258238,-0.101236,0.274688,0.0616138,1.16557,-0.311501,0.422505,-0.232406,-0.0713413,-0.285789,-0.918944,-0.823205,0.0932124,-0.171391,-0.0498645,0.0393788,0.438625,-0.0931249,-0.16774,0.660993,-0.487092,-0.224408,-0.133711,-0.240468,-0.265022,-0.643969,0.569067,0.225872,0.0873824,0.921319,0.897624,0.447351,-0.134322,-0.376896,-0.66723,-0.387208,-0.00923411,0.216781,-0.163639,0.365781,0.632874,0.0206084,-0.10267,0.326555,-0.330413,-0.0543144,-0.484013,0.190982,-0.218864,0.0181842,0.80933,-0.480935,-0.423883,0.16493,0.0917203,-0.303625,0.097587,0.110041,-0.539639,-0.238349,-0.0902299,0.658793,0.0104522,0.275245,1.04864,-0.107113,0.0866001,-0.117302,0.385598,0.766816,-0.196896,0.236128,-0.234153,-0.475763,-0.0353737,-0.177393,0.0732502,0.578078,-0.258511,0.643169,0.114696,-0.100582,-0.136874,0.352088,0.0570247,-0.00638208,0.0389223,-0.0826692,0.402946,-0.269413,-0.184657,-0.809376,-0.362215,0.355692,-0.803828,0.0299806,-0.0737769,0.109957,0.206944,-0.151561,-0.239898,0.118079,0.710434,0.371025,0.03132,-0.48567,0.086184,-0.474845,0.385876,-0.17016,0.147216,-0.30812,0.29167,0.140007,0.102722,-0.0586639,0.721023,0.216346,0.00271039,0.510803,0.15187,-0.280767,0.220831,0.273984,-0.541737,0.0830407,-0.36777,-0.0104359,-0.528971,-0.276956,0.264037,0.491923,-0.518699,-0.453402,-0.164823,-0.0362625,0.660731,0.0125819,0.038681,-0.0464254,0.614839,-0.172515,-0.393993,0.0643119,0.528369,0.0284686,-0.126789,0.471216,-0.0857031,0.0433745,-0.0445448,0.887711,0.0393163,0.52726,0.40423,0.148058,0.0321657,-0.160404,-0.329647,0.0151132,0.138133,0.12758,0.0158389,-0.38366,-0.46519,-0.319596,-0.109786,0.24833,0.912034,-0.124919,-0.0546787,-0.195119,-0.102302,-0.192207,-0.430527,-0.386974,-0.357726,0.398669,-0.552087,0.430593,-0.0511879,-0.383201,-0.188082,-0.189686,-0.197173,0.351948,-0.0456489,-0.51892,-0.127996,-0.0550606,0.158243,-0.0947771,-0.602562,-0.21072,-0.29404,-0.104607,1.02642,0.0504453,0.264356,-0.135417,-0.379639,0.299273,0.183671,0.0140414,0.389333,-0.107283,-0.0517896,0.0814502,-0.207441,-0.151603,-0.321482,-0.154871,-0.333086,-0.433909,0.617089,0.115527,0.0593705,-0.181828,0.212479,0.0585498,0.143043,0.334424,-0.404644,0.204286,0.750581,-0.304818,-0.108141,0.867463,-0.467704,-0.35419,0.0854284,-0.225142,-0.226011,0.120027,0.293268,0.457421,-0.368106,0.428614,0.181574,-0.487937,-0.924215,0.839046,-0.363205,-0.133529,0.433657,-0.468724,0.0447558,0.396982,-0.143364,0.235381,0.161761,0.285468,0.648241,0.0407597,0.352255,-0.153321,0.200091,0.151209,0.413616,-0.246746,-0.340279,-0.508316,-0.491706,0.276365,-0.114666,0.320897,-0.271471,0.436276,-0.273204,-0.316965,0.0139709,-0.438498,-0.46624,0.00760703,0.411158,-0.562568,0.928321,0.257417,0.269795,0.0439714,-0.0729935,-0.134077,-0.0945803,0.137869,-0.981697,-0.167984,-0.36906,0.167258,0.250875,0.394147,0.133715,0.201124,0.36567,0.448468,-1.50468 +3419.19,0.877657,0.0912059,4,1.51177,0.899351,-1.14173,0.437736,0.674782,-0.164555,0.111035,0.214493,0.707113,0.216622,-0.0823501,-0.195282,-0.270148,0.120497,0.153499,1.14944,-0.511344,0.319752,-0.131111,-0.120967,-0.355452,-0.57496,-0.802676,0.274014,-0.388618,0.0665409,0.0656192,0.354867,-0.278462,-0.132887,0.918853,-0.173328,0.177894,0.311262,-0.351026,-0.198983,-0.176775,0.575623,0.427077,-0.306599,1.00491,0.903487,0.549296,-1.0488,-0.0536425,-0.685793,-0.621548,0.168539,0.169724,-0.112735,0.0496596,0.714814,0.373736,-0.654469,0.258232,-0.553378,0.0830067,-0.505634,0.401768,-0.350789,0.373237,0.852097,-0.283941,-0.232727,0.257019,0.00364071,-0.453303,0.0157548,-0.00243364,-0.398182,-0.152898,0.271741,0.928679,0.094069,0.430503,0.980832,0.227474,-0.0534386,-0.109406,0.151868,-0.429034,-0.010928,0.257158,-0.019087,0.0721369,-0.256355,0.285703,-0.14823,0.0649983,-0.452062,-0.0905181,-0.0941399,-0.131082,-0.00535394,0.693592,-0.301075,-0.437536,-0.022659,0.073462,0.265404,-0.208863,-0.238318,-0.192418,-0.735338,0.691022,0.275159,-0.171156,-0.155936,0.566333,0.514369,-0.128121,0.254069,0.176112,0.529379,0.363703,0.00136561,-1.02441,-0.072929,0.469699,0.00784237,-0.620552,-0.230994,-0.279033,0.0752686,0.0968059,0.572007,0.237209,0.493116,0.0747158,-0.909662,0.395953,0.397432,-0.216108,-0.0831179,0.340713,-0.749472,0.547481,-0.11926,0.518118,-0.291799,0.0167634,-0.295192,-0.123586,-0.738624,0.26933,-0.436458,0.209345,0.439597,-0.625172,-0.227301,-0.351609,0.342446,0.811907,-0.471007,0.396167,0.0605595,0.276069,0.128032,-0.185518,-0.243382,0.35523,0.07021,0.918835,-0.291741,0.094141,0.332812,0.103618,-0.283952,-0.33875,-0.396237,0.26939,0.0788782,0.210084,0.328558,0.132504,0.34625,0.211432,-0.635229,0.353172,0.590496,0.420464,-0.407491,0.332658,-0.30216,-0.619859,-0.532312,-0.334206,-0.180249,0.824655,-0.536239,0.320005,-0.0243082,-0.286515,0.201444,-0.351251,0.785919,0.260829,-0.12613,-0.514154,0.569912,-0.292635,-0.0336738,-0.162707,-0.0585263,0.129231,0.135439,-0.0102012,0.682133,-0.151255,0.286943,-0.0315596,-0.196812,0.281,0.823507,-0.833017,0.747406,0.0257939,0.304167,0.279196,-0.672354,0.45139,0.185503,0.0827438,0.341164,0.119967,0.690922,-0.152763,-0.0348139,0.355695,-0.0248305,-0.316347,0.419315,-0.190233,-0.0111943,-0.454398,0.530836,-0.248523,-0.465209,0.496027,-0.262632,0.0195547,0.584507,-0.155266,-0.136099,0.795824,0.0342894,0.228455,0.245886,0.308207,-0.362455,-0.0827243,-0.322366,0.931787,-0.586965,0.298652,0.269916,0.424258,-0.0197045,0.402201,-0.244903,0.10344,-0.231534,0.30494,0.0910631,-0.168736,0.466397,0.0294035,-0.135432,-0.120893,-0.00356866,-0.231934,-0.438595,-0.1321,-0.265576,-0.231285,-0.134395,-0.227471,0.29964,0.051775,-0.128218,-0.14321,-0.457523,-0.126958,-0.0785482,0.765487,0.366458,-0.161914,0.433582,-0.270709,0.27133,0.371848,0.859705,-0.0352299,0.232957,-0.403032,-0.121389,0.0748769,0.485025,-0.24694,-0.41484,-0.110837,0.148383,0.216282,0.385205,0.465061,-2.09248 +3403.86,0.736726,0.0912059,4,1.48867,1.09435,-0.835874,0.293205,0.431541,-0.14996,-0.35335,0.327084,0.823057,0.206119,0.150954,-0.406905,-0.266488,-0.117975,0.155403,1.18738,-0.454085,0.240924,-0.165199,-0.252161,-0.666447,-0.373376,-0.257001,0.177499,-0.0719402,-0.0575926,0.44215,0.551709,-0.405191,0.262343,0.761659,0.466211,0.23977,0.167747,-0.484089,-0.188795,-0.293619,0.379217,0.0969036,-0.283889,1.16453,0.78426,0.484192,-0.424552,-0.103352,-0.441866,-0.0727514,-0.451313,0.0707329,0.0333529,0.180334,0.61537,0.203436,-0.334995,0.135542,-0.342058,-0.298812,-0.779166,0.325376,-0.043778,-0.0318782,0.91283,-0.146014,-0.364315,-0.0156842,-0.0598362,-0.370805,0.314029,0.162169,-0.198364,0.148952,0.330655,0.838678,-0.282837,0.275393,0.92456,0.119488,-0.786342,0.13754,0.0142027,-0.186758,0.168479,0.120801,-0.0620516,-0.0868819,-0.290567,-0.100615,-0.40478,0.281258,-0.0824714,-0.426131,0.306341,0.028895,0.238611,0.361572,-0.488757,-0.254859,-0.105861,0.287695,0.233193,0.164352,-0.294567,-0.206772,-0.3269,0.58087,0.189757,0.145329,-0.222407,0.319396,0.61341,-0.555688,-0.0520084,0.590318,0.68537,-0.142043,0.352719,-0.677194,0.138027,0.161621,-0.473809,-0.345936,-0.330278,-0.453342,0.00439676,0.183017,0.56872,-0.0112681,0.456638,0.202877,-0.513207,0.0812885,0.254711,-0.374582,0.179255,-0.0849973,-0.773124,0.107521,-0.102225,0.704861,-0.428825,0.183251,-0.464138,0.201156,-0.63371,0.173738,-0.704001,-0.127378,0.205054,-0.628853,-0.264913,0.110152,0.083776,0.0172054,-0.132086,-0.15556,-0.0140508,0.285299,0.152635,-0.503033,-0.30622,0.311577,0.122017,0.637384,-0.459827,-0.17283,1.01658,0.197384,-0.300725,-0.159935,-0.492618,0.16626,-0.395302,0.194399,0.269824,-0.307141,-0.126827,-0.0258097,-0.54958,0.153882,1.01267,0.343403,-0.457002,0.467522,0.0844901,-0.638272,-0.078333,-0.304131,-0.471524,0.0916591,-0.233744,0.16198,-0.472166,-0.429374,0.0882947,-0.15492,0.426261,0.126347,-0.105413,-0.726177,0.771498,-0.313189,0.181124,0.0608534,-0.399171,-0.0817673,0.302104,0.171915,0.864253,0.00999266,-0.0821228,0.109457,0.170231,0.118112,0.961405,-0.260495,0.452871,-0.0345977,0.131179,0.064325,-0.621452,0.0154483,-0.127099,0.211204,0.376397,-0.260894,0.552854,-0.283604,0.0770116,0.889253,-0.358561,-0.387862,0.51741,-0.333506,0.134482,-0.305722,0.567096,-0.0375567,-0.18829,-0.00141354,-0.406725,0.209846,0.554267,-0.214518,-0.533877,0.314219,-0.256994,-0.0566704,0.354637,-0.169592,-0.315262,0.0822079,-0.605338,0.919785,-0.403297,0.0666641,0.578958,0.31335,0.0262241,0.181224,-0.0932266,0.140859,-0.101633,0.27987,0.157185,-0.130682,0.0394626,-0.186072,-0.00424725,-0.155351,0.246797,-0.204329,-0.295434,-0.145808,-0.360516,-0.140302,0.167416,0.0847058,0.399692,0.309646,-0.112302,-0.609186,-0.424724,-0.0573153,-0.184425,0.753667,0.182549,-0.23157,0.2779,0.184485,0.95769,0.104872,0.441458,-0.13278,0.289693,-0.463725,-0.355289,0.0293574,0.519081,-0.739915,-0.795543,-0.115778,0.14781,0.182251,0.38446,0.426909,-1.68011 +3399.94,1,0.0912059,5,1.61159,0.948181,-1.01214,0.261743,0.317529,-0.007658,0.15772,-0.596972,0.269008,-0.219746,-0.244566,-0.246091,-0.112302,0.434155,-0.251366,0.117657,0.0358456,-0.459909,0.183108,0.0999854,-0.278395,-0.851668,-0.626223,0.118114,-0.448808,-0.597583,-0.26154,-0.0851862,-0.455942,0.0590867,0.34602,-0.997184,-0.137735,0.136913,-0.0859874,-0.138953,-0.00588687,0.310208,0.230912,-0.358529,0.851141,0.223875,-0.127089,-0.118654,-0.154842,0.248631,-0.686366,0.853968,0.0367004,-0.152177,0.199298,-0.200896,0.0775598,-0.275269,0.704382,0.173406,-0.0340343,-0.701941,0.289229,-0.340107,-0.305722,0.595994,-1.09557,-1.2186,0.0871814,0.195968,0.129212,-0.189659,0.0828336,-0.512865,-0.203479,0.336369,0.239673,-0.00368143,0.902326,0.246662,0.367414,0.705735,-0.741885,0.372402,0.975003,-0.809446,-0.286604,-0.10855,-0.150615,0.378082,0.230981,-0.017214,-0.00643635,-0.213377,0.565735,-0.286122,0.0161775,-0.112472,-0.0626298,-0.0335736,0.394689,-0.385865,0.0350021,0.413929,-0.111128,0.388622,-0.527736,-0.0762205,-0.229347,-0.851311,0.257636,0.352141,0.3589,0.612186,0.600497,-0.0162816,-0.449575,0.322241,0.0939455,-0.578873,0.132102,0.111385,0.116412,0.3988,-0.591554,0.0268873,0.111576,0.0123514,-0.386598,-0.289165,0.51951,-0.153163,0.542028,-0.0782722,0.172879,-0.208155,0.267549,0.838533,0.31862,0.535245,-0.054473,-0.218218,0.0223902,-0.680649,-0.72555,-0.065339,0.0258305,-0.0667469,0.108722,0.905593,-0.0861902,0.627884,0.513963,0.10585,-0.517557,0.278765,0.257332,0.291831,0.64999,0.813071,0.108035,-0.12103,0.504989,0.247981,0.288059,-0.163385,0.684465,0.384448,0.13846,-0.785605,0.283367,0.230228,0.044494,0.487263,0.358733,0.369929,-0.162508,-0.45436,-0.0633195,0.025094,-0.223769,0.300125,-0.0390089,0.940805,-0.54301,0.195663,0.161008,-0.307346,0.632115,-0.627742,-0.0846619,0.0270111,0.299812,-0.358812,0.0202113,0.322039,0.444076,-0.52822,0.232828,0.0135354,-0.163749,-0.254554,-0.324359,-0.681032,0.00607309,-0.494771,0.14944,0.487712,0.167118,-0.492433,-0.944501,1.14305,0.113578,0.467865,0.0377439,-0.382118,0.0568117,-0.709358,0.0244625,0.0698467,-0.339816,0.150289,0.369941,0.209084,0.00972978,-0.63643,-0.160477,-0.0364813,-0.354932,0.883117,-0.0835689,-0.322272,-0.659955,0.501579,0.218312,0.172433,-0.0789011,-0.685257,-0.208978,0.48942,0.0254004,0.269589,1.17169,-0.39971,-0.5241,-0.0858255,-0.0406828,0.415908,0.322406,0.445682,0.611874,-0.279184,-0.0483395,-0.602884,-0.392925,-0.446548,0.295437,-0.191512,-0.423412,-0.287226,-0.830833,-0.187848,0.0145294,-0.308004,0.0316662,0.410995,-0.0737989,0.159069,0.189608,0.169426,0.133036,-0.190855,-0.0313403,-0.18863,-0.106594,-0.0590727,-0.270055,0.504961,0.138,-0.0315256,0.0297201,-0.690517,0.30345,0.0685817,0.305768,0.244617,-0.464384,0.215409,-0.446032,0.191724,-0.00153918,0.11372,-0.0181469,-1.38919,-0.315762,-0.463949,-0.126066,-0.0551784,0.263828,-0.532987,-0.189779,-0.358253,0.262603,0.496452,0.239208,0.181675,0.224032,0.426234,0.47332,-0.833391 +3385.63,0.980418,0.0912059,5,1.58144,0.803882,-0.978581,0.253224,0.511218,0.109885,0.348677,-0.0691994,0.192801,0.206386,-0.180871,-0.307186,-0.17877,0.509689,-0.515946,0.696382,-0.0927007,-0.266485,-0.664013,0.0374004,-0.0419422,-0.98212,-0.463842,0.527414,-0.425413,-0.173542,-0.514924,0.117517,-0.238811,0.0273729,0.473099,-1.0893,-0.321353,0.000907407,-0.342778,-0.131238,-0.117373,0.620046,0.594064,-0.466373,0.711128,0.222137,-0.133555,-0.315463,-0.105457,0.255686,-0.0353456,0.570426,0.125362,-0.10174,-0.143847,-0.370088,0.0496223,-0.457741,1.08837,0.0716303,-0.178751,-0.534918,0.704539,-0.220323,0.00119607,1.0204,-0.598155,-0.282836,0.178619,-0.229018,0.0289759,-0.24553,0.084067,-0.0754875,-0.0925951,0.586777,0.216144,0.241294,0.935013,0.735996,0.578326,0.359627,-0.741313,-0.163421,0.961998,-1.01352,-0.094833,0.186482,0.251702,0.0927941,-0.159409,-0.538281,0.562614,0.0603228,0.442246,0.0610804,-0.17988,0.101171,-0.2394,0.00632826,0.377226,-0.624348,-0.198353,0.425855,-0.514267,0.371042,-1.15025,-0.587914,-0.308696,0.0679716,0.109658,0.589759,0.683221,0.773616,0.554639,0.302052,-0.455768,0.256956,0.295125,0.0476305,-0.41779,-0.204409,0.396747,0.309693,-0.230767,-0.133369,0.42569,-0.135286,0.110045,0.516521,0.398986,-0.37351,0.146302,0.0923721,-0.22715,-0.0998269,0.375233,0.593786,0.244584,0.494381,-0.0803115,-0.154907,0.0566736,-0.231405,-0.478361,-0.0143149,-0.235037,-0.000952335,0.164342,0.910797,-0.35939,0.322605,0.121685,-0.436018,-0.313804,0.0141455,0.670429,0.286047,0.318031,0.246803,-0.147794,-0.172103,0.58443,0.100336,0.423547,-0.171897,1.0513,0.152718,-0.600605,-0.592835,0.0046888,-0.220272,-0.206194,0.201694,0.352151,0.202369,-0.0437253,-0.199293,0.448505,-0.0958313,-0.357743,-0.586828,-0.255275,0.850737,-0.224282,-0.552422,0.273729,-0.668517,0.435859,-0.601264,-0.262381,-0.437765,0.497631,-0.0809621,-0.0727008,0.370832,0.164711,-0.743256,0.21741,0.511445,-0.160485,-0.310591,-0.184344,-0.356144,-0.374557,-0.578014,0.636566,-0.134344,0.106276,-0.0779888,-0.475268,1.0609,0.32515,0.1673,0.490298,-0.0636928,0.192133,-1.22675,0.21244,0.0204677,-0.201336,0.445896,0.368532,0.0547856,-0.0770606,0.0999789,-0.0167907,-0.191495,-0.736912,1.02645,-0.0110413,-0.260522,0.146678,0.26259,0.364835,-0.252624,-0.390176,-0.516959,-0.147531,0.516077,0.718094,0.0237583,0.974689,-0.942191,-0.324359,0.0540152,-0.688051,0.252147,0.309971,0.448853,0.342721,-0.0857353,-0.272256,-0.846648,-0.170061,-0.524961,0.147009,0.146391,0.137375,0.130335,-0.878945,0.157856,-0.081261,-0.548453,0.734596,0.241189,-0.257144,0.275257,-0.00521098,0.0183009,0.358972,0.224732,0.304704,-0.0154271,-0.282168,0.107446,-0.0779348,0.442063,0.321778,0.375656,0.108722,-0.777869,0.00494143,-0.416311,-0.0119122,-0.189891,-0.784434,-0.0559361,-0.413802,0.1587,0.0698532,-0.075048,0.253717,-1.16065,0.0828967,-0.141427,0.0936562,-0.0708599,0.0522997,-0.800633,-0.240849,-0.504383,0.372437,-0.151139,0.196521,0.167042,0.256984,0.408707,0.506936,-1.29037 +3390.52,1,0.0912059,5,1.58489,0.841463,-0.925217,0.255415,0.54811,0.100101,0.378762,-0.0941669,0.157285,0.226141,-0.224025,-0.305375,-0.253792,0.467491,-0.513872,0.678823,-0.105164,-0.295935,-0.64035,-0.0379307,-0.0237997,-0.96545,-0.486854,0.509275,-0.37567,-0.225953,-0.560782,0.0456145,-0.213345,0.107054,0.415549,-1.124,-0.276419,0.070911,-0.315159,-0.102212,-0.0669328,0.613099,0.579552,-0.415817,0.763606,0.229674,-0.064365,-0.269791,-0.0898002,0.275305,-0.0052362,0.533652,0.205575,-0.110111,-0.229911,-0.25777,-0.00574144,-0.373594,1.07903,0.0272955,-0.217841,-0.541437,0.60856,-0.216097,0.0351839,1.04104,-0.538817,-0.320674,0.106281,-0.231278,0.0534899,-0.273167,0.0134288,-0.0520669,-0.102193,0.524948,0.260188,0.129888,0.93093,0.704807,0.65124,0.430316,-0.668273,-0.169714,0.969001,-0.984647,-0.129452,0.189439,0.157595,0.0258518,-0.222618,-0.424177,0.58071,0.0742277,0.4435,0.0806946,-0.230725,0.149281,-0.17097,0.0400482,0.42723,-0.654211,-0.198916,0.480954,-0.471857,0.373377,-1.16805,-0.606224,-0.302733,0.094957,0.195994,0.570763,0.718473,0.781055,0.65286,0.304831,-0.449522,0.269328,0.224914,0.0533477,-0.319983,-0.233256,0.409106,0.276702,-0.25856,-0.12907,0.420459,-0.144593,0.067252,0.463097,0.438293,-0.384254,0.178163,0.0737808,-0.195358,-0.124214,0.319362,0.636349,0.211204,0.488892,-0.160303,-0.106597,0.032425,-0.173536,-0.489472,-0.0614689,-0.293207,0.0836164,0.23122,0.822789,-0.36736,0.358781,0.173794,-0.372433,-0.250582,0.0183526,0.765597,0.382723,0.231039,0.239956,-0.119507,-0.127763,0.626513,0.0825185,0.397978,-0.196137,1.03403,0.192943,-0.588453,-0.637621,-0.00163641,-0.276613,-0.125981,0.0771234,0.417297,0.224226,-0.033108,-0.223087,0.456595,-0.0336538,-0.355992,-0.577298,-0.201045,0.838351,-0.233503,-0.53182,0.321548,-0.674224,0.418584,-0.60213,-0.252477,-0.429581,0.40521,-0.0560113,-0.0361987,0.327119,0.156475,-0.784063,0.199412,0.599973,-0.193671,-0.252329,-0.276049,-0.32457,-0.328734,-0.579079,0.646746,-0.153431,0.0299298,-0.152687,-0.465118,1.01033,0.292022,0.136783,0.506303,-0.0635825,0.22219,-1.17069,0.168203,-0.0179976,-0.216786,0.459197,0.332789,0.16278,-0.108461,0.124535,-0.0177079,-0.207252,-0.782903,0.999064,-0.0338282,-0.258261,0.103409,0.279006,0.31718,-0.208485,-0.2605,-0.519214,-0.149241,0.532678,0.730794,-0.0795648,0.875479,-0.891327,-0.339988,0.0492088,-0.632384,0.208097,0.354202,0.46323,0.362022,-0.0629103,-0.222596,-0.915596,-0.106604,-0.549285,0.174477,0.161477,0.111959,0.0615164,-0.847695,0.17597,0.032282,-0.560855,0.605511,0.34661,-0.225189,0.182052,-0.0826819,-0.0169852,0.339971,0.178682,0.197636,-0.0793581,-0.24117,0.0610537,-0.163667,0.38777,0.35483,0.402917,0.129029,-0.841803,0.0382698,-0.475294,-0.00616947,-0.226521,-0.80062,-0.0260656,-0.489951,0.0980589,0.172068,-0.151603,0.198845,-1.14838,0.0556588,-0.158833,0.175404,-0.0902793,0.12068,-0.769477,-0.227639,-0.433483,0.340148,-0.13553,0.220447,0.160044,0.265072,0.400056,0.514852,-1.50351 +3404.14,0.686605,0.0912059,4,1.62383,0.845288,-0.467026,0.156493,0.0940161,-0.0694382,-0.151537,0.228678,0.177378,0.228611,0.0579224,-0.17439,0.117332,0.39254,-0.347672,1.16143,0.346659,-0.115908,0.15691,-0.486118,-0.30245,-0.90692,-0.364572,0.09646,-0.246758,-0.568703,0.309606,0.0361268,-0.301968,0.162384,0.64121,0.240054,0.2276,0.204123,-0.0712557,-0.0317448,-0.263339,-0.179338,0.459473,-0.656697,0.808709,0.587612,0.176234,-0.97192,-0.173163,-0.224624,-0.643097,-0.199063,-0.0417925,-0.0537482,0.298546,0.51477,0.134557,-0.730953,1.05261,-0.126292,-0.224993,-0.754016,0.436284,-0.477173,0.239827,0.585107,-0.357729,-1.38035,-0.354412,0.67094,-0.796924,0.0305802,0.152604,-0.728872,0.130573,-0.0119558,0.775965,0.297438,0.351446,0.15609,0.358857,-0.0287837,0.204383,0.144529,0.429029,-0.318644,0.428381,-0.772654,0.191094,0.119888,0.270532,0.0231846,-0.247383,-0.219865,-0.471672,0.117494,0.258179,-0.0406453,0.468151,-0.917511,-0.00475605,-0.0434266,0.572005,0.388585,0.45271,-0.55898,0.231593,0.0100683,0.178308,-0.731512,-0.0550599,-0.354745,0.040294,0.30468,-0.718738,-0.877013,0.627361,-0.043138,-0.697846,0.622611,-0.201801,0.436196,0.104957,-0.490244,-0.803416,0.0115428,-0.633255,0.0857687,-0.139542,0.0632579,-0.0340528,0.253249,0.127248,-0.585156,0.320589,0.0899525,0.371084,0.453782,-0.521999,-0.382408,0.475278,0.153796,0.582972,-0.57594,-0.145027,-0.0336503,0.716228,-0.34195,0.135646,-0.539107,0.43771,0.584407,0.141113,0.062711,-0.210423,0.13575,-0.390266,-0.27579,0.235599,0.653259,0.312652,0.508077,-0.0853967,-0.31412,0.0255058,0.220589,0.886713,-0.230241,0.251114,0.718056,0.488345,0.0159837,-0.193139,-0.307114,-0.18795,0.159063,-0.338725,-0.289076,-0.00435175,-0.227523,-0.723728,0.731697,0.282981,0.81978,0.185418,0.142141,0.219912,0.238902,-0.643996,-0.177051,-0.432984,-0.125336,0.159647,-0.553446,0.0438902,-0.226452,0.0148403,-0.246521,0.363218,0.240926,0.605692,-0.344106,-0.0541258,-0.130698,0.18094,0.473667,0.60327,-0.0564571,0.0774169,-0.179523,-0.519862,1.26182,-0.432349,0.240704,-0.623169,-0.0616615,0.254844,0.0585968,-0.428257,-0.240821,-0.0199916,0.215577,0.436249,-0.355339,0.0932539,-0.534368,-0.32372,0.218022,-0.528617,0.528538,-0.473371,-0.301048,-0.170799,-0.349005,-0.366951,-0.271663,-0.297735,0.378879,-0.607361,0.407512,-0.567738,0.00542137,0.455132,-0.308883,-0.679974,0.164209,0.535216,-0.186596,0.229292,-0.55604,0.234152,0.391642,-0.00695998,0.0608368,0.0483006,-0.793253,0.410804,-0.375648,-0.166819,0.554643,0.00166559,0.221578,-0.524256,0.461271,0.167487,0.334347,0.504166,0.0724391,-0.139033,-0.233693,0.0277202,-0.100349,-0.534307,-0.0406246,0.0142893,-0.610253,-0.387411,0.21477,-0.539609,0.186834,0.270968,0.701784,0.18611,0.344696,-0.0746659,-0.42374,-0.391263,-0.17065,0.95421,0.231782,-0.483589,0.695342,-0.215695,0.702816,-0.306036,0.233342,0.205133,0.229894,-0.367392,-0.117822,-0.13011,0.52563,-1.10899,0.151707,0.112225,0.157149,0.166853,0.39642,0.408477,-0.0683793 +3404.86,0.754926,0.0912059,4,1.64595,0.970147,-0.37024,0.15314,0.615329,-0.171453,-0.397005,0.681016,0.446592,0.168129,0.111958,-0.473258,-0.135441,0.070802,0.112295,0.570652,0.236705,0.0480806,-0.131021,-0.135354,-0.179946,-0.54985,-0.285184,-0.0115613,-0.328411,-0.0867449,-0.24461,0.455069,-0.381438,-0.150347,0.39665,-0.164433,0.255257,0.455438,-0.259634,-0.502054,-0.198202,0.276057,0.0242185,-0.414221,0.745049,-0.163235,-0.141674,-0.66585,-0.0550765,-0.255404,-1.04212,-0.215155,-0.259637,-0.241485,-0.0598498,-0.385992,0.366204,-0.552401,0.828249,-0.0109016,-0.796261,-0.813147,0.263557,-0.552954,-0.00866051,0.791031,-0.746707,-1.1433,-0.271824,-0.38941,-0.652426,0.149223,-0.178786,-0.250154,0.375342,0.288639,0.678934,-0.034504,0.894122,0.465991,0.0482753,0.514696,-0.747537,0.213743,0.322026,-0.290207,0.27719,-0.638885,0.4888,-0.180875,0.712436,0.0933517,-0.0446842,-0.021819,0.0602925,-0.0101815,0.0403481,0.0137872,0.118148,-0.494659,-0.294627,-0.0956586,0.855323,0.141993,-0.0911932,-0.289673,-0.352943,-0.274744,-0.0188228,-1.03009,0.0931256,0.190488,0.350259,0.038431,-0.563864,-0.445269,-0.0178346,0.18483,0.191613,0.154619,-0.293146,0.0768327,0.511255,-0.233665,-0.693229,-0.0327716,-0.255145,0.343362,-0.128539,-0.26845,-0.42547,0.0927914,0.350748,-0.404311,-0.187764,0.0645132,-0.180887,0.303692,-0.17915,-0.0427204,0.00354727,-0.147942,0.164037,-0.748608,-0.396085,0.036039,0.18482,-0.243361,0.307446,-0.0627571,0.583432,0.534795,0.112712,-0.158645,0.0228939,-0.000147092,0.254757,0.201318,0.0439347,0.951025,0.0124264,-0.045229,0.339004,0.30862,0.275094,0.473814,0.404696,-0.347838,-0.302747,0.729016,0.417418,-0.186406,-0.0630056,-0.598468,-0.558492,0.736845,-0.478183,-0.262247,0.112158,-0.156389,-0.294787,0.228758,0.103029,0.667213,0.00619348,0.399909,-0.0206185,0.169875,0.499249,-0.301225,-0.521893,-0.31004,0.507489,-0.365457,0.23595,-0.392012,-0.265856,-0.948701,0.702889,0.093778,0.684848,-0.363935,-0.639435,0.189107,0.219124,-0.283144,0.406574,-0.232246,0.54554,-0.270603,-0.397397,1.17467,-0.512615,-0.0179481,-0.16715,-0.555454,0.292593,0.260739,-0.752723,0.196441,-0.838701,-0.0667096,0.299498,-0.320223,-0.120749,-0.790928,0.627766,-0.159118,-0.144204,1.14737,-0.075774,0.00621696,0.668263,0.221069,-0.806709,-0.234521,-0.482519,-0.0954603,-0.593389,0.473016,-0.20666,0.238971,0.39639,-0.709905,-1.10393,0.220218,0.212569,-0.071108,0.458943,-0.187295,0.215974,0.550107,-0.431512,-0.145535,0.185752,-0.941485,0.242966,-0.93188,-0.427161,0.629203,-0.0572764,0.0956067,-0.375945,0.016084,0.898848,0.534318,0.0848285,0.602192,0.41478,-0.0051149,0.304779,-0.066699,-0.428113,0.0113467,-0.577143,-0.268037,-0.427319,0.144047,-0.219369,0.421005,0.136771,-0.0731411,0.047156,0.0352154,-0.435737,-0.540084,-0.264924,-0.462547,0.382917,0.570241,0.286891,0.497975,-0.432138,-0.246122,-0.223372,-0.250057,0.58547,0.589005,-0.331139,-0.565144,0.288261,0.0687328,-0.247554,0.325388,-0.0214155,0.194372,0.248543,0.440877,0.498541,-2.01983 +3395.03,0.76663,0.0912059,4,1.71125,0.885527,-0.51301,0.303998,0.420381,-0.159534,-0.272292,-0.039003,0.804624,0.0775706,-0.126901,-0.593861,-0.201682,0.302267,0.149038,0.870428,0.109503,-0.0054513,0.112647,-0.0631354,-0.311603,-0.379207,-0.623964,0.0756286,-0.110692,-0.0754758,0.153607,-0.128059,-0.0585682,0.143935,0.674567,-0.722859,0.496967,0.291923,-0.235275,-0.723754,-0.765659,0.334998,0.14484,-0.702894,0.525977,0.0698582,-0.0207766,-0.941065,-0.432406,-0.390887,-0.642335,0.248275,-0.15643,-0.340018,-0.554304,-0.120764,0.300347,-0.739818,0.57638,-0.374518,-0.344077,-0.581494,0.269752,-0.65878,-0.308998,0.720046,-0.379147,-1.41007,-0.00479669,0.282437,-0.382029,0.0394922,-0.452008,-0.271811,0.170059,0.291966,0.619629,-0.0737395,0.817885,0.347091,0.192944,0.61385,-0.374326,0.323163,0.000120077,-0.0911603,0.506053,-0.0667798,-0.409275,0.282355,0.399431,0.365153,-0.265751,-0.673557,0.147693,-0.743446,-0.205446,0.0457293,-0.0651599,0.121418,-0.361969,-0.0170635,0.421605,0.0669052,0.629563,-0.276423,-0.286105,-0.0290024,-0.160539,-1.03631,-0.220013,0.309889,0.244468,0.740584,-0.70962,-0.111039,-0.188847,0.0697198,0.198759,0.196152,0.104987,0.0917805,-0.307431,-0.0779577,-1.10373,0.0254189,-0.670721,0.431733,0.0593939,0.104925,0.111949,0.389247,-0.0403372,-0.247049,0.02731,0.261443,-0.0364668,0.427964,-0.360468,-0.235124,-0.283949,-0.00584832,0.00616691,-1.13543,-0.658277,0.256127,0.349214,-0.369872,0.145007,0.280946,0.162382,0.462676,-0.124857,-0.505595,-0.397989,-0.0078613,-0.200156,0.194649,0.182139,0.0831845,0.791522,-0.102662,0.141279,0.456514,-0.0426291,-0.0838883,0.959705,0.0460743,-0.000917728,0.520086,0.128586,0.189944,0.350461,-0.124383,-0.734089,0.278109,0.0234307,-0.273481,0.265144,-0.134839,-0.577308,0.100969,-0.361835,0.610326,-0.170071,0.702391,-0.0503665,0.895851,0.206329,-0.818749,-0.0664199,-0.5726,0.473352,-0.448081,0.331109,0.185861,-0.501349,-0.558995,-0.0825638,-0.000988076,0.143691,-0.413093,-0.330881,-0.229563,0.0353158,-0.48172,0.427546,0.356367,0.103002,-0.619938,-0.546722,1.15508,-0.0299996,0.351467,0.0225926,-0.545612,0.561011,-0.656601,-0.453515,0.694911,-0.0818589,0.64177,0.321355,-0.105072,0.188199,-0.573969,-0.260602,0.516145,-0.38152,0.324683,-0.534233,-0.224756,0.0469507,-0.399184,-0.214727,-0.247377,-0.361439,-0.414819,-0.823485,0.324948,-0.353168,-0.0725097,0.462528,-0.433418,-0.761842,0.56335,0.00475864,0.525245,-0.0464956,-0.476215,0.95796,0.488668,-0.558182,-0.13509,-0.029193,0.47129,0.581191,-0.855345,0.144145,0.174881,0.210906,0.0150788,-0.443965,0.0661213,0.184325,0.543368,-0.097677,0.503424,-0.000511484,0.131662,0.292873,-0.0302664,-0.083085,-0.337162,-0.598736,-0.249527,-0.515893,0.305637,0.839558,-0.287265,-0.00504174,0.180219,-0.174047,0.170156,-0.364232,-0.883652,-0.580307,0.0666385,0.303402,0.138678,0.119271,0.0432446,-0.711939,-0.254264,0.0192409,0.0870498,-0.131808,0.36016,-0.104076,-0.4157,0.387125,-0.143546,-0.166425,0.34188,-0.0182464,0.144803,0.206012,0.380529,0.453886,-1.22877 +3382.48,0.986131,0.0912059,5,1.70404,1.05642,-0.0391504,-0.0320223,0.243016,-0.162945,-0.270104,-0.0861553,0.367699,0.277804,-0.0650999,-0.529652,-0.280885,0.0161308,-0.230274,0.347612,0.296124,-0.150591,-0.384797,0.0223009,-0.393064,-0.886217,-0.309524,-0.367615,-0.0458612,-0.4423,0.219097,0.739538,-0.509605,-0.0280555,0.611151,0.316813,-0.0975862,0.465426,-0.0904781,-0.429085,-0.170874,0.343201,-0.394957,-0.609142,0.48986,-0.156638,-0.226102,-0.623167,-0.943703,0.0430375,-0.998305,0.122804,0.0325531,-0.0423117,0.0729429,0.228694,0.108858,-0.153755,1.01716,-0.757256,-0.365562,-1.20855,0.366834,-0.280193,0.221412,0.41988,-0.753679,-0.224383,-0.500651,0.191972,0.68807,-0.024216,0.787907,-0.539253,-0.290432,0.185779,0.799125,0.0140222,1.09381,0.130297,0.461813,-0.127625,-0.292028,-0.362323,0.517044,-0.0709271,0.343147,0.310949,0.22597,-0.206066,-0.0908117,-0.478893,0.34116,-0.340931,0.00127377,0.265175,-0.0799679,-0.370789,0.043848,-0.226739,-0.0712868,0.12312,0.25703,0.656741,-0.553575,0.256929,-0.63532,0.567212,-0.235235,-0.359664,0.0363158,-0.0418045,-0.303011,0.705858,0.543692,-0.391331,0.395454,0.241448,0.285995,0.215727,-0.121934,-0.18687,0.528515,-0.0479977,-0.0593838,0.0249103,-0.0960038,-0.599478,-0.215253,0.780476,0.311518,0.288616,0.273667,0.0349715,0.132518,0.0820287,-0.0299551,0.56845,0.203787,0.265996,0.0558939,0.135848,0.416093,-0.628122,-0.445061,0.19264,-0.243659,-0.0886798,-0.00664134,0.0265004,0.610945,0.425323,0.0860109,-0.157181,0.0106111,0.10841,0.0401637,0.243747,0.0998442,-0.18367,-0.50664,0.166922,0.328069,-0.0292407,0.12886,0.0583972,1.24773,0.263352,0.100658,-0.75016,0.36989,-0.898446,-0.352875,-0.00654657,0.47969,-0.474025,-0.553597,0.0748928,0.0336676,0.499071,-0.122768,-0.170098,0.124837,0.915604,-0.477637,-1.00892,-0.666006,0.0584631,0.604041,-0.646706,-0.400496,-0.762557,0.13911,-0.174534,-0.146374,-0.0137707,0.461907,-0.69614,0.420911,0.0574049,-0.15899,-0.326702,-1.03682,-0.14179,0.259601,-0.869118,0.468628,-0.28639,0.178708,0.416686,-0.284699,0.840781,0.585381,0.0850397,-0.412925,-0.169749,0.528183,-0.201541,0.0505153,0.383139,-0.0493037,0.00826842,1.14259,-0.27196,-0.0420215,-0.236124,0.118105,0.0541823,-0.613518,0.656454,-0.1846,-0.142803,0.207508,-0.0127478,-0.288744,-0.0754189,0.260392,-0.164981,0.123123,0.181536,-0.331256,0.357408,0.693396,-0.0911892,0.0573819,0.323463,0.620928,-0.51968,0.0566183,0.0220963,0.112695,0.453625,0.622039,-0.26523,-0.168568,-0.506783,0.401194,0.0219421,0.462788,0.220127,-0.447798,0.225954,0.676107,0.619822,0.306794,0.765009,-0.0771677,-0.542741,0.0224276,0.15544,-0.132766,-0.0461469,-0.411063,0.133785,0.0144333,-0.093224,0.0141286,-0.568372,-0.555932,0.217877,0.649875,-0.437969,0.592055,0.131289,0.703768,-0.527255,-0.670163,-0.362629,0.483325,0.604101,-0.0504116,0.753013,-0.36436,0.319185,-0.313694,0.356917,-0.160325,0.017791,-0.39137,0.175823,-0.0982602,-0.125412,-0.157225,-0.055079,-0.274923,0.155753,0.189328,0.394656,0.435118,-0.878743 +3398.77,0.952616,0.0912059,5,1.44143,0.823757,-1.52759,0.646527,0.437138,-0.0917503,0.128687,0.534232,0.4207,-0.118975,-0.0462906,-0.0530487,-0.114137,0.786335,-0.214496,0.886427,-0.273662,0.20078,0.0583205,-0.061123,-0.166959,-0.907857,-0.135121,0.623497,-0.224635,0.486272,-0.142637,0.258743,-0.0751843,0.319199,0.905199,-0.599415,-0.201474,0.290137,-0.342799,0.303198,-0.42555,0.168621,0.00961678,-0.0255831,1.43052,0.939851,0.562608,-0.498681,0.491978,-0.141332,-0.507971,0.0569927,0.536635,-0.289986,0.373363,0.53491,0.294863,-0.260014,0.209205,0.344473,-0.228273,-0.429494,0.369867,-0.0318793,0.455734,1.04843,-0.389729,-1.2052,0.226743,-0.045349,-0.489043,-0.0690584,-0.53762,-0.428913,-0.0857251,0.178154,0.528937,-0.3862,0.0543828,0.345574,0.618955,-0.289414,-0.223268,0.412165,0.152307,-0.369184,-0.203287,-0.762222,-0.23448,-0.150135,0.184301,0.158183,-0.17075,-0.27872,-0.00220478,-0.334135,0.126489,-0.281852,-0.377304,-0.360863,0.0938413,-0.484576,-0.191695,-0.0260488,0.52868,-0.250721,-0.027563,-1.05629,0.386696,-0.344762,0.425348,-0.54021,0.669365,0.272674,-0.528969,0.000973235,-0.0843529,0.505457,-0.327553,0.0645869,-0.529507,0.175994,0.317775,-0.0560812,-1.14818,-0.0910433,-0.282686,0.280264,-0.0575641,-0.426976,-0.119287,-0.0937597,0.0115336,-0.71929,0.194742,-0.1964,-0.0835647,0.639522,-0.177066,-0.19441,-0.302332,-0.296791,0.417787,-0.232709,0.00636784,-0.0161178,-0.0219201,-0.556728,0.190942,0.422108,-0.854935,0.191985,-0.073041,-0.00131246,-0.340667,0.22173,0.275956,-0.199354,0.354085,0.801851,0.194653,-0.102077,-0.0124916,-0.00305876,0.338877,-0.0365288,0.0621505,-0.219254,-0.277868,0.920236,-0.590105,0.339251,-0.316911,-0.248437,-0.113718,0.537977,-0.124073,-0.0965537,-0.0617049,-0.554598,-0.303501,-0.0939902,0.383539,0.66012,0.657162,0.805182,0.439585,-0.0896519,-0.498228,0.0790195,0.0582466,0.0943822,-0.048435,-0.800151,-0.296975,-0.111043,-0.79794,-0.0076041,-0.25012,0.219953,0.307069,-0.50328,0.163609,0.354045,-0.11921,0.214492,0.0791506,0.162881,0.0307489,-0.700504,-0.713549,1.03526,-0.582442,0.368484,0.535468,0.0957266,-0.279358,0.464652,-0.626721,0.198877,-0.317112,-0.100062,-0.676647,-0.129228,-0.200358,-0.372339,-0.0301919,0.0976722,0.216214,0.306486,-0.384717,-0.0288002,0.0132779,-0.302357,-0.0374863,0.311666,-0.527413,-0.268445,-0.716263,0.551151,0.126718,-0.132534,0.758478,-0.455454,-0.392822,-0.275011,-0.558816,0.447977,0.612339,0.458778,0.606881,-0.383754,-0.809251,-0.613116,0.221411,-0.43715,0.543357,-0.0868022,-0.529937,0.404608,-0.100592,-0.119792,-0.302228,-0.218968,-0.228238,0.0904034,0.392455,1.01269,0.0739531,0.177399,0.0711632,-0.127364,0.0845129,0.027626,-0.327125,-0.382729,-0.485683,0.738303,0.229723,-0.354256,-0.135387,0.442122,-0.0370334,-0.141764,-0.510272,0.204287,-0.06755,0.32542,-0.481943,-0.0905938,-0.219967,-0.27003,0.604884,-0.542273,-0.124016,-0.103078,0.514101,-0.0833017,-0.023957,-0.834914,0.308087,0.389827,-0.239077,-0.151707,0.158306,0.161573,0.272135,0.401961,0.521665,-1.25372 +3404.34,0.562357,0.0912059,5,1.59081,0.703736,-1.40326,0.504293,0.70564,-0.128318,-0.185559,-0.319007,-0.151491,-0.216823,0.0804715,0.166373,-0.16886,0.237827,0.146924,0.950188,0.354038,-0.0524543,0.393674,-0.0202176,-0.513772,-0.26655,-1.00328,0.33675,-0.30861,-0.217082,0.413965,-0.49958,-0.55368,0.0397015,0.663745,-0.986488,-0.187588,0.546678,-0.0537315,0.0846931,-0.264191,1.01393,0.815291,-0.313667,1.07161,-0.00870483,0.866741,-0.426527,0.456764,-0.54863,-0.38956,0.302714,0.720453,0.130298,0.442657,0.68399,0.345345,0.566367,0.840264,0.136953,-0.181395,-0.937517,0.655382,-0.408421,-0.053708,0.919664,-0.388389,-1.06123,0.136358,-0.103321,0.127337,-0.0505713,0.212945,-0.833203,-0.116094,0.209302,0.469262,0.137616,0.367782,0.346197,0.108617,-0.627304,-0.449934,0.566895,0.167014,-0.446433,0.0453787,-0.0497243,-0.303178,-0.204776,0.428913,-0.646614,0.177882,-0.245813,0.199984,-0.213186,-0.11733,-0.0193945,-0.303693,0.05866,-0.133708,-0.0713069,0.414615,0.076709,0.594252,-0.083925,-0.438181,-0.465013,0.610244,-0.408027,0.172174,-0.185124,-0.0264935,0.0535606,0.497451,-0.0564393,-0.45682,0.234292,-0.0575006,-0.0355964,-0.0959739,-0.0753966,0.722838,-0.470965,-0.714837,-0.590484,0.602301,0.240788,-0.344076,0.0293778,-0.229284,0.2623,0.400989,-0.587732,0.49493,-0.254942,-0.10577,0.207167,0.159763,-0.0828908,-0.062392,-0.0360478,0.65096,-0.781029,-0.258846,-0.454974,0.191869,-0.203682,-0.267437,0.0489447,0.790643,0.166013,0.223321,0.21297,0.10747,-0.505643,0.0827262,-0.251094,0.970091,-0.199085,0.0319321,-0.217222,0.0459013,0.198871,0.401638,-0.0410388,0.376651,-0.0184613,-0.747601,-0.806922,-0.151849,0.171471,-0.139735,0.334492,-0.433342,-0.708666,-0.0350162,0.0987141,0.553792,-0.110701,-0.158179,0.144477,0.396043,0.948351,-0.122755,-0.411622,-0.180147,0.18776,-0.243401,-0.0999062,-0.0419519,0.292889,-0.0928372,-0.807961,0.0926003,-0.184098,-0.0642484,-0.540785,0.0557353,-0.309616,0.0064204,0.209029,-0.586834,0.0478629,-0.0393815,-0.613852,0.0610687,-0.570971,-0.0715557,-0.149554,-1.32619,0.990386,-0.487036,0.35237,-0.112989,-0.0646858,-0.195643,0.617977,-0.271566,0.320496,-0.387927,0.0599417,0.258236,-0.195061,-0.339661,-0.347736,-0.342407,-0.0790169,-0.827007,0.283027,-0.172228,-0.501979,-0.0529682,0.0588176,-0.556493,-0.234722,-0.578803,0.428569,-0.216873,0.463858,0.162637,0.22933,0.774321,-0.417506,-0.672652,0.298965,-0.0970066,-0.369409,0.677217,0.234362,0.415721,0.350099,-0.535716,-0.221795,-0.24373,-0.758534,0.328899,-0.40172,0.157584,0.197151,0.155971,0.107265,0.434713,0.265984,-0.0443838,0.0687524,-0.126194,-0.0768851,0.435673,0.385903,-0.109454,0.250206,0.216593,-0.593113,0.0981008,-0.384022,0.423462,0.0155119,-0.180965,0.367769,-0.143968,0.597435,-0.12266,0.222942,-0.335975,-0.183564,0.00617224,-0.168075,-0.0475048,0.31362,-0.437173,0.806628,0.136656,-0.08356,0.141197,0.175318,0.451883,0.0894055,-0.566315,-0.81333,0.573301,-0.521568,0.230341,0.728921,-0.199946,0.124109,0.252804,0.35229,0.502797,-1.70481 +3429.22,0.698892,0.0912059,4,1.53248,0.786659,-1.36555,0.502747,0.933355,-0.231993,-0.0294832,0.0131901,-0.0134361,-0.15698,0.0740439,-0.0679699,-0.0584709,0.355457,-0.344614,0.920307,0.152007,0.345718,0.219149,-0.0402304,-0.369741,-0.604503,-0.55637,0.354916,-0.477773,-0.239348,0.314215,-0.361423,-0.642211,0.0790139,0.630842,-0.949237,-0.176314,0.573273,-0.0704369,-0.122188,-0.506266,0.70805,0.372296,-0.0749412,1.09827,-0.158521,0.603288,-0.26887,0.193386,-0.54101,-0.0938257,0.3838,0.271317,0.198446,0.183163,0.716921,0.434467,0.153065,0.745322,-0.255325,-0.41967,-0.538145,0.679562,-0.612099,-0.115905,0.951117,-0.581473,-0.845128,0.0776998,0.249612,-0.0997793,-0.262853,0.0927376,-0.726406,-0.17525,0.151064,0.436274,-0.198519,0.30531,0.293836,0.19301,-0.487623,-0.645946,0.532888,-0.0275107,-0.764793,-0.206554,0.124603,-0.257103,-0.0609678,0.083155,-0.234278,0.173322,-0.207164,0.221152,-0.395442,-0.138941,0.211783,-0.0792625,-0.260711,0.314774,0.179607,0.300256,0.0233776,0.638308,0.0665386,-0.724908,-0.389012,0.235882,-0.742053,0.414059,0.209619,-0.102392,0.26178,-0.270775,0.182633,-0.261613,0.222449,0.281626,0.0235152,-0.369182,-0.115016,0.3273,-0.436125,-0.583115,-0.277951,0.21754,0.213048,0.0895458,0.0527784,0.10196,0.253073,0.146297,-0.389397,0.349287,0.0118703,0.0985116,0.109557,-0.256176,0.00922222,-0.0679483,-0.553093,0.6454,-1.14859,-0.361476,-0.328887,0.380211,-0.307641,0.219546,0.13006,0.362895,0.228771,0.0770521,0.174561,-0.103282,-0.472597,0.419742,-0.147762,1.07528,0.0720198,0.387269,0.319061,0.337475,0.0764611,0.12627,0.0869881,0.355736,0.0619718,-0.754372,-0.336088,-0.356224,0.102105,-0.310059,-0.0625278,-0.630294,-0.505895,-0.0797441,0.0205171,0.37414,-0.343541,-0.112806,-0.262544,0.496042,0.860271,0.489153,-0.368,0.221138,0.125036,-0.211064,-0.106766,-0.415503,0.46639,-0.168893,-0.775503,-0.0973088,0.056266,-0.429277,-0.405618,-0.00638583,-0.169061,-0.0450336,0.0844307,-0.439068,0.050349,0.102711,-0.817845,-0.186123,-0.49422,0.40719,-0.173779,-0.570461,1.15125,-0.294934,0.46739,0.118966,-0.195509,0.0163548,0.311798,-0.0113151,0.307074,-0.265722,-0.0496011,0.341169,0.113154,-0.445518,-0.499669,-0.471365,0.08661,-0.0796222,0.094693,-0.0647327,-0.395891,0.171076,0.0287118,-0.232251,0.109722,-0.850674,-0.0815962,0.27239,0.0599279,0.0944349,0.439564,0.626443,-0.310543,-0.567284,0.245121,-0.114419,-0.274597,0.573151,0.544259,0.407775,0.232121,-0.657241,-0.141126,-0.765232,-0.860638,0.169545,-0.27041,-0.398769,-0.0459426,0.0183673,-0.269644,0.630498,0.488353,0.0993341,0.247437,-0.000574072,0.152941,0.50058,0.204292,0.249293,0.285944,0.206791,-0.075196,0.369099,-0.395073,0.242158,-0.164381,-0.176807,0.422338,0.173915,0.311675,0.617264,0.0504664,-0.32263,-0.115789,-0.189657,0.288104,0.183756,0.305773,-0.342102,0.274502,-0.211367,-0.24763,0.128083,0.425091,0.11978,0.260461,-0.604074,-0.392134,0.264445,-0.494025,0.0378374,0.262386,-0.00428666,0.135394,0.274524,0.36796,0.523951,-2.65814 +3439.93,0.961926,0.0912059,4,1.53547,0.723166,-1.27754,0.501266,0.811031,-0.210086,-0.121748,0.191344,0.122424,0.0517992,0.0691785,0.0244101,0.103663,0.170534,0.0489072,1.15777,0.607861,0.248872,0.193129,0.139733,-0.344854,-0.703704,-0.775677,0.553655,-0.543146,-0.108429,0.32935,-0.184565,-0.671449,0.213787,0.676914,-0.526386,-0.156667,0.699438,0.098708,-0.165459,-0.382967,0.785812,0.209438,-0.121918,0.949984,0.161848,0.626919,-0.568489,0.163597,-0.044151,-0.117998,0.407354,0.352173,-0.0114369,0.516492,0.966253,0.214397,-0.629422,0.700806,-0.0570067,-0.293835,-0.946264,0.885529,-0.622349,0.0392509,0.676098,-0.55142,-0.581478,0.0145399,0.128184,0.384579,-0.00176784,0.0823343,-0.641657,-0.522082,0.396052,0.532754,-0.00320627,0.134785,0.161454,0.0410953,-0.296056,-0.584606,0.476474,0.117963,-0.769827,-0.0529947,0.112268,0.114837,0.185726,-0.248022,-0.288362,0.0792618,-0.256339,0.25772,-0.338949,-0.126514,0.0866698,-0.141863,-0.125562,0.338595,-0.151194,0.435172,0.0209215,0.288537,0.00261289,-0.688388,-0.208647,0.537918,-0.235358,0.552906,0.0629761,-0.0728509,0.405782,-0.0747801,-0.118471,-0.575453,0.421179,-0.238111,0.25488,-0.141092,0.0453782,-0.0417366,-0.358867,-0.54754,-0.0855799,-0.16866,-0.144529,-0.036935,0.240461,-0.330267,0.0196801,0.463026,-0.749271,0.0869541,0.169417,-0.0892266,0.224336,-0.637047,-0.331338,0.0273499,-0.232426,0.603482,-1.02846,-0.437323,-0.436075,0.424458,-0.471959,0.0168833,0.367844,0.181325,0.233056,0.180528,0.408372,-0.579822,-0.350284,0.290126,-0.040278,0.960656,0.26998,0.190716,0.136328,0.189459,0.439097,0.172862,-0.216523,0.580185,0.0425204,-0.505872,0.0648615,-0.273129,0.0608224,-0.195414,-0.252783,-0.0733459,-0.164105,0.149624,-0.110416,0.179357,-0.197243,-0.31177,-0.330959,0.313081,0.841121,0.645238,0.021637,0.339958,0.142529,-0.0497248,-0.0496507,-0.480873,0.420723,0.100238,-0.805669,0.100637,-0.00394569,-0.631542,-0.24527,0.302332,0.252556,0.226563,0.037249,-0.632705,-0.146021,0.0175683,-0.580809,0.014713,-0.511992,0.547154,-0.157115,-0.400422,0.879219,-0.210253,0.316525,0.186156,-0.225327,0.130306,0.383077,0.239584,0.529388,-0.106579,-0.208473,0.475881,0.0489372,-0.212093,-0.269594,-0.276661,0.152529,-0.487304,0.0592047,0.0102694,-0.532727,0.236227,-0.174665,-0.251629,0.145339,-0.583153,0.00803224,0.237506,-0.0265623,0.157693,0.454849,0.952582,-0.69832,-0.476402,0.150152,-0.0907551,-0.195146,0.00355705,0.0911216,0.651037,0.12714,-0.229155,0.22645,-0.470391,-0.838826,0.34641,-0.258223,-0.283679,0.219783,-0.00573419,-0.0315695,0.105008,0.264501,0.370088,0.136279,-0.134659,0.297324,0.0250259,0.193768,0.154075,-0.0163368,0.525603,0.140476,0.455287,-0.210643,-0.152481,-0.338187,0.420043,0.419656,-0.0202753,0.398545,0.693055,-0.068821,-0.271144,-0.0980398,-0.525079,0.112884,0.0130466,0.0944731,-0.210445,0.519426,0.0626664,-0.138556,0.207466,0.0451636,0.0939793,0.250983,-0.41913,-0.499979,0.089903,-0.118614,0.369483,0.432061,0.239692,0.133918,0.218227,0.365948,0.467148,-2.18712 +3414.81,0.673925,0.0912059,4,1.56511,0.628181,-1.48234,0.661167,0.74996,-0.14698,-0.424148,-0.0797385,0.2189,0.240834,0.162673,-0.0249622,-0.152817,0.609887,-0.14467,0.801274,0.130233,0.0780703,-0.312152,0.12297,-0.00753779,-0.677237,-0.0154809,0.459109,-0.449814,-0.0513245,-0.174771,0.0905657,-0.48659,0.271041,0.790808,-0.935214,0.304913,0.489644,-0.609863,-0.243423,-0.882286,0.34206,0.517972,-0.207312,1.16231,-0.174989,0.0757885,-0.242291,0.22617,0.0918182,-0.413324,0.45297,0.404356,0.425236,0.0957449,0.00782602,0.0860106,0.0621376,0.425344,-0.428984,-0.270986,-0.446907,0.374776,0.085267,0.322609,1.23403,-0.965977,-1.52135,-0.294693,0.560241,0.19843,-0.290239,0.115037,-0.44123,-0.00122189,0.0692005,0.55315,-0.480585,0.183615,0.579587,-0.01722,-0.205375,-0.531864,0.304401,0.535815,-0.967,0.0730623,0.204627,0.285533,-0.0137558,-0.320302,-0.255643,0.210926,-0.0842196,0.499804,-0.344994,-0.176412,0.0331209,0.31998,0.0944507,-0.0351031,0.317765,0.354222,0.367898,-0.0866941,-0.248244,-0.348564,-0.381733,1.14963,-0.352081,-0.395107,-0.336717,0.221008,0.132569,-0.336098,-0.283785,-0.36874,0.601903,-0.709127,0.175327,-0.720036,0.00506482,0.384034,-0.0101425,-0.549799,0.136024,-0.0678427,-0.44675,0.49241,0.190948,-0.170713,0.0473275,0.388767,-0.384675,-0.196301,-0.0673665,-0.512458,0.313942,-0.0509559,-0.171385,0.513781,-0.303863,0.569403,-0.902769,-0.968995,0.157452,0.18858,-0.706594,0.0848329,0.271799,0.453344,0.477641,-0.149456,-0.119515,-0.537997,0.389399,0.230042,-0.00424122,0.765428,-0.460722,0.615168,-0.291799,-0.239227,0.16612,-0.0358296,-0.412352,0.466795,-0.437618,0.140992,0.0395381,-0.0401265,-0.338099,-0.702571,-0.120022,0.405263,-0.316769,0.114485,0.232758,-0.135249,-0.04421,0.17388,-0.19204,0.447565,0.313873,0.72629,-0.341375,0.492437,0.196994,-0.0775529,-0.267714,-0.102745,0.175234,0.0831129,-0.268192,-0.0445284,-0.279822,-0.263474,-0.88882,0.285051,0.268578,0.299931,0.0486552,-0.315905,-0.125874,-0.427997,-0.603891,-0.0801015,-0.101002,0.393332,0.507565,-0.768928,1.29202,0.380637,0.459492,-0.316941,0.172602,0.439671,0.678533,0.120885,0.0775128,-0.171298,-0.355671,0.459302,-0.636264,0.19232,-0.543208,-0.551203,0.107888,-0.668939,0.283692,-0.320248,-0.633112,-0.148074,-0.0410148,-0.0617558,0.235626,-0.0788187,-0.0733658,-0.278408,0.30196,-0.479482,-0.00351245,0.152591,-0.335451,-0.189483,-0.199547,0.164982,0.0279971,0.547118,-0.174681,0.553421,0.129536,0.354565,-0.1242,-0.301512,-0.189067,0.186834,-0.465919,-0.116123,-0.032077,0.353266,-0.0882896,-0.114376,0.0331572,0.456682,0.532707,-0.649131,-0.0356351,0.217404,-0.0913716,0.472274,-0.455919,-0.123977,0.0407374,-0.321232,-0.356265,-0.719171,0.41756,0.296417,-0.182752,0.185061,0.384066,0.452331,0.189501,-0.595129,-0.0596728,0.523548,-0.611831,0.422374,0.176215,-0.164782,-0.181562,0.454824,-0.407231,0.143761,0.0973682,0.327462,-0.12528,-0.140233,-0.567277,-0.068694,0.093642,-0.556475,-0.419235,-0.2925,0.138487,0.248033,0.372138,0.498029,-1.84662 +3396.09,0.977626,0.0912059,4,1.66595,0.8289,-1.18059,0.454451,0.728269,-0.130217,-0.223194,-0.0754812,0.185195,-0.0094537,-0.429048,-0.536905,-0.375577,0.663321,0.264372,0.943844,-0.0570937,-0.0472012,-0.110592,-0.153123,-0.422249,-0.642115,-0.800429,0.344242,-0.165463,-0.341594,0.0401328,0.224633,-0.900002,0.300629,0.64874,-0.631675,-0.242777,0.376535,-0.386193,-0.253471,-0.463523,0.784067,0.157699,-0.462356,0.892182,0.278954,0.620917,-0.760642,0.517099,-0.667797,-0.887227,-0.234236,0.179327,-0.0279366,0.0788593,0.629706,-0.506066,-0.751665,0.471323,-0.265306,-0.400873,-0.871853,0.348924,-0.939625,-0.154302,0.853294,-0.505995,-0.825038,0.315842,0.087453,0.15367,-0.43674,-0.110108,0.47238,0.425233,0.771793,-0.0901092,0.0211391,0.184665,0.340271,0.557395,0.076799,-0.181653,-0.0819245,0.67113,-0.0530489,0.0575048,0.149352,-0.264894,0.319011,-0.108569,0.532116,-0.056367,-0.137614,0.435404,0.237948,-0.0683544,0.108049,-0.0717095,-0.213247,0.372344,-0.115236,0.486671,-0.121614,0.609478,-0.0350781,-0.763859,-0.716335,0.538899,-0.652625,0.20991,-0.055975,0.461107,0.819359,0.139148,0.308934,-0.273538,0.354578,0.414402,-0.208647,-0.344376,0.141613,0.503787,0.2373,-0.897448,-0.423872,0.476835,0.317067,0.0519478,0.0829356,-0.247214,0.334028,0.474732,-0.0997268,0.3271,-0.262681,-0.166496,0.277296,-0.460581,-0.390267,0.115993,-0.475387,0.466367,-0.977004,-0.141093,-0.580819,0.311343,-0.302562,0.254213,-0.21149,-0.704627,-0.355633,0.234414,-0.296958,-0.335741,0.0816822,0.593645,0.057883,0.744709,0.237319,0.466241,0.0928758,-0.012636,-0.054913,-0.0541449,-0.0985656,-0.066785,0.492553,0.702259,-0.44741,-0.0011603,-0.20913,-0.0797889,-0.102802,0.723869,-0.145658,-0.17334,0.364081,-0.546403,-0.879478,-0.357485,-0.026712,0.299137,0.924014,0.575533,0.130717,0.340458,0.42363,0.249185,-0.865609,-0.490153,0.0625817,0.0213233,-0.28907,-0.497868,-0.167981,-0.208255,-0.180231,0.535769,0.282156,0.0839981,-0.255967,-0.995945,0.0636906,0.0762675,-0.849073,0.302972,-0.00133029,0.316331,0.0702928,-0.746786,1.02631,0.460564,-0.410602,-0.250214,0.169084,-0.279499,-0.383464,-0.141772,0.40636,0.118695,0.0790869,0.513106,-0.343098,-0.362397,-0.850387,-0.986167,-0.0288151,0.0457645,0.233553,-0.0276539,-0.972397,-0.255221,0.168019,0.540866,0.0672551,-0.413709,0.0608089,0.103591,0.679367,0.456788,0.193116,0.395265,0.180236,0.538001,-0.272615,-0.110826,0.0958851,0.795825,-0.31854,0.621992,0.25482,-0.496391,-0.508477,0.107616,-0.752082,0.675719,-0.603477,-0.300061,0.428179,-0.210156,0.083863,0.126326,-0.346749,-0.0792946,0.819824,-0.070178,-0.121392,0.42942,0.036712,0.0221026,0.0808014,-0.1894,0.0368335,0.350067,0.0498352,-0.873633,0.13403,-0.103372,-0.00810801,-0.232756,-0.331809,0.528946,-0.165302,-0.497214,0.0142333,-0.449997,0.355626,-0.237964,-0.46531,-0.0694898,0.610545,0.634253,0.228824,0.135496,-0.104517,0.370792,-0.522106,-0.0270279,-0.552927,0.464384,-0.366,-0.494091,-0.522462,0.0422931,0.170685,0.215644,0.41314,0.464375,-1.99533 +3390.87,0.992135,0.0912059,5,1.59916,0.778339,-1.33861,0.517324,0.430369,-0.0152897,0.0552181,-0.0461429,0.546103,0.365041,-0.364899,-0.495053,-0.134019,0.50244,-0.0690504,0.553457,0.152854,-0.104516,-0.185889,0.0485758,-0.269298,-0.872614,-1.0459,0.200189,-0.735925,-0.283982,-0.294105,0.196241,-0.374684,-0.226485,0.591326,-1.21537,0.0176099,0.201826,-1.07057,0.218846,0.238602,-0.208074,0.390134,-0.559253,1.04828,0.927253,0.303538,-0.204613,0.103672,0.163106,-0.655448,0.282466,0.19211,-0.254653,-0.151512,0.493977,0.19621,-0.421777,0.411241,-0.485016,-0.216151,-0.483078,0.303534,-0.324737,-0.0357585,0.909658,-1.16472,-0.831875,-0.308961,-0.392185,-0.197102,0.479923,-0.656575,-0.198878,-0.0835726,0.39318,0.449456,-0.480853,0.69682,0.611029,0.555989,-0.0938637,-0.364656,0.616348,0.380034,-0.0735474,0.0869792,0.622986,-0.357884,-0.332143,-0.0840044,0.011149,0.424205,-0.0443673,0.495051,0.0144901,0.283476,0.442929,-0.50378,-0.495739,0.269759,0.449086,0.284007,0.106769,-0.302564,0.236578,-1.29165,-0.380476,0.737713,-0.283634,1.25981,-0.0647537,0.580613,0.376573,-0.357497,0.0911196,0.609337,0.514106,0.176084,0.34296,-0.227048,0.251913,0.424052,0.38876,-0.924581,-0.1599,-0.659936,0.041217,0.414479,-0.147211,-0.0610867,0.168167,0.730203,0.2227,0.0544187,0.162934,-0.46315,0.629921,-0.188417,-0.147407,-0.193553,-0.788196,0.760694,-0.375643,-0.267603,0.0892701,0.522466,-0.731339,0.112407,-0.671432,-0.0213315,1.08082,-0.338486,0.302677,-0.25677,0.0548768,0.452175,-0.142435,0.113163,0.351829,0.473967,0.791409,-0.211247,0.078768,-0.229534,-0.135517,0.557576,0.247413,0.577834,-0.328888,0.127409,0.152231,-0.0122503,0.423262,-0.0539512,-0.289036,0.189508,0.268771,0.0620967,-0.207393,-0.293596,-0.557737,0.2991,0.799646,0.960526,-0.29403,0.446898,-0.185789,-0.01831,-0.752629,-0.497794,-0.00568973,-0.252946,-0.432104,0.0823288,-0.610052,0.22726,-0.322738,-0.328817,0.430356,0.237564,-0.0149773,-0.483853,-0.107601,-0.0769434,-0.677395,0.445444,-0.124217,0.214776,-0.360154,-0.489803,1.26836,0.552714,0.780843,0.141246,0.231507,-0.0983251,-0.219984,-0.670327,0.57021,-0.622493,0.243414,0.00558704,-0.225815,0.0864958,-0.407891,0.381478,0.677553,-0.3806,0.831797,-0.861849,-0.101986,0.0955545,0.109224,-0.0369981,0.137776,0.238233,-0.0650869,-0.354752,0.401706,0.18172,0.568485,0.552794,0.132073,-0.990708,-0.215529,0.205331,0.472926,-0.111148,0.112666,1.22926,0.359492,-0.154739,-0.437143,-0.257328,-0.57467,0.00962041,-0.265087,-0.000381297,0.246657,-0.13553,-0.28198,0.0819084,0.305166,0.366429,0.499448,0.357291,0.0762165,-0.0266995,0.351173,0.179445,0.429458,-1.14861,0.228042,0.0192544,-0.231791,-0.767069,-0.032425,-0.35499,0.620028,0.488378,-0.135498,-0.858729,-0.0605322,-0.753417,-0.22226,-1.07585,-0.123886,0.396262,0.579667,-0.0228667,-0.0256607,0.0956029,-0.707419,-0.0355531,-0.0584927,-0.198348,0.374215,-0.224862,-0.377092,0.080707,-0.251812,-0.00470967,-0.015257,-0.106257,0.180847,0.324508,0.425261,0.569656,-0.989098 +3402.57,0.858489,0.0912059,4,1.64892,0.638156,-1.17284,0.508977,0.543058,-0.0294862,0.0114613,-0.214598,-0.282507,0.190776,-0.112042,-0.106362,-0.201655,0.406577,0.102432,0.390815,0.400378,-0.250273,-0.154683,0.1508,-0.296085,-0.618593,-0.99656,0.450327,-0.502543,-0.0508588,-0.506973,0.50212,-0.456831,-0.0576716,0.89057,-1.23292,0.0922417,0.328213,-0.278489,-0.13511,-0.194906,0.605831,0.11352,-0.830805,0.681798,0.564838,0.251623,-0.609276,-0.278339,-0.436389,-0.531042,-0.363617,-0.0718356,-0.113063,-0.20518,0.162613,-0.0180994,-0.996982,0.702259,-0.242495,-0.108422,-0.783732,0.550105,0.0179845,0.0970015,0.737714,-1.30804,-0.613989,-0.0694248,-0.139572,-0.375896,-0.0222774,-0.497736,0.0756533,-0.124778,0.360815,0.645283,-0.40885,0.733894,0.369336,0.742664,0.176839,-0.266273,0.484539,0.647392,0.221234,0.419166,0.0960509,-0.260426,0.346115,-0.185546,-0.272614,0.257644,-0.597469,-0.048057,-0.364732,0.379545,0.37075,0.141895,-0.318672,0.619141,-0.13387,0.0292507,0.291026,-0.519664,0.984686,-0.481579,-0.248679,0.782867,-0.156065,0.615004,0.0129722,0.091916,0.935726,-0.228904,-0.351438,0.676591,0.497628,-0.424943,-0.0741748,-0.335055,0.0794471,-0.211459,0.0786336,-1.22169,0.494679,-0.37791,0.503293,-0.208994,0.100062,0.443273,-0.0455087,0.615966,-0.246615,-0.0999965,-0.143332,0.169699,0.246884,-0.316754,0.314702,-0.308286,-0.275156,0.370101,-0.167432,0.00610758,0.0516331,0.165413,-0.685213,0.761646,-0.227163,-0.180975,0.586491,-0.0114553,-0.25471,0.0543065,-0.0782265,0.496493,0.118784,-0.073901,0.446011,-0.140797,0.475004,0.217408,0.411414,-0.307738,0.0500325,0.266672,0.639476,0.553309,-0.11795,0.168193,0.0236764,0.431645,0.291604,0.653289,0.10082,-0.100097,-0.32002,-0.354096,0.171346,-0.552573,-0.010354,0.391716,0.789667,0.831245,-0.202643,0.735323,0.0995219,-0.124505,-0.785569,-0.105975,0.134364,0.35281,-0.965238,0.268501,-0.324435,0.624699,-0.817831,-0.150823,0.129639,0.168575,-0.484916,-0.859529,-0.205726,0.248332,-0.343633,0.461943,-0.683577,-0.216066,-0.292484,-0.597489,1.14564,0.651253,0.0671611,-0.0451862,0.402472,0.230951,0.233573,-0.25511,0.545561,-0.180003,0.231358,-0.0115494,-0.21796,-0.634938,-0.130404,0.720282,0.069806,-0.38785,0.95435,-1.02403,-0.0568781,-0.12558,-0.106283,-0.159587,0.126213,-0.103398,-0.379636,-0.42723,0.319157,-0.519963,0.251263,0.74645,0.0935662,0.0377063,-0.188976,0.0632312,0.0435344,0.588682,-0.0847179,0.25002,0.186808,-0.219128,-0.271153,0.295029,-0.797634,0.423835,-0.376237,-0.0400018,0.306312,-0.190118,0.126884,0.348532,-0.0362493,0.419128,0.0630558,0.172308,0.549711,0.0203924,0.533926,0.0394085,-0.200249,-0.848906,0.0577779,0.131364,-0.700681,-0.47182,0.0407388,-0.765117,0.821287,-0.111323,0.12634,-0.283208,-0.126772,-0.670177,-0.266121,-0.323019,0.0990477,-0.434499,0.795431,-0.0499317,-0.192374,-0.147339,0.320934,0.0782383,0.459968,-0.145861,-0.149273,-0.100259,-0.482267,0.0417132,0.277737,0.340217,-0.22253,-0.381297,0.191493,0.225374,0.437599,0.474736,-1.14124 +3404.54,0.937038,0.0912059,4,1.49847,0.863592,-1.25641,0.525929,0.706346,-0.026182,0.562269,0.237399,0.521118,0.133225,0.0299532,-0.525016,-0.158361,0.387057,-0.552374,0.384623,0.526424,0.202744,-0.309636,-0.00548256,-0.174244,-0.786554,-0.419054,0.0694048,0.204512,-0.193822,-0.329554,-0.188647,-0.375946,0.218727,0.723537,-0.378054,-0.19064,-0.0975807,-0.941139,-0.102473,-0.686617,0.383594,1.07261,-0.37156,0.989597,0.471928,0.113484,-0.381585,0.303383,-0.0622276,-0.196697,0.385164,0.122428,0.0955179,-0.0769286,0.811777,-0.23561,-0.540532,0.257947,-0.655313,0.0934939,-0.840643,0.273082,-0.376577,-0.0521251,0.830865,-1.25072,-1.28665,-0.24937,-0.617164,0.345331,-0.0444992,0.538047,-0.251421,-0.0843178,0.214638,0.401965,0.637404,0.882043,-0.244217,0.282694,0.508033,-0.167204,0.383876,0.251087,-0.128788,0.344843,-0.200594,0.190308,0.486851,0.230213,0.129847,-0.0384852,0.134884,0.584802,0.0474092,0.193774,0.0307089,-0.0120115,-0.121008,0.374019,-0.585105,0.727824,0.40546,-0.612553,-0.587501,-0.194244,0.044013,0.712515,-0.381638,0.198618,0.239992,0.383716,0.414095,-0.502958,-0.0843748,0.0467632,0.501209,0.478687,-0.306973,-0.417438,-0.00186487,-0.107176,0.00470652,-0.564794,0.353891,0.620018,0.655484,-0.404617,-0.0366582,0.19465,0.217491,0.34786,0.150025,0.506697,-0.209378,-0.514014,1.28289,-0.0413794,-0.54667,0.00182309,-0.408807,0.618197,-0.496217,-0.0701715,0.281634,-0.26154,-0.360913,0.240291,-0.901488,0.508058,0.394583,0.0253966,-0.180917,-0.0309859,0.770912,0.205782,-0.519758,0.16018,0.0727656,0.117702,0.111355,0.0829869,0.228483,0.01846,-0.463855,0.770454,0.449351,0.235371,0.0822487,0.18634,-0.568552,-0.188247,-0.235531,0.599628,-0.422844,0.25216,0.418775,0.0785562,0.312054,-0.162813,-0.23324,0.441777,0.790154,0.865535,-0.0467524,0.275815,-0.298572,0.579366,-0.930577,-0.16618,0.0327752,0.652042,-0.126352,0.0480689,0.260285,0.434795,-0.390948,0.155895,0.0897983,0.120474,-0.146354,-0.947129,-0.226458,-0.141991,-0.336225,0.296946,0.557868,0.780613,0.0226661,-0.361633,0.965895,-0.409332,0.0715611,0.00488572,0.257241,-0.117306,0.405827,-0.340091,0.357767,-0.274304,0.226964,0.494218,-0.250489,-0.0382978,-0.791329,-0.1285,-0.167313,-0.303772,0.334419,-0.530626,0.0808237,0.872981,-0.102071,0.175045,0.19707,-0.0503051,-0.0390554,-0.0928088,0.365394,-0.307879,0.16784,0.594764,-0.123501,-0.130529,-0.0143641,-0.511791,-0.00739773,0.425524,-0.33319,0.710772,0.304164,-0.341758,-0.440558,0.153466,-0.545109,0.106247,0.104133,-0.347428,0.201354,-0.0905243,0.278314,0.249426,0.16939,0.10512,0.642308,0.308971,0.283413,0.378091,-0.316632,-0.168254,-0.368406,-0.573194,0.536298,0.0659601,0.242303,-0.754024,-0.0389486,-0.703564,0.452083,0.0915079,0.185439,0.0396038,-0.160569,-0.645237,0.0510267,-0.476049,0.0928444,0.403374,0.119672,0.101733,-0.146112,0.630326,0.336461,0.0591014,0.129927,-0.329408,0.194153,-0.0154263,-0.388823,0.27202,0.0416728,0.204737,0.0664557,0.507476,0.147313,0.29688,0.383814,0.544867,-2.20533 +3386.3,0.751658,0.0912059,4,1.56697,0.702117,-1.34623,0.535431,0.449484,-0.00736758,0.379205,-0.349214,0.355684,0.414859,-0.0641658,-0.287562,-0.482004,1.02934,-0.05562,0.153735,0.455845,-0.00941693,-0.168625,0.0627245,-0.217274,-0.815186,-0.790539,0.395858,0.16905,-0.0743321,-1.22575,-0.0143644,-0.320066,-0.152715,0.80104,-0.525848,0.124981,-0.154206,-0.123861,-0.277878,-0.0912608,0.308328,0.575988,-0.531235,0.820029,0.543163,0.417002,-0.653325,0.0284918,-0.151766,-0.655233,0.241624,0.112049,0.0333076,0.041561,0.615974,0.0508044,-0.270613,0.426703,-0.520424,0.0183999,-0.667839,0.328622,-0.231254,0.227161,0.839925,-1.26445,-1.34978,-0.643308,-0.377025,0.267575,-0.0134639,0.138434,-0.608756,-0.0803424,0.450103,0.248229,0.351998,0.72057,0.105069,0.617048,0.179786,-0.0198954,0.282482,0.08454,-0.42685,0.202872,0.0555823,-0.404812,0.435692,-0.0484684,-0.806915,0.186772,-0.423883,0.398928,0.337134,0.701181,-0.0462921,-0.205931,-0.0137872,0.211167,-0.109115,1.03425,-0.0954939,0.524861,-0.188267,0.0455046,-0.286891,0.546588,-0.370785,-0.129805,-0.410767,0.170173,0.231059,0.056495,-0.0631369,-0.290272,0.760796,0.740115,0.262585,-0.21987,0.445471,-0.0680641,0.295131,-0.186524,-0.426471,0.080776,0.480437,-0.507122,-0.095094,-0.12686,0.445669,0.442733,0.316975,0.340494,-0.333884,-0.234146,0.946283,-0.513506,0.464877,0.0113431,-0.319874,0.285368,-0.561584,-0.578166,0.245478,0.0242685,-0.364071,-0.00268582,0.218534,0.599924,0.494594,-0.394154,-0.238151,-0.118017,0.732313,0.282091,-0.409163,-0.211195,-0.0523136,0.0309496,-0.566489,0.377245,-0.146303,0.0351159,-0.564443,0.20398,0.716697,0.172357,-0.345116,0.085361,-0.262623,0.0174841,0.141043,0.60988,-0.131434,0.0336671,0.0303944,-0.0379564,0.0984983,-0.0156735,-0.502929,0.633021,0.883225,1.35453,0.0874555,0.703349,0.371675,0.503819,-0.799727,-0.348167,-0.383197,0.37223,-0.323601,-0.37161,0.1335,0.633882,-0.425146,-0.106038,0.45303,0.0272053,-0.208062,-0.534358,-0.162899,0.112403,-0.533163,-0.0388911,-0.0465037,0.490779,0.138083,0.159931,1.05515,-0.393451,0.875966,0.319714,0.362512,0.199304,0.262856,-0.394608,0.456152,-0.0824235,0.0818817,0.933774,-0.0928194,-0.110424,-0.824104,-0.34517,0.0967774,0.0997529,0.54875,-0.0421549,0.455829,0.359226,-0.185503,-0.0412095,0.23319,0.203541,-0.0835331,-0.373971,0.347117,-0.359502,0.39841,0.46645,0.506335,-0.250417,-0.198501,-0.614583,0.218074,0.402343,-0.536673,0.460785,0.044318,-0.0476957,-0.777798,0.104089,-0.205136,-0.0940704,-0.213994,0.328812,0.100681,-0.0775518,-0.0835407,-0.667477,0.116927,-0.148096,0.0426856,0.503572,0.0129895,0.436081,-0.213912,0.102704,-0.139125,-0.66817,0.0575892,-0.33184,-0.311819,-0.299815,-0.261561,-0.136442,0.0658262,0.215513,0.285987,0.139895,-0.162438,-0.0370985,-0.267675,-0.980889,-0.184146,0.519492,0.0687088,0.0800007,-0.35217,0.191141,0.0339916,0.388588,-0.125805,-0.37161,-0.0443368,-0.152118,-0.541887,0.569981,-0.250359,0.0743223,-0.224821,-0.171496,0.16498,0.226509,0.406178,0.475929,-0.965135 +3413.1,0.757531,0.0912059,4,1.65064,0.888742,-1.387,0.484286,0.213621,0.0299669,0.0514499,0.166419,-0.0352473,0.224863,-0.266303,-0.742967,-0.472796,0.458701,-0.548068,0.193899,0.42413,-0.487551,-0.577142,-0.180883,0.010301,-0.355358,-1.13921,-0.251917,-0.0847296,-0.156329,-0.475941,-0.246667,-0.440623,-0.187218,0.519013,-0.412153,-0.222856,-0.186068,-0.735739,0.0423668,-0.0449936,1.06285,-0.146514,-0.382589,1.07699,0.330597,0.508554,-0.696164,-0.245449,-0.185869,-0.800727,0.320104,-0.0603405,0.0802636,-0.090879,-0.143598,0.293888,-0.0378899,0.283905,-0.438414,0.184419,0.111269,0.248691,0.282772,-0.151528,0.875103,-0.889442,-1.31137,0.0134085,-0.0685097,-0.0378997,0.711601,-0.136681,-0.452417,0.064032,0.44876,0.477748,-0.0335885,0.847011,0.200198,0.488138,-0.429938,-0.459459,-0.267118,0.0285681,-0.788903,0.526505,-0.200463,-0.636297,0.112379,0.227468,-0.604686,-0.0733926,-0.467351,-0.295388,0.428234,0.318082,-0.384196,-0.00685846,-0.93265,0.212256,0.140886,0.951203,0.253617,-0.246451,-0.272927,-0.126936,-0.372724,0.728153,-0.517437,-0.190861,0.222964,0.161996,0.967401,-0.140583,-0.326406,-0.0782296,0.433164,-0.0326289,-0.0590224,-0.625236,0.16095,-0.284346,0.169888,-0.782646,-0.520348,-0.527499,0.266488,-0.786272,0.110049,-0.131212,-0.0378261,0.588515,-0.225753,0.566788,-0.337639,-0.124537,0.6775,-0.44584,0.267224,0.238861,0.0588801,0.197764,-1.02229,-0.131251,0.29892,-0.420588,-0.420792,0.552072,0.135863,-0.132588,0.693447,-0.274175,0.0477154,-0.28054,0.373083,0.114213,0.0497037,-0.0317988,0.304941,0.863627,-0.0905342,0.134196,0.228776,0.189367,-0.0760675,0.707756,0.584188,-0.327193,0.571576,0.354643,0.0218356,-0.391561,-0.0579,-0.125326,-0.300533,0.22793,-0.0211316,-0.0729728,-0.71143,-0.046248,-0.29689,0.249844,1.01908,0.430553,-0.0858097,0.654582,-0.274459,-0.315339,-0.380458,-0.707767,-0.116057,-0.0313554,-1.11533,-0.390383,0.219578,0.541145,-1.03712,-0.0954532,0.208369,0.230724,-0.449266,-0.437127,0.657828,0.359296,-0.760037,0.122083,0.0864898,0.493478,0.110852,-0.28503,0.979147,0.308775,0.0531143,0.545178,-0.0862457,0.420097,-0.316782,-0.317385,0.450376,-0.396057,-0.218325,-0.125575,-0.717736,-0.176337,-0.211954,0.0146771,0.45595,-0.164745,1.04674,-0.412321,0.141435,0.513608,-0.166022,-0.371027,0.231394,0.0495477,-0.305864,0.197369,0.228141,-0.280182,0.479937,0.776505,-0.0159401,0.0593999,-0.595474,0.166448,0.11069,0.384037,-0.0777121,0.572741,0.359117,0.262856,-0.769679,0.385549,-0.11777,-0.0252517,-0.0977276,0.399116,0.113918,-0.523951,0.0103148,0.179611,0.0120583,0.220053,0.307184,0.567273,-0.488408,0.341291,-0.25606,0.0946803,-0.781501,-0.508284,-0.185095,-0.0266133,-0.232452,-0.337657,0.01484,0.288173,0.0445125,0.136952,0.383889,0.30411,-0.0750221,-0.152595,0.152324,-0.486254,0.0657659,0.403714,-0.112462,-0.227443,0.0117699,-0.0130065,-0.39658,-0.167197,0.264355,-0.50161,0.0431428,-0.315076,-0.301578,0.331552,-0.383025,-0.379411,-0.407136,0.00412829,0.15561,0.296807,0.394475,0.5448,-0.367806 +3400.15,0.796191,0.0912059,4,1.68417,0.876859,-1.32688,0.480302,0.32396,0.0248522,-0.0355154,0.122346,0.180768,0.179215,-0.345558,-0.797899,-0.49226,0.371398,-0.472076,0.23852,0.471104,-0.329883,-0.58101,-0.169103,0.0355703,-0.338565,-1.15364,-0.355164,-0.0195958,-0.0444926,-0.330852,-0.19109,-0.500453,-0.204592,0.683463,-0.528874,-0.275312,-0.132556,-0.667581,-0.00702392,-0.00428313,1.23761,0.0451918,-0.297507,0.956,0.351065,0.513267,-0.515841,-0.308801,-0.215532,-1.04041,0.52951,-0.0861429,0.223813,0.0564792,-0.0901668,0.240131,0.020105,0.239529,-0.41526,0.14514,-0.224548,0.36796,0.185207,-0.168556,0.905198,-0.863933,-1.14431,0.174013,0.0473859,-0.054073,0.575526,-0.0549363,-0.393185,0.0868283,0.356912,0.507273,0.211753,0.693938,0.00174517,0.504919,-0.374372,-0.345963,-0.370249,0.0484977,-0.865931,0.459356,-0.17135,-0.691719,0.245465,0.0726097,-0.9097,0.0330246,-0.447376,-0.22613,0.422916,0.247677,-0.549053,0.0401987,-0.618455,0.256189,0.0842951,1.09262,0.217434,-0.263039,-0.251076,-0.154185,-0.335024,0.454922,-0.481339,-0.107681,0.244577,0.185191,0.947028,-0.10947,-0.307562,0.105953,0.540828,-0.216615,0.0290844,-0.62179,0.120178,-0.233753,0.206623,-0.650934,-0.411106,-0.336546,0.423654,-0.631187,0.059262,0.169265,-0.0999754,0.674436,-0.0644085,0.619977,-0.342708,-0.147405,0.404779,-0.468029,0.108813,0.154887,0.0463911,0.169231,-0.80735,-0.0732344,0.238966,-0.554748,-0.429599,0.56854,0.066322,-0.0951622,0.674692,-0.361434,-0.0417869,-0.18154,0.531276,0.167214,0.173813,-0.20691,0.13313,0.900453,-0.0714065,0.127928,0.249656,0.221109,-0.126423,0.628124,0.505663,-0.31409,0.549337,0.433325,-0.115403,-0.558947,0.18236,-0.150318,-0.166601,0.254885,0.137016,-0.16912,-0.661833,0.00682845,-0.0890168,0.168089,1.01463,0.604623,-0.0152891,0.622939,-0.21773,-0.269499,-0.45403,-0.699285,-0.207039,-0.0440102,-1.30827,-0.409125,0.213802,0.431462,-1.09716,-0.204318,0.124832,0.221809,-0.537841,-0.556946,0.600891,0.363316,-0.859684,0.123067,0.0406557,0.435671,0.0702813,-0.442488,1.054,0.503694,0.135986,0.465086,-0.0110483,0.594947,-0.460005,-0.37887,0.432832,-0.150776,-0.310363,-0.0428516,-0.553364,-0.409338,-0.123123,-0.0832079,0.388035,0.0123327,0.907777,-0.344149,0.013237,0.494191,-0.178749,-0.268734,0.0163125,-0.0765289,-0.22338,0.155636,0.27636,-0.248716,0.542118,0.707584,-0.0587055,0.134337,-0.462715,0.391273,-0.011176,0.401256,-0.0316778,0.61068,0.379035,0.324484,-0.732208,0.257387,-0.111121,-0.0839491,-0.19013,0.170054,0.202782,-0.354097,0.143579,0.133912,-0.0209314,0.299955,0.313247,0.556719,-0.538042,0.35233,-0.314955,0.0841957,-0.875964,-0.480937,-0.274456,0.059029,-0.196724,-0.290467,0.118047,0.448717,-0.0750913,-0.127092,0.551229,0.378966,-0.0940566,-0.108651,0.182646,-0.522957,0.137325,0.494642,-0.0893419,-0.282288,0.0693052,-0.0544989,-0.398668,-0.214852,0.355636,-0.344897,0.0816765,-0.214135,-0.204597,0.202761,-0.271507,-0.425527,-0.206978,0.2249,0.159614,0.284406,0.399517,0.533297,-0.706099 +3390.34,0.880898,0.0912059,4,1.56517,0.821869,-1.74049,0.597154,-0.428532,-0.109174,-0.245992,0.0737983,-0.0547924,0.664197,-0.496453,-0.170196,-0.488106,0.688856,0.0105067,0.194027,0.631382,-0.48993,-0.323334,-0.184746,-0.277164,-0.747373,-0.776992,-0.0455903,-0.185506,-0.220549,-0.525293,-0.0979297,-0.371414,-0.281548,0.7694,-0.0335833,-0.310575,-0.20008,-0.748681,-0.188443,-0.438755,0.651804,-0.103444,-0.149766,1.19233,0.926578,0.693548,-0.841743,-0.195663,-0.130136,0.0190774,0.349265,-0.0541416,0.0744934,-0.098612,0.987181,0.247924,0.267805,0.328893,-0.463592,-0.00821476,-0.515741,0.0722123,-0.0835953,0.27325,0.764285,-0.905574,-1.16754,-0.310872,0.280818,0.532272,0.623672,0.173556,-0.347465,-0.615967,0.207279,0.683781,-0.0736343,1.29636,-0.104039,0.335365,-0.341531,-0.147446,-0.125753,0.405077,-0.503388,0.458481,-0.442412,0.216209,0.109398,-0.0869627,-0.752232,-0.447157,-0.493751,0.0383918,-0.289576,0.0600189,0.0767856,0.542687,0.335556,-0.16997,0.0130026,0.427685,0.272958,0.171141,0.48113,-0.720636,-0.549382,0.743431,-0.404638,0.114162,0.435045,0.0796114,0.78795,0.213524,-0.692625,0.0776066,0.414948,-0.0943842,0.480373,-0.856605,-0.0614833,-0.423876,0.402111,-0.644882,0.101587,0.0220856,0.778826,-0.339155,-0.282838,-0.560612,0.0792386,0.283637,-0.151356,0.0554017,-0.0346126,0.234844,0.246448,-0.481118,0.101638,0.101469,0.0218746,0.167139,-1.07827,-0.0707043,0.453195,-0.376098,-0.468116,0.562824,-0.0519436,0.599031,0.270585,-0.0861074,-0.432186,-0.394722,-0.232917,0.113803,-0.445902,0.452265,0.498936,0.716123,-0.0692966,0.0764066,0.248227,0.790786,0.0350462,0.78623,0.822102,0.155409,0.689397,0.375215,-0.438499,-0.71191,0.111877,0.100175,-0.342766,-0.126788,-0.236299,-0.255456,0.0197176,-0.243761,0.536432,0.142273,0.866341,0.712749,-0.0518727,0.610151,-0.0756329,-0.419579,-0.736719,-0.112463,-0.366426,-0.193048,-0.690971,-0.142684,0.251695,0.377748,-0.948694,0.022878,0.322536,0.220308,-1.035,-0.572732,0.413496,0.404197,-0.320588,-0.31606,0.277334,0.306185,0.502514,-0.394079,0.667453,-0.0128713,-0.35775,0.096357,0.250546,0.0783825,-0.427271,-0.288102,0.529429,-0.0217757,-0.0317751,0.263916,-0.969404,0.299046,-0.320082,0.55437,0.34921,0.278143,0.731933,-0.0501531,0.135767,0.241531,-0.313006,0.00509665,0.0916399,0.24703,-0.600339,-0.0466383,0.612128,-0.476372,0.465375,0.301157,-0.00966941,0.438241,0.159623,0.235886,0.21686,0.0843044,-0.725353,0.580685,0.0771778,0.121391,-0.795707,0.0997812,-0.137554,-0.178917,0.285746,-0.0637269,0.683308,-0.206829,0.00667346,0.317727,0.0615949,0.632178,0.345182,0.0967911,0.0198434,0.431903,0.109997,-0.125659,-0.192357,-0.452971,0.184979,-0.261438,-0.125344,-0.339702,0.888459,0.315176,0.0289632,-0.0601892,0.478679,0.164709,-0.357327,0.00365792,-0.270671,-0.113315,-0.210673,0.495692,-0.0342166,-0.0222273,-0.382764,0.0333072,-0.206365,0.14115,0.201934,0.363484,-0.0390053,-0.175007,-0.240588,0.0500536,-0.318703,-0.207073,-0.183435,0.0332222,0.167381,0.205507,0.409122,0.453328,1.91023 +3392.83,0.995262,0.0912059,4,1.582,0.671052,-1.97002,0.735676,0.357733,-0.143851,-0.258066,-0.350369,-0.437285,-0.257374,0.29235,-0.213001,-0.181444,0.409436,-0.585384,0.303102,0.564406,-0.195989,-0.170869,-0.38337,0.0870858,-0.478719,-1.02446,0.162251,-0.613544,-0.515101,-0.287571,-0.316068,-0.858714,-0.0775655,0.882365,-0.344315,-0.290161,0.226902,-0.68073,0.102822,-0.465608,0.645293,0.168377,-0.653674,0.668296,0.40281,0.216578,-1.00371,-0.218722,0.0211809,-0.663003,0.29777,0.367051,-0.0138482,0.342487,-0.150285,-0.168412,-0.520875,0.595006,0.0466009,-0.19726,-0.22769,0.175966,-0.308806,0.0685563,1.11247,-0.739829,0.295196,0.255643,0.0175661,-0.361837,0.0389122,0.0840318,-0.626555,-0.0790233,0.0539182,0.378855,0.39522,0.442765,0.29265,0.36703,-0.111645,-0.354256,-0.213489,0.205835,-0.79314,0.225838,0.323089,-0.517675,0.277166,-0.00453431,-0.414428,0.44771,-0.388227,-0.107302,-0.216016,0.12713,0.148224,0.0569208,0.482518,0.322173,-0.200662,0.406045,0.0813645,0.166634,0.125501,-0.142914,-0.65819,0.711204,-0.52329,-0.0084981,-0.216924,-0.0235317,0.352078,0.282067,0.0595594,0.0254387,0.240749,-0.164073,-0.186148,-0.638144,0.356672,1.11604,-0.0180371,-0.7439,-0.152957,-0.227815,0.319869,0.732677,0.249554,0.0833896,-0.503054,-0.27255,-0.806252,0.22753,0.0629268,0.27372,0.408676,-0.545488,0.072347,-0.189531,0.276886,0.184101,-1.19066,-0.0190615,0.244553,0.638169,0.104786,0.00527927,-0.303771,0.0430741,0.273309,-0.778569,-0.363028,-0.778997,0.16038,0.373091,0.33084,0.802816,0.329014,0.327007,0.790667,-0.0256879,0.236173,0.0239067,0.0922022,0.829456,0.0547559,-0.520144,-0.326377,0.163865,-0.494165,-0.259453,0.222367,0.171202,0.0145957,-0.114222,0.506349,-0.547037,-0.548812,0.104547,-0.585299,1.02859,0.654756,0.296054,-0.0484172,0.435831,0.145217,-0.0938456,-0.408991,-0.843398,-0.0579181,0.173271,-1.15269,0.201647,-0.155166,0.119268,-1.04146,0.144401,0.104231,0.182908,-0.198907,-1.48958,-0.303847,0.121994,0.528526,0.654969,0.376128,0.199889,0.274146,-0.6328,0.70814,-0.602269,0.221624,0.093504,0.0177804,-0.503675,0.320521,-0.0356001,0.378217,0.135399,0.164288,0.39966,-1.0184,-0.0828568,-0.757217,-0.75021,-0.482977,-0.0167317,0.535854,-0.333433,-0.200939,0.294558,0.384396,0.357535,-0.121978,0.27028,-0.145982,-0.574128,0.556382,0.293875,-0.0402805,0.662752,-0.505774,-0.613233,0.373572,0.438214,0.305912,0.555014,-0.280027,0.315289,0.13532,-0.0533902,-0.207255,0.0207774,-0.196597,-0.00204777,-0.0802229,-0.524235,0.764277,-0.390814,0.069679,0.425737,0.408412,-0.0887194,0.277117,0.145137,0.554329,0.436437,0.571778,-0.40585,-0.302485,0.328419,0.17701,0.192878,-0.0774052,-0.20681,0.437617,0.493395,-0.0299717,0.660513,-0.115049,-0.0923473,0.0129761,-0.0491445,-0.197174,-0.624644,0.475587,-0.135374,0.433211,-0.54621,-0.0829171,0.592275,1.05853,-0.204133,0.0761436,-0.349632,0.586904,0.30915,-0.605039,-0.210633,0.415965,0.290103,0.261456,-0.507426,0.176981,0.209878,0.420691,0.458125,-0.418626 +3426.33,0.776899,0.0912059,4,1.65786,0.601709,-1.2126,0.639712,0.758038,-0.257114,-0.302693,0.0212037,0.207061,0.66424,0.332076,-0.289297,-0.364812,0.676911,0.173035,0.233116,0.297625,0.120831,-0.0943566,-0.0940691,0.405676,-0.267689,-0.552749,0.775506,-0.307544,0.206625,-0.174522,0.0332724,-0.194485,-0.132517,1.10174,-0.612806,0.536723,0.460672,-0.317305,-0.507245,-0.338159,0.737768,0.518878,-0.599317,0.766627,0.60461,0.457153,-0.610729,-0.135056,0.133486,-0.111106,-0.182633,-0.142867,-0.380688,-0.0381453,0.611463,-0.0858666,-0.243679,0.248195,-0.439019,-0.221875,-0.585383,0.307235,-0.871933,0.329634,0.436208,-0.276382,-1.99113,0.317806,0.0967277,0.172439,-0.750237,-0.364958,-0.234914,-0.0644678,0.727894,0.704754,-0.11566,0.844913,0.0910853,0.172345,0.215482,-0.0176597,-0.0555975,-0.0140246,-0.0566967,0.192074,-0.118871,-0.240297,-0.19029,-0.114169,-0.0905373,0.255833,-0.714286,-0.674536,-0.416187,-0.0215164,-0.182655,-0.0364802,-0.351551,-0.455666,-0.476184,0.14752,0.267576,0.0965823,-0.31602,-0.305381,-0.0488059,-0.205219,-0.12286,0.49176,0.0570109,0.683937,0.112458,-0.141365,0.0966574,0.0471267,0.398528,0.174203,0.12824,-0.364896,0.0155954,-0.0528045,-0.428466,-1.33068,-0.442064,-0.236114,-0.76667,-0.519494,0.276777,-0.0959385,0.0320507,0.201513,-0.17372,-0.562958,0.0399013,-0.383168,0.834611,0.091096,-0.146955,-0.0267955,-0.22127,-0.0539745,-0.294535,-0.486825,-0.101801,-0.428383,-0.785831,-0.0506702,0.34252,-0.260211,0.394297,-0.0820384,-0.36669,-0.140257,0.204949,0.076162,-0.219645,-0.271205,0.0258032,0.0482463,-0.214983,-0.00868173,-0.157357,0.0923945,-0.144677,0.63905,0.187677,0.323893,-0.0854896,-0.140936,0.0418865,-0.38443,-0.578675,-0.0986278,0.241344,-0.0521771,-0.246453,0.0666133,-0.236095,-0.346219,-0.168922,-0.529786,0.862141,0.000665803,0.172155,-0.15287,-0.120666,-0.219486,0.172554,-0.263324,-0.373572,0.490006,0.343067,-0.157021,-0.150493,0.222761,-0.682293,-0.0156608,0.0977265,0.549636,-0.878942,-0.507766,0.389386,-0.0593861,-0.540726,-0.0897149,-0.23783,0.42718,-0.525456,-0.413888,0.568004,0.434926,-0.473046,0.235942,-0.197216,0.521507,0.00409649,-0.749881,0.384631,-0.0529617,0.171908,-0.24014,-0.522369,0.265509,-0.424251,0.764308,0.17431,-0.290874,0.475627,-0.344446,-0.371197,-0.0370723,0.128792,-0.192454,0.164784,-0.884285,-0.103609,-0.60832,0.481553,0.267812,-0.108265,0.554638,-0.228538,-0.123789,-0.48742,-0.22783,-0.31004,0.276512,-0.571717,0.3236,-0.0806688,-0.188176,-0.201205,-0.070466,-0.634704,0.673548,-0.185052,-0.301018,0.661705,-0.30703,-0.132111,0.0408864,0.142565,0.436122,0.0165919,0.177149,0.170534,0.060807,0.146096,0.168528,-0.0186169,-0.942808,0.0181414,-0.466614,-0.229986,-0.385481,-0.291046,-0.549957,0.0076546,-0.255499,0.311567,0.0503726,-0.123625,-0.273328,-0.404417,-0.346123,0.0383352,0.520932,0.542887,-0.0844245,0.656985,-0.183164,-0.479606,0.284886,-0.10241,0.454337,-0.59797,-0.114045,-0.325756,-0.428469,-0.706285,-0.397556,-0.112021,0.133979,0.128483,0.223404,0.358446,0.472657,-1.82774 +3407.76,0.803202,0.0912059,4,1.70853,0.663763,-1.12299,0.58351,0.680089,-0.142794,-0.0620603,0.109719,-0.276068,0.295184,0.258932,0.0611581,-0.500196,0.411896,0.118966,0.304323,0.0831132,0.322982,-0.259481,-0.116876,0.736652,-0.126231,-0.74118,0.519215,-0.014992,0.294198,0.034933,0.661055,-0.335297,-0.143465,1.15377,-0.623043,0.175257,0.203464,-0.401551,-0.525424,-0.194443,0.533739,0.315422,-0.443374,0.839823,0.0802226,0.714266,-0.603177,-0.215114,0.673727,-0.668991,-0.0758994,0.0411567,-0.624334,0.0138428,0.153752,-0.227966,-0.55563,0.217507,-0.757035,-0.599651,-0.277818,0.0880839,-0.835263,0.236087,0.691208,-0.691813,-1.222,0.0130294,-0.0504668,-0.175021,-0.482688,-0.159734,0.081481,-0.125472,0.109494,0.434231,0.243571,1.08578,0.535942,0.626105,0.635751,-0.00207824,-0.194735,0.32572,-0.389478,0.0936827,-0.22634,-0.287913,-0.347354,0.125798,-0.379181,0.333447,-0.682733,-0.370046,-0.589327,0.137259,0.118426,0.439457,0.14167,-0.266345,-0.440777,0.00237025,0.178371,0.465646,-0.474952,-0.333506,-0.0710068,0.293546,-0.585585,-0.18006,-0.0722387,0.381551,0.208021,0.0952463,0.263567,0.256094,0.45391,-0.167837,0.00778024,-0.347107,0.186513,0.0646984,-0.44359,-1.31142,-0.0138401,-0.700365,-0.815454,-0.472629,0.480739,0.605507,0.080407,0.0680215,-0.0924379,0.177235,-0.0280648,-0.589048,0.915766,-0.397995,-0.32312,-0.490326,-0.0587892,-0.122636,-0.434294,-0.147003,-0.105503,0.45519,-0.774609,-0.510134,0.290182,0.0100474,0.334312,-0.069853,-0.290486,-0.798632,-0.0326476,-0.200852,0.211739,0.362654,0.0479088,-0.289517,-0.044126,0.281209,-0.581655,0.0401825,-0.0586477,0.366587,-0.4428,0.317353,-0.180344,-0.434839,0.331201,-0.346016,0.0152666,0.118885,-0.0372602,0.136784,-0.241154,0.081061,0.286277,-0.161999,-0.234852,-0.309703,0.52164,-0.12556,0.255255,-0.397807,-0.0324047,0.112924,-0.101996,-0.571645,0.0380147,0.183771,0.339541,-0.27463,-0.112327,-0.396151,-0.0285456,-0.234266,-0.0850734,0.388565,-0.871313,-0.450375,0.588095,-0.151491,-0.876336,0.326832,0.409559,0.0265465,0.0703173,-0.146152,0.779182,0.347066,0.0363628,0.280256,-0.188316,0.572057,0.0928234,-0.697534,0.199911,-0.073482,-0.253866,-0.0373898,-1.07216,-0.22422,-0.525449,0.0407054,-0.0935968,-0.394173,0.399823,-0.623663,-0.150251,0.105304,-0.565013,-0.495638,0.10036,-0.949968,-0.173469,-0.548227,0.291437,0.748444,-0.377041,0.330034,-0.243626,-0.398212,0.0569129,-0.144287,0.170517,0.496547,-0.344706,0.227078,-0.0864146,-0.377675,-0.249625,-0.111966,-0.301199,0.578951,-0.392687,-0.369456,0.285446,-0.735579,0.269556,0.0933333,0.134784,0.0403263,-0.371853,0.0632103,-0.400416,0.187226,0.27895,0.119489,-0.291064,-0.0361811,0.295088,-0.160538,-0.414603,-0.3364,-0.273862,-0.234959,-0.245713,0.0812213,-0.0522964,0.281562,-0.23675,-0.320082,-0.444124,-0.242731,0.536723,0.627116,0.439677,0.221837,0.057789,-0.473321,0.195808,0.0383174,0.426449,0.182893,-0.0315073,0.381387,-0.25225,-0.0759314,0.11462,-0.120467,-0.514072,-0.0224997,0.137359,0.223597,0.37062,0.472861,-1.65037 +3424.42,0.913988,0.0912059,4,1.75968,0.948539,-0.729567,0.316707,0.486157,-0.220894,-0.0635695,-0.320018,0.0697301,0.046381,0.06005,-0.192141,0.149705,0.176561,-0.398636,0.932452,-0.0187426,0.113458,0.110383,0.0248833,0.143382,-1.29844,-0.817544,0.172134,-0.361572,0.0699135,-0.0826033,0.0883926,-0.44141,0.133284,0.804821,0.153886,-0.264197,0.0763567,-0.90239,-0.610737,-1.13767,0.0385478,0.51708,-0.390419,0.499528,0.248751,-0.202819,-0.899452,0.0134301,-0.964058,-0.702069,0.134714,0.239337,-0.193593,-0.193907,0.537124,0.0924256,-0.596842,0.113983,-0.111089,-0.0363693,-1.36167,-0.00814033,-0.842624,0.0296786,0.794194,-0.896994,-0.889058,0.125736,1.00091,0.248297,0.734748,0.577569,-0.587837,0.0210791,0.492673,0.602475,0.206664,0.269701,0.58879,-0.20275,0.0518002,-0.297609,-0.632551,0.515209,0.0196724,-0.0895303,-0.648623,-0.299509,-0.206713,0.0184479,-0.0375034,-0.233488,-0.221976,-0.132212,0.24852,-0.00721978,0.244621,-0.0718027,-0.551311,0.0866464,-0.407219,0.0990212,0.355296,-0.0787597,0.0392322,-0.596737,-0.537683,-0.236339,-0.21015,-0.171463,-0.164213,0.383253,0.481436,0.1362,-0.444988,-0.111324,0.436023,0.43043,-0.19328,-0.587269,0.338306,0.873716,0.157035,-0.846426,0.182866,0.476146,0.158418,-0.29357,0.13163,0.192241,-0.0210558,0.249462,-0.483798,0.185457,-0.0409561,0.375314,0.299788,0.313298,-0.352098,-0.241567,-0.36152,-0.140637,-0.640284,-0.16973,0.061404,-0.237313,-0.598128,-0.0828096,-0.19101,-0.58798,0.601259,-0.299123,0.177375,0.438741,0.376766,0.318529,-0.061025,0.352433,0.327691,0.180642,-0.182885,-0.22826,0.36197,-0.207892,-0.468517,0.423936,-0.087891,-0.0202024,0.423706,0.0662538,-0.0951721,-0.408611,-0.0347421,0.157575,-0.381748,-0.075286,0.053661,-0.231865,-0.57271,-0.67856,0.154248,0.340943,0.627123,0.179933,0.142438,-0.0851057,0.00651316,0.143245,0.0261299,-0.241965,-0.0274939,-0.178739,-0.862083,-0.248164,-0.347673,0.0032683,-0.40534,0.136311,-0.166076,-0.30405,-0.902443,-0.161502,-0.268639,-0.292046,0.00948309,-0.0761446,0.275764,0.094829,0.0706137,-0.38673,0.883834,-0.306172,0.805696,0.0439004,0.104141,0.054584,0.22025,0.35784,-0.0318842,0.056142,0.463378,0.491407,-0.091162,0.0178466,-0.459783,0.233577,0.225356,-0.576454,0.219803,0.0827327,-0.048812,-0.00916951,0.0852069,0.0559475,0.147806,-0.0766289,-0.729723,-0.538786,0.65751,-0.233999,-0.00143869,0.371708,-0.0298039,0.248127,0.0973079,-0.434709,0.00398451,0.421562,-0.207452,0.426105,0.175019,-0.108944,-0.244739,-0.124742,-0.249841,0.534744,-0.83894,0.151149,0.728507,-0.331588,-0.419957,-0.0213211,0.211597,0.489212,0.309988,-0.171812,0.0304716,0.0194025,0.228119,-0.258446,-0.212936,-0.185761,0.249427,0.522217,-0.274179,0.135753,0.237082,-0.0257014,0.301956,0.177087,-0.344524,-0.458572,0.1177,-0.759258,0.311631,-0.0118896,-0.0283996,-0.0103516,-0.0528383,-0.606698,0.262233,-0.0036627,-1.04109,0.283775,-0.144786,0.154462,0.177937,-0.0348572,0.023759,0.0297509,-0.0104877,-0.171645,0.052598,-0.375471,0.143394,0.241687,0.378674,0.491616,-1.39304 +3428.24,0.713058,0.0912059,4,1.66621,0.848867,-1.10265,0.482124,0.496655,-0.113832,0.228219,-0.206941,0.163412,-0.126125,0.0937889,-0.239759,-0.140777,0.346178,-0.499662,0.615096,-0.162065,0.166721,-0.183468,0.0407627,0.329737,-0.876263,-0.66531,0.373808,-0.283797,0.0847696,0.398984,0.667195,-0.500237,-0.108412,0.706602,-0.170532,0.0718626,0.154793,-0.956952,-0.253948,-0.638278,-0.353899,0.139653,-0.635389,0.905788,0.31665,0.206778,-0.851525,-0.426448,-0.984843,-0.740356,0.200082,0.0915995,-0.472189,-0.179255,0.768978,0.0677413,-0.0930229,0.237502,-0.254104,0.0528896,-0.796683,0.0791739,-0.777885,-0.0817291,0.769748,-1.24172,-1.146,0.129961,0.619017,0.222598,0.828045,0.44376,-0.337943,-0.0380474,0.774186,0.571016,0.36521,0.235829,0.410795,0.337472,-0.241014,-0.178255,-0.579093,0.171775,0.0463026,-0.0624161,-0.41014,-0.373389,-0.0467841,-0.199788,-0.278172,0.0139793,-0.281326,-0.446995,0.0415087,0.104019,0.358555,-0.162537,-0.399805,-0.167335,-0.208422,0.404123,0.117308,0.150101,-0.161979,-0.325881,-0.777033,0.164525,-0.452482,0.511208,-0.148344,0.324961,0.729249,0.183605,-0.398969,0.0499534,0.505442,0.0250861,-0.426187,-0.76446,-0.0330117,-0.0165336,0.220592,-0.651979,-0.250399,0.0256088,-0.170697,-0.696469,0.16035,0.439689,-0.0298073,-0.0183587,-0.462015,-0.111925,0.378413,0.249259,0.247905,-0.11199,-0.405221,0.0624752,-0.0480488,-0.162161,-0.577217,-0.266352,-0.241572,0.0240578,-0.465809,-0.0241713,0.249789,-0.13402,0.319275,-0.215513,-0.0154556,-0.132703,-0.280561,0.410861,0.271164,0.0921868,0.201659,0.426917,-0.153888,0.0669785,0.251812,0.515427,-0.0573898,0.128977,-0.119184,-0.119161,-0.239417,-0.619593,-0.31674,-0.705177,-0.510015,-0.0369869,-0.340269,-0.188665,-0.408958,-0.00683582,-0.714505,-0.581691,-0.250175,0.359189,0.314559,0.221183,0.137538,-0.231273,-0.140183,0.238585,0.0626387,0.0724935,-0.322852,0.249043,-0.516961,-0.312226,0.0166444,-0.576812,-0.291212,0.184612,0.647345,-0.255463,-0.543719,-0.0811803,-0.26789,-0.201089,0.247643,0.00825011,-0.0616041,0.371833,0.180803,-0.20206,0.851154,-0.0551282,0.686689,0.177988,0.444805,0.139489,0.0900931,-0.594059,0.0749408,-0.194833,0.113945,0.686796,-0.399842,-0.276879,-0.198127,0.204738,0.233483,-0.0271248,0.383602,0.157618,-0.308089,-0.150497,-0.0286387,0.268021,0.000287846,0.205706,-0.260122,-0.637452,0.741955,-0.288772,0.0382943,0.694256,0.232714,-0.0778611,0.218368,-0.341313,-0.180802,0.312158,0.480784,0.275266,0.0118276,0.0364918,-0.155379,-0.785744,-0.705635,0.382743,-0.75421,-0.261731,0.254121,-0.395679,-0.516264,0.0753002,0.0232073,0.330431,0.164498,-0.0821289,0.00351637,0.145449,0.107159,-0.0347346,0.220956,0.181613,0.0844814,0.475245,-0.204365,-0.0487543,0.279398,0.0826379,-0.0734426,0.200468,-0.111476,-0.18978,0.0239939,-0.581715,0.38019,0.0103528,0.272633,-0.0751907,0.243673,-0.352023,-0.257421,-0.155175,-0.877069,-0.0322265,-0.245488,-0.484063,-0.109257,-0.0473558,-0.111281,0.0955973,0.23026,-0.625681,-0.117433,-0.139879,0.110728,0.328888,0.332758,0.573487,-1.33276 +3427.18,0.917825,0.0912059,4,1.44641,0.92102,-1.04546,0.450885,0.775073,-0.111254,0.0290983,0.139556,0.226776,-0.182441,0.266326,-0.173986,0.0717938,0.691242,0.354599,1.2579,-0.0722285,-0.227049,0.221706,0.0605987,-0.140752,-0.319987,-0.201377,0.235207,-0.291241,-0.0145183,-0.116528,0.00208247,-0.113517,0.346819,0.58506,-0.36948,0.310877,0.386098,-0.280852,-0.10223,-0.137535,0.891623,0.430841,-0.463655,0.677708,0.275437,0.273616,-0.862544,0.00856668,0.8916,-0.162321,-0.0227371,0.317261,-0.253726,0.169961,-0.116508,0.00143028,-0.0216501,0.314173,-0.376819,-0.440998,-0.537942,0.595011,-0.0568512,0.1419,0.808519,-0.152398,-0.41578,0.0763811,-0.250004,-0.0537713,-0.250108,0.00212412,-0.3486,0.172671,-0.324846,0.263158,-0.860149,0.0989604,0.564464,0.521189,0.383482,-0.587472,0.240758,0.195529,-0.657135,0.390486,0.397163,0.089566,-0.286274,0.354494,0.224635,-0.0104262,-0.20986,0.198533,-0.225899,0.0287634,0.067062,-0.147292,0.22043,0.247559,0.069052,0.430229,0.724031,0.00613982,-0.114422,-0.450104,-0.0641676,0.0486866,0.14934,-0.00152902,-0.309518,0.439066,-0.318245,-0.11367,0.00502144,-0.144226,0.410958,0.142476,-0.0348334,0.185587,0.0771092,0.359409,0.190321,-0.646916,0.479606,-0.00551597,-0.298313,0.188537,-0.0403112,-0.16277,1.08843,0.403117,-0.122061,0.352849,-0.701849,-0.141036,0.256076,0.0103612,0.447891,-0.184627,-0.467167,0.458242,-0.424633,-0.161461,0.180402,-0.00241542,-0.371559,0.242537,-0.0822903,-0.0822663,0.203647,0.14028,-0.67581,-0.27196,0.506182,0.347328,-0.231894,0.515916,0.679152,0.0719734,0.467899,0.262616,-0.0920116,0.265499,-0.215182,0.610555,0.36075,-0.0530566,0.292851,0.330025,0.554962,-0.125959,0.608537,0.475956,-0.181905,0.0853577,0.261122,-0.257705,0.0549398,-0.0826662,-0.190904,0.0867195,0.913161,-0.205381,-0.224767,0.135178,-0.00600831,0.292197,-0.128109,-0.0971255,-0.274944,0.328851,-0.101681,0.0609016,0.086669,0.110451,-0.460234,0.0424138,-0.285915,0.267943,-0.327709,-1.29663,-0.154039,0.0418559,-0.176323,0.323415,-0.163589,-0.328147,-0.0183009,-0.788568,1.13112,-0.323751,-0.486804,-0.321786,0.0840023,0.0655038,0.49736,0.216211,0.610816,-0.0446954,0.507519,-0.0439596,-0.184019,0.135665,-0.792625,-0.162878,0.0980699,-0.448441,0.16936,-0.0641092,-0.4509,0.605169,0.0215761,-0.729309,-0.0273963,-0.154895,-0.39856,-0.124676,-0.11567,-0.197666,0.122613,0.187996,-0.450258,-0.160445,0.114682,0.0570089,0.234913,0.372694,0.265001,0.551863,0.247476,-0.554748,-0.568433,0.115415,-0.611714,0.552067,0.376514,0.0285734,-0.074799,-0.261182,-0.166896,-0.496292,0.0650279,0.255965,0.416408,0.0848009,0.355322,0.0181405,0.303747,0.215745,-0.150943,-0.702633,-0.0226789,-0.132434,-0.345698,-0.37828,0.0391849,0.301013,0.562914,0.217685,0.33817,0.142436,-0.0520273,0.0830379,-0.209057,-0.662829,-0.495914,0.189424,0.841079,-0.0544369,0.554757,0.355362,0.342895,0.219114,0.503612,0.643207,0.121218,-0.134234,-0.180457,-0.156553,-0.623856,0.206617,0.18279,0.168594,0.133286,0.148437,0.365084,0.385276,-2.60547 +3409.62,0.853752,0.0912059,4,1.58789,0.888251,-0.790481,0.259909,0.558097,-0.169365,0.276022,-0.186403,0.295828,0.35726,0.104407,-0.407879,0.432825,0.682533,-0.246921,1.28903,0.0895339,-0.331642,0.0153544,0.158364,-0.0781987,-0.613231,-0.368102,0.148648,-0.138333,-0.228447,0.102105,0.123776,-0.563531,-0.141801,0.60117,-0.666716,-0.150211,0.319963,-0.140312,-0.186336,0.0759997,0.198493,0.214671,-0.220514,0.633127,0.377033,0.572704,-0.642565,0.0336788,0.066131,-0.155611,-0.0999464,0.367798,-0.322406,0.173452,0.0889219,-0.0508589,-0.731527,0.830166,-0.0761049,-0.398848,-0.892034,0.494391,-0.597141,0.220653,0.719087,-0.449418,-0.379124,0.106718,0.169822,0.409613,-0.476837,0.157587,-0.53925,0.417546,0.035667,0.0122967,0.202232,0.22277,0.445317,0.585056,0.705787,-0.510927,0.167246,0.103076,-0.599216,0.152357,0.326693,-0.122531,-0.348523,0.447238,-0.426103,0.117608,-0.0259035,0.278233,-0.151226,-0.0852144,-0.307018,0.126625,0.355033,-0.236174,-0.0570896,0.20812,0.406297,0.136028,0.22718,-0.840867,-0.198637,0.109875,0.267741,-0.26857,-0.309197,0.085101,-0.0351646,-0.441996,0.103877,-0.278708,0.32634,-0.170869,0.0594914,-0.301078,-0.013942,0.146241,-0.133136,-0.579804,0.0419167,-0.120544,-0.138361,-0.0522917,0.24738,-0.0727167,0.879994,0.0837615,-0.0397362,0.249549,-0.5569,-0.276796,0.155013,0.0870293,0.24818,-0.480712,-0.650142,0.200062,-0.62497,-0.432701,-0.113463,-0.0263773,0.0419354,-0.236325,-0.040674,-0.407661,0.328334,0.0561719,-0.707416,0.00434478,0.387154,0.0252163,-0.121443,0.282227,0.458649,0.275155,0.597974,0.209032,-0.759311,0.116999,0.0306807,0.23253,0.0179121,-0.329294,0.519641,0.103419,0.275248,0.226748,0.241537,0.33611,0.207963,-0.221548,0.149548,-0.146671,0.478474,-0.206462,-0.395857,0.284831,1.10755,-0.0827319,-0.114034,0.0538977,-0.112727,-0.219211,0.0736965,0.0366652,-0.226984,0.837303,-0.0436948,-0.219452,-0.0599957,-0.307891,-0.145778,-0.437787,-0.359998,0.232144,-0.352101,-1.07042,-0.00258343,-0.231241,-0.187935,0.408645,0.151281,-0.523969,-0.244768,-0.803947,1.20386,0.345448,-0.244123,-0.0139123,0.0660203,0.5222,0.212958,0.105244,0.68858,0.112726,0.10022,-0.0946724,-0.398466,0.271623,-0.31481,-0.0995785,-0.146215,-0.200221,0.317585,-0.967154,-0.533371,0.525713,0.0462223,-0.967623,0.00594461,-0.111389,0.461721,-0.147107,-0.15882,-0.577256,0.474918,0.46024,-0.287104,-0.563866,0.337795,-0.405649,0.877907,-0.093905,0.360074,0.17897,0.413594,-0.528042,-0.595804,0.0822725,-0.840179,0.415961,0.23904,-0.060352,0.409559,-0.523662,-0.0248505,-0.293342,-0.165434,-0.0675425,0.241489,0.361988,0.103506,0.0842995,0.540809,-0.026618,-0.0440036,-0.801314,0.157001,-0.216174,-0.585202,0.0371356,-0.143795,0.205473,0.40211,0.529903,0.320471,0.14268,-0.219356,0.0523928,-0.149385,-0.707396,-0.440911,-0.238081,0.181267,-0.324602,0.652512,0.307097,0.287066,0.026062,0.300761,0.841454,-0.0373775,0.00309729,0.190363,-0.129232,-0.267261,-0.096408,0.156078,0.0597394,0.152118,0.156002,0.390023,0.39497,-1.62407 +3418.81,0.959625,0.0912059,4,1.56678,0.916181,-0.786109,0.386063,0.956364,-0.148154,0.138283,-0.170721,0.109345,-0.0402438,0.303695,-0.55701,0.200408,0.63158,-0.228542,1.02871,0.0891568,-0.135928,-0.376709,0.0147072,-0.0421884,-0.100566,-0.363701,0.430409,-0.280177,-0.019324,-0.0761118,0.489795,-0.44121,0.165192,0.468414,-0.132316,0.343296,0.355257,0.0189992,-0.477782,0.141861,0.330633,0.279395,-0.375154,0.627018,0.449074,0.587343,-0.5099,0.0462344,0.376217,-0.233146,0.132788,0.39351,0.0475987,-0.142846,0.5432,-0.0642417,-0.14328,0.409081,-0.264038,-0.312547,-1.11487,0.590878,-0.60168,-0.060172,0.432088,-0.687945,-1.18252,0.00187981,-0.229539,0.0507558,-0.390316,-0.0557403,-0.50148,0.120427,-0.0832222,0.0381227,0.257405,-0.123057,0.444266,0.214058,0.362968,-0.295539,-0.114423,0.266031,-0.135217,0.13319,0.110436,-0.285863,0.121242,0.0594608,-0.191902,0.454729,-0.140203,0.136593,-0.105082,-0.1189,-0.316118,0.00641314,-0.286185,-0.42875,-0.124925,-0.0764642,0.211192,0.473969,0.0467759,-0.780308,-0.272891,0.197664,-0.530238,-0.0557572,-0.518069,-0.243604,0.413324,-0.34089,-0.286571,-0.92672,0.490927,-0.243299,0.136078,-0.155541,-5.59018e-05,-0.12361,-0.0407867,-0.510512,0.30838,0.159005,0.242717,-0.181896,0.221688,0.0873658,0.23367,0.10528,-0.276049,0.233358,-0.113864,-0.0926793,0.110942,0.0240681,-0.352843,0.0733077,-0.273245,0.226073,-0.257335,-0.0554156,0.201179,0.59066,0.148983,-0.100588,-0.455313,-0.417466,0.401569,0.399907,-0.482363,-0.384945,0.612101,-0.0771335,-0.0255657,0.139493,0.464963,0.401081,0.0858329,0.281497,-0.431658,0.401191,-0.119114,0.264244,0.136182,-0.175642,0.365786,-0.0317451,0.357937,0.148909,0.294973,0.521288,0.0261023,-0.0241438,0.0771601,-0.0223199,0.0437252,-0.205832,0.121593,0.278191,1.23706,0.0808351,-0.217549,0.10713,0.0551068,-0.60501,-0.163104,0.150462,-0.197693,0.862439,-0.51075,-0.311933,-0.0668388,-0.802101,-0.775846,-0.399695,-0.29091,0.0784361,-0.326351,-0.997566,-0.0927625,-0.379475,-0.382877,0.343033,0.290175,-0.550599,0.324467,-0.441393,1.2751,0.384984,0.152187,-0.0230861,0.100073,0.454924,-0.223784,0.062461,0.609611,0.333712,-0.000253727,0.184436,-0.613317,0.313918,-0.292833,-0.242106,-0.209043,-0.491083,0.241653,-0.598332,-0.5032,0.26758,0.245686,-0.896062,0.300676,0.0338723,0.430299,-0.103058,0.312312,-0.716864,0.00843913,0.36969,-0.434439,-0.31956,0.710256,-0.0341344,0.36587,-0.283031,0.192036,0.791769,0.602768,-0.134911,-0.705396,0.339608,-0.655493,0.289516,0.114052,-0.206443,0.303618,-0.144139,-0.0924461,-0.416677,0.146136,-0.023388,0.466018,0.492573,0.705864,-0.239693,0.546165,0.111481,0.0206219,-0.457209,0.119588,-0.0613752,-0.451918,0.0219024,-0.244511,0.131155,0.186738,0.589628,0.00940848,0.0391759,-0.214925,0.020958,-0.343244,-0.552371,-0.448906,-0.341202,0.402979,-0.498862,0.719578,0.345451,0.576644,0.0304616,0.140161,0.0369376,0.439664,-0.239448,0.143083,-0.194281,-0.250091,0.0514767,-0.0844097,-0.000903172,0.135002,0.219642,0.367426,0.46866,-3.14396 +3402.86,0.998273,0.0912059,4,1.588,0.915881,-0.902281,0.406313,0.657105,-0.153119,-0.109692,-0.0690286,0.32574,0.406709,0.165276,-0.230195,-0.316265,0.13878,-0.0779559,0.58828,0.287033,0.129846,0.372483,-0.0596554,-0.0439945,-0.955997,-0.760901,0.162001,-0.657443,0.101819,0.355907,-0.0777116,0.012636,0.12703,0.452746,-0.826699,0.149186,0.591649,-0.387737,-0.830692,-0.440865,0.565188,0.545773,-0.162643,0.790573,0.20043,-0.220319,-0.298156,0.0963913,-0.640873,-1.38113,-0.148414,-0.00128334,0.0409074,0.0378307,-0.17882,0.0562743,-0.0290894,-0.0637371,-0.339156,-0.459631,-1.15396,0.425103,-0.357661,0.0996314,0.747112,-0.742412,-1.06947,-0.550256,0.612539,0.107982,0.633661,-0.0480724,-0.954477,-0.00703231,0.500313,0.587803,-0.210112,0.817119,0.127551,0.443751,-0.274553,-0.279102,-0.0465215,0.16562,-0.366032,0.166261,0.155246,-0.611201,-0.785378,0.0562181,-0.238369,-0.294382,0.126585,-0.137684,0.180228,-0.312612,0.202298,0.714722,-0.896255,0.427197,-0.452007,0.0315497,0.413623,-0.341178,-0.00838537,-0.495332,-0.312755,-0.162513,-0.0927975,-0.213762,-0.297734,0.439073,0.429427,-0.292616,0.241836,0.810115,0.673653,0.0441178,0.13017,0.0347174,-0.393028,0.242049,-0.428648,-0.301106,-0.37853,0.31479,-0.323587,-0.0481018,-0.0267225,0.419168,-0.220968,0.469492,-0.429712,0.0925901,-0.30408,-0.2495,0.616596,-0.840106,0.331788,-0.188223,-0.0460144,0.349988,-1.10744,-0.381025,-0.337723,0.0881996,-0.425705,0.157892,0.38324,-0.214833,-0.00694205,-0.182826,-0.0802373,-0.498744,0.112901,0.141713,0.233778,0.353088,-0.10146,0.164122,-0.0810244,0.0988139,0.545014,-0.38076,-0.356706,0.266813,0.279706,0.234914,-0.271527,-0.00479227,-0.37571,-0.222568,-0.0720086,-0.035147,-0.0692282,0.302652,-0.524183,0.139062,0.344168,-0.550597,-0.254814,0.115111,0.36165,-0.0573941,-0.215525,0.304552,-0.00542096,0.0357625,0.106564,-0.843555,0.252302,-0.103177,-0.32737,-0.00532173,-0.306677,0.0583973,-0.650731,0.355252,0.287758,-0.0157322,-0.360677,-0.371972,-0.170309,0.345002,-0.25298,0.0236708,-0.585868,-0.205865,-0.739125,-0.467764,1.09268,-0.351478,0.137127,-0.00355233,-0.442526,0.516437,-0.280538,-0.305411,-0.0643446,-0.491286,0.536022,-0.147766,0.0902699,-0.526355,-0.287908,0.842483,0.317932,-0.288125,0.467298,-0.114025,0.163351,-0.241723,-0.163134,-0.295919,0.158462,-0.161552,-0.302281,-0.864214,0.059484,0.179492,0.188656,0.8057,-0.678775,-0.354079,0.192785,-0.22974,0.306638,0.470362,-0.191341,0.137875,0.38561,-0.553516,-0.206605,-0.237784,0.157329,0.369202,-0.238888,0.175269,0.190592,-0.330691,0.124152,0.484891,-0.0056864,0.611308,0.118227,-0.404587,0.535615,0.569976,-0.0502481,0.479828,-0.235947,0.140228,-0.149341,-0.1486,0.812977,-0.178397,0.190318,-0.566131,-0.470198,0.209865,0.0530372,0.379291,-0.323476,-0.357066,-0.427188,0.481074,0.297649,0.290128,-0.0651314,-0.316583,0.225786,-0.66425,-0.863809,0.549256,0.140549,0.376998,0.350352,-0.114211,-0.808241,0.149849,0.343855,0.00554599,0.188832,0.0301374,0.12784,0.236371,0.357547,0.48618,-2.08566 +3400.69,1,0.0912059,4,1.56783,1.14457,-0.43569,0.0344782,0.867777,0.102993,0.175225,0.456308,-0.354289,0.133899,-0.24017,-0.402827,-0.0722756,-0.0605831,0.0547528,0.901609,-0.301773,-0.269959,-0.369984,-0.362018,-0.414637,-0.239611,-0.503484,-0.255759,-0.119988,0.00323478,-0.0850393,0.454935,-0.550491,-0.0122941,0.603029,-0.0994206,-0.0408802,0.153587,0.10256,-0.338256,0.223177,0.199948,-0.032432,-0.490983,1.08368,0.578757,0.49168,-0.525437,0.0141579,0.236924,-0.288787,0.251963,0.251586,-0.0318564,0.15079,0.652391,0.243256,-0.437269,0.606312,-0.192434,-0.393585,-0.744511,-0.0564993,-0.731065,0.200418,0.813124,-0.117888,-0.952705,0.330369,0.357486,-0.418962,-0.164832,0.0957035,0.126818,-0.00662705,-0.0401849,0.614792,-0.0995926,0.35986,0.629444,0.612251,0.183033,-0.260099,-0.02272,0.212176,-0.79761,0.214088,-0.071249,-0.159982,0.447563,-0.0248373,-0.0325133,0.208023,-0.681888,0.246827,0.379957,0.220788,-0.276418,0.331341,-0.560661,-0.558627,-0.0904482,0.560651,0.313032,0.481952,-0.606104,-0.662547,-0.66149,0.842423,-0.228014,0.55188,0.0676778,-0.0389274,0.638438,0.0734836,-0.685958,-0.953555,0.650817,0.236651,0.18423,-0.315746,0.544458,0.104248,0.209996,-1.1425,0.345375,-0.408166,-0.471311,-0.464536,0.204361,0.212045,0.292332,-0.101963,-0.618394,-0.0377956,0.30714,0.17735,0.0515155,0.443238,-0.396838,0.147091,-0.251002,0.29801,-0.590331,0.232348,0.185015,0.290056,-0.458357,-0.0710996,-0.0317285,0.188244,0.356132,0.0847948,0.138288,0.324594,-0.099217,0.125401,0.385814,-0.147329,0.59799,0.513127,0.323338,0.230744,-0.694727,0.42664,-0.0381721,0.829815,-0.591338,0.0560419,0.454242,0.0548394,0.0751871,-0.212299,-0.023502,0.0831357,0.0389659,0.20851,0.154273,0.0211989,-0.223277,0.0199808,0.284274,0.252115,0.905572,-0.306953,0.319253,0.106774,0.0534502,-0.275538,0.10051,-0.471486,-0.851107,0.590314,-0.0554906,0.106488,-0.0727328,0.0348542,-0.536265,-0.193399,-0.106753,-0.101263,-0.212845,-1.21907,0.240574,-0.477498,-0.0384174,0.320895,0.292099,0.356239,0.619221,-0.679481,0.947212,0.237938,0.675788,-0.217695,0.0280977,0.53686,0.104492,-0.219196,1.03947,-0.57021,-0.125854,0.557515,-0.377545,0.0377211,-0.891274,-0.161261,0.191427,-0.52617,0.530484,-0.521799,-0.887104,0.326732,-0.0320171,-0.277567,0.0468321,-0.785151,0.0432173,0.101279,0.788382,-0.139702,-0.00340827,0.0573714,-0.171035,0.379976,0.0121516,0.123227,-0.155362,0.809571,-0.622152,0.589549,0.00969352,0.207525,-0.467111,-0.51459,-1.00854,0.263434,0.0172053,-0.321943,0.0706298,-0.353322,-0.378406,0.120394,0.0788069,-0.228448,0.167096,0.838218,0.0284446,-0.0567974,0.0654541,-0.394737,0.195869,-0.40233,0.0357317,-0.578253,-0.481664,-0.734728,-0.402753,0.366185,0.247585,0.106722,-0.35815,0.372733,-0.00586755,-0.189021,-0.120304,-0.138396,-0.687987,-0.0224591,0.511185,0.11183,0.265826,0.552361,-0.25117,0.166946,-0.242331,-0.0110802,0.293187,-0.155114,0.178256,-0.494224,-0.552732,-0.709799,-0.634087,0.00885672,0.155112,0.142685,0.393843,0.377737,-3.16607 +3412.05,0.978487,0.0912059,4,1.66547,1.02417,-0.924064,0.25762,0.811516,-0.0334569,-0.240265,-0.223141,0.599531,0.618076,-0.48507,-0.249982,-0.274126,0.167661,-0.40246,0.820298,-0.474431,-0.289615,0.515317,-0.202489,-0.400846,-1.02575,-0.824379,-0.624582,-0.102901,0.149053,-0.112055,0.361237,-0.477059,0.0411722,0.669664,-0.633326,-0.377829,0.104446,-0.338729,-0.343188,0.0159892,0.564227,-0.0226814,-0.272606,0.800789,0.265826,0.135664,-0.147215,0.0168489,-0.14495,-0.289531,-0.407244,0.448309,0.373832,0.0238189,0.129224,0.0961952,0.0192029,0.900621,-0.308888,-0.432901,-0.26286,0.363526,-0.0199562,0.338271,0.982181,-0.935358,-0.400909,-0.0180031,0.4406,-0.73228,0.481044,-0.0584108,-0.35054,-0.0433654,0.398755,0.598914,0.221648,0.645907,0.631576,0.458732,-0.0183751,-0.180367,0.0166024,-0.114573,-0.134196,0.624512,-0.20242,-1.03275,0.168629,0.450727,-0.276616,-0.0833668,-0.439065,-0.00492027,-0.0922276,-0.294599,0.00955249,0.236448,-0.201277,-0.182964,0.420106,0.316373,0.129317,-0.603605,-0.248695,-0.173021,0.314774,0.0086664,-0.661433,-0.147002,-0.360695,0.243943,0.430294,-0.303729,-0.459128,-0.0729838,0.0462516,-0.0940904,0.516781,-0.809357,0.118817,0.390714,0.290425,-1.15654,0.342803,-0.0869148,0.192853,0.308186,0.360817,-0.0326075,-0.143792,0.577803,-0.838323,0.0399941,-0.148389,-0.618954,0.532523,0.0414418,0.195131,-0.771549,-0.0190804,0.151461,-1.04523,-0.113065,0.216706,-0.311192,-0.294106,0.368228,0.19571,0.0592386,0.314378,-0.179022,0.00350495,-0.349187,0.0288791,0.100995,0.222975,0.326609,0.427597,0.669714,0.291323,0.063779,0.239852,0.430614,-0.651534,0.478707,0.181493,-0.12899,0.841788,-0.081241,-0.363265,0.245931,0.395659,0.0736788,-0.0830434,-0.320618,0.472113,0.553111,-0.37886,0.0506495,0.235242,-0.201021,0.558953,0.460004,-0.442494,0.220976,-0.642535,-0.512089,-0.387619,-0.431307,0.0986567,-0.237873,-0.397007,-0.150299,-0.0546266,0.123479,-0.114687,0.228374,0.140638,-0.0474518,-0.596561,-0.5755,0.3635,0.578504,-0.510075,-0.415525,0.132499,0.117104,0.524233,-0.74808,0.698994,-0.172902,0.701096,-0.161667,-0.0959117,0.205832,-0.319157,0.529138,0.781129,-0.261021,0.221984,0.354441,-0.573883,-0.629633,-0.917876,0.192084,-0.0891753,-0.514858,0.223711,-0.35477,-0.515149,0.461286,-0.0159417,-0.401297,-0.0465956,-0.255086,0.378521,-0.65459,0.610874,-0.14885,-0.323901,0.935474,-1.14396,-0.401706,0.191958,-0.0912103,0.197305,0.19415,0.379317,0.115803,0.467036,-0.470707,-0.635965,-0.690246,-0.832609,0.446635,-0.0567111,-0.678218,0.313255,-0.35463,0.169531,-0.361597,0.103156,0.0355015,0.205088,-0.621046,-0.149515,0.253743,0.136335,-0.380554,-0.488876,0.248611,-0.131438,-0.0585273,0.167356,-0.474091,0.256886,0.248183,0.310595,-0.260658,0.215172,0.0845625,-0.251981,-0.270808,-0.10645,-0.419966,0.348435,0.0352844,-0.129405,-0.673792,0.430478,-0.384173,-0.153957,-0.410865,-0.194775,-0.0136105,-0.0881696,-0.207754,-0.549224,-0.0619656,0.344783,-1.105,-0.368406,-0.390417,0.15909,0.189492,0.398861,0.435307,-2.5897 +3408.72,0.975594,0.0912059,4,1.65641,0.986157,-1.18109,0.345949,0.742136,-0.065992,-0.28886,-0.263634,0.587984,0.673101,-0.348741,-0.149079,-0.230263,0.00648244,-0.445344,0.769398,-0.580619,-0.237655,0.554777,-0.257612,-0.349893,-0.965772,-0.820128,-0.648951,-0.0777525,0.126107,-0.123665,0.272485,-0.534623,0.180041,0.641137,-0.595453,-0.300468,0.180302,-0.264555,-0.391034,0.181513,0.623035,0.0227559,-0.304827,0.844961,0.157328,-0.0267873,-0.136981,-0.106715,-0.223521,-0.157853,-0.433915,0.48104,0.350356,0.0618177,0.086691,0.122858,-0.0713044,0.85638,-0.210475,-0.404692,-0.460421,0.237788,-0.0630581,0.4397,0.994747,-0.824461,-0.484458,0.0326759,0.425216,-0.681506,0.637707,-0.0692195,-0.314054,-0.115717,0.354452,0.567701,0.317227,0.545072,0.732515,0.394269,0.0213814,-0.137379,0.0435579,-0.0719698,-0.190427,0.636116,-0.257653,-0.862256,0.236068,0.294878,-0.179109,-0.117023,-0.44274,-0.00702804,-0.152869,-0.275414,-0.0316847,0.138414,-0.217351,-0.00545719,0.304713,0.253644,0.163775,-0.604426,-0.28091,-0.281745,0.248664,0.0676808,-0.544635,-0.0754759,-0.298931,0.401571,0.41416,-0.169066,-0.407091,-0.0996363,0.149589,-0.0252523,0.472397,-0.747922,0.111165,0.299783,0.272413,-1.20866,0.466288,-0.138036,0.21789,0.122209,0.37761,-0.0129186,-0.288199,0.586253,-0.748125,-0.0155178,-0.17126,-0.497821,0.598913,0.0850822,0.0821693,-0.704217,0.0723781,0.294916,-1.06171,-0.242262,0.260388,-0.239825,-0.161874,0.367918,0.0399559,0.0980927,0.346698,-0.287697,0.0693407,-0.274806,-0.0122152,0.0407338,0.130854,0.391427,0.364251,0.766849,0.371703,0.0488135,0.231808,0.376568,-0.664975,0.486178,0.124665,-0.0820646,0.787056,-0.0462995,-0.329877,0.145642,0.472068,0.0147648,-0.118678,-0.358178,0.536527,0.587947,-0.38055,0.0434399,0.19122,-0.263225,0.519344,0.335072,-0.493366,0.15313,-0.544308,-0.729599,-0.4249,-0.593663,0.102263,-0.299476,-0.43295,-0.103044,-0.17,0.205307,-0.177798,0.270949,0.0309288,-0.0185358,-0.628749,-0.544636,0.41732,0.61066,-0.482351,-0.414965,-0.0577699,0.177097,0.603952,-0.608792,0.702473,0.0186822,0.775793,-0.0391835,-0.120228,0.292991,-0.384283,0.648484,0.678298,-0.321117,0.252127,0.365415,-0.631712,-0.578458,-0.917907,0.167906,0.000875104,-0.634393,0.324072,-0.32276,-0.486126,0.462975,0.0201228,-0.365724,-0.0436895,-0.209146,0.358869,-0.572223,0.521977,-0.120589,-0.128116,0.816413,-1.14053,-0.437723,0.263333,-0.134906,0.154989,0.135124,0.31406,0.169642,0.398646,-0.536716,-0.558148,-0.728213,-0.838729,0.44729,0.0206279,-0.649201,0.407796,-0.415957,0.288354,-0.382533,0.0839534,0.0396491,0.128689,-0.661946,-0.332753,0.276218,0.108894,-0.422664,-0.36298,0.422284,-0.0867315,-0.0317685,0.229752,-0.492434,0.226127,0.263473,0.147324,-0.192584,0.28427,0.0915624,-0.329314,-0.127095,-0.0294168,-0.460172,0.288197,0.0420631,-0.191345,-0.599581,0.401956,-0.429843,-0.150997,-0.512224,-0.0576677,-0.0378327,-0.120797,-0.183781,-0.538738,-0.0472462,0.320166,-1.25983,-0.419469,-0.441482,0.161878,0.175871,0.402341,0.41937,-2.24181 +3409.63,0.768661,0.0912059,4,1.59924,1.07428,-0.87641,0.239561,0.983833,0.0401639,-0.116863,-0.323239,0.651697,0.262135,-0.352619,-0.221904,0.143653,0.0492029,-0.342783,0.704831,-0.060192,-0.0751009,0.0201217,-0.332754,-0.660658,-0.551355,-0.856184,-0.413746,0.00795094,-0.240839,-0.014068,0.195089,-0.215714,0.0482033,0.755377,-0.181556,-0.215413,0.0357557,0.14099,-0.527203,-0.0635625,0.374357,0.564705,-0.164387,0.906833,0.177615,-0.111246,-0.473826,-0.108863,-0.143132,-0.313774,-0.164748,0.213195,0.277723,0.187926,0.408792,0.213881,-0.291194,0.691834,-0.153889,-0.551256,-0.416991,0.523544,-0.0850349,0.209033,0.9287,-0.382348,-0.952307,0.0258684,0.281611,-0.552758,0.0944473,0.111563,-0.524548,-0.0256035,-0.172478,0.60156,-0.038246,1.00785,0.148271,-0.229537,0.171925,-0.455815,0.0138896,0.243571,0.130049,0.594791,-0.228163,-0.146828,0.184622,0.243515,0.08412,0.363704,-0.586182,-0.165837,0.117382,0.232393,-0.147811,0.576083,0.21236,-0.119885,0.0248752,0.26273,0.467798,-0.0554748,-0.440048,-0.366524,-0.0421883,0.51204,-0.223539,0.365663,-0.433598,0.184557,0.32904,-0.248315,-0.538704,0.0336231,0.288929,-0.402586,-0.131246,-0.626659,-0.296662,-0.258587,0.306327,-1.20654,-0.0616596,0.0465842,-0.00859449,0.212386,-0.00898784,0.242428,-0.359566,0.135711,-0.507086,-0.306501,0.114494,-0.185965,0.233871,0.0479785,-0.135806,-0.367328,-0.0253909,0.439529,-1.36627,-0.271429,-0.0281834,0.0180028,-0.030824,0.552963,0.247534,-0.085804,0.320531,-0.548545,-0.0389659,-0.936034,0.050636,-0.110012,0.152386,-0.0199575,0.289323,0.715596,0.664814,0.166446,0.367621,0.201044,-0.429014,0.705238,-0.186512,0.0244871,0.20689,-0.274982,-0.609005,-0.520285,0.188292,0.204402,0.510022,-0.16135,0.0647441,0.818207,0.181586,-0.38406,0.176572,-0.264843,0.887074,0.169144,-0.383294,-0.412317,-0.730976,-0.648791,-0.500739,-0.340828,0.18717,0.420024,-0.727426,0.0450158,0.306521,-0.351924,-0.462544,-0.0844339,-0.513967,-0.0415022,0.272509,-0.301644,0.38684,0.0661692,-0.400306,-0.106778,-0.616519,-0.387715,-0.445074,-0.629573,0.683005,-0.77663,1.26135,0.0615116,-0.404441,0.277766,-0.0625405,0.545775,0.520602,-0.151755,0.0725051,0.245718,-1.10211,-0.180382,-0.636136,-0.0322388,-0.00174775,-0.471979,0.240236,-0.475333,-0.53483,0.731656,0.231822,-0.744315,-0.15627,0.0159263,0.309694,-0.117963,0.698951,-0.232155,0.208572,0.378423,-0.983417,-0.385355,0.335001,-0.00649884,0.117011,0.388659,-0.0848384,0.724057,0.14896,-0.423769,-0.71493,-0.525485,-0.88659,0.27842,0.248943,-0.237434,0.0136117,-0.524021,-0.492824,-0.404357,-0.244074,-0.199287,0.169802,-0.387841,0.00130151,-0.149046,-0.313096,-0.220925,0.0669394,0.247355,-0.0496306,-0.551343,0.19831,-0.735747,0.296397,0.235849,0.310404,0.0909511,0.355002,-0.192996,0.171335,0.0338558,-0.325485,-0.622114,0.589032,-0.0230106,0.116807,0.0857542,0.617784,-0.306412,-0.297559,-0.128565,0.310765,0.229002,0.434601,-0.231423,-0.742206,0.363986,0.169948,-0.173415,-0.550129,-0.378548,0.182629,0.265872,0.427351,0.515628,-3.3429 +3396.2,0.409103,0.0912059,4,1.47245,0.971768,-0.940876,0.284352,0.840008,-0.00337061,-0.0255015,0.510492,0.625446,0.267069,-0.391571,-0.866581,0.480233,0.269469,-0.108958,0.799778,0.0199386,0.171529,0.144066,0.0276772,-0.449646,-0.887156,-0.97592,-0.0786252,-0.344009,-0.126592,0.243745,0.548139,-0.696004,0.173796,0.762889,-0.901806,0.265614,0.152537,-0.179564,-0.118169,-0.308137,0.593375,-0.339047,-0.177144,1.00141,0.541622,0.596986,-0.280409,0.306486,0.748631,-0.115208,0.141904,0.692703,0.269626,0.308553,0.703019,0.203546,-0.927281,0.86166,-0.257945,-0.299278,-0.970028,0.512518,-0.120398,0.466571,1.37773,0.279578,-1.61066,0.703228,0.619068,-0.694289,-0.784927,-0.186755,0.277185,0.23299,0.111394,0.43701,0.0192264,0.686759,0.545525,0.432153,-0.411742,-0.532789,0.386229,0.45716,-0.952537,0.34348,-0.216139,-0.0714197,0.0184661,-0.274013,0.707314,0.00930158,-0.53234,0.117841,0.0349381,0.181811,0.0565596,-0.283395,-0.099898,0.394784,0.130684,0.370584,0.45559,0.0312028,0.189579,-0.198018,-0.675856,0.265697,0.218077,-0.331926,-0.381598,0.269938,0.297612,-0.397665,-0.128449,0.541349,0.313429,0.236163,0.424518,-0.802903,0.427648,0.450357,0.0638433,-0.535972,-0.592512,-0.136446,-0.334982,-0.244653,0.391408,0.183276,0.198506,0.900624,0.529771,0.138554,0.102605,0.404501,0.660703,-0.443295,-0.227172,0.3301,-0.102867,0.674863,-0.328583,-0.0151502,0.275402,0.077324,-0.505402,-0.202561,0.628843,0.257248,0.30265,-0.146565,0.0538121,-0.383794,0.0264395,0.461385,0.322223,0.432553,0.00348695,0.259458,0.123409,0.285303,0.18023,0.388491,-0.0121911,0.608143,-0.429858,0.230834,0.371045,0.341269,0.38395,-0.230281,0.321766,0.174665,0.205886,-0.0540331,-0.058856,0.25208,-0.302305,-0.257814,-0.261893,-0.192708,0.308722,-0.330243,-0.302773,-0.829815,-0.181957,0.211159,-0.297442,-0.455778,-0.0845971,0.514357,-0.329096,-0.200876,-0.120913,-0.350197,-0.620748,0.00389607,0.151324,0.355181,-0.465719,-0.462166,0.124074,0.161624,-0.526578,0.710627,0.0107229,0.22582,-0.158623,-0.564046,0.877435,0.0779806,0.181505,0.401858,-0.127337,0.676623,-0.185697,0.43935,1.24194,-0.795821,0.327477,0.193399,-0.1699,-0.142456,-0.980261,0.21452,0.228585,-0.633325,0.184955,-0.621129,0.0509853,-0.17551,-0.0120784,-0.734113,0.0969403,0.64158,-0.102747,-0.692512,0.472554,0.14811,-0.220114,0.431141,0.00692357,-0.366024,0.227716,0.491133,-0.386918,0.501659,-0.124633,0.42844,0.218075,-0.178966,-0.0470579,-0.388763,-0.422856,0.18914,-0.465264,-0.250966,-0.176339,0.142283,0.0988575,-0.122655,-0.315686,-0.497425,0.234241,0.362826,0.428895,0.161807,-0.141952,-0.05465,-0.234321,0.0848531,0.0860858,-0.358805,-0.172776,-0.298141,0.544185,-0.354114,0.13983,-0.27198,0.495834,0.223753,-0.105781,-0.0677097,0.302155,-0.202899,0.514972,0.236473,-0.0475448,-0.394268,0.215253,0.287584,-0.0571345,-0.17484,-0.73612,0.807079,0.171817,-0.91773,-0.734661,0.0510671,-0.147893,-0.0769041,-0.685578,-0.712545,0.160216,0.242265,0.40027,0.492204,-2.80871 +3400.03,0.708795,0.0912059,4,1.58493,1.03914,-0.37956,0.120912,0.892711,-0.0368057,-0.0530109,-0.13465,0.137972,0.534118,-0.135703,-0.298729,-0.296965,0.0488825,-0.162793,0.879546,0.176863,0.126128,0.285189,-0.431628,-0.360011,-0.863139,-0.145116,-0.0069261,0.0807554,0.310717,-0.116354,0.554315,-0.52088,0.229428,0.651824,-0.409474,0.480569,0.247766,-0.138845,-0.163359,-0.0783115,0.306186,0.46483,-0.639533,0.556033,0.457171,-0.205219,-0.918501,-0.219425,-0.0858474,-1.1767,0.00204627,-0.0030293,0.0343536,-0.288366,0.543593,-0.345098,-0.445,1.10285,-0.844942,-0.456555,-0.312071,0.592502,-0.475832,0.257864,1.23677,-0.368304,-1.08849,-0.058212,-0.0506968,-0.0381039,0.61319,-0.207852,-0.379022,0.172328,0.164584,0.923946,-0.294125,0.683394,0.589266,0.0950325,-0.044905,-0.0232447,0.566971,0.410944,-0.684382,0.167704,0.109011,0.124486,-0.139299,0.0647191,0.307446,0.194726,-0.0622332,0.20398,0.0703149,-0.0496377,-0.0537972,0.378477,-0.715568,0.156945,0.467495,0.138667,0.70738,-0.124445,-0.307054,-0.242082,0.0712666,0.212855,-0.0388752,0.00803555,-0.163077,0.10931,0.298319,-0.310587,0.49565,0.409652,0.037951,0.402975,0.442733,0.108184,-0.259391,-0.0681299,-0.00755288,-0.793123,-0.815474,-0.561935,-1.13792,0.468283,0.357167,0.0888791,0.449311,0.26896,0.142916,-0.44852,0.214152,-0.00626082,0.0402407,-0.546146,-0.0628638,-0.899838,0.196949,0.685719,-0.529232,-0.450837,-0.0734585,0.103569,-0.81398,0.339804,-0.207366,0.122326,0.259207,-0.0382599,-0.428096,0.203109,0.254621,-0.117137,-0.874464,0.558955,0.227205,0.788824,0.104068,0.307521,0.000176174,0.312239,0.362914,0.867997,-0.502241,-0.0946661,0.226612,-0.215291,-0.441858,0.0759988,0.228811,0.319836,0.302604,-0.420566,-0.0442378,-0.692072,0.0931266,-0.0973578,0.291809,0.123307,0.538608,-0.252247,-0.212439,0.349636,-0.239825,-0.251712,-0.0616213,-0.677107,-0.255012,0.192999,-0.397114,-0.0764964,0.216353,0.827943,-0.485891,0.0261864,0.0888065,0.144679,-0.0852349,-0.70623,0.148673,-0.0120397,-0.265994,-0.768144,0.335163,-0.379452,0.33021,-0.338571,1.07076,0.557777,0.333212,0.261195,0.0167303,-0.0891721,-0.195119,-0.406937,0.1191,0.10536,0.548644,0.600465,-0.695825,0.22892,0.0607027,-0.239136,-0.116564,-0.0762853,0.663959,-0.30852,-0.0793326,-0.393162,0.481624,-0.213438,-0.396589,0.229777,0.172979,-0.343394,0.361269,-0.456388,-0.0191092,0.201212,-0.429378,0.166994,-0.306002,0.374675,0.387587,0.0915381,0.154267,0.72643,0.738511,0.192568,-0.158799,-0.510573,-0.592879,0.568738,-0.764816,-0.282648,0.597776,-0.797669,0.156706,0.0902671,0.421178,0.592183,0.303179,0.133095,0.0846682,-0.0936829,0.0579384,0.129596,0.164527,-0.563779,-0.0438273,-0.362523,-0.204732,-0.40717,-0.127694,0.902939,0.39659,0.471567,0.0658918,0.444499,-0.00976384,-0.221909,-0.642524,-0.422933,-0.285971,-0.249242,0.582923,-0.0141268,0.390919,0.390509,0.272959,-0.342565,0.279885,0.124974,0.41654,-0.184082,-0.389077,-0.39676,-0.336034,-0.243924,0.099094,-0.202554,0.151878,0.38851,0.389715,0.623306,-3.12186 +3405.18,1,0.0912059,4,1.52651,1.03099,-0.348118,0.0779785,0.6023,-0.146057,0.592736,0.137179,0.160579,0.257513,-0.0585939,-0.489589,0.414806,0.151106,-0.132123,1.09507,-0.193755,0.260069,0.240142,-0.209775,-0.295971,-1.12646,-0.190515,-0.242792,0.186663,0.240723,-0.396946,0.924826,-0.547278,0.142079,0.579815,-0.722218,0.26205,0.190729,-0.00670736,-0.346728,-0.516493,0.432874,0.0798017,-0.262198,0.61536,0.570908,0.219592,-0.872451,-0.190268,-0.2182,-0.723314,0.253695,0.33186,-0.0113177,0.0684899,0.321818,0.132555,-0.387046,0.954474,-0.825081,-0.432767,-1.12562,0.700014,-0.440557,0.425262,1.27903,-0.872239,-0.941927,-0.177728,-0.147352,0.0260061,0.597053,0.215872,-0.258659,0.222948,0.457269,0.573075,0.0929306,0.426201,0.61437,0.32609,0.074263,-0.100992,0.141901,0.411788,-0.323594,0.104577,-0.170576,0.239221,-0.464055,-0.141309,0.363574,-0.273046,-0.386572,0.0159017,-0.755219,-0.169992,0.368709,0.0987515,-0.498127,-0.0273326,0.157576,0.118796,0.650624,0.15237,0.0955563,0.0651286,-0.342529,0.402207,-0.252531,-0.206826,-0.0709257,0.329463,0.564312,-0.345169,-0.281069,-0.164366,0.11706,0.148207,0.478813,0.184514,-0.440177,-0.345661,0.0376084,-1.17737,-0.545288,-0.470719,-0.550893,0.0322509,0.458987,0.309681,0.0113304,0.180769,-0.271713,-0.591018,0.232063,0.126933,0.142589,-0.150854,0.234803,-0.0389196,-0.414828,0.332239,-0.0823322,-0.856741,0.147511,0.234977,-0.671465,0.503192,-0.0491435,0.578028,0.161302,0.154441,-0.634645,0.0759367,0.387078,0.571721,-0.452522,-0.125755,0.307997,0.686118,0.528679,0.425245,-0.219641,0.268215,0.724122,0.95032,0.0495953,-0.502797,0.0180879,-0.292935,-0.0400719,0.399704,-0.389246,0.0979015,0.134303,-0.0475398,0.245997,-0.480169,-0.201308,-0.54507,0.602894,-0.199033,0.163442,-0.34526,-0.0927644,0.640968,-0.30637,0.00904752,-0.318385,-0.599686,-0.226947,0.259964,0.0861453,0.0948902,-0.0890157,0.237575,-0.567556,0.490129,-0.218713,0.19049,-0.59102,-0.411312,0.15221,0.384224,-0.109368,-0.685184,0.129864,0.0151282,-0.129518,-0.631814,0.924605,0.188377,0.120943,0.231398,-0.228483,-0.0634735,0.134138,-0.519753,0.696685,-0.127901,0.39954,0.501475,-0.489629,0.272515,-0.0938344,0.200275,0.0251873,-0.208616,0.877512,-0.451323,0.0261479,-0.0430281,0.362988,-0.76586,-0.180925,0.199677,-0.677213,-0.448054,0.456908,0.196875,-0.454248,0.312028,0.13948,-0.597661,-0.165056,0.102052,0.24359,0.995946,0.458096,0.525346,0.616946,-0.25742,-0.295631,-0.327889,-0.308825,0.294154,-0.411364,-0.36633,0.739692,-0.501261,0.489146,-0.4017,0.435824,0.155323,-0.184594,0.161497,0.381695,-0.230496,0.0712735,0.388082,0.151988,0.0411329,-0.560014,-0.619802,-0.0925149,-0.954289,-0.433102,0.331373,0.360761,0.296493,-0.242084,0.214599,0.168091,-0.274174,-0.411307,-0.317643,-0.363325,0.108632,0.314576,-0.16482,0.941758,0.337918,-0.362404,-0.193843,0.536214,0.000481194,0.508032,-0.0979937,-0.678761,-0.332162,-0.213365,-0.107994,0.507184,0.0993996,0.175695,0.2947,0.41916,0.542863,-2.15027 +3429.55,0.993155,0.0912059,4,1.54564,1.08631,-0.148847,-0.0508436,0.919479,-0.164439,0.213804,-0.0278797,0.195631,0.122054,-0.0700129,-0.166797,0.490465,0.0219557,-0.0871501,1.0373,-0.00273743,0.0440005,0.227309,-0.408036,-0.303049,-0.863127,-0.432151,-0.195636,-0.36506,-0.247195,-0.262288,0.674357,-0.551909,0.324109,0.503913,-0.481104,0.209646,0.422299,-0.324655,0.0585614,-0.461214,0.617223,0.674565,-0.612346,0.549509,0.261014,0.135662,-0.805713,-0.0195977,-0.268828,-0.13553,0.236544,0.180404,-0.00840222,-0.187471,0.274897,0.237709,-0.29225,1.12849,-0.626652,-0.104883,-1.11464,0.690196,-0.391457,0.536109,1.21548,-0.433269,-0.387666,0.341045,0.266473,-0.168171,0.526426,0.00133086,-0.666754,-0.30545,0.235428,0.582894,-0.100598,0.637514,0.557278,-0.0536297,0.0531835,0.151176,0.0891269,0.473242,-0.560297,0.109972,-0.173594,0.0881659,-0.0101032,0.133022,0.52902,-0.273142,-0.0101279,-0.125063,-0.464551,0.0122376,0.114241,0.315505,-0.816837,-0.141548,-0.0761408,-0.225202,0.606455,0.0137711,0.131814,-0.300953,-0.00549597,0.314217,-0.682343,-0.204076,0.177688,0.325784,0.469396,-0.121151,0.122691,-0.150818,0.327955,0.0672301,0.182141,-0.145558,-0.116387,0.415765,-0.061571,-0.761023,-0.416127,-0.36971,-0.543549,-0.137667,-0.129177,0.415061,-0.224576,0.401093,-0.00174556,-0.244143,0.0702726,-0.0815005,0.0203922,0.00607592,-0.0591734,-0.122777,-0.51752,0.502673,-0.287824,-0.32451,-0.088751,0.168793,-0.621542,0.226062,0.099705,0.44756,0.450417,0.090575,-0.601027,-0.0903957,0.102643,0.526873,-0.481264,-0.158534,0.360662,0.582201,0.639702,0.463629,-0.246033,0.808959,0.391898,0.887715,0.170091,-0.586566,0.245985,-0.128095,0.0196557,-0.10519,0.0812038,0.22096,-0.118997,-0.377644,0.594293,-0.228486,-0.357013,-0.224018,-0.0921683,-0.370737,0.299397,0.147577,-0.61408,0.318261,0.113143,0.0583085,-0.611071,-0.62274,-0.212285,0.0392229,-0.244819,0.0496866,-0.245242,0.0360812,-0.72493,0.262351,-0.279475,0.263761,-0.187023,-0.651392,0.270112,0.166629,-0.226327,-0.363139,-0.22528,-0.121032,-0.00284373,-0.767439,0.861925,0.106388,0.666967,0.254808,0.473337,0.231542,0.0472885,-0.399385,0.65671,-0.529691,0.528243,0.194348,-0.786375,0.389504,0.032739,0.256116,-0.498552,0.226567,0.522885,-0.838523,-0.33956,-0.457345,0.253597,-0.18266,-0.158687,0.468066,-0.223822,-0.67368,0.519018,-0.201782,-0.353435,0.204775,0.214893,-0.518885,-0.294959,-0.207107,-0.00473098,0.763322,0.2034,0.386217,0.331841,-0.378832,-0.143205,0.0436905,0.142467,0.440244,-0.127203,-0.0909844,0.414992,-0.503744,0.356089,-0.123901,0.438416,0.290209,0.0160602,0.240116,0.528986,-0.0442646,0.17711,0.345174,0.0658417,0.291733,-0.246745,-0.232209,-0.155042,-0.756805,-0.471958,0.226171,0.179747,0.305843,0.443868,-0.00527926,0.539329,-0.0960958,-0.821724,-0.076401,0.109619,0.302049,0.372641,-0.251702,0.369592,0.192198,-0.484248,0.0667058,0.388323,-0.303676,0.788607,-0.0424526,-1.17707,-0.336143,-0.278977,0.0873876,-0.327353,-0.100308,0.128511,0.303659,0.358484,0.551052,-3.25984 +3415.7,0.968474,0.0912059,4,1.57771,0.949678,-1.03451,0.301672,0.334456,-0.230983,0.362584,0.770613,0.35525,0.313635,-0.0551378,0.165758,0.239589,0.435271,-0.385692,0.725456,-0.163183,-0.0562072,-0.172066,-0.219286,-0.175812,-1.10323,-0.600383,0.263053,0.0258996,-0.330926,0.638696,0.278072,-0.209349,0.0917224,0.566585,-0.420526,0.018462,-0.0346269,0.13207,-0.439571,-0.0865685,0.684536,0.178937,-0.137024,1.01253,0.433748,0.261675,-0.301448,0.377667,-0.465814,-0.871973,-0.0486877,0.292054,0.242449,-0.124011,0.859227,0.158783,-0.00415573,0.564863,-0.365098,-0.142274,0.0376615,0.260444,0.0125091,0.206408,1.29273,-0.839728,-1.52434,-0.0735053,0.188389,-0.5553,-0.328821,-0.0343798,-0.130844,-0.439429,-0.0415254,0.384129,-0.178332,0.537857,0.546487,0.550284,0.0409724,-0.114669,-0.410697,0.467967,0.11697,-0.145584,-0.738686,-0.0154665,-0.167595,-0.493477,-0.221579,-0.0188853,-0.584364,-0.786079,-0.194732,0.0814273,-0.0674548,-0.0789296,0.366927,0.142415,0.280986,0.126206,0.220032,0.224662,0.0725502,-0.363119,-0.871401,0.568223,0.0366289,-0.000997365,0.0932413,0.38914,1.15036,0.225371,-0.720978,0.463748,0.249926,0.2204,0.387145,-0.333806,0.193038,-0.565278,-0.0506267,-1.05718,-0.129278,-0.241798,0.244299,-0.299576,-0.12492,0.314596,0.207739,-0.390358,-0.523923,-0.329008,-0.283043,0.436241,0.436852,0.134451,-0.0620334,0.439955,0.291082,0.0330651,-0.479616,-0.2376,-0.297141,-0.103469,-0.0815209,-0.12069,0.436373,-0.535542,0.249078,-0.294204,-0.325337,-0.27211,0.0767058,0.0369843,0.0136378,0.196412,0.23895,-0.402022,-0.0943026,0.15429,0.0934107,-0.133133,0.0318925,0.179402,0.389781,0.546294,0.248143,0.26058,-0.43043,-0.0182821,-0.580753,-0.311559,0.0944293,0.086708,-0.0359007,-0.0801938,-0.0096171,-0.209111,0.0962602,-0.0207611,0.281801,-0.0752712,-0.0286203,-0.383636,-1.07289,-0.341275,0.311318,0.025347,0.0237319,0.0702996,-0.606976,-0.260926,-0.125677,-0.162107,0.0291577,-0.155684,0.347135,-0.0203638,-0.340778,-0.267822,-0.193974,-0.349936,0.172769,0.613876,-0.109038,-0.458681,0.18258,-0.530853,0.923298,0.363426,-0.323133,-0.530859,-0.698894,-0.125463,-0.0668496,-0.58056,-0.029295,-0.0668209,-0.0561611,0.365479,-0.569532,-0.728708,-0.885186,0.0476979,0.375946,-0.112074,0.376514,-0.129089,0.0367872,-0.258352,0.055065,-0.322646,0.0434523,0.0724265,0.141088,-0.794156,0.471695,-0.105367,0.365045,0.319013,-0.457438,-0.183549,0.33572,-0.160128,0.00680824,0.396475,0.58104,0.67616,-0.214376,-0.7974,-0.0533835,0.271631,-0.351759,0.340742,-0.447634,-0.262392,0.73697,-0.571997,0.19703,0.141898,-0.250446,-0.18406,0.891735,-0.733705,-0.329649,0.0393904,-0.212928,-0.0783887,-0.0488635,-0.319548,0.301586,-0.022447,-0.0210649,-0.369132,-0.13343,-0.165947,0.0679664,0.0195004,-0.147373,-0.357985,-0.0853851,-0.45644,0.191225,-0.4494,-0.725254,0.276326,0.0889755,0.229751,0.457373,-0.179529,0.362795,-0.0379079,0.193909,0.17862,-0.097557,0.254532,0.0113826,0.225068,-0.244982,0.177732,0.19046,-0.3714,0.124334,0.205392,0.35261,0.453202,-0.896393 +3433.66,0.985299,0.0912059,4,1.5868,1.00027,-0.843406,0.180207,0.565185,-0.00198539,-0.299262,-0.225903,0.0943564,-0.0449446,-0.0584352,-0.698881,-0.396377,0.300284,-0.241972,0.828589,-0.246218,-0.239895,-0.112695,-0.39413,-0.506244,-1.36051,-0.890322,0.00325452,-0.446388,-0.221495,-0.000249124,0.505712,-0.32331,0.33726,0.439304,-3.60482e-05,0.355801,0.459802,0.259188,0.299405,-0.510297,0.513481,0.573403,-0.206342,1.00461,0.672554,0.127904,-0.433112,-0.0315599,0.659429,-0.849606,0.294049,0.670241,-0.275064,0.41428,0.0738554,0.324346,-0.696732,0.799504,-0.415847,-0.460176,-1.30414,0.444509,-0.706441,-0.0745423,0.976863,-0.607108,-0.581098,-0.00584762,0.187268,0.0973637,0.115496,0.333545,-0.523845,0.491028,0.734372,0.264731,0.0870054,0.553907,0.546913,0.0595795,-0.00235706,-0.134147,0.291065,0.821081,-0.64514,0.0680304,0.687513,-0.0337842,-0.360675,0.254794,-0.0926149,-0.200604,0.0574896,-0.0446571,-0.0440009,-0.172437,-0.467413,0.0597843,-0.612506,-0.229617,-0.488262,-0.0334135,0.101265,-0.121804,-0.43785,-0.167823,-0.153662,-0.397565,-0.679975,-0.0737992,-0.280717,0.0420846,0.150929,-0.831592,0.120787,-0.127284,0.322249,0.0448994,-0.176993,-0.0886839,0.145921,0.782226,-0.203995,-0.304447,0.071088,0.160579,-0.0806986,0.191278,-0.0847671,0.155561,-0.0476651,0.816664,0.137931,0.137857,-0.0575534,0.0856868,0.65507,0.0487659,0.0301793,-0.211057,-0.30938,0.396087,-0.222942,-0.451161,-0.144527,-0.00749062,-0.361301,-0.266184,-0.314805,0.415709,0.0489732,0.0672239,0.0835294,-0.214052,-0.149403,0.104983,0.00500638,0.115254,-0.0491427,0.593621,-0.0729878,0.0366897,-0.211159,0.447964,-0.224935,0.794716,-0.30951,-0.626329,0.227796,-0.257039,0.549172,-0.281893,0.229578,0.231194,-0.404017,-0.21861,0.288949,0.368597,-0.421023,0.0196487,0.0827127,0.372359,0.603111,-0.387762,0.309471,0.645533,0.918781,0.129092,-0.43643,-0.430162,-0.468229,0.220888,-0.0984644,-0.0664503,0.0457461,0.235394,-0.525341,0.408325,-0.139979,0.53662,-0.179775,-0.0146793,0.380781,-0.156616,-0.387386,-0.256876,-0.13096,0.172741,-0.346182,-0.676495,0.818921,-0.461807,0.48608,-0.04135,-0.0977139,0.361051,0.143594,0.257133,0.115561,-0.330811,0.300473,-0.0641829,-0.0280256,0.552094,0.0273024,-0.405072,0.17332,-0.244578,0.362568,0.0130642,-0.171982,0.303387,0.0367445,0.011474,-0.0422332,-0.0824082,-0.283339,-0.0375844,0.525875,0.17269,-0.0216994,0.203102,0.239638,-0.100856,0.102505,0.291019,-0.338179,0.0860078,-0.190005,0.218579,0.399208,0.41654,-0.681202,-0.200989,-0.397805,0.626068,-0.040305,0.0237951,0.533681,-0.392621,0.312719,0.102675,-0.0419704,0.300691,-0.140883,0.435084,0.574243,0.193547,0.343479,0.116601,-0.0497242,-0.108122,-0.257991,-0.336141,-0.265991,-0.19666,0.104152,0.123069,-0.0743972,0.282499,0.106705,0.854084,-0.00521671,0.215431,-0.262225,0.0224123,0.488026,-0.191451,0.0575497,-0.191174,-0.0866248,0.454976,-0.678757,0.106283,0.201102,0.380536,0.444299,0.0348406,-0.677145,-0.087619,-0.0591237,-0.143277,-0.13411,0.103258,0.0977741,0.362988,0.312689,0.602485,-1.78519 +3430.96,0.947769,0.0912059,4,1.61462,1.03422,-0.316861,0.0814336,-0.0709749,-0.053611,0.285157,0.628386,0.718288,0.527659,-0.365939,-0.185295,-0.414633,0.629159,0.0241685,0.777992,-0.263477,-0.115171,0.770587,-0.259875,-0.364718,-1.51856,-0.852616,0.0695326,-0.617928,0.281134,0.204568,-0.106808,0.0442083,0.0385434,0.574425,-0.0357953,-0.286558,0.289211,-0.133137,-0.322624,-0.533039,0.408717,0.214848,-0.587646,0.798101,0.880703,0.0905552,-1.18183,-0.549559,-0.334627,-0.135914,-0.171581,0.562464,-0.184699,0.314856,0.159189,-0.180199,-0.732749,0.881352,-0.358101,-0.0254237,-0.656042,0.547785,-0.211675,0.753135,1.14022,-0.709383,-0.526651,0.133887,-0.30353,0.0119563,-0.193041,0.299876,0.152471,-0.0257242,0.515174,0.525554,0.0525632,0.607593,0.977619,0.595354,-0.0472377,0.110771,-0.000636531,0.68066,-0.670367,0.424643,-0.0607482,0.0121059,-0.18165,0.257325,-0.0272601,0.151746,-0.180266,-0.194177,-0.0955225,-0.14814,-0.475242,-0.259023,0.322027,0.128817,0.240955,0.460319,0.100641,0.0866555,-0.257702,0.340138,-0.0891521,0.335228,-0.349499,0.450146,-0.207879,0.308597,0.273074,0.158068,-0.0113994,-0.0687571,0.110478,-0.0654248,0.41083,-0.365275,-0.204648,-0.173688,0.130537,-0.32719,-0.111135,-0.401892,-0.229771,-0.0229384,0.143535,-0.0477534,0.091698,-0.0151588,-0.192925,0.16595,-0.183559,0.225352,0.548869,-0.0442105,-0.0610795,-0.690098,0.334538,0.184367,-0.0639891,0.104668,-0.032153,0.450051,0.182755,0.0819417,0.0556339,-0.402504,0.373987,-0.111413,-0.266976,0.173381,-0.00338967,-0.17814,-0.373136,0.752581,-0.248971,-0.147836,0.115705,0.236253,-0.204006,-0.199059,0.389151,0.720377,-0.139465,-0.337825,0.459834,-0.235957,0.056747,-0.108317,-0.0689505,-0.00530946,-0.149692,-0.13282,-0.664282,-0.523407,-0.0713618,-0.044748,0.30736,-0.238692,0.393822,-0.235303,-0.317293,0.0394364,-0.0185259,-0.0628222,-0.443492,-0.750991,-0.134583,0.23533,0.0532857,-0.200313,0.0992977,0.213944,0.276016,-0.139827,-0.118734,0.186103,0.205459,-0.0987931,0.0481602,0.0686779,0.0086023,-0.271884,0.109549,-0.428234,-0.499813,0.100079,1.13096,0.165615,0.00345665,-0.212799,-0.517324,-0.588628,0.375745,-0.0411467,0.222047,0.488832,0.20691,-0.0502915,0.156864,-0.0122552,-0.775634,0.00445746,-0.068944,-0.511855,0.0177737,0.0087169,-0.352931,0.150729,0.121275,-0.515397,-0.194829,0.194008,0.0456473,-0.116187,0.130132,-0.0640506,0.00880371,0.0534273,0.0122581,-0.309088,0.281284,0.0761661,0.19862,0.139565,0.490851,0.273295,0.505862,-0.0317409,-0.303414,-0.52434,-0.259414,0.458615,-0.0138636,-0.796382,0.329806,-0.0499848,0.453242,0.19257,-0.245887,0.193967,0.203701,-0.400601,-0.211454,0.247811,-0.155991,0.00771328,-0.443578,0.421288,-0.188043,-0.361407,-0.431689,0.162368,-0.0203076,-0.176573,-0.219528,0.292328,0.162443,-0.0366663,0.0853792,0.164691,0.0323444,-0.496253,0.227144,0.0768025,0.286441,-0.427259,0.782627,-0.122083,-0.0607663,-0.591624,0.459865,-0.20595,0.308079,-0.275738,-0.125219,0.0917743,-0.0141123,-0.305908,-0.694174,0.148855,0.118856,0.290646,0.344756,0.539116,0.124443 +3434.1,0.807115,0.0912059,5,1.57146,1.03802,-0.553761,0.17091,0.137268,0.000809619,-0.154949,0.447117,0.890394,0.628248,-0.33784,-0.698651,0.031116,0.604066,-0.155386,0.588073,0.0801005,-0.203227,0.0631711,-0.235218,-0.495122,-1.25485,-0.471615,-0.0444525,-0.941388,-0.160958,0.389807,0.121019,0.0902469,-0.169828,0.703178,-0.0857738,0.410973,0.384996,-0.389398,0.00333156,-0.667633,0.749401,0.201374,-0.825548,0.933536,0.391886,-0.125907,-0.763994,-0.255638,0.0368663,-0.310719,-0.20787,0.796148,0.100017,0.287761,0.234027,0.244068,-1.14213,0.819223,-0.521483,-0.441163,-1.17042,0.326948,-0.393352,0.29691,0.683796,-0.264342,-0.700898,0.0849065,0.0108007,0.145211,-0.242225,-0.01567,-0.0546918,0.199639,0.35318,0.309327,-0.114285,0.495447,0.633143,0.539378,0.183481,0.0856658,0.229176,0.604531,-0.0925662,0.150545,-0.462009,-0.0203822,-0.0691869,0.275748,-0.304182,0.459095,-0.356298,0.145678,0.0779959,-0.168856,-0.231357,0.219481,0.257434,0.385002,-0.507607,-0.0719721,0.255393,0.103572,-0.615752,0.00417651,0.120961,0.0444647,-0.297028,0.145595,-0.0435396,-0.123829,0.516997,0.224525,-0.153035,0.32784,0.117972,-0.138077,0.470615,0.18288,-0.260701,0.298247,-0.273232,-0.10931,-0.260257,-0.282637,-0.823871,0.406624,-0.100281,-0.134584,0.164752,0.456078,-0.0211077,0.816754,-0.0935101,0.316401,0.607684,-0.108584,0.0172359,-0.411991,0.570882,0.324622,-0.1408,-1.149,0.198278,0.24301,-0.0417214,-0.596299,0.123856,-0.741389,0.455279,0.265061,-0.30072,0.298599,-0.111755,0.046541,0.0828289,0.134576,0.416393,-0.127263,-0.0229334,-0.0372604,-0.103189,0.0117186,0.253585,0.964042,-0.235204,-0.547938,0.476286,-0.34839,-0.0996739,-0.0702006,-0.0332658,-0.0414923,0.132324,-0.304204,-0.553442,-0.409286,0.255994,-0.315079,0.421392,0.266118,0.640602,-0.224115,-0.314578,-0.114198,0.350146,-0.581273,-0.676561,-0.179767,-0.141325,0.116998,-0.196332,0.0204821,0.335091,0.367172,-0.653254,-0.0256252,0.111972,-0.062429,-0.171668,-0.243184,-0.250775,0.173727,-0.245403,-0.042467,-0.116029,-0.0803119,0.185719,-0.247382,0.732433,0.0207694,-0.0476375,-0.26859,0.132342,0.0858091,0.458852,-0.234973,-0.175629,-0.026416,0.34627,0.10659,0.20943,0.169522,-0.528978,-0.128389,-0.287673,0.112604,-0.193087,-0.320755,-0.265872,0.120869,-0.0247256,0.0622028,-0.301651,-0.202594,-0.099425,0.0726607,0.503329,0.0469185,-0.0801247,0.484954,0.27633,0.0944184,-0.0680379,0.0533161,-0.468879,0.56017,0.19621,0.486136,0.404797,0.101265,-0.581905,-0.302682,0.1162,0.24123,-0.552042,-0.293063,0.607384,-0.0191942,0.370678,0.228418,-0.0528445,0.157021,-0.139575,0.179624,0.0837826,0.287867,-0.374727,0.195302,0.136005,-0.0456151,-0.473954,-0.317543,-0.721348,0.00554759,0.306529,0.159297,-0.280421,0.288071,-0.370877,0.272576,0.135779,-0.0634103,-0.0964507,-0.685184,0.617372,-0.1215,-0.0483964,0.124704,-0.038973,-0.218907,-0.116604,-0.000336381,0.526593,-0.152305,0.489607,-0.191926,-0.478365,-0.615183,-0.0378485,-0.182926,-0.079139,0.0819309,0.0858216,0.261114,0.292953,0.510993,-0.59074 +3415.99,0.970347,0.0912059,4,1.51449,1.094,-0.0349565,-0.162668,0.229986,0.0540111,0.855999,0.326978,0.033938,0.501126,-0.2163,-0.00179771,-0.448008,0.416218,0.178429,1.1424,0.285086,0.147502,0.0417486,-0.182242,-0.460677,-0.829319,-0.497774,-0.290465,0.437239,-0.337511,-0.0280369,0.538633,-0.438418,-0.0865378,0.75379,-0.266582,-0.414006,0.12559,-0.285383,-0.296865,-0.504304,0.204889,0.368769,0.0403043,1.24306,0.34361,0.195467,-0.306982,0.192135,-0.279592,-0.86296,0.113312,0.225224,-0.252079,0.0075597,0.0985392,-0.231308,-0.178718,1.37463,-0.293956,0.100609,-0.509297,0.381136,-0.238726,0.233113,0.714011,-0.90749,-0.780986,-0.0168503,0.011718,-0.604592,-0.222051,-0.116383,-0.23634,-0.247211,0.478012,0.485919,-0.215028,0.513638,0.0902516,0.0799079,-0.123561,-0.0131221,-0.348169,0.545372,-0.147219,0.527571,0.0582479,0.483705,-0.388102,-0.285337,0.242247,-0.024465,-0.252155,-0.146741,-0.261624,-0.0263524,0.415784,0.207004,-0.535665,-0.761142,0.060061,0.197533,0.00470528,0.0877942,0.524938,-0.42505,-0.258539,0.37173,-0.308767,0.501495,-0.139505,0.764985,0.600537,-0.282623,0.465082,0.11026,0.163678,0.421627,-0.0891061,-0.246336,0.43082,0.115564,0.0494767,-0.757047,0.119599,0.0156102,0.203014,-0.878852,0.10716,0.545601,-0.193224,0.0721412,-0.500904,-0.137263,-0.283839,-0.22411,0.0203307,-0.0605063,0.0292103,0.100367,-0.285438,0.372842,-0.230673,0.164596,0.106989,0.141553,-0.652376,0.618648,0.152312,-0.143238,0.414076,-0.519269,0.426845,-0.525826,0.231429,0.448507,-0.00463301,0.500425,-0.209366,0.402367,-0.0128179,0.0511238,0.178239,0.478025,0.0995015,-0.0184917,0.350712,0.660606,-0.237512,0.353487,-0.440115,0.0547294,-0.183442,0.54096,-0.355083,-0.252681,0.443508,0.194174,0.15767,0.164229,-0.540029,-0.188359,0.904354,-0.00653381,0.0784746,0.404465,-0.311451,0.312304,0.037189,-0.367151,-0.116741,0.641545,-0.604615,-0.187843,-0.201809,-0.351302,-0.0366975,-0.2449,-0.0348654,0.624274,-0.182609,-0.111607,0.142685,0.0299174,0.07339,0.256863,-0.125718,0.0586395,-0.213138,0.164346,1.01312,-0.151312,0.521752,0.176325,-0.126473,0.403105,-0.385245,0.225526,0.319614,0.0943246,-0.254637,0.380885,-0.995903,-0.135896,-0.129016,-0.298777,0.623088,-0.313879,0.965493,-0.18213,0.0441925,-0.193061,0.325585,-0.0840809,-0.0610345,0.0926606,0.000898398,-0.205195,0.357027,0.314524,0.13605,0.756202,-0.687376,-0.525548,0.314334,-0.398383,0.378946,-0.0650709,-0.245485,0.210587,-0.0187823,-0.258546,-0.232167,0.104926,-1.10508,0.263258,0.0800579,-0.0350744,0.0502657,-0.569312,-0.549018,-0.373629,0.262507,0.124772,0.569127,-0.082815,0.216045,0.0379933,0.660644,-0.362161,-0.458133,-0.0594592,0.179105,0.0875111,0.176087,0.125555,-0.794131,-0.42275,0.153294,-0.453991,0.427204,0.0910885,-0.0985548,-0.220204,-0.0301679,0.445379,-0.556682,0.246381,0.602448,-0.27201,0.32708,0.210378,-0.124664,-0.506308,-0.547786,0.267813,-0.0927913,0.126407,-0.540852,-0.109592,0.0523883,0.00381875,-0.301139,-0.0111251,0.129865,0.256699,0.360368,0.506654,-1.02401 +3440.35,0.937748,0.0912059,4,1.55929,0.992302,-0.330431,-0.045231,0.199711,0.0345057,0.277949,0.329489,-0.272425,0.507975,-0.0337912,-0.468618,0.206272,0.0787351,-0.0985918,1.12313,0.193035,-0.194892,0.0413208,0.217552,-0.139505,-0.837339,-0.34117,0.1643,-0.257399,-0.474094,0.286863,0.497808,-0.406549,-0.0148151,0.862858,-0.00292161,0.595548,0.102714,-0.23108,0.00742536,-0.225646,0.763771,0.303938,-0.434964,1.20854,0.345015,0.0607895,-0.514168,0.0495139,0.163055,-0.611458,0.314778,0.432987,-0.179358,0.380545,0.244384,0.0498225,-0.448456,1.44352,-0.440241,-0.486648,-0.509688,0.512216,-0.184279,0.276898,0.699665,-0.45856,-1.57967,0.0759888,-0.233064,0.0205707,0.0192971,0.288231,-0.180059,-0.152506,0.158584,0.84175,-0.121525,0.304931,0.265046,0.406211,0.155725,-0.47731,0.119118,0.257688,-0.24031,0.152647,-0.573769,0.0503951,-0.25091,0.0939388,-0.269438,0.0267094,-0.403286,0.281021,0.0335558,0.11255,0.0138909,0.17286,0.0461031,-0.170541,-0.0513234,0.0945095,0.260375,0.155171,-0.370847,-0.931397,0.0207556,-0.189307,-0.0578768,-0.109518,0.452302,0.401726,0.253588,0.210613,-0.0343997,-0.505117,0.109582,0.088984,0.557664,-0.0618557,0.0887506,0.368978,-0.50015,-0.111968,-0.0478625,-0.607897,-0.734091,-0.10197,-0.254135,0.438669,0.243978,0.107227,-0.117464,-0.0959876,0.390367,0.275896,0.182163,-0.341684,-0.13768,-0.00410923,-0.15427,0.321898,-0.189481,-0.444661,0.0467028,-0.480013,-0.14261,-0.525576,0.0608169,-0.118058,0.211317,0.091068,-0.20256,0.00486559,-0.00977607,0.275305,0.175902,-0.255051,0.77444,-0.410035,0.113301,-0.18427,-0.320651,-0.228479,-0.275716,0.611801,-0.454964,-0.106908,-0.380699,0.00748777,-0.163317,0.118101,0.473002,0.334925,0.249837,-0.405061,-0.307324,-0.308806,-0.151635,-0.103503,0.265172,-0.31076,0.816919,0.126331,0.0675254,-0.223163,-0.520884,-0.21219,-0.074166,0.191667,-0.240629,0.197385,-0.198792,0.206575,0.155377,0.0997535,-0.905257,-0.127422,0.190357,-0.199124,-0.505497,-0.294777,-0.275684,0.117237,-0.67625,0.699183,0.174347,-0.156766,0.502761,-0.163842,0.734204,-0.0253947,-0.151313,-0.115047,0.135756,0.0864001,0.451323,-0.0528142,0.0212324,-0.737893,0.150564,0.195501,-0.359601,0.303991,-0.509217,-0.700352,0.258042,-0.112146,0.505347,0.0109579,-0.377861,-0.142658,0.268203,-0.135388,-0.367259,-0.198803,0.0137595,-0.407131,0.803116,-0.458991,0.23575,0.473021,-0.157762,-0.312683,0.0407913,0.298757,-0.504401,0.579068,0.249908,0.055579,0.331954,0.234004,-0.316788,-0.189011,0.0683761,-0.304168,-0.255641,-1.05648,0.0625799,-0.154023,-0.518349,-0.329485,-0.270756,-0.0386711,0.326801,0.0572492,-0.050544,-0.689319,-0.249312,0.0771268,-0.0483531,0.0013358,-0.00984387,-0.0292154,-0.00859996,-0.563588,-0.0776404,0.0996491,-0.105909,-0.0305505,0.00169716,-0.575984,-0.24699,-0.0100472,-0.106389,0.100739,0.11839,0.0996969,0.080297,0.19922,0.0892935,-0.0369246,0.209975,-0.280823,0.565148,0.0157859,-0.0558009,-0.307333,-0.13615,-0.083841,-0.0303212,-0.159658,-0.57572,0.0714332,0.113796,0.261676,0.337337,0.511542,-0.650165 +3449.16,0.986994,0.0912059,4,1.58463,0.959916,-0.238178,-0.0459704,0.0123115,-0.0410337,0.122474,0.0647745,0.525289,-0.26225,-0.284066,-0.0230467,0.22209,0.285931,-0.0186039,1.03811,0.131587,-0.202796,-0.21458,-0.132582,-0.197343,-0.998456,-1.01917,0.141574,0.277351,-0.325868,-0.0729037,-0.157635,-0.0638647,0.120376,0.660087,-0.593563,-0.313387,-0.247677,-0.0297901,-0.144337,-0.716516,-0.109347,-0.0802172,-0.116711,1.19976,0.701698,0.424341,-0.407056,-0.138605,0.0195027,-0.441687,-0.350207,0.667456,0.208899,0.206048,-0.307861,-0.00481666,-0.749083,1.30439,-0.285659,0.189457,-0.671816,0.35682,0.10207,0.24707,0.707005,-0.672638,-0.693824,0.0410716,0.569441,0.101728,0.102357,0.231998,-0.518217,-0.409316,-0.265055,0.480892,0.282435,0.183033,0.0328271,0.482445,0.064263,-0.0479707,0.101021,0.451572,-0.104554,0.2193,-0.119889,-0.200003,0.495519,-0.292861,-0.485446,0.175172,-0.170127,-0.22859,-0.482972,0.213386,0.0530807,0.185955,-0.235692,0.251691,-0.166759,-0.357856,0.0680824,0.0443109,0.175066,0.0831183,-0.0930425,-0.331111,-0.164756,0.744844,-0.585218,-0.00465923,0.69944,0.215507,0.251772,0.483094,0.162432,0.205354,-0.302069,-0.36059,0.392357,-0.178111,0.0884994,-0.82328,-0.178517,0.290597,0.251795,-0.227847,0.0482733,0.48442,0.308759,0.134021,-0.00575601,-0.0477828,-0.243821,-0.336717,0.294324,-0.292147,0.230261,-0.0175667,-0.160885,0.189953,-0.605561,0.195678,-0.0614715,0.0821085,-0.295977,0.343829,0.546123,-0.138715,0.317579,-0.157991,0.233602,-0.0450422,0.380016,0.164626,0.087798,0.535261,-0.19125,0.801741,-0.349098,-0.243035,0.0561715,0.147865,-0.06603,0.621593,0.0943376,0.14143,0.468043,0.0777237,0.215399,-0.0535868,-0.26075,0.31013,0.00570511,-0.146336,0.507908,-0.00990837,0.206797,-0.25966,-0.290561,0.0799592,0.621464,-0.149653,0.755532,0.37675,0.320652,0.271325,-0.20718,-0.315954,0.0811285,0.254664,-0.335403,0.126772,-0.0121728,-0.20151,-0.374532,0.209991,0.12986,0.222904,-0.451728,-0.313219,0.109612,-0.258261,0.269117,0.0197983,-0.41342,0.421972,-0.262414,-0.353103,1.14826,-0.0356738,0.154929,0.10542,-0.136065,0.294764,-0.570582,-0.235473,0.503174,0.0480773,-0.0817515,0.185941,-0.170301,-0.484201,-0.251583,0.310132,-0.534622,-0.157671,0.454196,-0.189223,0.044147,0.533583,0.248358,0.347713,-0.200983,-0.153541,-0.259417,-0.0988122,0.318932,-0.0947886,-0.320196,0.661092,-0.22379,-0.112408,0.280509,-0.82089,0.47283,0.266442,0.229723,0.47571,-0.016237,-0.648014,-0.0165203,-0.0060973,-0.786539,0.312298,-0.657618,0.166912,0.256455,-0.511755,0.418907,0.509602,0.21028,0.127255,0.26136,-0.132564,0.46486,0.382073,0.02308,-0.415669,0.0607166,-0.466541,-0.100936,-0.0999958,-0.294988,0.0121814,-0.0544238,0.257112,0.423459,-0.0722791,-0.0238676,-0.0971952,-0.0875762,-0.0684218,-0.513596,-0.799592,-0.0902965,0.255188,0.0147456,-0.405648,0.379182,-0.0147336,-0.442384,-0.293228,0.127552,0.492115,-0.234738,0.216861,-0.66657,0.324357,0.103716,0.105664,-0.32977,-0.233254,0.102772,0.228321,0.32058,0.47783,0.0256699 +3434.9,0.956785,0.0912059,4,1.66916,1.02243,0.055218,-0.18612,0.195538,-0.153114,0.0928037,0.287564,-0.206325,0.168681,-0.172495,-0.607628,0.35207,0.445238,0.191434,0.936073,0.121838,-0.30659,0.0421918,-0.220467,-0.311351,-1.25805,-0.516785,0.0203129,-0.452152,-0.190608,-0.419214,0.0132376,-0.268221,0.20999,0.764183,-0.456898,-0.165019,0.227854,-0.0671794,-0.0356928,-0.261163,0.201319,0.0906176,-0.532371,0.992939,0.0669491,0.125901,-0.480717,0.254644,-0.617511,-0.937578,-0.334066,0.234418,0.010805,0.213829,0.0346795,0.0687092,-0.725922,1.18297,-0.797312,-0.448389,-0.943325,0.582999,-0.330685,0.360281,0.646708,-0.519202,-1.12284,-0.286729,0.22851,0.0778117,-0.0680395,0.20563,0.220321,0.370002,0.516895,0.496106,-0.0358752,0.669834,0.473147,0.282562,0.33429,-0.509486,0.0697208,0.460619,-0.204861,-0.0122262,0.101511,-0.423048,-0.0251895,0.2109,0.272224,-0.286992,-0.404733,0.259123,-0.0124905,-0.112298,0.0618696,-0.312932,-0.622743,-0.219792,0.0303931,0.182484,-0.182106,-0.531881,-0.612916,0.0108435,0.223349,-0.304516,-0.143942,0.737173,-0.191944,-0.335717,0.301971,-0.405378,0.0707631,0.417155,0.254516,-0.0666659,-0.195059,-0.67766,0.0864811,-0.332854,-0.018688,-0.585109,0.203554,-0.833295,0.367491,-0.083055,-0.0751227,0.583621,0.410981,0.123164,-0.302688,0.0469049,0.142752,0.108088,0.571633,-0.129024,-0.582819,0.22461,-0.441024,0.16454,-0.447321,-0.470258,-0.0780722,0.242422,-0.20171,0.521992,0.272879,-0.201795,0.141376,-0.282709,0.741209,-0.0581015,0.0624319,0.0359461,0.043743,0.333592,0.275463,0.188989,-0.108726,0.157677,-0.0325754,0.0756769,-0.284545,0.280818,-0.288656,-0.534086,0.221037,0.152878,-0.101024,0.119179,0.234527,0.474175,-0.548742,-0.157222,-0.283612,0.139565,-0.0225884,-0.256201,-0.21567,0.532969,0.631528,0.165528,0.201931,0.298022,-0.0912596,-0.16161,-0.174254,-0.388174,0.090861,0.29329,-0.340669,-0.0655434,0.0600808,-0.672923,-0.185086,0.203256,-0.100064,0.291002,-0.656736,-0.100277,-0.168845,-0.198544,0.413073,0.236343,0.201859,0.0664295,-0.498456,-0.25371,0.610518,0.401851,0.023942,0.181808,-0.311362,-0.0782562,0.294779,0.164721,0.124611,-0.604009,0.0424464,0.0843775,-0.358489,-0.368135,-0.38065,0.240588,0.238736,-0.321403,0.638813,-0.326353,-0.42929,0.154016,-0.16001,-0.38966,0.180451,-0.555445,0.423364,-0.273254,0.42184,0.172935,-0.395599,0.602058,-0.117838,-0.255422,0.301119,-0.092098,0.246145,-0.271433,0.392921,0.0207958,-0.21649,-0.142402,-0.10997,-0.128972,-0.238207,0.469651,-0.185222,-0.0669431,0.568241,-0.0362057,0.31425,0.00525739,0.0698591,-0.30573,0.379989,0.117035,0.543913,-0.509567,0.0377728,-0.116059,-0.460576,-0.173832,0.00162421,-0.0654307,0.0402397,0.0916912,-0.0718274,0.0793723,-0.147658,0.12489,0.0229349,-0.0383233,0.579477,-0.421247,0.0228386,-0.208009,0.0817847,0.0602372,-0.115632,0.038222,0.618494,-0.272993,-0.299314,-0.0517645,-0.0241202,0.649743,0.221894,-0.0429102,0.0137118,-0.501096,0.311818,-1.24767,-0.338568,0.0379115,0.108483,0.235189,0.329367,0.484963,-0.601816 +3429.84,0.777565,0.0912059,4,1.64099,0.986511,-0.299313,-0.0231192,-0.13239,-0.0577595,0.112412,-0.0943482,0.493604,-0.0867416,-0.162385,-0.286062,0.0277225,0.647981,0.174284,0.710542,-0.102131,-0.0906322,-0.337806,-0.130176,-0.928421,-0.901314,-0.887411,0.00145631,-0.263355,-0.59855,-0.043764,0.601354,-0.559582,-0.172879,0.879537,-0.966364,0.171026,-0.127799,-0.493262,0.246733,-0.522832,0.228566,0.214765,-0.0830667,1.06399,1.27086,-0.250608,-0.516522,-0.0245269,-0.103058,-0.652849,0.0254837,0.424324,0.282983,0.629549,-0.00400596,-0.0490664,-0.43863,0.493088,-0.176203,-0.193205,-0.241905,0.421051,0.0038887,-0.0346931,0.979773,-1.21785,-0.646423,0.059658,0.0622477,0.0156451,0.246757,0.264362,-1.05689,-0.0505409,-0.432888,0.595595,-0.676257,0.4645,0.63217,0.117302,-0.100295,-0.0730803,0.500948,0.417881,0.0560718,0.173361,-0.0696208,0.219749,0.155604,-0.377861,-0.101818,-0.00585642,-0.672977,-0.0951329,0.0904519,0.327029,-0.0571084,0.278274,-0.125328,0.272135,-0.221965,-0.0634748,0.489371,0.11315,0.0958531,-0.528697,-0.936997,-0.0967447,-0.202658,0.0291227,0.0814286,0.0454966,0.245095,0.118512,-0.0758788,-0.257901,0.815974,0.550586,0.570332,-0.122139,-0.0694934,0.633313,-0.121108,-0.348529,-0.464751,-0.0636579,-0.801442,-0.0283496,0.500164,0.0738573,0.451826,0.138644,0.543813,0.0350443,-0.191266,-0.610028,0.365123,0.124252,-0.105555,-0.277994,0.35338,0.814121,-0.495804,0.275302,-0.0573187,0.0827199,-0.1131,0.194809,-0.0171923,0.366537,0.26467,-0.378621,-0.359504,-0.202068,0.0921387,0.0548327,-0.100161,-0.26152,0.209712,-0.056455,0.196001,-0.0277195,-0.166607,0.327095,0.0106857,0.67526,0.381741,-0.0811409,-0.137745,0.0589214,-0.188818,-0.419747,-0.60389,0.00199041,0.554872,0.485079,0.673602,-0.129499,0.294041,-0.155298,-0.064551,-0.278304,0.647062,-0.0495112,-0.0816363,-0.0880338,0.134265,0.0956357,0.225396,0.48672,-0.549868,0.0783317,-0.85438,-0.059034,-0.226768,0.408534,-0.409818,0.0143902,0.248681,0.310815,0.332959,-0.33686,-0.0443268,0.00126869,0.0572014,-0.123479,-0.0799242,0.166137,0.62602,-0.15123,0.599999,-0.22501,0.230875,-0.189424,0.0190416,-0.0113547,-0.195895,0.125183,-0.00964164,0.167967,0.270461,-0.127347,-0.066615,0.568396,-0.485569,0.115824,0.00967074,0.185933,0.552843,-0.0881538,-0.102677,0.155736,0.513107,-0.00110945,0.376774,0.243319,-0.253378,-0.317747,0.48485,-0.221808,0.116818,0.273496,-0.334792,0.182143,0.120123,0.184631,-0.106072,0.210079,0.31994,0.620049,0.412352,-0.158904,-0.45285,-0.0363451,-0.360644,0.374729,0.258122,-0.22229,0.266277,-0.493627,-0.0508139,0.0978522,-0.0114554,0.413221,0.15276,0.295925,-0.769269,-0.127575,0.188882,-0.385069,0.228363,-0.341895,-0.0598157,-0.273428,-0.341533,-0.672569,0.140316,0.00140174,0.139811,0.0927645,-0.492371,-0.0658275,-0.728636,-0.325163,-0.218858,-0.594634,0.158005,0.443644,0.0142787,-0.421125,-0.141034,0.364796,0.323695,0.330454,0.340603,-0.206881,0.109968,0.0730192,-0.836163,0.205326,-0.126086,0.635899,-0.247961,-0.110528,0.126635,0.294381,0.355858,0.542569,0.530023 +3417.35,0.88429,0.0912059,4,1.62257,0.847115,-0.299961,-0.168819,-0.365357,0.0431891,0.138975,0.0557238,0.191403,-0.278262,-0.311187,-0.31781,0.507321,0.535095,-0.321773,0.358801,0.0404414,-0.442003,-0.505801,0.0559857,-0.430301,-0.937493,-0.731181,0.343804,0.176603,-0.508007,-0.300387,-0.156024,-0.931808,-0.267266,1.07388,-0.610206,-0.113261,-0.0953682,0.289418,0.299045,-0.668418,0.241175,-0.00430671,-0.218926,1.00399,0.270385,-0.00860581,-0.575956,0.10992,-0.549392,-0.561972,-0.00498387,0.564377,0.131971,0.704417,-0.229128,-0.030179,-0.15264,1.11516,-0.523255,-0.315279,-0.262418,0.560703,0.125871,0.317503,0.810439,-0.981293,-0.492409,0.0917563,0.458119,-0.128019,0.0577377,-0.00150932,-1.04593,-0.211761,-0.130599,0.686736,-0.558701,0.242661,0.499137,0.0978755,0.153606,-0.525164,0.303707,0.461408,-0.61755,0.12847,-0.0976459,0.0756683,-0.247429,0.00620381,-0.0312814,0.274714,-0.526991,0.685949,0.257098,0.1132,-0.250183,-0.102305,0.0063099,0.238626,0.0467844,-0.171889,0.388844,-0.222931,-0.825993,-0.00795028,-0.492381,-0.047946,-0.109912,-0.625765,0.220344,0.202293,0.530048,-0.0498582,-0.0538437,-0.242956,0.795378,0.186606,0.320004,-0.329131,-0.112512,0.431547,0.0703515,-0.175407,0.516603,-0.642395,-0.372415,-0.260551,-0.19586,-0.0264858,0.404385,0.164603,-0.191471,-0.238091,0.169748,0.446002,0.581977,0.106485,-0.11993,-0.0725659,-0.0771947,0.348243,-0.0951075,0.092099,-0.134371,-0.106793,0.0566261,0.212249,-0.140777,0.281449,0.282496,-0.690419,-0.112526,0.190235,0.118191,0.106991,0.0644256,-0.262647,-0.102451,-0.568871,0.277324,0.330853,-0.054093,0.00129955,-0.0735318,0.403028,-0.242952,0.463563,-0.0231033,0.276483,-0.162586,0.15633,-0.0594932,0.191469,-0.0506369,0.160451,0.0913137,0.228383,-0.0318029,0.198172,0.193803,-0.209021,0.365494,0.426344,0.521078,0.304702,-0.21173,0.481747,0.104072,-0.334832,-0.207329,0.203481,-0.153758,-0.159357,-0.266485,0.18694,-0.33491,-0.143847,0.0515374,-0.0379526,0.157256,-0.209993,0.390083,-0.102977,-0.164878,-0.0939112,0.476338,-0.169385,0.387026,-0.126169,0.679591,-0.339772,0.126703,0.136829,0.216808,0.267207,-0.743594,0.149837,0.488269,-0.652962,0.394678,0.216687,-0.540317,0.257632,-0.244959,-0.429328,-0.147519,-0.352737,0.683397,-0.312607,-0.335609,0.170576,0.414465,-0.00129184,0.526739,0.281054,0.0223042,-0.587041,0.508832,0.34505,0.040292,0.300669,0.09306,-0.166876,-0.136675,0.287624,0.242299,-0.360382,0.253469,0.143407,-0.168924,-0.0811487,-0.158692,0.407954,-0.65029,0.776429,0.242846,-0.637615,0.508789,-0.29143,0.133534,-0.361157,-0.222097,-0.0377099,0.0967013,-0.259993,-0.386312,-0.614684,0.271395,-0.428196,0.210042,-0.305566,-0.138694,-0.426731,-0.464231,-0.438018,-0.141041,0.0533507,0.286247,-0.243778,-0.652924,-0.0968719,0.0166413,-0.100559,0.0328098,-0.0211825,-0.160831,0.426633,-0.380055,-0.335749,0.271466,0.587505,-0.0483459,0.33214,0.492542,-0.327547,0.397728,-0.154769,-0.150243,-0.503205,0.352246,0.22174,0.22997,0.406104,0.104049,0.220932,0.322567,0.470034,1.64473 +3436.86,0.907276,0.0912059,4,1.66407,0.908975,-0.208388,-0.181324,-0.457618,0.00188115,0.194543,0.219949,0.488167,-0.0904669,-0.308196,-0.338572,0.445369,0.603788,-0.196186,0.528719,0.242412,-0.341271,-0.603667,-0.135423,-0.617994,-0.839208,-0.811628,0.217569,-0.139385,-0.550742,-0.261854,0.0528341,-0.775973,-0.221612,1.20173,-0.700223,-0.549841,-0.07973,0.130741,0.48301,-0.848813,0.103139,0.0616587,-0.204394,1.29864,0.329557,0.14781,-0.764019,0.0264871,-0.620801,-0.227704,0.186862,0.277208,0.170326,0.541034,0.233948,-0.208791,-0.27412,0.909745,-0.613722,-0.145821,-0.29559,0.270304,-0.426178,0.283731,0.672182,-0.997169,-0.715336,-0.471235,0.294363,-0.0400732,-0.128831,0.268563,-0.637526,-0.34869,0.164109,0.840452,-0.166584,0.247172,0.138166,0.187097,0.22038,-0.366793,0.0522445,0.46777,-0.732447,0.210816,-0.0282922,-0.130833,-0.324954,-0.160992,0.0157153,0.0777145,-0.520157,0.596313,0.603243,0.275673,-0.0807886,-0.237708,-0.225572,0.511356,-0.251622,-0.0537408,0.310542,-0.500696,-0.7947,0.0146708,-0.740187,0.249792,-0.267325,-0.142249,-0.0453093,0.304021,0.529685,-0.274204,0.0628962,-0.276805,0.770995,0.433554,0.550519,-0.585732,0.233474,0.272556,-0.170965,-0.507465,0.247961,-0.822414,-0.225163,-0.0105384,-0.0857728,0.0936896,0.267514,0.322323,0.0171566,0.0516019,0.115845,0.359146,0.277764,-0.190629,0.0251816,-0.339413,-0.194183,0.604345,-0.575156,0.178144,-0.174877,0.0441421,0.0466264,0.381079,-0.305025,0.387446,-0.00822471,-0.940472,0.239223,0.158576,0.0443358,-0.134564,0.0926711,0.0719357,0.16681,-0.139715,0.103542,-0.0693427,-0.194668,0.178722,0.171866,0.418437,-0.378418,0.12488,-0.158446,0.456129,-0.111198,-0.0383959,0.15491,0.440304,-0.0774787,0.410137,-0.135689,0.38994,-0.0412006,0.0644244,-0.123301,-0.0393694,0.401158,0.418157,0.323314,0.37126,-0.283063,0.127746,0.205062,-0.185421,-0.0321773,0.0362038,-0.154056,-0.05055,0.038998,0.207223,-0.331231,0.0250225,0.4782,0.289513,0.0231352,-0.579733,0.305561,-0.178686,-0.0618908,0.047564,0.403854,-0.208692,0.0539821,-0.31825,0.378317,-0.531466,-0.0554351,0.197086,-0.0192105,0.143843,-0.356281,-0.1012,0.701102,-0.551134,0.259718,0.350874,-0.276038,0.27546,-0.340114,-0.590574,-0.126774,-0.478955,0.960835,-0.289948,-0.238762,0.239151,0.121753,-0.103811,0.370824,0.268344,-0.0964517,-0.563154,0.495209,0.174534,0.0235505,0.501489,0.0876789,0.0955766,-0.321063,0.181149,0.352975,-0.325753,0.0237572,0.0183321,-0.0946329,0.0123224,-0.212539,0.378996,-0.493414,0.456963,-0.0170617,-0.424458,0.695496,-0.0866226,0.142493,-0.191377,-0.0597314,-0.0531194,0.0876279,-0.131373,0.00645605,-0.567111,0.338917,-0.618023,-0.12193,-0.170087,-0.0651847,-0.697437,-0.556552,-0.496152,0.11325,0.0673562,0.235282,-0.144774,-0.36645,-0.125894,0.23489,-0.115873,-0.145775,0.127144,-0.0731737,0.16352,-0.243648,-0.134247,0.257559,0.339594,-0.0482872,0.417944,0.458376,-0.0884643,0.143793,0.217566,0.138446,-0.501101,0.36161,-0.313661,0.0564242,0.494163,0.118743,0.302459,0.344591,0.549963,1.85722 +3442.19,0.895184,0.0912059,4,1.62047,1.04703,-0.368204,0.0414437,-0.184884,-0.13193,-0.271281,-0.014355,0.0460769,0.0551583,-0.314049,-0.0409816,0.00703568,0.447903,0.201904,0.923019,0.214942,-0.0548913,-0.231234,0.0884959,-0.393235,-0.623296,-0.503031,0.410428,-0.228837,-0.744158,0.245686,0.463502,0.231426,0.0660148,1.03773,-0.429144,-0.630242,0.164142,-0.413846,-0.191162,-0.242308,0.134979,-0.314133,-0.256771,0.851799,0.691533,-0.0438211,-0.689825,0.26016,0.422102,-0.946765,-0.0097857,0.296258,0.0039779,0.117602,-0.488836,0.0405754,-0.343412,0.224016,0.0113216,-0.478206,-0.571553,0.294636,-0.249155,0.41203,0.639225,-0.958921,-0.815828,0.472845,0.124713,-0.276295,-0.297677,1.0802,-0.253082,-0.22593,0.0438485,0.189293,0.0845176,0.79431,0.640377,0.420127,0.354672,-0.37442,-0.0706478,0.0664146,-0.114168,-0.233651,-0.195337,0.172235,-0.36111,-0.24878,-0.782336,-0.101101,-0.397442,-0.113787,0.227426,-0.543886,-0.0530328,-0.151739,-0.135478,-0.0796688,0.361649,-0.213521,0.0439412,0.0879541,-0.070531,0.0130875,-0.246472,0.226238,0.000626632,0.199747,0.464465,0.0987686,0.568804,-0.118501,-0.0777817,-0.142147,0.879962,0.190287,0.248667,0.115394,-0.0429636,0.684147,-0.876542,-0.456956,0.0846989,0.11115,0.308945,0.420323,0.0191874,0.416351,0.141247,0.149663,-0.339259,-0.0460023,-0.183875,-0.24353,0.52766,0.174516,-0.296524,-0.138812,0.22713,0.378604,-0.0903304,-0.32557,-0.479992,-0.0713153,-0.24955,-0.0982045,0.173604,0.0653056,0.625035,-0.586971,-0.154063,-0.0401437,-0.00272783,0.0510397,0.013343,0.144751,-0.00456558,0.0664817,-0.217153,-0.166505,-0.294942,0.211667,-0.247542,0.0494855,0.1956,-0.164485,-0.160475,0.395479,-0.384318,-0.421721,-0.0772896,0.25036,0.0470057,0.381161,-0.337209,-0.00149107,-0.109645,0.0721987,0.0669062,-0.145566,0.97914,0.107904,-0.245773,0.0479143,0.271643,-0.206213,0.286269,0.0386217,0.0239077,0.143094,-0.250686,0.288427,-0.112285,-0.0869227,-0.815689,-0.025942,0.0253892,-0.152904,-0.119728,-1.18664,0.22064,-0.366192,-0.0149003,0.531178,-0.053424,0.063231,-0.10913,-0.338948,0.601912,0.711445,0.508691,-0.11762,-0.363808,0.170182,-0.170728,-0.0458963,0.0635388,-0.307169,-0.123376,0.0481566,-0.372484,-0.0616346,-0.384513,0.298756,0.271804,0.0742559,0.353765,-0.52598,0.131866,0.0725504,0.441899,-0.700113,0.651041,0.342162,0.189498,-0.552602,0.473551,0.0745741,-0.150755,0.385975,-0.18242,-0.361886,0.384269,0.217777,0.237556,0.129208,0.387221,0.525719,-0.244966,-0.466567,-0.171203,-0.0610672,-0.491201,-0.149339,-0.25295,0.0346613,0.111855,0.0448463,-0.329428,0.0735025,-0.314858,0.187571,0.592965,-0.175599,-0.173066,-0.0455444,-0.80935,-0.183389,0.198111,0.396383,-0.279504,0.0697671,-0.311698,-0.49408,0.0823768,0.16127,0.273985,0.146573,0.0102496,0.466867,0.183661,-0.388321,-0.122211,0.143483,-0.00439606,0.288945,0.335626,-0.258732,0.188329,-0.249425,0.167562,0.476182,-0.186124,-0.0765814,-0.106486,-0.386964,-0.254511,0.209506,0.150127,0.0769541,0.0173867,-0.00120427,0.113799,0.15195,0.33734,0.389807,0.570274 +3452.47,0.454726,0.0912059,4,1.62153,0.968125,-0.761102,0.252791,0.122014,0.0372618,0.455184,0.135559,0.497736,-0.198905,-0.00716116,0.185808,0.128168,0.526108,0.152035,0.584341,0.268665,-0.226379,-0.376844,0.047997,-0.207559,-0.50835,-0.744579,-0.0273774,0.0810952,-0.5821,0.184982,-0.190016,-0.150048,0.281986,0.907437,0.0149545,0.320148,0.41341,-0.307426,0.0347563,0.0348321,0.747208,0.355229,-0.239139,1.21532,0.28877,0.548681,-0.568791,-0.358006,-0.131777,-0.721767,-0.684151,0.103728,-0.210843,0.342474,0.751546,0.0727369,-0.273416,0.421001,-0.395275,-0.152614,-0.838621,0.325682,-0.630103,0.200139,0.586546,-0.509721,-0.71147,-0.337522,-0.00443029,0.0109383,0.144734,0.125382,-0.381418,-0.178104,0.767364,0.824062,-0.275375,0.625172,0.0361378,0.350026,0.487722,-0.316676,0.0613476,-0.0503985,-0.134738,0.0955858,-0.199346,0.546101,0.449005,0.288768,-0.502443,-0.0487861,-0.373268,-0.0675572,0.137826,-0.0237808,0.10834,0.0122377,-0.285032,-0.00979112,-0.184954,-0.241447,0.129945,-0.20567,0.0836618,-0.312104,0.271331,-0.0615515,-0.252987,0.965518,-0.532407,0.319754,0.322358,0.320341,-0.429919,-0.127062,0.48926,0.23459,0.0577196,-0.205308,0.256559,0.263159,0.395382,-0.748621,0.465406,0.120197,0.112184,0.154128,0.125209,0.140069,-0.0924227,0.323924,-0.952014,-0.398285,-0.00623872,-0.243733,0.267779,-0.377881,0.0150655,0.256334,-0.527024,0.297848,-0.271242,0.298669,-0.0721756,-0.152292,-0.20047,0.334174,0.137029,0.0813634,-0.184323,-0.07962,-0.0651755,-0.561529,-0.0220415,-0.115455,0.0757528,-0.179845,-0.527275,0.566587,0.401361,-0.364614,0.00296919,-0.014285,-0.0898503,0.62931,0.152634,-0.0263543,0.137571,-0.0288109,-0.153649,0.0607775,0.0234372,0.263232,0.0806006,0.161176,0.173961,-0.232163,-0.0292931,-0.247983,-0.207189,0.445534,0.822522,-0.0774095,0.401381,0.0552865,0.0773744,-0.172241,-0.357056,-0.0215083,-0.384073,0.121097,-0.465743,-0.134463,0.0475105,0.287898,-0.472527,0.330083,0.531623,0.122364,-0.372543,-0.301027,-0.190678,0.0756692,0.121488,0.106515,-0.2346,0.0650593,-0.0885316,-0.658744,0.838859,-0.338517,0.178084,-0.0136985,-0.440924,0.121785,0.140877,-0.429928,0.221006,-0.176744,0.134877,0.0663903,-0.0527122,0.076115,-0.504478,-0.132849,0.558422,-0.0531793,0.732493,-0.0288763,-0.63527,0.0109075,-0.378851,-0.224994,0.0507892,-0.40983,0.0604961,-0.228223,0.54388,0.0970267,0.111031,0.779518,-0.385672,0.531991,-0.260878,0.118281,0.166563,0.252182,0.121244,-0.0295383,-0.00325669,0.0940846,-0.780567,-0.4927,-0.171749,0.170218,-0.277369,0.351134,0.290677,-0.409514,-0.100213,0.164638,0.0990067,-0.147029,0.346696,0.279953,0.478592,-0.00769046,0.0594046,-0.130759,-0.25943,-0.584304,-0.144884,-0.162479,0.00850286,-0.181016,0.238908,-0.134981,-0.108824,-0.130732,0.0236998,-0.411707,-0.668058,-0.612649,0.367744,-0.474503,-0.0559425,0.205024,0.0149901,-0.416449,-0.294908,0.0848013,0.0262848,0.0666146,-0.0123396,0.232233,0.544552,-0.154445,0.173654,-0.740155,-0.180526,-0.315223,0.0160323,-0.0417026,0.0924309,0.236292,0.304025,0.486099,-0.344289 +3478.75,0.88961,0.0912059,4,1.61219,0.950824,-0.976342,0.304995,0.217809,-0.0874447,-0.0731541,-0.0731588,0.262517,0.637377,0.287278,-0.127065,-0.444735,0.679422,-0.148698,0.81967,-0.231827,0.14939,-0.224795,0.17336,-0.18458,-0.925616,-0.598323,0.224987,-0.363243,-0.327206,-0.273812,0.35573,-0.0300915,0.041254,0.68542,-0.320616,0.0838174,0.109809,-0.345748,0.01102,-0.49649,0.535028,0.738523,-0.640941,1.07087,1.13216,0.0325333,-0.69987,-0.0254899,0.511714,-0.297199,-0.167432,0.550416,0.124977,0.162324,0.423248,0.164151,-0.0604158,0.415886,-0.349529,-0.329726,-0.902075,0.275379,-0.323065,0.512799,0.888641,-0.571925,-0.926661,0.0976234,0.152631,0.437867,-0.243114,0.079287,-0.575069,-0.236561,0.450678,0.0232047,-0.309067,0.712363,0.754902,0.0958758,0.0609422,-0.182783,-0.0428552,0.577978,-0.188205,0.00533532,-0.00871269,0.0120818,-0.365231,0.0927556,-0.0621843,0.385403,-0.214252,0.109742,-0.292046,-0.0104797,0.197116,-0.392209,-0.297813,-0.317646,-0.387115,0.188602,-0.108568,-0.419743,-0.0719003,-0.194499,-0.604463,-0.0613752,-0.0746247,0.0666782,-0.235202,0.261721,0.182246,-0.0388946,-0.113005,0.0252284,0.540589,0.258304,0.256167,-0.0441065,0.203183,0.0992046,-0.360273,-0.357114,-0.283277,-0.157101,0.174603,0.231043,0.116739,0.308932,-0.00849566,-0.183949,0.164728,0.262766,-0.34463,-0.162785,0.563547,0.126185,-0.272352,-0.0231141,-0.300915,0.271898,-0.289673,-0.18292,0.0365185,0.310186,0.0325499,0.315422,0.0510506,-0.31447,-0.130799,-0.312554,-0.195431,0.201579,0.189686,0.0242514,-0.11441,0.260046,0.507569,-0.745157,0.190819,-0.274923,-0.351016,-0.12452,0.163629,0.627129,-0.456311,-0.369516,0.157123,-0.105266,0.107139,-0.376036,0.150993,-0.0896641,-0.275183,0.0473439,0.173393,0.208103,-0.00551491,0.232181,-0.0649811,-0.227011,0.720214,-0.121412,-0.614782,0.648938,-0.293362,0.0531984,-0.189662,-0.110775,-0.337151,-0.244271,-0.37193,-0.0262462,0.325345,-0.0884355,-0.620021,-0.148272,0.471465,-0.271419,-0.549714,-0.149687,0.385908,-0.0979727,0.0568023,0.342704,0.318639,-0.340848,-0.210522,-0.429916,0.773087,0.563233,-0.0918151,-0.0375559,0.130294,-0.114641,-0.0400489,-0.305735,0.0845123,-0.32709,0.0479454,-0.00546509,-0.379051,-0.131286,0.0700279,0.118035,0.320117,0.0743808,0.100017,0.0398099,0.040094,0.347843,0.27117,0.0692829,0.327133,0.00849958,-0.286843,-0.527868,0.600933,0.32944,-0.389463,0.385435,-0.437697,0.0143361,0.314877,-0.203543,0.140493,0.0146045,-0.0698199,-0.0470323,-0.230467,0.0416401,-0.255663,0.030366,-0.638892,0.551174,-0.346434,-0.358654,-0.121331,-0.192908,0.003513,0.143204,-0.255396,-0.206826,0.339361,0.106342,0.0568102,0.490924,0.122046,0.116074,0.0783001,0.37664,-0.310835,-0.271043,-0.407201,-0.291432,0.0703894,-0.134462,0.140377,-0.500498,0.0462356,0.0017145,0.329269,-0.096131,-0.0138396,-0.642842,-0.150499,-0.149314,-0.127882,-0.0786565,0.13952,0.1418,-0.064778,0.0172593,-0.0923654,-0.230937,0.248102,-0.314968,-0.252277,-0.101426,0.466757,0.213831,-0.647107,0.196927,0.0848867,0.183825,0.291353,0.428748,-0.546297 +3456.33,0.978948,0.0912059,4,1.6419,0.883107,-0.864926,0.278872,0.148601,-0.100759,0.0877866,0.139661,0.47863,0.287675,0.442622,-0.2058,-0.077056,0.633404,-0.0778557,0.423846,0.080549,0.0815155,-0.288678,0.253097,-0.356352,-0.966656,-0.627094,0.330742,0.168889,-0.584921,0.0308886,0.312824,-0.0292342,0.305025,0.711202,-0.332472,-0.153226,-0.0633207,-0.405544,0.156602,-0.734913,0.794192,0.470596,-0.644366,1.24889,0.822783,0.172997,-0.927254,-0.0942475,0.359271,-0.0662035,-0.313972,0.539202,0.082762,0.502586,-0.511013,0.230487,-0.568306,0.673443,-0.187132,-0.191751,-0.392261,-0.00996089,-0.435888,0.38071,0.949488,-0.565863,-0.715679,-0.271467,0.127063,-0.0617664,0.304504,-0.124592,-0.68795,0.00161747,0.285088,0.337813,-0.0110485,0.325161,0.548845,0.284829,0.0282533,-0.352337,-0.129298,0.303408,-0.472258,-0.08054,0.0117215,0.0274194,-0.287016,-0.361416,-0.133816,-0.21197,-0.161123,0.322302,-0.116538,0.016574,0.575018,0.0196408,-0.207963,-0.383074,-0.132873,-0.00517865,0.044416,-0.10514,0.342171,-0.149618,-0.75089,-0.0340271,-0.0567762,0.378494,-0.151255,-0.125184,0.0251312,0.298781,-0.000931293,-0.112958,0.318037,0.000959409,-0.238233,-0.118243,0.289564,0.325085,-0.0795537,-0.284406,-0.208431,-0.246476,0.210757,0.168444,0.0794122,-0.146055,0.344003,-0.420804,0.0755574,0.216296,-0.24466,-0.089626,0.809964,0.35899,-0.174519,0.0905248,-0.531694,0.349021,0.21103,-0.265245,0.052295,0.000701175,-0.157287,-0.399025,0.528264,-0.375868,0.0397685,-0.40071,-0.446135,0.143165,0.408627,-0.0691947,-0.0461148,0.283352,0.106951,-0.415647,0.509162,-0.260298,0.218279,-0.156545,-0.151496,0.544124,-0.393823,-0.156191,-0.237631,-0.208745,-0.39665,-0.289804,0.139879,-0.0348382,-0.598255,0.0930237,0.386823,0.263823,0.0257488,0.205787,0.127536,-0.250593,0.579975,-0.195756,-0.276715,0.6227,-0.446103,-0.54226,0.121203,0.162354,-0.48076,-0.146275,-0.127422,-0.240608,0.317661,-0.278344,-0.742958,0.0666366,0.250843,-0.0990358,-0.138788,0.053854,0.501015,0.0378366,0.0104444,0.0308861,-0.0855759,-0.244779,0.169109,-0.416791,1.02308,0.186656,-0.280022,-0.0899348,-0.282835,0.00711794,-0.157785,-0.147951,-0.0228293,-0.756058,0.0930345,0.132695,-0.360486,-0.167823,-0.134899,-0.173036,0.241765,-0.360206,-0.0686676,-0.418336,-0.239592,0.259149,-0.278073,0.239138,-0.102978,-0.113097,0.0553101,-0.373031,0.551742,0.282467,-0.18017,0.362945,-0.219421,-0.101092,0.20661,-0.154989,0.0629465,0.357393,-0.126003,0.105358,-0.368032,0.0362211,-0.438672,-0.161654,-0.375352,0.212367,-0.382499,-0.0990484,-0.0692408,-0.0183206,0.109452,-0.31409,-0.178647,-0.271822,0.0633445,-0.19825,0.0207327,0.286266,0.108395,0.15114,0.0195186,0.140927,-0.101273,-0.113959,-0.367877,-0.527736,0.52884,-0.480631,0.211787,-0.620454,0.436137,-0.123247,0.165416,-0.442095,-0.269141,-0.192047,0.452474,-0.0343743,-0.136374,-0.250654,0.192924,-0.0110551,0.421984,0.0730578,0.363658,-0.0417258,0.200177,-0.261157,-0.42623,0.0786567,0.344663,0.35559,-0.258948,0.23548,0.0917377,0.199759,0.302882,0.446944,-0.197549 +3459.99,0.891546,0.0912059,4,1.59835,0.835669,-0.95849,0.367417,0.0491237,-0.0546952,0.277591,0.0830213,0.344426,0.142205,0.205746,-0.171319,-0.261482,0.663247,-0.077541,0.318211,0.118,-0.0747758,-0.284134,0.321297,-0.321946,-0.97014,-0.367374,0.331718,0.0901152,-0.503212,0.114627,0.204217,-0.0559312,0.135087,0.827539,-0.543146,-0.294968,0.155385,-0.403951,0.168679,-0.604107,0.718001,0.422117,-0.711329,1.0847,0.621223,0.145094,-0.923442,-0.0478704,0.475927,0.0459944,-0.529795,0.306879,0.097841,0.502308,-0.457972,0.381072,-0.555478,0.515902,-0.242973,-0.266116,-0.499753,0.262966,-0.320885,0.322615,0.749546,-0.356542,-1.04447,-0.225661,0.0862836,-0.113582,0.582258,-0.331431,-0.7848,0.000254012,0.147236,0.26357,-0.0568879,0.233868,0.451955,0.195818,0.0157879,-0.222067,-0.0399012,0.298216,-0.286192,-0.0361581,0.069831,0.213618,-0.258959,-0.337911,-0.198932,-0.250828,-0.233326,0.151353,0.111775,0.0403951,0.4295,0.0887884,-0.146324,-0.251559,0.0267111,-0.11941,0.179899,0.192302,0.294444,0.0856584,-0.600066,0.138407,-0.122613,0.310648,-0.192039,0.046197,-0.114832,0.187042,0.133369,0.119351,0.371722,0.283489,-0.305227,-0.317431,0.0682667,0.208137,-0.0265526,-0.355494,-0.0623748,-0.0377387,0.243851,0.075912,0.155085,0.230379,0.508931,-0.231906,0.047785,0.105029,-0.335362,-0.195081,0.84603,0.0851035,0.0559667,-0.104672,-0.442446,0.462222,0.165854,-0.287738,-0.101504,0.204696,-0.0682267,-0.362291,0.40291,-0.421579,0.124725,-0.444904,-0.361334,0.161569,0.249369,-0.0434404,-0.0802187,0.213752,-0.0552498,-0.44306,0.335997,-0.229967,0.275828,-0.31307,-0.140312,0.540314,-0.336142,-0.120153,-0.202126,-0.150341,-0.292167,-0.404102,0.211073,-0.201752,-0.429131,0.0448263,0.395006,0.175363,0.0709347,0.139032,-0.0231676,-0.0635406,0.432993,-0.135767,0.00491234,0.417278,-0.650643,-0.432573,0.165459,0.0126558,-0.560337,-0.320448,-0.416639,-0.0350558,0.31985,-0.097906,-0.645429,0.327562,0.275714,-0.144392,-0.0958208,-0.117656,0.666227,-0.1363,0.1169,-0.159687,0.0947133,-0.207699,0.108757,-0.276883,0.853348,0.264109,-0.320632,0.0320071,-0.281338,0.115125,-0.0203243,-0.359674,0.0740044,-0.781796,0.120217,0.0521367,-0.370992,-0.0548685,0.0547745,-0.210016,0.253688,-0.0859187,0.199442,-0.458091,-0.15669,0.307583,-0.346131,0.270509,-0.0300853,-0.380105,0.0830652,-0.368598,0.595797,0.572892,-0.0324715,0.25437,-0.339955,-0.250804,0.265257,-0.182345,-0.0874347,0.234323,-0.276006,-0.105759,-0.352345,0.156979,-0.617565,-0.111356,-0.309945,0.241518,-0.187324,-0.0251566,0.00344294,-0.0067966,0.154752,-0.106937,-0.196517,-0.390363,0.0529415,-0.21027,0.0853356,0.437374,0.0271133,0.236917,0.237154,0.230828,-0.0305006,-0.198966,-0.465421,-0.35681,0.541305,-0.443677,0.148707,-0.400905,0.419537,-0.0840425,0.23941,-0.425932,-0.1767,-0.343087,0.403702,-0.0514683,-0.0410111,-0.157032,0.124585,0.277515,0.391409,0.0111782,0.462453,0.059741,0.194647,-0.219032,-0.442026,-0.0813489,0.0655698,0.273727,-0.173281,0.174757,0.0930554,0.19841,0.30505,0.445432,0.126679 +3430.71,0.535811,0.0912059,4,1.64155,0.755803,-0.977746,0.378401,0.183225,0.0186667,0.0784056,0.0769738,-0.0163628,0.206585,0.494922,-0.317166,-0.350772,0.572584,-0.0937988,0.37975,0.19961,0.012992,-0.26108,0.223477,-0.349583,-0.8598,-0.710508,0.438043,-0.126211,-0.674142,0.0575272,0.390917,-0.107058,0.166133,0.640656,-0.15278,-0.0764825,0.105197,-0.360741,0.201393,-0.760011,0.834671,0.465195,-0.793783,1.2028,0.791436,0.0928891,-0.829611,-0.315826,0.244881,-0.421963,0.0265492,0.653291,-0.0295473,0.647769,-0.383876,0.334338,-0.545695,0.590937,-0.409862,-0.512069,-0.372113,0.249931,-0.522047,0.161298,0.898794,-0.80608,-0.955289,-0.1998,-0.217836,0.223183,0.363548,-0.562519,-1.06782,-0.115374,0.0255679,0.355649,-0.167752,0.306473,0.302467,0.127582,-0.117165,-0.536357,-0.107556,0.139285,-0.424159,-0.111491,0.576683,0.131947,-0.125052,-0.260262,-0.0656552,-0.065015,-0.170866,-0.0359139,-0.0996269,0.137845,0.293763,0.00222652,-0.00384755,-0.162325,0.117055,0.21891,-0.0228883,-0.00407185,-0.0326227,0.00260785,-0.14091,0.258982,-0.165885,0.0566136,-0.258564,0.338548,-0.0470177,0.177416,0.321681,0.00632725,0.351589,0.230909,-0.275601,-0.835108,-0.00405758,0.0247669,-0.0984321,-0.217728,-0.0335439,0.00435617,0.235634,0.238622,0.0273293,0.343008,0.180469,-0.14768,-0.0684721,-0.0410082,-0.24376,-0.112395,0.79434,0.139085,-0.0243463,-0.291797,-0.484424,0.53597,0.304848,-0.315452,0.0427861,0.331216,-0.33389,-0.19047,-0.038552,-0.524039,0.014806,-0.0366776,-0.510421,-0.152778,-0.0890858,0.304113,0.267435,0.122937,0.121382,-0.443606,0.688164,-0.180082,-0.0331175,-0.504494,-0.26046,0.640099,0.0567508,0.161318,-0.211414,-0.278444,-0.431524,-0.355349,0.243676,-0.137973,0.0545002,-0.0247394,0.317193,0.0794612,-0.0903225,0.0252801,-0.0102526,-0.201469,0.66366,-0.11478,0.361317,0.308062,-0.367441,-0.438034,0.242015,0.055041,-0.740428,0.0628694,0.109936,0.0830074,0.243508,-0.108979,-0.343661,0.254864,0.306906,0.164433,-0.325765,-0.0539345,0.482924,-0.316247,0.356352,-0.278767,-0.0997503,-0.424202,0.0112871,-0.0332394,0.737861,0.269686,0.0388043,-0.204865,-0.0455882,0.118763,-0.0827159,0.0551111,0.375068,-0.660408,0.0587975,0.118668,-0.421621,0.078901,-0.0106239,-0.235237,-0.350125,0.0237083,0.439509,-0.181925,-0.38812,0.388701,-0.262614,0.19667,-0.157254,-0.658495,0.4306,-0.66541,0.519734,0.297895,0.242348,0.462554,-0.498658,0.0232907,0.0539908,-0.189829,0.0554018,0.640349,-0.641268,0.0817516,-0.00477336,0.194006,-0.613117,-0.198085,-0.292353,0.113798,-0.195174,-0.0730324,0.121645,-0.0695204,0.195973,-0.18353,-0.131496,-0.312378,0.135426,-0.199683,-0.356259,0.27168,-0.495941,0.0431795,0.0985635,0.448502,-0.311857,0.0520703,-0.64996,-0.619288,0.339663,-0.438854,0.468041,-0.10604,0.0713013,-0.161514,0.582744,-0.0132497,-0.416245,-0.51496,-0.103468,-0.27397,-0.360995,-0.442066,-0.0847973,0.0401204,0.290414,0.0665197,0.359327,-0.0988161,0.392559,-0.0910124,-0.413098,0.0126978,-0.0192253,0.183629,-0.058862,0.0787656,0.0727149,0.216157,0.269657,0.464927,-0.152743 +3436.71,1,0.0912059,4,1.60575,0.856966,-0.604045,0.140177,-0.0649504,-0.0446745,0.131239,0.105658,-0.255397,0.144898,-0.201094,-0.384798,0.00553365,0.527623,-0.281146,0.897175,0.335249,-0.045663,-0.708217,0.252552,-0.0174224,-0.499332,-0.910796,0.120217,-0.449903,-0.0412262,0.330827,0.241718,-0.334753,-0.218509,0.808777,-0.79411,-0.0295674,0.13254,-0.557399,-0.150229,-0.0502624,0.20212,0.223065,-0.706413,0.724229,0.40157,-0.0556667,-0.392723,0.182841,-0.583616,-0.651364,0.272648,0.713494,0.188881,0.187192,0.417201,0.251468,-0.216173,0.795664,0.170854,0.199235,-0.332796,0.576236,0.141811,-0.269866,1.03413,-0.616816,-0.701764,-0.33525,0.0694156,-0.522079,-0.595867,0.505347,0.0470266,-0.0291119,0.579619,0.485895,0.0804613,0.423133,0.404107,0.0314444,0.265774,0.00959028,0.164882,0.197319,-0.230007,0.415132,-0.488974,0.124532,-0.18408,-0.176905,-0.227831,0.369163,-0.467266,-0.381238,-0.267868,0.0725536,-0.153717,0.0945443,-0.100691,0.0166963,-0.282014,0.448126,0.477649,0.115111,0.204051,-0.745432,-0.0730705,0.0358094,0.0376043,0.397406,-0.365378,-0.157756,0.790802,0.103495,-0.598604,-0.133968,0.430461,-0.067888,0.18988,0.300697,0.287016,-0.0482235,0.534957,-0.47867,0.331825,-0.162417,0.0704397,-0.23372,0.190368,-0.101337,-0.296569,0.137412,-0.198967,0.141914,0.193803,0.258614,0.235204,-0.403158,-0.121027,0.219069,-0.0257053,0.0907705,-0.760016,-0.0900458,-0.0409778,-0.155913,-0.434676,-0.238169,-0.424105,0.274387,0.4684,-0.18848,0.193273,0.0309556,0.37865,0.28242,-0.293304,-0.237297,0.174254,-0.0748648,-0.218499,0.569415,-0.146543,0.335608,0.1671,0.478032,0.200691,0.191832,0.444221,0.262282,0.100105,-0.0342329,-0.369697,-0.0657541,-0.241692,0.013874,-0.407431,-0.048516,-0.348222,-0.300938,0.271513,0.387966,-0.056917,0.313683,-0.965704,0.388026,0.0925869,0.0673867,-0.0086037,-0.0766011,-0.26741,0.143731,-0.199716,-0.205553,-0.324026,-0.321155,-0.453588,-0.556317,0.334423,-0.252005,-0.151626,-0.771638,0.0851504,0.218968,-0.332656,0.520838,-0.0569577,-0.301581,-0.0755148,-0.273645,0.853509,0.205689,-0.251192,0.166652,0.071756,0.0377478,-0.0677012,-0.365493,-0.315641,0.478212,0.438567,0.240694,-0.151252,-0.0987118,-0.670625,0.0795707,0.239327,-0.473522,0.0235581,-0.121803,-0.136359,-0.497335,0.137785,-0.519718,0.332333,0.533097,-0.542482,0.073689,0.441297,0.0977104,0.379823,0.347751,0.154352,-0.375461,0.495311,0.0727165,-0.00566416,-0.0847201,0.888743,-0.000207128,0.275116,-0.448007,-0.219743,0.389248,-0.159043,0.335982,-0.201528,0.34258,-0.111824,-0.217296,-0.640076,0.0769061,-0.17034,0.162136,0.213122,-0.037593,0.22455,-0.144038,0.0801581,-0.273201,-0.0990675,-0.525645,0.291837,-0.0640569,0.263349,0.490183,-0.354175,0.357206,-0.200123,0.195637,-0.250024,0.338005,-0.260749,-0.547854,0.192698,0.100959,0.350896,0.254895,0.238679,-0.0896515,0.610237,-0.253569,-0.264349,-0.0664012,0.00293886,0.256336,-0.225196,-0.124904,-0.699365,0.335166,-0.243811,-0.330951,-0.145783,0.357394,0.0903009,0.224789,0.300501,0.474119,0.501904 +3415.67,0.858997,0.0912059,4,1.52197,0.881388,-1.00987,0.339461,0.583061,-0.022674,-0.0865907,0.345515,0.481817,0.251944,0.208878,-0.327046,0.256595,0.406478,0.0339959,0.419419,0.393301,0.492261,0.0585188,0.506157,-0.0113035,-0.683627,-0.831443,0.318366,-0.0321374,-0.318492,-0.145585,0.536517,-0.591653,-0.0757182,0.942469,-0.803491,0.192507,0.0658251,0.136392,0.142526,-0.682102,0.578101,0.448519,-0.234586,0.597504,0.744126,0.140095,-0.372611,0.0974687,-0.22764,-0.645099,-0.0562985,0.452998,0.466415,0.252618,-0.142626,0.362081,-0.166271,0.533607,-0.114829,-0.222618,-0.621555,0.43375,-0.218724,-0.0211507,1.33618,-1.05985,-1.12459,0.331267,-0.130229,-0.0389226,0.0540787,-0.0214255,-0.832287,0.610216,-0.19714,0.567568,-0.213053,0.834068,0.084315,-0.0990934,0.552898,-1.02825,-0.0962289,0.5386,0.0969636,-0.00188755,0.320121,0.253835,0.30211,-0.256358,-0.0495958,0.226868,-0.267387,0.410363,-0.00890345,0.344899,0.255527,0.371333,-0.257514,0.251058,-0.192667,-0.102033,0.88014,0.27391,0.152342,0.0703949,-0.394639,0.485887,-0.176606,0.856519,0.160494,0.00876895,0.328566,-0.101731,-0.0495256,-0.0661131,0.568892,0.324551,-0.0607563,-0.494911,0.00483774,0.0581755,0.113817,-0.717442,0.171726,0.118572,-0.365889,0.0254249,0.167038,-0.0293046,-0.0418954,0.234899,-0.544843,-0.171389,-0.232215,0.251322,0.66872,0.0352252,-0.296333,0.107277,-0.567749,0.128042,-0.0622718,0.0401463,0.153712,-0.141611,-0.626573,-0.108005,0.360459,0.249656,0.703912,-0.208551,0.329872,-0.0992607,-0.233677,-0.0150548,-0.208847,0.568233,0.437864,0.246387,-0.317225,0.0133885,0.227073,0.338166,-0.0736891,0.526926,0.311369,0.801594,-0.274611,-0.134684,-0.487052,-0.194774,-0.143435,-0.169847,0.189885,0.136902,-0.619713,-0.430152,-0.252337,-0.11484,-0.144693,-0.10463,0.521008,0.00393831,-0.00123255,0.199136,0.0701145,-0.0658194,-0.347522,-0.224518,-0.0325675,0.478697,-0.670496,-0.118804,0.0144893,0.489262,-0.682976,0.00293139,0.0761811,-0.190918,-0.496589,-0.894664,-0.205952,-0.456468,0.224039,-0.542715,0.127271,0.141711,0.373047,-0.578882,0.687964,0.13493,0.305321,-0.121495,-0.29821,-0.00521341,0.232162,0.43912,0.287536,-0.698734,0.322586,0.53364,-0.718122,-0.43671,0.079418,-0.108617,-0.500908,0.1971,0.566146,-0.884934,-0.908268,0.157635,-0.432341,-0.415067,-0.0122643,-0.237763,0.224252,-0.0802194,0.570116,-0.554602,0.187024,-0.0200035,-0.307947,-0.767358,0.447591,0.264022,-0.085441,0.328747,-0.442163,0.542307,0.223019,0.0598034,-0.557559,-0.244779,-0.134697,-0.124091,-0.69688,0.0618774,-0.646526,-0.683301,-0.0390396,0.165733,-0.123774,-0.024547,0.473991,-0.24998,-0.0256771,0.0298012,0.372828,-0.216686,0.190869,0.186835,0.0239147,-0.105921,-0.447555,-0.707575,-0.181837,0.389125,-0.147726,0.668382,0.0873567,0.53435,-0.211233,-0.440772,-1.01518,0.586093,0.087182,-0.358464,-0.033312,0.168512,0.231872,0.375403,-0.54226,0.132625,-0.316914,-0.102869,-0.258184,-0.137087,-0.297215,-0.0238269,0.0523249,0.649268,0.126319,0.0131881,0.128103,0.22175,0.357915,0.470903,-1.75758 +3422.3,0.913144,0.0912059,4,1.47989,0.791681,-1.21193,0.467235,0.623,-0.194674,0.256285,0.384721,0.213179,0.795956,0.0285055,-0.680933,0.0165572,0.312775,0.124967,0.367893,0.358867,0.368204,-0.00447611,0.328459,0.397109,-0.629593,-0.296894,0.456752,-0.215331,-0.366417,-0.0135213,0.314196,-0.679121,0.0295892,0.848145,-0.314857,-0.294991,0.526578,-0.0728589,-0.0928463,-0.220496,0.269719,0.294677,0.320226,0.758716,0.189942,0.36631,-0.464749,-0.0418796,-0.0531414,-0.804343,0.295591,0.379692,0.0411569,0.191907,-0.106633,0.346795,-0.335482,0.755908,0.324477,-0.105941,-0.724628,0.497758,-0.010733,0.153361,1.34109,-0.378847,-0.43288,0.158237,0.0724669,-0.579611,-0.206572,0.13709,-0.684898,0.336535,-0.106419,0.45591,-0.220929,1.12511,-0.170108,0.10631,0.236941,-0.878558,0.0474653,0.576164,-0.460394,-0.0214381,-0.148621,-0.0304924,0.0424205,-0.381593,-0.723125,-0.0178411,-0.243014,0.0304836,0.220167,0.168811,-0.40535,-0.233477,-0.434832,0.00148309,0.419607,-0.291607,0.660388,0.18245,-0.00694306,-0.213335,-0.29719,0.307473,-0.26855,0.577527,-0.418145,-0.245899,0.307558,0.17944,-0.20085,0.451036,0.287002,0.111131,-0.0627791,-0.281194,0.0544857,0.0284602,0.0292715,-0.205187,-0.212567,0.101263,-0.758595,-0.100662,0.193116,-0.326505,-0.404584,0.375529,-0.0687199,0.240153,0.192001,-0.0158559,0.827403,-0.438635,-0.761406,0.0947604,-0.422403,-0.151726,-0.493951,-0.499233,-0.119871,-0.217519,-0.500459,0.020922,-0.217024,0.0253553,0.582927,-0.167259,0.00108908,0.0829277,0.569956,-0.0536108,-0.4463,0.430069,-0.222021,-0.324532,-0.0601604,0.41564,0.80041,-0.117373,0.603276,0.721602,0.0171154,0.187092,-0.0781127,-0.0271402,-0.334955,-0.169853,0.0129883,0.397692,0.170649,-0.0504431,-0.535723,-0.339009,-0.0925437,-0.3485,0.293357,0.504265,0.263853,0.433949,-0.23017,0.541718,0.263637,-0.202979,-0.160516,-0.537065,-0.102125,0.654649,-0.235418,-0.037591,-0.527091,0.205871,-0.369909,-0.0286112,-0.110514,0.0189061,-0.692212,-0.695865,0.106507,-0.0898731,-0.547441,-0.0480181,0.12319,0.0863717,0.160502,-0.326104,1.06901,0.000826704,0.370953,-0.250938,-0.0700871,-0.14735,-0.216379,-0.037195,0.635452,-0.767919,0.169354,0.261107,-0.49607,-0.102201,-0.171359,-0.12596,-0.396356,-0.238451,0.359417,-0.525992,-0.511434,0.110879,-0.350299,-0.170141,0.11411,-0.403803,0.250734,-0.16293,0.850533,-0.154641,-0.668591,0.215964,-0.34436,-0.347268,0.614814,0.166568,-0.0351915,0.119837,0.139883,0.532207,0.175974,-0.13448,-0.269372,0.0212578,-0.418965,0.0454169,-0.391781,-0.1755,-0.503244,-0.518841,-0.123165,-0.286059,-0.0780992,0.291019,0.461674,-0.102319,-0.07168,0.407725,0.287884,-0.265207,0.346272,-0.309586,0.172496,-0.296509,-0.455947,-0.717573,-0.247209,0.114719,-0.406471,0.485696,0.28366,0.433461,0.164518,-0.65687,-0.505991,0.397622,-0.0757199,-0.0983127,0.152966,0.0902005,0.374298,-0.0547762,-0.388093,0.145413,-0.397775,-0.365896,0.458373,-0.40772,-0.581017,0.61763,-0.236087,0.068048,0.650155,0.217143,0.148763,0.229721,0.385698,0.479292,-1.74567 +3405.88,0.61694,0.0912059,5,1.46711,0.733611,-1.19667,0.504051,0.496808,-0.0982697,0.171136,0.0496864,0.304458,0.105638,0.265465,-0.123509,-0.211263,0.523309,0.00202971,0.671789,0.678987,0.666789,0.150198,0.633237,0.370651,-0.603039,-0.265015,0.35261,-0.0790845,0.0650135,0.46881,0.358518,-0.0424921,0.147583,1.05147,-0.88593,0.353393,0.498836,0.278823,0.185932,-0.504862,1.27996,0.732513,0.292138,0.542405,0.21037,0.425577,-0.459799,-0.0232644,-0.680523,-0.354881,0.633258,0.677587,0.669336,0.198631,0.404858,-0.100623,-0.0666417,0.723718,0.0333614,-0.154709,-0.339751,0.230651,-0.429017,0.153298,0.875419,-0.825459,-1.31744,-0.182008,-0.186772,-0.471132,-0.189169,-0.104242,-0.0599393,-0.0339308,0.552012,0.590264,-0.102756,0.457515,0.237362,-0.205851,0.17269,-0.84716,-0.314189,0.465409,-0.0870211,0.25045,0.0899488,0.119253,-0.0122911,-0.290985,-0.156814,0.262342,-0.505416,0.0643359,-0.230924,-0.460986,-0.474637,0.0655742,0.360078,0.209798,-0.200962,-0.397268,0.494689,0.246988,0.215157,-0.952786,-0.142931,0.546436,-0.0683704,0.230263,-0.380671,0.174658,0.10681,0.42595,0.184447,0.0279308,0.447327,-0.341512,0.630495,-0.594375,0.0876079,0.283219,0.541232,-0.633359,0.0564895,-0.402474,-0.246223,0.0236503,-0.186778,0.709772,-0.119904,0.540914,-0.666236,0.570032,-0.343439,-0.592371,0.4223,-0.323884,0.050252,-0.457774,-0.407537,0.191143,-0.519478,-0.104653,-0.202131,0.0270164,-0.876375,-0.172514,0.438439,-0.158322,0.51977,-0.148272,-0.254955,-0.411584,-0.25336,-0.618631,0.0840263,0.14908,0.336499,0.362098,-0.171116,0.037522,0.102653,0.426448,-0.520166,0.589943,0.294378,0.167876,-0.703406,-0.391574,-0.346833,-0.162741,-0.140053,0.224922,-0.227307,-0.0411945,-0.379045,0.0716275,-0.0929557,-0.00229753,-0.547692,0.080339,0.304869,-0.367285,-0.803244,-0.250609,-0.337171,-0.0953729,-0.731191,-0.409305,-0.291221,0.649272,-0.0143247,0.22145,-0.30856,0.371961,-1.18729,-0.363278,0.4219,-0.153949,-0.608775,-0.12535,-0.385991,-0.0631426,0.0445359,0.134831,-0.123316,0.52569,0.482024,-0.241145,0.916312,-0.0162423,0.576577,-0.22263,-0.521663,0.02533,-0.0357544,-0.249606,0.169042,-1.24733,0.6934,0.833323,0.0290392,-0.151405,-0.621273,0.0506112,0.408262,-0.582276,0.146336,-0.423554,0.205963,-0.12921,-0.16314,0.097746,-0.0696591,-0.368277,-0.171771,0.23687,0.537375,0.000961587,0.349469,0.792711,-0.038105,-0.039135,-0.301529,-0.00807692,-0.247453,0.101168,0.00882845,0.542331,0.70239,-0.130378,-0.43196,-0.264341,-0.486969,0.198905,-0.566106,0.257988,-0.119915,-0.450152,0.43657,-0.311211,0.243543,0.204538,0.558086,0.213746,0.263338,-0.00126764,0.455097,0.212385,-0.201029,0.422817,0.139158,-0.321102,-0.177965,0.318174,0.361086,0.14845,-0.688702,0.673718,0.697845,0.135477,-0.226848,0.107,0.281519,-0.321745,-0.835594,0.166443,0.32597,-0.359331,0.59346,0.0974536,-0.253924,-0.0650121,0.0393022,-0.0495085,-0.408872,0.0954358,-0.694175,-0.339508,0.02795,0.418323,-0.419003,0.192812,0.171165,0.226245,0.413721,0.475652,-1.30388 +3410.49,0.618873,0.0912059,4,1.46122,0.736975,-1.22248,0.536925,0.827745,-0.0499993,-0.0237127,-0.100984,0.433433,0.111077,0.013638,-0.366679,-0.205186,0.616718,0.0193166,0.515497,0.624997,0.599775,0.186386,0.488723,0.438352,-0.880097,-0.323857,0.657097,-0.361687,-0.0644123,0.301481,0.257653,-0.181078,0.216042,1.15608,-1.17185,0.426228,0.530823,0.128812,0.0276228,-0.674648,0.620085,0.413186,0.198682,0.633626,0.305665,0.127259,-0.133577,0.0693555,-0.335269,-0.484652,0.871545,0.445156,0.456343,0.318384,0.195881,0.122187,-0.227616,0.497656,0.25218,0.0563098,-0.338328,0.227401,-0.636112,0.213643,0.945897,-0.52014,-1.93445,-0.22994,0.155931,-0.617113,0.0544543,0.00172822,-0.1991,-0.113277,0.795789,0.577614,-0.45809,0.670137,0.35107,0.355377,0.218258,-0.72608,-0.341367,0.316056,0.0177673,0.0800703,0.273546,-0.196516,-0.122229,-0.355854,-0.135649,0.060038,-0.53925,0.0541219,-0.174198,-0.317774,-0.499236,0.248725,-0.102359,0.22999,0.188553,-0.357345,0.85032,0.238653,-0.201996,-0.919945,-0.0896519,0.334323,-0.112362,0.267724,-0.459611,-0.108281,0.207217,0.100352,0.11857,-0.196731,0.441454,-0.512761,0.401921,-0.344407,0.181429,0.00055074,0.175409,-0.512201,0.328465,-0.49289,-0.128588,-0.258018,0.281344,0.650682,0.0973972,0.418668,-0.318446,0.0103425,-0.168669,-0.324827,0.478508,-0.273172,-0.216075,-0.551865,-0.0920899,0.268264,-0.493693,-0.260069,0.0349773,-0.0781707,-0.814587,-0.0877228,0.363375,-0.249123,0.54421,-0.31466,-0.0884517,-0.599189,0.0720183,-0.603848,-0.544759,-0.0226911,0.167185,0.394038,-0.417955,0.369866,0.495223,0.119508,-0.21322,0.589347,0.394411,-0.111004,-0.607878,-0.402218,-0.185542,-0.332287,-0.00187336,0.157621,-0.383409,0.0600942,-0.200171,-0.0468555,0.10733,-0.0160569,-0.534472,0.587487,0.215116,0.143407,-0.534721,-0.0679449,-0.177338,-0.19207,-0.793206,-0.39973,-0.215239,0.680449,-0.169749,-0.0644527,0.176638,0.3602,-1.08083,-0.563521,-0.119969,-0.565615,-0.525695,-0.368468,-0.353469,-0.00361571,-0.0191905,0.343123,-0.259007,0.5212,0.524863,0.257434,0.804057,0.263175,0.687258,-0.0284156,-0.25171,0.0454522,0.0665559,-0.283023,0.116903,-1.06299,0.471174,0.728092,-0.167026,-0.157143,-0.30643,-0.0959744,0.704571,-0.220108,0.415314,-0.161099,0.0754513,-0.495378,0.092275,-0.0672625,0.0281191,-0.455059,0.269628,0.0880564,0.739298,0.0595382,0.112645,0.717221,-0.0930542,-0.234495,0.148229,-0.232689,-0.384725,-0.0664628,-0.0357686,0.734339,0.98533,-0.227948,-0.463836,-0.435771,-0.749656,0.188092,-0.497373,-0.129565,0.0411359,-0.520624,0.422391,-0.0980527,0.197399,0.116352,0.905885,0.26835,0.684368,-0.0740874,0.0722159,0.152912,0.435132,0.263968,0.0958152,-0.192176,-0.180365,0.221168,0.0768093,0.256413,-0.296361,0.214733,0.323193,0.310518,-0.0439463,0.165597,0.117418,-0.612574,-0.803278,-0.222365,-0.169276,-0.432796,0.0583686,0.43351,-0.241823,0.0655479,0.0956894,-0.467729,-0.488126,0.0924762,-1.06848,-0.196162,-0.143542,0.564105,0.0155242,-0.211785,0.155098,0.200499,0.393824,0.447771,-2.44404 +3386.42,0.802681,0.0912059,5,1.51814,0.861367,-1.06368,0.486128,0.689635,-0.14127,0.289922,0.194444,-0.0520147,0.104324,0.0258546,-0.233957,-0.454084,0.532782,0.0669601,0.756401,0.284206,0.330777,-0.182413,-0.0457656,0.169103,-0.531707,-1.10019,0.350193,-0.460565,0.0186421,-0.0645511,-0.343849,-0.37263,-0.15365,1.00746,-0.102317,-0.442129,0.548921,0.109923,0.0527978,-0.152645,0.774848,0.579604,-0.361342,1.10322,0.544762,0.738345,-0.600477,0.0360947,-0.0259341,-0.211713,0.446786,0.633384,-0.227818,0.0435433,0.602158,-0.175781,0.240522,0.762959,0.195326,-0.403092,-1.10195,0.344767,-0.283246,-0.0718498,1.15526,-1.17872,-0.828933,-0.086609,0.38676,0.0654277,0.233677,0.114479,-0.129252,0.419147,0.463666,0.468338,0.210994,0.701995,0.328672,-0.136842,0.0638308,-0.261934,0.0782803,-0.159383,-0.102188,0.492458,0.427212,-0.233528,-0.264211,0.668758,-0.183881,-0.329716,-0.669896,-0.205952,-0.222694,-0.079216,-0.164017,-0.522362,0.1992,-0.134601,-0.609943,0.304585,-0.195716,0.153723,-0.335949,-0.377423,0.158884,1.21573,-0.509009,-0.341328,0.0251372,0.262155,0.370328,-0.00765864,0.199441,-0.0813068,0.0684391,-0.175794,0.224689,-0.422065,0.160949,0.456137,-0.755495,-0.826299,0.138897,-0.10692,-0.0212931,-0.775756,0.131203,0.226886,0.563175,0.4748,-0.126458,0.166084,0.0332811,-0.210258,0.359508,-0.573792,-0.452562,0.150779,-0.0684892,-0.265315,0.28524,0.190871,-0.19307,-0.0412026,-0.235128,0.0161836,0.623746,0.404744,0.694353,-0.317065,0.351441,-0.59734,0.19032,-0.377849,-0.17469,0.795015,0.653148,-0.0951037,0.186698,-0.0380519,-0.231926,0.499441,-0.709905,0.0951838,0.067557,-0.277411,-0.208096,-0.344329,-0.161469,-0.529874,0.399369,0.380478,-0.90508,-0.424783,0.0460694,-0.133748,-0.0629411,-0.14302,-0.248599,0.365503,0.719631,0.387272,-0.0915317,0.791606,0.115339,-0.691064,0.0496583,-0.372659,0.351892,-0.00434526,-0.570588,0.0121639,-0.722481,-0.083743,-0.547127,-0.27325,-0.125686,0.220848,-0.446913,-0.40726,0.491493,0.00174588,0.0810226,0.337809,-0.115572,0.348672,-0.183112,-0.249428,0.896322,-0.229633,0.29744,-0.23099,-0.443735,-0.24888,0.18939,-0.347445,0.86853,0.195776,0.0483521,0.221062,-0.221757,-0.235447,-0.938194,-0.117181,-0.221537,-0.792152,0.0977247,0.351631,-0.487956,-0.765651,0.35612,-0.617732,-0.19121,-0.478241,-0.350878,-0.744671,0.676904,0.723315,-0.0851421,0.112498,-0.469685,-0.0429664,-0.197492,0.399174,-0.0196767,0.217705,-0.409508,0.270438,-0.0319308,-0.591444,-0.0971493,0.251141,-0.778951,-0.0384011,-0.941475,0.213028,-0.0680737,-0.413492,0.306487,0.0514148,-0.0122722,0.197681,0.0447824,0.0222923,0.117434,0.472126,0.0578046,-0.451552,-0.326309,0.236306,-0.114824,-0.39401,0.135486,-0.61797,-0.481632,0.00250786,-0.321606,-0.317775,-0.00860278,-0.0298845,0.119468,-0.544717,-0.0504102,0.284013,0.241901,-0.000661626,-0.0493972,-0.0504376,0.688658,-0.4096,0.218487,-0.372036,-0.282373,0.101676,-0.0679756,0.202927,-0.0888333,-0.000662047,0.345505,-0.225455,-0.236483,0.650919,0.13852,0.394664,0.372182,0.628223,-2.16099 +3407.91,0.851837,0.0912059,5,1.45088,0.754213,-1.23487,0.57536,0.858814,-0.0234638,-0.291549,0.122239,0.357184,0.282741,0.326455,-0.0599893,0.340173,0.927322,-0.217442,0.592874,0.126614,0.473582,0.153902,-0.0776326,0.553552,-0.812691,-0.159656,0.302997,-0.348495,0.278186,0.110419,0.658847,-0.434977,0.18761,1.10197,-0.196615,0.861767,0.839245,-0.272029,0.0567248,-0.595598,0.659387,0.362577,-0.454088,1.06833,0.14282,-0.0226515,-0.380224,0.111009,-0.808113,-0.540434,0.410062,0.0690421,0.0269199,0.159409,0.353073,0.0117968,-0.293989,0.740517,-0.203224,0.0620556,-0.183677,0.448469,-1.11015,0.239978,0.551473,-0.572928,-1.08141,-0.291857,0.255573,-0.194053,0.285669,-0.236486,-0.616237,-0.228754,-0.338299,0.32274,-0.394374,0.688398,0.174877,0.35943,-0.252895,-0.536119,-0.198742,0.510369,-0.414119,0.195644,-0.519354,-0.0231678,0.272659,-0.0265747,0.124245,0.477426,-0.225521,-0.425281,0.214187,-0.24537,-0.571438,0.059615,-0.00491599,0.195667,0.0160103,0.373222,0.110467,-0.0533366,0.458845,-0.405611,-0.329411,-0.538773,-0.12633,-0.126691,-0.184821,0.585536,0.404267,0.269824,-0.124407,-0.108509,0.112621,-0.125819,0.252093,-0.191105,0.00303453,0.189638,-0.25011,-0.485327,0.1295,0.197545,-0.295293,0.516947,0.456117,0.0248601,-0.154559,0.358676,-0.0270695,0.0282304,-0.517194,0.336018,0.740013,-0.401258,-0.00124668,0.17808,0.28649,0.536736,-0.164461,-0.240473,0.607923,0.37333,-0.740794,0.0760758,0.0922355,0.123563,0.69045,-0.174545,-0.781978,-0.328871,-0.321401,0.518317,-0.240697,0.395602,0.00393167,0.438318,0.0349239,-0.387594,0.665224,0.332291,0.475807,0.93993,0.0964685,0.0642053,0.0397417,-0.0712026,-0.0872631,-0.0325533,-0.287193,0.203211,-0.447982,-0.280097,-0.227062,0.0926573,0.251708,-0.0263291,0.543847,0.219789,0.896849,0.438927,0.357959,0.0137091,-0.0683035,-0.357484,-0.203791,-0.58982,-0.483298,0.226854,-0.0498494,-0.396935,0.309117,0.423784,-0.271406,-0.0964525,0.297865,0.0576369,-0.509064,-0.665173,-0.262248,0.330082,-0.258269,-0.132405,0.171707,-0.308799,-0.23891,-0.0437327,0.636285,-0.247097,-0.0719693,-0.217445,-0.0901642,0.0339703,-0.00142549,-0.228885,0.126511,-0.294036,-0.189938,0.523343,-0.476664,-0.161167,-1.00786,0.737846,0.540403,-0.493163,0.615915,-0.161185,-0.325928,0.318839,0.36604,-0.355643,-0.371716,-0.234633,-0.538635,-0.51951,0.461531,0.0400736,0.621914,0.744798,-0.242059,-0.290107,0.514712,-0.463565,-0.244809,0.449843,-0.0395354,0.617563,0.344285,0.34828,-0.870458,-0.19036,-0.386153,0.55903,-0.459801,-0.663344,0.663254,-0.283204,-0.103486,-0.620728,0.296697,0.196153,0.324902,0.284853,0.397689,0.477476,-0.0819849,0.181255,-0.285718,-0.308355,-0.694471,-0.25537,-0.59968,0.455644,-0.100374,0.182347,0.128254,-0.17797,0.195692,0.00224514,-0.317996,0.0387967,0.757604,-0.250756,-0.445956,0.618972,0.66638,-0.420503,0.175505,0.427245,0.226569,-0.185621,-0.0128008,-0.129395,-0.0080488,-0.228538,0.0608375,0.238271,0.248537,0.764644,-0.356128,-0.146446,0.115341,0.17404,0.339619,0.417181,-2.62457 +3422.38,0.931602,0.0912059,4,1.5941,0.804054,-0.632147,0.30865,0.486437,-0.184052,0.547896,-0.0666365,0.139956,0.149332,0.189409,-0.157467,-0.141747,0.807685,0.0506287,0.479427,0.652635,0.24514,-0.0999586,0.0457214,0.17958,-0.202346,-0.934862,0.310146,-0.194278,0.157592,0.34466,0.228788,-0.059157,-0.357927,0.835325,-0.175704,-0.0637343,0.503657,-0.14907,-0.0384158,-0.107003,0.485334,0.333745,-0.668646,1.03959,0.326555,-0.12052,-0.962776,-0.0888739,-0.0978462,-0.710253,0.10069,0.325882,-0.413825,-0.122062,0.142613,-0.108471,-0.0598101,0.993704,-0.0657901,-0.411038,-0.758495,0.346519,-0.0319796,0.0397281,0.822241,-0.286251,-0.630836,-0.349301,0.307206,0.333366,-0.389152,0.636426,0.150243,-0.487629,-0.424979,-0.00369617,-0.429326,1.11417,0.421752,0.255915,0.680895,-0.0106657,-0.189115,0.449049,0.0710635,0.524972,-0.168469,-0.374311,-0.310362,-0.0610771,-0.210896,0.471789,-0.456811,-0.112982,0.0600647,0.228668,-0.130444,0.220225,-0.140337,-0.300489,-0.387763,-0.0323628,-0.157175,0.348793,0.25034,-0.610725,-0.659132,-0.0761501,0.171562,0.24911,0.134707,0.359079,0.733545,0.198441,-0.528889,-0.128217,0.0839776,-0.675437,0.235364,-0.614016,0.189421,0.153082,-0.657559,-0.299967,-0.137797,-0.586227,-0.19867,-0.0688485,0.495351,0.42076,-0.240489,0.0924893,0.046889,0.0932764,-0.253186,0.0430474,0.58347,-0.0826664,-0.625201,-0.19951,-0.236006,-0.0857155,-0.860593,0.0912237,-0.0831644,-0.200364,-0.538774,-0.593566,-0.529415,0.0772181,0.745233,-0.371093,-0.0516102,0.151172,0.10324,0.0144471,-0.0139272,0.129616,0.508374,-0.148376,0.17205,0.0186785,0.112907,0.108642,0.00836347,0.375258,-0.555447,0.262582,0.220876,-0.0201194,0.0374462,0.102274,0.289214,-0.178125,-0.189862,-0.35806,-0.641528,-0.162343,-0.256523,0.0520478,-0.149853,-0.365174,0.59129,-0.333687,-0.0123213,0.408061,-0.336474,-0.665068,-0.145413,-0.226124,-0.0870304,0.33958,0.228163,-0.30622,0.210592,-0.0362081,-0.84606,-0.0729741,0.546156,0.3009,-0.552658,-0.62624,0.00368329,-0.0932777,-0.712837,0.118968,-0.100051,-0.248048,-0.0608503,-0.175235,1.02935,-0.211598,-0.0671552,0.266555,0.0615231,-0.492361,0.531152,0.132772,0.184717,-0.465972,0.0967206,0.33141,-0.17241,0.547077,0.226596,0.378367,0.0708072,-0.123062,0.266498,0.00385099,-0.295456,-0.0613518,0.082052,-0.0210962,-0.106053,-0.554867,0.0186898,-0.87117,0.460107,-0.263949,0.0503316,0.831797,-0.653052,0.142539,0.0387286,-0.025061,0.466489,0.658524,0.0889593,0.525484,0.33431,-0.44016,-0.471082,0.0146364,0.079512,0.232052,-0.106712,-0.120244,0.275258,-0.788904,-0.0137159,0.026445,0.258507,0.0762325,0.00152556,-0.00408716,0.361476,0.21812,0.509424,0.00562296,-0.136649,-0.0485436,0.196713,-0.0171295,-0.0581438,-0.803565,-0.766176,0.662614,0.162904,0.192476,0.406069,0.41294,-0.113583,-0.437443,0.149216,-0.0709667,-0.226226,-0.12983,0.32154,-0.414931,-0.136383,0.282397,-0.391212,-0.395684,0.148888,0.127072,-0.10606,0.0831297,-0.0143018,0.535032,0.0283343,-0.591483,-0.419695,-0.123102,0.149559,0.33607,0.386729,0.579715,-1.35685 +3411.46,0.92074,0.0912059,4,1.61016,0.817225,-1.1415,0.390007,0.730007,-0.242399,-0.531471,0.446422,0.27969,-0.215519,-0.247565,-0.3521,-0.141825,0.294149,-0.239228,0.273169,-0.0116079,0.0691487,-0.229371,-0.0390102,0.379384,-0.819166,-1.05857,0.280708,0.0345417,-0.182585,0.0481059,0.489611,-0.24805,0.0664888,0.723079,-0.578933,-0.418568,-0.16669,-0.377304,-0.312807,-0.380448,0.0721129,0.540474,-0.0946773,1.05896,0.277359,0.387411,-0.215171,-0.364179,-0.0932381,-0.693916,-0.361429,0.282641,0.194884,0.225393,0.63869,0.282081,-0.323363,1.20038,0.137291,0.161339,-0.619181,0.42842,-1.22868,0.23855,0.986403,-0.301772,-1.14028,0.317247,0.212103,-0.532321,-0.180467,-0.59149,-0.210725,0.0473821,0.290615,0.649848,-0.274548,0.872443,0.387232,0.484183,0.134189,-0.299112,-0.452748,-0.179774,-0.651039,-0.166618,-0.538982,0.136912,-0.600358,-0.459446,-0.0109172,-0.000617912,-0.401179,-0.0438513,0.377212,0.175312,0.332453,-0.138618,-0.410484,0.348024,-0.194961,-0.245668,0.145231,0.276313,0.0769987,-0.334965,0.308995,0.445536,-0.630582,0.715615,-0.447805,0.47444,0.378566,-0.34309,0.104895,0.0224489,-0.189152,9.71511e-05,0.292952,0.030225,0.086773,0.56517,-0.342806,-1.01033,-0.0971311,-0.219525,-0.365403,0.210949,-0.146185,0.386719,0.154413,0.356555,-0.69135,0.212504,-0.369682,-0.264641,1.20497,-0.326826,-0.312014,0.0104612,-0.0882955,0.234846,-0.68072,-0.0754795,0.0431109,0.26545,-0.171434,0.500125,-0.404993,-0.201221,0.334452,-0.0893952,-0.397115,0.0334611,0.63833,0.232433,-0.0332776,-0.433464,0.646116,-0.239452,-0.0383914,-0.512892,-0.156771,0.229522,0.241684,1.12467,-0.634016,0.655335,0.274271,-0.4414,-0.479141,-0.204371,-0.793016,-0.272536,-0.558423,-0.605383,0.212323,-0.0787983,-0.286134,-0.245693,0.0683953,0.0655275,0.676233,0.128749,0.184193,-0.450126,-0.424274,0.0949488,-0.267315,-0.255815,-0.051882,0.584115,0.108505,-0.0593762,0.0958902,-0.0797794,-0.431319,-0.226615,-0.0180166,-0.113073,-0.823018,-0.359311,0.653075,-0.0262612,-0.205218,0.241274,-0.0700169,-0.22919,-0.651325,-0.56283,0.688892,0.232279,0.246246,0.0542759,-0.244279,0.601398,-0.261315,0.379863,0.255523,-0.336493,0.177454,0.462999,-0.435345,-0.344541,-0.0614696,0.0561078,0.533413,-0.647457,0.518294,-0.0980536,-0.401963,-0.220589,0.357405,0.215956,-0.682979,-0.0587476,-0.359939,-0.0917862,0.179044,0.299178,0.55023,-0.0157714,-0.0305363,0.317694,0.522436,0.715922,-0.260306,0.0385422,0.521639,1.05726,0.498702,0.0277921,-0.0964057,-0.175393,-0.738347,0.350302,-0.144434,-0.199504,0.168779,-0.694466,0.232779,-0.116859,0.100402,-0.0312167,0.69831,-0.219848,0.58285,0.137722,0.897186,0.234842,-0.0262388,0.106721,0.35871,0.0875748,-0.204607,-0.173563,0.243734,0.129887,-0.386931,0.0673403,-0.187114,0.357197,0.215315,0.301566,0.133766,-0.389852,0.117558,0.19884,0.498004,-0.13722,-0.0868476,0.124221,-0.944479,-0.271216,-0.266989,-0.412319,0.496922,0.354853,-0.458529,-0.00852933,-0.20843,-1.03782,-0.219698,-0.214543,0.149648,0.149036,0.386843,0.386052,-1.96763 +3416.07,0.983902,0.0912059,4,1.5999,0.786291,-1.1767,0.421576,0.916848,-0.274895,-0.452637,0.429863,0.364252,-0.103172,-0.194161,-0.267204,-0.0534772,0.308938,-0.333878,0.34854,-0.0763425,0.0403053,-0.120221,0.141932,0.224012,-0.750085,-0.78394,0.268409,-0.0939696,-0.386338,-0.0338004,0.422203,-0.12652,0.131677,0.806796,-0.734635,-0.224804,0.0512457,-0.461232,-0.249217,-0.0893344,0.0999076,0.444006,0.01229,1.16364,0.38053,0.325967,-0.310903,-0.263452,0.094494,-0.765516,-0.299399,0.351022,0.220069,0.064315,0.792671,0.0974012,-0.437546,1.25067,0.0149176,-0.0674391,-0.761714,0.387839,-1.08133,-0.0265052,1.01489,-0.41289,-0.906186,0.283335,0.288519,-0.36342,-0.0396741,-0.497627,-0.252727,0.0026541,0.353015,0.550162,-0.2071,0.850625,0.37075,0.416354,0.0257544,-0.400929,-0.304803,-0.0304509,-0.612172,-0.395823,-0.500289,0.141328,-0.351335,-0.48873,-0.092528,-0.135372,-0.395151,-0.0185105,0.418209,0.23686,0.533692,-0.166774,-0.23731,0.446678,-0.102586,-0.232627,0.275732,0.33415,-0.00959269,-0.332428,0.469697,0.465974,-0.729175,0.655047,-0.532009,0.467385,0.21559,-0.283481,0.155093,-0.17384,-0.197577,-0.144294,0.156638,-0.180094,0.119113,0.348842,-0.339596,-1.16972,-0.21492,-0.0780052,-0.206464,0.326703,-0.274305,0.471825,0.0291855,0.230883,-0.680336,0.134737,-0.217778,-0.110795,1.2269,-0.181958,-0.508037,-0.0749183,0.0342043,0.0461145,-0.804663,-0.271332,-0.0460204,-0.0948416,-0.0702244,0.461543,-0.366292,-0.190365,0.1992,-0.241126,-0.563847,-0.242346,0.558613,0.403726,-0.244909,-0.323861,0.745784,-0.302724,-0.102043,-0.700771,-0.14117,0.166171,0.307892,1.02299,-0.604374,0.481991,0.288974,-0.512858,-0.68383,-0.25885,-0.813367,-0.35962,-0.520028,-0.536478,0.204623,-0.000173541,-0.329227,-0.252138,-0.025077,0.401118,0.572408,-0.0409765,0.198287,-0.294835,-0.558013,0.0749266,-0.011127,-0.163979,-0.169587,0.585005,0.214255,-0.209361,-0.0898278,0.139447,-0.52499,-0.106103,-0.178027,-0.139326,-0.837782,-0.271394,0.603414,-0.182571,-0.127774,0.294609,-0.0462214,-0.210427,-0.650396,-0.462805,0.666666,0.327139,0.0172789,0.215496,-0.15638,0.67663,-0.41874,0.374672,0.394053,-0.451796,0.256722,0.495806,-0.260978,-0.206326,-0.142958,-0.0997521,0.69111,-0.595033,0.269162,-0.0925803,-0.349591,-0.146656,0.0702821,0.19553,-0.452867,-0.154538,-0.282833,0.0061592,0.253372,0.105644,0.469073,0.219974,0.048278,0.469556,0.389195,0.878554,-0.286503,-0.0892613,0.749607,1.01406,0.338747,0.108446,-0.172667,-0.0751609,-0.486358,0.293598,-0.260542,-0.102202,0.00381027,-0.710271,0.303046,-0.257951,0.0591274,0.000676353,0.416045,-0.414234,0.722341,0.0817984,0.715672,0.275297,-0.114634,0.043236,0.291798,0.0474425,-0.180728,-0.194892,0.235487,0.151058,-0.259484,0.0846618,-0.351665,0.364977,0.0944893,0.303804,0.241929,-0.439626,0.0183367,0.266925,0.521188,-0.134336,-0.0247519,0.231658,-0.787002,-0.254758,-0.231513,-0.402078,0.299748,0.385727,-0.344119,-0.236579,-0.17267,-1.10993,-0.0181803,-0.132408,0.145175,0.172256,0.381019,0.415037,-2.54679 +3409.65,0.95681,0.0912059,4,1.59777,0.82656,-0.89398,0.351764,0.910546,-0.29961,-0.0818083,0.421264,0.239664,-0.0762783,0.0434511,-0.158868,-0.0174845,0.223548,-0.215535,0.400943,-0.0684076,0.260307,-0.239097,0.089388,0.230151,-0.774958,-0.813491,0.315393,0.192903,-0.262121,0.0707728,0.285376,-0.168339,0.189543,0.755642,-0.523151,-0.224443,0.147907,-0.454107,0.0317117,-0.492994,0.100619,0.577326,0.182013,1.02304,0.329819,0.279963,-0.392981,-0.303965,0.237569,-0.546212,-0.13712,0.318004,0.211131,0.239733,0.625886,0.172737,-0.301757,1.09862,-0.0924845,0.0820224,-0.857085,0.606673,-0.654575,-0.00986205,0.825868,-0.518423,-0.740559,0.207984,0.236139,-0.38915,-0.391368,-0.548682,0.102125,-0.052968,0.38871,0.4133,-0.119337,1.10701,0.570144,0.399149,0.078161,-0.435407,0.0297411,0.17321,-0.200573,-0.312865,-0.583352,-0.000156905,-0.35591,-0.430198,-0.53436,-0.0502223,-0.210484,-0.132855,-0.307673,0.337684,0.39256,-0.419373,-0.505266,0.324367,-0.116552,0.0140478,0.162084,0.322005,-0.00683392,-0.338941,0.320365,0.557622,-0.649223,0.665647,-0.507669,0.384765,-0.0373868,-0.0703365,0.202396,-0.0934744,-0.0857705,-0.0152659,-0.0229865,0.00282556,0.115195,0.211309,-0.263063,-1.07707,-0.0372309,-0.462855,0.012957,0.606389,-0.0661577,0.237883,0.0564531,0.42286,-0.891438,0.149354,-0.571044,-0.177741,0.899345,-0.375229,-0.28325,-0.10019,-0.0295032,-0.0787023,-0.956683,-0.250765,-0.0628103,-0.0293567,0.102048,0.727347,-0.246922,-0.352876,0.264153,-0.378022,-0.554527,-0.490039,0.479447,0.669547,-0.313398,-0.146204,0.693374,-0.663302,-0.18153,-0.656542,0.296837,0.208379,0.355253,1.05092,-0.678819,0.532962,0.145118,-0.379477,-0.72129,-0.166623,-0.348715,-0.13977,-0.415755,-0.56491,0.327709,-0.652727,-0.3439,-0.202624,0.0778203,0.11988,0.645229,0.00754536,0.26659,-0.0462653,-0.762003,-0.0602127,-0.0436909,-0.269629,0.161898,0.629047,0.281352,-0.181565,-0.284773,0.251969,-0.539278,-0.152225,0.177242,-0.147363,-0.97868,-0.343305,0.645393,-0.0796991,-0.340625,-0.0159153,0.0269345,0.124595,-0.514744,-0.286659,0.811983,0.0111352,0.154759,0.0761626,-0.312001,0.684377,-0.326475,0.611987,0.591229,-0.24441,0.143017,0.346076,0.069817,-0.0217491,0.0210289,-0.16329,0.499126,-0.494957,0.499637,0.0596421,-0.549894,-0.263302,-0.205618,0.207373,-0.448669,-0.254116,-0.299296,0.117914,0.251741,0.314832,0.0235269,0.349405,-0.070568,0.0949971,0.184592,0.714901,-0.379199,-0.068288,0.583432,0.686366,0.394043,-0.0638761,-0.120659,-0.0725266,-0.190633,0.340971,-0.453326,-0.0693264,0.275161,-0.469508,0.16566,-0.308603,0.23306,-0.103004,0.422987,-0.188541,0.772927,-0.0762327,0.603918,0.152026,-0.208722,-0.518053,0.203078,-0.0299167,-0.323889,-0.317469,1.62635e-05,0.377937,-0.144153,0.153049,-0.538903,0.618233,0.0343459,0.534415,0.0923633,-0.468943,0.276028,0.543584,0.50054,-0.181144,-0.0589135,0.177923,-0.594362,-0.260539,-0.518395,-0.38527,0.391938,0.257878,-0.62397,-0.210835,-0.034932,-0.829576,-0.00615334,-0.435517,0.173637,0.1737,0.416698,0.416774,-2.67535 +3418.38,0.952541,0.0912059,4,1.56383,0.747599,-0.927344,0.258151,0.422032,-0.310268,-0.0248435,-0.282378,-0.19034,-0.18269,-0.177092,-0.328343,-0.270502,0.404163,-0.138851,0.311889,0.245456,0.073343,-0.670111,-0.105881,0.321046,-0.703838,-0.302025,0.301626,-0.228118,-0.202125,-0.410102,0.0673958,-0.282118,0.179309,0.77225,-0.151749,0.296147,0.099307,-0.25454,-0.21937,-0.183756,0.101496,0.07804,-0.157687,1.00281,0.501121,0.689501,-0.541737,-0.376843,-0.723169,-0.241214,0.200467,0.689628,0.0879814,0.358305,0.48303,0.206798,0.307216,1.43491,-0.141815,0.263441,-0.596722,0.528094,-0.618123,-0.131977,0.904829,-0.267389,-0.720467,-0.0342392,0.115788,-0.226956,-0.461702,0.657421,-0.628572,-0.170014,0.306136,0.676922,-0.243304,0.319428,0.269745,0.255641,-0.011774,-0.188798,-0.732491,0.312935,-0.767104,0.380834,-0.403028,-0.324371,-0.00825669,0.0839554,-0.012221,-0.236596,-0.326149,-0.803911,-0.249916,0.096524,0.374523,-0.127617,0.0731339,0.17105,-0.266246,0.485631,0.171635,-0.0501402,-0.383703,-0.354822,0.674851,-0.0678062,-0.13844,0.108165,-0.000816,-0.0755713,0.320768,-0.500756,-0.316009,0.0247385,-0.0848253,0.238544,-0.549987,-0.357628,0.0122907,0.126864,0.332792,-0.121559,-0.35289,-0.255914,-0.066669,-0.209324,0.268898,0.174584,-0.0741049,0.333263,-1.07817,0.00238821,-0.150679,0.176191,0.855188,0.0877822,-0.410862,-0.0170315,-0.296311,-0.142744,-0.218929,-0.453341,0.0946575,-0.236876,-0.0384627,-0.416999,0.248422,-0.619031,0.314347,0.0601015,-0.485115,-0.422065,-0.0527324,0.805508,-0.229226,0.577325,0.406075,0.350428,0.0740953,0.00590514,0.0410507,0.438627,0.432126,0.651283,-0.626229,0.341699,0.489429,-0.39039,-0.200304,0.0471275,-0.108933,-0.118503,-0.223071,-0.361975,0.145751,-0.377516,-0.227992,-0.2943,-0.0432692,0.0481797,0.834297,0.521204,-0.389616,0.0027711,-0.237104,0.12921,0.210004,-0.867501,-0.360059,0.0444036,-0.419701,-0.0410394,0.0383964,-0.08982,-0.98017,-0.15453,0.633209,0.0533486,-0.572543,-0.545106,-0.184048,-0.292447,-0.102584,-0.242533,0.204095,-0.00894039,0.365659,-0.797646,0.850028,-0.0675867,-0.584953,0.496975,0.11709,-0.108622,-0.438645,0.296647,0.151037,-0.3359,0.274773,0.308503,-0.680829,0.2197,-0.561201,-0.635238,-0.52288,-0.0327947,-0.133079,9.79264e-05,-0.357557,0.173447,0.0841003,-0.122432,-0.324272,-0.162618,0.196658,0.082673,0.493926,-0.017716,-0.202836,0.233616,0.359745,0.0598614,0.502149,0.0622975,-0.204875,0.108095,0.0901083,0.504188,0.399945,0.494338,0.00157614,0.151132,-0.470216,0.673818,-0.423177,0.0573542,0.214556,-0.27648,-0.0116098,-0.110234,-0.00586124,-0.647884,0.453424,0.167596,0.290162,0.304498,0.0973415,0.252244,0.0445834,-0.447617,0.122438,0.223687,0.396798,0.0266056,0.25014,0.0885517,0.232542,0.00134426,0.398209,0.130561,0.0545171,-0.000738766,-0.29736,-0.417201,-0.232674,0.287618,0.88436,0.0454438,0.151277,0.642086,-0.427225,-0.150119,-0.282639,-0.0744167,0.786031,0.0425429,0.124664,-0.30037,-0.116035,-0.326299,0.544464,0.233425,0.111156,0.182172,0.333401,0.426816,-0.838959 +3430.34,0.570725,0.0912059,4,1.64613,0.826023,-1.28171,0.436521,0.524481,-0.214572,0.22996,-0.350974,0.456736,0.247144,0.119997,-0.281171,-0.397852,0.243997,-0.357558,0.632275,0.0076183,0.24806,-0.362401,-0.0768559,0.0661524,-0.844534,-0.617165,-0.0275375,0.0699336,-0.390229,-0.151437,0.594618,-0.479441,-0.0104342,0.475532,-0.613197,0.0884842,-0.172417,-0.675216,-0.0304003,-0.603557,0.711563,0.581482,-0.34423,0.898327,0.205713,0.204323,-0.391834,0.0819888,-0.431082,-0.079658,-0.0142062,0.410931,0.215997,0.00953528,0.580098,-0.168662,-0.62946,0.691639,-0.109907,0.370649,-1.00204,0.515873,-0.228808,-0.147112,0.870385,-0.490986,-0.533814,-0.103874,-0.147152,-0.728503,-0.0819208,-0.0439072,-0.748074,0.247611,0.111029,0.518704,-0.320208,0.341992,0.41737,0.0585124,0.162294,-0.0641562,-0.229866,0.457249,0.214012,0.313985,-0.0950069,0.0199859,-0.613703,0.0515722,-0.470909,-0.148048,-0.282788,-0.378971,-0.0957693,-0.0447891,0.233457,0.117678,-0.0379161,0.0338455,-0.492142,-0.288187,0.446351,0.270313,-0.518759,0.0243133,-0.0428404,-0.274093,-0.0275851,0.23878,-0.160641,0.336199,0.842003,-0.319645,0.0589332,-0.661279,0.254004,0.123276,-0.615931,0.183033,0.18026,0.94093,0.160063,-0.386009,0.104679,-0.228431,0.0248247,-0.0902535,0.395959,0.581363,0.0942307,0.298814,-0.965704,-0.14438,-0.00393933,-0.20417,0.645182,-0.591872,-0.428587,0.505004,-0.524293,0.166876,-0.411085,-0.368174,-0.0264702,-0.700926,-0.268673,0.255852,-0.0724544,-0.481337,0.20804,-0.199277,-0.182807,0.0126092,0.695497,0.21163,-0.334447,0.849828,0.104416,0.248408,0.119236,0.032113,-0.4297,0.327868,-0.14137,0.862041,-0.00660457,0.00245351,0.208859,-0.430957,-0.365298,-0.0210123,-0.377308,0.171767,-0.616818,-0.350734,-0.487992,0.0648745,-0.20218,0.0219716,-0.0380508,0.179892,0.588368,0.23798,-0.0723821,0.307996,0.218637,0.0995816,-0.314712,-0.462673,-0.217139,0.43709,-0.867578,-0.286394,-0.212501,0.120633,-0.187979,-0.236402,0.319968,0.416875,-0.56154,-0.673648,-0.339018,0.199939,-0.600008,-0.295023,0.0656152,-0.186242,-0.245949,-0.630659,1.19688,0.578527,-0.0872141,0.344647,0.160222,0.152246,0.696404,0.0761566,0.0673279,-0.57588,-0.0348204,0.453872,-0.244201,-0.0490366,-0.319119,-0.579429,-0.372163,-0.389341,0.20142,-0.116371,-0.45038,0.419674,0.246039,-0.294897,-0.202923,0.190272,-0.797031,-0.0847463,0.271535,-0.11704,0.323748,0.475991,-0.658128,-0.00966525,0.213677,0.129752,-0.048285,0.319925,-0.085681,0.718322,0.635011,-0.239027,-0.153143,0.227932,-0.637189,0.301042,-0.355517,-0.631506,0.135364,-0.638407,0.254175,0.316088,0.291416,-0.0753777,0.476179,-0.118869,-0.370829,0.301434,-0.102578,0.263894,-0.0523937,-0.690555,0.643717,0.389187,-0.148404,-0.381873,-0.318294,0.426096,0.115508,0.29357,0.465623,0.360923,-0.67078,0.262422,0.265101,-0.518816,0.22716,0.179816,-0.0466474,-0.173177,0.517184,0.258256,-0.26633,-0.00935045,0.269576,0.0554659,0.485823,0.00249113,0.308245,-0.447115,0.326569,0.217605,-0.333676,0.0475958,0.161657,0.224262,0.402066,0.473563,-1.24231 +3408.47,0.823156,0.0912059,4,1.69523,0.859782,-1.26301,0.534055,0.828046,-0.285212,0.0576413,-0.515736,-0.259187,0.331005,0.0141506,-0.44845,-0.495713,0.24431,-0.432146,0.127042,-0.0140906,0.0735894,-0.192544,-0.175622,-0.116515,-0.969382,-0.318861,0.0782292,0.0317314,-0.259714,-0.560006,-0.0286946,-0.340641,0.00060819,0.475021,-0.551708,0.202724,0.314533,-0.424421,-0.419365,-0.487211,1.03699,0.652751,-0.484018,0.635286,0.726944,0.320079,-0.704507,-0.549437,-0.484446,0.110389,-0.145146,0.386192,-0.19599,-0.312118,0.340547,-0.438845,-0.393755,0.549762,-0.176669,-0.14532,-0.890222,0.213193,-0.810521,-0.0531336,0.827141,-0.342549,-0.959316,-0.690975,0.105145,-0.551297,0.603339,-0.900295,-0.410284,0.096694,0.178747,0.28054,-0.568476,1.05607,0.45495,-0.22872,0.112363,-0.213084,-0.4143,0.168179,0.0906262,0.136868,-0.482606,-0.119916,-0.249671,0.110578,-0.465885,-0.102904,-0.254447,-0.219734,0.209412,-0.357678,0.0456754,-0.250868,0.130184,-0.21391,-0.718494,-0.0934237,0.463821,0.240032,-0.422458,-0.395486,-0.276725,0.0110509,-0.236028,0.306999,-0.467385,0.637029,0.466776,-0.24665,0.659783,-0.268022,-0.023197,0.107395,-0.140984,0.0530734,0.224691,-0.0733952,0.167986,-0.11628,0.267019,0.0506493,0.1876,-0.322823,0.118286,-0.110959,0.30029,0.0872064,-0.321825,-0.595392,-0.118752,-0.390482,0.717737,-0.258704,-0.276574,-0.438719,-0.359409,0.157716,-0.595755,-0.445291,-0.111115,-0.833536,-0.356818,0.360161,-0.241087,-0.14478,0.705857,0.0613159,-0.638536,0.390449,-0.0771922,0.211635,0.221249,0.612688,-0.0908509,0.118194,-0.54665,0.027772,-0.400794,0.391797,0.0473051,0.963021,0.0485038,-0.132298,-0.286276,-0.271922,-0.428201,-0.0891146,0.0142175,0.82203,-0.619467,-0.376896,-0.457401,-0.368679,0.175196,-0.337415,-0.286799,-0.171557,0.300792,0.0777754,0.210859,0.0796358,0.363715,0.109516,-0.504378,-0.168269,-0.491198,0.377568,-0.610944,-0.231716,0.336494,0.188726,-0.794165,-0.121661,0.590849,-0.0406338,-0.339916,-0.804362,-0.33294,0.0991334,0.126525,-0.163826,-0.0553147,-0.506361,-0.738314,-0.348267,1.07057,0.149866,-0.26341,0.159857,0.307856,-0.0607223,0.210899,-0.485815,-0.0244232,-0.430313,-0.19768,0.454459,0.202837,-0.28757,-0.988833,-0.235449,-0.276145,-0.404547,0.178661,-0.0589899,-0.445262,0.275563,0.147053,-0.108047,-0.173608,0.340684,-0.16775,0.0253539,0.374718,-0.070368,0.289795,0.686739,-0.262775,0.230498,0.61402,-0.0318696,-0.274296,-0.0594374,0.0467987,0.309134,-0.217272,-0.132294,-0.139144,0.382728,-0.593354,0.618468,-0.299924,-0.931019,-0.0157114,-0.134634,0.634749,0.0858182,0.472647,0.0459192,0.864776,0.164474,0.213113,0.111044,0.189855,0.144883,-0.42805,-0.620183,0.180822,0.219345,0.494565,-0.350376,-0.182326,0.212393,0.101082,0.0414615,0.450279,0.327962,-0.691388,0.294823,-0.346073,-0.194116,0.412554,0.161973,0.30265,0.0348248,-0.233138,0.166356,-0.409579,-0.0486973,-0.00385356,0.0661494,0.36935,-0.163015,0.0315008,-0.0943505,-0.203179,-0.620298,-0.542663,-0.149735,0.126821,0.271197,0.356119,0.520766,-2.34533 + +# Elapsed Time: 4.25098 seconds (Warm-up) +# 4.46316 seconds (Sampling) +# 8.71414 seconds (Total) + diff --git a/src/test/interface/example_output/epil.2.csv b/src/test/interface/example_output/epil.2.csv new file mode 100644 index 0000000000..1ec7d54ab3 --- /dev/null +++ b/src/test/interface/example_output/epil.2.csv @@ -0,0 +1,1046 @@ +# stan_version_major = 1 +# stan_version_minor = 3 +# stan_version_patch = 0 +# model = epil_model +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = 0 (Default) +# thin = 1 (Default) +# adapt +# engaged = 1 (Default) +# gamma = 0.050000000000000003 (Default) +# delta = 0.65000000000000002 (Default) +# kappa = 0.75 (Default) +# t0 = 10 (Default) +# algorithm = hmc (Default) +# hmc +# engine = nuts (Default) +# nuts +# max_depth = 10 (Default) +# metric = diag_e (Default) +# stepsize = 1 (Default) +# stepsize_jitter = 0 (Default) +# id = 2 +# data = src/models/bugs_examples/vol1/epil/epil.data.R +# init = 2 (Default) +# random +# seed = 1434824835 +# output +# sample = samples.csv (Default) +# append_sample = 0 (Default) +# diagnostic = (Default) +# append_diagnostic = 0 (Default) +# refresh = 100 (Default) +# save_warmup = 0 (Default) +lp__,accept_stat__,stepsize__,treedepth__,a0,alpha_Base,alpha_Trt,alpha_BT,alpha_Age,alpha_V4,b1.1,b1.2,b1.3,b1.4,b1.5,b1.6,b1.7,b1.8,b1.9,b1.10,b1.11,b1.12,b1.13,b1.14,b1.15,b1.16,b1.17,b1.18,b1.19,b1.20,b1.21,b1.22,b1.23,b1.24,b1.25,b1.26,b1.27,b1.28,b1.29,b1.30,b1.31,b1.32,b1.33,b1.34,b1.35,b1.36,b1.37,b1.38,b1.39,b1.40,b1.41,b1.42,b1.43,b1.44,b1.45,b1.46,b1.47,b1.48,b1.49,b1.50,b1.51,b1.52,b1.53,b1.54,b1.55,b1.56,b1.57,b1.58,b1.59,b.1.1,b.2.1,b.3.1,b.4.1,b.5.1,b.6.1,b.7.1,b.8.1,b.9.1,b.10.1,b.11.1,b.12.1,b.13.1,b.14.1,b.15.1,b.16.1,b.17.1,b.18.1,b.19.1,b.20.1,b.21.1,b.22.1,b.23.1,b.24.1,b.25.1,b.26.1,b.27.1,b.28.1,b.29.1,b.30.1,b.31.1,b.32.1,b.33.1,b.34.1,b.35.1,b.36.1,b.37.1,b.38.1,b.39.1,b.40.1,b.41.1,b.42.1,b.43.1,b.44.1,b.45.1,b.46.1,b.47.1,b.48.1,b.49.1,b.50.1,b.51.1,b.52.1,b.53.1,b.54.1,b.55.1,b.56.1,b.57.1,b.58.1,b.59.1,b.1.2,b.2.2,b.3.2,b.4.2,b.5.2,b.6.2,b.7.2,b.8.2,b.9.2,b.10.2,b.11.2,b.12.2,b.13.2,b.14.2,b.15.2,b.16.2,b.17.2,b.18.2,b.19.2,b.20.2,b.21.2,b.22.2,b.23.2,b.24.2,b.25.2,b.26.2,b.27.2,b.28.2,b.29.2,b.30.2,b.31.2,b.32.2,b.33.2,b.34.2,b.35.2,b.36.2,b.37.2,b.38.2,b.39.2,b.40.2,b.41.2,b.42.2,b.43.2,b.44.2,b.45.2,b.46.2,b.47.2,b.48.2,b.49.2,b.50.2,b.51.2,b.52.2,b.53.2,b.54.2,b.55.2,b.56.2,b.57.2,b.58.2,b.59.2,b.1.3,b.2.3,b.3.3,b.4.3,b.5.3,b.6.3,b.7.3,b.8.3,b.9.3,b.10.3,b.11.3,b.12.3,b.13.3,b.14.3,b.15.3,b.16.3,b.17.3,b.18.3,b.19.3,b.20.3,b.21.3,b.22.3,b.23.3,b.24.3,b.25.3,b.26.3,b.27.3,b.28.3,b.29.3,b.30.3,b.31.3,b.32.3,b.33.3,b.34.3,b.35.3,b.36.3,b.37.3,b.38.3,b.39.3,b.40.3,b.41.3,b.42.3,b.43.3,b.44.3,b.45.3,b.46.3,b.47.3,b.48.3,b.49.3,b.50.3,b.51.3,b.52.3,b.53.3,b.54.3,b.55.3,b.56.3,b.57.3,b.58.3,b.59.3,b.1.4,b.2.4,b.3.4,b.4.4,b.5.4,b.6.4,b.7.4,b.8.4,b.9.4,b.10.4,b.11.4,b.12.4,b.13.4,b.14.4,b.15.4,b.16.4,b.17.4,b.18.4,b.19.4,b.20.4,b.21.4,b.22.4,b.23.4,b.24.4,b.25.4,b.26.4,b.27.4,b.28.4,b.29.4,b.30.4,b.31.4,b.32.4,b.33.4,b.34.4,b.35.4,b.36.4,b.37.4,b.38.4,b.39.4,b.40.4,b.41.4,b.42.4,b.43.4,b.44.4,b.45.4,b.46.4,b.47.4,b.48.4,b.49.4,b.50.4,b.51.4,b.52.4,b.53.4,b.54.4,b.55.4,b.56.4,b.57.4,b.58.4,b.59.4,sigmasq_b,sigmasq_b1,sigma_b,sigma_b1,alpha0 +# Adaptation terminated +# Step size = 0.0848144 +# Diagonal elements of inverse mass matrix: +# 0.0062656, 0.0170591, 0.146738, 0.0382207, 0.11259, 0.0071497, 0.0788301, 0.0704789, 0.096297, 0.103616, 0.0694109, 0.0628146, 0.0939676, 0.0629172, 0.0676052, 0.0771469, 0.0715427, 0.0583505, 0.0807492, 0.0610588, 0.0742971, 0.0760267, 0.117313, 0.0678737, 0.073825, 0.0816859, 0.069318, 0.104608, 0.0782713, 0.0582, 0.0539917, 0.116515, 0.103844, 0.0568257, 0.0716434, 0.0730305, 0.106072, 0.094473, 0.0774242, 0.0893384, 0.057472, 0.0732826, 0.102757, 0.0751313, 0.0675248, 0.117188, 0.0982065, 0.107465, 0.0614015, 0.0725224, 0.0648589, 0.115521, 0.0563886, 0.159018, 0.0876785, 0.0771977, 0.063106, 0.0850421, 0.0698609, 0.0992691, 0.0792607, 0.058992, 0.108835, 0.147669, 0.104018, 0.0881289, 0.10293, 0.0963755, 0.0988333, 0.0905815, 0.0944159, 0.0968036, 0.0977662, 0.124602, 0.113368, 0.111951, 0.111683, 0.093481, 0.104965, 0.112967, 0.0933836, 0.0778051, 0.0698284, 0.0678385, 0.0606803, 0.0831954, 0.0944627, 0.0896874, 0.0930607, 0.0981079, 0.105518, 0.118362, 0.0984117, 0.0518715, 0.0507499, 0.0552896, 0.0611955, 0.0741439, 0.0749118, 0.0928124, 0.0840029, 0.0731411, 0.0800864, 0.0782927, 0.0893238, 0.0561025, 0.0606933, 0.0782251, 0.0604805, 0.0872302, 0.0810116, 0.0816781, 0.0946416, 0.088986, 0.0966338, 0.0921563, 0.101842, 0.0890575, 0.0637924, 0.0771718, 0.061209, 0.0576633, 0.0632453, 0.065026, 0.0851346, 0.0866946, 0.112731, 0.103001, 0.0830557, 0.120124, 0.120682, 0.0970696, 0.103021, 0.0494141, 0.0496155, 0.0496632, 0.0478456, 0.0909086, 0.0957465, 0.0949393, 0.104758, 0.0865008, 0.0962335, 0.0843082, 0.118302, 0.100172, 0.0991373, 0.0999132, 0.0838334, 0.115374, 0.0892476, 0.110735, 0.107949, 0.0864665, 0.0976236, 0.100555, 0.0917759, 0.0838757, 0.0769061, 0.0948983, 0.0856064, 0.0584939, 0.0504232, 0.0452663, 0.0557488, 0.10151, 0.11862, 0.107554, 0.125142, 0.107791, 0.098714, 0.104492, 0.121159, 0.0751632, 0.0646208, 0.0732803, 0.0692689, 0.0586273, 0.067174, 0.0677932, 0.0771653, 0.07865, 0.0854679, 0.0670943, 0.0972911, 0.0938257, 0.104576, 0.110447, 0.128063, 0.0964581, 0.093513, 0.0989863, 0.112629, 0.107198, 0.0875172, 0.0986753, 0.106756, 0.110833, 0.0938045, 0.111255, 0.104036, 0.0555376, 0.0566114, 0.0529011, 0.060809, 0.0906885, 0.0928352, 0.0730583, 0.0827284, 0.0993776, 0.101212, 0.116724, 0.103725, 0.0868685, 0.0872786, 0.0814889, 0.0837498, 0.0928127, 0.074718, 0.0799952, 0.100753, 0.128906, 0.125733, 0.121995, 0.146151, 0.0986663, 0.11676, 0.0982862, 0.121064, 0.0960836, 0.0867504, 0.120315, 0.111593, 0.0673896, 0.060066, 0.058144, 0.0588814, 0.0825915, 0.0871855, 0.0822301, 0.0724886, 0.0616906, 0.0823589, 0.0840211, 0.0854605, 0.116343, 0.101747, 0.11794, 0.123745, 0.0740856, 0.0816291, 0.0787975, 0.0749124, 0.118231, 0.1127, 0.124349, 0.126525, 0.0347618, 0.0388464, 0.0382612, 0.0392035, 0.0998842, 0.0880047, 0.105895, 0.0975811, 0.0873864, 0.0976983, 0.0932908, 0.0892935, 0.0951584, 0.0984257, 0.099384, 0.0993044, 0.0653528, 0.0683174, 0.0613298, 0.060036, 0.0992995, 0.11268, 0.0960896, 0.126481, 0.094921, 0.076738, 0.115188, 0.0867374, 0.0883181, 0.0659518, 0.0694937, 0.0783549, 0.0933708, 0.112488, 0.0953019, 0.113334, 0.0959339, 0.123971, 0.13159, 0.133348, 0.108725, 0.0991149, 0.0908321, 0.114049, 0.0545967, 0.08456 +3364.92,0.999014,0.0848144,5,1.53126,1.06367,0.136596,-0.0891285,0.47699,0.0472489,0.0524662,0.33023,0.0765287,0.509054,-0.644347,0.0704231,0.0389439,0.138663,0.219574,1.21254,0.239169,0.346996,0.04499,0.0632066,-0.119408,-1.39283,-0.317073,-0.121618,-0.114217,-0.0432038,0.250107,0.396032,-0.0210103,0.0728657,0.585175,-0.527794,-0.101789,-0.0917762,0.118768,-0.278404,-0.141363,0.706194,0.917719,-0.339218,0.409333,-0.0803082,-0.229702,-0.44133,-0.257825,0.13594,-0.034404,-0.363622,0.390234,-0.204407,0.412667,0.602047,0.560541,-0.786457,0.799441,-0.34748,-0.161737,-0.448587,0.830096,-0.176078,0.0231564,0.204754,-0.484925,-0.990439,-0.211289,0.470984,0.106426,-0.412923,-0.0741196,0.0932697,0.283827,0.414881,0.85622,0.0294925,0.258866,0.266053,0.565557,0.631542,-0.0315176,-0.267429,1.04412,-1.46955,0.587559,-0.412331,-0.0880343,-0.426309,0.719371,0.236581,0.497957,-0.201105,0.11273,-0.0778498,0.436133,-0.135622,0.246787,0.201423,-0.444854,-1.14721,0.515832,0.76502,-0.00488083,-0.873201,0.0517213,-0.53027,-0.371294,-0.622911,0.0483483,-0.327603,-0.232065,0.588288,-0.252399,-0.197867,0.967239,0.696992,-0.678082,0.123516,-0.678985,-0.457011,-0.110527,0.074855,-0.885905,0.86015,0.261714,-0.178261,-0.552998,0.320934,0.351723,0.563424,0.90273,-0.0355079,-0.115548,0.376526,-0.0162982,0.529018,-0.148046,-0.198519,0.405214,0.0791737,0.434721,-0.310447,-0.374562,0.359852,0.889085,-0.222534,0.185457,0.51442,-0.167897,0.823584,0.176674,0.202217,0.112825,0.326172,0.21769,-0.244502,0.513907,-0.0153328,-0.533773,0.00542314,0.143798,0.619855,-0.0984054,0.31209,1.10358,-0.300028,-0.782883,-0.1085,-0.0915093,0.339056,-0.368038,-0.71066,-0.30734,0.465784,0.153409,-0.530763,-0.125883,-0.219312,-0.656397,-0.5169,0.343129,1.24111,-0.157283,0.306217,0.154361,-0.332305,0.45447,-0.212151,-0.168893,0.176727,0.310723,-0.310308,0.660058,0.367905,0.131703,-0.93183,-0.464069,0.877427,0.334637,-0.272917,-0.412433,0.305199,0.107225,0.424767,0.620163,0.126625,-0.152225,0.502536,-0.670807,1.28532,-0.02594,0.793175,0.538236,-0.208293,1.09541,0.266915,-0.241791,-0.441431,-0.275512,0.668889,0.964738,-0.179063,0.322318,-0.18011,-1.18997,-0.0282626,-0.839926,0.685422,-0.27257,-0.578077,-0.335811,-0.637105,-0.165654,0.340106,-0.0465053,-0.840583,-0.580664,0.362199,0.127597,-0.0394146,0.471349,-0.165889,-0.730497,-0.87188,0.645098,-0.0893178,0.880807,-0.12415,0.721208,-0.496354,0.0610554,-0.54388,-0.773554,-0.408115,0.0247008,-0.191395,-0.702749,0.371067,-0.512346,0.312868,-0.124831,0.00647831,0.361802,0.319683,0.634973,-0.492107,0.504454,-0.0780014,0.238673,0.446594,0.22622,-0.00277442,-0.388975,-0.293288,-0.939899,-0.0174669,-0.516599,0.343504,0.658309,-0.150596,0.574829,-0.159546,0.608847,-0.0317629,-0.596435,-0.97878,0.193906,0.178429,-0.0730073,-0.090607,-0.0982024,-0.3145,-0.0169565,-0.109065,0.245271,0.201802,-0.595259,-0.448381,0.0905795,0.231568,-0.0501033,-0.457555,0.0738929,0.238151,0.157134,0.488007,0.396401,-1.93181 +3358.12,0.863453,0.0848144,4,1.5786,0.984335,0.0700406,-0.0714159,0.590439,0.0882498,-0.0680656,0.583385,-0.151976,0.43043,0.0120085,-0.22844,0.457955,0.111999,0.10432,0.903965,0.47374,0.0751504,-0.534613,-0.122074,-0.193434,-1.06338,-0.233743,0.101253,-0.725655,-0.154583,-0.219611,0.561637,-0.629441,-0.119699,0.525176,-0.493334,0.0691532,0.125034,0.110884,-0.28447,0.0132605,-0.192386,0.932567,-0.606071,0.774022,0.0549632,0.14227,-0.947688,-0.189514,-0.152047,-0.210235,-0.202027,0.380877,0.147927,0.317727,0.801348,0.702348,-1.24578,0.827501,0.19601,-0.028415,-0.27273,0.954642,-0.690789,-0.0753716,0.48553,-1.0066,-1.52794,-0.186918,0.729097,0.169679,-0.311392,0.255063,-0.654848,-0.131468,0.206827,1.04483,-0.133138,0.139461,0.12428,0.477962,-0.102147,-0.416969,0.395101,0.636609,-0.996172,0.551306,-0.128777,0.0752658,-0.37988,0.149125,-0.479642,0.537518,-0.552997,-0.251745,0.0499021,0.30315,-0.229545,0.367356,0.00735984,0.163375,-0.898587,-0.180696,0.296203,-0.0602891,-0.71654,-0.557912,-0.195306,-0.694622,-0.0951094,0.482461,-0.0182485,-0.0537816,0.265479,-0.826744,-0.559997,0.83231,0.622926,-0.169512,0.574272,-0.619859,-0.352931,0.308034,0.444561,-0.454222,0.55017,0.589909,0.00869954,-0.0117151,0.388158,1.23491,0.133499,0.489379,-0.234249,0.402905,0.551232,-0.30752,0.508004,-0.169433,-0.266938,0.0399472,-0.161014,0.0864418,-1.12313,-0.48852,0.103839,0.598806,-0.181552,-0.454719,0.41515,-0.0713274,0.467643,0.0783394,0.475954,0.0149931,0.259414,-0.0500854,0.023875,-0.283366,0.748749,0.108881,0.0339235,0.425141,0.229441,-0.509266,0.0780205,0.83311,-0.500764,-0.520768,0.00991638,-0.0768472,0.275678,-0.0556988,-0.680925,-0.297635,-0.314544,0.0253151,-0.426563,0.320213,-0.233956,-0.165635,0.00513075,0.872703,1.38676,-0.113011,-0.679958,-0.00101074,-0.431151,-0.0713787,-0.914688,-0.548802,-0.466055,0.641588,0.15691,0.297759,0.0605939,-0.0992375,-0.943326,-0.269808,0.703584,0.0390697,-0.0147955,-0.133449,-0.329277,-0.00111538,0.00361126,0.284033,0.0197451,-0.792433,0.673044,-0.533541,1.40808,-0.113186,0.672739,0.513943,-0.326396,0.264081,0.261355,-0.216408,-0.32425,-0.138572,0.530106,1.02965,-0.402961,0.32634,-0.0246856,-0.901152,-0.072866,-1.04182,0.679972,-1.0145,-0.281353,0.547618,-1.06898,-0.398577,0.284077,0.43541,-0.643223,-0.133507,-0.0184287,0.0932259,-0.151426,0.713846,0.357941,-0.228721,-0.859422,0.275953,-0.10866,0.928298,-0.139238,0.487837,-0.231782,-0.360322,-0.159818,-0.450971,-0.549986,0.45092,-0.746591,-0.0861468,-0.00618061,-0.35533,0.388178,-0.026726,-0.214667,0.851828,0.859221,0.680952,0.338794,0.610946,0.147251,0.0132287,0.0521712,0.0384601,0.231762,-0.523479,-0.723547,-0.767291,0.798681,-0.335445,0.336569,0.233857,0.195238,0.0862103,0.0336669,-0.312904,0.433497,-0.650601,-0.521586,-0.092722,0.175775,-0.89727,-0.680555,-0.653424,-0.477617,0.0932038,-0.554238,0.399494,-0.111188,-0.578295,-0.358536,0.0481253,0.110899,0.141935,-0.702343,0.264997,0.233777,0.372962,0.483505,0.610706,-2.11292 +3382.09,0.916419,0.0848144,5,1.54304,1.11151,-0.603362,0.117557,-0.289164,-0.15996,0.256579,-0.347908,0.540153,-0.0681091,-0.0366382,-0.153741,-0.643941,0.516831,-0.0827056,0.666685,-0.028892,-0.424732,-0.10238,-0.266061,-0.815073,-0.814575,-0.62843,0.00957975,0.356499,-0.628884,0.128064,0.576961,0.0578938,0.247076,0.737767,0.0928206,0.43871,0.252742,-0.378072,0.228032,-0.735818,0.912789,-0.0330529,-0.0149379,1.28276,1.09233,0.376196,-0.65428,-0.100225,-0.0650129,-0.82309,0.631414,1.19564,-0.0956138,0.216279,-0.156705,0.320684,0.274737,0.400487,-0.866488,0.282539,-0.822577,0.340437,-0.0442239,0.203124,1.12155,-0.566795,-0.452809,0.659866,0.254429,-0.0487591,0.227153,0.183213,-0.37367,-0.201116,0.665783,0.980128,0.0967406,0.844764,0.868624,0.18411,0.382058,-0.218298,-0.0565612,0.267765,-0.0111196,-0.143963,0.219041,0.320052,0.59591,-0.529806,0.280277,-0.148097,-0.526047,0.258986,0.0425641,-0.230536,-0.345752,-0.340395,-1.00114,0.164068,0.236163,0.439481,0.139294,0.170166,0.140881,-0.00795404,-0.244903,0.676587,-0.497454,0.423144,-0.74393,0.347497,0.527115,0.807749,-0.737123,-0.0183217,0.457865,0.174386,-0.488942,0.0050324,0.155624,0.522755,-0.275059,-0.840326,-0.0866251,-0.549112,-0.467577,0.0541663,0.0218446,-0.712193,0.297525,-0.165154,-0.60961,0.00456514,-0.0278042,0.538838,0.39953,0.0199314,0.0408547,0.206169,-0.00499185,0.862034,-0.327352,-0.387138,-0.164016,-0.0623845,-1.13532,0.857642,-0.292042,0.0268862,0.449973,-0.291828,-0.742128,-0.690867,0.0505332,-0.188918,-0.14336,0.683318,0.219871,0.343583,-0.0056167,-0.185038,-0.133769,0.577185,0.103956,0.731384,0.146131,0.320628,0.369853,-0.381791,-0.815291,-0.569561,0.408528,-0.499107,0.316636,-0.176766,0.284592,-0.484808,-0.00464429,-0.775546,0.135908,0.322529,0.382389,0.339333,0.152075,0.194793,0.333498,0.0658364,-0.0911027,0.188555,-0.297444,-0.382157,-0.619648,0.00190114,0.102288,-0.0554826,-0.0452312,0.344795,-0.0772428,0.22929,-0.303982,-0.973418,0.17553,0.0365173,-0.314948,0.582378,0.127821,0.221117,-0.597559,-0.368768,0.997484,0.0101906,-0.520942,-0.422786,-0.518722,-0.0564751,-0.151945,-0.759745,0.814192,-0.611737,-0.151184,-0.191414,-0.56434,-0.101999,-1.11688,0.844629,0.4386,0.254407,-0.297624,-0.00752417,-0.509712,-0.274655,0.0135723,-0.237763,-0.0426796,-0.959989,0.180365,-0.452731,0.489758,0.0459207,0.659601,0.565871,-0.661955,-0.094838,0.513633,0.0774631,0.19686,-0.112531,0.550982,0.0432327,0.368171,0.661849,-0.00746595,0.318283,-0.682373,0.47273,0.188509,-0.222188,0.5059,0.00923251,-0.37824,0.177985,0.358329,-0.223046,0.135625,-0.173216,-0.333915,0.0416905,0.245569,0.0408823,-0.219198,-0.307109,-0.160405,-0.333131,-0.0421491,0.221513,-0.467718,0.362613,-0.173266,0.0135561,-0.156137,0.127009,0.238809,0.096633,-0.502401,0.0108167,0.514718,-0.203935,-0.126475,0.347661,1.12734,-0.312383,-0.210989,0.202078,0.707837,-0.338,0.54112,-0.0547103,-0.318131,-0.000517976,-0.125547,-0.184779,0.369345,-0.374097,0.218931,0.275828,0.467901,0.525193,0.783428 +3391.74,0.92765,0.0848144,5,1.44381,0.905622,-1.50458,0.509363,-0.253098,-0.0303798,0.268878,0.556185,0.291138,0.792439,-0.298058,0.0685329,-0.184127,0.606585,-0.314787,0.835375,0.0046851,-0.31185,-0.334413,0.393126,-0.0476244,-1.40286,-0.933878,0.268683,-0.652104,-0.554957,-0.144956,0.162695,0.023532,-0.461776,0.658614,-0.753476,-0.177964,0.311612,-0.439796,0.291535,-0.56038,1.29496,0.0978587,-1.0614,1.57819,1.1718,0.531469,-1.2311,-0.149174,0.0867453,-1.09084,0.124551,0.936748,0.185116,0.509424,0.765332,0.424932,-0.858887,0.607125,0.121898,-0.174702,-0.34233,0.194543,-0.580175,0.675571,1.33386,-1.48723,-0.848271,0.0554671,0.319013,0.15623,-0.346973,-0.0163752,-0.298401,-0.115346,0.894367,0.304831,-0.119701,0.811372,0.621606,0.534181,-0.180854,-0.251474,0.231898,0.745493,-0.209063,0.163618,-0.0343018,0.236065,-0.571395,0.134909,-0.551991,0.183867,-0.243108,-0.223556,-0.583186,0.0883815,-0.131895,-0.024278,-0.0363422,0.444545,-0.144182,-0.0392,-0.178864,-0.221446,0.212625,-0.461847,-0.15576,0.66115,-0.483321,0.250085,-0.743516,0.0635937,0.814008,0.222265,-0.116114,0.112242,0.0428384,0.195183,0.346387,-0.439627,0.397326,1.00267,-0.0745116,-1.26267,-0.447956,-0.626803,-1.15068,-0.355562,0.135971,0.829001,-0.165452,0.457962,-0.357652,0.288847,0.178049,-0.320009,0.755861,-0.20045,-0.00962459,-0.111184,-0.434635,-0.172911,-0.267414,-0.297475,-0.12838,0.33379,0.275911,-0.261805,0.404854,-0.434583,0.71744,0.254372,0.138063,0.072061,-0.30212,0.181031,-0.153813,-0.0461796,0.0894131,0.435694,-0.22823,-0.224781,0.360031,0.239297,0.162937,0.784452,-0.0296053,0.28272,0.0944472,-0.36885,-0.00232802,-0.0802179,-0.602809,0.442466,0.0637563,-0.154793,0.846322,-0.0214883,0.115042,-0.0595164,0.393137,0.33742,0.709802,0.254354,-0.348553,0.276919,-0.31868,-0.0793254,-0.876237,-0.299089,-0.473095,-0.0147721,0.0394036,0.153096,0.155098,0.0652659,-0.347611,0.0619353,0.40287,-0.202421,-0.230981,-0.428217,0.372975,-0.431493,-0.262382,0.14978,-0.552393,-0.328242,0.183283,-0.533229,0.943362,0.476931,0.348579,-0.304534,-0.186608,0.0702705,1.01331,-0.640479,0.486663,-0.236736,-0.0512552,-0.166625,0.111909,-0.2257,-0.601752,0.355498,0.594719,0.0264138,0.256738,-0.353388,-0.312022,0.582825,-0.230619,-0.433111,0.00369909,-0.0731317,-0.567933,0.0250308,0.668357,-0.0257329,0.0189409,0.0884782,-0.0184745,0.322027,0.217266,-0.306311,0.280206,0.637594,-0.138617,0.712494,0.0831757,0.190325,-0.845757,0.581825,-0.490528,0.891122,-0.174026,-0.0288496,0.132482,-0.501868,0.320438,-0.233557,-0.544595,0.493688,0.864419,0.494162,-0.0237728,-0.151215,-0.696289,0.033011,0.660164,-0.0708443,-0.023227,-0.359236,-0.499471,-0.0477944,-0.0721975,0.143512,0.340684,-0.244874,-0.562247,0.355001,0.158461,-0.11556,-0.748886,-0.263225,-0.245243,-0.128965,0.341159,-0.224689,0.10321,-0.0953768,0.391879,-0.255874,0.691894,0.188328,-0.123684,0.272381,-0.0490758,0.140353,-0.512034,-0.534021,0.27034,0.403492,0.186684,0.487551,0.432069,0.698249,0.99801 +3388.51,0.696921,0.0848144,4,1.46391,1.06288,-0.822616,0.230758,-0.468683,-0.0824112,0.147484,0.284302,-0.0512262,0.544373,-0.572525,0.162936,-0.108126,0.710632,-0.364816,0.650672,0.162011,-0.360572,-0.101602,0.06599,-0.54745,-0.966035,-0.586464,0.266651,-0.565629,-0.56295,0.717406,-0.0945996,0.0341369,0.163428,0.57684,-0.553388,-0.010172,0.247442,-0.534484,0.141572,-0.426559,1.18887,0.026395,-0.572973,1.5199,1.14818,0.540309,-0.292157,-0.15431,0.395875,-1.38622,0.75827,0.967752,-0.0363207,0.345513,0.904966,0.287713,-0.437549,0.581947,0.182246,-0.465996,0.044212,-0.0581002,-0.155435,0.310662,1.49862,-1.13304,-1.03325,0.100497,0.307065,0.0390533,0.137181,-0.292194,-0.228208,-0.227544,0.465537,0.43845,-0.347588,0.928367,0.552268,0.35956,0.0309784,-0.325434,0.0819097,0.625332,-0.438549,0.113029,-0.00572323,0.26252,-0.25747,0.320376,-0.194283,0.135589,-0.0433011,-0.144507,-0.0610052,-0.56745,-0.0719011,-0.414684,0.0174238,0.40053,0.249183,0.20952,-0.0252692,-0.29784,0.392794,-0.516278,-0.538754,0.970033,-0.867007,0.560548,-0.939016,0.234762,0.547914,0.331673,-0.200646,-0.297698,0.251218,0.355475,0.400956,-0.66742,0.516506,0.533014,-0.32802,-0.936415,-0.360259,0.00704452,-0.855473,0.0238346,-0.208509,0.653952,0.290653,0.473674,-0.278152,0.450406,-0.157186,-0.408066,0.622233,-0.0883312,-0.0525215,-0.286206,-0.177692,0.359873,-0.162795,-0.205789,0.265332,0.279462,0.0711346,-0.160952,0.227055,-0.32215,0.636684,0.280165,0.402104,-0.276914,0.182907,0.201778,0.297254,-0.448388,0.00665952,0.239462,0.00950548,-0.194095,-0.0612732,-0.179144,-0.170107,0.633882,-0.289946,0.148093,0.505951,-0.508536,0.0250995,0.526785,-0.56838,0.168023,-0.163562,-0.19906,0.141701,0.298661,-0.0547627,-0.567494,0.452353,0.559363,0.340531,-0.44877,0.140478,0.367099,-0.211315,0.143169,-0.716596,-0.994212,-0.503166,0.235366,0.444919,0.499008,0.265536,-0.00920129,-0.435146,0.214863,0.14024,-0.384912,-0.112361,-0.0511956,0.340117,-0.469094,-0.238965,-0.147503,-0.197637,-0.00806449,0.0282333,-0.828194,1.00137,0.128863,0.499723,-0.0941081,-0.762631,0.0104578,0.549061,-0.541852,0.132787,-0.129437,-0.328534,0.0956651,-0.177506,-0.254043,-0.102196,0.346912,1.00975,-0.100439,0.0637332,-0.224456,-0.0983844,0.767728,0.216314,-0.146625,-0.0994934,-0.423709,-0.464146,-0.126941,0.530163,-0.302584,-0.00273998,0.184993,-0.307763,-0.299769,-0.0799557,0.168524,0.353473,0.566831,-0.0362913,0.42714,0.0174288,0.362612,-0.137494,0.421026,-0.333991,0.369204,0.267632,-0.625778,0.0706497,-0.576042,0.493855,0.0784983,-0.125001,0.916261,0.802373,0.229131,-0.245081,0.0246567,-0.368164,-0.0523305,0.16543,-0.417422,-0.212461,-0.427015,-0.275985,-0.125923,0.110406,-0.0529987,0.626856,-0.282206,-0.524324,0.214153,-0.310553,-0.260841,-0.762772,0.377199,0.657552,0.139094,0.226191,-0.122333,-0.129993,-0.130976,0.484255,-0.166151,0.58081,0.270019,-0.341263,-0.132548,-0.56143,0.607113,-0.406424,-0.419106,-0.273292,0.294118,0.142823,0.745897,0.37792,0.863653,1.37469 +3399.31,0.849874,0.0848144,4,1.49484,0.974146,-1.10103,0.259535,-0.519368,-0.103073,0.065502,0.233125,0.180537,0.975459,-0.305404,-0.0958166,-0.204198,0.564281,-0.344849,0.62534,0.271689,-0.428929,-0.0783367,0.121103,-0.421253,-0.865675,-0.508046,0.119619,-0.678329,-0.551075,0.31939,-0.0411275,-0.0824414,0.0103416,0.523848,-0.514605,-0.251201,0.329164,-0.451398,0.207862,-0.623459,0.986524,0.0478674,-0.744933,1.61303,1.18694,0.366164,-0.27113,-0.183321,0.484567,-0.92341,0.406396,0.87895,-0.099078,0.303248,0.571999,0.158891,0.148107,0.659403,0.0440966,-0.127109,-0.0526226,-0.0361665,-0.133838,0.396717,1.30149,-1.12734,-0.98982,0.149942,0.311877,0.0208674,-0.187089,-0.286924,-0.440341,-0.339763,0.38792,0.427739,-0.21744,0.799157,0.499188,0.317396,0.153189,-0.336047,0.0412791,0.471461,-0.0660123,0.318463,-0.18887,0.123545,-0.272879,0.257843,-0.579986,0.0995888,0.0560899,-0.367679,-0.169026,-0.10042,-0.0055815,-0.175586,0.349367,0.673711,0.0943818,-0.0559259,0.0605246,-0.14314,0.292676,-0.751575,-0.456427,0.634442,-0.674271,0.501151,-1.00652,0.0491901,0.411946,0.200231,-0.111842,-0.0189983,0.423843,-0.295252,0.295756,-0.854345,0.916191,0.168726,0.0767992,-0.774868,-0.499509,0.00996551,-0.558023,0.060457,0.143005,0.721969,0.383435,0.265628,-0.0981933,0.160722,-0.311236,-0.517524,0.543786,-0.162791,-0.106009,-0.161211,-0.16346,0.102289,-0.302421,-0.231754,0.23086,0.213762,-0.20248,-0.15516,-0.189233,-0.807252,0.414339,0.275575,0.398514,-0.359902,-0.107263,0.235104,0.305055,-0.585653,-0.0303169,0.0786632,0.310897,0.0330088,0.117831,0.260651,-0.332669,0.596354,-0.286023,-0.360667,0.133354,-0.239181,0.15133,0.543613,-0.734704,0.186723,-0.154912,-0.170161,0.414224,-0.181669,-0.0473624,-0.269257,0.326944,0.722937,0.150407,-0.312624,0.0506321,0.448132,0.0649363,0.0432808,-0.578014,-1.09923,-0.489163,0.170513,0.593407,0.465769,0.332574,-0.235624,-0.374868,0.00653966,0.168237,-0.327041,-0.250357,-0.440343,0.657245,-0.465523,-0.0560471,-0.397192,-0.109023,-0.494348,0.314921,-0.144424,0.864522,0.141263,0.125799,0.113314,-0.261437,0.24771,0.214709,-0.415915,0.0370832,-0.300981,-0.192084,-0.0492895,-0.327048,-0.157587,-0.547877,0.33672,0.766162,-0.203191,0.150469,-0.372444,-0.150122,0.77334,-0.0333979,0.109752,-0.0847455,-0.161959,-0.140147,-0.306032,0.850809,-0.394307,0.158946,0.209206,-0.409622,-0.533933,-0.0679921,0.152022,0.285142,0.472108,0.383058,0.584808,0.0328012,-0.0181928,-0.14958,0.5373,-0.0769195,0.342746,0.0588205,-0.552353,0.156345,-0.532063,0.232421,0.38677,-0.0836704,0.987883,0.780799,0.248799,-0.261461,0.202575,-0.414462,0.0301276,0.0781286,-0.322771,-0.282358,-0.420512,-0.256773,-0.0730982,-0.0950205,0.0482712,0.646039,-0.313411,-0.176842,0.254828,-0.276664,-0.226131,-0.691695,0.340734,0.249292,0.310808,0.151023,-0.25965,-0.0346453,-0.140732,0.45432,-0.129333,0.610914,-0.0461812,0.248484,-0.158829,-0.061559,0.331078,-0.137494,-0.33349,0.335546,0.263417,0.143719,0.552714,0.379103,0.743448,1.85492 +3403.42,0.803218,0.0848144,4,1.45819,0.920385,-1.01174,0.285768,-0.623541,0.00982044,0.427175,0.233117,0.406147,0.744322,-0.411873,-0.0730279,-0.214116,0.947222,-0.17352,0.812206,0.291573,-0.168442,0.0391819,0.0866726,-0.139678,-0.703714,-1.11222,0.242722,-0.514639,-0.764011,0.467196,-0.169098,-0.0710157,-0.168471,0.70018,-0.797415,-0.0898428,0.160612,-0.440497,0.00347304,-0.522017,1.12821,0.172563,-0.77749,1.40179,1.07218,0.586698,-0.435154,-0.0541201,0.0503648,-1.27562,0.523091,1.13574,-0.0753221,0.391305,0.588709,0.0444162,0.116366,0.660993,0.0972976,-0.138963,-0.125316,0.0471079,0.468226,0.129586,1.03706,-0.943262,-0.75309,0.13746,0.110423,-0.129061,-0.178964,-0.0959951,-0.383259,0.047549,0.249666,0.470887,0.339567,0.653563,0.620323,0.450767,0.176675,-0.31356,-0.103961,0.281607,0.135994,0.353541,-0.288534,-0.248525,-0.402644,0.589307,-0.720056,-0.158447,-0.0639914,-0.262724,0.136824,-0.182823,-0.0158763,-0.0530259,0.086717,0.415276,-0.293848,-0.214946,0.0618334,-0.349159,0.169917,-0.59945,-0.397194,0.628925,-0.894431,0.767005,-0.685454,-0.163399,0.653647,0.0714869,-0.113547,0.0921456,0.346603,-0.136737,0.258684,-0.607379,0.684194,0.158237,0.342651,-0.525591,-0.363777,0.130886,-0.340178,-0.176323,0.380666,0.314175,0.0227419,0.220494,-0.00179201,0.0174027,-0.196531,-0.496808,0.586888,-0.180321,-0.176734,-0.27896,0.219176,0.365594,-0.393563,-0.160136,0.171621,0.210385,0.190818,0.183841,-0.0335166,-0.818239,0.153568,0.123156,0.130325,-0.144643,-0.11628,0.20141,0.125568,-0.117939,-0.0324464,0.180232,0.157459,-0.110446,0.27314,0.110724,-0.468189,0.547492,-0.424092,-0.297911,0.413171,-0.133089,-0.138453,0.164501,-0.672147,0.276703,0.225938,-0.116481,0.295127,-0.321089,0.0601252,-0.156481,0.372718,0.554175,0.517503,-0.0620601,0.0949883,0.61193,-0.242111,0.06896,-0.375327,-1.03931,-0.571505,-0.368171,0.210746,0.292178,0.55353,-0.364442,-0.289927,0.467896,0.0284633,-0.226592,-0.418646,-0.370895,0.654756,-0.265807,0.261771,-0.161748,-0.267537,-0.375792,-0.0918229,-0.0521271,1.33583,0.315363,0.111896,0.106522,-0.0193989,0.27711,0.452235,-0.206435,0.187633,0.207977,-0.15614,-0.130772,-0.816471,-0.0628413,-0.431656,0.529639,0.734225,-0.505087,-0.00670308,-0.121608,-0.294056,0.997116,0.00183751,0.125682,0.0611826,-0.198614,0.00831472,-0.652282,0.894268,-0.0251628,0.0255016,0.135674,-0.326542,-0.510135,0.116959,-0.110054,0.355311,0.603634,0.741909,0.51899,0.0450079,0.371814,-0.107498,0.515712,-0.288789,0.177885,0.136602,-0.798871,0.318748,-0.410148,0.226625,0.440968,-0.0631161,1.05196,0.57469,0.640883,-0.388665,0.470435,-0.489305,0.407218,0.0116184,-0.450728,-0.143189,-0.175232,0.00982092,0.0514287,0.324179,-0.0851283,0.442619,-0.20088,-0.114865,0.336266,-0.585765,-0.43668,0.0244969,0.437653,0.0891614,0.33768,-0.00938606,-0.374879,-0.0810795,0.0749928,0.286536,-0.0256102,0.492093,0.0470886,0.0732521,0.07727,-0.416681,0.049601,-0.364524,-0.726425,-0.0695322,0.372142,0.135519,0.500102,0.368129,0.707179,2.15914 +3381.28,0.612004,0.0848144,5,1.43414,1.03264,-1.39907,0.412244,-0.122123,-0.322495,0.214262,0.573063,0.334942,0.175559,-0.37549,-0.377054,-0.0682611,0.573518,0.214869,0.909704,0.00795194,-0.355671,-0.252829,0.0932749,-0.199277,-1.08549,-1.18381,0.096885,-0.168573,-0.491071,-0.413538,0.503884,-0.330853,-0.17253,0.5255,-0.202724,-0.348744,0.164495,-0.257498,0.327262,-0.984127,0.138291,0.326221,-0.396375,1.08012,1.09628,0.639036,-0.633327,-0.0855172,0.091886,-0.275462,0.364432,0.934844,0.0362235,0.637097,0.340344,0.430877,-0.971062,0.627703,-0.083156,-0.159083,-0.0742405,0.412477,-0.0544139,0.66457,1.11216,-0.180094,-1.63772,0.084038,0.345203,-0.418676,0.168622,0.333687,-0.667705,0.115237,0.507695,0.492301,-0.191072,0.544485,0.354129,0.211702,0.169262,-0.313806,-0.339371,0.568917,0.189984,-0.221893,-0.0396522,0.49616,0.612476,-0.389529,-0.103442,0.423465,-0.064031,-0.277573,-0.209082,-0.346189,-0.378022,-0.0872272,0.220227,-0.324133,-0.238247,0.718837,0.150828,0.415573,-0.225234,-1.0017,-0.427287,0.0943981,-0.611965,0.409185,-0.350097,0.496891,0.261842,0.0522252,-0.339319,0.0493357,0.0908704,0.0974834,0.0666537,-0.467038,-0.0175171,0.185483,-0.105287,-0.383792,-0.744758,-0.203658,0.366987,-0.275698,-0.352434,-0.0119568,0.0685487,0.0552932,-0.154709,0.36296,-0.467995,-0.384201,0.3512,0.0811678,-5.29053e-05,-0.239635,-0.301741,-0.128197,-1.28385,-0.22832,-0.438583,0.524654,-0.105443,0.41763,0.102296,0.425657,0.728581,0.0692408,0.179369,0.215274,0.0700704,0.0131519,-0.171628,0.987768,0.629524,0.498509,0.829944,-0.116218,-0.559179,-0.0795033,0.121718,0.951398,0.509321,-0.0278506,0.205339,-0.376191,-0.0326122,-0.678971,0.630355,-0.213997,0.359097,-0.301384,-0.0860602,0.113763,-0.35187,-0.12365,-0.376476,0.47885,0.864336,-0.359686,0.563205,0.951685,-0.444168,-0.273318,-1.2043,0.543531,-0.213035,0.598738,-0.577203,-0.433015,-0.254894,0.362051,-0.541452,-0.449598,-0.162705,0.240732,-0.788772,-1.2811,0.711095,-0.205409,0.112894,0.69267,0.0223387,0.178801,-0.171488,-0.424591,1.14342,-0.410859,0.419566,-0.98961,-0.86467,0.205843,0.784115,-0.432461,-0.169431,-0.76988,0.184538,0.101119,-0.494613,-0.0714174,-0.87852,0.0334959,0.536583,-0.0703233,0.443825,-0.599176,-0.339522,-0.706456,0.0641443,-0.681114,-0.406198,0.29081,-0.216488,-0.247825,0.454885,-0.114963,-0.10889,0.857689,-0.178487,-0.465153,0.544957,-0.168091,-0.435991,0.345623,-0.26159,0.0827335,-0.0696106,-0.601302,-0.532637,-0.333454,-0.507205,0.833539,-0.37262,0.0296406,0.0408109,-0.571152,0.0602146,-0.0165505,0.0984213,-0.383206,0.40504,-0.515331,0.118261,-0.0900791,0.536974,0.225213,0.235009,0.0510955,0.043967,-0.207273,-0.717781,0.045112,-0.615793,-0.0751453,-0.217554,0.0685378,-0.00175197,0.123604,0.0579106,0.182149,-0.668845,-0.146686,0.237184,-0.391193,0.421075,-0.454054,0.624925,0.366476,0.426632,-0.226707,0.222675,0.3277,-0.69516,-0.00296246,-0.414793,-0.027503,0.38628,0.176545,-0.800773,-0.488322,0.190687,0.273425,0.436677,0.5229,0.438673 +3374.8,0.935085,0.0848144,4,1.46755,0.901156,-1.21465,0.354738,0.181185,-0.147432,-0.0371321,0.416253,0.298485,0.320775,0.0197904,-0.424952,-0.00926946,0.717613,0.0935339,0.858324,-0.0559531,-0.157079,-0.23878,-0.0977588,0.0268111,-1.43265,-0.716834,0.379977,-0.282272,-0.587401,-0.0324656,0.933283,-0.00680532,-0.362799,0.233217,0.0370216,0.05861,0.193754,-0.0462884,0.229537,-0.57756,0.758423,0.68506,-0.253117,1.25113,0.993346,0.726449,-0.316813,0.194903,0.121559,0.0877113,0.605304,0.859418,-0.179311,0.705197,0.735657,0.360225,-0.772166,0.859978,-0.151466,-0.274029,0.05123,0.316901,-0.322186,0.583549,0.502641,0.218944,-1.42278,0.00115611,0.341065,-0.497737,0.101822,0.413449,-0.088337,-0.271363,0.615182,0.326839,-0.521437,0.58859,0.643022,0.499285,-0.557027,-0.247069,-0.224553,1.10745,-0.406304,0.0290992,0.60369,0.188962,0.500953,-0.328806,-0.443051,0.175219,0.194083,-0.0628604,0.0316571,-0.285635,-0.164166,0.229445,0.545034,0.295385,-0.133874,0.778334,0.345413,0.292556,-0.131012,-0.854564,-0.611947,0.145928,-0.576471,0.0997371,-0.319968,0.506387,0.302701,-0.305346,0.0966248,0.0668729,0.0645311,0.370532,0.261092,-0.37109,0.14845,0.406965,-0.303939,-0.712366,-0.87878,-0.145142,0.148717,-0.185252,-0.317105,-0.4811,-0.233551,0.0489198,-0.718252,0.0843688,-0.115181,0.116785,0.225222,-0.234431,0.0132155,-0.673185,0.223314,0.320457,-1.71702,-0.332829,-0.438348,0.326709,-0.157965,0.395688,-0.228355,-0.139194,1.11598,0.20277,-0.0312477,0.283377,0.397444,-0.0987624,-0.124891,0.632001,0.713847,0.192307,0.29848,0.145157,-0.29542,0.706811,-0.302678,0.822956,0.462408,0.0971462,0.156844,-0.264696,0.0856464,-0.687374,0.470086,-0.0451098,0.240999,-0.301659,-0.272553,-0.262577,-0.323167,-0.451181,-0.60727,0.37822,0.947901,-0.410557,0.474828,0.674997,-0.445169,-0.247857,-0.949464,0.375232,-0.0472759,0.0400683,-0.103145,-0.201985,-0.179057,0.0840701,-0.317788,-0.318828,-0.166041,-0.118569,-1.02778,-0.770061,0.712847,-0.126886,0.270299,0.479219,-0.179604,-0.240306,-0.131722,-0.791496,1.1435,-0.588009,0.227654,-0.641355,-0.96346,-0.265543,0.627733,-0.514313,0.102453,-1.04905,0.0288993,0.387256,-0.000735478,-0.235226,-0.975352,0.0735801,0.287061,-0.0526028,0.182928,-0.262449,-0.474184,-0.556779,0.0529455,-0.522584,0.0209591,0.027923,-0.0841207,-0.713168,0.61648,-0.0796991,-0.355094,0.754353,-0.362424,-0.294776,0.269147,-0.60011,-0.229694,0.128113,0.372364,0.248196,0.340029,-0.638903,-0.633613,0.179224,-0.75741,0.451621,-0.134382,-0.420399,0.0462392,-0.214015,0.324435,-0.205805,-0.19718,-0.361571,0.858528,-0.428937,-0.43522,-0.157221,-0.230454,0.158243,-0.166633,-0.0343156,0.235228,-0.0573383,-0.352299,-1.03661,-0.600177,0.200899,-0.0149698,0.555808,-0.242836,0.262869,0.00827363,0.0489616,-0.426371,-0.686443,0.840211,-0.299893,0.646074,-0.151314,0.130939,-0.136497,0.00468664,-0.276783,0.169636,0.359489,-1.02326,-0.09073,-0.306487,0.139429,0.319244,0.240955,-0.532067,-0.877884,0.216309,0.279515,0.46509,0.528692,-0.388513 +3392.36,0.931225,0.0848144,4,1.50827,0.95697,-1.05975,0.280542,0.235602,-0.0576179,0.327999,0.174672,1.03437,-0.205764,-0.307408,0.00142116,-0.372987,0.602093,-0.181774,0.801167,0.143576,-0.202754,0.451846,0.338357,-0.181053,-0.818724,-1.4293,0.124775,-0.675618,-0.403361,0.393349,-0.146173,-0.0516214,-0.102122,0.375342,-0.067289,0.211188,0.396728,-0.235702,-0.159629,-0.543527,0.505429,0.416267,-0.154087,0.871886,0.330788,0.139061,-0.499593,0.04672,-0.0352048,-0.834954,-0.2132,0.928194,0.16393,0.565375,0.519199,0.117291,-0.584371,1.02026,0.221404,-0.1494,0.083339,0.228749,0.338335,0.312287,1.13223,-1.04667,-1.19609,0.728906,0.132586,0.258952,-0.46385,-0.209087,-0.447375,0.164302,-0.140887,0.4123,-0.0830193,0.336864,0.471799,0.413993,-0.0131833,-0.646501,-0.187883,0.355825,-0.714957,0.173088,-0.517258,-0.586401,-0.556728,0.00483947,-0.368495,0.497464,-0.55119,-0.525968,-0.429478,-0.211675,-0.380745,0.503701,0.154531,-0.292024,-0.852288,-0.305947,0.622743,0.333178,0.417288,-0.0672327,-0.0885247,-0.185495,-0.208532,0.63157,-0.916409,0.290103,0.309927,0.179388,-0.295711,0.795215,0.122644,-0.0666656,0.457884,-0.216545,0.34831,0.21493,0.370175,-0.0785655,-0.477121,-0.62156,-0.38415,-0.0253883,0.131531,-0.111801,0.519734,0.508275,-0.129558,0.319242,-0.23225,0.0529283,0.838137,-0.109017,-0.0465539,0.128919,-0.344991,0.0326287,-0.171124,0.146219,0.237667,0.430177,-0.979966,-0.351951,0.309746,-1.3031,0.0111539,0.0607856,-0.177887,-1.07632,-0.742754,0.260646,0.0488396,-0.288218,0.232961,0.350912,0.499747,0.471721,0.148437,0.0627163,0.286515,0.472329,-0.0536111,-0.311252,0.278014,-0.319712,-0.217863,-0.568672,-0.0994658,0.373637,0.165739,-0.192671,-0.232628,-0.15731,-0.768188,0.324274,0.0963231,0.493107,0.778875,-0.524368,-0.349358,0.274263,-0.208979,-0.384675,-0.645826,-0.189688,-0.172431,0.218345,-0.581637,-0.215475,-0.332487,0.137875,-0.833429,0.171961,0.115153,-0.509922,0.0426027,-0.032532,0.332517,-0.341565,-0.130592,0.190903,-0.0623989,-0.309553,-0.0229519,-0.295129,1.04849,0.0114087,0.0364054,0.416499,0.0686749,0.101262,0.0314158,-0.0753697,0.325285,0.062995,0.358254,0.662407,-0.506711,-0.306148,-0.292124,-0.30253,-0.289266,-0.415839,0.134163,-0.356782,-0.689976,0.506666,0.294653,-0.0680577,-0.337726,-0.0367315,-0.145055,-0.787732,0.488939,-0.0355697,-0.182582,0.843551,-0.212495,-0.01887,0.0357867,0.468429,-0.191324,0.24072,0.385666,0.481043,0.0483863,-0.499746,-0.219633,-0.00138417,-0.721943,0.349046,-0.596019,-0.399352,0.204321,-0.453898,0.27716,0.946341,0.148535,0.575244,0.677499,-0.191684,0.616135,0.0703621,0.608436,0.250222,-0.55533,-0.0973662,-0.233422,-0.527009,-0.798816,0.544559,0.32282,0.0416908,-0.485022,0.063632,0.36872,0.443882,-0.215783,-0.367526,-0.180612,-0.0206938,-0.0919457,-0.119901,0.312169,-0.609596,0.268269,0.3066,-0.122576,-0.0530886,0.258269,0.429036,-0.0282242,0.28271,-0.876895,-0.378015,0.00381983,0.340511,0.0951078,0.478443,0.173148,0.323877,0.416111,0.569102,-0.660596 +3409.67,0.99047,0.0848144,5,1.50255,1.08869,-0.493385,0.0883622,0.40893,-0.104338,0.190686,-0.160798,0.0415144,0.550892,0.0774691,0.0351723,0.161902,0.638875,0.0293904,0.757589,0.183163,-0.00916828,-0.409004,-0.421233,-0.323949,-1.04847,-0.144897,-0.0118601,1.87004e-05,0.195077,-0.280035,0.472243,-0.0493102,-0.136219,0.851212,-0.035615,0.0430154,0.116946,-0.584753,-0.0866875,-0.394299,0.843893,1.0197,0.102169,0.874884,0.832875,0.728355,-0.353669,0.0540308,0.253973,0.000270042,0.473635,0.454584,-0.0463034,-0.0289038,0.265167,0.565012,-0.0642438,0.94188,-0.0463071,0.026679,-0.922578,0.633525,-0.796565,0.328213,1.22567,-0.156432,-0.135196,-0.600913,0.26397,0.473676,0.296718,0.600775,-0.369526,-0.39335,0.686747,0.209571,0.095106,0.954887,0.193563,-0.0257497,0.0902631,0.00620911,0.0195967,1.01052,0.202211,0.0816351,0.412054,0.208358,0.265371,0.164283,0.125134,-0.244364,-0.277542,0.157831,-0.0727486,0.0394339,0.777141,-0.336909,-0.00614853,0.282237,-0.417968,0.229629,0.314697,-0.365051,-0.704458,-0.709498,-0.614228,0.155533,-0.446281,0.120824,0.18924,0.227996,0.373569,-0.313264,0.0439831,-0.472479,0.123184,-0.0692163,-0.160826,-0.321072,-0.0227255,0.0357186,-0.302981,-1.01966,0.402584,0.0761326,0.352158,-0.332408,0.162883,0.284868,0.0202023,-0.206588,-0.904874,-0.14661,-0.359949,-0.187687,0.440476,-0.329725,-0.352053,-0.0359631,0.0853329,0.42832,-0.832212,-0.647715,-0.364086,0.0799163,-0.0111316,0.802226,0.0235496,0.0294377,0.840242,-0.456827,-0.110955,0.747998,0.715017,0.466273,-0.0188825,0.917096,0.427719,-0.401107,-0.51601,0.0567737,-0.138927,0.274382,-0.343557,0.51742,0.02756,0.320141,0.251223,-0.0713494,0.0865887,-0.0588251,-0.521456,0.0335922,-0.228497,-0.128488,-0.332965,-0.0862607,0.319691,-0.694695,-0.261257,0.214496,0.717273,0.311041,-0.24168,0.503437,0.0754443,0.192322,0.00620587,-0.0914523,-0.488348,0.00424495,-0.184369,-0.29075,0.15362,0.298992,-0.399026,-0.257022,0.286062,0.515815,-0.764649,-0.776353,-0.068358,0.172177,0.133362,-0.0314624,-0.00771159,0.669196,-0.208374,-0.586062,0.622798,-0.70652,0.286379,-0.739682,0.040485,0.151317,0.514131,-0.358453,0.0470009,-0.537883,0.358938,-0.11677,-0.183017,0.233834,-0.867876,0.385964,0.284994,-0.254124,0.387571,-0.382991,-0.0299697,-0.105096,-0.252554,-0.0614041,-0.187762,-0.224174,-0.0580325,-0.0839476,0.446628,0.148276,0.206135,0.282426,-0.442932,-0.28354,0.0485012,-0.818294,0.280509,-0.164322,0.0704235,0.304291,0.0351531,0.0903041,-0.797933,0.201776,-0.316218,0.298445,0.104449,-0.139032,0.113737,-0.168951,0.0566738,-0.244036,0.018519,0.194468,-0.335653,0.422047,-0.100874,0.111983,-0.171905,-0.566148,0.137969,0.0637439,0.210568,0.479729,0.459705,-0.930396,-0.306603,0.0412081,0.0391705,0.571123,-0.349062,0.10535,0.276338,-0.0554229,-0.111467,-0.270963,0.234792,0.0793181,0.0118656,0.0573534,0.519979,-0.239325,-0.321534,-0.244812,-0.103116,-0.219336,0.337921,-0.257389,0.378356,0.216265,-0.40699,0.0150296,-0.451963,-0.398747,0.149653,0.210355,0.38685,0.458645,-1.57824 +3396.92,0.900625,0.0848144,4,1.47087,1.12464,-0.778876,0.134662,0.477245,-0.077717,0.0649459,-0.18654,0.200877,0.395626,-0.197357,0.294948,0.210109,0.662511,-0.215081,0.659696,0.0628584,-0.0786816,-0.187159,-0.448415,-0.487229,-1.04191,-0.154409,-0.216647,-0.0269841,0.345028,-0.39649,0.393143,-0.11994,-0.0509427,0.794443,0.191178,0.12777,0.0205436,-0.622313,-0.0338976,-0.259554,0.730798,0.938904,0.106776,1.10364,1.07575,0.881269,-0.525222,-0.0355385,0.0407936,-0.199447,0.494491,0.373981,-0.104174,0.0982957,0.177088,0.518531,-0.0341525,1.02572,0.0612333,0.0375575,-0.727689,0.834585,-0.92321,0.240802,1.27447,-0.494829,-0.318773,-0.40105,0.248425,0.372906,0.242026,0.691979,-0.457776,-0.414191,0.848185,0.268187,-0.0908776,0.975663,0.0226477,-0.00605696,0.192521,-0.26915,0.16226,0.939356,0.141504,0.228644,0.158696,0.229503,0.141438,0.257816,0.109963,-0.201078,-0.340715,0.21629,0.167246,0.0732031,0.642698,-0.227447,0.0763419,0.230767,-0.174799,0.300581,0.335101,-0.102842,-0.704725,-0.543582,-0.542584,0.355704,-0.359717,0.198511,0.151167,0.350933,0.443523,-0.511816,-0.137677,-0.230085,0.124751,-0.116312,-0.218574,-0.258404,-0.184671,-0.15465,-0.304848,-0.930111,0.266826,0.0652375,0.302142,-0.520663,0.31968,-0.0308863,-0.0881655,-0.168433,-1.0289,0.0187573,-0.601053,-0.226237,0.391514,-0.113888,-0.306636,0.0247306,0.301061,0.294394,-0.784404,-0.483249,-0.414467,-0.077939,-0.0814091,0.862559,0.096459,-0.028103,0.827786,-0.329878,0.0868164,0.482035,0.556731,0.22868,0.0592157,0.805701,0.442625,-0.35659,-0.485098,-0.0557333,0.0614489,0.423434,-0.301428,0.426436,-0.0902422,0.142144,0.327989,-0.0849714,-0.0457317,0.103502,-0.557932,-0.0988292,-0.327913,-0.199227,-0.479064,-0.0677661,0.194474,-0.772808,-0.135299,0.22749,0.753365,0.14931,-0.430759,0.292376,-0.00234357,0.33118,-0.0185986,0.480457,-0.56125,-0.0880831,0.127688,-0.265321,0.0442061,0.386262,-0.678155,-0.285939,0.32477,0.577244,-0.572803,-0.907493,0.13447,-0.0235342,0.416985,0.00843515,-0.0160487,0.707105,-0.151306,-0.415926,0.760253,-0.617169,0.367579,-0.742815,-0.134888,0.258949,0.491197,-0.118666,0.305617,-0.0756876,0.303847,-0.12055,0.00769238,0.234935,-0.836614,-0.074282,0.0654632,-0.0633646,0.313285,-0.576453,-0.105558,0.141592,-0.40946,-0.0922894,-0.10646,-0.312193,-0.158978,0.0631433,0.433985,0.165278,0.0421755,0.342925,-0.394847,-0.0821949,0.13137,-0.766814,0.0170969,-0.226776,-0.0624878,0.0760231,-0.0453893,-0.120479,-0.963599,-0.0591662,-0.371868,0.279482,0.0812359,-0.224102,0.00591291,-0.361743,-0.227262,-0.204386,-0.184679,0.191389,-0.0696547,0.43981,-0.138743,0.352457,-0.0602317,-0.624326,-0.0856494,-0.14397,0.201233,0.43644,0.65471,-0.982892,-0.264357,-0.177687,-0.163922,0.559261,-0.0970644,0.0449804,0.135394,-0.245048,0.0325106,-0.195016,0.416004,0.405451,0.0535757,-0.248562,0.287687,-0.424339,-0.336469,-0.382469,-0.245815,-0.27357,0.513152,-0.238819,0.18568,0.125111,-0.542642,0.150185,-0.102301,-0.445192,0.150079,0.182126,0.3874,0.426762,-1.80084 +3389.99,0.870095,0.0848144,4,1.53435,0.985177,-0.467363,0.0554111,0.875021,0.0726135,0.321827,0.694487,0.383514,0.0900918,0.230526,-0.0447481,-0.388341,0.59919,0.102077,0.882326,-0.0501839,-0.115382,-0.00433519,0.022644,-0.450238,-0.788448,-1.06405,-0.117611,-0.853783,-0.12449,0.0418714,0.391145,-0.686613,0.536477,1.0597,-0.301543,-0.0446589,-0.0612855,-0.139384,-0.357669,-0.207943,0.303134,0.597149,-0.286296,1.22358,0.44798,-0.293532,-0.494128,0.223014,0.0430784,-0.767719,-0.10493,0.388071,0.493464,0.0819675,1.32428,0.263064,0.294132,1.27404,-0.188927,0.124903,-0.977557,0.644278,0.0874407,0.0974934,1.20722,-0.744235,-0.844341,0.131528,0.0582109,-0.22819,0.262119,0.204002,-0.561624,-0.535755,0.128107,0.32477,-0.419198,0.435403,0.604441,0.693411,0.207357,-0.10603,-0.102161,0.0698437,-0.0806505,0.128564,-0.016301,-0.338096,0.284577,-0.237626,-0.394896,-0.0498496,-0.739638,-0.14536,0.379152,0.434381,0.38934,0.145799,-0.804601,0.299453,-0.639614,-0.241119,-0.00295721,0.424079,-0.0936884,-0.054782,0.0809119,0.386477,-0.0265122,0.146226,-0.157326,0.205618,0.492063,-0.656723,-0.202892,-0.00823062,0.223747,-0.0153224,0.0602503,-0.771332,0.204867,0.844656,0.440577,-0.75436,-0.0383245,-0.0370844,0.195892,0.32968,0.136557,-0.157539,0.360017,0.107772,0.0714135,0.534605,-0.0959793,0.353326,0.940891,-0.290752,0.325731,0.42416,-0.00890003,0.516425,-0.162832,-0.518068,0.121044,0.785197,-0.58475,0.306563,0.677121,-0.278944,-0.311382,-0.350261,-0.182536,-0.333645,0.127238,0.574243,0.350621,-0.633227,0.619113,-0.130607,-0.217981,0.222779,-0.542099,0.488255,0.179964,0.641412,0.312317,-0.0421432,-0.13177,0.335787,0.0262765,-0.473564,0.386631,0.0655858,-0.36901,-0.299696,-0.156559,-0.198855,0.182853,-0.225343,-0.178254,0.0914085,0.404318,-0.0326666,-0.87631,0.274908,-0.0572037,-0.0384531,-0.865283,-0.653951,-0.5719,-0.244567,-1.34247,-0.206927,-0.0857677,0.0725925,-0.380671,-0.0132388,0.169685,-0.190925,-0.385651,-0.572026,-0.0416958,0.0417865,-0.391425,0.0429169,-0.00123644,-0.599281,0.430814,-1.15639,0.628257,-0.0986377,0.403251,0.833733,0.0375156,0.502507,0.394248,-1.02333,0.244719,-0.112293,0.259346,0.364271,0.271628,0.000979941,-0.0115464,-0.261903,1.05192,-0.528765,0.543557,-0.481559,-0.387338,-0.216691,0.437088,-0.184406,-0.192587,-0.223464,-0.115732,0.402743,0.237197,-0.485351,-0.298991,0.442127,-0.311446,-0.22484,0.779925,0.632076,-0.762155,0.436891,0.0621927,0.223547,0.00949316,-0.311669,-0.69203,-0.150816,-0.286355,0.155852,-0.12452,-0.121759,0.0587372,-0.0990575,0.236067,-0.258948,0.130523,0.792063,0.0591371,0.479634,0.760444,0.128017,0.0330004,-0.189369,-0.527551,-0.12999,-0.0873791,-0.331015,-0.679722,-0.33613,0.342757,-0.0543362,-0.00104469,-0.399051,-0.0571427,-0.0780539,0.0201894,-0.612703,-0.120121,0.0251674,0.191839,-0.423746,-0.0853638,-0.0308725,-0.762641,0.00368782,-0.338828,-0.131845,0.231944,0.197567,-0.683036,-0.230366,-0.228046,0.0101436,-0.38962,-0.122489,-0.568661,0.726071,0.160895,0.41645,0.401117,0.645329,-2.93742 +3390.44,0.980516,0.0848144,5,1.49113,0.97818,-0.834683,0.178419,0.46977,0.0203137,-0.0717232,0.696454,0.291295,0.0699058,0.167073,-0.0266656,-0.119335,0.385557,0.105057,0.997268,0.040277,-0.104434,-0.172099,-0.152141,-0.312339,-0.860265,-0.680679,0.0112402,-0.627034,-0.0181837,0.0257893,0.248549,-0.82996,0.323875,0.891443,-0.221232,-0.0522922,0.0441557,-0.0760754,-0.104886,-0.019887,0.404288,0.789214,-0.113488,1.21434,0.29585,-0.0258534,-0.737748,-0.0998767,0.177784,-0.656027,0.161823,0.348253,0.35237,0.130894,1.16692,0.235409,0.0108509,1.08334,-0.00775116,0.196835,-0.957908,0.797567,-0.443429,0.115303,1.15407,-0.471586,-0.826684,-0.20116,0.13627,0.0205679,-0.0437367,-0.0725665,-0.592762,-0.720312,0.140451,0.245237,-0.252513,0.245033,0.579602,0.377193,0.0372756,-0.370941,-0.180695,0.0703831,0.0668461,0.417963,0.359289,-0.0920852,0.31552,-0.328467,-0.488538,-0.331339,-0.779491,-0.141526,0.347975,0.276763,0.390344,0.231027,-0.743916,0.318511,-0.853694,0.191724,-0.026273,0.105087,0.132295,-0.142749,-0.0584292,0.241342,-0.256388,0.282639,-0.167725,0.437032,0.644303,-0.80665,-0.0279778,-0.103001,0.0678792,-0.217022,0.103756,-0.343279,0.413294,0.731254,0.396039,-1.05381,0.105428,0.116635,-0.173012,0.299503,0.0293759,-0.180159,0.00114123,0.127809,0.163138,0.272063,-0.0631569,0.487361,0.902242,-0.385214,-0.0637406,0.275203,0.0110665,0.470402,0.00848049,-0.216915,-0.0171432,0.963153,-0.263755,0.125549,0.980263,-0.0194969,-0.287518,-0.314324,-0.245753,-0.26912,0.0814718,0.320708,0.600371,-0.477795,0.587279,-0.024906,0.151769,0.0480546,-0.290484,0.345941,0.688104,0.449997,0.472839,0.173288,-0.256441,0.355721,-0.182058,-0.485535,0.311031,0.394256,-0.0239115,-0.341036,-0.0107082,-0.641113,0.294777,-0.235607,-0.32786,0.313006,0.344413,-0.199211,-0.524412,-0.00765837,0.306346,-0.0570096,-0.568376,-0.765194,-0.770394,0.0472507,-1.61622,-0.0988646,-0.239749,0.226168,-0.0669783,0.115022,-0.129557,-0.0991,-0.330144,-0.839949,-0.033529,0.0935197,-0.424151,0.28057,-0.0986414,-0.430247,0.349482,-1.05754,0.747371,-0.160068,0.584271,0.807533,-0.0637731,0.377569,0.420172,-0.770257,-0.0887115,-0.117094,0.347929,0.425726,0.329866,0.225142,-0.255249,-0.168189,1.03196,-0.446603,0.637788,-0.353263,-0.142572,0.310079,0.500455,-0.674844,0.0295075,-0.557023,-0.335314,0.199066,0.0726987,-0.290603,0.221842,0.413534,0.146904,-0.51725,0.343648,0.467385,-0.878282,0.345811,0.333151,0.33466,0.0467,-0.372706,-0.713727,-0.0386447,-0.141167,-0.0845534,-0.216698,0.27334,-0.0540682,-0.401459,0.165439,-0.198992,0.33951,0.643913,0.245581,0.127063,0.845467,0.364342,0.0153393,-0.271735,-0.512367,-0.00934125,0.230982,-0.173236,-0.662626,-0.289128,0.269008,-0.277692,0.045869,-0.364327,0.201702,0.155776,0.203851,-0.560675,-0.134406,-0.137665,-0.0503863,-0.404957,0.345065,0.314842,-1.03722,0.222058,-0.0456509,-0.115583,-0.0831471,0.179162,-0.484803,-0.503096,0.198324,-0.28524,-0.19817,-0.0456409,0.242356,0.462966,0.158857,0.385994,0.398568,0.621284,-1.53351 +3394.25,0.973909,0.0848144,4,1.51658,0.977667,-0.729443,0.233743,0.699924,-0.0183306,-0.156399,0.376196,0.0805173,0.174056,0.081302,0.0722099,0.445755,0.661618,0.189946,0.813777,0.189157,0.186932,-0.0774719,-0.0389444,-0.289099,-1.00873,-0.129414,-0.160319,-0.833734,-0.218077,-0.186447,-0.159537,-0.695946,0.557439,0.926751,-0.224401,-0.121011,-0.21877,-0.179249,-0.270213,0.301443,0.293081,0.613246,-0.113579,1.29564,0.523207,-0.026758,-0.883907,0.0747446,-0.336725,-0.727091,0.323078,0.255963,0.245091,0.285631,0.743746,0.197283,-0.436597,1.07788,-0.0130786,-0.0311154,-0.462866,0.705869,-0.304439,0.497907,1.29245,-0.828174,-1.28963,0.126036,0.352712,0.26619,0.0596179,-0.136095,-1.17788,-0.358197,0.128678,0.179019,-0.407788,0.377431,0.648601,0.478277,0.116724,-0.150749,0.19736,0.109123,-0.125819,0.471957,0.476702,0.0354466,0.228755,-0.61408,-0.383291,0.0427491,-0.773583,0.112507,0.31636,0.403846,0.148744,0.176684,-0.642782,0.235023,-0.708673,0.159494,-0.114119,0.373214,0.304543,-0.0459822,-0.507476,0.524088,0.0661265,0.449143,0.0678796,0.127101,0.299519,-0.395448,-0.0849211,-0.178494,0.0521405,-0.0805835,-0.0483195,-0.0157124,0.100683,0.145738,-0.0888921,-0.761428,-0.396819,-0.339398,-0.684153,-0.0524797,0.24205,0.135351,0.107099,0.105635,-0.0494231,0.22841,-0.161987,0.153817,0.489023,-0.437736,0.336938,0.0527419,-0.00373606,0.420368,-0.107466,-0.45546,0.248583,0.735894,0.149117,0.310377,0.644925,-0.0701303,-0.24182,-0.350916,0.209824,-0.0573966,0.295837,0.282268,0.0538685,-0.464575,0.358806,-0.135149,0.0561046,-0.0836032,-0.892621,0.533057,0.710194,0.582925,0.496087,0.0141622,-0.129767,0.230398,-0.113002,-0.651576,0.531009,-0.0197735,-0.129842,-0.223818,0.0953851,-0.768954,0.0644596,0.0691589,-0.00680163,0.775234,0.537747,-0.174736,-0.288555,0.000855113,-0.0182247,0.154426,-0.938822,-0.583933,-0.335018,-0.0210686,-1.40516,0.0138648,-0.45332,0.350007,-0.145258,0.277358,-0.0491909,-0.212425,-0.486342,-0.882424,0.111536,-0.0511475,-0.224713,-0.216532,0.0810685,-0.304788,0.797163,-0.668662,0.889536,-0.405588,0.420525,0.412465,-0.141546,0.0748737,0.0832041,-0.649157,0.33176,0.0730778,-0.0303674,0.0770258,0.00468387,0.0452628,-0.392882,-0.662499,0.724878,-0.378782,0.484764,-0.189113,-0.104488,0.42508,0.200467,-0.305319,-0.118774,-0.16029,-0.154035,0.252287,0.306654,-0.114916,-0.0604247,0.183191,-0.0925462,-0.11046,0.521123,0.420854,-1.02273,0.385975,-0.0498954,0.307512,0.0298158,-0.172825,-0.499001,0.173608,-0.0275582,0.00442105,-0.600027,0.290363,-0.021388,-0.629137,0.0999894,-0.0268944,-0.00570314,0.495074,0.540313,0.289203,0.897511,0.053112,-0.299369,-0.135111,-0.546481,0.136553,0.553846,-0.236304,-0.444796,0.211621,0.370334,-0.333784,-0.348349,-0.201812,0.0220093,-0.122981,0.331908,-0.463625,-0.0607965,-0.239789,-0.145076,-0.34337,0.0910049,0.0399242,-0.716327,0.00748389,0.293284,-0.363035,0.159912,-0.0956981,-0.721038,-0.44413,0.282304,-0.770873,-0.148727,-0.136259,0.318546,0.597233,0.179826,0.238624,0.424059,0.488492,-2.36932 +3368.37,0.46406,0.0848144,5,1.61678,0.934906,-1.01201,0.406044,0.467522,-0.199828,0.265154,0.0998505,0.456904,-0.100631,-0.169102,-0.120405,-0.765374,0.594443,-0.0503243,1.00141,-0.099835,-0.145465,-0.223262,-0.0322561,-0.267075,-1.38129,-1.24555,0.116931,0.46822,-0.304013,-0.211701,0.273667,-0.00693421,0.145373,1.04365,-0.641937,0.0842706,0.298538,-0.218368,-0.275213,-0.910701,0.803952,0.0954373,-0.256224,0.50394,0.440235,0.377388,-0.632373,-0.338761,0.450388,-0.684029,0.364164,0.399705,-0.120302,-0.120012,0.371685,-0.267243,-0.404196,0.155951,-0.556576,-0.810071,-0.983501,0.0403304,-0.781681,-0.403786,1.14161,-0.555539,-0.677292,0.478723,-0.288061,-0.61019,-0.0720743,0.368044,0.168065,0.128741,0.405426,0.564385,0.295764,0.569926,0.602561,0.402057,0.0552929,-0.306898,-0.0330989,0.888785,-0.521061,-0.139997,-0.66828,-0.131521,-0.0752902,0.057716,-0.0221801,-0.41584,-0.520628,-0.240741,-0.419654,0.0359733,-0.367762,-0.202963,0.455445,0.0676831,-0.0813744,-0.159018,0.746557,-0.296062,0.0186001,-0.449635,-0.169044,-0.402207,-0.463694,-0.19809,-0.778277,0.431821,0.562781,0.241126,0.100834,0.378034,0.543435,0.0214152,0.00632999,-0.425579,0.0387842,0.348322,0.183365,-0.799555,0.315857,0.247352,0.396851,-0.26411,-0.275316,0.316093,0.0748911,0.24068,-0.742674,-0.0993452,-0.0850613,-0.0715915,0.283614,0.249148,-0.390054,0.102624,-0.416834,0.588363,-0.776013,-0.226501,0.166621,-0.504022,-0.887018,0.0275464,-0.63654,-0.191314,0.32945,-0.275105,-0.243387,-0.436255,0.404515,-0.0753329,-0.298764,1.00548,0.591482,0.0106993,-0.406917,0.339566,0.711278,0.122241,-0.580965,0.682201,-0.569298,-0.0340923,0.38437,-0.483817,-0.0626036,0.0804447,-0.928324,0.580845,-0.113995,0.177746,-0.225634,0.762132,-0.128899,-0.664091,0.0490551,-0.425002,0.39082,0.472826,0.0188919,0.507408,-0.379374,-0.461103,0.461325,0.196261,-0.33086,0.360003,0.832626,-0.244408,0.583227,-0.519104,-1.14092,0.0672362,0.587638,-0.0974627,0.0406393,0.0509043,-0.139248,0.143833,-0.143127,0.712007,0.0500875,0.157054,-1.07494,-0.479309,0.559419,0.709917,-0.352506,-0.333105,-0.295436,0.0958404,0.22859,0.287011,-0.163399,-0.662625,0.186159,0.34698,-0.328713,0.126884,-0.527238,0.647958,-0.36131,-0.281138,0.0687324,-0.319091,-0.445404,-0.390389,0.0277546,-0.00135916,0.278822,-0.148317,0.0217735,-0.801209,0.628177,0.361432,0.0472757,0.553712,-0.678195,-0.12438,-0.442741,-0.703025,0.70457,0.266044,0.322509,0.0880922,0.113999,-0.0167926,-0.640262,-0.238047,-1.13708,0.681859,0.367536,-0.560175,0.336665,0.260957,0.0140089,0.0689501,0.244031,-0.217041,-0.00197014,0.22913,-0.825882,0.0557539,0.129034,-0.648425,0.575802,-0.359922,-0.259382,-0.148257,0.00398721,-0.625127,-0.0689381,0.108452,0.206458,0.527598,-0.0364774,0.868989,-0.175058,0.17636,-0.172937,-0.227301,0.222082,0.241966,0.261723,-0.368147,1.10609,0.374583,-0.66039,0.320741,-0.0468824,0.218038,1.13664,0.223729,-1.15805,0.773489,-0.285934,-0.0130485,-0.571459,-0.564912,0.165817,0.248473,0.407207,0.49847,-1.39156 +3378.36,0.999724,0.0848144,4,1.68822,0.94123,-0.905046,0.34657,0.238885,-0.146357,0.431038,0.105803,0.213314,-0.0427403,0.0279419,-0.279451,-0.80228,0.310806,-0.347895,0.751414,0.00241314,0.0877272,-0.0725619,0.000213938,-0.441212,-1.23666,-0.794615,-0.00941362,0.196266,-0.353967,0.0687802,0.174612,0.100616,0.0959247,1.08891,-0.838133,-0.0280987,0.392758,-0.24777,-0.376934,-0.746298,0.719315,0.00855813,-0.206061,0.59292,0.333294,0.388902,-0.652813,-0.528154,0.412847,-0.710131,0.468054,0.471388,-0.290813,-0.269697,0.233078,-0.00610454,-0.448099,0.191185,-0.559501,-0.789897,-0.680618,-0.119599,-0.44846,-0.0665645,0.930498,-0.58797,-0.576461,0.133306,-0.15718,-0.310708,0.00405235,0.0942969,-0.130455,0.284441,0.299584,0.519862,0.275653,0.519469,0.33747,0.43358,0.26057,-0.386615,-0.153099,0.888633,-0.668513,0.22753,-0.608318,-0.0481702,-0.288843,0.0057377,-0.0935313,-0.425398,-0.838834,-0.252373,-0.223388,0.0866932,-0.471565,-0.297849,0.226938,0.330708,-0.131139,-0.306732,0.76763,-0.168714,0.0961469,-0.575557,-0.354547,-0.088041,-0.297801,0.0524688,-0.49976,0.555031,0.653404,0.523402,-0.168999,0.514631,0.450749,-0.00558982,0.293271,-0.376769,0.143178,0.294243,0.219845,-0.943177,0.082244,-0.00198891,-0.160852,-0.298217,-0.255853,0.369273,0.263929,0.506465,-0.812717,-0.026044,-0.364715,-0.322012,-0.283198,0.028808,-0.411669,0.045411,-0.390618,0.425099,-0.564052,-0.146824,0.18961,-0.457435,-0.371002,-0.153362,-0.677218,-0.170046,0.367703,-0.329473,-0.295576,-0.657399,0.145757,-0.339795,-0.0792829,0.834633,0.716898,-0.038058,-0.192077,0.312829,0.660796,0.386424,-0.489576,0.748457,-0.277851,0.0456863,0.342508,-0.476097,0.120555,0.0874961,-0.559277,0.254784,-0.19109,-0.0147482,-0.464063,0.678665,0.0787438,-0.535673,-0.240981,-0.25025,0.233455,0.374986,-0.0278318,0.155822,-0.857203,-0.633743,0.416771,0.295001,-0.410733,0.521567,0.682322,-0.254235,0.625972,-0.498483,-1.12942,-0.125368,0.848537,-0.0553422,-0.0626626,0.16094,-0.32735,0.0944765,-0.500034,0.72081,-0.0642312,0.438453,-1.02556,-0.651757,0.509363,0.890002,-0.328592,-0.727668,-0.50917,-0.00932703,0.374632,0.0845333,-0.108942,-0.884305,0.200339,0.303613,-0.377265,0.185662,-0.707858,0.486231,-0.420373,-0.209334,0.0228388,-0.433481,-0.113238,0.009514,0.0931667,0.00473434,0.223374,-0.0249699,-0.0677247,-0.658649,0.618227,0.290481,0.32336,0.290494,-0.451889,0.16605,-0.131265,-1.13037,0.420705,0.377051,0.301208,0.29536,0.149948,-0.200561,-0.557139,-0.421613,-0.963416,0.658514,0.0711363,-0.507136,0.45963,0.0570255,-0.0628965,0.0980176,0.142565,-0.255588,0.313258,0.162355,-0.996543,0.408678,0.230256,-0.612524,0.414819,-0.20467,0.0733954,-0.0238002,0.28281,-0.502139,0.0534709,-0.349099,0.363936,0.367866,-0.149167,0.588754,-0.273661,0.294844,-0.453911,-0.0675076,0.287209,0.274942,0.415089,-0.229132,1.09174,0.25661,-0.0879626,0.433739,0.112788,0.27304,1.05551,0.0989418,-0.462271,0.624,-0.245399,-0.249421,-0.486911,-0.503822,0.232296,0.285377,0.481971,0.534207,-0.585441 +3413.96,0.842214,0.0848144,5,1.55991,0.805781,-1.54119,0.564904,0.246122,-0.218219,-0.000134177,-0.0558452,-0.144566,0.241964,-0.118286,-0.563535,-0.0535144,0.543871,-0.476334,1.095,-0.161761,-0.206807,-0.622745,-0.271762,-0.151135,-0.888031,0.0130025,0.169771,-0.420094,-0.0778715,0.118551,0.803104,-0.349274,0.243237,0.885274,-0.280972,0.275179,-0.0704496,-0.167831,0.21845,-0.775078,0.183079,1.00186,-0.365712,0.808151,0.418623,0.0364795,-0.562223,-0.023131,0.504086,0.191157,0.0523615,0.679479,-0.28918,-0.110391,0.0889747,0.294641,-0.437084,0.13833,-0.00273747,-0.437257,-0.643971,0.274139,-0.253579,0.434376,1.20518,-0.577537,-0.538925,0.273866,-0.0767206,-0.106752,0.135684,-0.408406,-0.618251,0.00563167,0.571741,0.276304,0.00288744,0.357653,0.915752,0.179138,0.0747699,-0.0359986,0.145986,0.612322,-0.792842,0.149714,-0.0367404,-0.131211,0.0845297,-0.818671,-0.497748,0.0494703,-0.22515,-0.450329,0.00103903,0.130501,-0.308717,-0.2738,-0.548444,-0.156881,-0.147519,0.161189,0.18316,-0.0666378,0.0677559,-0.0486288,0.207347,0.0364106,-0.274928,0.0962059,-0.790467,0.650352,1.04769,-0.0134502,-0.283709,-0.10936,0.746534,0.263479,0.267335,-0.11059,0.11568,0.521735,-0.443847,-0.438116,0.0867559,0.276395,0.269409,0.260249,0.415413,0.341133,-0.0744579,0.0221777,0.126343,0.825981,-0.0118692,0.538205,0.35787,0.208998,-0.163122,-0.0451742,-0.264141,0.179469,-1.04329,-0.545881,0.0309073,-0.133445,-0.710854,0.0444059,-0.0740199,-0.39478,-0.21808,-0.387153,-0.473042,-0.348862,0.225518,0.236329,-0.175002,0.554054,-0.0646804,-0.0194753,0.112637,0.291962,0.148909,0.237411,-0.0869932,0.866677,0.00352217,0.0746542,-0.0805005,-0.361199,-0.102332,-0.457205,0.369318,-0.505446,0.47168,0.354368,-0.0820306,0.233185,-0.596919,-0.179924,-0.220071,-0.161932,0.859271,0.0819678,-0.144407,0.548059,0.161108,-1.00908,0.0980827,-0.439764,-0.218349,0.104043,-0.680611,-0.146427,0.121019,-0.304885,-0.316091,0.111304,0.425305,0.000654961,-0.605572,-0.955537,-0.14792,0.094719,0.456921,-0.34853,0.0166008,-0.762231,0.324558,-0.198119,0.689896,0.091323,-0.0576563,-0.141851,-0.199423,0.196241,0.59259,-0.313376,0.192961,0.167396,0.182917,0.61051,-0.0213208,-0.499338,-0.656676,-0.153464,0.409952,-0.369746,0.14076,0.087465,-0.293868,-0.0512358,-0.108044,-0.213215,0.336689,0.146142,0.106186,-0.339115,0.617396,-0.124108,-0.370622,0.0660629,-0.509218,-0.898585,-0.390106,-0.144816,0.306065,0.159662,0.123088,0.739252,0.519817,-0.0916308,-0.42597,0.633727,-0.838853,0.589799,-0.527714,0.0545834,0.558036,-0.247754,0.700147,-0.441154,0.109204,0.24098,0.624979,-0.291384,0.348997,-0.116789,-0.149705,-0.251914,-0.240888,-0.166806,0.369657,-0.50946,-0.464115,0.088396,0.468176,0.110238,0.529711,0.604106,0.455362,0.355382,0.206301,-0.46372,-0.0338082,-0.777371,-0.151176,-0.205463,0.208546,0.475202,0.486775,0.0665453,-0.631378,0.188483,-0.0399035,0.722717,0.0691484,0.295204,-0.0643037,-0.49546,0.340189,0.26682,-0.333915,0.306631,0.150907,0.143613,0.388468,0.378963,-0.353154 +3415.36,0.873526,0.0848144,4,1.55135,0.910435,-0.935502,0.354263,0.64303,-0.131473,0.136375,-0.0977945,0.0652304,0.34894,-0.0259599,-0.431515,-0.228307,0.494062,-0.523825,0.576928,-0.373643,-0.0849853,-0.225137,0.0985263,-0.389612,-0.982505,-0.185699,-0.00940028,-0.143013,-0.395918,0.268955,0.32423,-0.192668,0.573459,1.00509,-0.361478,0.391652,0.0268397,0.00586015,0.289939,-0.4556,0.433028,0.696954,-0.51455,0.778302,-0.0921394,0.522785,-0.739877,-0.136412,0.59134,0.196527,0.13463,0.589733,0.00989482,0.00171813,0.253292,0.271253,-0.508255,0.404623,-0.228827,-0.0376302,-0.808117,0.179656,-0.506554,0.371672,1.098,-0.661476,-0.496901,0.140698,0.115178,0.322646,0.473191,0.0675271,-0.69429,0.0952203,0.507317,0.59307,0.41723,-0.000352107,0.686798,0.110326,-0.300288,-0.210119,0.104035,0.413384,-0.20791,0.391408,0.0267037,0.327964,-0.321949,-0.38508,-0.523992,-0.137564,-0.569916,-0.131192,-0.455163,0.0499918,-0.714756,-0.101586,-0.296702,-0.155916,-0.780478,0.0558298,0.423236,0.0816752,-0.153652,-0.316423,-0.175584,-0.236422,-0.815813,0.570228,-0.58025,0.810938,0.651181,0.0412007,-0.128915,-0.457613,0.562783,-0.0563269,0.194623,-0.492238,0.265971,-0.162542,0.0423463,-0.460896,0.197633,-0.0984556,0.512733,-0.124892,0.0513928,0.558068,-0.60749,-0.124209,-0.813165,0.542782,-0.515871,0.553697,0.547749,0.49913,0.262351,0.18307,-0.382926,0.547042,-0.798286,-0.0287852,0.330036,-0.269775,-0.601696,0.235236,0.297431,0.0881811,0.299129,-0.215188,-0.415411,-0.21679,0.660215,-0.0801603,-0.683286,0.428543,0.6492,0.0356703,0.491343,0.147082,-0.214214,0.206094,-0.0597689,0.822044,-0.386682,-0.378969,0.653238,-0.298527,0.0402931,0.304515,0.279628,0.0256102,0.232238,0.210457,0.127877,0.00500407,-0.592934,-0.137896,-0.167367,-0.0894738,0.29825,0.18512,-0.187704,0.154816,-0.0958466,-0.120297,0.191228,-0.779643,-0.608069,0.568946,-0.155363,-0.346007,0.378445,0.0232507,0.138079,0.0216679,0.0478635,0.182913,-0.175096,-0.967014,-0.521535,0.0467258,0.0204535,-0.00899168,0.0384129,-0.545502,0.234213,-0.910236,0.653486,0.165742,-0.59739,-0.200955,-0.0695184,-0.215815,0.111769,-0.0939201,-0.374292,0.251946,0.160411,0.295408,-0.237139,-0.377323,-0.529277,-0.226332,-0.0302359,-0.180245,0.138707,-0.0786792,0.133775,-0.0412846,-0.132409,-0.445125,0.223816,0.00245662,0.371803,-0.45535,0.736536,-0.371687,0.397901,0.183544,-0.801336,-0.570688,-0.450804,-0.0455923,0.199239,0.0792518,0.248626,0.895304,0.450463,0.0485975,-0.27281,0.399208,-0.201321,0.876175,-0.460188,0.193322,0.324488,0.264957,0.205811,-0.590203,0.0258104,-0.40933,0.00341972,-0.10308,-0.228721,0.304579,-0.560982,-0.176685,0.33006,-0.185464,0.0469553,0.0305457,-0.476443,0.0461483,0.101129,-0.163481,0.269631,0.518524,0.659376,0.309588,0.583482,-0.227231,0.107486,-0.680801,-0.329415,0.303352,0.288479,0.0572247,0.326698,-0.0910886,-0.0096031,0.375461,-0.113017,-0.13065,0.480094,-0.0105043,0.0992906,0.246129,-0.469276,0.270542,-0.0330356,0.467303,0.1417,0.260415,0.376431,0.510309,-2.00455 +3419.66,0.460751,0.0848144,5,1.5629,0.888978,-1.34978,0.47072,0.117353,-0.196152,-0.0725795,-0.121442,0.289722,0.201195,-0.0283688,-0.209792,-0.188561,0.416513,-0.369521,0.620989,-0.330718,-0.0722682,0.262964,-0.0332799,-0.4629,-0.647654,-0.628722,0.0763697,0.0248511,-0.33331,0.216391,0.0928297,-0.134685,0.166177,0.890267,-0.576747,0.497651,-0.0207688,-0.212081,0.00300111,-0.223067,0.413562,0.23682,-0.769874,0.956624,0.401078,0.525199,-0.908071,-0.299781,0.815058,-0.192365,0.441239,0.599072,-0.101712,-0.324485,0.546738,0.169824,-0.625515,0.16268,-0.499958,-0.191758,-0.572456,0.15297,-0.452684,0.565845,1.30679,-0.120887,-0.369922,-0.244225,0.394701,0.261405,0.88479,0.153213,-0.563556,0.625154,0.494804,0.486178,0.389834,0.0543894,0.531354,0.216502,-0.188297,-0.125646,0.431716,0.647771,-0.467531,0.184833,0.0139413,0.276134,0.0387486,0.060792,0.0973185,-0.0467099,-0.513904,-0.13834,-0.164433,0.261237,-0.191274,-0.268242,-0.166595,0.120946,-0.467523,-0.0331369,0.30719,0.527395,-0.399559,-0.213551,0.289133,0.126855,-0.9351,0.224136,-0.685313,0.288579,0.586265,0.260631,-0.362634,0.289003,0.504207,0.139844,-0.00807874,-0.430759,0.0190954,0.33229,0.13891,-0.403283,-0.142331,0.454199,0.528076,0.0371757,-0.0055107,0.0392316,-0.123093,0.0117919,-0.566666,0.131617,-0.17882,0.410884,0.656925,0.261329,0.0913391,0.214468,-0.244857,0.401502,-0.619885,-0.000222001,0.048025,-0.603419,-0.298876,-0.0339379,0.286897,-0.208748,0.00184774,-0.180643,-0.126994,-0.240248,0.686063,-0.208929,-0.56896,0.695362,0.45225,0.229484,0.0672915,0.344413,-0.153613,0.482408,-0.120657,0.664771,-0.600189,-0.184869,0.751318,-0.187833,-0.277434,0.334483,0.21532,0.213059,0.467196,0.227975,-0.0691998,0.352014,-0.430602,-0.237784,-0.510814,0.0613195,0.239455,0.0865326,-0.328188,-0.124165,0.0950448,-0.286622,-0.0808609,-0.191159,-0.399967,0.504166,-0.415281,-0.327155,0.534826,0.00702834,0.100945,-0.273041,-0.294381,0.208935,-0.414708,-0.382039,-0.662613,0.115628,0.058986,0.194897,0.0472446,-0.548916,0.263504,-0.458192,0.623702,0.130486,-0.442427,-0.0940479,-0.12258,0.192987,0.503929,-0.0915224,-0.0157988,0.40337,0.145516,0.130034,-0.368223,-0.241237,-0.486416,-0.563426,0.0476373,0.311489,0.136575,-0.0699427,0.320894,-0.145215,0.33838,-0.460321,0.192504,0.201252,0.0261057,-0.437586,0.72623,-0.216151,-0.0145828,0.568042,-0.487501,-0.172345,0.157808,0.12599,0.430791,0.640976,0.384612,0.45712,0.0341711,0.186981,-0.721978,0.116216,-0.202598,1.10565,0.026742,0.0958503,0.229897,-0.0472304,-0.242353,-0.404643,0.0297457,-0.299389,0.801995,0.474959,-0.128906,-0.219596,-0.718775,-0.351244,0.0102766,-0.647091,0.269516,-0.0882089,-0.511966,-0.00434661,-0.0678026,-0.170211,0.186739,0.501318,0.622358,0.464788,0.302799,-0.308631,-0.197319,-0.859477,0.322913,0.00909488,0.11685,0.0585615,0.139485,-0.114287,-0.12054,0.199326,0.145231,-0.144623,0.550423,-0.100696,-0.273473,0.56655,-0.567262,0.173504,0.0750459,-0.0108397,0.139127,0.160935,0.372998,0.401167,-0.0865348 +3414.46,0.994154,0.0848144,4,1.50759,1.02904,-1.075,0.385358,0.300358,-0.0718608,-0.311026,-0.117649,0.25333,0.713487,0.0337693,-0.625801,-0.539069,0.533046,-0.19257,1.0361,-0.343877,0.0485196,0.00240388,-0.207624,-0.436211,-0.925275,-0.78961,-0.104258,-0.209394,-0.0693363,-0.207119,0.192747,-0.0433085,0.108903,0.834364,-0.56479,0.271249,-0.201708,-0.480051,0.112483,-0.178052,0.560847,0.302971,-0.633283,0.787905,0.279638,0.563259,-0.717538,-0.168508,0.655132,-0.111035,0.254053,0.655645,-0.111106,-0.304038,0.931814,0.0982874,0.0527169,0.212977,-0.55158,-0.488955,-0.622728,0.180387,-0.32092,0.20657,1.17873,-0.246883,-0.791965,0.057129,0.158323,0.560143,0.782696,0.138713,-0.709931,0.320563,0.822584,0.539794,0.549333,0.489278,0.856545,0.178451,0.362625,-0.0871883,0.398412,0.421601,-0.590468,0.374767,-0.0087718,0.0496907,0.125643,-0.354493,-0.353683,-0.112081,-0.65539,-0.311649,-0.278213,0.318574,-0.23602,-0.0385648,-0.691251,0.226136,-0.882252,0.668945,0.402525,0.274645,-0.394994,-0.425388,0.43813,-0.214426,-0.223878,0.0782704,-0.338567,0.267823,0.681941,0.168293,-0.19191,0.252137,0.325641,0.510605,0.366452,-0.391117,0.112932,0.477517,0.0835857,-0.417696,-0.334127,0.122804,0.394893,0.183279,-0.0226132,0.282922,0.16175,-0.0836077,-0.674442,0.00978032,-0.0473725,0.213184,0.498814,0.272939,-0.153518,0.362338,-0.221602,0.467976,-0.302321,0.18597,0.346361,-0.629573,-0.49595,0.0426058,0.302891,-0.123253,0.00839815,-0.372477,0.376899,-0.294581,0.518673,-0.130432,-0.351314,0.327599,0.628491,-0.279326,-0.0796949,0.577772,-0.105894,0.318894,-0.226567,0.976684,-0.223785,-0.40052,0.241472,-0.314248,-0.445815,0.459281,-0.145357,0.220091,1.23439,0.21065,-0.141345,0.29589,-0.17566,-0.124205,-0.60972,0.200856,0.60592,-0.0404509,-0.723296,0.0168246,0.248043,-0.510155,-0.233759,-0.173031,-0.652235,0.406029,-0.254457,-0.151989,0.48403,-0.0828255,-0.322535,-0.267815,-0.227576,-0.189558,-0.285183,-0.975526,-0.537576,0.168983,-0.298412,0.349018,0.228663,-0.901742,0.301309,-0.33936,0.85478,-0.0620296,-0.276779,-0.129553,-0.495358,-0.0245781,0.100767,-0.561455,-0.14305,-0.399366,0.206222,0.378619,-0.367431,0.129613,-0.298812,-0.510178,0.150012,0.13083,0.120504,-0.0708148,0.110046,-0.460394,-0.084769,-0.241258,0.127286,0.401109,-0.0341704,-0.0997457,0.672263,0.287947,0.397843,0.208749,0.0910495,-0.137915,0.289572,0.283409,0.529658,0.629602,0.73874,0.385225,0.103907,-0.0598278,-0.236616,-0.11855,-0.172681,0.71949,-0.192853,-0.202029,0.299605,-0.609565,-0.198681,0.0698266,-0.1514,-0.571223,0.0790849,0.530421,-0.250424,-0.290681,-0.571974,0.0669955,0.0480358,-0.207005,0.232264,-0.0712761,-0.622952,-0.300617,-0.296539,-0.158761,-0.0987355,0.551609,0.773968,0.335459,-0.0887748,-0.248239,-0.189051,-0.791519,0.210001,0.11922,0.311422,0.162051,0.0869847,-0.367282,0.0179104,0.135945,0.349081,-0.115962,0.549232,-0.08917,-0.00535786,0.0617898,-0.278606,0.0808528,0.264679,0.460624,0.150403,0.230293,0.387818,0.479888,-1.0915 +3429.33,0.707685,0.0848144,4,1.6435,0.889151,-1.10395,0.359542,0.714567,-0.158942,-0.484585,-0.0524039,-0.191893,-0.352379,0.0577455,-0.308614,-0.343413,0.149061,-0.48149,0.679367,-0.24267,0.268981,-0.382565,-0.207143,-0.124565,-0.847559,-0.818721,-0.448052,-0.118516,-0.173809,-0.602505,0.412697,0.0825211,-0.0812566,0.557459,-0.321772,0.290703,0.090711,-0.172199,0.226364,-0.459238,0.802889,0.725647,-0.0684828,0.444655,0.341381,0.196487,-0.640969,-0.37723,-0.080063,-0.387201,0.195505,0.507758,-0.0473646,0.027156,0.596656,0.186777,-0.695697,0.727145,-0.236838,-0.387997,-1.28449,0.462713,-0.696838,0.294699,0.890432,-0.665804,-0.959357,-0.0945568,0.0618187,0.0713881,0.55803,0.268027,-0.430713,-0.020203,0.742274,0.379853,-0.589212,0.275761,0.790927,0.260423,-0.00361617,-0.155114,-0.036874,0.415857,-0.614267,0.503768,0.16425,0.0127119,0.272239,-0.331135,-0.389295,0.185867,-0.455507,-0.367723,0.1766,0.0202698,0.161069,-0.0285558,-0.165481,-0.513364,0.2718,0.176625,0.580814,0.317169,0.459897,0.0398384,-0.35281,0.0764891,-0.573941,0.450126,-0.610357,0.287258,0.533171,0.0492363,0.216858,0.0399395,0.303105,0.469939,0.461669,0.148073,0.278527,0.480703,0.0136682,-1.05367,-0.302628,0.263482,-0.214288,-0.157597,-0.23674,0.264379,-0.0434434,-0.126402,-0.689455,0.882239,-0.0598725,0.263434,0.10269,-0.000963434,-0.697963,-0.382406,0.0716289,0.00420004,-0.502286,-0.00669556,0.344364,0.240116,-0.467162,0.224995,0.269149,0.176161,0.412857,0.153954,0.163569,-0.56363,0.221498,0.37795,-0.667516,0.177937,0.422345,-0.0153584,0.0460895,0.620766,0.384258,0.579895,-0.0804199,0.778593,-0.0590277,0.0217568,0.31197,-0.50278,-0.140624,0.112095,0.341989,-0.028123,0.0169397,-0.530096,-0.0355465,-0.102994,0.0411679,-0.0969681,-0.339274,0.215298,0.502948,0.36148,-0.951296,0.534271,0.386351,-0.114637,-0.0192637,-0.445678,-0.524368,0.738318,-0.285939,-0.0281039,0.0880885,0.322053,-0.698065,-0.626896,0.156607,0.44216,-0.666499,-0.682329,-0.381971,0.456595,-0.133746,0.0394499,-0.243192,-0.581429,-0.0680591,-0.311293,0.812568,-0.511871,0.213023,0.381349,-0.018155,0.0802928,-0.484746,-0.0197483,0.446163,-0.385212,0.204296,0.570057,0.271842,0.168547,-0.618901,-0.221798,0.428253,-0.153419,0.16307,-0.271578,-0.100402,0.111535,0.123283,0.0994441,-0.109304,0.0641612,-0.0578552,-0.125769,-0.070699,0.282385,-0.0638589,0.722821,-0.861894,-0.329061,0.461043,-0.116669,0.221554,0.235377,0.452345,0.152888,0.344016,0.185807,-0.256078,0.134309,-0.624069,0.745653,-0.599835,-0.578237,0.237773,-0.190452,-0.106453,0.683608,0.479444,0.318316,0.301737,-0.0202679,0.238577,-0.155662,0.161856,-0.0356353,-0.140898,-0.122475,-0.131123,-0.356288,-0.077805,-0.314619,0.253922,-0.227482,-0.168162,0.338362,0.14603,0.15008,0.373802,-0.211393,-0.120941,-0.932238,0.181741,-0.0562121,0.321878,0.0444901,-0.47381,-0.452821,-0.624385,-0.0662597,0.494837,0.0334622,0.484378,-0.406273,-1.00401,0.285083,0.0690584,-0.240951,-0.0289895,0.148837,0.153026,0.225239,0.391185,0.474594,-2.02189 +3416.85,0.936444,0.0848144,4,1.6551,0.922663,-1.1145,0.358571,0.472425,-0.141493,-0.440772,-0.0185463,-0.116105,-0.201458,-0.00866414,-0.428207,-0.335574,0.191043,-0.414191,0.732131,-0.177219,0.465151,-0.394693,-0.235821,0.0404737,-0.937628,-0.981942,-0.449719,-0.33266,-0.161818,-0.549464,0.320816,-0.113256,-0.0227443,0.596525,-0.153345,0.212793,0.16413,-0.20511,-0.0759183,-0.374581,1.03024,0.630386,-0.126765,0.329963,0.404279,0.102767,-0.626257,-0.415535,0.0224909,-0.425815,0.22295,0.639913,-0.108619,0.0802228,0.6436,0.0121242,-0.584862,0.657254,-0.443757,-0.270721,-1.33133,0.416061,-0.721675,0.382844,0.733968,-0.637764,-1.17396,-0.109471,-0.125553,-0.224233,0.715672,0.153863,-0.709305,0.00916743,0.853932,0.320172,-0.64716,0.320135,0.894548,0.0925171,-0.0609621,-0.136527,0.100302,0.523939,-0.496388,0.634655,0.254053,0.0503857,0.0490703,-0.671102,-0.195862,0.341189,-0.378066,-0.155024,0.25599,-0.0132991,0.0146353,0.310858,-0.0812529,-0.322175,0.185176,0.345791,0.638865,0.335983,0.389405,-0.145874,-0.525981,0.173316,-0.563292,0.328369,-0.646962,0.190874,0.507055,-0.075787,0.227788,0.0383257,0.138908,0.354145,0.301597,0.466895,0.267013,0.245326,-0.000300051,-0.873028,-0.238444,0.36448,-0.308766,-0.122755,-0.192368,0.179397,0.149383,-0.1082,-0.511118,0.667923,-0.018175,0.251322,0.216574,-0.111295,-0.711232,-0.633951,-0.0219184,0.0829182,-0.429604,0.100718,0.369448,0.348829,-0.245432,0.286077,0.210271,0.189868,0.412167,0.0397541,-0.072806,-0.488943,0.320409,0.393434,-0.445882,0.324478,0.381213,-0.0019884,0.0305157,0.651685,0.460434,0.588551,0.183786,0.824065,0.110693,0.0251156,0.401579,-0.569792,-0.186373,0.134194,0.460861,0.0104187,0.102152,-0.507465,0.137192,-0.0429751,0.12711,-0.0304441,-0.437231,0.186079,0.504766,0.385733,-0.788021,0.670133,0.487829,-0.175877,-0.00713443,-0.523826,-0.407517,0.561876,-0.353211,-0.0162971,0.15002,0.381444,-0.698511,-0.638851,0.195846,0.575867,-0.721896,-0.758019,-0.29835,0.464404,-0.20364,0.10379,-0.036494,-0.431671,-0.160785,-0.244587,0.858736,-0.273197,0.354826,0.371854,-0.0876816,-0.34289,-0.505421,0.353511,0.432378,-0.573278,0.259076,0.50065,0.591023,0.25092,-0.813128,-0.215346,0.254734,-0.33724,-0.0038722,-0.430693,-0.0829217,0.00505997,0.312695,-0.133264,-0.0420959,0.17546,-0.0244417,-0.27852,-0.0241144,0.248737,-0.167325,0.832462,-0.841196,-0.265404,0.516799,-0.0886544,0.132631,0.145311,0.425951,0.0464241,0.297855,0.0508695,-0.227895,-0.0130888,-0.480204,0.629617,-0.440026,-0.721737,0.318349,-0.383492,0.130086,0.512289,0.347226,0.38078,0.400925,0.00742378,0.0853269,0.0484831,-0.00568139,0.180394,-0.208375,0.0676073,-0.335896,-0.652931,-0.258836,-0.317451,0.366161,0.0473357,-0.382068,0.261007,0.0508611,0.251991,0.457916,-0.217147,-0.195667,-0.631466,0.0127214,0.148669,0.346677,-0.0884869,-0.291129,-0.350394,-0.615123,-0.0115668,0.402465,-0.0350675,0.546223,-0.230957,-1.00977,0.28234,0.0363777,-0.50445,-0.127051,0.0235923,0.171258,0.220174,0.413833,0.469227,-1.26358 +3426.42,0.983231,0.0848144,4,1.5102,0.872461,-1.07434,0.396469,0.986912,-0.0633262,-0.0440082,0.202156,0.293883,0.530765,0.111481,0.130762,-0.113166,0.162036,0.261434,0.856719,0.464481,0.0285927,0.427282,0.0207938,-0.0762331,-0.797683,-0.465668,0.463168,-0.228056,-0.0615875,0.0847207,0.0365852,-0.159225,0.0143868,0.803967,-0.605019,-0.245954,0.592796,0.0727775,-0.145109,-0.0618356,-0.387421,0.43444,-0.313288,0.960238,0.593688,0.193892,-0.722993,0.254763,-0.0461364,-0.558628,0.231198,0.665271,-0.077778,0.0335607,0.533967,0.14155,-0.264617,0.489932,0.240479,-0.153472,-0.753634,0.375185,0.0711223,-0.217401,1.55996,-0.25802,-0.622976,-0.00218149,0.726465,-0.353152,-0.604358,-0.102012,-0.246225,-0.253248,-0.137607,0.891062,0.153892,0.678073,-0.0999782,0.161191,-0.0843724,-0.386734,0.0350446,0.645927,-0.387402,-0.0717601,-0.114816,-0.0195862,0.30868,0.52263,-0.245548,-0.0189898,-0.45415,-0.165733,0.051926,0.175558,-0.0784267,-0.752037,-0.127419,0.412407,-0.614438,-0.116509,0.154777,-0.145281,0.0453454,-0.358816,-0.384899,0.335092,-0.0261046,-0.123366,-0.284133,0.0611002,0.44747,-0.28502,-0.473491,0.237718,0.669832,-0.653557,-0.16593,-1.09213,-0.00703507,0.234764,0.23252,-0.586721,0.0176157,-0.729181,-0.108749,-0.235891,0.409176,0.531324,-0.166287,0.27423,-0.367329,-0.114421,-0.211956,-0.288132,0.64478,-0.201983,-0.0491263,0.291765,-0.310275,0.662564,-0.368667,-0.711012,-0.22404,-0.320415,-0.358883,0.390398,-0.118271,-0.31682,0.43768,-0.499404,-0.112575,0.394707,0.00929167,-0.177859,0.0205405,0.0954923,0.451511,-0.0766618,-0.319936,-0.222535,-0.280549,-0.287227,0.0976124,0.158261,-0.364792,-0.0576226,-0.180761,-0.12566,-0.215673,-0.234988,-0.657254,0.270529,-0.062665,0.38233,-0.131647,0.0988759,0.292793,-0.33472,-0.163528,-0.137033,0.536376,-0.333794,0.361447,0.119252,-0.185852,-0.160592,-0.0673891,-0.373227,-0.266637,-0.215425,-0.640497,-0.0669661,-0.356396,-0.486535,-0.430296,0.469456,0.186445,-0.374878,0.191302,-0.301388,0.564532,-0.384043,0.0514532,0.133903,0.0939126,0.467733,-0.483596,-0.384823,0.889063,0.187174,0.101859,-0.200775,-0.342978,0.127528,0.406338,-0.278436,0.0199139,0.147501,0.273126,-0.0164031,-0.904253,-0.0694103,-0.164307,0.141766,0.247076,-0.44964,0.265323,-0.408406,-0.179276,-0.0763411,-0.301119,-0.32283,0.370127,-0.608454,-0.134005,-0.164356,0.960104,-0.0527234,0.309023,-0.067069,-0.152276,0.0961791,-0.163143,0.414439,0.0117105,0.613617,-0.375566,0.444638,0.0452394,-0.205048,-0.465818,-0.242656,-0.723595,-0.0042523,-0.399077,0.164656,0.301474,-0.292352,0.364113,-0.470342,-0.113481,-0.153393,0.299749,-0.0679042,-0.132329,-0.125523,0.37169,-0.373131,-0.426602,-0.221949,0.380068,0.332137,-0.54518,-0.235943,-0.0826083,0.0700895,0.401976,0.0261857,-0.0843981,0.378611,-0.157771,-0.221971,0.0775516,0.209917,-0.353599,-0.514229,-0.114878,-0.0301529,0.304925,0.386183,0.382366,0.0584497,-0.308184,0.291641,0.216549,0.109112,-0.172058,-0.0822268,-0.422172,0.328775,0.126297,0.0673953,0.131571,0.232587,0.362728,0.482272,-3.10429 +3449.92,0.997411,0.0848144,4,1.5201,0.811235,-1.25154,0.475242,0.99069,-0.120505,0.122192,0.31224,0.0406906,0.24884,-0.0707169,-0.102761,0.0274866,0.267074,0.137231,0.70974,0.196417,0.101754,0.343245,0.0326676,-0.330542,-0.734183,-0.93219,0.670439,-0.450462,0.081655,0.0719039,0.550248,-0.228096,0.0954614,0.975304,-0.664131,-0.184039,0.363876,0.159454,-0.0898366,-0.0289517,0.0793221,0.562914,0.122907,1.07345,0.557185,0.381825,-0.434224,0.0824766,-0.00663341,-0.597152,0.593205,0.322828,0.229617,0.117515,0.533624,0.289767,-0.00734332,0.430232,0.231432,-0.28157,-0.665752,0.494987,-0.330241,0.071905,1.23642,-0.298838,-1.07227,-0.137382,0.922815,-0.0930394,-0.44358,-0.134324,-0.107928,-0.177374,-0.0942972,0.604455,0.00380186,0.7185,0.169846,0.243366,0.0379734,-0.642077,0.157834,0.640575,-0.200542,-0.0416923,-0.489754,-0.0816395,-0.0402786,0.443898,-0.318206,0.268915,-0.446711,-0.178555,0.111,0.0961065,-0.062871,-0.331252,-0.380309,0.371704,-0.451254,0.0155184,0.0310937,-0.177037,0.125573,-0.402802,0.0452573,0.177338,-0.0840681,0.0950359,0.0121832,0.0114119,0.514138,-0.513438,-0.346155,0.359763,0.64838,-0.527076,0.139812,-1.05266,0.127174,0.197209,0.101796,-0.730125,-0.165931,-0.613608,-0.132248,-0.105176,-0.121587,0.354149,0.181765,0.0764876,-0.311149,-0.24014,-0.400909,-0.235869,0.231587,-0.284105,-0.280101,0.349335,-0.0678668,0.532998,-0.313865,-0.182636,-0.235414,-0.32556,-0.20904,0.157953,-0.219895,-0.493264,0.294574,-0.203815,-0.558444,0.152158,0.297305,0.136109,-0.126863,-0.0808427,0.43913,-0.219918,-0.2185,-0.226524,-0.0348175,-0.220729,0.505292,0.332653,-0.184514,-0.167484,-0.534131,-0.0780823,-0.159822,-0.403345,-0.402378,0.287324,-0.190425,0.21331,-0.290136,0.258717,-0.334717,-0.099485,-0.130739,0.148952,0.515993,-0.0564554,0.103782,0.344586,-0.292158,0.138803,-0.206112,-0.382283,-0.291403,-0.114971,-0.564228,-0.0277778,-0.256639,-0.449164,-0.548537,0.0713355,0.100225,-0.464307,0.204762,-0.307091,0.229198,-0.355145,-0.144539,0.608638,0.126976,0.597452,-0.341707,-0.295095,0.87069,0.182268,-0.0548582,0.228636,-0.195148,0.296577,0.16939,-0.485174,0.0496356,0.187311,0.652064,-0.0062643,-0.988657,-0.277478,-0.196514,0.128575,-0.0977186,-0.38748,0.391449,-0.487195,-0.265778,0.051646,-0.0640466,-0.0875299,0.455528,-0.479494,-0.169665,-0.278666,0.74663,-0.158922,0.516184,-0.130596,0.193716,0.224243,-0.0322953,0.137644,-0.195235,0.429296,-0.320739,0.498653,0.289225,-0.288861,-0.077472,-0.0896138,-0.707494,0.117403,-0.466749,0.0504191,0.09611,-0.354858,0.155167,-0.44899,-0.118621,0.164345,0.53518,-0.315717,-0.0748627,-0.0725057,0.0854088,-0.338037,-0.335377,-0.0443323,0.344939,0.401833,-0.560677,-0.0101934,0.0744102,0.0850591,0.349982,0.0662214,-0.265965,0.145045,-0.395057,0.0358543,0.14869,0.119137,-0.611876,-0.442348,-0.0990793,-0.0452511,0.364991,0.190582,0.159752,0.299944,-0.368979,0.242819,0.139016,0.124073,-0.450174,0.148495,-0.378406,0.5561,-0.176242,0.159388,0.11426,0.194995,0.338023,0.441582,-2.966 +3469.75,0.948243,0.0848144,4,1.62627,0.777805,-1.20156,0.545177,0.802449,-0.0571239,-0.209602,-0.0350119,-0.219859,-0.159129,0.096932,-0.35519,-0.266131,0.329334,-0.558558,0.957346,0.0978323,0.0588345,-0.25774,0.050248,-0.235729,-1.1974,-0.542249,0.524534,0.305651,-0.325319,-0.316796,0.324658,-0.555536,0.0307798,0.732915,-0.818026,0.757429,0.274904,-0.296192,0.0366153,-0.28091,0.819774,0.77084,-0.537211,0.848031,0.389347,0.0416257,-0.582323,0.245029,0.224549,-0.285921,0.0145978,0.0394565,0.203725,-0.0537714,0.535715,-0.298979,-0.857689,0.353581,-0.341317,-0.289453,-0.991161,0.336981,-0.502279,0.132012,0.867223,-1.14717,-0.527941,0.0369799,-0.3274,0.118948,0.508803,0.0143745,-0.312673,-0.01113,0.484532,0.365024,-0.0884284,0.141596,0.278795,0.325444,-0.220582,-0.0121012,0.0546995,0.412126,-0.288365,-0.0486616,0.0697607,0.213247,0.151257,-0.450293,0.486475,0.180945,-0.0829451,0.000457674,-0.352763,-0.0997309,-0.2947,0.169684,0.313292,0.145429,0.128102,0.252517,0.357775,0.312542,-0.1326,-0.295819,-0.59859,-0.157459,-0.0751522,-0.156396,-0.122508,0.236177,0.260207,0.052396,0.331883,-0.0120512,0.449079,0.279354,0.316627,0.306394,0.213244,-0.00157507,-0.137502,-0.196147,0.412559,0.655477,-0.297434,0.0202484,-0.0125163,-0.0108579,-0.0183194,0.529029,-0.0510743,0.270615,0.19862,0.0248516,0.248889,-0.099099,0.229206,-0.172003,-0.547423,0.265558,-0.16429,-0.0178739,-0.0948654,-0.116553,-0.527016,0.201728,-0.246613,0.23383,0.25533,-0.00236953,0.380255,-0.54336,0.266186,0.213236,-0.225064,0.17996,0.313595,0.17404,-0.0804195,0.305548,-0.208118,0.534265,-0.442979,0.357158,0.0790016,-0.196819,0.309674,0.295365,-0.159636,0.203557,0.163993,0.0585214,0.319348,0.0878875,0.158059,-0.0889802,0.371642,-0.240619,-0.176891,0.114465,0.379962,0.101137,-0.408254,0.382485,-0.066182,-0.626334,0.0933273,0.0129522,0.0281704,0.12326,0.073284,-0.0476189,0.137189,0.17392,-0.323992,-0.268004,-0.0777104,0.407139,-0.390898,-0.0919629,0.0314194,-0.108854,-0.174882,-0.0668859,-0.154755,-0.571171,0.376396,-0.107637,0.863848,-0.0157345,-0.0253831,0.0148544,-0.0812154,-0.321568,-0.0218987,-0.0330203,0.288043,-0.470875,-0.406264,0.398486,0.371947,0.0230604,-0.599076,-0.398573,0.454516,-0.447304,0.448522,-0.00454326,-0.352236,0.137414,0.325059,-0.210021,0.0476809,-0.161918,0.0988375,-0.33571,0.261994,0.154067,-0.245592,0.552239,-0.48084,-0.294181,0.277415,-0.435995,0.2554,0.0538402,0.11092,0.347626,0.19885,-0.111015,-0.446145,-0.118025,-0.226669,0.220224,0.237471,-0.285982,-0.0642298,0.0111291,0.456904,0.590426,-0.191156,-0.306403,0.0647618,0.552204,0.213736,0.0728544,0.0286685,0.180184,0.306942,-0.192687,-0.0879889,-0.479608,-0.0569061,-0.0427634,0.0187992,-0.277318,-0.294542,-0.0517145,0.366182,0.473796,0.200297,-0.513873,-0.339227,-0.226416,0.127003,0.45294,0.0247895,-0.312867,-0.148549,0.168058,-0.135918,-0.000768501,0.38687,-0.0492911,-0.145546,0.0648021,-0.105035,-0.0943408,0.14476,-0.279411,0.083361,-0.371002,0.0762987,0.257697,0.276222,0.507638,-2.28424 +3458.01,0.971562,0.0848144,4,1.59032,0.798733,-0.772226,0.36399,1.24062,-0.113225,0.291464,0.243199,0.778036,-0.0340033,0.0664325,-0.328666,-0.319323,0.382672,-0.23594,0.733526,-0.10258,0.0954655,0.400468,-0.216808,0.023619,-0.436176,-1.46168,0.718547,-0.616074,-0.0931153,-0.0136724,0.570194,-0.351701,0.227777,0.834115,-0.877436,0.0300121,0.414486,-0.365401,-0.501891,-0.194901,0.110989,0.600237,-0.148781,0.879674,0.265533,0.0867042,-0.44943,0.0359526,-0.473148,-0.668041,-0.188228,0.0677409,0.0686373,-0.268508,-0.0558839,0.112164,-0.0132743,0.917795,-0.544348,-0.527092,-1.01682,0.718196,-0.682123,0.160858,0.858244,-0.183327,-1.20896,-0.265383,0.297299,-0.0384355,-0.709489,-0.0325042,0.0254074,0.36135,0.305353,0.489428,0.251702,0.414909,0.498811,0.110013,0.160077,-0.34395,0.179246,0.610676,-0.109679,-0.0652813,-0.196481,0.435987,-0.166715,0.322176,-0.261919,0.119211,-0.276812,0.38803,0.357256,0.268147,0.592138,0.146066,-0.261443,0.216769,-0.707004,-0.0111814,0.0566217,-0.0359356,-0.282991,-0.162672,-0.149874,0.427206,0.39904,0.0178639,0.0986478,0.0612468,0.491287,0.146267,-0.222661,0.3046,0.241348,-0.0487019,0.254282,-0.515978,-0.0748827,0.413813,0.380128,-0.473079,0.125842,-0.840539,0.107079,-0.112039,0.319633,0.40025,0.39221,0.203879,-0.357067,0.0827733,-0.364598,-0.389907,0.461366,0.00315278,-0.180665,0.214443,0.242533,0.377995,-0.347829,-0.0184399,-0.376955,0.154901,0.107548,-0.128812,0.535279,-0.255187,0.175509,-0.163348,-0.347428,0.162846,0.0694505,0.286027,0.0898697,-0.217855,0.221404,0.0180859,0.418611,-0.0834079,0.184471,-0.634009,0.374964,0.316837,-0.477822,0.0494237,-0.370147,-0.201919,-0.126584,-0.415166,-0.114375,0.345973,-0.0768376,-0.129838,-0.419321,0.334555,-0.281187,-0.255652,0.121401,-0.0157623,0.86911,-0.0107662,0.0104175,0.0822097,0.231435,0.0554335,0.018817,-0.088128,0.0561921,0.397675,-0.452716,-0.0280583,-0.0200591,-0.115635,-0.390259,0.12975,0.289194,-0.293023,0.0600176,-0.337118,0.600871,-0.363985,-0.120251,0.539683,0.341563,0.588709,-0.0155888,-0.537413,0.981242,-0.085229,0.244344,0.0554235,0.137794,0.07078,0.0470114,-0.436912,-0.0544524,0.209741,0.399794,0.104864,-0.254472,-0.316982,-0.268341,0.372685,-0.176788,-0.259712,0.586394,-0.245353,-0.183291,0.0102489,-0.0532253,-0.25935,0.0908593,0.0561687,-0.320172,0.0321519,0.374341,-0.0338329,0.272488,0.508346,0.0243676,-0.111907,0.0126977,0.216104,-0.582278,0.347189,0.00129416,0.786469,0.15725,-0.117359,-0.210184,0.618771,-0.456258,0.345658,-0.237799,0.175815,0.494157,-0.221818,-0.813221,-0.523672,-0.245367,0.120016,0.39008,-0.0367194,-0.035793,0.112781,0.388845,-0.106761,-0.26453,-0.293259,0.0813714,0.521126,-0.256054,-0.224089,-0.00284281,0.0248163,0.372014,0.190032,-0.00965956,0.0754838,-0.155263,0.322988,0.385957,0.262645,-0.0481634,-0.340188,0.269152,0.161098,0.331279,0.0990534,-0.171851,0.0296148,-0.0317932,0.323911,0.426223,-0.323247,-0.494981,0.272117,0.114442,0.064844,-0.134852,0.416189,0.107381,0.232176,0.327691,0.481847,-3.85155 +3439.55,0.81751,0.0848144,4,1.53806,0.983342,-0.517664,0.170062,1.06003,-0.0801922,-0.340626,-0.145735,0.54207,0.259662,0.0620086,0.0201835,-0.106787,0.1719,-0.37951,1.21318,0.139339,0.106339,-0.148131,-0.229178,-0.445445,-0.520882,-0.376065,0.37858,-0.245705,-0.359143,0.462597,-0.181553,-0.14588,0.504129,0.659152,-0.353603,0.266181,0.769984,-0.0963979,-0.102794,-0.227371,0.194189,1.18736,-0.463101,0.878585,0.0559336,0.288569,-0.322093,0.181047,0.192845,-0.709931,0.204781,-0.0133221,0.0185138,0.144479,0.783446,0.33967,-0.805735,0.834775,-0.238629,-0.450935,-1.03091,0.555351,-0.55851,-0.154614,0.79887,-1.39282,-1.03924,-0.343922,0.250483,0.118302,0.252833,-0.0653932,-0.322668,-0.41437,0.289672,0.402869,-0.196281,0.150616,0.486574,0.394265,-0.227984,0.226621,0.0767569,-0.196791,-0.0263122,-0.0685511,0.560961,-0.00202161,0.113415,-0.513788,-0.24126,-0.415383,-0.224446,-0.129227,-0.192942,-0.135528,-0.0435052,0.0456796,-0.223187,0.182802,0.202919,-0.0627608,0.433496,0.326545,-0.0680046,-0.463096,-0.590113,-0.218412,-0.250326,0.134925,-0.298655,0.520627,0.251539,-0.582559,0.058715,0.325767,0.532828,0.143256,0.20848,-0.0852077,0.0578443,-0.0673734,-0.215496,-0.213552,-0.0274263,-0.0899678,-0.571823,-0.0303423,0.246503,-0.414436,-0.237548,0.281445,0.260858,-0.0769473,-0.0649393,0.298947,-0.0292627,-0.365746,0.332299,-0.0788118,0.0747446,0.545089,-0.44437,-0.132413,-0.226176,-0.104,0.135575,-0.198621,0.209283,0.21295,0.442401,-0.18854,0.215502,-0.518078,0.118493,0.281346,-0.123094,-0.287667,0.745682,-0.0633476,-0.233578,-0.0543265,-0.00015936,0.265748,-0.397887,0.607968,0.323282,0.116008,-0.203115,0.364683,0.22521,-0.102943,0.0750029,-0.510524,0.226951,0.0961797,0.0205481,0.463204,-0.0116734,-0.160892,-0.0268487,0.49934,0.347748,-0.489677,-0.377747,0.413914,-0.0764789,-0.41238,-0.354614,0.0532156,0.156622,-0.387331,-0.0860566,-0.112878,0.229585,0.29475,-0.386884,-0.159968,0.494227,0.413702,-0.0181957,-0.488113,-0.247182,-0.505502,-0.022522,0.903301,-0.54162,-0.0443181,-0.135539,-0.742616,0.899128,-0.236528,0.568406,-0.428087,-0.197296,0.284533,0.144958,0.0717982,-0.0257771,-0.312431,-0.0170934,0.48357,-0.4496,0.442707,-0.373142,-0.500967,0.544933,-0.227769,0.832831,0.138763,-0.0704165,-0.0382244,-0.176311,0.286028,0.0624815,-0.224191,0.29981,-0.00566103,0.432461,0.24327,-0.170444,0.450586,-0.290694,-0.392105,0.691122,0.322975,0.0734313,0.352542,0.19689,0.27252,0.0631837,0.220269,-0.489201,-0.0239383,0.0271973,0.422287,0.0466237,-0.219561,0.0482185,-0.223926,0.176496,0.752646,-0.0959152,0.580736,0.273413,-0.0478446,0.0724539,-0.229475,-0.647398,0.223065,0.381433,-0.188743,-0.461023,-0.141242,0.174389,0.217733,0.099039,-0.290707,-0.309812,-0.0287162,0.154228,-0.0849766,0.169147,-0.506126,-0.461182,-0.246207,0.132324,0.292754,0.21182,-0.133692,0.246826,0.20169,0.0107866,0.0172747,0.455008,0.0368825,0.058111,0.178689,-0.16039,-0.231116,-0.218446,-0.304562,-0.188946,0.0374547,0.0948565,0.292989,0.307988,0.541284,-3.58875 +3438.29,0.959142,0.0848144,4,1.58732,0.924679,-0.634128,0.248383,0.732162,-0.0806409,-0.184467,0.0322204,0.299619,0.493027,0.0354655,-0.249018,0.199817,0.453713,-0.358665,0.938716,0.0179753,0.14841,-0.54637,0.0786375,-0.188233,-0.654103,-0.754802,0.303114,-0.57432,-0.232007,-0.0643032,0.140763,-0.191178,0.752301,0.759336,-0.615338,0.199379,0.642843,0.123201,-0.0923183,0.217855,0.540249,0.924288,0.164373,0.992884,0.198217,0.568629,-0.570804,0.106973,-0.0754977,-0.781727,0.19155,-0.14094,-0.170362,0.0188882,0.736063,0.198605,-0.160952,0.528409,-0.186685,-0.419379,-1.20561,0.52505,-0.762583,0.00165295,0.895873,-1.2001,-1.24069,0.148506,0.209985,-0.188374,0.592718,-0.112972,-0.442822,-0.270079,0.441516,0.622286,-0.121017,0.455132,0.15374,0.18027,0.105387,-0.156893,0.152316,-0.0422201,-0.0912637,-0.0670124,0.580331,0.0835605,-0.18504,-0.117487,-0.292221,-0.370936,-0.0933138,-0.0486887,-0.0176918,-0.0486705,0.034619,0.263952,-0.231052,0.194222,-0.171585,0.0356615,0.115305,0.589887,-0.384047,-0.718081,-0.321298,-0.4854,-0.19974,-0.0550165,0.120662,0.167101,0.100367,-0.539216,-0.244811,0.470337,0.523705,0.107861,-0.284563,-0.259413,0.229511,0.0582997,-0.422694,-0.203023,-0.015155,0.00479588,-0.797824,0.378428,0.123893,-0.296865,-0.0524062,0.0075128,0.268845,-0.214327,-0.0705461,0.343,0.378285,-0.0417814,0.0575576,-0.32401,-0.125428,0.326,-0.540487,-0.211785,0.0168663,-0.0900761,0.0831088,-0.0840519,0.486786,-0.154309,0.0306618,-0.195075,0.29991,-0.458544,0.0938087,0.0893756,-0.341401,0.0687073,0.777115,-0.0959301,-0.176937,-0.0264741,0.0157221,0.00915935,0.0972152,0.349702,0.509655,0.115922,-0.273184,0.0427521,0.168024,-0.0205709,0.190688,-0.412079,0.322749,0.207514,0.112086,0.620002,-0.00467413,-0.104034,0.0519012,0.473356,0.378397,-0.228586,-0.130262,0.164239,0.0807779,-0.240789,-0.0512454,0.355919,-0.0203979,-0.0771419,-0.425477,-0.167034,0.343334,-0.112833,-0.454385,-0.267953,0.245713,0.382255,0.10451,-0.133573,-0.0658366,-0.420631,0.154135,0.500029,-0.289333,0.336117,-0.223165,-0.557187,1.0176,-0.392104,0.388594,-0.32847,-0.145279,-0.106319,0.459789,0.281279,-0.175837,-0.163057,-0.207665,0.551986,-0.043891,0.235768,-0.0832049,-0.71416,0.168853,-0.337388,0.866969,-0.172936,-0.0716215,-0.343743,-0.00455027,-0.0972979,0.323484,-0.32088,0.291542,-0.214038,0.172437,-0.309219,-0.264207,0.390756,-0.0512036,-0.479448,0.268023,0.622956,0.330069,0.341673,0.201269,0.279717,0.0906135,-0.247055,-0.48007,-0.0292163,-0.318965,0.360511,-0.298177,-0.0859232,0.0610066,-0.203519,0.45129,0.717824,0.0246849,0.398398,0.605538,0.52369,-0.0475481,-0.394532,-0.716236,0.237817,0.493331,-0.148794,-0.6001,-0.445325,-0.000161071,-0.663419,0.15886,-0.393542,-0.319738,-0.0517229,0.183819,-0.0299832,0.103227,-0.448147,-0.121494,0.210458,0.131454,0.158429,0.216884,0.136043,0.495591,-0.28636,-0.241179,0.194072,-0.087277,-0.285464,-0.172705,0.288745,-0.308072,0.0967769,-0.273833,-0.143656,0.0195169,-0.0339015,0.122323,0.31896,0.349746,0.564765,-2.3603 +3427.17,0.895358,0.0848144,5,1.56114,0.860364,-1.10176,0.460659,0.757262,-0.223162,-0.11961,-0.0448196,0.33924,0.119947,0.186103,0.0686047,0.114438,0.0466896,-0.0290635,0.857142,0.301327,0.243032,0.0594141,-0.0766483,-0.157566,-0.807384,-0.82178,0.250362,-0.553071,-0.0182814,0.0978579,0.00301525,-0.306382,0.690498,0.589464,-0.597705,0.279963,0.598161,-0.251326,-0.252956,0.109389,0.325792,0.636463,-0.225164,0.799841,0.229856,0.0812257,-0.896295,0.240892,0.595262,-0.683841,0.10624,0.0449069,-0.169028,0.172346,0.34041,0.249815,-0.777815,0.437747,-0.0382416,-0.494515,-0.362713,0.22211,-1.12484,0.0287552,0.837079,-1.01486,-0.840371,-0.0267411,0.293319,0.260867,0.128877,0.226683,-0.646429,-0.36302,0.124113,0.744162,-0.156071,0.558898,0.539543,0.193935,0.125522,-0.0793829,0.100457,0.577697,0.207734,0.122666,0.184745,-0.0510867,0.473595,0.253093,-0.167627,-0.611977,-0.472627,-0.231369,0.390678,-0.506593,-0.393816,-0.190206,-0.220827,0.0757846,-0.0890571,-0.372492,0.326514,0.333608,-0.394968,-1.19593,-0.294598,-0.530708,-0.822397,0.0700724,0.183222,-0.242984,0.49474,-0.207433,-0.287391,-0.146215,0.516557,0.0727313,0.336845,-0.226183,0.187756,0.555659,-0.503891,-0.628264,0.023934,0.398032,-0.365041,0.0234012,0.0560366,-0.0565931,0.203906,0.498384,-0.670117,-0.405981,-0.0827977,0.250289,0.495153,-0.341881,-0.251235,0.356713,-0.333576,0.315055,-0.787922,0.121592,-0.317107,0.344752,-0.225006,-0.148543,-0.0374917,0.426473,-0.500664,0.0264846,0.0525441,-0.268421,-0.118994,0.0012339,0.219997,-0.0662317,0.350966,-0.107559,0.0965118,0.278432,0.00315786,0.41478,0.585035,0.545267,-0.126129,0.0668609,-0.107662,0.409113,-0.0441916,-0.591476,-1.00052,-0.15359,0.0973692,-0.0366946,0.202936,0.0130642,-0.404275,-0.287054,0.167966,0.392083,0.373546,0.574384,-0.0642558,-0.570927,-0.063775,0.17374,-0.15074,-0.340268,-0.0507922,-0.0512428,-0.90774,-0.00631715,-0.0514566,-0.453767,-0.864991,0.00197852,0.0108947,-0.367273,-0.640581,0.0217158,-0.0417039,-0.236679,0.449095,0.2172,-0.604998,-0.063243,0.169304,-0.62362,1.00426,0.0811784,-0.119332,-0.198157,-0.400754,-0.145575,0.00187088,-0.145352,-0.488288,0.055514,-0.02019,0.101628,-0.27879,0.206676,-0.813599,0.0845862,0.124463,-0.220975,0.68606,0.218847,-0.307985,0.0825013,0.293373,-0.264654,0.104115,0.0718312,-0.150164,-0.252916,0.590398,0.412192,-0.23545,0.904806,-0.385046,-0.543242,0.255851,0.308066,0.374895,-0.117651,0.373821,0.295876,0.595606,0.289818,0.234128,0.325908,-0.378809,0.416233,-0.268968,-0.157008,0.243699,-0.0510746,0.244032,0.0120903,0.157659,0.407039,0.102765,-0.391448,0.270113,-0.146188,-0.00191299,0.175137,-0.338863,-0.250588,0.270498,-0.133459,0.0133525,-0.33762,0.0713956,-0.0974981,0.108222,0.150219,0.339585,-0.743303,-0.0481644,-0.144869,-0.274609,-0.282279,-0.127934,-0.152712,0.402075,-0.136987,0.107395,0.351098,-0.637537,0.249576,0.511563,-0.251918,0.419067,-0.450878,-0.269038,-0.148172,-0.0360721,0.481138,-0.0318395,-0.191496,0.111053,0.230482,0.333246,0.480085,-2.27609 +3420.73,0.992713,0.0848144,4,1.62205,0.749206,-0.916703,0.396992,0.620441,-0.116697,0.185613,0.0729776,-0.304013,-0.0668577,0.0289957,-0.274569,-0.201949,0.115276,0.0234123,0.907947,0.110275,-0.117471,-0.0397983,0.282622,0.00557995,-0.616349,-0.919918,0.439279,-0.866079,-0.182384,0.302824,0.142641,-0.560079,0.528769,0.620901,-0.858547,0.307574,0.518059,-0.100849,-0.364859,-0.128897,0.265016,0.824481,-0.200511,0.806667,0.110544,0.89017,-0.581138,0.477962,0.482847,-0.161559,0.0937452,0.00110741,-0.0562752,-0.110562,0.334661,-0.0876122,-0.93513,0.451731,-0.831176,0.110333,-0.51022,0.434239,-0.483181,0.210609,0.898095,-0.96356,-1.01661,0.209771,0.503637,-0.0209311,-0.112094,0.0382852,-0.0944137,0.0738031,-0.241403,0.921029,-0.265989,0.0671577,0.112307,0.292633,0.359691,-0.400004,0.0179969,0.67651,-0.126026,-0.108233,-0.327066,-0.0970915,-0.25845,0.0423365,0.739625,-0.271246,-0.170488,0.357782,-0.351953,-0.0770211,0.258352,-0.209211,-0.596402,0.137506,-0.0367736,-0.36033,0.187125,0.16544,-0.606472,-0.394713,-1.12894,0.140929,-0.190344,0.557527,-0.220087,0.577054,0.435228,-1.11906,-0.600759,0.432563,0.495693,0.0119958,-0.115313,-0.651192,0.057197,0.00605923,0.402931,-0.750795,0.282617,0.451785,-0.533918,0.0264366,0.490216,0.372866,-0.328003,0.167486,-0.20532,0.0809421,0.36357,-0.284553,0.151802,-0.19868,-0.160552,0.405779,-0.283843,0.427226,-0.283215,-0.230523,0.186989,0.578307,-0.278147,0.438301,0.808177,-0.047,-0.274228,0.00631185,-0.112603,-0.0830127,-0.124992,-0.0305677,0.179398,0.481616,0.647498,0.365998,0.266443,0.0780897,0.0013454,-0.117862,-0.174664,0.13455,0.372786,-0.123102,0.373909,-0.0585724,-0.458214,0.14227,-0.96798,0.231435,0.174424,0.356356,-0.423313,-0.178765,-0.562685,0.0390078,-0.153782,0.0322125,0.706525,0.52982,-0.492922,-0.528539,0.0473053,0.31978,0.254228,0.0464082,-0.243011,0.0506857,-0.362261,0.283626,-0.383326,-0.270513,-0.286622,-0.0725814,0.208809,-0.514491,-0.562283,-0.163586,-0.0931387,0.00047899,-0.101503,-0.236791,-0.527452,0.163315,0.258185,-0.28202,1.15577,0.14323,-0.186273,0.248784,-0.633176,0.0993374,-0.107378,-0.059027,0.115082,0.0157636,0.0906292,0.755428,-0.161397,0.269449,-0.777425,-0.11723,0.174982,-0.28784,0.693408,-0.23635,-0.224773,-0.3784,-0.0264328,-0.0434835,0.21452,-0.252108,-0.0743618,-0.647862,0.474643,0.199853,-0.276145,0.248988,-0.134619,0.298888,-0.072956,-0.323027,-0.0638919,0.138425,0.144689,0.477563,0.109932,0.279181,0.236513,0.327443,0.000745272,0.304887,0.363597,-0.0337826,0.425164,-0.220076,0.000341169,0.804061,-0.197255,0.56279,0.363578,0.21367,-0.0922995,-0.299379,-0.348171,0.421818,0.267006,-0.596693,-0.314419,0.0431208,-0.200735,0.0919513,0.0214449,-0.0580689,-0.213162,0.0875411,0.0172047,0.475708,-0.116167,-0.617858,-0.0367838,-0.63523,0.14335,-0.070953,0.258459,-0.387781,0.379964,0.253528,0.356915,0.282731,0.0233262,-0.0814123,-0.172739,-0.0310877,-0.29076,-0.229854,-0.227699,0.12093,-0.280152,-0.609841,0.134732,0.291738,0.367059,0.540128,-1.62791 +3423.7,0.978464,0.0848144,5,1.62019,0.768542,-0.937985,0.400783,0.647592,-0.0942818,0.133272,0.0200378,-0.342859,-0.153694,0.0226684,-0.238018,-0.180606,0.083618,-0.0252729,0.940524,0.173633,-0.124865,0.0181578,0.27408,-0.0259578,-0.647219,-0.872779,0.400868,-0.841848,-0.207609,0.282179,0.129287,-0.494619,0.474603,0.60649,-0.843577,0.255515,0.509897,-0.0860985,-0.406353,-0.153508,0.243257,0.785775,-0.186211,0.788945,0.124601,0.965214,-0.558693,0.42518,0.501557,-0.216292,0.00581644,-0.0396201,-0.0757392,-0.107472,0.344689,-0.114089,-1.04355,0.45728,-0.799755,0.113953,-0.563344,0.353716,-0.464742,0.181415,0.88585,-0.973035,-0.965124,0.189552,0.47228,0.0236725,-0.0474325,-0.000140554,-0.150385,0.0765457,-0.141674,0.930582,-0.272606,0.0920843,0.17937,0.248338,0.401362,-0.379684,0.111014,0.652931,-0.160782,-0.134297,-0.323681,-0.100688,-0.308651,0.011175,0.688977,-0.243613,-0.103251,0.418762,-0.391415,-0.0994706,0.226958,-0.304992,-0.593586,0.212567,-0.0510846,-0.253621,0.194177,0.209427,-0.586156,-0.357387,-1.14026,0.189113,-0.216546,0.48525,-0.246335,0.596282,0.465164,-1.00313,-0.660192,0.330815,0.483088,0.0597104,-0.134138,-0.668365,0.00340981,0.054666,0.394295,-0.714223,0.297166,0.420082,-0.481861,0.0411331,0.492884,0.23883,-0.422041,0.0880546,-0.158219,0.0126402,0.340172,-0.22786,0.134781,-0.209623,-0.132897,0.29596,-0.327952,0.410612,-0.341733,-0.117988,0.18539,0.663893,-0.260355,0.487514,0.75555,-0.0307193,-0.320116,0.0335762,-0.0809513,-0.11803,-0.108374,-0.0243186,0.122705,0.4485,0.61736,0.342202,0.294688,0.146228,0.0552158,-0.0746313,-0.131623,0.114081,0.403071,-0.122435,0.492795,-0.0712265,-0.406476,0.101567,-0.883951,0.236308,0.114703,0.379644,-0.443918,-0.219452,-0.503976,0.053566,-0.162342,0.0666724,0.697756,0.510035,-0.603314,-0.512107,0.0928702,0.284555,0.146585,0.0216775,-0.205463,0.0131239,-0.372631,0.282418,-0.402577,-0.318536,-0.255156,-0.114008,0.25103,-0.527454,-0.437757,-0.19096,-0.0922819,-0.00112836,-0.0951532,-0.233388,-0.441502,0.113967,0.301537,-0.270154,1.10531,0.12108,-0.206238,0.33578,-0.608019,0.202205,-0.0154098,-0.086976,0.123531,-0.0133203,0.106775,0.740881,-0.252076,0.245762,-0.786076,-0.191833,0.104243,-0.244642,0.71409,-0.205152,-0.190203,-0.49281,-0.0746249,-0.0299663,0.243198,-0.181316,-0.0807623,-0.688899,0.458341,0.194611,-0.207446,0.235405,-0.15782,0.328738,-0.026921,-0.232652,-0.0595682,0.172824,0.0586458,0.497956,0.139484,0.328596,0.200376,0.405589,-0.0089636,0.335534,0.381062,-0.00360957,0.443542,-0.234073,-0.0282049,0.829915,-0.161804,0.549936,0.342001,0.162208,0.0354644,-0.310908,-0.314882,0.437445,0.320065,-0.563044,-0.210843,0.0694139,-0.152369,0.18484,0.0785254,-0.0921189,-0.138672,0.113193,0.0424288,0.51673,-0.108543,-0.629269,-0.04581,-0.616475,0.161842,-0.00936069,0.278029,-0.405494,0.276881,0.217101,0.370626,0.250009,0.0196999,-0.0445988,-0.208462,-0.00891794,-0.312479,-0.238674,-0.264167,0.184447,-0.321873,-0.602605,0.135336,0.289379,0.36788,0.537939,-1.7521 +3393.88,0.714773,0.0848144,4,1.48381,0.91055,-1.38778,0.563846,0.758358,-0.128499,-0.372868,-0.142319,0.488308,-0.0903259,0.256293,-0.0203415,0.0317233,-0.0715174,-0.259416,1.10325,0.173828,-0.0969106,-0.0874395,-0.0602229,-0.239485,-1.12552,-0.566816,0.466783,-0.428696,-0.176283,0.3767,0.534639,-0.532041,0.594892,0.433531,-0.736312,0.309923,0.487082,-0.349896,-0.432426,-0.349493,0.442522,0.188331,0.231288,0.621648,0.287036,0.558592,-0.41383,-0.148615,0.754927,-0.613181,0.102001,0.109259,0.120755,0.0709728,0.715844,0.250952,-0.597944,0.101222,0.34509,-0.490823,-0.455052,0.328009,-0.697031,0.0657175,1.0719,-1.02182,-1.01123,0.0737954,0.229657,-0.824871,-0.228159,0.0408283,-0.113044,-0.129658,0.316399,0.640488,-0.540632,-0.0737432,0.270809,0.21366,-0.161692,-0.56282,0.236431,-0.359986,0.0804442,0.181512,-0.430891,-0.0630206,-0.0944446,0.344648,0.0238719,-0.460243,-0.153868,0.626443,0.0123604,-0.0927861,-0.183117,-0.251976,-0.423929,-0.294798,-0.392848,-0.164023,0.455387,0.505791,-0.504709,-0.626133,-0.49364,-0.242588,-0.455241,0.477678,-0.119069,0.124293,0.453468,0.00483865,-0.194393,0.242115,0.751361,0.169966,0.372493,-0.106947,0.241803,0.221889,0.655003,-1.01303,-0.317706,-0.132778,-0.452222,-0.448281,0.0295664,0.4328,-0.344433,0.0738448,-0.479804,-0.191626,0.175463,-0.224885,0.467369,-0.122548,0.213588,-0.0065713,-0.535733,0.575666,-0.753833,-1.08847,-0.503359,0.531692,0.335417,0.0193079,0.422725,0.658155,-0.425499,0.219181,-0.291417,0.253781,0.181292,0.399433,0.416163,0.258621,0.747092,0.1315,-0.375349,0.45542,0.00855016,-0.423425,-0.0663311,1.25934,-0.722773,-0.0336508,0.248564,0.399197,-0.320244,-0.608805,-0.36484,0.156137,-0.112335,-0.0512347,-0.0503691,0.455164,0.100803,-0.327138,-0.0168742,0.146664,0.56012,0.000284613,-0.363746,-0.313647,0.246931,0.595957,-0.579739,-0.242086,0.00136726,0.398357,-0.265713,0.435906,-0.10669,-0.662083,-0.763265,0.408856,0.224345,0.14003,-0.116784,-0.332108,0.528587,-0.470816,0.383874,0.315199,-1.06001,0.0357012,0.298781,-0.690947,1.2808,-0.643828,0.261213,-0.531788,-0.375434,-0.239837,0.644449,0.00654321,0.0876249,-0.459767,0.423024,0.5282,-0.670907,-0.443098,-0.847317,-0.354197,-0.0385951,-0.0217281,0.559373,-0.347862,-0.0170647,0.0139974,0.219424,-0.153748,0.338502,-0.0785368,-0.267367,-0.683622,0.59212,0.207688,0.455654,0.70071,-0.681492,-0.215061,0.323925,-0.268802,-0.374845,0.601778,0.200245,0.278958,0.27028,-0.431297,-0.684725,-0.14569,-0.0800345,-0.151048,-0.333313,-0.337507,-0.134679,-0.70808,-0.227244,0.241282,-0.0879178,0.411492,0.53718,-0.109166,-0.0595246,-0.443909,0.213619,0.448442,-0.195091,-0.158616,0.147905,-0.10914,0.532573,-0.168348,0.710093,-0.149682,0.0985361,0.25601,-0.168542,0.0259566,0.215596,-0.422877,-0.0755839,-0.246144,-0.212674,0.338698,0.425365,0.141224,0.324531,-0.004522,-0.0981933,0.229376,-0.0681008,0.367955,0.0452533,0.149317,-0.675753,-0.031207,-0.310806,0.328778,-0.00962828,-0.471418,0.179798,0.241925,0.424026,0.491859,-2.41703 +3381.15,0.833827,0.0848144,4,1.54488,0.887325,-1.16574,0.498772,0.978596,-0.0904111,-0.0955285,-0.198197,0.440346,0.415552,0.0116863,-0.127821,-0.0892122,0.168881,-0.190531,1.04341,-0.0632396,-0.00427174,0.233041,0.222993,-0.170006,-0.883428,-0.460157,0.194202,-0.318512,-0.360798,0.211373,0.346474,-0.298464,0.355376,0.290726,-0.795055,0.152848,0.527056,-0.504453,-0.434719,-0.0599206,0.40218,0.0112615,0.251858,0.783697,0.0699274,0.623543,-0.763537,0.279297,0.69538,-0.430929,0.153505,0.0957925,0.158667,0.194077,0.67768,0.244202,-0.361459,0.308381,0.358944,-0.295524,-0.562301,0.312612,-0.373809,-0.169968,1.26059,-1.03567,-1.67884,-0.0695266,0.493357,-0.826204,-0.257001,0.32322,-0.273926,0.00369933,0.59349,0.612883,-0.443089,0.134599,0.409682,0.727457,-0.403796,-0.368423,0.258291,-0.148877,0.0860987,-0.0738856,-0.420261,0.0771506,-0.402907,0.499759,0.747906,-0.549473,0.0817311,0.305208,0.311403,-0.288291,-0.255752,-0.119211,-0.680881,-0.0837087,-0.0850144,0.160327,0.471391,0.667081,-0.207286,-0.329681,-0.466907,-0.460253,-0.284169,0.452776,-0.0623688,0.372254,0.497737,0.229773,-0.186489,0.677864,0.605166,0.169929,0.0997116,-0.0534385,0.0381801,0.0912869,0.996442,-0.891897,-0.396443,-0.0771578,0.0120276,-0.591413,0.16788,0.342605,-0.112927,0.19292,-0.388408,-0.272147,0.214613,-0.273206,0.56059,0.105089,0.339274,0.484963,-0.498926,0.553751,-0.790577,-1.00994,-0.220799,0.415121,0.293419,0.0822477,0.567906,0.179446,-0.410738,0.195485,-0.471062,-0.0887854,0.229801,0.637041,-0.0762518,0.7332,0.527367,0.180354,-0.21088,0.649558,-0.106245,-0.480862,-0.037904,0.730947,-0.420098,-0.230497,-0.0421578,0.094058,-0.312989,-0.603742,-0.403044,0.35658,0.031116,0.146408,-0.283318,0.530052,0.0704463,-0.313394,-0.348126,0.213347,0.487411,-0.0541271,-0.420477,-0.0545653,-0.176982,0.635444,-0.678872,-0.416886,-0.0407346,0.618799,-0.0379307,0.553484,0.146297,-0.672108,-0.591683,0.591545,-0.0313752,0.411959,-0.477208,-0.587305,0.279067,-0.104762,-0.00210813,0.419545,-0.432908,-0.169732,0.309222,-1.11915,1.38716,-0.612081,0.322179,-0.120426,-0.0815526,-0.151194,0.252889,0.154938,0.240624,-0.281312,0.310665,0.38921,-0.533945,-0.594671,-0.401185,-0.0534722,-0.317861,-0.014619,0.406712,0.12071,-0.325172,-0.204317,0.0585567,-0.644944,0.265113,-0.150494,-0.441859,-0.706965,0.571195,0.217845,0.423679,0.59765,-0.538268,-0.259672,0.200368,-0.695771,-0.287123,0.52234,0.426991,0.553304,0.365824,-0.565243,-0.767555,-0.0532239,-0.331408,-0.345543,-0.570085,0.0889897,0.307133,-0.678024,-0.263726,-0.107231,0.175199,0.659411,0.821341,-0.22565,-0.03659,-0.542492,0.700717,0.432943,-0.372526,0.026833,0.26425,0.0354234,0.167754,-0.467499,0.574584,-0.0224593,0.0550607,0.402489,0.105093,-0.0516954,0.102609,-0.190132,0.292182,-0.0453456,-0.144588,0.293402,0.374443,-0.202915,0.221274,0.15575,-0.315675,0.120782,-0.15592,0.175679,0.0824128,0.109922,-1.02861,-0.208259,-0.369571,-0.0234078,-0.137005,-0.419917,0.162332,0.275435,0.402905,0.524819,-3.11052 +3407.93,0.98271,0.0848144,4,1.47481,0.949091,-0.788819,0.315651,0.900655,-0.0581171,0.277566,-0.13058,0.520033,0.422338,0.110195,-0.196082,-0.11325,0.0499,-0.4203,1.19645,0.214497,0.0102209,0.483866,0.22864,-0.111623,-0.548846,-0.61456,0.231443,-0.177026,-0.27017,0.310171,0.318973,-0.379907,0.435616,0.37634,-0.596069,0.422198,0.522737,-0.681044,-0.218068,-0.0079775,0.322414,0.210984,-0.0395117,0.639943,0.248307,0.34836,-0.494834,0.26782,0.630115,-0.610379,0.357469,0.200046,0.102604,0.0745743,0.888316,0.0980758,-0.230569,0.50603,-0.10524,-0.432528,-0.328697,0.570776,-0.374633,-0.0907838,0.953653,-0.900952,-1.30372,-0.170711,0.312549,-0.687763,0.110298,0.0678559,-0.459839,0.179022,0.506166,0.491267,-0.416496,-0.0484233,0.641176,0.53364,-0.424907,-0.391817,0.246023,0.0444412,0.036878,0.13794,-0.293116,0.258375,-0.364734,0.219603,0.273447,-0.289013,-0.00731156,0.418626,0.45141,-0.178584,-0.163256,-0.25072,-0.804516,0.157263,-0.0710498,0.444338,0.733948,0.455043,-0.0618016,-0.245734,-0.590778,-0.822178,-0.261019,0.649957,0.0131874,0.286109,0.809943,0.261466,-0.015108,0.762656,0.487598,0.153121,0.189677,-0.166649,-0.119569,0.182929,1.07007,-1.01265,-0.249721,-0.178543,-0.184932,-0.357185,0.552692,0.602934,-0.0390168,0.502649,-0.423188,-0.452384,-0.0357309,-0.108477,0.285141,0.0652345,-0.0855104,0.224618,-0.360034,0.554889,-0.996308,-0.920684,-0.140927,0.46279,0.337143,0.200369,0.439052,-0.107485,-0.497281,0.359062,-0.519532,-0.164192,0.265443,0.716889,-0.226595,0.59916,0.437918,0.291216,-0.0927519,0.623739,-0.0689833,-0.0319821,-0.0196963,0.785128,-0.28479,-0.0523465,-0.0261946,0.120213,-0.150324,-0.423988,-0.275082,0.436303,-0.024452,0.211744,-0.358493,0.224186,0.00543467,-0.164874,-0.398979,0.00699003,0.650178,0.16293,0.0661752,0.268497,-0.187117,0.0206699,-0.707186,-0.392252,-0.0222815,0.625055,-0.0701784,0.249186,0.0517979,-0.459705,-0.638017,0.664874,0.136584,0.308962,-0.391213,-0.522134,0.0399339,0.00202691,-0.449709,0.47105,-0.494245,-0.481933,-0.049793,-1.04495,1.30991,-0.634593,0.348781,0.112519,0.00497845,-0.320377,0.250194,-0.0824299,0.321235,0.0520799,0.286982,0.241295,-0.494218,-0.0980495,-0.586093,-0.435377,-0.239901,-0.283633,0.355884,0.390336,-0.322528,-0.324023,-0.02049,-0.718413,0.0939518,-0.0285405,-0.235758,-1.04715,0.350849,0.168365,0.47194,0.530491,-0.567608,-0.309474,0.370994,-0.500765,-0.0263243,0.512447,0.423458,0.610534,0.187238,-0.975774,-0.657766,0.246872,-0.197654,-0.0798273,-0.805501,-0.163792,0.364517,-0.863919,-0.344849,0.0502003,0.114861,0.500573,0.370845,-0.178099,-0.185243,-0.27063,0.375489,0.545424,-0.142671,-0.0278056,0.314728,0.0313406,0.303969,-0.705983,0.402797,0.150334,0.144092,0.419816,0.0142111,0.186504,-0.0802091,-0.269767,0.475231,0.166222,-0.104261,0.233238,0.325134,-0.0242638,0.0615883,0.498319,-0.305111,0.145605,-0.0250779,0.234953,-0.143506,0.0670822,-0.607494,-0.170979,-0.285303,-0.0722153,-0.570184,-0.340549,0.173501,0.217105,0.416535,0.465945,-3.06348 +3410,0.873367,0.0848144,4,1.58167,0.693571,-1.17227,0.562394,0.454179,-0.0958984,0.221444,0.124469,0.29123,0.474574,0.626129,-0.342078,-0.0353104,0.828777,-0.205182,0.879467,0.273084,0.0615128,0.232372,0.0136466,0.439837,-0.547037,-0.407485,0.829065,0.138965,-0.513498,0.236229,0.016757,-0.00385868,0.237725,0.565886,-0.302751,-0.109616,0.445499,-0.154639,-0.0496691,-0.47801,0.28113,0.360242,-0.726926,0.56524,0.287689,0.320824,-0.479602,-0.423179,-0.212515,-0.808996,0.284919,0.426014,-0.116452,-0.145361,0.721326,0.256645,0.163624,0.67053,-0.265125,-0.331272,-0.708919,0.328121,-0.392179,-0.080669,1.02608,-0.921181,-0.484315,0.311237,-0.0206509,0.0300951,-0.206373,-0.781104,-0.384354,0.0277832,0.566543,0.459958,0.355839,0.432356,0.0362555,0.215594,-0.434092,-0.0567529,-0.285024,0.79104,-0.339544,0.160873,-0.201716,0.439447,-0.432408,0.550307,0.239565,0.373916,0.17827,0.307864,-0.481647,0.0763327,0.105508,0.336417,-0.430936,0.0951626,-0.372574,-0.716224,0.739438,0.35097,-0.0143231,-0.293179,-0.383197,-0.0253665,0.449624,0.129226,-0.349952,0.255962,0.599514,-0.589389,-0.389422,-0.499197,0.27664,-0.498051,0.0332583,-0.131968,-0.121151,-0.111861,-0.333059,-0.794075,-0.0293725,-0.500439,-0.347313,-0.607496,0.191567,0.0228983,-0.0452967,-0.159158,-0.0681262,0.241357,-0.0458919,0.500621,0.505345,-0.293738,0.230945,-0.193661,-0.555034,0.155387,-0.165395,-0.606595,-0.172461,-0.338928,-0.328183,0.115317,0.880822,0.343988,0.564281,0.236527,0.384636,0.407717,-0.206893,-0.160987,-0.538743,-0.0990083,0.827213,-0.0792666,-0.346177,0.123983,0.420176,0.0652898,-0.193093,0.631166,0.0975054,0.447273,-0.55709,-0.39256,0.104901,-0.152693,-0.138755,-0.208857,-0.629269,-0.300262,-0.254455,0.279303,-0.941254,-0.0834425,-0.407163,0.194688,0.533671,-0.45254,-0.371691,0.355209,0.256443,0.0398866,-0.221087,-0.690502,-0.810322,0.251204,-0.596702,-0.180002,0.288327,0.224275,-0.429384,0.174322,-0.192335,-0.124332,-0.309416,-0.324486,-0.154794,-0.100473,-0.055399,0.522291,-0.103605,-0.345427,-0.16908,-0.415079,1.33931,0.0400483,0.197065,0.143307,-0.239788,-0.0893838,0.419238,-0.634593,1.0713,0.229103,0.351284,0.699947,-0.340186,-0.254464,-0.756543,0.0164739,-0.136182,-0.958709,0.362369,-0.523452,-0.245662,0.107882,-0.405089,-0.620089,0.0269859,0.051022,0.175046,-0.0591946,0.566052,0.00345503,0.376397,0.162907,0.302525,-0.080308,-0.199529,0.30104,0.439835,-0.016336,-0.451768,0.30514,0.344429,0.168166,-0.408415,-0.14716,-0.539352,0.449578,-0.572604,-0.266657,0.220602,-0.445782,0.171148,-0.0622529,-0.221891,-0.0799468,0.919527,0.0327519,0.627197,-0.393159,0.234262,0.0445936,0.211952,0.00656723,-0.135909,-0.161762,-0.0767175,-0.315295,0.747731,0.156278,0.184684,-0.21489,-0.541728,0.473145,-0.301326,0.376552,-1.20819,0.225666,-0.439649,-0.158006,-0.125823,-0.266358,0.0886769,-0.205521,-0.406304,-0.026674,0.312936,-0.336189,0.395755,-0.0277891,-0.720076,0.497647,0.457002,0.278425,-0.13451,0.17601,0.166465,0.252553,0.408001,0.502547,-1.04576 +3416.12,0.606874,0.0848144,4,1.52979,0.743894,-1.14858,0.299394,0.419338,-0.0558184,0.310197,-0.424354,0.498354,-0.178596,0.120593,0.0266358,-0.480554,0.0168154,-0.459527,0.585988,0.17879,0.133143,0.103265,0.220818,-0.0227561,-0.901996,-0.540391,0.451962,-0.320529,-0.227742,-0.271791,-0.0963478,-0.637576,-0.0729226,0.598836,-1.04038,-0.0204574,0.0253777,0.266593,-0.0876438,-0.312507,0.222882,0.22598,0.310002,0.93698,0.46794,-0.246265,-0.311779,-0.366783,0.112177,-0.368784,-0.10809,0.637871,0.194489,-0.0626439,-0.0770497,0.872969,-0.347002,0.736443,-0.00996292,-0.465103,-0.680656,0.575299,0.0992895,0.221941,0.594496,-0.460252,-0.624423,-0.210206,-0.12664,-0.196928,-0.333843,0.414604,-0.567657,-0.466616,0.28804,1.01233,0.325209,0.448948,0.493313,0.391613,-0.269094,-0.619879,-0.11159,0.246909,-0.251128,-0.0882479,-0.223723,-0.0455794,0.438659,-0.178946,0.0287338,-0.0938603,-0.210132,-0.398938,0.567287,0.135496,-0.0624368,-0.108143,-0.0630771,-0.0146665,-0.0926119,0.670605,0.126804,-0.163522,0.425925,-0.978839,0.61404,0.297309,-0.747668,0.144761,-0.308104,0.6031,0.883896,0.56191,-0.279143,-0.249798,0.636329,0.570035,0.805532,-0.756116,0.400374,0.393388,-0.393933,-0.672889,-0.134292,0.201107,-0.631206,-0.243895,0.0167403,0.113955,-0.0269627,0.433394,-0.368744,0.269152,0.153245,-0.0395343,0.507544,-0.118766,-0.293162,-0.210175,-0.122047,0.224988,-0.416705,-0.220646,-0.184172,0.493042,0.363184,-0.236653,-0.134042,-0.714386,0.183445,-0.0145225,-0.0492074,-0.065244,0.577155,-0.0490955,0.018225,0.676024,0.335193,0.404439,0.0878061,0.292737,-0.29739,0.934848,-0.270639,1.56002,0.228198,0.135751,0.581156,0.0393226,-0.502548,0.0237592,0.153042,-0.232956,-0.0171289,0.329728,-0.408494,0.464502,0.206959,-0.423474,0.00735332,0.432919,1.27318,0.347044,-0.327844,0.556844,-0.331235,0.268946,-0.32314,0.433105,-0.065373,0.282575,0.027097,0.446717,0.241423,-0.163669,-0.707444,-0.273643,0.0459187,-0.236002,-0.367051,-0.436064,-0.424804,-0.325899,-0.283055,0.323986,-0.4909,-0.0953443,0.0550438,-0.505734,1.02403,0.743888,0.420241,0.113843,-0.251643,0.388041,0.194495,0.645768,-0.145125,-0.57674,0.243008,0.281855,-0.0988187,-0.21669,-0.563975,0.613745,0.66659,-0.0369276,0.0621034,0.00639422,0.27175,0.00611503,-0.47262,0.404921,0.131587,-0.212868,0.147805,-0.371453,0.568398,-0.447157,-0.0759655,1.32828,-0.213411,-0.312482,-0.00547709,-1.0351,-0.0621184,0.197325,0.411145,0.0816371,0.142632,-0.210104,0.143906,-0.245012,-0.263387,-0.0823899,-0.289001,0.112342,0.038592,-0.444006,0.146625,0.238995,-0.0307841,-0.1534,0.139915,0.271014,0.553548,0.6879,0.262596,0.324327,-0.0124331,-0.298131,0.444608,-0.265671,-0.377532,0.120038,-0.151367,0.198529,-0.362968,0.455075,0.309036,0.343641,0.0237952,0.311865,0.00312032,-0.5852,0.589566,0.12791,0.190432,0.308094,0.187767,-0.49672,0.207697,0.157209,-0.161722,0.403961,0.620927,0.219504,-0.478727,-0.097788,-0.288452,0.176865,-0.913853,-0.181604,0.170137,0.171742,0.412476,0.414418,-0.843983 +3404.43,0.813624,0.0848144,4,1.57585,0.801195,-1.04328,0.430853,0.749248,0.0727747,0.294113,0.0417069,0.405775,-0.436959,-0.231594,-0.188996,-0.288075,0.0283335,-0.198115,0.700578,0.395296,0.166901,-0.225613,-0.0861209,0.0928359,-0.670195,-0.866784,0.360432,-0.371794,-0.438006,-0.100892,0.299492,-0.502245,0.109762,0.785392,-0.265304,-0.321986,0.257054,-0.128689,-0.113027,-0.788405,0.596903,0.421361,-0.507811,0.900102,0.609837,0.0855568,0.0147368,-0.748408,-0.648755,-0.812007,0.263418,0.659246,0.105585,-0.0653093,0.0797011,0.699173,-0.574067,0.638686,-0.0772997,-0.191206,-0.893971,0.246639,-0.482943,0.434957,0.733107,-0.829205,-0.722793,0.398409,0.222768,0.264507,0.143488,0.0242192,0.0992642,-0.219428,1.20397,0.921779,-0.0496913,0.337909,0.315283,-0.201834,0.0906085,-0.473014,0.133238,0.45307,-0.817908,-0.0835745,-0.42829,0.377691,-0.492465,0.522422,0.209763,0.143741,-0.585014,-0.82381,0.0384611,0.225679,0.0215141,0.317098,0.0139896,-0.0283021,-0.411352,0.549109,-0.223541,0.212052,0.124328,-0.420022,0.412502,-0.01106,-0.261942,0.162071,-0.57652,0.393909,0.342651,-0.21543,-0.538466,-0.333884,0.5364,-0.400139,0.125817,-0.116251,0.418213,0.66294,-0.546751,-0.313419,0.371041,-0.0810614,-0.0782639,-0.41361,0.402006,-0.0546669,0.379158,0.549241,-0.571828,0.608229,0.244762,-0.191901,0.562873,-0.486508,0.0188025,-0.341271,0.201848,0.221259,-0.611489,0.0391524,0.0996147,0.042504,-0.274291,0.106853,0.392337,-0.141955,0.0622761,-0.0465288,-0.104493,-0.4023,-0.125523,-0.216267,-0.0252107,0.621444,0.437105,-0.024162,0.418208,0.00427965,0.19109,0.867208,-0.3616,1.54852,0.0177886,0.618172,-0.117492,-0.315549,-0.39384,0.287675,0.192674,-0.650851,-0.059589,-0.0133657,-0.280716,0.293261,-0.372197,-0.27139,-0.725997,0.281133,0.955833,0.323233,-0.168846,0.488135,-1.14679,0.54782,-0.541541,0.200912,-0.0111378,0.366528,-0.542317,0.223254,0.495274,0.284913,-0.632744,0.0240749,0.308978,-0.0100546,-0.342362,-0.605671,0.147044,0.185753,-0.221432,0.00779638,-0.619671,-0.0983347,-0.29144,0.00828564,1.05782,0.0750146,0.206644,0.136205,-0.138176,0.587144,0.319552,-0.272872,0.0338644,-0.286063,0.365995,0.505925,-0.21643,-0.703041,-0.594828,0.862592,1.0395,-0.395472,0.113177,-0.110597,0.173323,-0.246682,-0.236114,-0.29088,0.381251,-0.28147,0.177456,0.0158247,0.740425,-0.251706,0.144765,0.417291,-0.424064,-0.712612,-0.191334,-0.251224,0.367186,0.304409,-0.0472421,0.555794,-0.0613219,-0.00920637,-0.266095,-0.544517,-0.312601,0.0951305,-0.356697,-0.450424,0.153771,-0.535319,0.260582,0.142832,-0.272808,0.450351,-0.193928,0.486942,-0.0901714,0.310784,0.18707,-0.297485,0.334394,0.268735,0.104927,0.014246,-0.642989,-0.885875,0.380585,0.0305818,-0.268332,0.432072,-0.123246,0.272707,-0.337003,0.519231,-1.2545,0.314768,0.066515,0.0305111,-0.0687353,-0.212204,0.350987,-0.605666,0.678872,-0.0803185,0.135523,0.143171,0.275569,-0.108037,-0.344962,-0.384524,0.489312,-0.0449294,0.127576,0.0586942,0.162079,0.258911,0.40259,0.508833,-2.20661 +3396.17,0.990453,0.0848144,5,1.63255,0.823842,-1.52764,0.588665,0.86038,0.0274241,-0.024354,-0.400781,0.301955,0.735542,0.169118,0.189647,-0.454151,-0.173396,-0.517399,0.624933,0.0101326,-0.102892,0.186843,-0.376583,-0.341358,-0.781691,-0.471045,0.242913,-0.380367,0.0970177,0.163912,-0.0345287,-0.187748,-0.205789,0.627185,-0.793868,0.339663,0.105885,-0.405878,-0.0432278,-0.315611,0.451632,0.478741,-0.233555,0.642636,0.0142263,0.886525,-0.818323,-0.656771,0.926772,-0.938887,-0.138463,0.544817,-0.0970449,-0.0832833,0.413739,0.239983,-0.360506,0.207083,-0.251599,-0.170196,-0.277901,0.287753,-0.590548,-0.00794524,0.595075,-0.491824,-1.33377,-0.527314,0.0312901,-0.235457,-0.0746338,-0.260865,-0.713267,-0.480918,-0.143372,0.588335,0.29646,0.825776,0.34749,0.449092,-0.128375,0.112309,0.166618,0.393853,-0.524091,0.327465,0.313542,-0.0787268,-0.00425703,-0.258493,-0.600836,0.609692,-0.26422,-0.124264,0.0199183,0.00402882,0.00345126,-0.34083,-1.03638,-0.300912,-0.855912,-0.222748,0.838243,-0.28218,-0.169131,-0.542302,-0.0789434,0.177673,-0.712853,0.140343,-0.693803,0.127652,1.08323,0.26333,-0.266342,0.753851,0.545547,0.150611,0.0684161,-0.778251,0.141211,0.150722,0.0913089,-0.817198,-0.163958,0.253307,-0.705335,0.142016,0.187014,0.149114,-0.0381687,0.175437,-0.593282,-0.305165,0.13635,-0.112099,0.521978,-0.19648,-0.723442,-0.745311,-0.0108039,0.74952,-0.370791,-0.63262,-0.290285,0.440048,-0.274829,-0.373861,0.498795,0.138729,0.794748,-0.349153,-0.2467,-0.264501,0.624576,0.407921,0.264643,0.714229,0.328645,0.77866,0.0982506,0.319988,-0.0909474,-1.32614,0.133397,1.47468,-0.564968,-0.718169,0.285364,-0.355777,-0.0492934,-0.176227,0.0486229,0.37204,0.343717,0.0312355,-0.29162,-0.365184,-0.329314,-0.0168617,0.111087,0.315305,0.923876,-0.405763,0.23405,0.0144228,-0.06261,-0.95677,-0.520406,-0.992692,-0.39515,-0.419535,0.0933597,0.212121,0.00398979,0.234822,-0.69168,-0.245861,-0.170262,0.38245,-0.169706,-0.59384,0.0907983,-0.424363,-0.49056,0.330136,0.130378,0.333528,0.147073,-0.615304,0.78603,0.0536117,0.0812139,-0.123987,-0.0620722,-0.458877,0.23737,-0.455407,0.440484,-0.0345513,0.105901,0.597364,-0.639327,0.193759,-0.229577,-0.174553,0.431142,-1.15513,0.0799177,-0.21903,-0.509399,0.46715,-0.420567,-0.340826,-0.0342015,0.0827108,-0.150576,-0.874474,0.58746,0.400085,-0.339847,1.1758,-0.417471,0.0453881,0.501596,0.073057,0.155676,0.0640539,-0.365934,0.501347,-0.359127,-0.220667,-0.129029,0.685028,-0.719746,0.35276,-0.34808,-0.39591,0.303164,-0.304078,-0.153884,-0.37686,0.114,-0.0130844,0.45966,-0.100314,0.492944,-0.269343,0.199301,0.0211723,-0.457498,-0.278941,0.0342161,-0.809634,-0.514373,0.458859,0.108754,0.041716,-0.135711,-0.245364,0.359081,-0.132324,-0.494292,-0.152315,-0.392353,-0.277646,-0.0335198,-0.626266,0.0733473,0.250777,-0.0217354,-0.133059,-0.473656,0.0917647,0.106025,-0.0838558,-0.210258,0.00263571,-0.464128,-0.396042,-0.111346,0.157059,-0.949513,-0.161266,0.181485,0.187241,0.426011,0.432714,-2.44272 +3420.41,0.868067,0.0848144,5,1.54227,0.763762,-1.48054,0.550194,1.26388,-0.00971872,0.703019,-0.210256,-0.0636879,-0.932133,0.314866,-0.398014,-0.511754,0.14981,-0.182535,0.789409,-0.209888,-0.0243017,0.358859,-0.0522949,-0.230362,-0.68555,-0.987624,-0.172086,-0.789758,0.0765439,0.110692,0.448931,-0.476051,0.194472,0.615407,-0.68322,-0.466125,0.0363638,0.170901,-0.155123,-0.0649356,1.08638,0.523701,-0.665712,0.742536,0.133614,0.222576,-0.485746,0.281666,-0.547651,-0.516202,-0.082528,0.161551,0.0472164,0.268984,0.416929,0.257864,-0.523229,0.993619,0.051766,-0.492611,-1.39776,0.435351,-0.61233,0.370122,1.11855,-0.16315,-0.907406,-0.0996284,-0.300888,0.15942,0.105219,0.392878,-0.168702,-0.0932092,0.626992,0.644286,-0.205299,0.504048,0.4485,-0.0251114,-0.133832,-0.585815,0.161984,0.806766,-0.377277,0.499047,-0.00100013,0.014169,-0.315613,0.204695,0.0794865,-0.0154942,-0.5454,-0.114182,-0.0126767,0.558032,-0.200066,0.163575,0.0941828,-0.237563,0.401712,0.552907,0.105233,0.506515,0.420677,-0.16542,-0.100416,-0.0253284,0.339011,0.16957,-0.0141323,0.393565,0.29556,0.0151771,-0.288903,-0.311426,0.101784,-0.101936,0.399328,-0.0307121,0.162588,0.633945,-0.364874,-0.760827,0.271902,-0.617302,0.159245,-0.58817,0.466008,0.59221,0.224753,0.324513,-0.610483,0.353558,-0.0859166,0.131333,0.645614,-0.343997,0.118463,-0.0406675,-0.231244,0.192158,-0.64305,0.306747,0.447027,0.252252,-0.713513,0.208369,-0.0320318,-0.486192,0.438315,0.217045,-0.169569,-0.136009,0.0166381,-0.105979,-0.568048,-0.212986,-0.046638,-0.280271,0.131828,-0.0034433,0.112837,1.30718,-0.146471,0.598479,0.349601,0.504957,-0.19937,0.0149964,-0.325088,-0.0795026,-0.603038,-0.192854,0.0849305,-0.269062,0.223628,0.516806,-0.00618075,-0.118645,-0.0579431,0.0219336,0.620209,0.351953,-0.460269,0.402438,-0.399687,0.843579,-0.202793,0.381616,-0.209637,0.308313,-0.99538,-0.149497,0.212452,-0.145048,-0.450457,0.0600537,0.299708,-0.0879122,-0.137658,-0.528282,0.513694,0.172454,0.217985,0.0819515,-0.541591,-0.273725,-0.263949,-0.0864507,1.13257,-0.114338,0.196184,0.558842,-0.317932,0.457957,-0.100833,-0.529683,0.245235,-0.356677,0.462304,0.133465,-0.391373,-0.150652,-0.395213,-0.326672,0.337628,-0.0419545,0.45273,-0.586628,0.188999,-0.0580089,0.244694,-0.0894975,-0.314203,-0.28031,0.0741582,-0.0123593,0.630709,-0.16099,0.286605,0.181457,-0.723712,-0.388807,-0.0873874,-0.49187,0.144853,0.953804,0.609892,0.169913,0.25763,-0.230194,-0.536126,-0.536341,-0.573679,0.493734,-0.509155,-0.29526,0.256426,0.0281655,0.222633,0.346395,0.367368,0.533876,0.359499,0.0370149,-0.083436,0.619134,0.40168,0.122309,0.106048,0.0101661,0.322637,0.343153,-0.206065,-1.11952,-0.406037,-0.00569287,0.153195,0.477677,-0.175191,0.319792,0.491401,0.322443,-0.155614,-0.323207,-0.0627575,0.434752,0.198883,-0.30607,0.691296,0.0625831,0.139123,-0.420897,-0.17783,0.492479,0.406164,0.167719,-0.225041,0.0609578,-0.04652,-0.32366,0.452103,-0.130112,0.153843,0.235156,0.392229,0.484929,-3.7453 +3427.01,0.905592,0.0848144,4,1.57834,0.839291,-1.10272,0.464978,1.12004,-0.13812,0.301571,-0.427192,0.357135,-0.142571,0.344144,-0.156282,-0.0715228,0.187245,-0.381883,0.572689,-0.130596,0.0413589,0.0333596,0.0432464,-0.147911,-0.721971,-0.319103,-0.0331619,-0.385464,-0.132057,0.284033,-0.132254,-0.528453,-0.0920057,0.836356,-0.915753,0.408391,0.120471,-0.208999,-0.0430986,0.0440863,0.828689,0.597292,-0.426298,0.748976,0.0808229,0.298739,-0.337924,0.129407,-0.391549,-0.768378,0.0171363,0.127026,-0.160169,-0.128733,0.630216,0.171689,-0.40831,0.983958,-0.465797,-0.130551,-1.10818,0.287772,-0.461214,0.185425,0.906205,0.126042,-1.37675,-0.045077,-0.0389378,0.00724902,-0.235445,0.150963,-0.452047,0.409231,0.278028,0.394485,-0.238731,0.492669,0.873609,0.194141,0.108529,-0.835507,0.379405,0.236962,-0.898854,0.46833,0.19549,0.345798,-0.0350591,-0.125972,0.0687505,0.0761466,-0.0163189,-0.312891,-0.154471,-0.0014228,-0.249865,-0.155001,-0.826819,-0.254742,-0.141213,0.647088,0.754745,0.356451,0.0583075,-0.579228,-0.334341,-0.114914,-0.60697,0.329858,-0.121063,0.812424,-0.0318816,-0.174026,-0.626331,-0.423603,-0.154811,-0.50832,0.17744,-0.435543,0.335206,0.20851,0.0803086,-0.901323,-0.0907222,0.317761,-0.0154491,-0.516096,0.459805,0.485288,0.358706,-0.248649,0.0666155,0.264327,-0.136107,-0.0415549,0.50619,-0.218042,-0.249763,0.0287234,-0.396147,0.248703,-0.552914,-0.559537,0.296108,0.292058,-0.408927,0.223594,0.00510958,0.152135,0.631866,-0.375486,-0.0663094,-0.438561,0.808351,0.231179,-0.550512,0.414664,0.473512,0.0673108,0.386614,0.0942022,0.22437,0.243881,0.00107922,0.593437,-0.20315,-0.0411997,0.162853,0.0332658,0.380735,0.164187,-0.523435,-0.0920345,0.301701,-0.381634,0.119513,0.136209,0.0217677,-0.146874,-0.0881006,-0.0468846,0.778834,0.116883,0.921975,0.634441,-0.481452,-0.202618,-0.382198,0.130456,-0.489741,0.569809,-0.623742,0.449824,0.289919,0.100552,-0.893698,0.557291,-0.28634,-0.236531,0.087245,-0.322433,0.055831,0.406609,-0.0145521,0.0525461,-0.0166132,0.937923,0.0523294,-0.318987,0.750265,-0.104831,0.344075,0.493257,-0.278812,-0.189789,0.15324,-0.257183,0.637972,-0.211804,0.262346,0.70427,-0.218619,-0.194196,-0.451768,-0.406782,0.152946,-0.4486,0.388356,-0.189676,-0.191177,0.490621,-0.073905,0.221421,-0.323768,-0.0713566,-0.128601,-0.265953,0.417752,0.199306,-0.0769152,0.83186,-0.889739,-0.00127042,0.0835132,-0.406747,0.163969,0.234836,0.204206,0.190665,-0.0436523,0.0468607,-0.474385,-0.052322,-0.32329,0.785655,-0.434856,-0.346575,0.12955,-0.258981,-0.0165714,-0.0808824,0.457786,0.25128,0.595396,-0.497951,0.328647,0.296124,-0.266191,0.0322027,-0.251071,0.458209,0.0194447,-0.199534,-0.289986,-0.501212,-0.627297,-0.228122,0.519169,0.111657,0.0019188,-0.156565,-0.144229,-0.985544,0.367842,0.256195,0.238012,0.0782433,0.452655,-0.50796,0.473742,-0.274711,0.454129,-0.452098,0.0609983,0.235067,0.176193,0.174744,-0.348694,0.598589,0.183003,0.232495,0.00301831,-0.164487,0.133803,0.267643,0.365791,0.517343,-3.45083 +3403.61,0.920978,0.0848144,4,1.56925,0.869966,-1.21773,0.483485,0.700619,-0.088056,-0.225756,-0.218673,0.205274,-0.242791,0.269453,-0.225235,-0.188118,0.259664,-0.341477,0.719616,-0.0757535,0.246094,0.202059,0.154531,-0.308146,-0.241356,-0.497812,-0.152301,-0.704685,0.0261438,0.191834,0.201104,-0.658464,-0.263101,0.932192,-0.0935966,0.162866,0.124179,-0.22716,0.169009,-0.344559,0.756823,0.338422,-0.166528,0.634058,0.426584,0.63462,-0.397413,-0.0374847,-0.503963,-0.214563,0.697282,0.41305,-0.133708,0.0268404,0.260221,0.168222,-0.92132,0.828122,-0.679376,-0.174775,-1.23582,0.286053,-0.357737,0.00998104,0.789155,-0.127948,-2.21711,0.0191279,0.724915,-0.290233,-0.131377,0.34171,-0.434522,0.183708,0.376456,0.697694,-0.224213,0.698593,0.471591,0.247228,-0.242762,-0.285965,0.222913,0.225668,-0.551038,0.00815018,0.279068,-0.11908,-0.170909,-0.123708,0.194458,0.0238794,-0.449409,0.0219714,-0.483469,0.380653,-0.241409,-0.181012,-0.348917,-0.36628,0.247945,0.621307,0.368297,0.184695,-0.0476813,-0.202581,-0.412883,0.223304,-0.187489,0.5284,-0.239497,0.367714,0.168161,0.509437,-0.942253,-0.0569995,0.0118517,0.354478,0.238949,-0.0247008,0.0283741,0.0167547,-0.242457,-0.820869,-0.337657,-0.13145,-0.0175672,-0.26668,0.410536,0.0905961,0.542673,0.127387,-0.102611,0.0700806,0.037552,-0.177118,0.847048,-0.193628,-0.055585,0.0291185,-0.441387,0.424238,-1.02239,-0.0510503,0.234237,0.288021,0.165294,0.140633,0.23497,0.335982,0.258245,0.0395846,0.114786,-0.790769,0.446925,0.142839,-0.193066,0.365274,0.490556,0.232242,0.571444,0.0185008,0.21645,0.617366,-0.184961,0.0827818,-0.23874,-0.2846,-0.190763,-0.372962,0.402713,0.599797,-0.850436,0.481973,0.241641,-0.642792,-0.0854952,-0.516046,0.272594,-0.175091,-0.430065,0.234967,0.868484,-0.288068,0.819007,0.499627,-0.312596,-0.378763,-0.453759,0.446141,-0.234895,-0.203208,-0.17595,-0.0196031,0.302427,0.195745,-0.473672,0.0720903,-0.40134,-0.394306,0.150636,-0.593378,-0.135204,0.0872651,0.289979,0.0111893,-0.120865,0.609663,-0.00201172,-0.147781,0.738845,-0.387738,0.359693,0.112616,-0.287476,-0.287204,-0.516571,-0.56338,0.0215514,-0.36587,0.292923,0.379206,-0.132148,0.000844271,-0.38783,0.462051,-0.187696,-0.649105,-0.035311,-0.14551,-0.257661,-0.103018,-0.192641,0.431155,-0.340324,0.43403,0.179581,0.188728,0.835549,0.180478,-0.215338,0.803704,0.0626863,0.032561,-0.0143322,0.0851398,0.354507,-0.0174309,-0.206093,0.249711,-0.218052,0.363659,-0.466699,0.283826,-0.256487,0.437704,-0.14232,-0.461151,0.0351482,-0.472578,0.534179,-0.00569691,0.73018,0.468508,0.205361,-0.630075,0.267388,0.0882089,0.0478013,-0.152585,-0.769199,0.235044,0.40742,-0.0334706,-0.187952,0.0342221,-0.184466,-0.388883,0.187656,-0.0141449,0.1591,-0.280638,0.048585,-0.420057,0.378627,0.280991,0.185158,0.251324,-0.30627,-0.168911,0.255697,-0.366127,0.472955,-0.291359,0.0760865,-0.222901,0.519585,0.18628,-0.204436,0.212274,-0.265527,0.452879,0.0925191,-0.065415,0.146298,0.241097,0.382489,0.491017,-2.0914 +3407.04,0.985704,0.0848144,4,1.54532,0.839626,-1.03031,0.415841,1.01522,-0.0807963,-0.16538,-0.302651,0.385151,0.204095,0.29089,-0.169051,-0.193835,0.317605,-0.25111,0.908118,0.135857,-0.0872848,0.0713,0.255161,-0.160453,-0.537246,-0.541289,0.0702781,-0.662678,0.0185019,-0.0345289,0.294713,-0.929551,-0.237666,0.919749,-0.353087,0.0839543,0.26128,-0.299443,-0.0885014,-0.130379,0.977977,0.467325,-0.24504,0.781697,0.349037,0.97884,-0.652157,-0.137291,-0.71649,-0.187884,0.320119,0.531942,-0.143514,-0.0794513,0.417383,0.411307,-0.9228,1.08882,-0.582381,-0.339513,-1.26615,0.406972,-0.760288,-0.111511,0.69338,-0.20829,-1.8755,-0.0342088,0.5957,-0.326623,-0.157288,0.284227,-0.440775,0.589865,0.342424,0.576625,-0.287953,0.811537,0.343194,0.087959,-0.337158,-0.213788,-0.00161652,0.00127669,-0.508228,0.138524,0.391438,0.0954471,-0.234813,0.01882,0.384432,0.110721,-0.372336,0.296316,-0.135657,0.299748,0.0241341,-0.250979,-0.25326,0.162945,0.166724,0.25549,0.335598,0.108329,-0.101795,-0.317339,-0.366483,0.327371,-0.246466,0.0360825,-0.281821,0.303201,0.380214,0.513442,-0.823434,-0.268887,0.138101,0.323233,0.372967,-0.475478,0.363067,-0.196797,-0.390926,-0.750552,0.0392655,-0.117764,0.182137,-0.0139286,0.043416,-0.0252956,0.10089,0.179468,-0.187633,0.139575,-0.236859,-0.103596,0.816195,-0.284337,0.171941,0.0751739,-0.613724,0.763336,-0.687628,0.0885909,0.348177,0.168445,0.0932656,0.404068,-0.103303,-0.211527,0.469684,-0.233755,0.0631323,-0.613601,0.322419,0.086584,-0.363471,0.15097,0.695731,-0.0231468,0.287419,-0.0535678,0.436306,0.433576,0.158948,0.0995885,0.0992884,-0.254257,0.248827,-0.550935,0.260557,0.445023,-0.923344,0.309624,0.135545,-0.461076,-0.00577874,-0.0774328,0.375655,-0.0803352,-0.995831,0.35002,0.886331,-0.192095,0.404801,0.637005,0.0682784,-0.572619,-0.218674,0.446071,-0.314767,-0.0341491,-0.371642,-0.0875951,0.159558,0.101669,-0.258559,-0.0145276,-0.213225,-0.205352,0.226961,-0.504506,-0.298953,0.0889737,0.505231,-0.109585,-0.426984,0.324557,0.00680681,-0.205333,0.862041,-0.271893,-0.0348284,0.301323,-0.8412,-0.0815175,-0.0309362,-0.719229,0.085701,-0.431693,0.220392,0.569545,-0.569199,0.0805774,-0.655977,0.238401,-0.320701,-0.770939,0.0647418,-0.314045,-0.0137229,-0.153898,-0.227553,0.430937,-0.279418,0.408991,0.27575,0.36884,0.712602,0.206286,-0.246117,0.789654,0.154612,-0.0469273,-0.143399,-0.113878,0.503464,0.423804,0.0359762,0.34994,-0.199051,0.426749,-0.547913,-0.0682581,-0.276454,0.361634,-0.187971,-0.393335,-0.0111152,-0.399126,0.16053,-0.0980247,0.653069,0.616084,-0.080725,-0.376246,0.0504529,0.191583,0.0965731,-0.311602,-0.676725,0.52889,0.363482,0.413896,-0.295342,0.008691,-0.074162,-0.534971,0.264424,0.283435,0.217722,-0.0313261,0.0463331,-0.324263,0.0773927,0.438879,-0.281356,0.137496,-0.182514,-0.00775052,0.319334,-0.198664,0.552829,-0.464828,-0.0333155,-0.299783,0.488021,0.0702486,-0.180799,0.360062,-0.0635027,0.175547,-0.24933,-0.0582842,0.14302,0.260433,0.37818,0.510326,-3.14224 +3410.1,0.858899,0.0848144,5,1.62908,1.02907,-0.608625,0.229233,0.565297,-0.0870406,0.386427,0.805393,0.510683,0.416643,-0.0410506,-0.217276,-0.0692236,0.546613,0.015411,1.16174,0.199762,-0.126464,-0.251276,-0.423883,-0.180427,-1.13066,-0.923906,0.178484,0.323909,-0.149171,-0.0877307,0.713146,-0.068247,0.0972375,0.891113,-0.155862,0.199875,0.583359,-0.596587,-0.650196,-0.028578,-0.102349,0.266679,-0.432026,0.80951,0.356177,-0.274587,-0.852371,-0.471849,0.365379,-1.02696,-0.0950663,-0.0315531,-0.502376,-0.00488694,0.373183,0.263865,0.166542,0.447598,0.240454,0.0861781,-0.472608,0.502337,-0.767648,0.371279,0.799445,-1.1894,-0.0560107,0.160717,-0.29366,0.148561,0.202552,-0.199698,-0.186633,-0.810438,0.0672197,0.212843,0.034679,0.609538,0.457744,0.277458,0.159052,0.0471236,0.224192,0.970152,0.068985,0.201358,-0.381997,-0.338899,0.113654,-0.0898441,-0.592791,-0.0778966,-0.670968,-0.231207,0.145244,-0.234034,0.18324,0.397988,-0.220869,0.00373779,-0.874066,0.159206,0.182571,0.0861103,0.199257,-0.261096,-0.597251,-0.261261,-0.210872,0.273758,-0.16759,0.464953,0.763753,-0.548541,0.277828,0.396187,0.513966,-0.163589,-0.491604,0.165362,0.0294367,0.262255,0.35804,-0.26083,0.146051,-0.111308,-0.581538,-0.0968626,0.191601,0.345278,0.0297123,0.246932,-0.468808,0.131248,-0.311856,0.0072947,0.427485,-0.106836,-0.314774,-0.278256,0.435014,0.0748165,-0.136353,-0.572913,-0.01452,0.187957,-0.884993,-0.32883,0.178452,0.0481861,-0.141861,-0.385049,-0.111423,0.127139,0.00833156,0.176966,0.238226,0.218875,0.208734,0.0992626,-0.0920957,0.114446,-0.411421,-0.0513749,-0.23085,0.886067,-0.0235993,0.133846,-0.180545,0.532761,-0.394898,-0.592946,0.867645,-0.334897,-0.182399,0.0635742,-0.03421,-0.194498,-0.239046,-0.135425,0.551604,0.085003,0.728243,0.532655,-0.532041,-0.52025,-0.109493,0.323529,-0.233114,-0.852998,-0.138118,0.152815,-0.140928,-0.5387,-0.279464,0.15821,-0.824698,0.155872,0.28628,0.286376,-0.574392,-0.180449,0.365433,-0.398384,-0.68369,0.36676,0.209836,-0.447141,-0.187075,-0.778091,0.778415,0.333421,0.0405092,-0.0567877,0.724708,0.297774,0.159726,0.551903,0.0471133,0.144458,0.18023,-0.0748429,0.211107,-0.507281,-0.315799,-0.177365,0.715587,0.213517,0.696311,-0.0226133,-0.457991,0.328972,-0.116656,-0.751327,0.109738,-0.578463,-0.481375,-0.634625,0.340584,-0.256743,0.447289,0.20051,-0.421899,-0.0481837,0.112369,0.0634685,-0.523084,0.00450494,0.0847516,0.448413,0.533993,-0.638959,-0.460329,-0.205264,-0.432919,0.230877,-0.210234,-0.0339105,0.47815,-0.131046,0.0570344,0.149695,-0.315643,-0.138556,0.432543,0.518997,0.194422,0.155845,-0.126256,-0.0355733,0.637873,-0.835247,-0.24244,-0.636622,-0.205587,-0.294016,0.256281,0.462371,-0.038364,0.0665902,-0.16152,0.557975,0.0248991,-0.217536,-0.400524,-0.978502,0.0166904,0.143819,0.740173,-0.0708769,0.203489,0.0856837,-0.693296,-0.0356398,0.238244,0.306037,0.0716716,0.0607426,-0.446259,-0.286545,0.16385,-0.236331,0.133879,-0.0434035,0.137859,0.216308,0.371293,0.46509,-1.94277 +3417.36,0.998512,0.0848144,4,1.56108,1.05132,-0.348807,0.13573,-0.0651498,-0.0596483,0.114938,0.504935,0.288896,0.292528,-0.431132,0.0142494,0.440874,1.00237,0.100125,1.02391,0.418331,0.0127743,-0.440802,-0.463201,-0.234423,-1.26411,-0.683695,0.241185,0.0521989,-0.446322,-0.616272,0.866795,-0.23885,0.362499,1.0285,-0.0691161,0.073565,0.206256,-0.623764,-0.461894,-0.137156,-0.192246,0.273171,-0.434246,1.04665,0.5858,-0.161055,-0.675187,-0.337094,0.0155011,-0.669563,-0.266192,0.216053,-0.0624575,-0.143688,-0.235076,-0.142007,-0.0372541,0.354315,0.0316648,-0.204816,-0.634138,0.327245,-0.518414,-0.149002,0.561603,-0.671503,-0.959979,0.381107,-0.40206,-0.15391,-0.206371,-0.0576321,-0.275757,0.0207773,0.182676,0.227092,-0.37324,0.405379,0.0848736,0.392876,0.00738431,0.39887,0.086094,0.973914,0.00114837,0.110841,-0.350058,-0.420565,0.00759915,0.202548,-0.490969,0.226017,-0.327316,0.46325,-0.433709,-0.277807,-0.071077,0.396312,0.271494,0.442431,-0.213388,0.301217,0.389979,0.4089,0.523194,-0.232976,-0.175275,-0.0286703,-0.217433,-0.044841,-0.313701,0.0125373,0.961774,-0.730703,-0.0373012,0.523575,0.432756,-0.359654,0.100396,-0.157608,-0.481429,0.160722,0.649739,-0.676172,0.820411,-0.0225325,-0.300002,-0.104706,0.0347336,0.156217,-0.202852,0.213833,-0.23791,0.604659,-0.26517,0.351836,0.0171942,-0.161774,-0.0848205,0.0437131,-0.00882403,0.0624514,-0.265544,-0.239611,-0.170477,-0.441678,-0.332348,-0.228137,0.0106215,-0.0284479,0.084131,-0.404247,-0.117859,0.0094969,0.0369048,0.207931,0.394588,0.100147,-0.248259,0.362356,-0.200964,-0.086308,0.0393292,0.256172,0.0832595,0.824983,-0.212483,-0.599581,-0.466067,-0.0583037,-0.169601,-0.201071,0.862955,-0.175156,-0.123381,0.0639293,-0.0580192,0.0182623,-0.138799,-0.244486,0.0206505,0.113344,1.10499,0.929647,0.0185636,-0.316301,-0.460275,-0.0935478,-0.527492,-0.533593,-0.297697,-0.142967,-0.207497,-0.412537,-0.19722,-0.0575208,-0.573975,0.394447,0.137412,0.644968,-0.559356,-0.781735,0.421951,-0.316194,-0.419041,0.459112,-0.0552353,-0.14628,0.0917159,-0.183106,0.549037,-0.154871,0.0119951,-0.341675,0.0761922,-0.0675347,0.843334,0.34352,0.647597,0.235503,-0.00869807,-0.260678,0.492929,-0.273475,-0.306311,0.0403463,0.173383,0.00348647,0.671415,-0.319365,-0.334726,0.42092,-0.00553225,-0.164915,0.00659093,-0.123521,-0.219601,-0.340163,0.0297111,0.150058,0.306671,0.397703,0.0154304,0.0499754,0.4501,0.219396,-0.140486,0.0208395,0.273954,0.73357,0.309655,-0.253848,-0.562671,-0.0896868,-0.347153,0.079856,-0.43442,-0.540188,0.526364,-0.330577,0.132701,-0.0775608,-0.221712,0.0238888,0.455677,0.626118,-0.130448,0.227095,-0.0289112,-0.0938716,0.662921,-0.380067,0.0572963,-0.0463346,0.153265,-0.537473,0.255126,0.43936,0.194205,-0.107159,-0.421279,0.206846,0.371708,-0.333555,-0.342925,-0.678681,-0.0767637,0.205595,0.133358,-0.186338,0.437483,-0.183646,-0.515936,0.232534,-0.222397,-0.305306,-0.0243345,-0.477819,-0.272074,0.0768748,-0.0344892,-0.723276,0.0864266,-0.0691362,0.133112,0.245808,0.364845,0.49579,-0.0118584 +3387.08,0.898204,0.0848144,4,1.65873,0.918657,-1.16856,0.518608,0.0741615,-0.0909318,-0.0560877,0.632371,0.557233,0.869824,-0.140966,-0.348972,-0.197748,0.655548,0.408464,0.854332,0.298356,-0.262297,0.218272,-0.0273653,-0.238231,-0.924385,-0.977797,0.110013,-0.0730261,-0.178569,-0.508884,0.114781,-0.345622,-0.0920596,0.834839,0.0901159,-0.0669827,0.371383,-1.02495,-0.224717,-0.778466,0.274567,-0.400926,-0.285643,0.934718,0.340511,-0.0850535,-1.13582,-0.179156,0.0937804,-0.480335,0.582527,0.156275,-0.307181,-0.244087,-0.0842174,0.580898,-0.131102,0.0320232,-0.20366,-0.310373,-0.89345,0.365785,-0.377985,0.43121,0.811895,-1.23957,-0.708916,-0.0816949,-0.469626,-0.425955,0.151179,0.191866,-0.171163,0.173463,0.0707227,0.409663,-0.387563,0.533564,0.244065,0.370636,0.39926,-0.266784,0.199818,0.317569,0.279109,0.195769,-0.102581,-0.00274399,0.110748,0.0605906,-0.256002,-0.0155176,-0.461158,-0.0466009,0.186638,-0.180612,-0.335375,-0.303189,-0.738796,1.02252,0.277877,-0.238621,-0.238788,0.28095,0.0526275,-0.322872,-0.498989,-0.769778,-0.425496,0.239735,0.0402336,0.782803,0.979842,0.147642,-0.80815,-0.251371,0.455881,0.289042,0.411531,0.183679,0.4029,0.518991,0.0345513,-0.457567,0.276914,-0.0350457,-0.315595,-0.853046,-0.0636149,0.0786406,-0.108263,0.36134,-0.226331,0.324736,-0.397899,0.172386,0.56313,-0.51512,-0.706143,0.370894,0.479915,0.28649,-1.06131,0.272603,-0.262357,-0.14168,-0.0692215,0.237384,-0.314027,0.299258,-0.0146405,-0.355309,-0.314459,-0.0948669,-0.0389794,0.689814,0.276773,0.454319,0.974702,-0.397119,-0.00781782,-0.158545,-0.163472,0.54727,-0.157595,0.480415,0.589418,-1.2526,-0.32208,-0.208614,-0.569007,-0.212806,0.401083,-0.154619,-0.519494,-0.0719748,-0.557816,-0.60105,0.392702,-0.807784,-0.00840576,-0.28556,0.336945,0.661583,-0.0754104,0.592351,-0.196341,-0.273804,-0.0208849,-0.002842,-0.580703,0.361664,-0.264639,-0.106503,-0.402987,-0.141848,-0.705718,0.428388,-0.0427091,0.191061,-0.222993,-0.473067,0.402388,0.0407975,-0.230619,0.545312,0.657915,-0.0928295,0.300864,-0.666105,0.672639,0.117899,0.279026,-0.252313,-0.133403,-0.0839264,-0.371437,-0.311694,0.635184,0.0244926,-0.155419,0.18933,0.135419,-0.41497,-0.630424,-0.492449,-0.211232,-0.0962663,0.306083,-0.613827,-0.101534,0.391846,-0.0752905,-0.70594,0.187108,-0.409802,0.146851,0.25086,0.118417,0.368724,0.319487,0.6821,-0.376296,-0.350234,0.356321,0.400788,-0.214018,0.256756,-0.199915,0.439705,-0.0385212,-0.235805,-0.907837,-0.122034,0.25945,0.504388,-0.647771,-0.339617,0.359665,-0.495504,0.556254,0.18601,0.144898,0.151048,0.255691,0.521565,0.0190617,0.342008,-0.292803,-0.506658,-0.224881,-0.545317,-0.182444,-0.119903,0.152884,0.12509,0.504593,0.640126,-0.160769,0.000553796,0.109904,-0.0601476,-0.180978,-0.835705,-0.455521,0.119998,0.404778,0.203569,-0.269712,-0.0357642,0.429036,-0.288903,-0.854916,-0.104248,0.489071,0.0672873,0.162729,-0.23676,-0.82913,-0.416165,0.114917,-0.137272,-0.156316,-0.163148,0.169987,0.220995,0.412295,0.470101,-0.0667301 +3408.57,0.976528,0.0848144,5,1.66901,0.952083,-0.772722,0.349469,-0.121399,0.0524017,0.319724,0.163707,0.382489,0.235631,-0.0460948,-0.221095,-0.0749384,0.769438,0.00939672,0.494142,0.270676,-0.297002,0.0121993,-0.275396,-0.477779,-1.04383,-0.995539,0.292907,-0.0501747,-0.478054,-0.577207,0.463513,-0.164147,0.158937,0.943386,0.531491,-0.248873,0.206902,-0.966181,-0.62425,-0.924486,-0.0880743,0.375745,-0.482268,1.35371,0.54454,0.384231,-0.859548,-0.513019,-0.431704,-0.729372,-0.112905,0.137067,-0.283308,0.283812,0.475934,0.305471,-0.435231,0.194676,-0.202118,-0.464237,-0.962255,0.0470606,-0.62851,0.0529481,0.228287,-0.912978,-1.11881,0.156137,-0.446344,-0.438886,-0.416418,-0.0934992,-0.172631,0.28387,0.0528796,0.423691,-0.0943817,0.674563,-0.00341718,0.133844,-0.283186,-0.155059,0.0740023,0.192615,0.220101,0.0456966,-0.196101,-0.194104,0.230096,0.0913271,-0.119562,-0.00425955,-0.270518,0.409219,0.57303,-0.449133,-0.142015,0.0386078,-0.339586,0.903674,-0.305363,-0.105919,-0.0853071,0.224252,-0.25421,-0.405114,-0.35171,-0.0165528,-0.0284111,-0.0512237,0.119087,0.285584,0.473821,0.214845,-1.26984,0.156679,0.371457,-0.0669484,-0.00503217,0.0358053,-0.195935,0.253656,-0.023107,-0.885008,0.0651519,-0.386817,-0.362589,-0.748873,-0.0971521,0.2433,-0.0780712,0.16867,0.0750227,0.55324,-0.171366,0.105414,0.824323,-0.361721,-0.377645,0.15712,0.718072,0.367139,-0.643095,0.0562873,0.0174544,0.213091,-0.154285,0.397757,-0.18444,0.190984,0.276627,-0.0724944,-0.528014,-0.21896,0.0601002,0.795713,0.752801,0.615045,0.856483,0.05007,0.131242,-0.197933,-0.273643,0.301231,0.231717,0.602379,0.398008,-0.386613,-0.176248,-0.248138,-0.488852,0.0474818,0.165104,0.0733213,-0.118517,0.0222159,-0.516503,-0.290457,0.373809,-0.45888,-0.182841,-0.173134,0.924882,0.519484,-0.139577,0.315854,-0.151768,-0.532848,-0.118015,-0.0364275,-0.556218,0.391597,0.124386,-0.183641,-0.508402,0.161791,-0.54452,0.526803,-0.128894,0.186377,-0.0540568,-0.722853,-0.0835489,-0.121413,0.102898,0.441801,0.295049,-0.0733298,0.0529555,-0.659841,0.911495,0.00113084,0.398964,0.0556178,-0.0179105,0.0109159,-0.193978,-0.0145727,0.372356,0.443854,-0.487372,0.403946,-0.497265,-0.139352,-0.546331,-0.0501349,-0.480365,0.0357353,0.331802,-0.32137,-0.444324,0.347407,-0.539826,-0.771201,-0.0595399,-0.594341,0.281902,-0.198018,0.248422,0.0944214,0.204927,0.859782,-0.322475,-0.171046,0.364991,0.256918,0.16531,0.146069,-0.334152,0.383454,-0.170423,-0.0252581,-0.553523,0.133931,0.298421,0.0447698,-0.3703,-0.653761,0.335771,-0.0309751,0.175022,-0.125279,0.0462224,0.413074,0.137023,0.789826,-0.0228737,0.529607,-0.073787,-0.215568,-0.815437,-0.715796,0.0985897,-0.230604,-0.0484948,0.0904233,0.188541,-0.0267666,0.193599,-0.471306,0.288971,0.0948265,-0.16395,-0.539445,-0.544239,0.254349,0.407048,0.179662,-0.0521266,-0.0228479,0.519347,-0.475435,-1.03303,-0.190999,0.803096,0.384401,0.501619,-0.316078,-0.87888,-0.413077,0.107192,0.40697,-0.668682,-0.148028,0.144068,0.234692,0.379563,0.484451,0.450272 +3405.12,0.72818,0.0848144,5,1.63993,0.983506,-0.684415,0.345616,-0.124803,0.0575,0.306284,0.187439,0.395909,0.270502,-0.0910246,-0.159831,-0.0664142,0.777584,0.0457035,0.598582,0.207698,-0.22798,-0.0427987,-0.292743,-0.499806,-0.946065,-0.917187,0.362902,0.0633729,-0.449396,-0.628831,0.447322,-0.110824,0.215489,0.898589,0.466319,-0.17094,0.213487,-0.90088,-0.687835,-0.802418,-0.0170227,0.335644,-0.410788,1.32237,0.562814,0.403267,-0.873396,-0.455329,-0.369838,-0.641401,-0.206539,0.133255,-0.254704,0.249217,0.493625,0.3118,-0.42905,0.146858,-0.192659,-0.52538,-1.07673,0.0361537,-0.630741,0.0626897,0.2436,-0.90299,-1.07147,0.122435,-0.39817,-0.392123,-0.389661,-0.0809405,-0.133832,0.290853,0.149497,0.378467,-0.0980719,0.68088,0.00579781,0.0661271,-0.180885,-0.152802,0.0393064,0.221193,0.359797,0.107732,-0.190994,-0.206849,0.154984,0.0649105,-0.12325,-0.0467457,-0.258112,0.396729,0.505626,-0.50038,-0.13737,0.0275351,-0.212649,0.948877,-0.311525,-0.0514196,-0.13286,0.228199,-0.314459,-0.377158,-0.224889,0.0920566,-0.00861824,-0.17452,0.102559,0.315218,0.52241,0.237381,-1.33068,0.264473,0.356723,-0.0705761,-0.038678,0.0655364,-0.199475,0.307808,0.014133,-0.834413,0.082397,-0.385533,-0.392928,-0.727439,-0.1358,0.267202,-0.0674253,0.116816,0.0614649,0.524062,-0.136251,0.125856,0.890059,-0.359966,-0.32155,0.15775,0.753398,0.354395,-0.687378,0.0128711,0.000241737,0.105096,-0.149118,0.352922,-0.147832,0.178085,0.306908,-0.128336,-0.504396,-0.184744,0.0779684,0.856603,0.761418,0.568785,0.756791,0.00151282,0.194937,-0.204133,-0.292544,0.285736,0.225043,0.623561,0.46442,-0.4819,-0.219065,-0.207232,-0.486127,0.0438089,0.133274,0.0877085,-0.126613,0.0674254,-0.452574,-0.366904,0.382904,-0.451566,-0.182861,-0.164596,0.888131,0.546013,-0.15724,0.214361,-0.166904,-0.478031,-0.0408965,-0.101089,-0.523801,0.388509,0.138623,-0.18435,-0.483758,0.0881138,-0.59041,0.444487,-0.209971,0.227966,-0.0682144,-0.704129,-0.107468,-0.113677,0.0102069,0.459724,0.292443,-0.100177,0.131453,-0.680037,0.893936,-0.0353282,0.396577,0.0816833,-0.0499308,0.0695077,-0.105872,-0.0053879,0.325636,0.489666,-0.388879,0.377936,-0.562639,-0.123293,-0.450808,-0.0113146,-0.53064,0.0708493,0.369327,-0.246511,-0.41066,0.36855,-0.485762,-0.707802,-0.0394441,-0.491648,0.234714,-0.195181,0.259506,0.144159,0.182024,0.944124,-0.374732,-0.0897235,0.430769,0.21864,0.159192,0.143893,-0.474081,0.373683,-0.124542,0.0617904,-0.588115,0.073947,0.376822,0.0502885,-0.398644,-0.614743,0.370132,-0.051597,0.238196,-0.178477,0.0377942,0.470927,0.1505,0.779238,-0.0117393,0.50084,-0.0285333,-0.226412,-0.858115,-0.761518,0.0970979,-0.265931,-0.0664888,0.00214773,0.151387,-0.120536,0.291939,-0.421292,0.248637,0.0563347,-0.133892,-0.57602,-0.501669,0.261336,0.480307,0.147808,-0.0368395,-0.00495762,0.499744,-0.418746,-1.05983,-0.162622,0.860218,0.413926,0.498475,-0.295221,-0.911513,-0.417482,0.15318,0.38403,-0.582542,-0.101823,0.144929,0.234604,0.380696,0.484359,0.332907 +3436.35,0.731949,0.0848144,4,1.71279,0.868172,-0.778839,0.327451,0.103576,-0.187523,0.371566,0.34778,0.0523169,0.383917,0.00569109,-0.473949,-0.000928538,0.504695,-0.134149,0.621368,0.455388,-0.0640441,-0.355823,-0.178538,-0.389351,-1.02269,-0.819749,0.0190705,-0.420361,-0.293594,-0.530022,0.1528,-0.13609,0.325485,0.748589,-0.0736243,0.231139,0.341497,-0.892113,-0.412228,-0.928203,-0.0973369,-0.206079,-0.563569,1.03537,0.390945,0.122857,-0.979985,-0.437945,0.161261,-0.555348,-0.112447,-0.078004,0.146335,-0.211949,0.0678079,0.0847373,-0.581793,0.354529,-0.0078693,-0.591888,-0.940044,0.265972,-0.366017,0.285305,0.433602,-1.14684,-0.407494,0.168911,0.572937,-0.260864,-0.0186164,0.275827,-0.3665,-0.0827261,-0.13061,0.632673,0.230997,0.424393,0.377716,0.324534,0.157843,0.0752628,0.114861,0.624585,0.391322,0.30613,0.348178,-0.0785855,0.308082,-0.104475,-0.0725223,0.294381,-0.421972,0.254234,-0.0126465,-0.361554,-0.0423122,0.0420957,-0.0734739,-0.140042,-0.731152,-0.0465376,0.183202,-0.453596,0.0297866,-0.0078781,-0.297071,0.079269,-0.289027,-0.0507436,-0.140067,0.328917,0.343957,0.628146,-0.727233,-0.262811,0.299346,-0.0331436,0.172288,0.488081,-0.0672259,0.177192,-0.221599,-0.533509,0.285633,-0.380925,-0.150617,-0.0605969,-0.13809,0.0849249,0.0104105,-0.137006,0.135026,-0.450514,-0.0328125,0.251545,0.443024,-0.0444687,-0.196707,0.402058,0.247821,0.613088,-0.78244,-0.230481,-0.0765946,0.372017,-0.314096,0.126592,-0.24155,0.138987,-0.0780127,-0.157551,-0.211341,-0.243815,0.0347773,0.42498,0.236694,0.899884,0.705616,0.580669,-0.288856,-0.251903,-0.00969237,0.231506,-0.0496653,1.00086,-0.0626881,-0.0219891,0.482705,0.302048,-0.35484,0.301725,-0.0467475,0.25605,0.330748,-0.0284048,-0.469962,-0.257357,-0.0879894,-0.092489,0.116605,0.209973,0.586903,0.530689,0.407509,0.223849,-0.305501,-0.21101,0.0670992,-0.0915273,-0.408668,0.344958,-0.1391,0.00139555,-0.239069,0.276604,-0.290457,0.164526,0.27357,0.180967,0.338157,-0.382155,-0.178861,-0.0602329,-0.149275,0.622359,0.427903,-0.136714,0.168361,-0.259546,0.845567,-0.207767,-0.387791,-0.325423,-0.284151,0.101024,-0.0590195,-0.18846,0.300911,0.0487604,-0.58264,0.383304,-0.526998,-0.0945863,-0.569665,-0.572256,-0.626954,-0.3246,0.546053,-0.434921,-0.18117,-0.139407,-0.614131,-0.93809,0.0380638,-0.0937868,-0.0685981,-0.212818,0.519851,0.433694,-0.00729516,1.1143,-0.441307,-0.162589,0.35572,0.165469,0.11484,0.173329,-0.0264534,0.437039,0.253053,-0.0472062,-0.346427,0.309849,0.450967,0.475913,-0.106567,-0.341438,0.613825,-0.313381,0.181365,0.143212,0.0318572,0.311074,0.118395,0.444548,-0.0266532,0.359164,0.0247319,-0.091806,-0.82537,-0.247388,-0.118972,0.0667305,0.021953,-0.108961,0.427508,-0.104322,0.236646,-0.283787,0.297079,0.3337,0.457845,-0.322644,-0.250938,-0.215967,0.340984,0.734674,-0.0890046,-0.052272,0.55978,0.0241241,-0.587928,-0.089424,0.352457,0.0560898,0.111926,-0.324187,-0.266364,-0.658827,0.0415807,-0.0261038,-0.593422,-0.270239,0.133202,0.286001,0.364968,0.534791,-0.0203951 +3444.15,0.992704,0.0848144,4,1.68171,0.881448,-0.780181,0.345467,0.0118589,-0.192682,0.252241,0.350965,-0.0422965,0.568634,0.0513564,-0.388605,0.104143,0.633737,-0.109504,0.654317,0.317105,-0.152575,-0.386637,-0.129369,-0.456068,-0.849919,-0.986932,0.0389782,-0.323614,-0.27127,-0.592892,0.284548,-0.196473,0.44531,0.798909,-0.24414,0.178106,0.323823,-0.821208,-0.408148,-0.791325,-0.0801788,-0.116963,-0.616439,0.969737,0.395018,0.168911,-1.11319,-0.455549,0.145982,-0.695306,-0.112486,-0.0535853,0.0979472,-0.242787,0.0862124,0.149225,-0.328642,0.44373,-0.12855,-0.543705,-0.928725,0.161003,-0.382184,0.266982,0.413968,-1.14334,-0.517062,0.254332,0.600262,-0.272264,0.00784217,0.21621,-0.425982,-0.0284931,-0.0783163,0.541059,0.0914944,0.432133,0.395027,0.2996,0.138442,0.197428,0.111024,0.462056,0.416401,0.276542,0.422096,-0.153849,0.189394,-0.0748126,-0.110508,0.406443,-0.501462,0.267232,-0.0104735,-0.285957,0.0683383,0.0257718,-0.167506,-0.068131,-0.700972,-0.13868,0.111635,-0.413503,0.126866,-0.0416401,-0.277964,-0.0447289,-0.187039,0.00587068,-0.119463,0.290793,0.390529,0.584126,-0.612699,-0.240293,0.330463,-0.0531918,0.270699,0.426357,-0.0883973,0.0920051,-0.138375,-0.440216,0.214428,-0.298303,-0.115781,-0.0838168,-0.140197,0.161075,-0.102644,-0.185077,0.0780479,-0.40311,-0.0121359,0.200303,0.53427,0.00409501,-0.138892,0.324541,0.298693,0.641359,-0.840962,-0.177379,-0.182181,0.431526,-0.278175,0.0557471,-0.363638,0.2227,-0.101889,-0.091895,-0.115663,-0.195547,0.0421466,0.465807,0.151119,0.992279,0.797501,0.694432,-0.300656,-0.278079,-0.0701123,0.332449,0.0148009,0.913978,-0.0915444,0.072427,0.440555,0.305806,-0.429717,0.265354,-0.0196254,0.278377,0.226506,-0.0254993,-0.520437,-0.294359,0.0236615,-0.168668,0.177472,0.186998,0.50528,0.552125,0.398731,0.182341,-0.269109,-0.271227,0.162084,-0.0338933,-0.434584,0.417017,-0.141308,0.00900656,-0.368501,0.15539,-0.342912,0.156636,0.277961,0.186352,0.347408,-0.394153,-0.178962,-0.0458206,-0.141598,0.600377,0.483917,-0.211811,0.281097,-0.176336,0.917069,-0.267648,-0.307372,-0.297943,-0.453936,0.0284239,-0.0341816,-0.115047,0.295306,0.0107434,-0.515946,0.538794,-0.414746,-0.0339068,-0.554618,-0.421067,-0.582078,-0.349003,0.626485,-0.48167,-0.111808,-0.0719075,-0.672494,-0.937007,-0.00909916,-0.101878,-0.0146472,-0.258657,0.483995,0.383044,0.0876171,1.08809,-0.507164,-0.1725,0.392116,0.100268,0.127147,0.289075,-0.0779107,0.470742,0.229266,-0.0204001,-0.323379,0.271831,0.443719,0.44981,-0.08867,-0.292809,0.510608,-0.278598,0.201969,0.0895425,0.0127459,0.335162,0.0110313,0.492428,-0.0774939,0.256915,0.174904,-0.0593204,-0.877785,-0.106113,-0.0242647,0.112365,0.00635099,-0.210265,0.443179,0.00696684,0.36249,-0.203872,0.33722,0.251919,0.459358,-0.302754,-0.303559,-0.299665,0.232634,0.639116,-0.064714,0.0361807,0.268619,-0.0058337,-0.49178,-0.0873609,0.313518,0.0423074,0.0124845,-0.343193,-0.468395,-0.43142,-0.0168147,0.056843,-0.559479,-0.160771,0.12013,0.260277,0.346598,0.510173,0.214442 +3439.08,0.709016,0.0848144,5,1.54471,1.04765,-0.84104,0.25396,0.00245341,0.00299903,-0.144659,0.447315,0.504706,0.179285,-0.00558527,0.391021,0.0519327,0.210188,-0.144603,1.26649,0.244914,-0.0184746,0.0157429,0.0227718,-0.291317,-0.847688,-0.666197,0.172717,-0.227272,-0.214857,0.499664,-0.00893349,-0.269303,-0.170551,0.477959,0.0203692,-0.177044,-0.042597,-0.389954,0.106415,-0.476839,0.563751,0.510619,-0.0330312,0.884321,0.379693,-0.0458817,-1.16636,-0.254298,0.117153,-0.635294,0.569255,0.367174,-0.610056,0.257383,0.200311,0.00977751,-0.109249,0.2802,-0.0482867,0.192799,-0.411362,0.324551,-0.248788,0.205686,0.912653,-0.338124,-0.785591,-0.164732,-0.227956,-0.0954876,-0.0477339,-0.0499688,-0.522272,-0.440075,0.709855,0.781338,-0.0455933,0.767366,0.465122,0.188284,-0.114678,-0.337299,0.232736,0.556577,-0.467778,-0.0758916,-0.505116,0.0366084,-0.030903,-0.09337,0.0953797,-0.8258,0.0105677,-0.33877,0.2515,0.327513,0.0580623,0.349362,-0.143111,-0.0583422,-0.017639,0.371193,0.208986,0.69235,-0.260208,-0.109435,-0.125668,0.233212,-0.0558073,-0.0341824,0.21944,0.175604,0.733904,-0.172976,0.115352,-0.053897,0.50008,0.0751184,-0.305574,-0.314087,0.122468,0.294336,0.213745,-1.06953,-0.367197,-0.542656,-0.163293,0.363464,-0.0928953,0.325547,0.262105,0.105707,-0.790077,0.43878,0.163721,0.152708,0.228792,-0.200996,-0.142255,-0.400647,-0.0509108,0.330631,0.051452,-0.416763,0.059544,-0.0413863,-0.470968,0.453384,-0.00955763,-0.0654555,0.64426,0.0655822,-0.0500755,-0.486659,0.0855744,-0.036236,-0.0972609,-0.405177,0.326749,-0.731976,-0.158536,0.262524,0.613216,0.0860694,0.365994,0.424957,-0.103786,-0.113446,-0.337369,0.0214129,0.440551,-0.43022,-0.139999,-0.389935,-0.313448,0.103343,0.187762,0.0639574,0.0268819,-0.308699,-0.171384,0.0376544,0.954604,-0.489136,-0.537368,0.385289,0.210727,-0.1542,-0.629438,-0.268908,-0.265521,-0.190091,-0.581746,0.281198,0.695733,0.0069207,-0.679207,-0.178888,-0.155687,0.332761,-0.454216,-0.266219,0.677292,-0.155939,0.380379,-0.17015,-0.415706,0.192527,-0.260042,-0.724034,0.928271,0.344993,0.0918913,0.342709,0.316844,0.490092,-0.119522,0.331424,-0.056675,-0.419389,0.428095,0.0754016,-0.0562411,0.333697,-0.0920115,0.111928,0.553414,0.151264,0.608082,0.00535217,-0.314519,0.218538,0.394488,0.306929,0.170275,-0.0308514,-0.185611,0.0561387,0.321271,-0.0165156,-0.109782,-0.0121672,0.155376,-0.133143,0.350291,0.223685,-0.172541,0.592012,0.027702,-0.236966,0.0564043,-0.129382,-0.0993629,0.0751409,-1.37279,0.156765,-0.528899,-0.117261,0.214843,-0.206906,-0.116733,0.259493,-0.114123,0.266346,0.575708,-0.121515,0.315346,0.250457,-0.168518,0.146038,0.318958,0.161771,0.0179553,-0.252698,-0.196822,-0.170586,0.0110126,-0.250452,-0.626297,0.102635,-0.000193341,0.592109,-0.375277,0.0776859,-0.0818048,-0.085042,-0.195771,-0.18703,0.246425,-0.185415,0.134507,-0.105415,-0.391954,-0.12404,-0.475394,-0.0778743,-0.21752,0.0477642,-0.313762,0.106021,0.090953,-0.334158,0.460537,-0.0408366,0.122493,0.183442,0.34999,0.428302,-0.115326 +3414.38,0.919503,0.0848144,4,1.57663,0.84525,-1.07982,0.409461,0.119195,-0.039603,0.284359,0.142033,0.0658374,0.501496,-0.123294,-0.13082,-0.114743,0.625661,-0.723014,0.682891,0.391907,0.0138534,-0.219098,-0.172648,-0.327433,-0.887658,-0.849097,0.497742,-0.158629,-0.329317,-0.0396205,0.261145,-0.41249,-0.0114211,0.624938,-0.264884,-0.996385,-0.130422,-0.861957,-0.259028,-0.882706,0.427272,0.605826,-0.415896,0.863972,0.605993,0.0764428,-0.51778,-0.0181476,0.187122,-0.171005,0.324021,0.44782,0.0428609,0.16213,0.501058,0.362277,0.243857,0.401095,-0.494651,-0.111155,-0.59761,0.26433,0.137271,-0.0798533,0.81873,-0.493379,-0.581926,0.343589,-0.454549,-0.0218346,0.68874,0.28514,-0.431308,-0.371951,-0.0427149,0.533309,0.0471714,0.291406,0.28118,0.493542,0.456865,0.131119,0.108426,-0.0068985,-0.194029,-0.189181,-0.316871,0.235528,-0.0792653,-0.138342,0.0670006,-0.241718,-0.273545,0.129862,0.24445,-0.170847,0.307406,0.0531416,-0.418582,0.434628,-0.544701,-0.157582,0.338541,0.114086,0.0359758,-0.00111931,-0.277031,0.279825,0.450731,1.08528,-0.0183276,0.559312,0.384616,-0.0579413,0.0571296,-0.135689,0.52638,-0.0109431,0.16589,-0.740206,0.15347,0.437585,0.000694721,-0.249106,-0.210652,-0.303378,-0.543296,-0.254226,0.0872932,0.303845,-0.0129353,0.5739,-0.355382,0.505592,0.328583,-0.288866,0.0638893,-0.194188,-0.248972,-0.327074,-0.0975161,0.296497,-0.29664,0.940741,-0.401881,0.610468,-0.34707,-0.0690207,0.670195,0.0649784,0.644797,-0.415331,-0.245606,-1.04612,0.289726,0.341345,-0.241726,-0.180159,0.334473,0.122618,-0.0234959,0.403266,0.338453,0.338295,0.246814,0.513183,0.739838,0.0310514,-0.370866,-0.358431,0.080193,0.276568,-0.545073,0.109883,0.574001,0.130929,0.182947,-0.321591,-0.490806,-0.444524,0.151649,-0.0320364,0.815795,-0.111669,0.18069,0.375097,-0.299702,0.0152165,-0.11209,-0.200824,-0.303161,0.292459,-0.130511,0.0314826,0.0142386,0.0889717,-1.01517,0.347012,0.178562,0.0764598,-0.17472,-0.465737,0.827936,-0.322949,0.305812,-0.392663,0.259881,0.317196,-0.601479,-0.296856,1.27403,-0.548592,0.0272659,0.452025,-0.0599705,0.120873,0.323508,0.000492463,0.0690516,-0.13911,0.457596,0.291485,-0.134611,-0.202694,-0.145667,0.358232,0.287911,-0.378312,0.460164,0.194693,-0.123985,-0.00349242,-0.306915,-0.44653,0.14798,-0.229348,-0.266999,-0.573089,0.472126,-0.0678141,0.0751709,0.410004,-0.812928,-0.490485,0.000134228,-0.275343,-0.531081,0.193602,-0.252592,0.187,-0.0669263,0.17317,-0.388267,0.765852,-0.604218,0.415065,-0.130772,-0.22072,0.210932,-0.0738595,0.0958136,0.00948565,-0.132815,-0.0337524,0.17931,-0.285553,0.0315588,0.322147,0.594511,0.13316,0.531792,0.0274893,0.219211,0.0272082,-0.370629,-0.417051,0.0355184,-0.0912723,-0.01547,-0.244561,0.34642,0.653243,-0.268952,-0.15869,-0.230863,-0.312408,-0.435815,0.0492295,0.376612,-0.496463,0.668668,-0.37541,0.0866177,0.197104,-0.102698,-0.167856,0.328834,-0.217114,-0.324655,0.452196,0.151432,-0.175248,-0.155232,-0.412522,0.146192,0.23608,0.382351,0.48588,-0.124493 +3421.8,0.856812,0.0848144,4,1.65117,0.669586,-1.42147,0.506268,-0.0058665,-0.0489212,0.242441,-0.151166,-0.204835,0.360137,0.0135928,0.0502053,-0.291169,0.445102,-0.454875,0.84753,0.46588,-0.233321,-0.302581,0.236883,-0.155137,-0.559172,-1.09119,0.735138,-0.556828,-0.418686,0.0966695,-0.198218,-0.670625,0.106466,0.603478,-0.865171,-0.519033,0.158654,-0.71175,-0.384318,-0.951706,0.314471,0.740144,-0.492908,0.518004,0.343642,0.0541352,-0.660961,-0.0132875,-0.107329,-0.298456,-0.0269948,0.529471,0.0119073,0.251395,0.142507,0.232663,-0.467994,0.382301,-0.221565,0.236104,-0.893681,0.398241,0.0020389,-0.0129584,0.755926,-0.453764,-0.9459,0.17854,-0.103013,-0.318311,0.303409,0.143919,-0.274285,-0.448374,-0.623609,0.5483,-0.556616,0.161261,0.302152,0.272446,0.443927,0.0238784,-0.0124005,-0.0699497,-0.139951,0.0379054,-0.744115,-0.0363048,-0.624206,-0.263386,-0.00859418,-0.299901,-0.427304,-0.221216,0.131656,-0.588491,0.361641,0.0891283,-0.209004,0.274838,-0.558433,-0.131023,0.479448,0.115086,-0.13068,-0.287223,-0.28987,0.423614,0.315,0.110981,-0.174616,0.0558796,0.138536,0.0369268,-0.0587292,0.0197719,0.671342,0.133906,-0.302929,-0.777799,0.0246303,0.196284,-0.0729793,-0.174227,-0.234373,-0.2506,-0.474655,-0.20348,-0.00556494,0.694238,-0.19267,0.302554,-0.419035,0.190704,0.114259,0.0423915,0.366579,-0.502316,-0.213529,0.279739,-0.29283,0.533244,-0.260834,0.377176,-0.0867499,1.02586,-0.302775,0.10041,0.0917055,0.170737,0.153505,-0.187719,-0.038817,-0.975544,0.38406,0.372892,0.161006,-0.0626502,0.251131,-0.128451,-0.153793,0.593825,0.224672,-0.0673017,0.283861,0.621441,0.592893,0.105252,-0.245065,-0.0102244,-0.173988,-0.337804,-0.6026,0.210265,0.422018,0.0549542,-0.131792,0.0600255,-0.257776,-0.212063,0.228091,0.311999,0.510329,-0.128703,0.0891539,0.328002,-0.201781,-0.251996,-0.641711,0.0732373,-0.0714729,0.0835541,-0.182112,-0.014019,0.242623,-0.0153059,-0.807164,-0.105054,-0.0284249,0.237242,-0.0367848,-0.579814,0.60281,-0.476076,-0.478714,-0.557257,0.25446,0.256975,-0.748641,-0.627083,1.1499,-0.251966,0.478985,0.425397,0.0502515,0.126177,0.241502,-0.0534741,-0.21245,-0.0535869,0.785331,-0.173016,-0.405133,-0.0863531,-0.527434,0.150803,0.111541,0.153045,0.49295,-0.023181,-0.124195,0.716865,-0.152855,-0.380022,0.1948,-0.235494,-0.504512,-0.304439,0.546657,-0.310029,0.0731082,0.37799,-0.778662,-0.551461,-0.083398,-0.357867,-0.762564,0.149067,-0.21471,0.419961,0.023877,0.366668,-0.297451,0.341919,-0.674973,0.139321,-0.117844,-0.0521317,0.334611,0.0393084,0.0414997,0.397854,-0.048975,-0.230332,-0.0755686,-0.18633,-0.0262554,0.118064,0.0852381,0.367307,-0.0245362,-0.334571,0.148975,0.0306187,-0.051066,-0.424385,0.444814,0.109885,0.339997,0.271902,0.55604,0.81283,-0.406247,0.0782853,-0.725001,-0.504248,-0.648262,-0.0578512,0.258081,-0.264999,-0.260064,-0.355154,-0.118118,0.34327,-0.152294,0.0509301,-0.192749,-0.0843065,-0.505275,0.62413,0.0195833,-0.13121,0.176194,0.239385,0.112832,0.209969,0.335905,0.458223,0.765818 +3422.64,1,0.0848144,5,1.63265,0.625403,-1.45259,0.588368,0.427557,-0.109346,-0.0461504,0.00515626,-0.259824,0.474238,-0.0867627,0.171683,-0.275579,0.453496,-0.669347,0.761416,0.408842,-0.265037,-0.393915,0.0947478,-0.225842,-0.441112,-1.24954,0.575843,-0.471534,-0.433518,0.0437598,-0.00808249,-0.678819,0.191884,0.65445,-0.772045,-0.654919,0.0597068,-0.593324,-0.371128,-0.721769,0.354551,0.820251,-0.467976,0.684151,0.230992,0.129535,-0.653549,-0.311933,-0.0917908,-0.391961,0.161326,0.369159,-0.129925,0.322859,0.206578,0.33422,-0.65397,0.388835,-0.292659,0.203894,-0.700961,0.420581,-0.207586,0.161902,0.729656,-0.243598,-0.861728,0.290155,0.143662,-0.37839,0.072807,0.401085,-0.356586,-0.596603,-0.503876,0.572591,-0.429438,-0.0554952,0.204839,0.473817,0.291853,-0.316065,0.010204,-0.0110258,-0.0938654,0.114216,-0.659777,-0.00475666,-0.594654,-0.225362,0.17198,-0.301557,-0.377453,-0.0362268,0.0201263,-0.353845,0.484279,0.0456933,-0.151808,0.0954544,-0.232058,-0.0324218,0.499478,0.145753,-0.256987,-0.395678,-0.408809,0.553039,0.416614,0.046357,-0.183541,0.22723,0.164517,-0.0523249,-0.048338,0.0455185,0.64395,0.196437,-0.43797,-0.58405,0.164904,0.047284,0.145308,-0.302123,-0.416646,-0.241615,-0.567119,-0.281467,0.00522905,0.887003,0.0018353,0.265616,-0.373518,0.273902,0.152173,0.170796,0.366893,-0.517447,0.0936446,0.287438,-0.50613,0.716192,-0.181999,0.429988,-0.272529,0.780393,-0.22951,-0.0447031,0.209203,0.250851,0.103855,-0.0467896,-0.162371,-0.733648,0.229601,0.379602,-0.130355,-0.181762,0.482722,-0.179432,-0.0153258,0.543873,0.250777,0.0984886,-0.0197974,0.866718,0.50276,0.358713,-0.348067,0.0455641,-0.105554,-0.0626986,-0.301211,0.341302,0.151098,0.119184,0.0358777,-0.106096,-0.497769,-0.0903173,0.192685,0.291228,0.425494,-0.161456,-0.0751941,0.148631,-0.298993,-0.173392,-0.640569,0.10673,-0.121435,-0.20985,-0.320511,0.0992539,0.177343,0.0503203,-0.960898,-0.0698274,-0.538137,0.241917,-0.0946854,-0.699223,0.802851,-0.461491,-0.361398,-0.362574,0.28711,0.448378,-0.676437,-0.552056,1.21486,-0.302603,0.487024,0.473756,-0.0462482,0.283243,0.45903,-0.0674749,-0.328508,0.0160852,0.62843,-0.0489904,-0.547279,0.0368057,-0.531723,0.14478,0.472436,0.258622,0.568767,0.0183926,-0.166626,0.886307,0.0159251,-0.235603,0.242094,-0.34383,-0.525378,-0.355261,0.397225,-0.189433,0.473611,0.222503,-0.848687,-0.503112,-0.191129,-0.463492,-0.705252,0.287388,-0.0696368,0.272436,-0.0448675,0.18682,-0.435684,0.0369783,-0.496435,0.170854,-0.14377,0.0207151,0.310191,0.0875507,0.105366,0.45266,-0.0116227,-0.292775,0.0688833,-0.156192,-0.0442406,0.402474,0.116892,0.445881,-0.0419214,-0.330077,-0.0523157,-0.118673,-0.0495001,-0.235576,0.32477,0.147477,0.304743,0.392449,0.447381,0.748468,-0.286528,0.211546,-0.366225,-0.651435,-0.733622,-0.211423,0.245563,-0.235755,0.0661911,-0.528405,-0.0757405,0.28778,-0.0442548,-0.103125,-0.0533057,-0.11807,-0.628628,0.48555,-0.133657,-0.188642,0.229245,0.198806,0.123025,0.294183,0.35075,0.542386,-0.659867 +3416.49,0.889652,0.0848144,4,1.67741,0.726493,-1.63539,0.697286,0.128691,-0.012982,0.0193492,-0.257886,-0.112698,-0.450045,-0.0667405,0.131989,-0.579245,0.433439,-0.653755,0.685347,0.54233,-0.258688,0.0912142,0.0889966,-0.224506,-0.553333,-1.26842,0.72058,-0.598357,-0.40004,-0.225741,0.289632,-0.396193,0.208577,0.604078,-0.463294,-0.726604,0.166964,-0.563854,0.0656706,-0.735522,0.564316,0.708615,-0.01226,0.608177,0.697682,-0.0509004,-0.994513,-0.275359,0.0976306,-0.478711,0.513845,0.0828557,-0.0976317,-0.0464557,0.376011,0.298713,-0.567739,0.16547,-0.188626,0.323548,-0.875113,0.13971,-0.363809,0.158903,1.0475,-0.229649,-0.875452,-0.210143,-0.198285,-0.24889,-0.0021523,0.206755,0.371858,-0.459259,0.226263,0.584222,-0.629602,0.349106,0.216403,0.51512,0.00167222,-0.458084,0.188069,0.478775,-0.110825,0.0190914,-0.102789,-0.1193,-0.263732,0.467059,0.378797,0.00372767,-0.556828,-0.0921981,-0.696558,-0.532327,0.241319,0.0356398,-0.217977,-0.243161,-0.337781,0.0930631,0.465523,0.581372,0.0970111,-0.0369123,-0.580088,0.239982,-0.0697076,0.400443,0.0236466,0.310621,0.356751,-0.116543,-0.0908605,0.0613153,0.471436,0.470597,-0.484984,-0.285582,-0.0671666,-0.23157,0.177581,-0.349901,-0.337272,-0.255573,-0.201475,-0.425066,0.0509211,0.194954,-0.275454,0.183772,0.071322,0.0989347,0.209038,0.392543,0.270455,-0.462948,0.0612305,0.0316283,-0.0132588,0.635071,-0.996572,0.153331,-0.210665,-0.075166,-0.228829,-0.344851,-0.24998,-0.143343,0.585503,0.134641,0.610255,-0.522624,0.12655,0.00747209,-0.380179,-0.590262,0.183225,0.173739,0.0571475,0.25608,-0.0081514,0.14926,-0.127445,0.507854,0.817345,-0.726839,-0.290435,0.116745,-0.295485,-0.0919186,0.0421862,0.000149108,0.391183,0.0293415,0.574569,-0.360118,-0.501503,-0.203814,-0.396108,0.0428331,0.516569,-0.481765,-0.0260384,0.350364,-0.827719,-0.0792085,-0.0542515,0.150767,0.0635578,-0.295789,0.201199,0.198667,0.469922,-0.0471106,-0.252845,0.0234308,-0.433838,0.262353,-0.217387,-0.450755,1.16686,-0.431935,-0.167732,-0.00627608,-0.348925,0.255348,-0.324999,-0.0719652,1.1132,-0.224484,0.465636,0.387926,-0.292516,0.265803,0.217226,0.217067,-0.540048,-0.643923,0.285507,0.360873,-0.0275033,-0.319462,-0.0609601,0.610121,0.423897,-0.302068,0.73886,-0.236934,-0.176015,0.756331,-0.02697,-0.524811,0.0657448,-0.653113,-0.744086,-0.507801,0.587829,-0.16433,0.0314509,0.372294,-0.410621,-0.101232,-0.417933,0.0314848,-0.157601,0.109591,0.406735,0.426274,0.0985522,0.515983,-0.6398,0.364255,-0.259172,0.090109,-0.114342,-0.457424,0.0346411,-0.18497,0.414369,0.25223,-0.191391,-0.220216,0.0782294,0.383667,-0.0951406,0.412655,0.0238755,0.366677,-0.168768,-0.0500923,0.229931,-0.111721,-0.19786,-0.248968,-0.264197,0.052675,0.277816,0.136327,0.097897,0.0540197,-0.0815001,-0.0069784,0.0791425,-0.166423,-0.0379804,-0.202943,0.311086,-0.275868,0.499245,-0.292488,0.100175,-0.0846062,-0.00886982,-0.329074,-0.148535,-0.526721,-0.220972,0.262802,-0.167732,-0.30752,0.36093,0.141672,0.133398,0.223419,0.365237,0.472672,0.167011 +3414.19,0.925721,0.0848144,4,1.68755,0.771062,-1.30568,0.50552,0.537206,-0.0413761,0.0496356,-0.336686,0.132691,-0.573292,-0.0330967,-0.229505,-0.311627,0.328695,-0.431351,0.382565,0.205486,0.133582,0.0434,-0.0454243,-0.293533,-0.64866,-1.04619,0.376191,-0.436364,-0.561367,-0.196712,0.250879,-0.677943,0.191068,0.636012,-0.469378,-0.861581,0.143956,-0.236186,-0.145301,-0.370839,0.42851,0.481939,0.0802598,0.827144,0.213552,0.215093,-1.04503,-0.485626,0.111522,-0.769494,0.338847,-0.00852312,-0.0652018,0.0850551,-0.117789,0.148969,-0.359612,0.50718,-0.112096,0.243668,-0.784091,0.207577,-0.385143,0.204098,1.14421,-0.151502,-0.976262,0.211212,0.138562,-0.00183227,0.166266,0.198537,-0.187005,-0.199643,0.614588,0.5485,0.0230887,0.12839,0.243878,0.697293,-0.265885,-0.522503,0.0729856,0.484858,0.0542357,0.0630804,-0.302753,-0.0775102,-0.474304,0.459879,0.336772,-0.150883,-0.410718,-0.19909,-0.283717,-0.537222,-0.024785,-0.147474,0.346458,-0.106603,0.0256844,0.348967,0.485754,0.452991,0.357576,0.153717,-0.526682,0.257811,-0.0232087,0.148622,-0.133362,0.522432,0.517727,-0.0763779,0.0909972,0.631973,0.625789,0.0782218,-0.652646,0.0936953,0.143343,-0.225314,0.513772,-0.605859,-0.361074,-0.230729,-0.260965,-0.25396,0.500957,0.421316,-0.306898,-0.0309816,0.520181,0.166248,0.281756,0.35765,0.286066,-0.279468,-0.190597,-0.402239,-0.184238,0.650719,-1.03911,0.609676,-0.100954,-0.464733,-0.473292,-0.396416,-0.0769181,-0.00286254,0.213655,0.215194,0.0246817,-0.760154,0.338528,-0.129146,-0.4521,-0.19968,0.503237,-0.139354,0.317501,-0.0258886,0.0170757,0.266043,-0.0103218,0.511622,0.478814,-0.69257,-0.0832492,-0.00632417,-0.143483,-0.0364474,0.213974,0.0111743,0.239014,-0.241038,0.342429,-0.524884,-0.321294,-0.156293,-0.301882,0.514647,0.503016,-0.476583,-0.222992,0.320287,-0.555415,-0.0247227,-0.200088,-0.138771,0.237502,-0.368838,0.283051,0.312822,0.495234,-0.217154,-0.463001,-0.0504,-0.151324,0.078931,-0.115199,-0.718757,0.794731,-0.322099,-0.306343,0.15774,0.0598722,-0.0794556,-0.420424,-0.074204,1.14323,-0.52186,0.0434029,0.226156,-0.202748,0.220655,-0.0307807,-0.17028,-0.412843,-0.338581,0.275066,0.184897,0.0115734,-0.236562,-0.582573,0.270387,-0.00605873,-0.449456,0.611855,-0.391463,-0.00561964,0.667591,-0.164379,-0.281632,0.190431,-0.619866,-0.593073,-0.638612,0.550235,0.0125829,0.0356474,0.0226617,-0.619052,0.153365,-0.0321993,0.117524,-0.0789673,-0.214345,0.346287,0.305397,0.210872,0.407545,-0.398629,0.298969,-0.341417,0.0780329,-0.238088,-0.514459,0.362168,-0.353595,0.29703,0.190226,0.109102,-0.205366,0.00800601,-0.0135124,-0.092689,0.30767,0.183441,0.388861,0.422972,-0.383801,0.235157,-0.131085,-0.0105191,-0.409225,-0.190637,0.00168573,0.480076,-0.093038,-0.179656,0.488356,0.25488,0.317598,-0.0871088,-0.210403,-0.175172,-0.205305,0.193764,-0.0461051,0.00331408,-0.104732,0.29541,-0.0168216,0.0673547,-0.167836,0.374782,-0.291124,-0.285226,-0.0122348,-0.664248,-0.590633,0.381644,0.284399,0.105017,0.25425,0.324063,0.504233,-1.24211 +3418.37,0.921876,0.0848144,4,1.64285,0.645439,-1.35577,0.478899,0.26972,-0.127948,0.0702521,-0.34088,0.0295856,-0.123662,-0.11113,-0.274765,-0.804532,0.458696,-0.184461,1.17323,0.199969,0.0896292,0.0407802,-0.128062,-0.317291,-0.640278,-1.0771,0.508405,0.0291542,-0.361222,-0.0235439,0.172101,-0.757601,-0.366084,0.372526,-0.824886,0.0718262,0.250552,-0.339884,-0.187002,-0.139205,1.06015,0.536459,-0.198127,0.809695,0.260701,0.29777,-0.650017,-0.136367,-0.371806,-0.782654,0.462421,0.487384,0.0150048,0.0497731,-0.17113,0.679364,-0.872754,0.538672,-0.62539,-0.263938,-0.353308,0.37846,-0.0962551,0.258479,0.893187,-0.0784443,-0.973303,-0.640833,-0.223651,-0.401843,0.0207759,0.489532,0.0652427,0.0266689,0.132215,0.516126,0.0152038,0.380195,0.345544,-0.539718,-0.216546,-0.680678,-0.0539171,0.113324,-0.297817,0.150058,0.187919,0.289343,-0.247528,-0.0994988,0.430593,-0.545393,0.150738,-0.228101,-0.591833,-0.195111,0.265081,0.0974455,0.104254,0.185905,-0.0561671,0.291637,0.533252,0.585585,0.292115,-0.406881,-0.247124,-0.0381668,0.395821,0.322593,0.209341,-0.0977253,0.565058,0.139144,-0.412178,-0.160614,0.256041,0.536164,-0.0899687,0.0975809,-0.322629,0.196707,-0.359369,-0.605052,-0.0865349,0.490722,0.0127594,-0.50295,0.13768,-0.0117771,0.67514,0.137375,-0.370002,0.0159923,-0.177714,-0.561148,0.0284926,0.0645635,-0.0962537,-0.488196,-0.245905,0.599387,-0.699907,-0.609554,-0.0472261,-0.315065,-0.584116,-0.657468,0.299632,-0.0503717,0.660234,0.103287,-0.116629,-1.00925,-0.156998,-0.128781,-0.369362,-0.206028,0.0195911,-0.0685292,0.198029,0.201279,0.282757,-0.389393,0.228428,0.363545,0.655393,0.11932,0.0884863,0.329437,-0.589355,-0.23215,0.0283128,-0.0314814,0.0756203,0.269242,0.133154,0.350568,-0.15234,0.198543,-0.331249,-0.100946,0.902942,-0.424795,-0.300681,0.179031,-0.302247,-0.0976338,-0.147416,0.349761,0.12628,-0.0410145,-0.246009,-0.253689,-0.0149383,-0.564548,-0.227198,0.053226,0.0850965,0.508662,0.0738683,-0.393589,0.236579,-0.199711,-0.167082,0.618664,0.178808,-0.231278,-0.239245,-0.246765,1.267,-0.2987,0.151509,0.123152,0.352282,0.18148,-0.141945,-0.299028,-0.0309963,-0.577489,0.284727,0.361125,-0.562655,-0.0502185,0.0707768,-0.107279,0.367448,-0.134837,0.510064,-0.594502,-0.176778,0.249127,-0.15518,0.520461,0.158478,-0.457347,0.220124,-0.789056,0.444112,-0.307954,-0.0460033,-0.0324243,-0.319433,-0.261772,-0.110434,-0.252133,0.216852,-0.0536467,0.263416,0.309722,0.32965,-0.344564,-0.250429,-0.128326,-0.573468,0.23928,-0.211663,-0.293913,0.2476,-0.144851,0.478067,-0.0136681,-0.26391,-0.0495571,0.446387,-0.19442,-0.379997,0.374641,0.103903,0.255691,-0.154592,-0.0126453,-0.06264,-0.303243,-0.425223,-0.402222,-0.1803,-0.43139,-0.252856,0.335849,0.197765,0.136186,0.191967,0.367083,0.1689,-0.347318,-0.114483,0.246174,0.30404,0.093695,0.419796,-0.483043,0.0637986,0.154784,0.11792,-0.213138,0.313979,0.390209,-0.466344,0.226313,-0.162651,-0.251672,-0.32995,-0.0666031,0.127109,0.271469,0.356523,0.521027,-0.103508 +3401.98,0.9791,0.0848144,4,1.51067,0.641197,-1.35804,0.546656,0.518181,-0.0340773,-0.29169,-0.318504,0.156436,-0.419273,-0.0674595,-0.104048,-0.340309,0.801489,-0.00666325,0.752697,-0.104399,0.482863,-0.0329627,-0.203293,0.0563238,-0.729496,-0.904007,0.706952,-0.147926,-0.515547,0.0706327,0.523125,-0.524465,-0.0902888,0.450017,-1.0928,0.227712,0.681653,-0.373774,-0.0633791,-0.345121,0.854444,0.258551,0.179219,0.981243,0.493565,0.415083,-0.577343,-0.0957571,-0.157169,-0.715828,0.283226,0.182088,0.477971,0.16158,-0.047305,0.324542,-1.11759,0.767514,-0.797483,-0.0216073,-0.864753,0.419059,-0.261285,0.158069,1.12053,-0.164494,-1.17003,-0.277586,0.503384,-0.152536,-0.294861,0.0607886,-0.309478,0.13543,-0.0500306,0.299844,-0.262262,0.0267147,0.509159,-0.112298,-0.596267,0.150707,0.375073,0.406639,-0.616273,-0.00567457,-0.116849,0.0372125,-0.34049,-0.313809,0.336305,-0.706324,0.50298,-0.22103,-0.0338967,-0.1814,0.351826,0.200532,-0.0152105,-0.170288,0.270057,0.353694,0.24578,0.607327,0.498096,-0.154287,0.117505,0.497232,-0.135581,0.855057,0.15695,-0.0569621,0.518796,0.266024,-0.192484,-0.122504,0.644625,0.547353,-0.188208,-0.250183,0.11695,0.042055,-0.0631017,-0.34976,-0.552814,0.599132,-0.19923,-0.416884,0.255949,0.154662,0.739995,0.360865,-0.522924,0.216495,-0.370376,-0.284624,0.155002,0.309045,-0.399465,0.162799,-0.150695,0.654497,-0.825107,-0.375132,-0.124817,0.0687971,-0.490921,-0.871857,-0.0975819,0.223914,0.474284,0.419957,-0.234362,-0.747097,0.199353,-0.146265,0.56537,0.0844073,-0.561486,0.457165,-0.374747,-0.109377,0.216694,0.0312565,-0.285989,0.391255,0.551658,0.11135,0.0219656,0.271223,-0.245586,0.0233467,-0.0385976,-0.176815,0.19202,-0.193392,0.160885,0.20751,-0.263296,-0.0795931,-0.261874,-0.243062,0.797034,-0.260045,0.0105542,0.051089,-0.418339,-0.275911,-0.0738369,0.416499,0.0450161,-0.179106,-0.17678,0.0144939,-0.0879887,0.0647291,0.129122,0.0115309,0.330825,0.646203,-0.416458,-0.494159,0.240349,-0.263668,-0.126455,0.139208,-0.340238,-0.0762109,-0.281718,-0.547201,1.41292,-0.173989,0.0962532,-0.190851,0.486172,-0.171389,0.308292,-0.662374,-0.215463,-0.823981,0.146611,0.711873,-0.103736,0.00872903,-0.270337,-0.414346,0.466427,0.0736588,0.478155,-0.330746,-0.347338,0.0766952,-0.0847147,0.352844,0.0352297,-0.102505,0.0392914,-0.37074,0.493655,-0.549413,0.0733057,0.207938,-0.52371,-0.281647,0.577359,-0.431787,0.341227,-0.588045,0.140453,0.35885,0.158662,-0.314822,-0.355479,-0.30757,-0.790482,0.742714,0.0431536,0.29481,0.251672,-0.532434,0.542061,0.42369,-0.227684,0.0557496,0.686788,-0.0511791,-0.323858,0.252101,0.313719,0.60735,-0.105091,-0.24236,-0.0015865,-0.67294,-0.00404864,-0.0952127,0.0240183,-0.412317,-0.200198,0.540836,0.119807,-0.599823,0.464797,0.501668,-0.0733442,-0.234863,-0.191544,0.168488,0.328876,-0.166614,0.448764,-0.448778,-0.138379,0.0245138,0.648903,-0.33379,0.23241,0.423336,-0.438469,0.179749,0.0032295,-0.0365642,0.210601,0.251398,0.120587,0.322164,0.347257,0.567595,-1.13956 +3391.23,0.987261,0.0848144,4,1.46521,0.536073,-1.13247,0.479969,0.573372,-0.136272,0.607778,0.315732,0.494904,-0.291956,1.0077,-0.103358,-0.149787,0.903997,-0.305628,0.745848,0.414382,-0.0587144,0.107305,-0.133329,0.493417,-0.550803,-0.916198,0.700168,-0.568212,-0.0597346,-0.0511101,0.193578,-0.567931,0.469775,0.663773,-0.827352,-0.0747613,0.31261,0.400055,-0.284891,-0.220315,0.591777,0.407646,-0.514332,0.875832,0.257255,0.391676,-0.180544,-0.000699508,-0.019387,-0.964292,0.181475,0.54559,-0.160245,0.249108,0.727848,0.36899,-0.437599,1.24433,0.0380211,0.29198,-0.322924,0.644306,0.383826,0.335236,0.972968,-0.524789,-1.31677,0.242899,0.0659905,0.0443318,-0.232793,0.508769,-0.641718,-0.367933,0.0132268,0.414307,0.261555,0.721906,0.436734,0.183984,0.365984,-0.121013,-0.437483,1.20659,-0.412903,0.381789,-0.256084,0.142343,-0.582893,-0.292153,0.450103,-0.0646317,-0.143964,0.731407,0.581544,0.312776,-0.34497,0.313272,-0.0967061,-0.491218,0.14568,0.172529,0.421278,0.0874976,0.389815,-0.23159,-0.379986,0.0539827,0.00291632,-0.220489,0.0241138,0.504777,0.611588,-0.346115,-0.566501,-0.201493,0.0204762,0.203826,-0.20003,-0.000456082,0.258771,0.0739322,0.0723807,-0.388418,-0.476263,0.107771,-0.882501,-0.61471,0.372378,0.107926,-0.0611269,-0.0970446,-0.305177,0.748926,0.010907,0.692237,0.499587,-0.268128,-0.416719,-0.461819,-0.0682406,0.277559,-0.572109,-0.0698844,-0.04086,0.387503,-0.0983152,0.0313519,0.309079,-0.577481,0.6861,0.425507,-0.5557,-0.433461,0.190262,0.143323,-0.254486,0.0451186,-0.607513,0.0354645,-0.5112,0.250408,-0.573223,-0.150326,-0.126014,1.00746,0.695783,0.168551,-0.297357,-0.28089,-0.185539,-0.667485,-0.742573,0.635318,0.218497,0.00949474,-0.030845,0.0831865,0.129976,-0.091888,-0.25358,0.284192,0.295326,-0.254349,-0.32487,0.349348,-0.292466,-0.435247,-1.00249,-0.631758,-0.580757,0.856854,-0.610425,-0.103104,-0.345888,0.0900632,-0.319291,0.350251,-0.204758,0.415469,-0.077515,-0.740963,-0.156009,-0.0799719,-0.20367,0.415386,0.119914,0.0155276,-0.245815,0.0397173,1.47876,0.784929,0.273855,0.164982,-0.214815,0.561977,0.553036,-0.347667,-0.12774,-0.0116801,0.137888,0.185395,-0.357797,0.356925,0.169567,-0.133661,0.510666,-0.0330666,0.74894,-0.604197,-0.00863079,0.527582,-0.0976194,-0.775765,0.0451545,-0.311541,-0.206817,-0.696379,0.515308,-0.0888722,0.0115515,0.660038,-0.398413,0.0903361,0.220314,-0.328777,-0.171095,0.331053,0.583676,0.190886,0.41004,0.265999,-0.727451,0.633414,-0.506243,0.328081,0.111017,-0.383481,0.927389,-0.403359,0.102319,0.085518,0.0666984,0.598551,0.60286,0.3003,0.236117,-0.0330946,-0.185193,0.0914732,0.0595091,0.173502,0.175969,-0.038596,-0.245139,0.238282,0.231504,0.608048,0.29835,0.242325,0.554818,0.501473,-0.19496,0.00840819,0.437911,-0.725578,0.126398,0.33226,0.410199,0.24234,-0.319901,-0.386993,0.527526,-0.137572,0.47514,-0.214611,0.413736,-0.355951,-0.459802,0.0600582,-0.236075,0.186224,-0.259021,-0.311289,0.162694,0.238479,0.403353,0.488343,-1.21211 +3398.93,0.957416,0.0848144,4,1.57345,1.03025,-0.865521,0.306212,0.938486,-0.0164959,-0.331219,-0.189354,0.0719209,0.0250334,0.266297,-0.124591,-0.260462,0.1189,-0.178722,0.816338,-0.203139,0.21962,-0.0854493,-0.151674,-0.526172,-0.801934,-0.221922,-0.0283878,-0.128105,-0.300109,-0.0833563,0.315179,0.152059,-0.323182,0.694931,-0.289167,0.0528643,0.207766,-0.0586989,-0.122673,-0.661156,0.429519,0.182884,0.00378127,0.685793,0.726987,-0.0260844,-0.426792,-0.099867,-0.62358,0.112261,0.305891,0.477438,0.25556,0.11554,0.279233,0.460442,-0.0280956,0.394756,-0.0671787,-0.37581,-0.930301,0.421779,-0.577203,-0.56151,0.430636,-0.20924,-0.329509,-0.167002,0.499408,-0.0243945,-0.219821,0.297664,-0.535875,0.183566,1.01484,0.649166,-0.556017,0.814606,0.499454,0.551747,0.12277,0.147267,0.457779,-0.0643692,-0.404022,0.00518014,0.153751,-0.79178,0.479472,0.210302,-0.335941,0.282539,-0.279564,-0.340124,0.232903,0.164068,0.29509,0.552739,-0.285994,0.997948,-0.482283,0.0376039,0.445683,-0.0556403,-0.02401,-0.903108,0.0893899,-0.271186,-0.285264,-0.118405,-0.300544,0.433498,0.376438,0.220247,-0.327051,0.401447,0.651452,-0.225514,0.448196,-0.313682,0.0989858,0.0588745,0.840441,-0.846849,0.357714,-0.382056,0.0813773,0.262679,-0.0347664,0.587856,0.630773,0.357372,0.134062,-0.33262,-0.118017,-0.0485214,0.546685,0.126229,0.506647,0.356893,0.428967,0.481102,-0.266304,-0.28893,-0.0100505,0.383736,-0.521253,0.129404,0.410165,0.247087,0.348535,-0.338669,0.555755,0.195315,0.168485,0.0518299,0.367336,0.967666,0.947771,0.730924,0.986555,0.136993,0.106462,0.506512,-0.0893411,0.433114,-0.127446,-0.0441775,-0.00892209,0.069034,-0.322835,-0.229439,0.669595,-0.443351,-0.399013,0.0775426,-0.440248,-0.0945238,-0.116229,-0.266379,-0.213283,0.572329,1.46413,-0.217275,0.263887,0.376,-0.0461707,-0.0169248,0.43844,0.261452,-0.197252,-0.135016,-0.0111667,-0.0402981,0.369193,0.390985,-0.43465,0.10288,0.569747,0.00677487,-0.369827,-0.418554,0.243441,0.0101289,0.235385,0.773363,0.475181,0.446502,0.295577,-1.10589,0.77412,-0.0696044,0.232061,0.215899,0.069602,0.208739,0.0901487,-0.513904,0.962037,-0.487436,0.351869,0.0500485,0.212097,-0.309125,-0.673261,-0.425461,-0.193884,-0.898659,0.15236,0.00465441,-0.594817,-0.824221,-0.315965,0.264121,0.267678,-0.0360398,0.330456,0.230292,0.55671,-0.357588,0.164424,0.715171,-0.487592,-0.237725,0.106122,0.395588,0.543795,0.52699,0.442699,0.316791,-0.38595,-0.285218,-0.0779046,-0.0291267,-0.322625,0.332077,-0.464375,0.234177,0.216503,-0.145388,0.296944,0.263417,-0.101312,-0.0482082,0.141469,0.386792,0.266184,0.0742998,0.404495,-0.053047,-0.252395,0.119371,-0.0603484,-0.395536,-0.136629,-0.394269,-0.170803,0.117365,-0.377988,0.0851737,0.0106119,-0.0459551,0.148458,-0.375883,-0.153686,0.137377,0.196373,-0.157043,0.250337,-0.791887,0.487785,-0.0866419,-0.719708,0.0670034,-0.639087,0.0469798,-0.197325,0.0974705,-0.766551,0.542218,0.360614,-0.413574,0.0149169,0.284097,0.163575,0.167544,0.404444,0.409321,-3.19507 +3400.83,0.778918,0.0848144,5,1.62547,0.869958,-0.645857,0.174475,0.47536,-0.234749,0.129626,0.220618,0.816671,0.16898,-0.408681,-0.41058,-0.0863494,0.41327,0.049458,0.749559,0.339706,0.175217,0.300709,0.0594318,-0.389162,-0.876981,-0.875149,0.290456,-0.158366,-0.323373,-0.062446,0.438023,-0.405782,-0.0163298,0.579971,-0.430532,0.193702,0.0579516,-0.0137114,0.469887,-0.128009,-0.0247432,0.231796,-0.155985,0.684164,0.171712,0.264154,-0.665629,-0.196469,0.0411938,-0.730196,-0.285689,0.449793,0.100172,-0.389019,0.457382,-0.432836,-0.791684,0.694424,-0.30857,0.0939569,-0.586366,0.734771,-0.707608,0.557826,1.08162,-1.00236,-0.995556,0.240307,-0.108523,-0.168134,0.277261,-0.062031,0.0713227,-0.679585,-0.314908,0.416662,-0.015369,0.494469,0.117375,0.391548,-0.0497612,-0.501702,0.00494559,0.376727,-0.1954,0.086532,-0.348951,0.265681,-0.325488,-0.0333958,0.0786772,-0.188282,-0.277282,0.207063,-0.0248943,0.0351531,-0.301971,-0.370607,-0.295675,-0.891443,-0.129617,0.34769,0.240827,0.265555,-0.087505,0.0626228,-0.844336,0.273109,-0.409447,0.633744,-0.210002,0.362998,0.690369,-0.333613,0.115605,-0.257834,0.541977,0.317339,-0.213,-0.292014,0.142925,0.366265,-0.69228,-0.419339,-0.632141,-0.0554299,-0.399624,-0.33347,0.244629,0.0110595,-0.32647,0.331618,-0.916562,0.362951,0.0599488,-0.307516,0.59477,-0.531927,-0.418427,-0.157322,-0.51967,0.537966,-0.709357,-0.356115,0.079637,-0.0505017,-0.496447,0.16029,-0.102124,-0.337332,-0.370678,0.128728,-0.905097,-0.501591,0.213621,0.276711,-0.345501,-0.678538,-0.111736,-0.275482,-0.992982,0.178208,-0.00135706,-0.128265,-0.217796,0.715447,0.0772763,-0.0330168,0.273642,-0.230841,0.343517,-0.046229,-0.99495,0.650011,0.327325,-0.11295,0.331669,0.135196,-0.261107,-0.424221,-0.088839,0.0558151,0.326132,0.217764,-0.64876,-0.0278165,-0.237947,-0.159827,-0.846889,-0.747087,0.0106328,0.40199,-0.593362,-0.271318,-0.638763,-0.26149,-0.807716,0.269803,0.0444094,0.254313,-0.268397,-0.684551,-0.211568,0.0815763,-0.578351,-0.927176,-0.267846,-0.364052,-0.349309,0.138869,0.954104,-0.0286571,0.0668456,0.131734,-0.387742,0.0376027,0.107526,0.24178,-0.569412,0.120854,0.0935573,0.60554,-1.00167,0.158646,-0.317696,0.376053,0.487862,0.284805,0.353173,-0.464577,0.322022,0.925821,0.510931,-0.620363,0.159998,-0.287037,-0.644445,-0.82087,0.200418,0.571038,-0.0921858,0.330349,-0.146975,-0.0140329,-0.0520771,-0.349194,-0.660788,0.272863,-0.234388,0.750496,0.678734,0.175479,-0.554476,-0.292305,-0.625721,0.352459,0.268231,-0.414581,0.352034,-0.132083,-0.412324,-0.143089,-0.168875,0.529834,0.14719,0.117069,-0.0589923,0.341968,-0.241201,0.207708,-0.159462,-0.1367,-0.0614603,0.0261391,-0.169799,-0.493766,0.0692961,-0.129486,0.474502,0.215074,0.0857265,0.430775,-0.372446,0.106281,-0.708182,-0.724778,-0.305015,0.0360178,0.299952,0.345064,-0.0501354,0.0497815,0.428332,0.267239,0.765449,0.271177,0.333886,-0.469068,-0.0311073,-0.293267,-0.447412,-0.0189951,-0.340907,-0.35189,0.16331,0.248863,0.404117,0.498862,-1.2581 +3414.36,0.998956,0.0848144,4,1.68123,0.777316,-0.811984,0.325864,0.558212,-0.113863,0.251265,0.256012,0.618082,0.566449,-0.303372,-0.432723,-0.150113,0.333634,0.0210821,0.782596,0.355471,-0.0389779,0.118279,0.267416,-0.16849,-0.742859,-0.56359,0.276068,0.0167766,-0.315212,0.0968106,0.605043,-0.662736,0.134983,0.705311,-0.509821,0.0389228,0.20093,-0.15764,-0.317667,-0.123667,0.240138,0.346763,-0.106221,0.787769,0.237041,0.429459,-0.611732,0.0857961,-0.130459,-0.781871,-0.110773,0.449353,-0.0839325,-0.348226,0.283923,-0.437537,-0.763832,0.386889,0.0639795,0.0455343,-0.510694,0.445778,-0.799854,0.376862,0.871726,-0.704924,-0.802492,0.383197,0.0643371,-0.163755,0.0711978,0.211424,-0.0728363,-0.712306,-0.0238011,0.441395,0.349923,0.395979,0.102501,0.0364299,-0.457066,-0.41763,0.20769,0.408503,-0.208803,-0.0811473,-0.322067,0.35626,-0.524651,-0.00601888,-0.528271,-0.31681,-0.414936,-0.26223,0.0303922,0.118521,-0.140326,-0.448791,-0.422037,-0.6236,-0.272319,0.235767,0.0748583,0.226,0.33155,-0.177213,-0.44522,-0.185168,-0.605979,0.859529,-0.254878,0.298938,0.872669,-0.276785,-0.0546425,-0.00332206,0.782083,-0.11353,-0.00129956,0.0157886,0.101236,0.575181,-1.01615,-0.794369,-0.397168,-0.205438,-0.639647,-0.0169634,-0.0540071,0.423313,0.0156429,0.869594,-0.274064,-0.148054,0.254741,-0.464818,0.596958,-0.256848,0.0409493,-0.396928,-0.82819,0.415297,-0.284498,-0.562214,0.017449,0.0298306,-0.34728,0.161843,0.323747,-0.343641,-0.0665164,0.0863545,-1.32663,-0.443599,0.258237,-0.120309,-0.0945725,-0.498661,0.0524553,-0.155524,-0.081308,0.0593584,-0.183706,-0.369055,-0.179992,0.661078,-0.171582,-0.247416,0.213234,-0.210451,0.0550387,-0.349607,-1.2629,0.681728,0.0765355,0.182065,-0.0548894,0.00561307,-0.683461,-0.45526,-0.489651,-0.344571,0.353558,0.122266,-0.264448,-0.181004,-0.293462,-0.294222,-0.804231,-0.791816,-0.014443,0.359463,-0.284873,-0.168821,-0.260198,-0.388217,-0.665453,0.288419,0.143134,0.151343,0.0757094,-0.561343,0.204998,0.0273411,-0.32501,-0.830884,0.0263805,-0.176274,0.0413973,0.021706,0.920725,-0.504168,0.0365418,0.118298,-0.210523,0.225528,-0.197492,0.398781,-0.288999,0.0377665,0.0130883,0.511782,-0.898157,0.566521,-0.106349,0.441352,0.428705,-0.346966,0.317107,-0.524791,0.162755,0.581136,0.389911,-0.345715,0.340646,-0.263812,-0.16036,-0.397942,0.318711,0.255218,-0.178911,0.567179,-0.504804,0.0887538,-0.229221,0.304549,-0.478679,0.0887189,-0.333611,0.973508,0.47139,0.129327,-0.739356,-0.152831,-0.70729,0.0541067,0.0152013,-0.0320484,0.218353,-0.116306,-0.020737,0.181923,-0.426072,0.43625,0.319728,-0.046333,-0.230678,0.421986,0.0979811,0.171695,-0.558557,-0.131312,0.224548,-0.0341542,-0.0361437,0.167631,0.122554,-0.273433,0.0579356,0.166028,0.00965141,0.292318,0.0435403,-0.340262,-0.423542,-0.972469,-0.232318,0.122977,0.148296,0.31567,0.295181,0.393644,0.287199,0.367755,0.618519,0.57159,0.539977,-0.341033,-0.248375,-0.634811,-0.242129,-0.274477,-0.430864,-0.417548,0.169099,0.187261,0.411217,0.432736,-1.40012 +3407.71,0.985386,0.0848144,5,1.45602,0.790236,-1.65539,0.738197,-0.0106969,-0.208128,0.0478919,-0.118291,-0.0038882,0.0141289,-0.120435,0.0331922,-0.161425,0.885253,0.192842,1.10223,0.726616,-0.13298,-0.332631,0.370638,-0.104781,-0.668516,-0.702098,0.545999,-0.280131,-0.352307,-0.0620663,-0.0756773,0.0610753,0.149593,0.555705,0.0933085,-0.394688,0.666465,-0.61606,-0.275733,-0.507558,0.882731,0.469525,-0.725828,0.597955,0.803738,0.432242,-1.14956,-0.652421,-0.0223916,-0.414592,0.270413,0.752603,0.00686774,0.330811,0.434024,0.336542,-0.202754,0.00952991,-0.0995493,-0.696035,-0.518057,0.0236962,0.432971,0.711807,1.11212,-0.2318,-0.758243,0.0364386,0.068523,0.336339,-0.625186,-0.240937,-0.211173,0.570624,0.631569,0.334473,-0.77322,0.378593,0.0997142,0.771564,0.221839,-0.0346549,0.0108093,0.37075,-0.664105,0.294802,0.112169,-0.536757,0.529576,-0.437457,-0.0100341,0.381589,0.0729507,0.0480143,0.31785,-0.145998,-0.116916,0.773845,0.041224,0.765858,-0.353554,0.138402,0.643252,-0.0498921,-0.355984,-0.582133,0.0252782,0.611216,0.0605778,-0.223353,-0.482536,0.22204,0.507777,0.266483,0.00326427,0.674094,0.348992,-0.267447,0.548847,-0.479697,-0.104362,-0.251188,0.168243,-0.45648,-0.281311,0.316122,0.367916,-0.316016,0.375008,-0.125323,-0.30421,0.235733,0.119496,0.556475,-0.552502,0.135276,0.0752262,-0.655307,-0.137098,0.300301,0.236308,0.537535,-0.825447,-0.100718,-0.313484,0.0233547,-0.288551,0.0720054,-0.362925,0.316908,0.425812,-0.0262075,0.78631,0.266038,-0.0759504,0.331182,-0.10219,0.64211,0.391097,0.190879,0.0568067,0.336728,0.189456,0.433836,0.203041,0.650578,-0.118308,0.273613,0.522467,-0.360579,-0.107447,0.264807,0.812657,-0.0682443,-0.165308,-0.0451066,-0.152437,-0.350505,0.260492,-0.193885,0.293415,0.0336726,0.664208,-0.277342,0.112019,0.516881,-0.166919,-0.209616,0.292049,0.282379,0.262481,-0.0028071,-0.78875,-0.0429922,-0.0810531,-0.0698974,-0.802998,0.00530166,0.516247,-0.0254153,-0.278775,-0.153147,0.181136,-0.433005,-0.207792,1.07345,-0.15583,0.164731,-0.151837,-0.916903,1.22176,0.181975,0.488678,-0.160991,-0.190084,0.43451,0.376661,-0.427348,0.710996,-0.315225,0.530317,0.142851,0.0981629,-0.535306,-0.346875,0.0496427,0.346913,-0.40401,0.129034,-0.0523822,-0.397925,-0.056076,-0.308189,-0.0566607,-0.0316728,-0.128494,0.10541,-0.471814,0.310479,-0.224737,0.0357597,0.130183,-0.0987053,-0.310576,0.600288,-0.205736,0.428246,0.325281,0.550666,0.759338,0.164506,-0.0614386,-0.168652,0.157273,-0.617781,0.216067,0.0187798,-0.195272,0.419529,-0.0040077,-0.0013981,-0.270446,0.456385,-0.367131,0.356463,-0.0401046,0.388395,0.115953,0.206923,0.330414,0.124713,-0.188494,-0.108361,-0.344343,-0.437918,-0.588461,0.174983,0.349469,0.343973,0.394832,0.662508,0.156829,0.226517,0.210448,0.641254,0.108635,0.681307,-0.0960766,0.0922173,-0.144606,0.221115,0.0357696,-0.312822,0.247106,-0.453808,-0.150204,-0.26031,0.173963,-0.39334,0.593022,0.0730591,0.0937313,0.117333,0.165069,0.150617,0.330494,0.388094,0.574886,0.316153 +3396.41,0.856179,0.0848144,4,1.51001,0.805851,-1.45733,0.612975,-0.334211,-0.157864,0.130087,0.0292322,-0.0921268,0.561121,-0.592084,-0.234858,-0.534732,0.772541,0.234922,1.01714,0.694321,-0.113143,-0.54266,0.325362,-0.199839,-0.468775,-1.04412,0.426306,-0.209047,-0.444606,-0.295487,0.34223,-0.457113,-0.0410654,0.827575,-0.306516,-0.294099,0.503014,-0.566858,-0.187527,-0.358619,0.559947,0.418028,-0.177383,0.907722,0.76934,0.2473,-0.953444,-0.726316,-0.21086,-0.639154,0.360105,0.650229,-0.0793593,0.478154,0.246017,0.00650641,-0.385573,0.0712151,-0.245861,-0.774161,-0.119781,0.224769,-0.0713343,0.508757,0.696746,-0.457099,-0.626656,-0.213683,-0.126419,0.557847,-0.779237,-0.04301,0.240103,0.0135817,0.659844,0.772822,-0.533477,0.514235,0.0549433,0.5299,0.374514,-0.868389,0.0410775,0.148094,-0.975958,0.180263,0.450851,-0.158444,-0.213594,0.0352654,-0.27897,0.0800809,-0.072901,-0.306916,-0.111893,-0.486036,-0.140266,0.356512,0.0567928,0.591736,-0.346333,0.739841,0.379529,0.0286131,-0.328801,-0.110564,0.487539,-0.0687866,-0.129828,-0.0090692,-0.290139,0.192553,-0.0986499,-0.200141,0.108989,1.16826,0.461343,-0.561629,0.45749,-0.391517,0.362665,-0.138318,-0.432263,-0.705029,-0.192542,-0.361001,0.117013,-0.0249283,0.353431,0.151618,-0.222132,0.776311,-0.302529,0.846029,0.0384194,0.0913814,0.526045,-0.61894,0.146839,-0.357036,-0.146092,0.330931,-0.816363,0.433585,0.207742,0.251896,-0.429833,-0.154657,0.224068,0.514045,0.291613,-0.286736,0.457134,0.280379,-0.287172,-0.341519,0.142251,0.398157,0.608207,0.665139,0.104286,0.206981,0.217022,0.0643296,0.223454,1.19297,-0.363838,-0.630089,0.614657,-0.323028,-0.168874,-0.439792,0.110007,0.0756234,-0.120125,0.0632777,0.0701893,-0.229481,-0.0819,-0.349802,0.121477,0.587272,0.748861,0.0302072,0.334101,0.570822,0.0171379,-0.0434917,0.166746,-0.389172,0.168489,-0.338885,-0.846613,-0.0214054,0.382041,-0.0576371,-1.1527,0.36602,0.0803314,0.48835,0.232336,-0.642299,0.192288,-0.323262,0.167813,0.329384,-0.296667,0.538796,0.291117,-0.409147,1.35119,-0.623475,0.69032,0.0492317,-0.0961455,0.480793,-0.0374269,-0.447793,0.237423,-0.342143,0.386946,0.714562,0.121523,-0.296922,-0.393043,-0.71732,0.575687,0.162516,-0.0216709,-0.157263,-0.547001,0.22064,-0.3076,-0.410749,0.15431,-0.393578,0.120126,-0.472032,0.0917833,-0.0345762,0.24656,0.553322,0.0289365,-0.393671,0.549318,-0.0236928,0.572255,0.105497,0.528904,0.813854,0.43796,0.178303,-0.224249,-0.0605104,-0.332121,0.50512,-0.353149,0.00190097,0.183354,0.267047,0.371265,0.208542,0.327755,-0.252641,0.59751,0.458311,0.0421593,-0.071924,0.203405,0.00355149,0.366158,-0.711308,-0.494446,0.00740227,-0.131114,-0.751668,0.271648,0.227993,-0.338473,0.510341,0.115696,-0.209189,0.138819,-0.126621,-0.113031,-0.250998,0.469909,-0.248093,-0.305615,-0.167667,0.604181,-0.044195,0.0607379,0.0953878,-0.400457,0.708699,-0.139541,-0.149194,-0.413347,0.0096653,0.469653,0.0777732,0.139917,0.042092,0.151976,0.324184,0.389841,0.569372,1.41866 +3393.55,0.987908,0.0848144,5,1.55436,0.731759,-1.29597,0.395425,-0.282168,-0.0984822,0.225388,0.103001,0.276064,0.0951006,-0.138722,-0.449842,0.247341,0.572225,0.0576343,0.167855,0.294049,-0.284156,0.137153,-0.00451606,-0.27083,-0.564318,-0.370644,0.279293,-0.373782,-0.335473,0.0568202,-0.29118,-0.518036,-0.519854,0.445265,-0.644147,-0.286394,0.213599,-0.722296,0.34678,-0.409524,0.459497,0.312562,-0.368182,1.03857,0.59401,0.160318,-0.606414,0.481215,-0.0442458,-0.0417547,0.221944,0.703684,-0.0698022,0.113813,0.73684,0.316226,-0.161269,0.662992,0.354868,0.0498396,-1.03323,0.297137,0.144086,-0.000906352,0.438264,-0.73481,-0.464206,0.662807,0.203349,-0.750841,0.47459,0.214873,-0.748532,0.0384945,-0.258666,0.529584,0.103053,0.72374,0.338372,0.0912702,-0.310808,0.445113,0.154707,0.424539,0.345123,0.441093,-0.653279,-0.0936612,0.051358,-0.119881,-0.157023,0.180001,-0.296813,0.818782,0.198376,0.0205715,0.316693,-0.0593555,-0.378785,-0.107164,-0.166928,-0.740986,0.497404,0.0774425,0.44047,-0.675157,-1.19905,0.75755,-0.903638,0.563119,-0.584415,0.395041,0.962725,0.17634,-0.440928,-0.703578,0.528511,0.375677,-0.034626,0.0155302,-0.265043,0.352057,0.601019,-0.136293,0.385201,-0.536785,-0.335071,-0.363344,-0.107324,0.110508,0.336697,-0.086875,-0.231001,-0.733814,0.0909518,-0.0699994,0.616782,-0.0942623,-0.313803,0.0340303,-0.00955241,0.560916,-0.482022,-0.890037,-0.169759,-0.136875,-0.927586,0.0138335,-0.04793,-0.367238,0.49968,0.412354,-0.426014,-0.384561,-0.117511,0.798897,-0.173562,0.112482,0.431334,-0.277948,-0.269005,0.312692,-0.217096,0.55642,-0.562142,0.192838,0.815738,0.442788,-0.165974,-0.24047,0.0124915,0.012876,-0.321796,0.214725,0.215828,0.149421,-0.19341,0.254287,-0.0493653,-0.276345,-0.352635,-0.00562901,1.15457,0.328904,-0.579221,0.135972,-0.409294,-0.0763598,-0.706421,0.00586295,-0.37548,0.695352,0.0975189,0.223909,-0.460428,0.271895,-0.254916,-0.22767,-0.0985571,-0.227794,-0.631149,-0.739719,-0.110363,0.408077,-0.652977,0.143606,0.185812,-0.708897,-0.21608,-0.380766,1.06989,0.890712,-0.564524,-0.520673,-0.106262,-0.0725496,0.254767,-0.129137,0.155053,-0.213655,0.317657,-0.223732,-0.660938,0.183045,-0.363114,0.340742,-0.403656,-0.659879,0.406748,-0.388519,-0.0410688,-0.270335,0.293043,-0.146842,0.0910653,-0.362244,-0.253572,-0.229185,0.646705,-0.115986,-0.0597713,0.866659,-0.523443,0.0200596,-0.0494998,-0.192355,-0.734497,0.239977,-0.615033,0.444666,0.0306373,-0.352309,-0.149757,-0.011791,-0.368113,-0.0526937,0.0477694,-0.271463,0.569521,-0.561933,-0.743317,0.155046,0.0644586,0.482084,0.0714139,-0.0424577,0.226933,0.717801,0.24996,0.396071,-0.289038,0.593204,0.0905223,-0.0600784,-0.1533,0.552591,-0.133991,-0.0245891,0.308367,0.163829,0.113172,0.946771,-0.0570813,-0.0663364,0.135778,-0.32928,-0.0852003,0.0634325,0.803926,-0.0819284,-0.403852,0.227232,-0.0336384,0.115672,0.499899,-0.239439,0.444263,-0.0208998,-0.416559,-0.114583,-0.0414425,-0.522282,-0.208133,0.0360783,0.173561,0.267752,0.416607,0.517447,1.52792 +3392.6,0.745567,0.0848144,4,1.56474,0.773254,-1.3628,0.387414,-0.267755,-0.0658464,0.236641,0.0155958,0.30597,0.0529885,-0.103027,-0.518871,0.363259,0.571402,0.0264113,0.236299,0.332528,-0.31803,0.176323,-0.0262687,-0.238159,-0.658538,-0.46751,0.238222,-0.371137,-0.335267,-0.0434462,-0.33313,-0.585675,-0.523526,0.451055,-0.595675,-0.281698,0.195818,-0.763875,0.462063,-0.393028,0.515986,0.287963,-0.425827,1.05801,0.633597,0.115113,-0.61331,0.45353,-0.0102628,-0.0661647,0.20823,0.666351,-0.112836,0.145656,0.778846,0.290135,-0.129279,0.622498,0.460244,0.0886114,-1.05812,0.281676,0.0844555,-0.0175731,0.493463,-0.665503,-0.426765,0.755431,0.315034,-0.794421,0.478576,0.218375,-0.759058,0.021529,-0.278353,0.474591,0.131533,0.774337,0.339275,0.103059,-0.276489,0.496091,0.157453,0.379265,0.278816,0.452238,-0.690758,-0.0313526,0.0757867,-0.0947743,-0.194135,0.173499,-0.220076,0.695792,0.162839,0.00092981,0.32178,-0.00262487,-0.383427,-0.11421,-0.107525,-0.735232,0.543005,0.135108,0.49041,-0.67158,-1.16518,0.81688,-0.914472,0.542201,-0.600657,0.284511,0.949056,0.184856,-0.386934,-0.665799,0.519963,0.444568,-0.00407316,0.0492705,-0.303746,0.391203,0.544414,-0.22763,0.406574,-0.521792,-0.407573,-0.358782,-0.0956553,-0.0559354,0.291327,-0.0850968,-0.214453,-0.678367,0.134818,-0.0451331,0.607223,-0.228292,-0.303475,-0.123744,0.00920552,0.597381,-0.511776,-0.821584,-0.0791709,-0.113081,-0.998106,0.0267667,-0.0082494,-0.388141,0.548008,0.476849,-0.395189,-0.357116,-0.152231,0.843221,-0.101636,0.0475629,0.495294,-0.278323,-0.215696,0.251148,-0.270589,0.570736,-0.508124,0.183212,0.75727,0.426431,-0.125134,-0.282188,-0.0539126,-0.103871,-0.333792,0.23436,0.252299,0.186592,-0.0799783,0.3232,0.0319675,-0.318514,-0.40531,-0.024018,1.12412,0.2772,-0.584586,0.152682,-0.428926,-0.107109,-0.669705,0.0942474,-0.449166,0.742924,0.0606644,0.194202,-0.53731,0.246439,-0.245951,-0.281178,-0.0876331,-0.176813,-0.620072,-0.737335,-0.0437584,0.400467,-0.618194,0.168141,0.110099,-0.686671,-0.188164,-0.40944,1.07051,0.780668,-0.528191,-0.516346,-0.0894196,-0.0735199,0.278822,-0.142865,0.138862,-0.328614,0.347628,-0.134623,-0.658828,0.140287,-0.343787,0.267887,-0.362778,-0.734681,0.317568,-0.385317,-0.0223127,-0.278271,0.273227,-0.154517,0.0771822,-0.385033,-0.205543,-0.335312,0.62838,-0.169248,-0.00691561,0.904764,-0.533342,0.145003,-0.0757825,-0.220253,-0.703478,0.21264,-0.523793,0.446773,-0.029761,-0.377871,-0.151764,0.0036493,-0.339047,0.0447755,0.142622,-0.274827,0.529549,-0.619221,-0.813601,0.0797491,0.0493693,0.468255,0.124597,-0.0353127,0.196404,0.736911,0.204704,0.418206,-0.360268,0.550551,0.0212579,-0.124102,-0.132987,0.472344,-0.120357,-0.0619698,0.220854,0.201404,0.119698,0.947406,0.0019344,0.0355666,0.241078,-0.386004,-0.0676387,0.0208294,0.831494,-0.0855159,-0.371679,0.248742,0.0875982,0.0997673,0.4808,-0.309523,0.578651,0.0693128,-0.398118,-0.0748994,0.0387762,-0.440376,-0.244233,0.0526087,0.169311,0.254367,0.411474,0.504348,1.45164 +3397.34,0.96288,0.0848144,4,1.52142,0.700442,-1.61132,0.559237,-0.121015,-0.0889031,0.0312065,0.470229,-0.0742394,-0.136354,0.153908,-0.299923,-0.297443,0.501292,0.281536,0.25265,0.345907,0.232172,0.00501338,-0.108618,-0.172141,-0.595215,-0.454996,0.242366,-0.374397,-0.271928,-0.214721,-0.0734892,-0.428875,-0.228429,0.49004,-0.981873,-0.0101925,0.154392,-0.702672,-0.0610272,-0.253584,0.356864,0.572998,-0.393801,0.869312,0.810156,0.56748,-0.646708,0.141602,-0.279444,0.111566,0.760002,1.02884,-0.0415825,0.159912,1.0663,-0.0876146,-0.50362,0.484926,-0.515087,0.092169,-0.588451,0.514901,0.457521,0.00402606,0.839309,-0.392095,-0.610852,0.826132,0.0398288,-0.476181,0.31103,0.649686,-0.457772,0.0258033,-0.114861,0.500759,-0.219258,1.12403,0.315948,0.314746,0.264449,-0.0273434,0.0892998,0.402336,-0.146081,0.208443,-0.208561,-0.853683,0.267479,0.0308957,0.032268,0.217632,-0.0922495,0.729744,-0.180319,0.0600731,0.501076,-0.0973863,-0.496178,0.134141,-0.434778,-0.0200161,0.374987,0.237732,0.287453,-0.84111,-0.995122,0.770542,-0.623471,0.635243,-0.19308,0.428277,0.68019,0.161328,-0.484704,-0.345546,0.540372,0.347905,-0.0165716,0.0711149,0.20517,-0.114534,0.0828414,-0.47818,-0.203483,-0.302909,-0.083808,-0.0418791,-0.111756,-0.227203,0.262903,-0.0557879,-0.562645,-0.310902,0.384918,0.0408852,0.772294,-0.0393697,-0.143551,-0.531451,-0.108198,0.494813,0.139316,-0.698978,-0.0948551,0.0339737,-0.807747,-0.282594,0.0621763,-0.102774,0.627658,0.418535,0.198539,-0.564912,0.299626,0.865322,-0.246771,0.106039,0.251979,0.269109,-0.67736,0.278963,-0.13381,0.839031,0.0108509,0.37548,0.88924,0.149184,0.232509,-0.319651,0.0505124,0.246866,-0.240937,0.550203,0.107978,0.0813925,-0.22062,0.141444,-0.078825,-0.209872,-0.0270895,0.36889,1.06542,-0.00457408,-0.97695,0.507903,-0.75327,-0.0870636,-0.623523,0.069769,-0.112878,0.342243,-0.251753,0.344742,-0.905135,0.284443,-0.187967,0.142626,-0.574916,-0.170257,-0.199457,-0.163967,-0.0873328,0.271598,-1.11204,0.192834,0.101272,-0.576268,0.291379,-0.28455,1.43095,0.553923,-0.325112,-0.157863,0.148016,0.00349145,0.0592584,-0.31418,-0.00856537,-0.877002,0.175686,-0.25523,-0.390608,0.385232,-0.647726,0.271414,0.203734,-0.742849,0.305683,-0.512407,0.438047,-0.4359,0.772796,-0.138057,0.256027,-0.715126,-0.379779,-0.309985,0.226921,-0.0473378,0.137671,0.925444,-0.366353,0.0206703,0.0449254,-0.21098,0.026033,0.506074,-0.277229,0.116506,0.328813,-0.737063,-0.215156,-0.173757,-0.161928,0.291933,-0.112401,-0.0593799,0.212444,-0.644065,-0.549832,0.0121756,0.128698,0.17281,0.242757,-0.0475689,0.42916,0.433082,0.342918,0.144361,-0.0766063,0.165184,-0.259529,-0.139535,-0.563559,-0.698735,-0.0445854,0.289403,0.659617,0.128755,0.288637,1.15065,0.244589,-0.258367,0.62128,-0.0203555,0.190435,-0.289267,0.574517,0.301934,-0.63126,0.599121,-0.112696,0.100525,0.412588,0.123062,0.253825,-0.0139049,-0.132383,-0.026394,0.157619,-0.200174,0.223906,-0.434372,0.180904,0.214441,0.425328,0.463078,1.02329 +3379.85,0.975883,0.0848144,5,1.46661,0.851287,-1.17705,0.497132,0.241735,-0.000707246,-0.0657971,0.0159207,-0.0264537,0.0909374,-0.182872,0.18501,0.296587,0.454335,0.17287,0.506794,0.0583247,-0.305696,0.0283155,0.348099,-0.0532079,-0.844843,-0.582566,0.271967,-0.00949547,-0.284382,0.350092,0.437437,-0.249919,0.272641,0.676535,-0.282179,0.437559,0.319427,-0.575883,0.291814,0.128919,0.853572,0.527564,-0.0878976,0.647607,0.875798,0.0313076,-0.841248,0.237631,0.23612,-0.842634,0.139657,0.390273,-0.199041,0.0325166,0.287572,-0.0788416,0.10382,0.109027,0.193752,-0.131656,-0.420328,-0.0328953,-0.431408,0.673592,0.583277,-0.33283,-0.522971,-0.334071,0.630404,-0.354093,0.657354,0.717602,-0.37033,0.160091,0.847683,0.928105,-0.261611,0.619899,0.841489,0.290422,-0.182153,-0.71012,-0.174345,0.84183,-0.359713,0.238785,0.230966,-0.795171,0.0250397,0.0620635,0.0217148,-0.0587368,0.125512,-0.264812,0.0529979,-0.0744487,0.189966,-0.156283,0.0431469,0.702099,-0.37395,0.356127,1.03822,-0.122476,0.209172,-0.741978,-0.775669,1.14178,0.105423,0.292174,-0.52842,0.666827,0.569113,-0.52794,-0.396826,0.318428,0.771234,-0.314785,0.173674,0.0158597,0.304491,0.612964,0.112188,-0.70224,-0.249172,-1.00414,0.240865,0.448993,0.63785,0.75394,-0.00144957,0.17214,-0.462809,0.211544,-0.111671,-0.392622,1.26282,-0.221646,-0.247121,0.395145,-0.264925,0.492053,-1.32284,-0.574731,-0.0862503,0.380933,-0.0338791,-0.136758,0.598679,-0.227541,0.435776,-0.0994752,-0.624959,-0.0283059,0.603335,0.177168,-0.207393,0.31481,0.409912,0.487726,-0.470768,0.656883,0.444817,0.273217,0.462111,0.678276,0.346861,-0.194929,-0.502488,-0.930438,0.0936882,0.0161086,-0.238959,0.560432,0.503567,0.315179,-0.394376,0.0176128,-0.59568,0.237422,-0.179593,0.0173091,1.2508,-0.469224,0.132437,0.240118,0.0785154,-0.225178,-0.996081,0.106659,-0.01054,-0.128103,-0.708048,-0.0999118,0.319252,0.0244098,-0.865904,0.264728,0.221058,0.334343,-0.105647,-0.679079,-0.159027,-0.156366,-0.221842,0.852646,0.0289525,0.37313,0.121073,-0.451309,1.13975,-0.150057,0.0874028,0.159417,0.217845,0.461136,-0.541981,-0.212987,-0.480339,-0.2745,0.715942,-0.0153537,-1.1773,0.189321,-0.263038,-0.752081,0.174054,-0.175612,0.129472,-0.0701045,-0.621336,0.291337,0.41343,-0.209707,0.311684,0.203711,-0.166861,0.0523878,1.07359,0.141997,0.0179184,0.620191,-0.412595,-0.451658,0.188467,-0.0185615,-0.27103,0.805477,0.595406,0.850136,-0.588803,-0.236252,-0.270068,-0.0616411,-0.519062,0.189405,-0.174888,-0.284836,0.391646,0.00780913,-0.0579513,-0.105726,-0.0518618,0.445454,0.666273,0.262812,-0.424211,0.0456415,-0.154659,0.353052,-0.320669,-1.15732,0.126553,0.380191,-0.0664246,0.0678075,0.505241,-0.269057,0.615168,0.623392,-0.215224,0.345138,0.00740904,-0.626306,0.0858448,-0.410062,-0.304985,0.32467,0.157255,-0.265249,0.593627,-0.204354,-0.282392,0.240746,0.485815,-0.411761,0.188573,0.0242034,-1.13481,-0.205474,0.569224,-0.280866,0.0120098,-0.129359,0.192343,0.17093,0.438569,0.413437,-0.69377 +3401.7,0.996349,0.0848144,4,1.48285,0.892545,-1.0226,0.457626,0.479628,-0.117301,-0.0521465,-0.0503645,-0.036894,0.0546867,-0.213597,0.197321,-0.330406,0.315694,-0.189153,0.546822,0.228269,-0.0857551,-0.246292,0.063461,-0.0793992,-0.635813,-0.220482,0.449967,-0.265882,-0.398659,0.459874,0.4594,0.0368419,0.287514,0.734883,-0.079247,0.34975,0.362131,-0.670915,-0.114121,-0.140028,0.258853,0.387315,-0.14403,0.426678,0.634241,0.650793,-0.904825,0.0496661,0.201001,-0.63504,0.302914,0.407501,-0.119671,0.104638,0.0714348,0.0117868,0.00423072,0.0956244,-0.116585,0.201291,-0.483007,-0.070698,-0.532954,0.677435,0.316866,-0.329169,-0.204253,0.198983,0.728976,-0.408514,0.735764,0.791459,-0.238083,-0.163291,0.889276,0.831469,-0.408447,0.845697,0.803465,0.498223,-0.0335746,-0.913477,-0.348477,0.642076,-0.0498057,0.32156,0.170525,-0.751938,-0.492396,0.0745907,-0.29698,-0.189575,0.0935691,-0.609754,-0.090143,0.117147,0.200631,-0.157137,-0.24896,0.960984,-0.125763,0.174274,0.6302,-0.210105,0.201298,-0.678012,-0.348823,1.06845,-0.172183,-0.000180596,-0.234945,0.700541,0.75458,-0.18826,-0.494948,0.268688,0.574679,-0.250835,-0.37814,-0.0634456,0.0583543,0.627793,-0.119824,-0.478866,-0.583701,-0.543576,0.392747,0.50702,0.41461,0.516883,0.0401407,0.307434,-0.511918,0.185826,-0.189663,-0.444057,0.802141,0.0375957,0.00622513,0.0562865,-0.202439,0.500089,-1.35926,-0.864819,0.00256953,0.444271,-0.652541,-0.456207,0.593897,-0.291869,0.223534,-0.167166,-0.549937,-0.378761,0.294737,0.318651,-0.446084,0.576741,0.229757,0.125441,-0.784881,0.758569,0.313537,0.137046,-0.104444,0.0965865,-0.0756386,0.251304,-0.185515,-0.360776,0.0359014,0.0032497,-0.925903,0.2382,0.0508193,0.260798,-0.50666,0.0628021,-0.640732,0.113925,-0.134775,0.0354986,1.44303,-0.56352,0.0647498,0.709566,0.209821,-0.186494,-0.517861,-0.079362,0.097304,0.166441,-0.715062,0.172225,0.37456,0.127509,-0.53212,0.179544,0.365624,0.222834,-0.118958,-0.684258,0.082669,-0.440354,0.154303,0.660262,0.32573,0.219651,0.313833,-0.458783,0.96778,-0.422951,-0.155509,-0.0179764,0.237147,0.135116,-0.122853,0.179268,0.318951,-0.365875,0.510739,0.0617247,-0.825695,0.402252,-0.535167,-0.551309,0.18734,-0.0736942,0.12379,-0.426201,-0.0907082,0.239777,0.562018,-0.676691,0.248953,0.248419,-0.299613,-0.0562489,0.943183,0.182617,-0.209647,0.462431,-0.867549,0.166312,0.275967,-0.0186983,0.137866,1.16108,0.479071,0.806193,-0.403998,-0.622112,-0.170296,-0.327748,-0.689476,0.00499935,0.0130678,-0.120596,0.200871,-0.121315,0.0214247,-0.124497,-0.0395419,1.0389,0.869425,-0.195302,0.117095,0.332051,-0.346499,0.270117,-0.0871414,-0.916212,0.0551508,0.355743,-0.105768,0.0714045,0.311669,-0.0938355,0.364123,0.67356,-0.69125,0.310238,0.193922,-0.549088,-0.0871719,-0.452111,-0.389269,0.138284,-0.112837,-0.128332,0.472797,-0.224434,0.0817035,0.349558,-0.0152387,-0.527037,0.145106,-0.096446,-0.419135,-0.499314,0.288955,-0.214659,-0.298678,0.471588,0.239713,0.164275,0.489604,0.405308,-1.55477 +3399.87,0.992954,0.0848144,5,1.6581,0.910499,-0.710156,0.0850714,0.262438,-0.160597,-0.689143,0.0633659,0.540824,0.136773,-0.0889771,-0.268419,-0.0841073,0.0158035,-0.247033,0.418802,0.0585452,-0.439482,-0.129667,-0.0051074,-0.247272,-0.484759,-0.60237,0.178955,-0.140532,0.265563,-0.100991,0.276769,-0.395978,-0.0605424,0.251566,-0.423372,-0.131229,0.40705,0.241398,-0.0123535,-0.135392,0.60747,0.550735,0.0903747,0.597008,-0.0352603,-0.349413,-0.290864,0.116793,-0.274133,-0.160489,0.125027,0.221498,0.285634,0.198346,0.424369,0.098178,-0.168633,0.892513,0.0772372,-0.342214,-0.421532,0.573635,0.178631,-0.336922,0.338476,-0.223941,-0.605769,-0.0203821,-0.0554281,0.0118119,-0.770638,-0.262263,-0.384843,-0.699135,-0.478915,0.567721,0.284329,0.901509,0.188225,0.575902,0.129666,0.0408434,0.194588,0.144478,-0.928996,-0.278413,-0.600146,0.196314,-0.139381,0.160824,0.199633,0.206896,-0.388874,-0.0388222,0.0273381,-0.262154,-0.240789,-0.00855283,-0.284724,-0.684891,-0.709314,0.0551768,0.849674,0.0519716,0.00399634,-0.385386,-0.46046,-0.766354,-0.667479,0.748407,-0.13661,-0.242087,0.83009,0.161214,0.291303,-0.363422,0.651916,-0.284024,0.803225,-0.756553,0.289315,-0.0321984,-0.539038,-0.400015,-0.169442,-0.755359,-0.070401,-0.509055,-0.155489,-0.0333578,0.241296,0.439635,-0.589721,-0.12215,0.259314,0.140738,0.82101,-0.305979,0.163211,-0.289405,-0.319192,0.0150551,-0.282255,-0.222945,-0.443878,0.266492,-0.845457,0.828784,-0.290698,0.0890274,0.532723,0.314055,-0.0299908,-0.108422,-0.218456,0.0274357,0.0912765,0.170736,0.501336,-0.237565,0.00218647,0.290293,-0.408469,0.731578,-0.0875796,0.986025,-0.181376,0.218744,-0.100012,0.314245,-0.303404,-0.139363,0.821423,0.305612,0.104328,0.0255902,-0.0467818,-0.249584,0.316745,-0.501244,-0.0585437,0.271335,0.801146,0.12466,-0.66771,-0.124612,-0.231451,-0.0384791,0.0891174,0.0165734,-0.422714,-0.229336,-0.232968,0.0403259,-0.408311,0.518213,-0.67967,0.373572,-0.169759,-0.404228,-0.613883,-0.685651,-0.143027,-0.121445,-0.338275,-0.02739,-0.513848,-0.118695,-0.225001,-0.343199,1.29651,0.0683999,0.0832036,-0.0835225,-0.52343,-0.201685,0.363487,-0.503371,0.0591942,-0.344983,0.771418,0.546042,-0.037244,-0.499868,-0.798565,0.747413,0.410177,-0.511957,0.900123,-0.0722555,-0.213322,0.119615,-0.441904,-0.374201,0.0645943,-0.820312,0.191221,-0.550051,0.152871,-0.447065,0.0716027,1.20373,0.222732,-0.579939,0.360659,0.307385,-0.10077,-0.0325931,-0.672751,0.234657,0.317285,0.0432425,-0.302807,0.377498,-0.266839,0.766797,-0.138648,-0.348105,-0.015258,-0.576121,-0.122238,0.284302,-0.235273,-0.356592,-0.0174393,0.437343,0.168223,-0.0479827,0.364831,0.242608,-0.243724,0.441412,-0.116115,-0.643968,-0.881897,-0.907096,-0.160608,0.000423511,-0.444863,0.458294,0.644648,0.644706,-0.199107,0.0321582,-0.00994659,0.386831,0.388447,0.0651441,0.322831,0.310723,0.359926,0.645817,-0.261208,0.142495,0.178632,0.85709,-0.112493,0.0935177,-0.397348,0.331066,0.28896,-0.04699,0.0764069,0.0764091,0.192722,0.133304,0.439001,0.365108,-0.490257 +3404.88,0.873448,0.0848144,4,1.63996,1.02425,-0.729808,0.118087,0.544844,-0.116668,-0.744225,0.0195816,0.599425,0.468473,-0.1307,-0.403691,-0.0557518,0.160359,-0.374897,0.46782,-0.175194,-0.164086,-0.0264591,-0.153288,-0.32258,-0.546531,-0.470222,0.230573,-0.184915,0.197171,-0.0148426,0.167496,-0.537913,-0.417283,0.0666301,-0.417464,0.0219853,0.245674,0.274149,-0.272348,-0.0862331,0.670539,0.471799,0.066896,0.617736,-0.0647904,-0.383676,-0.164055,-0.0487532,-0.345177,-0.265786,-0.111297,0.138954,0.170398,0.0187753,0.340959,-0.068276,-0.120006,0.565403,-0.0325222,-0.287437,-0.382309,0.352274,-0.050339,-0.15672,0.454592,-0.303209,-0.233559,-0.293518,0.0635627,0.157795,-0.80502,-0.350085,-0.416475,-0.465542,-0.208066,0.315709,0.109277,0.722988,0.315454,0.250613,-0.0794288,-0.167413,0.0173829,0.231817,-0.845116,-0.208876,-1.05371,0.0497792,0.070046,0.303434,0.178259,0.0180529,-0.400205,0.454728,0.540111,-0.113186,-0.13881,0.12441,-0.238344,-0.478223,-0.689668,-0.172231,0.891522,0.104195,0.137294,-0.245032,-0.60544,-0.737831,-1.01809,0.556585,-0.0547808,-0.096652,0.933627,-0.191229,0.256073,0.0640382,0.601376,-0.234265,0.795983,-0.566937,0.208965,0.0491501,-0.274309,-0.18358,-0.139511,-0.386766,-0.162296,-0.41898,-0.219653,0.0122098,0.22128,0.13053,-0.702378,0.185404,0.122461,-0.0753271,0.479473,-0.498907,0.021808,-0.16236,-0.215933,-0.243912,-0.612101,-0.302602,-0.398646,0.0487217,-0.73792,0.655234,-0.2657,0.199986,0.495125,0.642655,-0.000820328,0.178542,-0.277963,0.0841979,-0.230633,0.203176,0.350164,-0.456366,-0.276055,-0.25859,-0.657385,0.317048,-0.266168,0.532925,0.235767,0.154614,-0.114827,0.0793438,-0.232356,-0.379659,0.401243,0.246007,-0.0202397,0.221241,0.241554,-0.221311,0.322615,-0.269143,-0.237799,0.565737,1.00913,0.0806612,-0.614129,-0.0993649,0.0647036,-0.194689,-0.312622,-0.251825,-0.644153,-0.110268,-0.110616,0.177114,-0.401441,0.433597,-0.780423,0.275651,-0.241399,-0.13277,-0.255621,-0.80724,0.0323092,-0.267805,-0.0785763,0.254957,-0.856676,-0.216208,-0.528996,-0.45437,1.35241,0.268954,0.233723,-0.00695365,-0.459173,-0.0365262,0.468759,-0.775585,0.304007,-0.233401,0.809667,0.38944,-0.158227,-0.674845,-0.516379,0.673258,0.682022,-0.746602,0.818699,-0.233707,-0.18401,0.0369339,-0.377847,-0.397329,0.0890063,-0.538809,0.0320613,-0.667286,0.110331,-0.164015,-0.0331095,1.22647,-0.0395317,-0.300101,-0.0920216,0.362038,0.173754,-0.147651,-0.0208686,0.104149,0.0488363,-0.283321,-0.130348,0.275964,-0.413914,0.656047,0.121112,-0.309751,0.123754,-0.452897,-0.109192,0.364108,-0.113018,-0.466275,-0.228175,0.462367,0.238974,0.339071,0.299162,0.328583,-0.181257,0.226341,-0.252732,-0.623896,-1.17722,-0.491156,-0.210647,0.168588,-0.403377,0.29734,0.637004,0.788405,-0.155715,-0.204588,-0.162906,0.521959,0.657806,0.277825,0.20458,0.301745,0.476217,0.597387,-0.581522,0.226067,0.071102,0.349676,0.0510229,-0.0304402,-0.332983,0.503929,0.346812,-0.109763,-0.181669,0.287741,0.172075,0.101576,0.414819,0.31871,-1.679 +3405.23,0.996724,0.0848144,4,1.5806,0.856198,-1.0319,0.449644,0.218176,0.00903258,0.380753,0.0694462,-0.0729041,-0.411819,-0.138648,0.323442,-0.501154,0.388042,-0.398935,0.289892,0.356191,0.0123793,-0.395554,-0.0607046,-0.239752,-0.751248,-0.526965,0.114213,-0.0737812,-0.282573,-0.0695833,0.0752234,-0.291036,0.0746014,0.579836,-0.78314,-0.317079,0.181595,-0.00206896,0.111904,-0.294571,0.341535,0.0663986,-0.420044,0.551644,0.295064,0.375716,-0.923119,-0.277334,0.327107,-0.414244,0.25262,0.239532,-0.337488,-0.193294,-0.0657576,-0.462497,-0.230638,0.364348,-0.0373814,-0.399274,-0.573095,0.113293,-0.318135,0.233621,0.297769,-0.396059,-0.743691,0.192718,0.746805,0.208172,0.348095,1.04492,-0.394052,0.167767,1.02402,0.730707,0.694558,1.0523,0.381872,0.142857,0.438196,-0.118442,-0.0125174,0.524727,0.204487,0.503176,-0.0437021,-0.584671,-0.195898,-0.360064,0.336799,0.531768,0.0881997,0.757763,0.146387,0.176281,-0.532127,-0.132507,-0.194059,0.00661231,0.178809,0.578143,0.288518,0.799417,0.264216,-0.891505,-0.253463,0.515915,-0.333513,0.172805,-0.585826,0.214891,0.792359,-0.00326339,0.447688,0.070375,0.440026,-0.613394,-0.0377749,-0.745514,-0.165982,0.208911,0.150812,-0.0875817,-0.511015,-0.372597,0.413026,0.0272674,0.143497,0.413238,0.0946566,0.173793,-0.623511,0.559778,-0.305141,0.466741,0.871818,-0.0107813,-0.412788,0.235883,0.0993695,0.763069,-0.652613,-0.555639,0.200742,0.198156,-0.534179,-0.472682,0.0860059,0.111885,0.416556,-0.234958,0.42844,-0.301835,0.271155,-0.361895,0.0239861,0.141238,0.396137,0.294347,0.0620482,0.79819,-0.334149,0.179804,0.548025,1.31932,0.297119,-1.12802,0.283953,0.312172,-0.345328,0.275829,0.0748618,0.518701,0.164862,-0.106687,0.0486663,0.448585,-0.182808,-0.322837,-0.427551,0.363437,1.10875,-0.0427922,-0.607249,0.976322,-0.00231039,-0.589201,0.0293927,-1.14599,0.0759725,-0.168977,-0.199673,-0.165807,0.472535,0.469269,-0.642859,-0.0422041,0.43297,0.0590321,-0.11189,-0.202641,0.150196,0.118713,-0.243657,-0.0519944,0.294262,0.320118,0.0876254,-0.0364133,1.17644,0.616216,0.46769,0.0805237,-0.458029,-0.187137,-0.198494,-0.172499,0.454234,-0.115004,0.076363,0.542072,-0.00166016,0.541569,-0.454156,-0.0380553,-0.0286193,-0.240965,0.332746,-0.468527,-0.0356356,0.325142,0.648544,-0.454521,0.209656,-0.042298,0.0202323,-0.516415,0.803083,-0.109376,0.0982046,0.727395,-0.952048,0.511638,0.21889,0.402508,-0.490086,-0.0621267,0.599191,0.500173,-0.0759951,0.193106,-1.13357,0.217529,-0.71749,-0.123114,-0.427183,0.397281,0.199052,-0.541288,-0.30902,-0.491422,0.0921689,0.205476,0.371979,0.0737027,0.478711,0.309135,0.0742032,0.197377,0.538431,-0.431165,0.00467678,-0.542176,-0.147579,-0.5495,-0.511986,0.343767,-0.793473,0.353678,0.625683,0.373046,0.327967,-0.196465,-0.467401,-0.673589,-0.0945214,0.186533,0.206342,-0.0338664,0.168165,0.35945,-0.219834,-0.0703495,-0.196486,0.187421,0.402219,-0.0419324,-0.788075,-0.50634,0.421447,-0.284493,0.0649108,-0.0646847,0.192748,0.121605,0.439031,0.348719,-0.543918 +3397.3,0.955367,0.0848144,4,1.57825,0.8595,-1.05362,0.364485,-0.128678,-0.0171797,-0.186991,0.448291,0.254248,0.0832512,-0.146002,-0.0443976,-0.435656,0.743535,-0.384963,0.541381,0.407599,0.269299,-0.526667,-0.0666737,-0.0635217,-0.146851,-0.587741,0.130055,-0.17593,-0.179102,-0.330814,-0.170446,-0.312839,-0.373554,0.546291,-0.39986,0.418745,-0.0571474,0.0666451,-0.0275156,-0.100867,0.370384,0.242999,-0.606534,0.716797,0.383553,-0.199169,-0.765592,-0.528821,-0.0562626,-0.345979,0.219254,0.25939,-0.108953,0.308888,0.390928,-0.18945,-0.222462,0.64105,0.269083,-0.575345,-0.673694,0.394016,0.266119,0.450312,0.446809,-0.263508,-0.436635,0.0238043,0.62329,-0.0948885,0.429093,0.965038,-0.00594871,-0.612174,0.724487,0.607531,0.885008,1.04807,-0.0943923,0.216904,0.0163211,-0.450851,-0.280872,0.186387,-1.0232,0.156098,0.105327,-0.511395,0.409138,-0.668181,0.402682,0.355117,-0.427349,0.482354,0.0211624,-0.00477158,-0.492645,-0.230255,-0.18007,-0.0850617,-0.216942,0.496868,0.199838,0.212211,0.0704398,-0.609471,0.0211358,0.62812,-0.160488,-0.426471,0.224749,0.418403,0.673004,0.195675,0.473539,0.498211,0.357314,-0.441424,0.212983,-0.450957,0.120367,-0.106929,0.24099,-0.212452,-0.473751,0.348965,-0.354423,-0.23789,0.452731,0.160806,0.18125,0.0462945,-0.718137,0.677729,0.271294,0.0781676,0.677697,0.0862829,-0.0768623,0.000945549,0.231938,0.139676,-1.12007,-0.383253,0.0878899,0.348349,0.0510764,0.0322633,0.127946,-0.1514,0.367532,-0.110606,0.761809,-0.582413,0.0780421,-0.336487,-0.927168,-0.460344,0.440362,0.292485,0.16785,0.28917,0.205531,0.20953,0.0762504,0.682014,-0.138929,-1.0191,0.190195,0.299765,0.109999,0.0779231,0.149278,0.670645,0.397098,0.00166142,-0.590049,0.237869,0.091975,-0.321991,0.0877725,0.560662,1.16176,0.218713,-0.687719,0.607053,-0.0437709,-0.812445,-0.236182,-0.378793,-0.10738,-0.42967,-0.432516,-0.02725,0.135572,0.0707182,-0.618863,0.138582,0.0874987,0.253071,-0.11757,-0.56811,0.0926981,0.167403,-0.091653,-0.307745,-0.246499,-0.27044,0.158114,-0.515261,1.20348,0.789358,0.308835,0.233901,-0.424283,0.350191,-0.289119,-0.140812,0.62591,-0.592228,0.287121,0.337274,-0.488567,-0.157661,-0.342505,0.257628,-0.502954,-0.437177,0.377696,0.0607181,-0.542414,0.215994,0.383244,-0.768846,-0.106672,-0.158404,0.270299,-0.406688,0.135499,0.0593141,-0.0898545,1.24973,-0.889469,0.0409918,0.37058,0.319441,-0.15288,0.406783,0.303665,0.747501,0.146997,0.463025,-0.562666,0.0516168,-0.581481,0.208292,-0.813581,-0.0767484,0.160142,-0.576612,-0.469445,-0.240507,-0.0998592,-0.283101,0.390079,0.361976,0.277312,0.844625,0.0463007,0.32502,0.464208,-0.249261,0.114438,-0.744227,-0.0399872,-1.24383,-0.340943,-0.0455018,-0.550192,0.715549,0.0423987,0.908287,0.178737,0.0497275,-0.828783,0.133955,0.275381,0.149634,0.132332,-0.247453,0.331473,0.18326,-0.00509316,0.0183458,-0.0377798,0.292403,0.558783,-0.0757121,-0.62651,-0.363281,0.733514,-0.380002,-0.208005,0.0308712,0.202465,0.142789,0.449961,0.377875,0.698095 +3379.93,0.97408,0.0848144,4,1.488,0.98077,-0.99742,0.291251,0.113686,-0.118433,-0.0617671,0.230399,-0.153576,-0.0314203,-0.349182,0.302827,-0.410969,0.247655,-0.467024,0.563046,0.46725,-0.0336357,-0.387232,0.043405,-0.0589513,-0.483174,-0.448855,0.269656,0.157223,0.0579878,-0.420205,-0.216388,-0.299508,-0.241874,0.555859,-0.546723,-0.0717652,0.0465427,0.174011,0.10418,0.0344114,0.751831,0.436924,-0.28104,0.756371,0.424555,0.0240092,-0.357299,0.151824,0.398135,-0.428319,0.393797,0.462802,-0.170226,0.260547,-0.0174583,-0.32113,-0.229905,0.51725,0.418099,-0.17731,-0.248349,0.615898,0.0847676,0.511329,0.279118,-0.281965,-0.299972,0.187009,0.635825,-0.0279091,0.702111,1.09925,0.014967,-0.906629,0.839852,0.886204,0.242865,0.5833,-0.0653029,0.581422,0.225738,-0.482099,-0.30342,-0.182216,-1.33109,0.312534,-0.157637,0.283882,0.726303,-1.10443,0.222412,0.50761,-0.330963,0.688936,0.354249,0.359496,-0.697982,-0.196361,-0.130111,0.278102,0.102589,0.971778,0.0164261,0.493965,0.521055,-0.624233,-0.0951945,0.174936,-0.553527,-0.234047,-0.145007,0.51919,0.465186,-0.157157,0.293542,-0.121087,0.440388,-0.347873,0.230424,-0.951525,-0.222032,0.68183,-0.206714,-0.180973,-0.197975,0.298475,0.201479,-0.112351,-0.0930494,0.580932,0.0522539,0.502343,-0.570968,0.402735,-0.244909,0.0427083,0.486652,-0.199558,0.201654,0.321769,-0.0836012,0.252353,-1.02149,-0.399145,0.00337059,0.434809,-0.0383411,0.181445,0.472439,-0.275819,0.353909,0.293219,0.777301,-0.658948,-0.11346,-0.366608,-0.481849,0.183199,0.715379,0.559027,0.220812,0.355268,0.0158598,0.016404,-0.247823,0.636211,-0.523936,-0.927337,-0.485655,0.381963,0.235753,-0.352255,-0.0491344,-0.0489283,0.449392,-0.0284482,-0.979126,0.148473,-0.445629,-0.267518,-0.0502194,0.000245631,1.41472,0.275896,-0.590849,0.780987,-0.434455,-0.269706,-0.648816,0.0598237,-0.153895,-0.219851,-0.43998,0.193235,0.502329,-0.0683885,-0.528298,-0.208071,0.180131,0.180274,-0.452086,-0.34515,0.292481,-0.217957,-0.330683,-0.0127019,0.0932549,0.138732,0.315018,0.0418894,1.19497,0.773048,0.265089,-0.0070286,-0.67524,0.214205,0.29507,-0.257909,0.352264,-0.434718,0.504759,0.0467171,-0.219466,-0.44993,-0.571217,0.465749,-0.452734,-0.998496,0.511,-0.210307,-0.593185,0.397317,0.471316,-0.723902,0.259279,-0.0693125,0.113664,-0.494354,0.371816,0.2051,0.176968,0.868202,-0.667883,0.856706,0.0371215,0.118472,-0.294981,0.046775,0.0341677,0.476472,0.441425,0.318849,-0.724306,0.0788786,-0.983022,-0.113686,-0.561215,0.167519,0.26553,-0.522455,-0.253347,-0.0975378,-0.0657112,-0.356871,0.0678259,0.684868,0.204992,0.677165,-0.621393,0.206041,0.912034,0.229022,0.378366,-0.576876,-0.0684643,-0.968862,0.0220835,0.0942879,-0.604599,0.674313,-0.126611,0.611609,0.224228,0.16755,-0.0382594,-0.0199059,0.486567,-0.0963624,0.20259,0.0120194,0.471948,0.336064,-0.00980502,0.0282533,0.226587,0.31575,0.326117,-0.416275,-0.890873,-0.653286,0.451357,-0.77857,-0.0767351,-0.0690195,0.205744,0.140238,0.45359,0.374483,-0.345909 +3382.44,0.971546,0.0848144,5,1.45689,0.889699,-0.795124,0.223848,0.147942,-0.184548,-0.0649349,0.479012,-0.0508188,0.341379,-0.237906,-0.0613627,-0.239477,0.59065,-0.0545372,0.899987,0.416571,-0.054978,0.0433426,-0.243314,0.133129,-0.0331425,-0.149951,0.222711,-0.219838,-0.100329,-0.326513,0.506143,-0.544257,0.0557716,0.596007,-0.38083,0.197242,0.494001,0.194503,-0.108446,-0.719809,0.888426,0.164235,-0.415291,0.890755,0.511524,-0.153823,-0.647396,-0.12064,0.125202,-0.326009,0.458149,0.402918,0.0760899,0.183174,0.216185,0.122828,0.201549,0.818949,0.0431069,-0.142312,-0.491594,0.663137,-0.471637,0.781489,0.60892,-0.627569,-1.0224,0.248366,0.75842,-0.464602,0.161595,0.724747,0.377477,-0.396893,0.371428,0.640874,0.598337,0.726241,-0.0224451,0.331396,-0.174919,0.0633985,-0.462504,-0.33072,-1.06147,0.000971522,0.414536,0.353392,-0.066642,-0.901262,0.406909,0.252086,0.0303916,0.168066,0.67609,-0.245536,-0.91282,-0.128222,-0.0218345,0.286524,0.326157,0.525909,0.303347,-0.0349089,0.238184,0.102269,-0.464699,0.535948,-0.734984,0.160558,-0.0768421,0.461201,0.820321,-0.510356,0.327201,-0.29862,0.420604,-0.344326,-0.0587591,-0.657673,-0.0495953,0.757496,-0.0828153,-0.393221,0.248189,0.146721,0.0576275,0.274056,-0.133387,0.458864,-0.271226,0.226325,-0.3712,0.214894,-0.182173,0.125191,0.463227,-0.0675621,-0.0516872,-0.00835808,0.200903,-0.0366619,-0.541113,-0.622234,-0.03254,0.431684,-0.268168,0.404202,0.420564,-0.319466,0.658462,0.219715,-0.438749,-0.950864,-0.0192488,-0.163673,0.202421,0.925686,0.386787,0.29775,0.46874,0.446289,0.327812,0.405524,0.0451939,0.467004,0.0183351,0.213687,-0.301299,0.197367,0.0802081,-0.362017,-0.156106,0.151927,0.551547,-0.015146,-0.860246,0.128868,-0.43766,-0.270647,0.453873,0.116732,1.5709,0.728384,-0.0471104,0.894558,-0.823043,-0.851312,-1.13994,-0.434626,-0.207799,-0.205909,-0.545387,0.164594,0.0713166,-0.0555277,-0.229172,-0.270164,0.251038,0.252802,-0.431918,-0.810505,0.237695,-0.00843002,-0.516459,0.0357752,0.217441,-0.108198,0.779303,-0.435888,0.964903,0.475645,0.0365156,0.00263145,-0.17914,0.12308,0.0812269,-0.340928,0.640526,-0.631035,0.686504,0.286616,-0.0676246,-0.320873,-0.925483,-0.257965,0.0118261,-0.949548,0.802456,-0.164959,-0.514767,0.393042,0.19327,-0.557146,0.0211283,-0.334132,0.407437,0.167763,0.18431,-0.16972,0.326128,0.895075,-0.898104,0.377529,0.300916,0.518814,-0.518653,0.204146,0.468608,0.716431,-0.483682,0.364573,-0.478354,0.156775,-1.09787,0.271411,-0.428385,-0.117898,0.336754,-0.145169,-0.0217873,-0.388019,0.119314,-0.15122,0.421134,0.763434,0.0272211,0.659355,0.227379,0.11112,0.445566,0.703279,-0.2093,-0.516196,0.218524,-0.168681,0.0562634,-0.248525,-0.522767,0.129943,0.400924,0.871499,0.319923,0.431578,0.311747,-0.614448,0.587365,-0.198054,0.778848,-0.225647,0.661609,0.572499,-0.20994,0.0983247,-0.103017,0.200297,-0.192187,-0.282273,-0.809223,-0.938116,0.457801,-0.41271,-0.219807,-0.0575437,0.233159,0.13513,0.482866,0.3676,-0.355567 +3391.48,0.480884,0.0848144,4,1.56842,0.777605,-1.02736,0.403067,0.501413,0.0503522,-0.0903521,0.55618,0.329584,-0.314293,0.267178,0.141883,0.0988439,0.14766,-0.501869,0.234586,-0.141134,0.461637,0.0158723,0.212414,0.151981,-0.71293,-0.278152,0.12789,-0.0704851,-0.103539,-0.176056,-0.0573089,-0.606814,0.120079,0.613954,-0.152442,-0.155006,0.362945,0.139908,0.0697672,0.153661,-0.088506,0.366924,0.087986,0.785063,0.224142,-0.1302,-0.361118,0.0968438,-0.217324,-0.307317,-0.129351,0.181198,-0.358863,0.257386,0.0427255,0.21447,-0.514245,0.749477,0.212577,-0.0568875,-0.353404,0.236327,-0.0891175,-0.0893758,0.39002,-0.734636,-0.735266,-0.00705889,0.286471,-0.271688,0.100647,0.408642,-0.836129,-0.000608599,0.516754,0.756394,0.530532,0.978851,0.764167,-0.474811,0.260673,-0.631352,-0.141561,0.588035,-0.539131,0.384657,-0.098835,0.187224,0.525708,-0.0277804,0.208468,0.0636947,-0.390419,-0.0235558,0.132453,0.135194,-0.179687,0.339133,0.369562,0.418745,0.032063,0.154097,0.416865,-0.200436,0.89893,-0.541717,-1.01398,-0.317335,-0.669212,0.178231,0.295073,0.680734,0.509451,-0.644541,-0.255452,-0.64419,0.357734,-0.444987,0.331112,-0.753123,0.141736,-0.162112,-0.357987,-0.271846,0.219995,-0.731462,-0.129849,-0.0777883,0.0932765,0.173823,0.0432697,0.127061,-0.261832,0.297855,0.329013,-0.00635807,0.750498,-0.314398,-0.123547,0.0937727,-0.333755,0.451554,-1.13428,-0.684364,-0.175273,-0.192982,-0.383781,0.270226,0.98556,-0.132566,0.283139,0.173718,-0.21517,-0.638272,-0.000741523,-0.330206,-0.154939,0.299409,0.483619,0.206127,-0.555592,0.446717,-0.504909,-0.145985,0.120939,0.890816,0.24882,0.127231,-0.362084,0.0314503,-0.0622893,-0.191866,0.463306,0.0484037,0.204577,-0.0579835,-0.23894,-0.180975,0.285725,-0.210649,0.245185,0.321044,0.631631,0.706197,-0.0828674,0.167168,0.214071,-0.414684,0.115617,-0.185578,-0.0536688,0.626786,-0.760471,0.438822,0.0604794,0.19299,-0.392855,0.12408,-0.133571,0.0835034,-0.738211,-1.29921,-0.630184,-0.0550356,-0.558009,0.0727728,0.528936,-0.27845,0.324891,-0.624176,1.26603,-0.105749,0.16881,-0.263266,-0.150521,0.383271,0.190418,-0.131781,0.0344233,-0.744757,0.204855,0.281729,0.101882,0.359915,-0.175858,0.409592,-0.0794947,0.67658,0.732981,-0.156199,-0.0616507,-0.146833,0.0167798,-0.174988,0.0928191,-0.359785,-0.248672,-0.204152,0.719047,0.0222268,-0.603902,1.02452,0.0612026,-0.165093,-0.158412,-0.033542,-0.306186,-0.656109,-0.764279,0.299373,-0.628259,-0.322392,-0.0768717,0.328065,-0.757685,0.434701,-0.308935,-0.409558,0.187986,-0.986389,0.0342389,-0.885766,0.215248,0.184471,0.262562,0.0672095,-0.555693,0.81048,-0.259063,0.0441554,-0.324824,-0.414235,-0.0190839,-0.0935374,-0.690307,-0.550223,0.322798,0.356547,0.44456,0.0791063,0.446537,1.18789,0.0456755,0.193316,-0.341744,0.11462,-0.257659,0.394287,0.17622,-0.164786,0.982003,-0.180977,-0.625931,-0.124243,0.68798,-0.0124075,0.351521,-0.172259,-0.588635,-0.24769,0.104846,-0.337459,0.863052,0.348679,0.196407,0.144438,0.443179,0.38005,-1.32598 +3423.12,0.964997,0.0848144,4,1.57337,0.940326,-0.586602,0.26328,0.642863,-0.261721,-0.118236,-0.267255,0.18401,0.439602,0.0491429,-0.348928,-0.27086,0.238871,-0.0326883,0.716854,-0.432907,-0.162249,0.0696858,-0.0204229,0.113868,-0.147575,-0.117305,-0.194994,-0.179901,-0.0560946,-0.161046,0.166576,-0.383348,-0.140644,0.62706,-0.412807,0.41468,0.139273,-0.294563,-0.331329,-0.73207,0.196461,0.276061,-0.38377,0.905495,0.332583,0.164094,-0.716464,-0.31734,-0.177911,-0.557404,-0.0545876,0.199848,-0.161534,0.0584934,-0.407414,0.222631,-0.323772,0.674424,-0.218381,0.0252063,-0.793504,0.548928,-0.546335,0.228843,0.730317,-0.366065,-0.464316,0.218676,0.658928,-0.16666,0.640018,-0.148304,0.0970816,-0.308785,0.327179,0.771399,-0.321158,0.36782,0.670039,0.58953,0.136445,-0.355797,-0.188923,-0.0815508,-0.239441,0.28864,-0.295411,-0.0823374,-0.409363,0.790537,0.322237,0.391457,-0.243072,-0.090282,-0.384581,0.163205,0.061004,-0.238826,-0.160413,0.127926,-0.784864,0.0299512,0.114536,0.351188,-0.477198,-0.19377,-0.0295874,1.05291,-0.346008,0.529531,-0.267836,0.712048,0.374083,-0.236126,0.279959,0.228267,0.320873,-0.225235,-0.514649,-0.352554,0.268699,0.553601,0.427794,-0.759237,0.184835,-0.0898887,-0.173004,0.107136,0.31107,-0.3349,0.394419,0.418832,-0.524414,0.0496798,0.062755,0.269054,0.720198,0.486192,-0.0260437,-0.486122,-0.335582,-0.165722,-0.687164,-0.554465,0.242942,0.509448,-0.455289,0.258521,0.0953842,-0.320248,0.594674,0.082274,-0.277753,-0.203669,0.299148,0.313203,-0.097965,0.197983,0.892981,0.476166,0.157716,-0.0357892,-0.317954,0.341821,0.0738246,0.755135,-0.0044066,-0.0872121,0.870043,0.155241,-0.021856,-0.470017,-0.110123,-0.317159,0.339854,-0.134659,-0.290238,-0.178012,0.0249557,-0.195391,-0.480398,-0.0452687,0.993503,0.0845694,-0.236847,-0.119001,0.170132,-0.110244,-0.650218,-0.451218,-0.161112,-0.0115818,-0.374,0.142748,-0.014451,0.182083,-0.319652,-0.169482,-0.189241,-0.368639,-0.821062,-0.379861,-0.76449,0.326958,-0.2845,0.432901,-0.365202,0.784805,0.497865,-0.335759,1.04845,0.254833,0.394498,0.102336,-0.617238,0.159327,0.418149,0.547586,0.555288,0.0815658,0.13588,0.458018,-0.455736,-0.239487,-0.240482,-0.0331275,0.502839,-0.874423,0.278804,-0.159356,-0.610929,0.751163,-0.243064,-0.260124,-0.0953219,-0.320537,-0.153281,-0.680972,0.146086,-0.126062,0.522265,0.736915,-0.135313,-0.360802,-0.446406,-0.228903,-0.0677567,0.00219106,0.656765,0.521484,0.198781,-0.717543,-0.261318,0.0252279,-0.909642,0.710231,-0.432791,0.00613051,0.153076,-0.109823,-0.0632759,-0.0565661,0.320164,-0.178609,0.390206,0.121958,0.0558323,-0.011378,0.912551,0.374739,-0.183111,-0.161582,0.433079,-0.476907,0.0320174,-0.966687,0.147975,-0.125509,-0.423893,-0.0386728,0.271299,-0.0381296,0.379932,-0.0793882,-0.129411,0.334952,0.187952,0.406451,0.798212,-0.0118919,0.703276,-0.17497,-0.371009,0.036927,-0.591509,0.0122642,0.045692,-0.526836,-0.287281,0.347746,-0.229313,0.137437,-0.374323,-0.34975,0.162131,0.146039,0.402655,0.382151,-2.09929 +3427.57,0.984254,0.0848144,4,1.56996,0.947241,-0.678272,0.256777,0.693606,-0.220479,-0.0579507,-0.153658,0.225236,0.409196,0.0649076,-0.37656,-0.165333,0.266821,-0.0126421,0.769029,-0.336161,-0.185895,0.110423,0.00965434,0.0721254,-0.144507,-0.222203,-0.121877,-0.129108,-0.106841,-0.0981984,0.0987191,-0.331449,-0.181578,0.63374,-0.451202,0.394525,0.149892,-0.326447,-0.279246,-0.818038,0.0940009,0.370863,-0.403341,0.914608,0.28557,0.171657,-0.659397,-0.306487,-0.256141,-0.586283,-0.0892253,0.19979,-0.194112,0.0423808,-0.435152,0.19879,-0.381008,0.673607,-0.172257,0.0393916,-0.805846,0.559102,-0.513325,0.184261,0.689347,-0.323754,-0.612365,0.130188,0.598281,-0.21549,0.67146,-0.144866,0.057379,-0.372589,0.274958,0.816321,-0.262207,0.393067,0.729631,0.610056,0.124983,-0.314994,-0.191294,-0.0891067,-0.23521,0.299261,-0.312897,0.00309299,-0.455957,0.795912,0.274623,0.417125,-0.263521,-0.105477,-0.28899,0.114106,-0.00891601,-0.252024,-0.0938943,0.135593,-0.779583,-0.0215047,0.107825,0.377911,-0.54388,-0.216304,-0.00763707,0.93269,-0.349636,0.572545,-0.295465,0.751529,0.342574,-0.136315,0.214215,0.338868,0.370099,-0.279422,-0.454808,-0.252087,0.308981,0.566911,0.380174,-0.748363,0.123789,-0.0861152,-0.280017,0.16645,0.333814,-0.260684,0.292643,0.446194,-0.494339,-0.0698338,0.0450462,0.338552,0.77586,0.504369,-0.0345176,-0.549688,-0.348474,-0.205975,-0.751473,-0.495333,0.25564,0.485641,-0.517761,0.266598,0.153024,-0.302102,0.68406,0.11877,-0.32231,-0.159932,0.327604,0.28644,-0.106399,0.129095,0.984418,0.506249,0.125514,-0.03939,-0.259887,0.344063,0.0621178,0.723272,-0.041241,-0.0484786,0.87718,0.110235,0.0730858,-0.41656,-0.162748,-0.292815,0.339459,-0.140396,-0.319558,-0.1863,-0.0830122,-0.199977,-0.534035,-0.0486541,0.931944,0.141737,-0.264084,-0.15389,0.186632,-0.152902,-0.596547,-0.400339,-0.0714705,0.0302209,-0.353926,0.142951,0.0593103,0.118299,-0.280733,-0.168928,-0.219615,-0.331648,-0.804128,-0.326284,-0.777811,0.343268,-0.240004,0.384079,-0.453137,0.750731,0.47109,-0.461071,1.04064,0.302802,0.489692,0.0838439,-0.670169,0.183581,0.437702,0.473508,0.519253,-0.0541544,0.087477,0.421522,-0.378346,-0.309978,-0.292055,-0.0812713,0.478885,-0.904135,0.295064,-0.190731,-0.668036,0.698161,-0.16451,-0.215574,-0.0959267,-0.364448,-0.137215,-0.753732,0.168771,-0.134486,0.502317,0.843587,-0.0493735,-0.400402,-0.384667,-0.252497,0.0120492,-0.00636883,0.679669,0.569342,0.229725,-0.670333,-0.185474,-0.00280837,-0.882628,0.755604,-0.357252,0.0012702,0.101002,-0.0936755,-0.0808325,-0.0811035,0.316165,-0.208467,0.26424,0.132716,0.0668003,0.0461262,0.90801,0.394004,-0.113099,-0.119958,0.466684,-0.516395,-0.05722,-1.01145,0.0768449,-0.117457,-0.395233,-0.0717639,0.252046,0.00325911,0.341972,-0.0625263,-0.24033,0.315166,0.130323,0.43662,0.790659,-0.0220095,0.67725,-0.0968047,-0.471099,0.00197067,-0.574517,0.00702041,0.0817741,-0.50747,-0.294315,0.374711,-0.157029,0.0581826,-0.427738,-0.318588,0.170473,0.141758,0.412883,0.376507,-2.23936 +3415.24,0.652035,0.0848144,4,1.61658,1.00054,-0.780809,0.258591,0.763127,-0.0893608,0.0265529,0.0811499,1.19917,-0.286871,-0.270711,-0.351277,0.127175,0.0208234,-0.437608,0.819495,-0.353533,0.196538,0.253676,0.206115,-0.234527,-0.816729,-0.580847,-0.109074,-0.270771,0.00407623,0.225225,-0.1365,-0.336205,-0.0421863,0.263426,-0.205499,0.55774,-0.107837,-0.0999098,0.0440113,-0.0147145,0.00339818,0.0798876,-0.214583,0.635238,0.238366,-0.334532,-0.426682,-0.0139659,-0.0283626,-0.085322,-0.1269,-0.0456729,-0.49924,0.215904,0.010866,0.0446761,-0.59298,0.722967,-0.567809,-0.232337,-0.243166,0.254815,-0.697389,-0.00734543,0.550634,-0.683751,-0.418263,0.450148,0.349874,-0.364447,-0.0772565,-0.242379,-0.144686,0.364342,0.19459,0.5363,0.125052,0.613543,0.864289,0.250759,-0.150578,-0.430421,0.287632,0.325048,0.42194,0.514921,-0.528978,-0.584818,-0.0802234,0.338385,0.0528118,0.317996,-0.245756,-0.32445,-0.348419,0.0131041,0.0158955,-0.637433,-0.0973201,-0.0768286,-0.552127,-0.429811,0.67842,0.434342,0.264612,-0.53075,-0.00260189,0.108591,-0.0214919,0.242664,0.0438372,0.110938,0.37483,0.181049,-0.170244,0.541369,0.0957344,0.071437,0.338254,-0.34124,0.013454,0.405631,-0.167707,-0.719641,0.202458,0.063787,-0.45304,0.492178,0.632222,0.137284,0.00990714,0.00375523,-0.35644,0.300392,0.225002,0.365266,0.386784,0.366507,0.315733,-0.474592,-0.117409,0.341165,-1.01723,-0.5078,0.0681139,-0.329858,-0.121405,0.109586,0.474166,-0.164726,0.200066,-0.122819,-0.0493077,-0.270237,0.367231,0.112614,0.0131312,0.365334,0.603975,0.135013,-0.0518053,0.377048,-0.242984,0.231164,-0.517792,0.578647,-0.341998,-0.817089,0.353425,0.401066,0.158685,-0.249802,0.258947,0.45435,0.0652688,-0.333724,-0.302487,-0.0690347,-0.00836782,-0.486238,-0.540185,0.283141,0.973298,-0.461032,-0.345145,-0.236506,-0.447474,0.147719,-0.569286,-0.340104,-0.00583033,0.699672,-0.288173,-0.130992,0.104633,0.173577,-0.325778,-0.324324,0.0830158,-0.401592,-0.650611,-0.472243,0.331758,0.0708921,-0.46648,0.449849,-0.21355,0.7844,0.442073,-0.433655,1.35103,0.365174,0.320627,0.212206,-0.426624,0.127683,0.374458,0.0563075,0.460761,-0.217479,0.379851,-0.00115258,-0.139938,-0.240282,-0.479403,0.544491,0.101965,-0.161847,0.714016,-0.235362,-0.611279,-0.381485,0.425975,0.355342,-0.139147,-0.0625015,-0.112825,-0.237544,0.270673,0.31895,0.0580476,0.814414,-0.351879,-0.346743,0.268528,0.0739246,-0.000126848,-0.0310612,0.471962,0.354176,-0.0723477,0.10356,-0.139844,0.59154,-0.202632,0.756624,-0.23888,-0.197592,0.262399,-0.1769,-0.521542,-0.280534,0.147763,-0.300514,0.00725998,0.404929,-0.370049,0.0260398,0.23177,-0.0307453,0.0818892,-0.240024,0.553149,0.0379879,-0.504037,-0.451359,0.663515,0.480187,0.131752,-0.223502,0.381193,0.208047,0.60597,-0.295937,0.300088,0.193381,0.650224,0.141869,0.9178,0.00105834,0.987193,0.00259757,0.246537,-0.0695581,-0.633269,-0.0513782,0.276329,-0.0158575,0.132906,-0.21392,0.0558029,-0.304354,-0.19288,-0.410348,0.158796,0.164295,0.398493,0.405333,-2.49839 +3418.87,0.895281,0.0848144,5,1.58997,0.724391,-1.52311,0.538903,0.574166,-0.17019,0.00038163,-0.209706,-0.46694,0.517669,-0.186705,0.319855,-0.217498,0.0905513,-0.0874314,0.453564,0.495041,0.0707699,-0.387466,-0.0841864,0.150239,-0.164816,-0.195481,0.370658,0.310312,-0.19257,-0.131868,0.51585,-0.145568,0.310702,0.738714,-0.522659,-0.423578,0.106112,0.0644274,-0.299127,-0.117847,0.387953,0.467109,-0.363071,0.989579,0.121602,0.778528,-0.142893,-0.244184,-0.0791522,-0.778281,-0.166222,0.18781,0.429228,0.152577,0.225299,0.00294305,-0.0418975,0.741945,0.0919485,-0.156449,-0.758569,0.31361,0.204372,0.0693113,1.31752,0.0853139,-0.797805,-0.234225,-0.215884,0.220248,-0.185729,-0.0932941,-0.45206,-0.734275,0.498606,0.681517,-0.234873,0.505593,-0.00965451,0.320693,0.305943,-0.200019,-0.308278,0.102236,-1.01125,-0.152664,-0.450233,0.0839092,-0.0599063,-0.114182,-0.0908218,-0.234688,-0.342528,-0.400582,0.255266,0.327909,-0.182186,0.55498,-0.693435,0.352076,0.226217,0.260129,0.0326195,-0.0390197,-0.0791893,-0.147507,-0.423577,0.23459,-0.618329,0.34443,-0.0641596,0.293663,0.67773,0.146102,0.307827,-0.162366,0.204191,0.151599,-0.151995,-0.231016,0.00898075,-0.41566,0.0680077,-0.597183,-0.590374,-0.258504,-0.09492,-0.817848,-0.219507,0.157269,0.417816,0.510801,-0.383243,-0.00685114,-0.242214,0.0265586,0.713485,-0.63605,-0.419251,0.324007,-0.0496496,0.270701,-0.271215,-0.271611,-0.14687,0.0621293,-1.06032,-0.301301,-0.148842,-0.160779,0.246898,-0.0718802,-0.366169,-0.101147,0.243516,-0.108986,-0.192874,0.00959889,0.510073,0.355301,0.0414321,0.0155378,0.683176,0.0303186,0.26947,0.823065,-0.0647021,0.442834,0.072393,-0.25486,-0.272888,-0.198465,-0.226203,0.145666,0.103598,-0.190812,0.211132,-0.0373364,-0.472707,-0.100868,-0.023015,-0.0397087,0.363475,0.380957,0.0385649,0.296941,0.155003,-0.421239,-0.451236,-0.194313,-0.294022,-0.537372,-0.275778,0.149274,0.0851309,-0.335089,-0.665985,0.362357,-0.138557,0.469911,-0.0737291,-0.784126,-0.570348,-0.190255,-0.248442,0.0721424,0.198691,-0.644395,-0.505291,-0.405419,0.759921,-0.595868,-0.0247656,0.172454,0.0987562,-0.148986,-0.492289,-0.101725,0.0599523,-0.279449,0.171311,0.602927,-0.497284,-0.0353231,-0.43502,-0.350823,0.400022,-0.212463,0.466606,-0.415408,-0.00898222,0.61432,-0.172461,-0.530503,-0.160498,-0.35269,-0.267774,-0.572338,0.489271,-0.596484,0.131933,0.174406,-0.372332,-0.203488,-0.275412,-0.29015,0.029701,0.484413,-0.0919655,0.628145,0.201384,0.0648881,-0.36278,-0.183702,-1.25755,0.00652303,-0.079117,0.0257136,0.24781,-0.358125,0.0590348,0.321368,-0.0103228,-0.0129605,0.613796,-0.257472,0.404653,0.271363,-0.0774827,0.107224,-0.399849,0.0377758,-0.148578,-0.336683,-0.0472208,-0.371777,-0.0942358,-0.62178,-0.14896,0.502013,-0.10456,-0.0141224,-0.658791,0.253042,-0.393084,-0.590153,-0.348291,0.481766,-0.750109,-0.130078,-0.190529,0.476399,-0.244637,-0.162511,0.605083,0.210518,-0.310066,-0.215522,-0.949989,0.108188,-0.197584,-0.0468588,-0.0472262,0.399752,0.144876,0.143798,0.380626,0.379208,-1.26509 +3430.9,0.978595,0.0848144,5,1.62095,0.671427,-1.31926,0.541057,0.406294,-0.195049,-0.15855,0.333436,-0.615927,-0.287066,-0.200385,0.109135,-0.24221,0.552138,-0.35269,0.523226,0.460382,0.0123027,-0.539534,-0.0614918,0.0793909,-0.673904,-0.822644,0.545548,-0.529753,0.134998,-0.0846784,-0.222247,-0.124552,-0.0709738,0.909416,0.0653641,-0.242777,0.291632,-0.399375,-0.318599,-0.172973,0.876614,0.430606,-0.35104,0.78426,0.464991,0.451706,-0.743228,-0.306339,0.0604053,-0.729846,0.0943797,0.182097,0.0778109,-0.100859,-0.23745,0.0773333,-0.44217,0.713508,-0.0986586,-0.0851703,-0.177071,0.31526,0.0965329,0.095556,0.731876,-0.827471,-0.997433,-0.0749496,-0.0481416,0.164826,-0.209608,-0.0976661,-0.101268,-0.305176,0.395268,0.583952,-0.284865,0.570124,0.105283,0.332767,-0.253165,-0.332202,-0.196152,-0.18913,-0.283336,0.178903,-0.276616,-0.211459,-0.183921,0.134562,-0.506573,-0.161849,-0.197855,-0.0932238,-0.0849363,0.172431,-0.0752243,0.17763,-0.992795,-0.17465,-0.244744,0.178628,0.289639,0.0172968,-0.0517644,-0.256748,-0.76086,0.287146,-0.378174,0.311499,0.06525,0.244046,0.903332,0.200447,0.0964057,-0.113023,0.178917,0.167394,-0.117113,-0.810687,0.230241,0.130953,0.350843,-0.836627,-0.614971,-0.356028,-0.366196,0.0649381,-0.335953,0.439812,0.0549004,0.569248,-0.821771,0.163097,0.0363449,0.0685887,0.307802,-0.46199,0.128665,0.197729,0.0919335,-0.187795,-0.72653,-0.0834373,-0.169899,-0.204121,-0.296384,-0.277712,-0.384236,0.132452,0.173921,-0.0158848,-0.0824478,-0.0786945,-0.178445,-0.0894131,-0.0111796,-0.00460011,0.459352,0.505373,-0.0600894,-0.0994749,0.989465,0.175765,-0.0760845,1.1046,-0.516137,0.28341,-0.0610939,0.0726321,-0.514562,0.0373545,-0.202704,0.206169,-0.261355,-0.252557,0.0328185,-0.128795,-0.176986,0.093993,-0.250635,-0.149218,0.538684,0.270938,0.395988,0.497058,-0.398624,-0.762439,-0.310331,-0.118553,0.0461005,0.0791435,-0.0502497,-0.0473047,-0.104983,-0.470297,-0.572885,0.12629,-0.465749,0.134601,-0.287897,-1.22138,-0.79906,-0.161638,0.168248,-0.273745,-0.08786,-0.381381,-0.0012213,-0.126202,0.832567,-0.436475,-0.255877,-0.0569535,-0.412802,0.0871588,-0.0123489,-0.412175,0.62321,-0.505211,0.0361987,0.50763,-0.295595,-0.289179,-0.261841,-0.0938422,0.38293,0.32707,0.486999,-0.413046,-0.223796,0.448507,0.0855252,-0.723838,0.08866,-0.247077,-0.247591,-0.351502,0.274636,-0.444499,0.0405865,0.583375,-0.225829,-0.322289,0.115222,0.241174,0.232294,-0.0362792,0.0720901,1.07201,0.123607,0.0588937,-0.344157,-0.206526,-0.636927,-0.0896438,-0.466457,0.218144,0.474907,-0.122031,-0.159655,0.183138,-0.020336,0.192163,0.518835,-0.125496,-0.0240505,0.288344,0.334739,-0.0679898,-0.440908,-0.793262,0.0173709,0.14365,-0.211934,0.114115,-0.0292298,0.00185907,0.331371,0.270436,-0.334209,0.125384,-0.218564,-0.0860765,-0.0631614,-0.5777,-0.325412,0.576844,-0.487767,-0.546935,0.0327111,0.461985,-0.613204,0.221646,0.669707,-0.467942,-0.576437,-0.0784205,-0.54655,-0.0306849,-0.0251344,0.211847,-0.379226,0.345241,0.126859,0.184639,0.356172,0.429696,-0.686105 +3420.8,0.929316,0.0848144,4,1.58236,0.701299,-1.24315,0.556609,0.50019,-0.0771925,-0.0233138,-0.31806,0.170244,-0.212875,-0.0590661,0.143928,-0.627256,0.411283,0.200299,0.657212,0.262603,-0.282935,-0.083043,0.0367573,0.125319,-0.389161,-0.827408,0.518206,-0.208477,-0.493485,0.136563,0.26689,-0.338441,0.00519949,1.14748,-0.69556,0.294184,0.139004,0.0551917,-0.120996,0.0182354,0.31437,0.385134,-0.361707,0.823853,-0.0295141,0.0321461,-0.33561,-0.317128,-0.0485937,-0.715561,0.0944301,0.313979,0.0510284,-0.206606,0.46049,-0.190172,-0.30196,0.546969,-0.51161,-0.493337,-0.337667,0.416942,-0.587036,0.122663,0.829599,-0.276216,-1.13264,-0.14037,0.451976,0.102359,0.534612,-0.126012,-0.37953,-0.428072,1.04216,0.585042,-0.137141,0.456708,0.604614,0.634574,0.49799,-0.109638,0.184896,0.671172,-0.138433,0.00372006,-0.50364,-0.310292,-0.122121,0.126118,-0.726604,-0.114645,-0.516355,0.153337,-0.288934,-0.0491843,-0.341765,0.103423,-1.15202,0.193167,-0.318386,-0.0909658,0.27556,-0.343362,-0.422117,-0.239327,0.100091,0.546721,-0.421073,-0.0940342,-0.289809,0.280279,0.902788,0.0791017,-0.0396371,0.357353,0.539175,0.39481,0.614917,-0.300646,-0.161026,0.182139,-0.202573,-0.539972,0.142444,0.354226,0.0229388,-0.15995,0.341778,0.223138,0.169261,0.213215,-0.152416,-0.0447597,-0.0306697,0.0874105,0.344068,-0.713496,0.0951666,0.424569,0.199386,0.564755,-0.00768807,-0.628652,-0.00461628,-0.365767,-0.169952,-0.433714,0.529055,-0.268516,0.477841,-0.774025,-0.563427,0.0185324,-0.184438,-0.18159,-0.0686338,0.384914,-0.158861,-0.212477,-0.206757,0.303853,-0.652799,0.0679226,-0.383953,0.637432,0.298431,0.712522,-0.18493,-0.246511,-0.100156,-0.155466,0.30039,0.286245,-0.427466,0.111355,-0.344649,-0.14845,-0.550078,-0.35761,-0.412931,0.487204,0.684207,-0.125732,-0.416531,0.685308,0.040172,0.221171,0.445327,-0.28772,-0.423807,-0.343363,-0.69583,0.163796,0.0451375,0.107057,-0.555758,-0.204627,0.221524,-0.315678,-0.293184,-0.721543,0.389051,-0.153385,-0.0947033,-0.326788,0.0534901,-0.338241,0.0359524,-0.0808228,0.693948,-0.233751,-0.0707197,-0.0522124,-0.507531,0.457977,-0.712737,0.0328141,-0.195286,-0.093389,0.154358,0.657883,0.0571687,-0.247094,-0.0173296,-0.0530434,0.515954,-0.227537,0.443326,-0.306633,0.291553,0.176631,-0.0360466,-0.622764,-0.0529198,0.321322,0.280392,-0.892261,0.360663,0.360159,0.552119,0.532084,-0.462883,0.0932924,-0.129152,0.224255,-0.233633,0.00353787,0.43524,0.110128,-0.144536,0.501269,-0.196963,-0.0414796,-0.934767,0.324356,-0.476146,-0.205961,0.420164,-0.204563,0.0541526,-0.160457,0.135166,0.18496,0.182376,0.093395,0.116138,-0.0319285,0.182613,-0.0859173,0.402844,-0.110308,0.157358,-0.732483,-0.0471522,-0.356466,-0.0504687,-0.539595,0.0576627,-0.0791637,0.226483,0.609758,-0.0741355,-0.361311,-0.47309,-0.0095348,0.208341,-0.0882558,-0.00458894,-0.124884,0.485311,-0.0850465,0.560885,-0.171723,-0.433603,0.548081,0.258456,-0.0606578,0.00163087,0.346743,0.312525,-0.55337,0.445318,-0.234649,0.130345,0.2455,0.361033,0.495479,-1.17343 +3417.79,0.984925,0.0848144,4,1.62059,0.721943,-1.4317,0.598242,0.491526,-0.200414,-0.0993733,0.0933295,0.0237041,0.0327046,0.567702,0.0478963,-0.860689,0.464822,-0.0084224,0.596234,0.2748,-0.453928,-0.177857,0.355591,-0.0635341,-0.811132,-1.30387,0.571402,0.159301,-0.00938033,-0.0864034,0.20095,-0.423558,-0.337293,1.04988,-1.10536,-0.175425,0.27761,-0.189469,-0.247429,-0.196985,0.186564,0.57666,-0.356821,1.04431,0.438993,-0.136955,-0.290212,-0.0950235,-0.237726,-0.528127,-0.112549,0.310253,0.381021,-0.349118,0.0568655,0.10746,-0.42634,0.466895,-0.266158,-0.500079,-0.32164,0.585724,-0.416733,-0.0170815,0.771801,0.0593915,-0.458006,-0.200022,0.430279,-0.253606,0.13963,-0.153913,-0.119913,-0.162795,1.31747,0.166662,-0.311453,0.925077,0.489711,0.872368,-0.0633676,-0.214182,-0.00511327,0.666803,-0.123971,-0.0317338,-0.319763,-0.869489,-0.391578,-0.296974,-0.557406,0.013595,-0.339858,0.276849,-0.199417,0.103095,-0.364085,0.302358,-0.803383,0.605736,-0.0493679,0.693316,0.0623629,-0.214079,0.141702,-0.381535,-0.275053,0.312049,-0.56903,0.0626214,-0.041982,0.163664,0.771649,-0.129462,-0.451958,0.268317,0.409949,0.36492,0.526715,-0.0651767,-0.1559,0.249318,-0.710135,-0.401027,-0.318687,0.385954,0.404746,0.0663943,0.19146,0.00406856,0.443907,0.0618089,-0.368362,0.311129,0.187999,-0.0740604,0.268035,-0.106018,-0.142849,-0.199118,-0.465001,0.298785,-0.527463,-0.194922,-0.0946983,-0.599979,-0.36778,-0.149179,0.0268021,-0.508709,0.477018,-0.495284,-0.290278,0.413501,0.0752132,-0.0544422,-0.0476762,0.279048,0.247483,0.174786,-0.179942,0.294412,-0.184995,0.113972,-0.144642,0.893041,0.219308,0.586605,0.343592,-0.489193,0.123482,0.0793833,0.245491,0.0784749,-0.37042,-0.343406,0.195539,0.0430734,-0.174192,-0.305764,-0.0454205,-0.0538475,0.893115,-0.477469,-0.431261,0.629674,-0.242529,0.316331,0.0724388,-0.492402,-0.421454,-0.351985,-0.232423,0.352871,-0.1472,0.293101,-0.486081,0.107764,-0.042684,-0.248641,-0.371862,-0.614237,0.468293,-0.180309,-0.478671,0.22697,0.0192289,0.267146,-0.201579,-0.150547,0.736457,0.35511,0.217149,0.206593,-0.42216,0.134884,-0.652112,0.154223,0.106054,0.0361292,0.0226499,0.752645,0.177555,-0.182206,-0.404733,0.13645,0.55878,-0.498315,0.452154,0.158456,0.309806,0.148152,0.146355,-0.274769,-3.83915e-05,0.324267,0.302482,-0.38816,0.355194,0.435567,0.20037,0.433562,-0.450864,-0.61951,-0.361792,0.204031,0.102896,0.437469,0.541432,-0.183532,0.070978,0.556259,0.0562359,-0.267296,-1.25363,-0.0692978,-0.713847,0.24411,0.122819,-0.286924,0.0196318,-0.275869,-0.022231,-0.367088,0.327431,0.0619088,0.590977,0.156833,0.35544,-0.0242779,0.402573,-0.285443,0.154981,-0.571354,0.0993492,-0.497471,0.212119,-0.208682,0.196474,0.173266,0.176787,0.202225,-0.678767,-0.283212,-0.431887,0.0422344,-0.168706,-0.277701,0.115314,-0.134625,0.654181,0.22581,0.651489,0.0826074,-0.0735924,-0.0580604,0.29514,-0.0329644,-0.373405,0.131032,-0.159477,-0.639749,-0.201988,0.139511,0.15663,0.185672,0.395765,0.430897,-1.05254 +3411.19,0.756696,0.0848144,4,1.54045,0.693118,-1.52882,0.65929,1.10467,-0.115203,-0.00797334,0.39937,0.0978027,0.0390864,0.56638,0.104366,-0.59271,0.11781,-0.162085,0.328765,0.282732,-0.13369,-0.136703,0.0812895,0.377188,-0.718475,-0.523102,0.624152,0.0321906,0.275606,0.462986,-0.0147615,-0.69627,0.104842,0.846567,-0.474771,0.171024,0.359545,0.290003,-0.259328,-0.21484,0.354507,0.754772,-0.253651,0.844484,0.50857,-0.0190427,-0.375255,-0.267533,-0.594093,-0.388913,0.238395,0.227763,0.0635807,-0.0853135,-0.169284,-0.0234309,-0.0300012,0.53539,-0.555964,-0.614297,-0.777065,0.309117,-1.04116,0.592971,0.993458,0.368715,-0.550168,-0.379803,0.267534,-0.0142005,-0.190442,-0.600458,-0.539295,-0.257147,1.2132,0.805145,-0.0164384,0.204449,0.356384,0.641195,0.497061,-0.109165,0.0467516,0.911535,0.0930388,0.013092,-0.290898,-0.543112,-0.526027,-0.0903731,-0.337817,0.29021,-0.443089,0.381204,-0.230798,0.122694,-0.333261,-0.101063,-0.222974,0.595459,-0.366231,0.0456325,0.0583976,0.230755,0.288741,-0.753355,-0.284108,-0.244731,-0.181516,0.530018,-0.0525594,0.198831,0.573212,0.172999,-0.118805,-0.22774,0.248916,0.0126834,0.244363,-0.263574,0.135884,0.146182,-0.191701,-0.678813,0.0670557,0.0850927,-0.456446,0.142959,0.0591965,-0.00801965,0.0718929,-0.296467,-0.402207,0.438742,0.141223,0.0704936,0.874218,0.0939916,0.0297689,-0.248208,-0.788276,0.151247,-0.354556,-0.811153,-0.0569682,-0.44127,-0.219854,-0.2346,0.134531,-0.557461,0.746417,-0.299765,-0.555261,-0.346968,0.453264,-0.397409,-0.0702361,0.292615,0.206139,0.0228037,-0.248376,0.102451,-0.33457,-0.0474792,0.163395,1.2455,0.572375,0.367863,0.0157851,0.228566,-0.300972,0.13231,0.536049,0.262094,-0.0995284,0.0388878,-0.0208121,-0.203529,-0.402832,-0.357741,0.0634698,0.271131,0.412749,-0.465471,-0.235736,0.461721,-0.0803236,0.0863681,-0.601996,-0.12392,-0.676181,0.219363,-0.419681,-0.207112,-0.0403541,-0.0649409,-1.07055,0.496948,-0.128112,-0.224496,-0.274425,-0.395644,0.64034,-0.346106,-0.739503,0.156829,-0.22609,0.764541,0.0532896,-0.0970559,0.928086,0.440562,0.0904304,-0.121387,-0.198006,-0.174473,0.222622,-0.053193,0.478115,-0.769677,-0.244819,0.538583,-0.135823,-0.156345,0.0556494,0.297845,0.74376,-0.737166,0.315286,-0.588242,0.235078,0.311136,0.558002,-0.332062,-0.177534,0.451642,0.194459,-0.0404145,0.343088,0.572355,-0.245948,0.378884,-0.446179,-0.0997644,0.307214,0.0611359,-0.473321,0.684673,0.0846621,-0.157996,-0.152667,0.449817,-0.0396486,-0.759941,-0.445354,0.16841,-0.398645,0.303433,-0.0683325,-0.514186,-0.383877,0.427065,-0.0850405,0.0934342,0.49609,-0.28967,0.176944,0.360719,-0.178799,0.0429949,-0.166864,-0.200252,0.0261323,-0.975057,0.104562,0.448552,0.0582087,0.13132,0.168236,0.172109,0.0900868,0.537658,-0.558295,-0.00398006,0.230508,-0.174748,0.416593,0.208754,0.578313,0.206356,0.169409,-0.0113864,0.193611,0.1389,-0.0321871,0.370741,-0.103427,0.297069,-0.586562,-0.0473222,0.0370325,0.0450584,0.167528,0.557418,0.130922,0.193543,0.361832,0.439935,-3.14541 +3420.13,0.99289,0.0848144,4,1.57616,0.893215,-1.04213,0.383048,0.881685,-0.0951808,0.172061,-0.204052,0.212247,0.314307,0.530508,-0.241498,-0.315498,0.391357,-0.0964907,0.86561,-0.0664921,0.0771463,-0.0387707,-0.0462591,-0.138737,-0.914111,-0.982579,0.188886,-0.000485166,-0.500552,-0.170903,0.358284,-0.969362,-0.138982,0.263206,-0.642159,0.254203,0.267262,0.0400115,-0.123786,-0.338383,0.516053,0.454082,0.0897427,0.901094,0.731413,-0.00436776,-0.200355,-0.195257,0.128109,-0.49762,0.285246,0.0161471,0.166525,-0.335493,-0.287341,0.0195694,-0.288121,0.534419,-0.637423,-0.149676,0.101694,0.356291,-0.516368,-0.191052,1.17773,-0.829192,-0.73208,0.190282,-0.159086,-0.0198051,-0.0402441,0.0888015,-0.52872,-0.226629,0.451139,0.41676,-0.261656,0.444328,0.538321,0.266551,-0.0600116,-0.473644,-0.0863941,0.727292,-0.368373,0.0681771,-0.280439,0.372353,-0.189662,-0.62403,-0.383337,-0.260976,0.374146,-0.164173,0.17747,0.22087,-0.446011,-0.276876,-0.221796,-0.298987,-0.238097,-0.0422835,0.477124,-0.231772,-0.0302245,-0.616132,-0.0286319,0.546768,-0.821873,0.220107,-0.0844922,0.106562,0.636966,-0.153881,-0.128372,-0.0764776,0.474696,0.477662,-0.0216969,-1.48491,0.206503,0.637776,-0.27578,-1.109,0.0178296,0.198557,-0.438059,-0.30774,-0.154534,0.137233,-0.490173,0.0690589,-0.43045,0.246277,-0.116582,-0.0627529,0.720339,-0.105711,0.257074,0.329337,-0.214093,-0.011629,-0.146438,-0.240369,-0.394013,0.0263373,-0.55341,0.459598,-0.0538214,-0.548226,0.721233,0.241659,-0.505966,-0.392045,0.317223,0.109264,0.116011,0.677108,0.166592,0.652997,-0.40419,0.0244849,-0.418768,0.166865,-0.512437,0.679379,0.122959,-0.206695,0.246706,0.0359697,0.380253,-0.215087,-0.315445,0.00203587,0.25878,-0.150423,0.0136943,0.404559,-0.338714,-0.108349,0.54525,0.519217,0.604168,0.0658107,-0.0827692,0.237716,0.0412958,-0.106936,-0.0520843,-0.500155,-0.56351,0.347928,-1.58922,-0.122341,-0.0910817,-0.671118,-0.137407,-0.322041,0.246268,0.39797,-0.393174,0.348689,0.369001,-0.297358,-0.443262,0.711811,0.149287,0.494859,0.0911565,-0.285565,1.17955,-0.42374,-0.00624534,-0.297284,-0.409073,0.303426,0.0230087,-0.484861,-0.0132945,-0.0447698,0.0542893,0.166868,-0.586431,-0.117148,-0.208824,0.0143861,0.260046,-0.180133,0.265032,-0.50966,-0.0215195,0.290681,0.262131,-0.0721741,0.252466,-0.468977,-0.0373096,-0.549894,0.452258,0.666427,-0.580195,0.489388,-0.623969,-0.274208,0.399572,0.258259,0.132274,0.10014,0.315453,-0.078628,-0.0524532,0.437797,-0.253399,0.0199412,-0.000148615,0.197182,-0.460522,-0.124914,0.207236,-0.286495,-0.0670828,0.42118,-0.166975,-0.0970665,0.708338,0.639099,0.753736,0.886579,0.474583,0.352232,-0.117331,-0.108873,0.0177193,-0.662509,-0.325736,-0.690157,-0.05519,0.16768,0.227431,5.65889e-05,-0.427388,0.781042,0.172411,-0.491975,-0.501166,0.278843,-0.397525,0.534591,0.242291,0.0306518,-0.306532,0.225819,0.342569,-0.145999,0.0449467,0.212041,-0.0308123,-0.083578,-0.244636,0.110751,-0.219816,-0.0780345,-0.0444046,-0.0794122,0.152933,0.187501,0.391066,0.433013,-2.72193 +3404.2,0.770552,0.0848144,4,1.55955,0.954323,-1.16103,0.375067,0.736061,-0.040209,0.425408,-0.0348567,0.178426,0.231841,0.0906617,-0.0572454,-0.0978441,0.0391815,-0.0871797,1.03284,-0.0568671,-0.218803,-0.0129079,-0.0287254,-0.157463,-0.844254,-0.762769,0.356552,-0.0341817,-0.203176,-0.102753,0.0431011,-0.930337,-0.143908,0.285979,-0.186657,-0.126328,0.267651,0.220905,-0.362254,0.0571428,0.642661,0.610173,0.0563279,0.778075,0.663886,0.159517,-0.284562,0.00747419,0.409349,-0.242918,0.120435,0.330297,0.224312,0.131414,0.00617913,0.341555,-0.384928,0.475995,-0.58547,-0.220012,0.240079,0.388968,-0.641731,-0.423839,1.15117,-0.391269,-0.584332,0.218713,-0.100656,0.138522,-0.195052,-0.00456748,-0.813715,-0.0736858,0.31836,0.124571,-0.567208,0.364269,0.292535,0.625051,-0.286589,-0.527799,-0.145464,0.751642,0.0570725,0.0765004,-0.646845,0.138438,-0.01544,-0.518846,-0.239444,-0.214839,0.486953,-0.0991924,0.168724,0.0424692,-0.353073,-0.471764,-0.430168,-0.519653,0.309977,-0.0998806,0.457852,-0.204644,-0.0920267,-0.580393,-0.00981232,0.129723,-0.513356,0.0717471,0.0597888,0.402669,0.599329,-0.148551,-0.380933,0.012942,0.427489,0.18646,-0.274605,-1.28317,0.0587044,0.315424,-0.159093,-0.76714,0.421405,0.146092,-0.178827,-0.309149,-0.343106,-0.184745,-0.253046,0.088999,-0.263999,0.0417801,0.219701,-0.363807,0.727191,-0.210852,0.137916,-0.308301,-0.154641,0.225961,-0.687836,-0.598109,-0.389495,-0.336886,-0.670351,0.57428,0.0861667,-0.394718,0.668858,0.0996581,-0.673966,-0.175847,0.361304,0.188791,-0.198834,0.476032,0.17368,0.269837,-0.548905,0.00687166,-0.47974,0.0746579,-0.62386,0.637025,0.126435,-0.0592389,0.27534,0.211369,-0.0269654,-0.35973,-0.194696,-0.176071,0.419898,0.0354894,0.0210478,0.209673,-0.437586,0.0317448,0.587206,0.395462,0.359467,0.00137911,0.266395,0.401302,0.126748,-0.536503,-0.317226,-0.163376,-0.546771,-0.0356516,-1.5822,-0.164993,0.100469,-0.760178,0.0729774,-0.455355,0.367548,-0.0228496,-0.490526,0.126481,0.280408,-0.145078,-0.452717,0.208749,0.0594967,0.406789,0.5587,0.0526989,1.31949,-0.372339,0.0836352,-0.292034,-0.211921,0.510364,-0.481252,-0.636701,-0.175841,-0.173034,0.352554,0.0363308,-0.546933,0.131552,-0.014776,-0.121854,0.225524,-0.205999,0.552808,0.00222002,0.0527784,0.352726,-0.189497,0.0984016,0.117791,-0.625465,0.0257853,-0.699494,0.281312,0.589067,-0.412864,0.364331,-0.74444,-0.168631,0.720866,-0.088116,0.409905,0.172605,-0.237135,0.0623545,0.136436,0.653085,-0.336963,-0.215917,-0.202203,0.354769,-0.369354,-0.243496,0.378935,-0.417751,0.077571,0.50042,-0.51971,-0.192019,0.195935,0.344209,0.660207,0.86457,0.283866,0.00258417,-0.0991253,-0.0803604,0.124179,-0.182689,-0.450875,-0.546907,-0.0232768,0.131691,0.0247137,0.0490828,-0.255946,1.02452,-0.0851124,-0.229346,-0.212802,0.143158,-0.0377882,0.196176,0.236274,-0.178931,-0.405548,-0.0105064,0.436729,-0.019578,0.136672,-0.0779987,-0.4619,-0.257982,-0.599476,0.129164,-0.264899,-0.283112,-0.352942,0.455228,0.135976,0.250797,0.36875,0.500797,-2.30683 +3400.3,0.861485,0.0848144,5,1.4462,0.836451,-1.28702,0.397065,0.432808,-0.171166,-0.41115,0.128957,0.28125,-0.113356,-0.395138,-0.545541,-0.176937,0.638363,-0.212116,0.495913,0.286932,0.0334116,-0.285905,-0.265723,-0.269272,-0.818548,-0.730954,0.0413079,-0.300379,0.251196,0.128448,0.509251,0.0298253,-0.120726,0.801584,-0.437865,0.0483892,0.597496,0.0747708,-0.433127,-0.226624,0.444744,0.223152,-0.39639,1.16919,0.611264,0.399651,-0.884141,-0.197401,-0.107561,-0.164496,0.0789225,0.759695,0.346846,0.214435,0.715934,0.25489,-0.250772,0.690531,-0.0589979,-0.0170193,-1.03648,0.471846,0.028914,0.688144,0.86226,-0.288984,-0.739843,-0.0948595,0.334256,-0.299237,-0.00800991,-0.236885,0.0281329,0.0832577,0.0915854,0.555196,0.185066,0.582902,0.628185,-0.10388,0.407958,0.440692,0.0533425,0.0962133,-0.520915,-0.0108949,0.0939478,-0.536874,-0.222118,0.278851,0.0109276,0.477958,-0.83728,-0.0630627,0.113792,-0.225345,0.322008,0.823503,-0.195839,0.749668,-0.975828,0.331826,0.251736,-0.230033,-0.275866,0.0373525,-0.150899,-0.00400405,0.166015,0.335574,-0.046801,0.108726,0.687025,0.118758,-0.0865788,0.356948,0.423415,0.32101,0.695307,0.493323,0.0656518,0.323857,0.178699,-0.509104,-0.664437,-0.0603139,0.116503,0.0692307,0.724899,0.60591,0.326022,0.244913,-0.303494,0.245797,-0.712785,-0.028937,0.0778557,-0.127001,-0.25304,0.512644,-0.018463,0.298477,-0.075377,0.15812,0.156534,0.220811,-0.617472,-0.452596,-0.117368,0.266465,0.405202,0.0174526,0.336756,0.263364,-0.352472,0.0479577,0.385154,-0.061884,0.421048,0.164125,0.296503,0.294408,0.233308,0.349006,0.404944,0.901309,-0.0419557,-0.157768,-0.2439,0.0345734,-0.258241,0.3795,-0.151252,0.172595,-0.379204,0.196443,0.236203,-0.0417409,0.0283733,-0.541787,-0.445651,0.0843295,0.817555,0.111729,-0.471159,0.142421,-0.150641,0.0527822,-0.158104,-0.265546,0.0383135,0.421247,0.946481,-0.18388,-0.537031,0.600452,-1.06127,0.490989,0.173245,0.552605,-0.226979,-0.810658,0.102871,-0.12498,-0.316209,-0.183464,-0.162682,-0.373536,-0.256093,-0.49805,0.939957,0.20914,0.284136,0.0392121,-0.38998,-0.05817,0.482454,0.0748385,0.546237,-0.417793,0.169701,0.330261,0.251064,-0.206479,-0.75004,0.10283,-0.373372,-0.38151,0.66883,-0.982905,-0.119713,0.0240258,0.0811263,0.00981116,0.050373,0.415855,-0.0262284,0.0587732,0.418995,-0.0842683,0.443275,0.546539,-0.406679,-0.407842,-0.0641962,0.42365,-0.277555,0.596371,0.489356,0.665226,0.359271,-0.75878,-0.646431,-0.193601,-0.787771,0.420925,-0.055285,0.274231,0.387723,-0.216561,-0.300799,0.0192848,0.445507,0.123687,0.101563,-0.303718,-0.382343,-0.265115,0.244276,0.248811,-0.286006,0.160581,-0.327946,-0.179616,0.307771,0.0968564,-0.186114,-0.0828439,0.176629,0.286374,0.277575,-0.23165,0.216798,0.144175,-0.170476,-0.841312,-0.0613765,0.292492,0.228357,0.314047,0.790546,0.0807396,-0.407235,0.383802,0.42146,0.595979,0.621616,-0.138333,-0.131329,0.367796,0.123452,0.308989,0.00171621,-0.935037,0.136879,0.275232,0.369972,0.524625,-1.12699 +3421.28,0.999957,0.0848144,4,1.65004,0.931904,-0.638219,0.194899,0.52923,-0.129837,-0.369269,-0.277939,0.242174,0.225284,0.0647406,-0.421768,0.0641299,0.773086,0.0826165,0.713141,0.0326656,-0.563941,0.0265123,-0.690404,-0.201129,-0.575783,-1.21028,-0.181493,0.199235,-0.0707145,0.345916,0.30354,-0.354765,-0.039402,0.727922,-0.424418,0.0783118,0.326116,-0.640518,-0.115995,-0.124905,0.671458,1.00454,-0.244484,0.980424,0.280941,-0.151197,-0.813661,-0.351309,0.208481,-0.746346,-0.00148334,0.0747365,0.185122,-0.0055344,0.483018,0.0763588,0.0551554,0.842678,-0.238521,-0.472713,-0.923972,0.445709,-0.567037,0.0316943,0.797908,-1.2889,-0.714086,0.222435,0.383905,0.0912898,-0.266656,0.0212754,-0.606955,-0.283826,-0.00511633,0.128894,0.178498,1.1013,0.483351,0.484404,0.0342118,-0.0478561,-0.0712242,0.503581,0.205177,0.401813,-0.683316,-0.479912,0.0563848,-0.405641,0.00808848,-0.00631731,0.195794,-0.424349,-0.0451935,-0.241362,0.333255,0.345586,-0.520861,0.286965,-0.607083,-0.224477,0.430969,0.151022,0.43361,0.134463,-0.0830949,-0.0420424,-0.651801,0.311623,0.0316969,0.028227,0.68853,-0.090635,-0.260907,0.0585037,0.307861,0.382163,-0.00778384,0.2237,-0.1387,-0.0205452,-0.170181,-0.584799,-0.315388,-0.582163,-0.117696,0.44656,0.226854,-0.036969,-0.0513407,0.382165,-0.321961,0.230131,-0.373166,-0.162939,0.905866,-0.361073,-0.103803,-0.460019,0.688685,0.272317,-0.781984,0.161662,-0.025195,0.0116145,-0.717957,0.0878948,0.258555,-0.138221,0.292608,-0.355679,-0.0261053,-0.739519,-0.455131,0.041494,0.257643,0.417542,0.0390126,-0.0300467,-0.0661204,-0.111172,-0.451092,0.0393931,0.39874,1.12425,-0.235109,0.124774,0.134686,0.193731,-0.475575,-0.347389,-0.117609,0.0517008,-0.375755,-0.283902,0.231695,-0.205444,-0.0411777,-0.0555484,0.390357,-0.197069,0.791376,0.412011,-0.476912,0.141757,-0.0684371,-0.0760481,-0.273426,0.364502,-0.317439,0.095,-1.00792,-0.140147,-0.15136,-0.503832,-0.334371,-0.0860055,-0.165808,0.28145,-0.316542,-0.489064,-0.00182532,0.0636701,-0.282863,0.369369,-0.160908,0.39293,-0.113564,-0.371513,0.714827,0.0506009,-0.159162,-0.241528,-0.267786,-0.0398768,-0.0173243,-0.201076,-0.1574,-0.0350595,-0.0256686,0.77604,-0.283913,0.508405,-0.287318,0.517461,0.273426,0.0221446,0.335044,0.0550126,-0.535142,0.461501,-0.0500024,-0.191397,0.00339073,-0.542908,0.0477724,-0.165716,0.144308,0.588128,-0.0195884,0.852953,-0.308683,-0.480412,-0.0154609,0.447288,0.398882,-0.0840149,-0.467512,0.376531,-0.210096,-0.29386,-0.48462,0.251193,-0.775142,0.481728,0.148585,-0.182575,0.950517,-0.180449,-0.0788838,0.30434,-0.0136836,0.441025,0.407168,0.289491,-0.272838,-0.127088,0.271002,-0.344346,-0.690012,-0.320735,0.156778,-0.366322,-0.541611,-0.485789,-0.377936,-0.182247,0.263106,-0.118704,0.178384,0.589635,-0.190554,-0.0853893,0.200656,-0.361351,0.128882,-0.0109619,0.114081,-0.144859,0.114841,0.588127,-0.151693,-0.249454,-0.395448,-0.173797,0.286995,0.417843,-0.294831,0.199785,0.218946,-0.0410456,0.0326791,0.382159,0.13666,0.270705,0.369675,0.520293,-1.5715 +3414.03,0.903083,0.0848144,4,1.54414,1.08057,-0.945761,0.368517,0.497597,-0.0890316,0.432235,0.742664,1.01503,0.200898,0.232821,0.0735242,-0.228714,0.468336,-0.576928,1.26188,0.288593,0.0372427,0.103859,-0.293629,-0.197903,-1.1533,-0.271238,-0.284947,-0.153971,-0.302977,-0.0231759,0.955221,-0.298976,0.103755,0.467645,-0.112564,0.414329,-0.0788524,-0.502858,-0.201471,-0.638213,0.883519,0.0785352,-0.429035,1.16811,0.516611,0.702327,-0.985221,-0.26398,-0.859191,-0.312065,0.574491,0.542079,-0.195856,0.121357,0.555526,-0.398534,-0.575118,0.221541,-0.485583,0.0558994,-1.03338,0.107981,-0.250641,0.825505,0.911326,-0.361705,-1.14846,0.443538,0.0758631,-0.0122308,-0.0522359,0.418825,-0.130026,0.180692,0.626192,0.57331,-0.43577,-0.225653,0.0217982,0.280753,-0.21786,0.114431,0.00737085,0.263232,-0.687443,0.0505395,0.297976,0.272101,-0.0315167,0.362337,-0.157207,0.0357449,-0.814201,0.481448,0.0207744,0.119821,-0.167514,-0.402995,0.0125029,-0.477406,0.165063,0.375671,-0.136717,0.358662,-0.312496,-0.508101,-0.0814003,0.280181,0.220961,-0.0569765,-0.678978,0.0547886,0.26078,-0.203089,0.557539,-0.0642676,0.304635,-0.0938226,0.195082,-0.540126,0.304141,0.418714,-0.251749,-0.428378,0.0224035,0.540226,-0.299587,-0.215222,-0.00234065,0.168703,0.367343,0.0139565,-0.0847595,-0.173275,-0.0888606,0.566149,-0.240674,-0.0157449,0.278046,0.324526,-0.122228,0.185276,-0.160441,-0.276661,0.0944584,-0.219799,0.0761378,-0.038352,-0.173301,0.416604,0.374185,0.204766,0.00051827,0.152137,0.637385,0.32856,-0.430844,0.18488,0.36587,0.153335,0.203973,-0.036609,0.33995,0.293558,-0.287932,0.341884,0.406455,-0.225812,0.0823682,-0.492579,0.0204849,0.0976695,0.180785,0.535966,0.219449,0.0413508,0.0488393,0.107066,0.115254,-0.487361,-0.503692,0.260965,0.709005,0.10587,0.509572,-0.112049,0.123713,-0.0561733,-0.236696,-0.495495,-0.131535,0.158284,0.51583,-0.163564,0.383893,0.400889,-0.608698,0.332071,0.410693,0.362139,-0.431903,-0.313809,0.179499,-0.0408141,-0.114475,-0.11742,-0.100899,-0.652725,0.131799,-0.093441,1.00703,-0.186408,0.432674,0.161705,-0.254425,0.0889312,0.367277,-0.364069,0.332648,-0.200586,0.113923,0.164991,-0.313943,-0.482847,-0.550992,-0.24558,0.108387,-0.398057,0.10537,-0.634802,0.00894617,-0.489689,0.40264,-0.0431824,0.0711226,0.427447,-0.278452,0.311008,0.670811,-0.441524,-0.214884,0.215088,0.293391,0.283335,-0.529772,-0.115056,-0.35106,0.39759,0.690192,0.0678206,0.467744,0.529658,-0.413463,-0.110865,-0.295093,-0.048191,-0.116651,-0.280392,0.0123556,-0.434906,0.0273147,-0.337379,0.19825,-0.449607,-0.00790469,-0.063472,0.086446,0.43675,-0.101769,0.324288,0.532231,0.324698,-0.150461,0.0629559,0.0984823,0.118469,0.422452,0.178235,-0.261522,0.122965,-0.029793,-0.102013,0.37487,0.158592,-0.0129105,0.0868483,-0.344263,-0.10845,-0.246202,-0.0673648,-0.00772599,-0.055806,-0.283509,0.121107,0.538866,0.21106,0.329383,-0.660852,-0.218023,-0.151891,-0.0659888,0.0749881,-0.231196,-0.557503,0.101049,0.28872,0.317882,0.537327,-1.84848 +3431.71,0.921714,0.0848144,4,1.62061,1.14226,-0.539387,0.151386,0.626257,-0.107906,0.712618,0.236056,0.815198,-0.185818,-0.523057,-0.680763,-0.397037,0.133672,0.121972,1.32809,-0.144957,-0.0068681,0.0889659,-0.20325,-0.365255,-0.689152,-0.884006,-0.341384,-0.31926,-0.431371,-0.228352,0.291909,0.00635817,0.276341,0.598133,0.0950526,0.524927,-0.080966,-0.328559,-0.0755546,-0.150465,0.281165,0.965132,-0.44244,0.927046,0.369995,0.196968,-0.773216,0.127766,-0.207975,-0.274716,0.0145238,0.445963,0.126301,-0.0743914,0.424662,-0.544214,-0.103933,0.378463,-0.205395,-0.640918,-0.904752,0.166028,-0.335121,0.0610647,0.963816,-0.75914,-1.24071,-0.0064266,0.115291,-0.059517,-0.113508,-0.291814,-0.0963574,-0.0552112,0.218417,0.442917,0.0335446,0.40599,0.396616,-0.0208652,-0.374726,-0.188818,-0.0636518,0.0242938,-0.41601,0.355324,-0.188017,0.102375,-0.2871,-0.449744,-0.460429,-0.486213,-0.229615,-0.223247,0.238439,0.276373,-0.366225,-0.104753,-0.155696,0.437337,-0.213363,0.22128,0.0491575,0.179742,0.055223,-0.594246,-0.261144,0.0257011,-0.703449,0.346362,-0.190461,0.464061,0.112138,0.13604,-0.256676,0.0811435,0.627203,0.576567,0.245518,-0.079785,-0.0671355,-0.457933,0.192512,-0.414844,-0.419005,-0.236448,0.245068,-0.449681,-0.228388,0.164047,0.309561,0.342199,-0.41285,-0.0068493,-0.112708,0.190261,0.106365,-0.207514,-0.623106,-0.136627,-0.0518711,0.201267,-0.374335,0.124412,-0.0875296,0.688593,-0.386543,0.383476,0.0755816,0.225229,0.0874123,-0.147986,-0.298588,-0.407998,-0.130862,-0.244656,0.402105,-0.0337143,0.0565132,0.00687799,0.0055556,-0.162438,-0.0369809,-0.0425156,0.218206,0.519712,0.280334,-0.501642,-0.0896172,-0.155994,-0.250615,-0.0492687,-0.0839611,0.658117,0.141774,-0.0733025,-0.0251396,-0.19015,0.0645595,0.116009,-0.234658,-0.133096,0.358124,0.221972,-0.410669,0.563729,-0.142886,-0.143164,-0.499139,-0.257537,-0.56815,0.467491,-0.199445,-0.234601,-0.150218,-0.399578,-0.631651,-0.0438868,-0.308356,0.0361515,-0.423442,-0.0194375,-0.116031,0.0798143,0.0503412,-0.172862,0.108099,-0.292225,-0.406372,-0.169038,0.869224,-0.306334,-0.146977,0.307398,-0.0241431,-0.17351,0.0736712,-0.0828329,-0.00110819,-0.54823,-0.108936,-0.414903,-0.452835,0.247015,-0.57994,0.529533,-0.65799,-0.0397495,0.139067,0.130198,-0.490017,0.0400208,-0.00476279,-0.0395979,0.20915,-0.432872,-0.654897,-0.286057,0.342457,-0.209979,0.0940173,0.217562,-0.292717,-0.427123,0.03651,-0.0745901,-0.0961542,-0.143408,0.432937,0.258134,-0.00788708,-0.386103,0.13437,0.0423837,-1.09081,0.531979,-0.0330871,-0.205104,0.392641,-0.545613,-0.321178,-0.410754,-0.0816804,0.912783,0.823112,0.196841,-0.0363041,-0.378211,0.160567,-0.0314453,-0.858276,-0.423652,0.42206,-0.26169,-0.238488,-0.197096,-0.518732,-0.16781,0.0293354,-0.287977,0.211613,0.415001,0.0398019,-0.346454,0.360581,-0.381653,-0.342846,-0.424226,0.187502,-0.216338,0.705229,0.348905,-0.22199,0.0522462,0.365016,0.125267,0.0983923,0.229654,-0.368189,0.071243,0.306894,-0.0900729,-0.268645,-0.174406,0.0889976,0.365161,0.298325,0.604286,-2.31109 +3422.51,0.993059,0.0848144,4,1.61789,1.08636,-0.389894,0.113581,0.606744,-0.0975545,0.841936,0.293414,0.499259,-0.086964,0.00255201,-0.535604,0.0400269,0.152428,-0.0679944,1.63086,0.182078,0.107391,0.561255,-0.120864,-0.198046,-0.86821,-0.972647,-0.043373,-0.120738,-0.0727292,0.0573878,0.329255,0.0364149,-0.0349464,0.648796,-0.0299534,0.151562,-0.0488775,-0.197205,0.023893,-0.318112,0.204676,0.919086,-0.574525,1.00111,0.224235,0.221606,-0.508412,0.180295,0.0958058,-0.306321,0.163425,0.390318,-0.259927,-0.0998976,0.661324,-0.604079,-0.291361,0.492209,-0.100735,-0.307508,-1.07076,0.336815,-0.428841,0.164737,0.798089,-0.559456,-0.985266,-0.300103,-0.0101868,-0.104021,0.353689,-0.340971,-0.285691,-0.197162,0.628775,0.724314,0.0656856,0.33925,0.311604,0.0976121,-0.467343,-0.594208,-0.190758,0.338465,0.0832814,0.366145,-0.138467,0.272303,-0.279013,-0.454114,-0.00485026,-0.298468,-0.326577,-0.307843,0.262507,0.103878,-0.0487285,-0.0289613,-0.314067,0.27627,-0.242139,0.0176234,0.0329529,0.298517,-0.257182,-0.677313,-0.0612704,0.445423,-0.351133,-0.253559,-0.224892,0.282163,0.514484,0.523226,-0.149204,-0.152017,0.209569,0.387748,-0.297884,0.0134329,0.141131,-0.434755,-0.163111,-0.373621,-0.120677,-0.190141,0.691442,-0.606601,-0.230943,0.402892,0.24426,0.393411,-0.406874,0.154787,-0.372786,0.123308,0.0993266,-0.312181,-0.543123,-0.345394,0.0297346,0.263667,-0.574288,0.339557,-0.19299,0.353755,-0.253487,0.0246614,0.0080413,0.797801,0.0458355,-0.213115,-0.110592,-0.644823,-0.0133599,-0.28231,0.0186917,0.211279,0.386433,-0.0836231,-0.232463,-0.181393,-0.218623,0.032355,0.251949,0.572134,-0.0843371,-0.414963,-0.340132,0.0227061,0.0638077,-0.181472,0.236906,0.551642,0.567188,0.0322611,-0.284084,0.162448,0.549415,0.241657,-0.28387,-0.126194,0.472301,0.347112,-0.333944,0.297164,-0.33185,-0.656651,-0.266133,-0.0779883,-0.12322,0.532532,-0.714217,-0.335226,0.313207,-0.241757,-0.366358,-0.320326,0.0464366,0.0374,-0.569059,-0.393046,-0.0383166,-0.133683,-0.467987,-0.365012,-0.10636,-0.0564426,-0.0187301,-0.184298,0.788913,-0.516922,-0.196743,0.31267,-0.199311,-0.277627,0.337776,-0.321777,-0.273133,-0.382374,0.0127809,-0.596385,-0.445008,-0.18304,-0.575906,0.210707,-0.661097,-0.151519,0.56827,-0.0550022,-0.557705,-0.0357571,0.486992,-0.613852,0.107959,-0.183118,-0.438223,-0.264672,0.379346,0.137444,0.549118,0.275233,-0.0531743,-0.312009,0.118644,0.154301,-0.414323,-0.110219,0.378424,0.416751,0.542534,-0.112967,-0.1699,-0.0480187,-1.07458,0.419254,-0.203162,-0.141881,0.252226,-0.504237,0.278902,-0.0270645,-0.0197419,0.448291,0.923602,0.370472,-0.071233,-0.378497,0.325836,0.16108,-0.68952,0.024158,0.246098,-0.0836897,-0.664765,-0.127803,-0.0465967,-0.163991,-0.0645328,-0.194256,0.14438,0.445647,0.170301,-0.170606,-0.0446561,-0.423684,0.0986047,-0.237866,0.336827,-0.32646,0.503927,0.764825,-0.539606,0.298839,0.138933,0.585533,0.0837233,0.245211,-0.00538324,-0.152645,-0.0133516,-0.00756494,0.267306,-0.183729,0.147775,0.348097,0.384415,0.589997,-2.19548 +3416.71,0.739373,0.0848144,4,1.55061,1.07006,-0.239703,0.0628723,0.649165,-0.224928,-0.042089,0.339916,1.29937,0.156602,0.153325,0.165018,-0.108289,0.423494,-0.243318,0.663742,0.261006,0.0961529,-0.00526737,-0.18005,-0.372225,-0.727422,-0.268349,-0.185,-0.526463,-0.118189,0.0178261,0.784605,-0.676,0.0636038,0.734827,-0.167863,0.462372,0.532369,-0.234351,0.0609437,-0.569035,0.426533,0.195446,-0.14998,0.707094,0.480303,-0.0473552,-0.103535,-0.417044,-0.212198,-0.57824,-0.0571692,0.267126,-0.0837368,0.216342,-0.193182,0.237165,-0.138165,0.621263,-0.523786,-0.0395497,-0.806249,0.62609,-0.377266,-0.158655,0.873198,-0.414571,-1.81953,0.190844,-0.284886,-0.153698,-0.602042,0.622592,-0.695368,-0.00311044,0.33105,-0.0845531,-0.189786,0.480825,0.686848,0.48466,-0.68507,-0.123404,0.19639,0.561871,-0.391798,0.187017,-0.0905914,-0.247472,0.021309,0.563653,-0.0822256,0.466837,-0.519489,0.116075,0.051216,-0.258079,0.135308,-0.321297,-0.187035,0.0686181,-0.236335,0.370169,0.369192,0.180143,0.37174,-0.461497,-0.0977464,-0.109752,-0.347003,0.4954,-0.298865,0.73652,0.418475,-0.456493,0.392964,-0.230164,0.568218,0.066634,0.124916,-0.575939,-0.192739,0.783076,-0.148527,-0.678651,-0.419588,-0.380875,-0.767672,0.231919,0.354747,-0.21693,0.344405,-0.0455163,0.00822872,0.412419,-0.332209,0.231128,0.723854,-0.0951874,0.0547159,0.125225,-0.319893,0.265671,-0.575342,-0.659068,0.267823,0.27515,-0.37255,0.0783562,0.00119312,-0.374267,0.687178,-0.0687224,0.0239124,0.317607,0.0988654,0.310261,-0.349844,0.196503,0.220791,0.338152,-0.401053,0.102949,0.257514,0.463559,-0.392081,1.03667,0.0609002,0.103216,0.047046,-0.0601948,-0.0565755,-0.319155,-0.201996,0.0247768,-0.79131,-0.0372649,0.115025,-0.270912,0.0925845,-0.517693,-0.101478,0.587736,0.689573,0.00354319,0.222888,0.133463,0.321326,0.570273,-0.623375,0.655249,-0.360837,-0.133145,-0.436884,-0.105912,-0.0289766,-0.355478,-0.559127,0.171612,0.0618357,-0.139245,-0.226794,-1.47428,0.363258,0.125087,0.155394,0.730065,-0.256514,-0.378383,0.14138,-0.516315,0.864312,-0.605962,0.692015,-0.46917,-0.0180273,0.201156,0.424527,-0.180742,0.24558,0.421183,0.0610396,-0.0399794,-0.62275,-0.176837,-0.819246,-0.185938,-0.00714737,-0.167581,0.348432,-0.183228,-0.00767869,-0.0945986,0.191099,0.294339,0.0284909,-0.058552,0.28725,-0.258286,0.634597,-0.414422,-0.073004,0.579646,-0.486448,0.244801,-0.039621,-0.554045,0.593203,0.272916,0.455117,0.629671,-0.112177,-0.316928,-0.434594,-0.648138,0.236925,0.0817748,-0.206125,-0.193385,0.413155,-0.0421105,0.226893,0.419028,0.485887,0.284783,0.0454805,0.188781,0.714762,0.763542,0.427762,-0.130241,0.472036,-0.171044,-0.171005,0.169877,-0.0674844,0.403957,0.459358,0.151226,0.232021,0.216931,0.0895585,0.309955,-0.407539,-0.253605,-0.801696,0.25966,-0.192639,0.327443,0.586826,-0.0807899,0.149922,-0.066858,0.0599762,0.0542233,-0.0738959,-0.0533749,0.241769,0.0980887,-0.753565,-0.197942,0.0462882,-0.163061,-0.655756,0.107668,0.165909,0.211057,0.407319,0.45941,-2.37375 +3392.72,0.956596,0.0848144,4,1.4695,0.943082,-0.353024,-0.0166062,0.235424,0.112086,0.757952,-0.515657,0.0359181,0.089472,0.119062,-0.0678009,0.164251,0.369772,0.513945,0.590731,0.30233,-0.280516,0.113136,-0.0935603,-0.186069,-0.814317,-0.765033,0.167287,0.202027,-0.0118937,-0.0096564,0.0907923,0.170953,0.0574532,0.847441,-0.325329,-0.547985,0.576402,-0.234478,-0.0407618,-0.0224404,0.261468,0.588346,-0.651936,1.0444,-0.172848,0.15012,-0.516347,0.0610436,0.38058,-0.223688,-0.0558957,0.736451,0.297155,0.601756,0.872547,-0.153554,-0.789078,1.27625,0.0336968,-0.232724,-0.457971,0.848877,-0.578449,0.869819,1.10038,-0.182009,0.242039,0.0975894,-0.192646,0.664463,0.448151,0.0716463,-0.648104,-0.179942,0.435679,0.877084,-0.301695,1.02195,0.705397,0.444199,0.179781,-0.320917,-0.226627,0.351367,-0.340602,0.438855,-0.326553,0.378619,0.327634,-0.153472,0.302813,-0.0653651,-0.233505,0.0442535,0.782046,-0.355505,0.44667,0.447277,-0.543636,0.412608,0.135617,0.190713,0.339853,0.469863,-0.0622322,-0.537203,0.26788,0.500768,-0.494734,0.178914,-0.177214,0.237287,0.2133,-0.729335,0.175602,0.417144,0.372232,0.640183,0.125294,-0.948729,0.0803023,-0.205541,-0.460227,-0.648763,-0.256997,-0.902933,0.0849136,-0.357432,0.626452,0.292583,-0.241841,0.249509,-0.88298,-0.268689,-0.151293,-0.0903941,0.674469,0.17651,0.0575881,0.11901,0.21953,0.446406,-0.398072,-0.782457,-0.098335,0.128543,-0.703325,0.31754,0.173781,-0.152438,0.0252494,-0.274542,-0.16805,-0.110402,-0.336476,0.389711,-0.113072,-0.378912,0.279999,0.173884,0.27758,0.199603,0.483673,0.418787,-0.019436,0.985472,-0.592875,-0.331424,0.612443,-0.071786,0.067354,-0.280251,0.374827,0.420501,0.882565,-0.106632,-0.493643,0.184779,-0.327261,0.0737592,0.237312,-0.512647,0.795144,-0.0835793,-0.2497,-0.212951,-0.21816,-0.55384,-0.672786,-0.664922,-0.368235,0.36731,-0.338218,-0.132673,-0.172848,-0.201557,-0.00504812,0.304451,0.376356,0.166945,-0.651838,0.295557,0.00742699,0.0300641,-0.0147861,0.0769256,0.262569,0.244403,-0.419588,-0.236138,0.893544,0.137997,0.223663,0.0771644,0.0495383,0.132271,0.206746,0.0243895,0.284725,-0.553349,0.342393,0.618086,-0.499702,0.4611,-0.277754,-0.0673567,0.254084,-0.478792,0.530526,-0.396399,-0.674086,0.368239,0.0150714,-0.276666,0.13391,-0.470476,-0.211607,-0.713538,0.185574,0.573983,0.0576686,0.641684,-0.677658,-0.143598,0.154361,0.0119164,0.0504261,0.321444,0.207792,-0.0062372,0.0977184,-0.481546,-0.474487,-0.429052,-0.968863,0.718734,0.125056,0.10829,0.0849726,-0.377983,0.228216,-0.42087,-0.0883488,-0.298254,0.566408,0.361156,-0.436766,-0.0722618,0.101735,0.0512801,-0.462403,-0.025945,-0.320228,0.067875,-0.229874,-0.721113,-0.518566,-0.196679,0.337923,0.00787815,0.382653,0.0552455,0.784246,-0.0291055,0.201705,-0.343111,0.308661,-0.161021,-0.174638,-0.254616,-0.71378,0.641406,-0.220244,0.164637,0.203728,0.580675,0.762845,-0.277042,0.37384,-1.05088,-0.123364,-0.0658606,-0.501336,-0.37305,0.185776,0.241332,0.431018,0.491256,-0.806165 +3391.23,0.979211,0.0848144,4,1.42562,0.915921,-0.630212,0.130052,0.398895,0.0296294,0.36197,-0.482351,-0.0420051,0.405013,0.177775,0.0636656,0.124114,0.48308,0.541046,0.645336,-0.139651,-0.241353,0.106511,-0.0621776,0.132184,-0.654546,-0.740197,0.2485,0.0783533,-0.157987,0.22655,0.351539,-0.163864,0.0929478,0.83889,-0.487495,-0.216168,0.739935,-0.202855,0.0442022,0.0218165,0.357098,0.53159,-0.720833,1.06998,0.131459,0.146069,-0.477924,-0.237944,0.11183,-0.185628,-0.0205719,0.498681,0.460846,0.71095,0.406572,0.286522,-0.745915,1.26275,0.0998377,-0.092059,-0.352513,0.558665,-0.214778,0.458367,1.06694,-0.291478,0.138988,0.301168,-0.284773,1.15954,0.45105,0.0714552,-0.422217,-0.0228302,0.557613,0.807464,-0.37173,0.959963,0.702408,0.19362,-0.0940414,0.0716186,-0.421846,0.406058,-0.224337,0.435709,-1.04869,0.100535,0.198299,-0.183912,0.321259,0.322241,-0.425633,0.135873,0.767307,-0.209779,0.423503,0.312368,-0.664235,0.286928,0.0796171,0.173334,0.181921,0.625574,-0.575015,-0.967519,0.0105369,0.115419,-0.796386,0.0236386,-0.265431,0.0172578,0.304185,-0.83569,0.309333,0.373008,0.332477,0.606729,-0.0567834,-0.777898,0.203216,-0.125938,-0.284196,-0.671904,-0.463747,-0.70096,0.146524,-0.336515,0.706421,0.0392907,-0.267564,0.169568,-0.373616,-0.416061,-0.049905,-0.13689,0.557935,0.131091,0.0921314,0.0815299,0.226016,0.254054,-0.568824,-0.584974,-0.0499543,0.157178,-0.6558,0.236451,-0.0380694,0.131872,0.0385085,0.156425,-0.476335,-0.240635,-0.177882,0.242887,-0.347426,-0.41166,0.504913,0.381266,-0.00325149,0.330634,0.564459,0.391987,-0.155458,1.05113,-0.556469,-0.441718,0.519773,-0.00981641,0.255528,-0.291453,0.526308,0.374862,0.650817,-0.198332,-0.463789,0.406526,-0.461756,0.476507,0.52755,-0.467214,0.505368,-0.212717,-0.310775,0.291236,-0.0420618,-0.677457,-0.916744,-0.634974,-0.561551,0.412213,-0.201024,-0.312917,-0.0947496,0.162225,-0.0589442,0.42154,0.228353,0.0440477,-0.722292,0.178141,-0.0496348,0.218191,0.0337065,0.260005,0.656646,0.188724,-0.454786,0.190651,1.05269,0.161807,0.480575,-0.310705,0.102417,0.327285,0.184923,-0.153529,0.141848,-0.529183,0.156537,0.881234,-0.663764,0.0475871,-0.119042,-0.0198061,0.275009,-0.0966071,0.486384,-0.262567,-0.404059,0.633027,0.580056,-0.524782,0.0942322,-0.0859066,-0.00704069,-0.490257,0.629129,0.759579,-0.0866905,0.556873,-0.598441,0.136245,0.453026,0.304165,0.0135249,0.391677,0.288127,0.0523022,0.226181,-0.422051,-0.375571,-0.319407,-0.694641,0.396193,-0.0161311,-0.529963,0.260471,-0.349101,0.111284,-0.266219,-0.0212313,0.0450344,0.306268,0.127792,-0.158016,-0.173589,0.216784,0.145483,-0.310783,0.196157,-0.63736,0.25427,-0.297375,-0.638171,-0.47033,0.106717,0.358414,0.204221,0.501023,0.0700728,0.428127,0.0646523,0.568539,0.093212,-0.0677533,-0.300903,-0.0962552,-0.351838,-1.02541,0.424913,0.0448774,-0.286943,0.265884,0.495492,0.748188,-0.197762,0.245277,-1.01465,-0.200121,-0.250444,-0.862679,-0.211624,0.202479,0.251764,0.449977,0.501761,-1.31755 +3432.95,0.988427,0.0848144,4,1.43709,0.876461,-0.73702,0.218979,0.331956,0.0451565,0.0486597,-0.250844,0.138912,0.1188,0.168471,-0.232815,0.282922,0.509556,-0.180341,0.857372,0.557558,0.0683032,0.373725,-0.00791165,-0.0385671,-0.850036,-0.903878,0.407084,-0.152749,0.153989,0.108032,0.235861,-0.0901239,0.108272,0.628928,0.0281934,-0.186796,0.411195,-0.129866,-0.0301883,0.174633,1.0229,0.276864,0.177802,0.995945,0.284354,0.0633617,-0.336727,-0.0443609,-0.00337438,-0.354837,0.343084,0.553853,0.455218,0.205257,0.300134,-0.285747,-0.0719653,0.950835,0.103527,0.182591,-0.190825,0.0608237,-0.560011,0.819102,1.17875,0.246069,-1.35691,-0.110052,0.568428,0.229914,0.536753,0.190348,-0.709238,0.332426,-0.312493,0.462116,0.0801659,0.70146,0.364161,0.562942,-0.0906701,-0.167904,0.321326,0.116583,-1.06333,0.248632,0.463021,-0.114891,-0.0135795,0.680403,-0.199089,-0.195665,0.146981,0.309426,-0.0092408,-0.28847,-0.15894,-0.089839,-0.452892,-0.230414,-0.255467,0.381832,0.620878,0.284681,0.0440282,-0.77203,-0.18459,0.0388303,-0.642154,0.487919,0.0986393,-0.281553,0.828855,0.358962,0.0778959,0.450395,0.497403,-0.0793511,0.0745072,-0.697907,0.498588,0.358409,-0.166775,-0.139244,-0.283576,-0.500714,-0.0821896,-0.189477,0.545757,0.160803,0.0900151,0.344794,-0.215891,-0.197749,0.0626461,0.0571207,0.322681,-0.288684,0.155988,-0.282239,-0.24275,0.154034,-0.253466,-0.0819936,0.215649,0.370738,-0.652462,-0.384965,0.173635,-0.0702537,0.530063,-0.190679,-0.0582964,0.630678,0.0868305,0.450913,0.5713,-0.00978485,0.0130717,0.49068,-0.40651,0.17459,0.456912,0.227702,0.201748,0.926468,-0.0989776,-0.221492,0.344501,-0.178196,-0.619275,-0.57918,-0.215479,0.882687,-0.771643,0.16256,-0.21251,-0.325796,0.234072,-0.270692,-0.32939,-0.219673,0.700538,-0.189064,-0.158127,0.189102,-0.0034768,0.259548,0.244429,-0.000752401,-0.0819688,0.386269,-0.203331,-0.0430222,0.0380137,0.374053,-1.13294,0.306703,0.00253114,0.658679,0.010505,-0.78698,0.689589,-0.217242,-0.349193,0.0656092,-0.0242011,0.394641,0.0375148,-0.131301,1.31323,0.0386437,0.310105,-0.0735548,-0.182662,0.407713,-0.225282,0.0204691,0.275673,0.0457022,0.361919,0.346641,0.206504,0.0982568,-0.389698,0.164642,0.00736789,0.0765525,0.648402,-0.416013,-0.11839,-0.0342378,-0.0284055,-0.123326,0.0471232,-0.303617,-0.428032,0.0266338,0.89183,0.065409,-0.108481,0.456758,-0.483933,-0.0450421,0.676117,-0.0331375,0.458999,0.0711097,0.151319,0.373189,-0.263419,0.0290768,-0.502183,-0.0330488,-0.39501,0.106385,-0.215979,-0.416207,0.402542,-0.322584,0.264843,-0.449126,0.128413,-0.235569,0.244597,-0.22937,0.480849,0.0674518,0.044758,0.123943,-0.335707,-0.287917,0.0478819,-0.39924,0.0265093,-0.729293,-0.127678,-0.305458,0.163696,0.00498646,0.37412,0.211896,2.55335e-05,-0.151668,-0.772483,-0.446966,-0.142067,0.407995,-0.389401,-0.092253,0.933191,-0.123613,-0.277005,0.0444738,-0.25447,-0.118084,-0.436557,-0.0462253,-0.405458,-0.099809,-0.258879,-0.499263,0.222866,-0.214978,0.138083,0.194751,0.371595,0.441306,-1.04619 +3433.17,0.924248,0.0848144,4,1.39518,0.994066,-0.722709,0.131736,0.360075,0.065229,0.287175,0.100921,0.542121,0.0964679,0.130647,-0.496116,0.0363766,0.489147,0.0881683,1.03041,0.477879,-0.370637,0.358682,0.0945323,-0.251752,-0.72104,-0.752727,0.133946,0.0271457,-0.167241,-0.0460445,0.221089,-0.204792,-0.0226124,0.541705,0.369749,0.228382,0.209183,0.268716,-0.254543,0.0306455,0.635299,0.293195,0.0827456,0.926836,0.716146,0.110888,-0.577497,-0.219676,0.145612,-0.710555,0.0198452,0.401161,0.776547,0.387205,0.367129,-0.113049,-0.27457,0.96798,-0.0178252,-0.35855,-0.400171,0.601779,-0.102961,0.034186,1.09355,-0.45397,-1.02008,-0.591007,0.431621,-0.207977,-0.0252781,0.435088,-0.446677,0.0236036,0.350569,0.728997,-0.202675,0.660086,-0.152072,0.552347,-0.21121,0.0445025,-0.224111,0.195056,-0.547913,0.497489,0.538401,0.15773,0.00591718,0.272395,-0.431844,0.086909,-0.0320831,-0.300875,-0.262222,0.0302037,-0.333555,0.170357,-0.532483,0.145726,-0.0640421,-0.177352,0.736664,0.0288616,0.0350196,-0.176795,0.0572668,0.41113,-0.44688,0.0237169,0.23749,0.111415,0.451622,0.219963,0.417693,-0.0111009,0.580806,-0.0677624,0.277835,-0.689228,0.407328,0.236607,-0.298575,-0.47843,-0.527183,-0.743044,0.0812919,-0.230479,0.739537,-0.391238,0.224749,0.360211,-0.527217,-0.033245,-0.0509399,-0.243558,0.440417,-0.531226,-0.170707,-0.231807,-0.167119,0.48646,0.094476,0.0608336,-0.160431,0.267339,-0.633123,-0.329064,0.293979,-0.314981,0.324443,0.0671283,0.173232,0.415612,0.0828996,0.313069,0.635362,0.342604,0.689375,0.480002,-0.28461,0.409839,0.53006,0.711811,-0.121858,1.42215,-0.218706,0.279154,0.338126,0.307278,-0.428656,0.0886384,-0.290998,0.337828,-0.558142,0.0463889,-0.14421,0.163955,0.166995,0.0411512,0.0566634,0.1829,0.0715359,-0.285238,0.393499,-0.0479004,0.123803,0.291751,-0.21719,-0.29904,-0.219872,0.766949,-0.349218,0.134175,-0.202395,0.413863,-0.694361,0.169167,0.0253167,0.0484511,0.120807,-1.03542,0.52747,-0.256644,-0.730728,0.00887881,-0.188564,0.105844,0.220933,-0.194912,1.22359,0.171948,0.171337,-0.173053,-0.355256,0.575599,-0.0695868,-0.0505499,0.287146,-0.265741,0.360921,0.00520177,-0.0124679,0.488215,0.0823211,0.320011,-0.273281,0.0277882,0.728673,-0.565399,-0.318546,0.130907,0.22987,0.0945953,0.153431,0.0136567,-0.527498,-0.067121,1.02132,-0.183555,-0.122459,0.452012,-0.829502,-0.154869,0.246814,-0.0253097,0.019412,0.263264,0.656189,0.347766,0.0786952,-0.369956,-0.223748,-0.0829002,-0.591708,-0.117219,-0.17538,-0.0787287,0.248745,-0.21085,-0.407943,-0.084059,-0.115318,0.214229,-0.0391556,-0.151288,0.346732,-0.295411,0.0334112,0.136205,-0.316889,0.406295,0.325346,-0.311899,-0.227754,-0.0956582,-0.159488,0.114588,0.177424,0.0681975,-0.00187387,0.504345,0.310551,0.173758,-0.239241,-0.271081,-0.448393,0.135862,-0.145936,-0.0277703,0.434991,0.148289,-0.0560803,-0.143769,0.181666,0.113958,-0.0150558,0.185816,-0.2325,-0.270394,-0.213805,-0.244415,0.16697,0.0796903,0.133291,0.155615,0.365091,0.394481,-1.31917 +3432.87,0.38413,0.0848144,4,1.51642,1.01456,-0.51888,0.00255713,0.637815,-0.056475,0.00166204,0.253599,-0.171106,-0.0778288,-0.0558126,-0.417876,0.00201123,0.094964,-0.0354859,0.654488,0.583135,-0.158555,0.0254549,-0.0407684,-0.348209,-0.262677,-0.430065,0.237823,0.0982112,0.119283,0.308425,0.562431,-0.0692697,0.0589345,0.533709,-0.125679,0.0507546,0.203202,0.0708618,0.101852,-0.0969857,0.43869,0.645128,0.0773385,0.809512,0.810221,0.0030338,-0.336011,-0.241812,-0.179634,-0.793955,0.075593,0.187727,0.430737,0.385994,0.201784,-0.0416007,-0.762411,1.16083,0.292438,0.316344,-0.490456,0.22672,-0.0840459,0.293754,1.02825,-0.315496,-0.797453,-0.569683,0.425487,-0.00573901,-0.150249,0.0361439,-0.357018,-0.226736,0.143865,0.445475,-0.529382,0.503467,-0.140457,0.321528,-0.35386,-0.411638,-0.0307044,0.291589,-0.536033,-0.0330414,0.0956511,0.0244002,0.00328592,-0.351246,-0.443455,0.322176,-0.0399494,-0.209433,-0.0973537,0.148737,0.330467,0.461512,-0.133675,0.242948,-0.0226172,-0.805488,0.712624,0.148265,0.0280518,0.0980203,0.149614,0.0909825,-0.21741,0.30386,0.337172,-0.275945,0.35106,0.249778,0.527583,0.262367,0.470308,-0.025286,0.126445,-0.327724,0.249839,0.0949877,-0.361826,-0.498986,-0.296779,-0.491516,-0.0617052,0.0382291,0.229849,-0.186001,0.28105,-0.0817673,-0.0723928,-0.492377,-0.119472,-0.416445,0.836053,-0.5185,-0.126544,0.0609195,-0.198756,0.282647,-0.905897,-0.245475,-0.231765,-0.021408,-0.692055,-0.498231,0.435861,-0.175394,0.279198,-0.175985,-0.617187,0.165227,0.170916,-0.127504,0.434943,0.216601,0.778391,0.19782,0.257914,0.443949,-0.143496,0.746928,-0.182463,1.30163,0.0869018,0.344961,0.0901332,0.423215,-0.179931,-0.432488,-0.293202,0.933836,-0.240424,-0.0234193,-0.421296,-0.222831,0.728387,-0.239147,-0.326194,0.40681,0.505362,-0.13987,0.446271,-0.0768979,-0.0419306,0.251328,-0.326485,-0.369565,-0.381653,0.628127,0.0109648,-0.130504,0.247388,0.155397,-0.681528,0.371646,-0.447232,0.0642463,-0.091614,-1.0826,0.576383,-0.169557,-0.54986,-0.0106832,0.24721,-0.424935,0.0420239,-0.244029,1.08974,0.349886,0.210901,0.00137119,0.0309121,0.178725,0.162211,-0.298445,0.108857,-0.368646,0.494898,0.165104,0.112666,0.224135,-0.150281,-0.0243374,0.188836,-0.150618,0.742531,-0.887378,0.0514916,0.313702,0.436879,0.164796,0.169842,0.136244,-0.385507,-0.247955,0.664419,-0.300172,0.115588,0.871512,-0.4477,0.0579045,0.000874234,0.266924,0.215842,0.789964,0.32357,0.296036,-0.0942654,0.0128786,-0.0728932,-0.0847161,-0.328253,-0.337799,-0.293101,-0.188695,-0.156284,-0.158688,-0.504744,0.29976,-0.149377,0.0827588,0.229949,0.228943,0.26422,-0.597923,0.32999,-0.271859,-0.905888,0.211323,-0.223067,-0.0768562,-0.568688,0.0538251,0.192118,0.319441,-0.148053,0.175051,-0.0476879,0.663059,-0.245788,0.862904,0.587606,-0.430064,-0.106382,0.627714,0.115715,-0.168481,0.488008,0.447246,-0.119624,0.0759493,0.138817,0.0224835,0.36577,0.185156,-0.567311,-0.287502,-0.154658,-0.0423815,-0.129479,0.415409,0.145312,0.247206,0.381198,0.497198,-2.11037 +3444.57,0.998348,0.0848144,4,1.51664,0.960437,-0.873102,0.225774,0.41257,-0.0505365,-0.0759684,0.158608,0.568014,0.187831,0.12968,0.0202558,-0.176753,0.39489,-0.0534214,0.698097,0.0596657,-0.276554,-0.12168,0.0880576,-0.529564,-1.03448,-1.08461,0.242026,-0.484481,-0.246142,0.111844,0.381425,-0.0803585,-0.0562578,0.839326,0.124466,0.29417,0.0252962,-0.277186,-0.381432,0.0803958,-0.0682128,0.199047,-0.17992,0.807412,0.362081,0.25867,-0.0703035,-0.276403,0.226373,-0.297684,-0.0881877,0.1499,-0.0708018,0.356281,0.190544,0.0624052,0.154827,0.635985,-0.0133592,-0.175084,-0.848449,0.198255,0.0256086,0.102896,0.65733,-0.30624,-0.31914,0.716926,0.383043,-0.0190899,0.318021,0.306231,-0.580106,-0.3228,0.595308,0.646274,-0.739162,0.620781,0.390918,0.445118,-0.300609,-0.163654,0.29256,0.591607,-0.473241,0.245376,0.176265,0.179609,0.052707,0.163341,-0.254046,0.117819,-0.311581,0.316821,0.162925,0.0841171,-0.0898414,0.251004,-0.489813,-0.229601,0.195015,0.577539,0.434502,-0.0379921,-0.0289297,-0.794052,0.154039,0.282401,0.285964,0.847104,0.384826,0.400224,0.4109,-0.442814,0.095915,0.143665,0.54932,-0.112206,0.395968,-0.308138,0.436424,0.365844,0.406448,-0.504668,-0.295018,-0.840347,-0.395079,0.0646978,0.469558,0.0815001,0.741992,-0.106533,-0.0448518,-0.0848896,0.105636,-0.278053,0.306123,-0.102102,0.0273275,-0.368652,-0.396719,0.581606,-0.386697,-0.179815,-0.350911,0.393664,-0.854259,0.134802,-0.299658,-0.292015,0.349102,-0.239695,-0.329756,0.124955,0.273626,0.702353,0.205672,0.11033,0.409005,-0.166008,0.0555418,0.300589,0.0499586,0.118989,-0.00181928,0.697917,-0.0841031,0.323118,-0.209227,0.0722346,0.37382,-0.729492,0.0153104,0.136915,0.207769,0.238277,-0.0390831,0.00121939,-0.557887,0.129354,-0.294169,0.249675,1.09324,0.370347,-0.644935,0.239846,-0.301707,-0.500992,-0.462668,0.140942,-0.139854,0.0309729,-0.276359,0.113504,0.202468,0.0173121,-0.758562,0.149822,0.51824,-0.0133345,-0.399471,-0.508464,0.264577,-0.221974,0.120267,0.151678,-0.556003,0.59925,-0.378204,-0.427525,0.714447,-0.0464104,-0.163959,0.505086,-0.0877348,0.193534,-0.270296,-0.705755,0.286232,-0.568527,0.441516,0.327631,0.0297484,-0.195601,0.256717,0.289028,-0.0464172,-0.734435,0.902705,-0.307392,-0.462794,-0.442331,0.298191,0.199121,0.184441,-0.534338,-0.168838,0.320148,1.08164,0.168676,0.243516,0.747288,-0.298833,-0.30806,0.176754,0.300848,-0.0229852,0.722853,0.181644,0.243205,0.360538,-0.145791,-0.409922,-0.0466152,-0.420053,0.285131,0.0396044,-0.418606,0.183746,-0.0239963,0.313049,0.122561,0.133968,-0.0454353,0.387803,-0.286627,0.151212,-0.119124,-0.022987,-0.0495659,-0.349713,0.196425,-0.16881,0.267287,0.289347,-0.493253,0.510485,-0.306071,0.270662,0.356815,0.143947,0.194931,-0.59799,-0.219672,-0.403517,-0.491892,0.448802,0.295918,0.360643,0.0838164,0.241864,-0.30885,-0.486015,0.0916884,0.188051,0.0387152,0.258524,0.468594,-0.511869,-0.236796,-0.104309,-0.0756993,0.189991,0.106469,0.1473,0.0939524,0.383796,0.306517,-1.29374 +3418.53,0.966405,0.0848144,5,1.78208,0.826772,-1.16203,0.524799,0.958369,0.0361058,0.0314545,-0.131542,-0.387212,0.181822,-0.154943,-0.113398,0.0463136,0.190997,-0.122736,0.715222,-0.691767,-0.170615,-0.231034,0.0731375,-0.12009,-1.18006,-0.435022,0.0634883,-0.789147,-0.0143168,-0.0774564,0.514942,-0.76836,-0.207066,0.61289,-0.716565,-0.0613756,0.429232,0.0456488,-0.144997,-0.724066,-0.104483,0.230528,-0.325279,0.748917,0.391402,0.0887845,-1.19073,-0.186184,-0.497023,-1.0943,0.345334,0.195519,-0.258364,-0.606342,0.202481,0.055978,-1.04244,0.2578,-0.53317,-0.360878,-1.48356,0.378143,-0.955677,-0.376402,0.956284,-0.591801,-1.60137,-0.73711,-0.0390949,0.142311,-0.30264,-0.114419,-0.316056,0.0616793,-0.0631155,0.463045,0.45785,0.513398,0.848175,0.303821,0.339493,-0.572522,-0.357156,0.251843,-0.300208,0.144359,-0.170225,-0.0821278,-0.0513804,-0.0851354,-0.102836,0.0836557,-0.534096,-0.461617,0.0817771,-0.0872839,-0.240141,-0.31305,-0.159383,0.297623,-0.615782,-0.238747,0.239416,0.233717,0.114802,0.12956,-0.737439,0.0331732,-0.965424,-0.252276,-0.566226,0.265428,0.675137,0.322059,-0.367196,0.407687,0.445856,0.367429,-0.29458,-0.291346,0.22842,0.233684,-0.48766,-0.664246,0.117522,0.609759,0.312783,-0.1331,0.0248732,0.48929,-0.507837,0.543354,-0.748115,0.229555,-0.0445963,0.191443,0.719461,0.225869,0.00871453,0.367208,-0.207745,0.080914,-0.528513,-0.641669,0.114718,-0.0995091,0.160687,-0.0137141,0.567519,0.148254,0.476575,0.0853868,0.0163756,-0.33778,-0.0096243,-0.623092,-0.499829,0.322795,0.19714,0.509838,0.202429,0.0456567,-0.034295,0.246019,-0.0132359,0.432199,0.213481,-0.311856,0.605894,-0.142145,-0.534599,0.521609,-0.0157173,0.05358,0.207384,0.0011584,0.00100808,-0.000859605,0.292835,-0.22905,0.349986,0.146756,0.377661,-0.370965,0.315295,0.238261,0.209837,0.403132,0.188782,-0.505289,-0.541227,0.181387,-0.407884,0.00809087,-0.216632,0.0106101,0.188775,0.178906,-0.199025,-0.262958,-0.371453,-0.561959,-0.423411,0.0368105,-0.314318,0.401454,0.526211,-0.57304,0.232646,-0.295812,0.962832,-0.185008,0.681937,-0.577956,-0.451178,-0.111676,0.4798,0.377735,0.253328,0.22886,0.0311628,0.257679,-0.651325,0.197172,-1.23009,-0.232369,0.630513,0.161194,0.205241,-0.117651,0.0870795,0.567086,-0.277597,-0.363663,-0.00683726,0.36668,-0.121778,-0.985619,0.25214,-0.00361371,-0.240897,0.295044,-0.398208,0.0161555,0.172129,-0.3912,-0.00470003,-0.00260157,0.10131,0.530195,-0.273393,-0.160108,-0.186014,-0.156503,-0.660604,0.627036,-0.341486,-0.0921509,-0.254003,-0.540226,-0.297569,-0.283009,-0.165547,0.432061,0.430091,0.431992,0.164382,0.354414,0.232654,-0.269073,0.055162,-0.147329,0.109231,-0.961089,-1.03266,0.00675631,-0.496811,0.15885,-0.262758,-0.166193,-0.148422,0.276251,0.538154,-0.150774,0.207901,0.0710107,-0.275443,-0.00887722,0.0212135,-0.331389,0.0882747,0.260776,0.443949,-0.0373278,0.0132638,0.0711967,-0.164492,-0.368778,-0.125328,0.276801,0.0130447,-0.435738,-0.515955,-0.0309969,0.135817,0.392084,0.368533,0.626166,-2.75737 +3398.3,0.895659,0.0848144,4,1.70879,1.03331,-0.797401,0.388753,0.630194,0.0905202,0.419624,-0.0725752,0.104116,-0.0174573,-0.202218,-0.48642,0.146497,0.230792,-0.562764,0.860112,-0.391215,-0.00617868,-0.368791,-0.0589028,-0.180872,-0.344656,-0.704211,-0.0716152,-0.746586,-0.313234,-0.233747,0.708329,-1.1328,-0.0498462,0.610366,-0.251973,0.0627309,0.302258,-0.343819,-0.202129,-1.06684,0.336168,0.212825,-0.483204,0.65322,0.26567,0.373215,-1.44472,0.0724084,-0.78933,-0.719623,0.110364,0.174601,0.126589,-0.572412,0.434599,-0.565425,-1.11501,0.108939,-0.675896,-0.395678,-1.23054,0.112189,-0.636156,-0.395122,0.88003,-0.146266,-2.04674,-0.572424,-0.19643,-0.143796,-0.226104,0.168967,-0.358329,0.368388,0.334539,0.484878,0.0479804,0.642573,0.940017,0.506952,0.828474,-0.139845,-0.0965518,0.473076,-0.439801,0.140294,-0.230783,0.187658,0.332705,0.273332,0.412285,0.335354,-0.373248,-0.5994,-0.263247,0.172885,-0.141268,-0.350558,-0.00256797,0.378222,-0.609429,0.315902,0.159908,-0.0612521,-0.34532,0.129808,-0.285592,0.590245,-0.704534,-0.426727,-0.00469565,0.0763067,0.682469,0.032988,-0.335567,0.907435,0.389488,0.0291877,-0.291124,-0.108288,0.132532,0.219289,-0.292888,-0.42614,0.282747,0.765056,0.123785,-0.370062,-0.301979,0.375381,0.0617583,0.605858,-0.166136,0.105975,0.0425255,0.192388,0.60848,-0.244843,-0.266183,0.216349,-0.141438,0.119123,-0.13235,-0.232654,-0.0117186,0.0370816,0.454389,-0.370885,0.0713835,0.176007,0.66032,-0.0643006,0.459805,-0.0244199,0.132275,-0.522876,-0.287081,0.46776,0.509856,0.406615,-0.0374174,0.126141,-0.216633,-0.0301816,0.0610368,0.512367,-0.119486,0.355617,0.416444,-0.0683717,-0.60969,0.208801,0.225952,-0.0361452,0.037523,-0.0997983,0.100636,-0.0160211,0.148498,-0.17427,0.375483,0.290994,0.361912,0.08445,0.701159,0.0496343,0.265707,0.281743,-0.785747,-0.784079,-0.397888,0.456189,-0.517867,-0.13704,-0.034197,0.0311157,0.0730629,0.24501,-0.0900491,-0.401042,0.219285,-0.292736,-0.303822,0.345437,-0.51221,-0.00564009,0.614825,-0.0969302,0.30519,0.0710566,1.11089,0.504414,0.182536,-0.203802,-0.384344,0.0198189,0.459208,0.612727,0.281609,-0.233192,0.143203,0.165301,-0.21062,0.0455472,-0.904607,-0.00761057,0.416423,0.406651,0.297874,-0.614051,0.121485,0.279848,-0.309249,-0.40303,0.1553,0.127927,0.400692,-0.917567,0.324521,-0.446652,0.0136735,0.484222,-0.609549,-0.235054,0.121319,-0.248193,0.0576463,0.120829,-0.23793,0.615116,0.340304,-0.242968,-0.392553,0.264181,-0.56122,0.787603,-0.280688,0.225949,-0.172212,-0.42497,-0.352306,0.0893958,0.0786671,0.402398,0.370879,0.355535,-0.195497,0.376728,0.431448,-0.139525,-0.189978,-0.0644711,-0.0621808,-0.222245,-0.56948,-0.14248,0.0277082,-0.256545,-0.114668,-0.115702,-0.313693,0.547999,0.74216,0.0645315,-0.295493,-0.178562,0.072014,-0.346185,-0.183065,0.424378,0.19876,0.225868,0.737894,-0.315227,0.380386,0.183671,-0.0147562,-0.386799,0.039191,0.403515,-0.0827081,-0.217997,-0.826461,-0.170233,0.138418,0.337778,0.372046,0.581186,-2.18251 +3408.15,0.947527,0.0848144,4,1.70787,0.999034,-0.410475,0.216626,0.915283,-0.133165,-0.183964,-0.0478821,0.746637,0.44862,0.155164,-0.412726,-0.334221,-0.218616,-0.276494,0.833754,-0.114352,-0.0270202,-0.249443,-0.110909,-0.126812,-1.33592,-0.589564,-0.0109167,-0.444263,0.000470609,-0.0926105,0.524348,0.200217,-0.382819,0.825643,-0.770608,0.0166802,0.21899,0.282605,-0.398226,-0.453667,-0.256101,0.359864,-0.151072,0.529028,0.54909,0.0680545,-0.674264,-0.727691,0.296578,-0.855012,-0.355547,-0.119041,0.386894,-0.240962,0.0386131,0.0951705,-0.73899,0.442417,-0.406712,-0.60455,-1.69556,0.15417,-0.754371,-0.314311,0.74415,-1.04942,-0.579085,-0.559055,0.756272,0.332395,0.0127834,-0.128847,-0.460622,-0.0143065,0.195337,0.804803,-0.161727,0.246787,0.638289,-0.0341913,-0.240635,-0.447942,0.0501088,0.52259,-0.263066,0.311319,-0.139397,-0.707646,0.271352,-0.214938,-0.293322,0.356753,-0.418413,-0.0634077,0.826305,-0.0994439,-0.150237,-0.409225,-0.0751178,0.306383,0.102696,-0.427892,0.424265,-0.187787,0.390725,-0.636808,0.00965992,0.236026,0.155159,0.26256,-0.340917,-0.285472,0.422441,-0.0124158,0.0472319,-0.214327,0.237791,0.29532,0.808924,-0.772029,-0.215161,-0.492619,0.676051,-0.739432,-1.01854,-0.145286,0.10863,-0.177921,0.404137,0.0804002,0.296779,0.0585879,-0.54236,0.0119712,0.148223,-0.35993,0.437951,0.0396098,-0.0178991,0.414298,-0.0356845,0.353465,-1.65056,-0.469844,-0.119725,0.367039,-0.891278,-0.0410601,0.0654099,-0.332797,0.545274,-0.195739,-0.695856,0.390759,0.068062,0.101522,-0.0284434,0.0560374,0.511323,0.273205,-0.19774,0.11934,-0.127384,0.0837784,0.11194,1.11186,0.396148,-0.102622,-0.108559,0.00375884,-0.11199,0.0403939,-0.282173,0.538692,-0.0530293,-0.16166,-0.293637,-0.0665402,0.557993,-0.370686,-0.00254261,0.797282,0.625771,0.0783061,-0.667129,0.145139,-0.218312,-0.0102414,-0.255337,-0.141212,0.0118307,0.283738,-0.0724562,0.177325,0.438676,0.261971,-0.494969,-0.197957,0.791004,0.0513183,-0.697961,-0.474788,0.309223,-0.272303,-0.219217,0.429381,-0.156834,-0.31505,-0.0960331,-0.29373,0.66723,0.0195983,0.258145,0.371628,-0.258607,0.111691,-0.155234,-0.28605,0.487,-0.126923,-0.174509,0.0924449,-0.627922,0.115434,-0.660164,-0.115459,0.283546,-1.05212,0.572735,-0.692423,-0.710873,-0.229254,0.256062,-0.782114,-0.158988,-0.274661,-0.425367,0.27155,0.414441,-0.0456572,0.184566,0.302209,-0.464329,0.0617838,0.311953,-0.0104605,0.289992,0.729917,0.161141,0.359777,0.253107,-0.0340031,-0.539192,-0.000366814,-0.517709,0.336661,-0.367589,-0.640273,-0.121759,-0.429667,-0.357153,0.304646,-0.00422856,0.679688,0.572165,0.221776,-0.0566118,-0.043923,-0.179386,-0.101507,-0.0348603,0.174683,-0.0605195,-0.755233,0.00596696,-0.184261,0.13639,0.09727,-0.00795043,0.323368,0.150792,0.069389,0.225459,-0.392037,-0.147108,0.035682,0.0541481,0.358144,-0.12112,-0.307609,0.0143696,0.232335,-0.197224,0.0733868,-0.0195337,-0.132101,0.719608,0.133341,-0.941032,-0.00122331,-0.535995,-0.27883,0.602893,-0.256443,0.163005,0.345015,0.403738,0.587379,-3.0534 +3424.56,0.958154,0.0848144,5,1.61206,0.987825,-0.649745,0.236478,0.813978,-0.0489252,-0.450328,-0.0682598,0.434028,0.380304,-0.0718235,-0.252912,-0.311589,-0.077936,-0.255055,1.36042,-0.157094,0.67246,-0.0856056,-0.0311452,-0.317853,-0.751945,-0.988676,0.117158,-0.159698,0.3336,0.355705,0.623574,-0.683259,0.0152546,0.832011,-0.61654,0.135696,0.433081,-0.562562,-0.145299,-0.0614267,0.246786,-0.139872,-0.385114,0.587731,0.229757,0.40198,-0.532778,0.00388957,-0.645348,-0.975759,0.307338,-0.0949522,0.0960626,-0.233324,0.334791,-0.185351,-0.4162,0.532558,-0.330226,-0.215099,-1.61964,0.514561,-0.498672,-0.541773,0.970583,-0.713618,-1.53663,-0.170606,0.280074,0.374353,-0.369119,0.0353727,-0.193821,-0.16715,0.625115,0.614043,0.149077,0.154258,0.0875182,-0.0739102,0.145329,-0.450535,0.210946,0.916389,-0.0589271,-0.019023,-0.0697683,-0.261619,-0.264441,0.110952,-0.404909,0.392345,-0.619557,0.144726,0.412857,-0.1862,0.15095,-0.481351,-0.401541,-0.0380042,0.164523,0.0597925,0.437463,-0.129559,0.351045,-0.181672,0.460957,-0.388876,-0.0962805,0.10064,0.41648,0.427977,0.809986,0.0106457,0.0170337,0.252271,0.428355,0.33107,-0.178434,0.393807,0.336336,-0.0342599,0.174872,-0.345738,-0.0194857,-0.428133,-0.252857,-0.0707988,0.307174,0.0917553,0.070346,0.259573,-0.211238,0.171566,0.0643785,0.134801,-0.00255524,0.0809351,-0.360305,-0.110245,-0.0677193,0.159722,0.0747678,-0.24861,0.0555308,0.104265,-0.571446,-0.39189,0.685998,0.268534,0.212018,-0.527135,0.0122596,-0.430405,0.0458326,-0.182282,0.00612007,0.068964,0.332365,-0.144494,0.590581,0.20829,0.318677,0.219187,-0.308972,0.569758,-0.271128,-0.110311,0.429871,0.142316,-0.313037,0.0623526,-0.38774,-0.380224,-0.535517,0.0902822,0.254294,0.0746497,0.0768935,0.189487,-0.0519862,0.776872,0.513916,0.127078,0.124885,0.319958,0.444334,-0.683606,-0.457571,-0.562834,-0.625055,0.51186,0.0495124,0.352785,-0.439816,-0.168355,-0.359217,-0.181478,0.194312,-0.474981,-0.162445,-0.00661445,0.412782,-0.0328516,0.0046426,0.14023,0.356039,-0.527021,0.106098,-0.208928,0.776802,-0.760143,0.523375,-0.224587,-0.189974,0.168691,0.258701,0.04134,0.361997,-0.668404,0.390276,0.458227,-0.286045,-0.0330433,-0.373588,-0.142937,0.011882,-0.0501265,0.804193,-0.198064,-0.292309,0.256928,-0.321366,0.125494,0.204884,-0.0575221,0.359032,0.284499,0.373051,0.375296,0.367041,0.68898,-0.847402,0.29762,-0.162083,-0.0840003,0.502449,-0.37769,-0.390623,0.306678,0.198922,-0.375225,-0.0181923,-0.0409678,-0.653602,0.434009,-0.555426,-0.356895,0.101758,-0.154296,-0.252279,0.258376,0.0344912,0.132198,-0.151961,0.0386032,0.251489,0.55413,0.372855,-0.228339,-0.272898,-0.444181,0.192072,0.0456905,-0.459599,-0.201812,-0.207038,0.327838,0.395172,0.558496,0.204396,0.419068,-0.0702547,-0.0302075,0.462265,-0.242515,0.0552413,-0.10923,-0.0469107,0.0317384,0.25805,-0.304966,-0.273368,-0.0238525,0.129479,0.280204,0.411223,-0.0883229,0.148253,-0.0108324,-0.288538,-0.0565114,-0.765869,0.223185,0.141944,0.285739,0.376755,0.534545,-2.70725 +3423.11,0.893181,0.0848144,4,1.62077,0.900887,-0.859453,0.408257,0.882969,-0.0753263,-0.624412,-0.144377,0.394324,0.812791,0.247208,-0.127602,-0.313033,0.13685,-0.126132,1.12919,-0.145493,0.499872,-0.342732,0.142168,-0.21095,-0.85129,-1.43343,0.269502,0.0973397,0.222519,0.641035,0.126578,-0.494405,0.207943,0.942953,-0.334297,0.301637,0.630746,-0.156942,-0.00808046,-0.39799,0.800018,0.267887,-0.577516,0.619918,0.137742,0.823597,-0.446579,-0.311117,-0.344585,-0.736153,0.19597,-0.140067,0.27999,-0.106494,0.312563,0.0166181,-0.383574,0.379526,-0.375172,-0.276037,-1.73937,0.0741463,-0.316778,-0.377199,0.749959,-0.56235,-1.08281,-0.437206,0.369202,0.345366,-0.48989,0.140747,-0.243184,-0.0669751,0.767826,0.532902,-0.0375755,0.132321,0.235565,-0.241226,0.395148,-0.579855,0.0989762,0.495789,-0.273869,0.0509626,-0.156399,-0.32827,-0.119817,0.166725,-0.343148,0.253571,-0.60175,0.410428,0.537235,-0.222042,-0.0488982,-0.467574,-0.209018,-0.444707,-0.116948,-0.0699871,0.354899,0.114176,0.504403,-0.191135,-0.269961,-0.227488,-0.317716,0.0775147,-0.0486758,0.0949218,0.315747,0.496789,-0.239995,0.234033,0.565046,0.363758,0.00304099,0.705773,0.0969386,-0.0707057,0.190454,-0.339209,0.09879,-0.373729,-0.151123,0.234867,0.0922785,0.488126,-0.0371629,0.474057,0.186007,0.287175,0.131085,0.0190741,0.145846,-0.0564634,-0.597645,-0.302235,0.0718082,0.288169,-0.0142247,-0.607397,-0.0312255,-0.128576,-0.645176,-0.350182,0.560492,0.119432,0.46093,-0.338834,-0.176087,-0.636319,0.0156886,-0.254311,0.220478,0.0380101,0.179108,-0.00199767,0.0436059,0.510184,0.537396,-0.110612,-0.364631,0.819012,-0.158755,0.133329,0.341319,0.291449,-0.0315602,-0.237386,-0.485747,-0.147363,-0.422675,-0.190901,-0.100085,0.269574,0.524745,-0.347682,-0.278634,0.390033,0.211764,0.160837,-0.126604,0.0718086,0.499964,-0.757815,-0.255284,-0.412038,-0.729942,0.58665,-0.14886,0.187349,-0.263621,-0.354095,-0.514803,-0.486168,0.000469313,-0.0376963,-0.181912,0.10213,0.622357,-0.0685192,-0.245114,0.425063,0.208208,0.0984746,-0.146032,-0.284197,0.826019,-0.700307,0.347727,-0.394804,0.0236998,-0.0209947,-0.0408314,-0.150125,0.1602,-0.82842,0.176155,0.4743,-0.201593,0.017956,-0.32288,-0.292672,0.0521457,-0.155901,0.774194,-0.0205349,-0.157628,-0.00925464,-0.195282,-0.513565,0.0352967,-0.153805,0.228447,0.263566,0.408015,0.0577253,0.207438,0.500855,-0.300284,0.22559,-0.266496,0.153441,0.208373,-0.308028,-0.294544,0.432066,0.151815,-0.0824956,0.121281,-0.517442,-0.454401,0.371952,-0.641262,-0.366759,0.0988143,-0.256635,0.0381234,0.148568,-0.273021,-0.138515,-0.146751,0.0538558,0.847672,0.579262,0.290168,-0.282447,-0.266065,-0.287486,0.0523464,-0.326213,-0.48498,-0.792472,-0.186042,0.0897117,0.13371,0.670208,0.320678,0.00452451,0.32882,0.182049,0.283057,-0.486699,-0.262879,-0.0190824,-0.290643,-0.350646,-0.0115841,-0.391274,-0.0324804,0.173088,0.0234808,0.279905,0.765528,0.0110102,-0.102538,0.149394,-0.2771,-0.549071,-0.489871,-0.0449808,0.101244,0.303843,0.318189,0.55122,-2.82 +3428.97,0.517454,0.0848144,4,1.55598,0.98356,-0.987072,0.424139,0.808845,-0.00932143,0.319779,0.159019,1.02915,0.124477,-0.169878,-0.659699,-0.0307504,0.252235,-0.113639,1.30243,0.288314,0.175976,-0.416767,-0.0646379,-0.346348,-1.14601,-1.26076,0.0773102,-0.111601,0.213745,0.358605,0.102182,-0.285848,0.0152339,1.09475,-0.250822,0.399897,0.255482,-0.32909,-0.0562278,0.351136,0.0309176,0.283093,-0.564601,0.480193,0.0156877,0.103934,-0.700366,-0.0931525,-0.455836,-0.49843,0.193912,-0.144893,0.0236889,0.00187297,0.469997,0.58016,0.0169896,0.361727,-0.159219,-0.705157,-1.02239,0.334148,-0.402943,-0.119355,1.23254,-0.207169,-1.31681,-0.271095,0.407818,-0.396968,0.232299,-0.244757,-0.270495,-0.0147619,0.281267,0.445486,-0.509999,0.0927732,0.279318,-0.023176,0.0118723,-0.248219,-0.0514636,0.311155,0.133259,0.142224,0.0522573,-0.120529,-0.120964,0.10445,-0.049401,-0.284126,-0.538964,0.264755,0.0205287,-0.343561,0.112943,-0.365875,-0.510689,0.175998,-0.159718,-0.0258524,0.496961,0.418992,-0.416659,-0.613857,0.370938,-0.254838,-0.810287,0.0489766,0.0213485,0.29446,0.343807,0.00476478,-0.873631,-0.0812733,0.336371,0.0882101,0.131189,-0.145386,0.465328,0.132602,-0.0681194,-0.640137,0.657445,-0.0402354,0.119799,0.261609,0.447884,0.118279,0.121721,0.274015,-0.845107,-0.115568,-0.218666,-0.00110246,0.231377,-0.195201,-0.370845,-0.250384,-0.737381,0.281392,-0.208816,-0.316412,-0.260988,0.509844,-0.1188,-0.0499684,0.489499,-0.06377,0.322345,-0.325047,-0.101039,-0.130219,-0.0685933,-0.245744,-0.140569,0.0881235,0.196263,-0.177824,0.658091,0.0161224,0.0292818,0.318137,-0.204107,0.664706,0.482441,0.191007,0.224635,0.282986,-0.208172,-0.487721,-0.192591,0.282866,-0.15201,0.0978078,-0.016487,-0.00336086,0.198148,-0.0867963,-0.114931,0.536371,0.623079,-0.516812,-0.191675,0.295746,0.442978,0.157385,-0.483902,-0.174755,-0.174016,0.270518,-0.202804,-0.35375,0.239814,0.0438014,-0.450218,0.0463996,0.254505,0.221166,0.240544,-0.210864,0.174735,-0.0684823,-0.799577,0.0748415,-0.0134672,-0.47941,-0.32993,-0.275376,0.384256,-0.173531,0.0442753,0.337439,-0.238455,0.0563374,-0.00862958,0.0385792,0.596219,-0.247978,0.433873,0.527766,-0.40873,0.0465002,-0.59961,-0.315829,0.450411,-0.590489,0.675176,-0.276482,-0.299914,0.305761,-0.478492,-0.272791,0.315507,0.148023,0.370444,0.245242,0.457856,-0.0057304,-0.148299,0.628475,-0.529572,-0.546537,0.068255,-0.262383,-0.243794,0.554505,0.362952,0.238172,0.258205,-0.0994151,-0.132306,0.196652,-0.568807,0.129663,-0.449904,-0.567296,-0.147323,-0.056227,-0.41458,0.611822,0.000448712,-0.211761,0.276243,0.0996903,0.248189,0.146599,0.0169854,-0.246295,0.229639,-0.456445,0.267064,-0.458501,-0.249667,0.2676,0.649762,0.618859,-0.156754,0.18908,0.482199,0.189976,-0.220591,-0.15494,-0.543926,-0.230135,-0.220476,0.236792,-0.0891643,-0.260282,0.494103,0.173344,-0.251844,-0.207176,0.429193,0.0735639,0.514426,0.113844,-0.390919,-0.231879,-0.0158656,0.179596,-0.140674,-0.0390846,0.119839,0.289725,0.346177,0.538261,-2.74938 +3449.79,0.999755,0.0848144,4,1.62956,1.02033,-0.968716,0.43874,0.826551,-0.0418901,0.254861,0.314879,0.790055,0.0299849,-0.270288,-0.248943,-0.323841,0.190918,-0.354434,1.03817,-0.10626,0.142902,-0.376626,-0.0772449,-0.370241,-1.23342,-1.00349,0.233064,0.0658273,0.263223,0.189298,0.38593,-0.501533,0.240688,0.957845,-0.483322,0.00269802,0.290294,-0.460545,-0.156447,0.212783,0.0488773,0.421444,-0.3741,0.566912,0.319983,0.209994,-0.663307,-0.240959,-0.62313,-0.56491,0.168877,-0.12965,-0.0906181,0.108535,0.387013,0.449089,-0.470806,0.259718,-0.290434,-0.583496,-1.22238,0.0858975,-0.308699,0.319586,1.09495,-0.361391,-1.20281,-0.263709,0.168558,-0.305048,0.0135682,0.030637,-0.138477,0.0683777,0.417306,0.485883,-0.44513,0.202149,0.254025,0.105222,-0.0498711,-0.554025,0.0554423,0.430759,0.278046,-0.248365,0.274364,-0.630273,0.0626016,0.351857,0.0090244,-0.547206,-0.512784,0.22826,-0.237358,-0.418848,0.131253,0.115075,-0.533598,0.153868,-0.119184,0.218349,0.667652,0.355403,-0.269817,-0.118726,-0.0187741,-0.0799981,-0.788119,-0.4292,-0.0687879,0.194526,0.225748,0.164172,-0.807311,-0.121371,0.315962,0.068465,-0.172238,-0.300983,0.108157,0.33999,-0.248656,-0.863678,0.479863,-0.416672,0.347372,0.328317,0.387446,0.479513,0.154087,0.566626,-0.529542,0.157705,-0.0489095,0.0630772,-0.141949,-0.179271,-0.254214,0.196812,-0.529664,0.321596,0.0498305,-0.610527,-0.219674,0.573689,0.154871,-0.205208,0.397448,0.117163,0.338195,-0.447155,-0.229581,-0.0942998,0.218125,-0.00668531,-0.408736,0.0725387,0.497908,-0.394586,0.539085,0.0545518,0.056331,0.435086,-0.21104,0.569644,0.107499,0.314735,0.438311,0.278943,0.0618326,-0.385006,-0.184811,-0.160194,-0.136894,-0.166291,-0.109455,0.019649,0.0333399,-0.394405,-0.0366709,0.067008,0.273676,-0.448719,-0.216677,0.60724,0.114202,-0.177326,-0.389534,0.034625,0.00774504,0.116379,-0.932695,-0.260085,-0.196746,0.282213,-0.275213,0.0992794,0.460282,0.200718,-0.0391825,-0.356576,0.369057,-0.164437,-1.02362,-0.0207361,-0.118758,0.0973405,-0.369185,-0.186032,0.493774,-0.401849,-0.0472609,0.170559,-0.0734543,0.0670533,-0.5256,0.0646856,0.554918,-0.139166,0.367057,0.297374,-0.303527,0.210537,-0.428006,-0.235327,-0.0527833,-0.0829528,0.755145,-0.2406,-0.265093,0.0835498,-0.380603,-0.254253,0.00914854,-0.0244852,0.177929,-0.238796,0.514469,-0.180215,0.00111046,0.571779,-0.880573,-0.379922,-0.0721525,-0.195852,-0.11643,0.0265555,0.341527,-0.0332219,-0.175471,-0.073852,-0.322109,-0.0142233,-0.766376,0.0656108,-0.240843,-0.434939,-0.201323,-0.23889,-0.110217,0.804985,-0.257103,-0.243793,0.268794,0.000903186,0.117515,0.381701,0.286827,-0.470861,-0.0415933,-0.420958,-0.0151653,-0.30624,-0.3888,0.168778,0.304426,0.447547,-0.223036,0.268038,0.197557,0.0976845,-0.14667,-0.15389,-0.251774,-0.271551,-0.172371,0.265159,-0.316135,-0.35321,0.155608,0.321232,0.0788928,-0.126009,0.335694,-0.0323694,0.214302,-0.205269,-0.130727,0.1048,-0.187347,0.0807253,-0.0113383,-0.454604,0.105565,0.290539,0.324908,0.539016,-2.81494 +3420.44,0.916215,0.0848144,4,1.67432,1.03355,-0.76304,0.458421,1.23839,0.0205485,0.126518,-0.141786,0.238589,-0.01978,0.138608,0.0219213,0.24269,0.482642,-0.464873,1.10178,0.0435548,-0.0761231,0.241803,0.123067,-0.32972,-0.780385,-1.01953,0.276401,-0.722916,0.265108,0.367304,0.839488,0.146543,0.383904,0.623158,-0.391088,0.481153,0.609384,-0.257195,-0.619557,-0.570169,0.499937,0.244672,-0.275449,0.59544,0.418524,0.566817,-1.07389,-0.497503,0.923159,-0.432535,-0.303884,-0.247567,0.0561821,-0.0969982,0.779257,0.0576547,-0.148052,0.0929259,-0.763377,-0.300863,-1.21744,0.457227,-0.785573,0.353871,1.09946,-0.751305,-1.1943,-0.205457,0.120133,0.0343441,0.426664,0.537469,-0.0833502,0.137557,0.33495,0.392345,0.0112191,0.520292,0.28826,0.504216,0.427272,-0.377102,-0.231702,0.843451,-0.535391,-0.169017,-0.436373,-0.50915,-0.119482,-0.580754,-0.509167,0.285729,-0.398658,-0.20477,0.234434,-0.397358,-0.0177928,-0.0716638,-0.690776,0.152137,-0.063122,-0.00851407,0.33844,0.127206,-0.127273,-0.720701,0.188429,0.147899,-0.00160335,0.660415,-0.0652614,0.372598,0.0990835,-0.513997,-0.249155,0.400244,0.349298,-0.338284,0.399666,-0.359792,-0.172563,-0.406239,-0.042823,-0.528668,-0.0480343,0.494534,0.299524,-0.509453,-0.0545739,0.173566,-0.195863,0.126456,-0.747174,0.138525,-0.295632,0.0125723,0.463604,-0.582408,-0.0190248,-0.246842,-0.363633,0.53755,-0.432347,-0.34153,-0.154567,-0.182252,-0.510465,0.0371887,-0.0335648,-0.914543,-0.295143,-0.141648,-0.0643443,-0.383557,-0.00602548,0.056222,0.0380043,0.186013,0.693382,0.406759,-0.794688,0.108037,0.138939,-0.0525516,0.180224,0.969924,0.192568,-0.331965,-0.385923,0.0255168,-0.202315,-0.295557,-0.15548,-0.309821,-0.632731,0.0300479,0.232602,0.0600676,0.0964594,-0.316523,-0.10625,-0.636726,0.331555,-0.417194,0.148433,0.211599,-0.0799506,0.0663454,-0.291141,-0.189749,-0.0544474,0.162684,-0.0767486,0.0578756,0.482937,-0.305765,-0.403306,0.137693,0.104102,-0.267007,-0.0789008,-0.0800782,0.673315,-0.419318,0.47285,0.389424,-0.184631,-0.276128,0.227849,-0.629587,0.936442,0.410752,0.417872,-0.441836,-0.147445,0.0752146,0.448454,-0.131366,0.849483,-0.644252,0.0406373,-0.410877,-0.0832588,0.0354291,0.117772,-0.502905,-0.299967,0.283094,0.425457,-0.260975,-0.811414,-0.0254387,0.0127643,0.188757,0.0308767,0.0289943,-0.458636,-0.802989,0.152658,0.00641695,-0.000302098,0.197911,0.000967711,-0.457968,0.177176,0.23574,-0.287549,-0.183391,0.148059,0.880593,0.158836,0.0169933,-0.642004,0.526754,-0.294952,0.08658,-0.141811,-0.248171,0.0904881,-0.194409,-0.148725,0.0457374,-0.40201,0.515751,-0.164948,-0.0884198,0.247666,-0.0792698,-0.135899,0.122035,-0.766613,0.624114,-0.0314401,-0.177481,-0.210803,-0.867001,-0.0853029,-0.471326,-0.293145,0.0641181,0.0440529,-0.101114,0.440868,-0.570881,-0.236938,-0.241838,-0.0889973,-0.00536853,0.102777,-0.525514,0.646718,-0.627335,-0.289626,0.0307437,0.505253,0.205467,0.189859,-0.22823,-0.695566,-0.472219,-0.478671,-0.445163,-0.278889,-0.176285,0.14071,0.277138,0.375114,0.526439,-4.30309 +3404.05,0.742515,0.0848144,5,1.59277,1.03213,-1.15644,0.560665,1.31941,0.0674779,0.0181622,-0.174882,0.68643,-0.0673522,0.026308,0.0782985,-0.0567563,-0.0269088,-0.675504,1.10341,0.0741044,-0.0603038,0.26726,-0.131529,-0.417362,-0.926498,-0.515093,0.181424,-0.635052,0.319064,0.261589,0.834402,0.0923857,0.0814187,0.647503,-0.129552,-0.0641226,0.752069,-0.490916,-0.558405,-0.787064,0.633477,0.242667,-0.226981,0.729292,0.538527,0.650893,-1.06359,-0.428068,0.545909,-0.216358,-0.555231,-0.133877,-0.224639,-0.00447031,0.672902,0.319686,0.100779,0.386993,-0.893629,-0.559455,-0.912433,0.431738,-0.94686,0.400314,1.13011,-0.429234,-1.08083,-0.127096,0.245474,-0.0889203,0.130406,0.386214,-0.431837,0.361202,0.385259,0.426194,0.0734396,0.584192,0.337066,0.490994,0.901514,-0.448982,0.0809467,0.756559,0.0881665,0.0588608,-0.65194,-0.411162,0.106751,-0.126469,-0.417378,0.217165,-0.124808,0.20697,-0.0970203,-0.474809,0.286472,0.156731,-0.340292,-0.0256058,0.184585,-0.380319,0.241182,0.214985,0.10135,-0.633303,0.189247,0.216276,0.297875,0.614429,-0.207068,0.164146,0.216321,-0.645083,-0.25155,0.393112,0.249041,-0.903284,0.330577,-0.306417,-0.0782142,-0.515718,0.129795,-0.986792,-0.035179,0.260187,-0.0995965,-0.380924,-0.233877,0.279116,0.121688,0.107278,-0.0882417,0.0802317,-0.231257,0.130992,0.0527576,-0.360011,-0.0707441,-0.128268,-0.236843,0.595656,-0.321812,0.0331574,-0.071296,-0.00253791,-0.81193,-0.385598,0.0321835,-0.561627,-0.287803,-0.200999,0.0116789,-0.455696,0.149434,-0.169747,0.335131,0.367851,0.627423,0.246048,-0.28482,-0.039567,0.215765,0.0512516,0.189612,1.07614,-0.0732718,-0.562259,-0.446302,0.15041,0.021196,-0.264832,-0.293659,-0.286218,-0.614609,-0.286549,-0.157485,-0.0305681,0.175507,-0.397,-0.0874148,-0.746682,0.341094,0.0698625,-0.0794997,-0.0521951,-0.274689,-0.103077,0.0295309,0.100103,0.374129,0.163235,0.018888,0.0460642,0.605481,-0.462638,-0.4977,-0.0618839,0.581826,-0.100551,0.0340469,-0.388162,0.382432,-0.224447,0.369108,0.358691,-0.0924519,-0.0218656,0.0426491,-0.544282,0.893057,0.178425,-0.158421,-0.529349,0.34725,0.181627,0.596799,-0.401059,0.90034,-0.799087,-0.0144661,-0.584505,-0.142823,0.40437,0.163121,-0.0910461,0.356346,0.201156,0.14697,-0.126511,-0.714997,0.260845,0.301066,0.0171725,-0.175639,-0.027248,-0.264894,-0.466433,0.283396,-0.142768,-0.110508,0.563844,-0.161544,-0.230986,0.054466,0.421699,-0.480981,-0.0772466,0.339303,0.347863,0.0203901,-0.0521545,-0.703293,0.537064,-0.994671,-0.240553,-0.380891,-0.216323,-0.171216,-0.0861654,0.0193485,-0.266017,-0.355656,0.186694,0.237024,-0.255374,0.479822,0.0460585,-0.35199,0.265286,-0.667608,0.248589,-0.257069,-0.322312,-0.348067,-0.655082,0.117183,-0.40938,-0.358908,-0.00300542,0.0325547,0.176123,0.278812,-0.240783,0.479649,-0.0647134,0.148805,0.113338,-0.217728,-0.318336,0.497858,-0.492064,-0.0510883,-0.384208,0.362188,0.192483,0.161216,-0.112267,-0.822135,-0.613354,-0.506871,-0.954745,-0.229957,-0.492775,0.136675,0.304765,0.369696,0.552055,-4.55313 +3426.23,1,0.0848144,4,1.61982,0.990671,-1.28392,0.443551,0.554133,0.0117082,-0.0811338,0.32624,0.391644,-0.150364,-0.146296,-0.661348,-0.205125,0.413548,-0.667511,1.11533,-0.195534,0.0152686,-0.679525,-0.201524,-0.535629,-1.37334,-0.710656,0.258794,-0.207808,0.260881,-0.29857,-0.0330165,-0.439224,0.700101,0.280432,-0.760028,0.203228,0.383465,-0.628006,-0.444935,-0.289162,0.688851,0.626914,0.160966,1.07098,0.536598,0.582166,-1.026,-0.604923,0.414552,-0.0198634,0.0194245,0.352291,-0.0292367,-0.0507189,0.324667,-0.0744407,-0.250324,0.556725,-0.0346357,-0.458097,-1.21342,0.399929,0.0246174,0.664856,1.22021,-0.258358,-0.685005,0.305357,0.785698,-0.612975,0.0707548,0.174066,-0.196602,0.0446758,0.75524,0.238349,0.113862,0.264381,0.553172,0.599524,0.0453521,-0.316202,0.0993395,0.276271,-0.59053,-0.0824382,-0.0194241,-0.234277,0.270041,0.170807,-0.385991,-0.501485,-0.171487,0.443337,0.0896346,-0.0673213,-0.104823,0.196746,0.0237326,-0.0913811,-0.510107,-0.117012,0.0720308,0.287078,0.21446,0.289536,-0.148225,-0.323571,-0.642658,0.439635,-0.375566,0.444062,0.429102,-0.129661,-0.0123634,0.288375,0.128568,0.483134,0.320012,-0.427081,-0.0809259,0.200522,-0.0770246,-1.03407,-0.13553,0.109842,0.307214,-0.137348,0.0798547,0.468023,0.596137,0.272981,-0.336238,-0.0873401,-0.361282,-0.29064,0.262455,0.18773,-0.319605,0.254192,0.0358701,0.636485,-0.0854409,-0.867,-0.645626,0.490704,-0.569956,0.587538,0.35688,0.0560768,0.28049,0.175293,-0.276357,-0.676158,-0.169845,0.410404,0.20036,-0.0947451,0.424691,0.294852,-0.524821,-0.333982,0.102733,-0.346783,0.377886,1.15982,-0.174837,-0.228529,0.360063,-0.0501011,-0.208733,-0.140125,0.0464195,0.227851,0.106618,-0.104565,0.00409227,0.177006,-0.0282143,-0.366913,-0.219541,-0.139402,0.483142,0.181185,-0.191259,0.198127,-0.00565015,0.0592505,-0.267383,-0.0150385,-0.417324,0.184193,-0.428455,-0.179848,0.42498,-0.459741,-0.61703,-0.674126,-0.208638,0.185899,-0.0818204,0.18357,-0.0743071,-0.343372,0.224306,0.0341093,-0.0373491,0.303939,0.0666498,-0.573225,1.27205,-0.232466,0.152268,-0.289058,0.162067,0.5739,0.317702,-0.538819,0.468069,-0.0743048,0.262125,-0.366885,-0.546959,-0.379863,-0.611213,0.720781,0.0526436,0.0360252,0.311113,0.471307,-0.104185,-0.0442878,-0.522179,-0.177533,-0.0225724,-0.0217004,-0.20427,0.296978,0.455399,-0.079224,-0.203029,0.25084,-0.554638,-0.0818123,0.251271,-0.178484,-0.500856,-0.141786,0.483909,0.341408,-0.0213419,-0.71588,-0.431927,0.322019,-0.773523,0.175933,-0.363658,0.39421,0.144508,-0.539674,-0.459352,-0.057384,-0.359041,0.172047,-0.180378,0.366856,0.125991,0.246934,-0.404445,0.220871,0.0905677,-0.912347,-0.523108,0.198342,-0.0548025,-0.352322,-0.348557,0.0657788,-0.375843,-0.201893,-0.178196,-0.251159,0.722692,0.140503,-0.139217,-0.239833,0.426349,-0.242838,0.819816,-0.285731,0.223059,-0.0200097,0.0391676,-0.266222,0.158777,0.290822,0.14491,-0.652402,-0.389363,-0.073747,-0.384129,0.347463,-0.655428,0.0419723,0.129168,0.251677,0.359399,0.501674,-1.72022 +3415.17,0.863007,0.0848144,4,1.64861,0.986595,-1.12726,0.430706,0.534027,0.0034439,0.179747,0.550237,0.241176,0.144334,-0.254165,-0.471033,0.0917677,0.399461,-0.56674,1.02752,0.164723,-0.0679407,-0.507928,-0.352922,-0.508363,-1.25867,-0.750453,0.366279,-0.471174,-0.0515495,-0.236661,0.0653924,-0.270181,0.815336,0.250234,-0.75759,0.188405,0.540716,-0.683852,-0.405438,-0.201977,0.686142,0.560688,-0.267602,0.87961,0.760518,0.565586,-1.05986,-0.756466,0.275174,0.0728365,-0.276268,0.289399,-0.524565,-0.0916093,0.514101,-0.144014,-0.649887,0.410417,0.0484776,-0.546841,-1.36175,0.510827,-0.20035,0.238292,1.00731,-0.0894304,-0.834506,0.355696,0.777735,-0.345881,0.377837,-0.353994,-0.0625087,-0.436298,0.462119,0.337817,0.237506,-0.124111,0.342773,0.668237,-0.364736,-0.0227061,0.319692,0.25936,-0.717558,0.0167198,-0.072682,-0.242395,0.0632233,0.0226895,-0.427246,-0.446035,-0.0258633,0.517946,-0.0843345,0.101706,-0.234459,0.195895,0.0917913,-0.134813,-0.808669,-0.110152,0.357028,0.436068,-0.114513,0.301493,-0.242898,0.0168679,-0.581844,0.674165,0.0350937,0.555417,0.546661,0.0503039,-0.248904,-0.177254,0.184562,-0.0228426,0.106226,-0.288458,-0.0555936,0.353429,-0.0882323,-0.752672,-0.284875,0.0278589,0.0773746,0.046691,-0.187573,0.507622,0.472653,0.557487,-0.53699,0.233378,-0.485563,-0.194135,0.0933814,0.176398,-0.384393,0.307547,0.216085,0.479078,0.119895,-0.703097,-0.412532,0.642888,-0.366273,0.568221,0.164168,0.2249,-0.299136,-0.136534,-0.304908,-0.77963,-0.0866737,0.475246,0.103364,0.0606354,0.496747,0.11233,0.0998945,-0.00852792,0.162375,-0.284402,-0.155807,0.959254,-0.213052,-0.0329379,-0.0956352,-0.191766,-0.166875,-0.446333,0.146287,-0.00220197,0.0323582,-0.0514205,0.00354213,0.004336,-0.173502,-0.220135,-0.393678,0.40068,0.584571,0.260786,0.0722916,0.21656,-0.33744,-0.0742784,-0.030133,0.0144047,0.0275738,-0.302328,-0.336789,-0.295267,0.458284,-0.507188,-0.784677,-0.573478,0.511962,0.248064,-0.0772992,-0.556142,0.154711,-0.589397,-0.196832,0.219129,-0.0169676,-0.369254,-0.255033,-0.826637,1.27727,0.177616,0.16316,-0.781054,0.174809,0.638663,0.213965,-0.363947,0.551744,-0.370325,0.254035,0.179935,-0.483173,-0.135817,-0.625699,0.477115,-0.171366,-0.0537806,0.474584,0.286191,-0.0227267,0.173002,-0.607462,0.0767026,-0.182083,-0.0235831,0.0281952,0.309764,0.19838,0.129403,0.3063,0.420149,-0.146273,0.227701,0.00453235,-0.132925,-0.474784,-0.426307,0.0889055,0.381318,-0.141554,-0.682222,-0.481529,0.290719,-0.415364,0.23778,-0.297809,-0.0840225,0.210974,-0.429429,-0.0784826,-0.586456,-0.138323,0.177479,0.748157,0.30991,-0.202104,0.731378,-0.616583,0.158346,0.000820701,-0.832191,0.0329153,-0.0395934,0.129155,-0.0225604,0.0690096,-0.0747606,-0.464377,-0.145951,-0.0945587,0.200918,0.50897,-0.041553,0.223825,0.0111115,0.685687,-0.0140012,0.550761,0.0351606,0.627849,0.20569,4.43233e-05,-0.0487231,0.105812,0.410583,0.25578,-0.438401,-0.434978,0.155973,-0.216486,0.0401125,-0.4976,0.0143208,0.139061,0.239821,0.372909,0.489715,-1.68554 +3427.12,0.890524,0.0848144,4,1.57436,0.835084,-1.62585,0.687237,0.569425,-0.0753396,0.175787,0.428948,0.139764,-0.205617,-0.126544,0.235331,-0.312828,0.683555,-0.368127,1.26668,0.105656,0.274269,-0.294799,-0.293288,-0.236953,-0.76968,-0.268161,0.186304,-0.1883,-0.601413,-0.3295,0.540203,-0.222039,0.580077,0.572489,-0.616835,-0.0524443,0.184137,-0.697155,-0.539572,0.184486,0.732588,0.553232,-0.338359,0.832434,0.824392,0.560802,-0.859236,-0.393751,0.689145,-0.070442,-0.0984412,-0.111124,0.0765855,-0.309558,0.960689,0.333374,-0.966094,0.228827,-0.371764,-0.456521,-1.16128,0.266666,-0.335115,0.152869,1.1351,-0.550738,-0.662412,0.60341,0.0290204,-0.472784,-0.130323,0.194212,-0.330177,-0.389391,0.368533,0.19253,0.552149,-0.105855,0.374387,0.182259,0.197278,-0.111666,0.399306,0.644593,-0.0450245,0.191282,-0.412625,-0.305535,0.0299313,0.174754,-0.108435,-0.726597,0.148301,0.070096,0.00151495,0.261522,-0.153549,-0.0272428,0.0911994,0.644652,-0.330539,0.736933,0.0984954,0.177766,0.260477,0.0773979,-0.335338,0.0920807,-0.139403,0.479305,-0.143865,0.40482,0.808794,0.292249,-0.0779216,0.482859,0.194208,-0.0348451,0.0298815,-0.349794,-0.169329,0.560693,0.315561,-0.937099,-0.380566,0.0353808,0.0857115,0.301873,-0.0212541,0.470326,0.225075,0.347688,-0.685394,-0.450688,-0.242972,-0.141011,0.0660885,-0.351325,-0.470324,0.828006,0.15882,0.353391,-0.238394,0.117587,0.21714,0.117103,-1.00402,0.380046,0.340952,0.131935,0.0360156,-0.145574,0.159621,-0.323007,-0.215702,0.341348,0.0359985,0.276834,0.0382816,0.0498472,0.19914,-0.0197439,0.0997276,-0.575313,-0.170169,0.828837,0.577444,0.0497502,0.584642,-0.109582,-0.307254,-0.0638052,-0.106173,-0.178244,0.573177,-0.213461,-0.45803,0.2331,0.142473,-0.410328,-0.446814,0.0794558,0.701396,0.101692,-0.191052,-0.00349479,-0.615874,0.212022,-0.304469,0.0975502,-0.308548,-0.269688,-0.44669,-0.349153,0.232203,-0.30176,-1.02788,-0.322851,0.267802,-0.140646,-0.239221,-0.640385,0.118618,-0.389385,0.0826633,0.299512,0.124436,0.056158,0.253386,-0.676158,1.19946,-0.0462469,0.0502052,-0.146149,-0.318299,0.26077,-0.155155,-0.588087,0.250085,-0.689291,0.339408,0.0918762,-0.362264,-0.152955,-0.699075,0.114541,-0.0649889,-0.304031,0.785533,0.407744,0.0237578,0.297755,-0.182146,-0.218147,-0.00438748,-0.125774,-0.0738946,0.222485,0.358905,0.396418,0.120558,0.18747,-0.349546,-0.0531632,-0.0196223,-0.537085,0.0320974,0.241263,-0.16123,0.641026,-0.413778,-0.887788,-0.382209,0.356667,-0.407711,0.0273718,0.173931,-0.0910611,0.172146,-0.517825,-0.084678,0.130879,-0.230866,0.0417204,0.212682,-0.0304773,-0.141824,0.195368,-0.470438,0.0799302,-0.0429061,-0.203273,-0.384513,0.671967,-0.127449,-0.382717,0.0628571,0.308383,-0.134823,-0.125442,0.0935365,0.214857,0.106922,0.609629,0.0722595,-0.338101,0.352112,0.241391,0.0880781,0.147845,-0.0614577,0.0401944,-0.151722,-0.322047,-0.22065,0.30539,0.339627,-0.208332,-0.260783,0.237233,-0.0819917,-0.0769606,0.167843,-0.34502,0.12302,0.370386,0.350742,0.608594,-1.57106 +3401.48,0.980963,0.0848144,4,1.47314,0.890955,-1.22073,0.502489,1.06123,-0.0798464,0.145156,-0.496174,0.637456,0.0789995,0.302045,0.100331,-0.329057,0.452023,-0.41234,0.489523,0.577133,-0.0887425,0.156412,-0.227488,-0.171998,-0.947582,-0.777583,0.107637,-0.650801,0.597095,0.0446786,0.506021,-0.435457,0.187281,0.433161,-0.653523,0.305366,0.849521,-0.192792,0.057784,-0.337386,0.477126,0.98999,-0.335755,0.833151,0.409505,0.951777,-0.850614,-0.283215,-0.392351,-0.823445,-0.0772186,0.117921,-0.0477429,-0.119251,0.819336,-0.332188,-0.074495,0.73312,0.143251,0.00713369,-0.897279,0.381702,-0.66684,-0.0248421,1.01448,-0.945461,0.0266542,0.308771,-0.106267,0.293492,0.222952,0.0238071,-0.46446,-0.479804,-0.094231,0.29186,0.153944,0.77727,-0.180117,0.227245,0.419134,-0.260904,-0.284139,0.173504,-0.739709,0.0680446,-0.184485,0.264716,0.130668,-0.615955,-0.211806,0.494343,0.00955775,0.360606,-0.0263925,-0.516874,0.513884,-0.0670633,0.0550388,-0.223489,0.362399,-0.407421,0.443968,0.22716,-0.103386,-0.110526,0.341871,0.102408,0.148017,0.826024,-0.016445,-0.0467983,0.465568,-0.603587,-0.133126,0.60345,0.183403,0.419612,-0.339819,0.458267,0.168244,0.529851,-0.13417,-0.64924,-0.351317,-0.340607,-0.665623,-0.440794,0.138632,0.410368,-0.0168414,0.174784,-0.00068874,0.516146,-0.396785,0.00323349,0.94367,-0.46958,-0.257189,-0.389089,-0.00579246,0.199431,-0.606201,-0.592219,-0.162821,0.693331,-0.721636,-0.0391509,0.265303,0.0575635,0.243506,0.371931,-0.0526691,-0.103341,0.220781,-0.292499,-0.344007,0.747284,0.292676,0.161662,-0.0587685,0.225474,-0.324596,-0.0118059,0.340737,0.950801,-0.0761711,-0.218059,-0.193021,0.568916,-0.432046,-0.12393,0.427118,0.251462,-0.180759,-0.212113,-0.269436,0.0372854,-0.0882394,0.0716097,0.0462715,0.547758,0.597121,1.06501,-0.0726377,-0.11043,0.385039,0.356704,-0.377959,0.269609,-0.580258,-0.0664995,0.199203,-0.24562,-0.356063,-0.0698676,-0.470925,0.281047,0.0227246,0.6639,-0.534482,-0.119134,0.0383321,0.141432,-0.0676671,0.185902,-0.177513,-0.312932,-0.273238,-0.766853,1.2144,0.151294,0.124712,-0.11375,-0.124782,0.453107,-0.356548,-0.641441,0.0198976,0.74836,0.151299,0.285774,-0.214018,0.392251,-0.215807,-0.336317,0.340987,0.381412,0.174897,-0.55408,-0.167494,-0.0136912,0.177716,0.00605495,-0.265528,-0.0681021,-0.305187,0.340204,0.660324,-0.434251,-0.0383782,0.663728,-0.514984,-0.893086,-0.301948,0.470801,0.272753,0.024833,0.695579,0.317421,0.298017,-0.174391,-0.496734,-0.433882,-0.341231,-0.230573,-0.166632,-0.209623,0.225256,-0.1904,0.298755,-0.344514,0.162683,0.0856846,-0.0222617,-0.175202,0.135347,-0.204982,0.237565,0.374189,-0.489524,0.139958,-0.226569,-0.378526,-0.474637,0.0502527,0.451309,-0.308661,0.276419,0.0970548,0.237088,-0.373958,-0.0602847,-0.259697,-0.0568256,-0.373034,-0.0636759,0.376475,0.652507,0.0755165,-0.0255576,0.782552,0.271255,-0.0371376,0.145875,-0.147268,0.416864,0.0871172,-0.600973,0.510253,0.097125,-0.512318,-0.561476,0.109387,0.153755,0.210011,0.392116,0.45827,-3.44028 +3386.95,0.996382,0.0848144,5,1.58358,0.646123,-1.71765,0.741854,0.414684,-0.164559,-0.280248,0.176002,-0.62993,-0.435983,0.479912,-0.408659,-0.172096,0.619898,-0.590504,0.425489,0.329439,0.178431,-0.307469,0.539389,-0.311936,-0.415226,-1.04721,0.521913,-0.410796,-0.681856,-0.182453,-0.0957924,-0.486005,-0.129699,0.855417,-0.556185,-0.452985,0.670831,-0.427636,-0.492356,-0.273883,0.670677,0.239638,-0.285109,1.02321,0.632381,-0.0952725,-0.933954,-0.356785,0.353765,-0.24727,-0.00908688,0.21507,0.133231,0.276282,0.331585,0.218999,-0.350232,0.553881,-0.0893826,-0.562594,-0.696099,0.479833,-0.433837,0.157892,1.12646,-0.607184,-1.89876,0.34614,0.315489,-0.514248,-0.410737,0.242016,-0.666854,0.130262,0.552319,0.555591,-0.324891,0.738502,0.709564,0.199176,-0.72829,-0.310136,0.406949,0.728275,-0.267359,0.389816,0.0734112,-0.778256,-0.475679,0.458065,-0.109159,-0.574392,-0.361539,-0.419623,0.133248,0.228076,-0.776202,0.468979,-0.590316,0.544536,-0.616426,0.817707,0.0462138,0.0017365,0.0705725,-0.334536,-0.517295,0.280813,-0.456027,-0.257732,-0.229266,0.457992,0.281622,0.555748,-0.0351796,-0.426342,0.236009,-0.608787,0.282686,-0.914882,0.124215,-0.312678,0.386503,-0.89871,-0.022856,0.154379,-0.0752309,0.476342,0.370391,-0.0181835,0.254857,-0.0407289,-1.02202,-0.325238,0.027411,0.0258688,0.402439,-0.353924,-0.213406,0.264698,-0.493047,0.522602,-0.331229,-0.149277,0.0161774,-0.219639,-0.242237,-0.146511,-0.159097,-0.389438,0.330318,-0.203621,-0.354252,-0.132782,-0.372155,0.407607,0.195405,-0.27603,0.796139,0.407671,0.405221,-0.169612,0.247904,0.547805,-0.127654,0.851081,-0.105152,0.186656,0.802681,-0.557286,0.123753,-0.503268,-0.718031,0.128019,0.167036,-0.242559,-0.189514,-0.480422,-0.0629946,-0.507622,-0.275138,-0.0374028,0.431449,-0.790359,-0.24848,0.305737,-0.579651,-0.362995,-0.00370433,-0.911354,-0.27783,0.35147,-0.894879,-0.0207251,0.325274,0.392953,-0.980506,-0.329941,0.141241,-0.650226,0.0638509,-0.729348,-0.131836,-0.324204,0.0768498,0.194518,-0.16607,0.220553,-0.136772,-0.121252,1.08405,-0.467368,0.153742,-0.16224,-0.265476,0.0605912,0.313026,0.155007,0.767334,-0.844417,0.0170992,0.132951,-0.472906,-0.127823,-0.158438,0.553403,-0.0752377,-1.06895,0.811508,-0.264329,-0.546063,-0.157769,-0.0114518,-0.41366,-0.251304,-0.544717,-0.231693,-0.941611,0.31651,0.479944,0.4323,0.137766,0.293417,0.786643,0.0574223,-0.149073,0.00818015,0.849226,-0.634572,0.154264,-0.0634366,-0.0149279,-0.264624,0.513065,-0.41294,0.590956,-0.316291,-0.124959,0.295587,-0.106323,0.078354,0.410419,0.125908,0.768803,0.741674,0.164193,-0.0171768,0.472777,-0.00766836,0.268254,0.17395,-0.262753,0.0604289,0.0478472,0.162454,-0.762047,-0.0480799,0.571364,-0.0358682,0.163664,-0.157845,0.93886,0.529547,0.462521,-0.105688,-0.233597,0.503327,0.136057,-0.254671,-0.478713,0.68552,-0.447294,-0.338061,-0.0691293,-0.167514,0.113573,-0.0418586,-0.0310524,-0.107338,-0.175481,-0.317215,0.545174,0.5273,-0.336921,0.153763,0.225911,0.392126,0.4753,-0.695325 +3406.5,0.545181,0.0848144,5,1.48323,0.726529,-1.13739,0.49077,1.01372,-0.0188947,-0.399687,-0.409459,0.562817,-0.0399372,0.631256,0.0846483,-0.290002,0.349428,-0.0580769,0.662001,0.365574,-0.158478,0.0705873,0.325521,0.391475,-0.0627381,-0.671791,0.652728,-0.359049,0.372023,-0.44678,0.0573971,-0.490886,0.135265,0.931626,-0.708896,0.435608,0.55804,-0.13177,-0.289653,-0.0378624,0.339701,0.775173,0.231112,1.31437,0.854435,0.676544,-0.372788,0.294661,-0.597597,-0.556885,0.549942,0.326028,-0.068417,-0.407171,0.481467,0.187004,-0.26176,0.901204,-0.335256,-0.349253,-1.00532,0.745761,-0.529064,0.471827,0.868643,-0.960456,-0.371264,0.322432,0.284985,0.383438,0.267216,-0.142612,-0.61501,-0.24577,0.110815,0.75314,-0.171392,0.758194,0.0752152,0.707896,0.444623,-0.368058,-0.241884,0.253016,-0.608635,-0.0886639,-0.276659,0.674892,0.36222,-0.295208,-0.198112,0.361188,-0.273606,0.108426,0.0308129,0.0621981,0.559999,-0.0450406,0.0406622,-0.288728,0.125668,-0.737332,0.346387,-0.099401,-0.0285642,-0.383767,-0.0304018,0.119406,-0.131954,0.592669,-0.207588,0.232774,0.649383,-0.462688,-0.329913,0.57225,0.354273,0.428262,-0.00794418,0.243311,0.0129916,0.692459,-0.54328,-0.583419,0.155359,-0.0959591,-0.350109,-0.430449,-0.157875,0.389503,-0.245069,0.108531,0.191893,0.52467,-0.128625,0.0593934,0.970863,-0.122992,0.274264,-0.381968,-0.114172,0.467932,-0.725641,-0.755723,-0.250409,0.393498,-0.498921,0.2997,0.519274,0.158104,0.409104,0.223163,-0.0851047,-0.207499,0.542411,-0.2625,0.0411672,0.629121,0.38986,-0.0487751,-0.59503,-0.0477446,-0.501665,0.1831,0.00541244,0.585821,0.224902,-0.185435,-0.602319,0.206459,-0.25345,0.127636,0.605457,-0.0201571,-0.177971,-0.128526,-0.192622,0.132134,0.0164415,-0.232497,0.128593,0.134157,0.700054,0.942956,0.0168404,-0.0598506,0.569441,0.229026,-0.512498,0.251304,-0.644365,0.0155559,0.146618,0.0303042,-0.169005,-0.114778,-0.272291,0.68842,0.0729141,0.252774,-0.408214,-0.345736,-0.106321,0.0522446,-0.643506,0.308693,0.115832,-0.015369,-0.067082,-0.783299,1.09572,0.261664,0.135066,0.344543,-0.0585151,0.49874,-0.134768,-0.156823,-0.221579,0.162072,-0.0600118,0.0740668,0.0274362,0.122424,-0.622963,-0.383006,0.560628,0.243585,0.103875,-0.200635,0.0761032,0.519053,-0.0451918,0.175204,-0.0903584,-0.187749,-0.459007,0.24106,0.483684,-0.405067,-0.264307,0.665737,-0.733268,-0.818573,-0.255155,0.37902,-0.24853,-0.109905,0.652126,0.260353,0.329907,-0.236627,-0.290993,-0.400019,-0.455234,0.254952,0.11961,-0.327055,-0.155036,-0.0811886,-0.155211,-0.52593,-0.0739089,-0.501282,0.11581,0.102926,0.541081,-0.177163,0.328161,0.181507,-0.518261,0.161902,0.148369,-0.301729,-0.294362,0.169962,0.610236,-0.525152,-0.0836965,-0.373697,-0.146776,-0.250589,-0.375989,-0.658425,-0.113724,-0.116053,-0.319099,-0.105223,0.771275,0.281374,0.0497794,0.476447,0.0345735,-0.0749816,0.137627,0.0735914,0.46119,-0.246344,-0.619799,0.265873,0.0360497,-0.711642,-0.532446,0.164067,0.178906,0.209062,0.422973,0.457233,-3.02966 +3410.58,0.975301,0.0848144,4,1.4327,0.548882,-1.71644,0.839503,0.855246,0.013691,0.415727,-0.349854,-0.0118767,-0.218702,0.977287,-0.113453,-0.65052,0.393624,0.0495334,0.43074,0.309435,-0.0544882,0.176633,0.160842,0.438683,-0.515364,-0.280721,1.23152,0.448972,-0.21422,-0.258915,0.50072,-0.213147,0.13277,1.09249,-0.441623,0.245835,0.714036,-0.0700836,-0.206321,-0.162959,0.825379,0.573564,0.813868,0.872355,0.487773,-0.217912,-0.551423,-0.150911,0.0243898,-0.400334,-0.142695,0.444202,0.405083,0.360418,-0.0655888,-0.0439525,0.184946,0.745112,-0.532746,0.256334,-0.750376,0.696143,-0.606427,0.372895,0.920448,-0.476742,-1.94754,0.198475,-0.21572,0.106466,-0.152817,0.33631,-0.503672,0.0576864,0.689179,0.564905,0.248394,0.649533,0.794473,0.686544,-0.602384,-0.112988,-0.133226,0.578834,-0.155173,0.107279,0.459987,-0.322968,0.184333,-0.0451094,-0.290242,-0.13756,0.135058,0.101629,0.186066,0.00668813,0.0227198,-0.216203,0.0976125,0.479029,-0.227518,-0.489482,0.0183966,0.365224,-0.168288,-0.172251,-0.14168,0.358593,0.142948,-0.168608,-0.292449,0.216706,0.378078,-0.527224,-0.214012,0.193786,0.127136,0.229686,0.373909,-0.545379,0.0474793,0.103941,-0.475673,-0.323642,0.431093,0.0705205,-0.632029,-0.0409488,0.551717,-0.116101,0.401928,-0.438424,-0.499904,0.57706,0.353122,-0.342484,0.507256,-0.249251,0.186008,0.428765,-0.305698,0.340827,-0.157781,-0.226053,-0.206509,-0.226641,-0.787774,0.362463,0.277091,0.201654,0.646323,0.117778,-0.0821174,-0.285235,-0.165586,0.311113,-0.148037,0.272323,0.0345272,0.0363356,-0.352132,-0.153896,-0.299991,0.187552,0.17527,0.723782,0.386957,-0.353639,0.343192,-0.154949,-0.12917,-0.145367,-0.231091,0.406877,0.0131788,-0.231901,0.383421,-0.486345,0.54114,-0.477288,-0.398029,0.189084,0.746647,0.0475878,-0.553046,-0.511904,-0.167637,0.0597281,-0.0762126,-0.341306,-0.648665,0.174844,-0.382532,0.409295,-0.0537505,0.246041,-0.36264,0.452998,0.061603,-0.103783,0.00898587,-0.654217,0.580712,-0.160822,-0.822656,-0.355733,0.243244,0.0361228,-0.346105,-0.144845,1.24954,0.330974,0.0784431,-0.142747,-0.234378,0.299701,-0.0341524,0.0456942,0.67984,-0.950734,0.225977,0.442485,-0.146594,0.23552,-0.259733,-0.736598,0.480951,-0.664896,0.487641,-0.324666,-0.344055,0.488196,0.407997,-0.699875,-0.0655781,-0.220678,-0.139807,-0.58196,0.0853798,0.396093,0.0472662,0.529927,-0.515411,0.45025,-0.108904,-0.244881,0.282181,-0.493202,-0.124268,-0.165711,0.254147,0.401719,-0.659077,-0.159549,-0.700126,0.333974,-0.45678,0.426843,0.304631,-0.577641,-0.208792,-0.344616,-0.214983,0.183318,0.331453,0.827195,-0.0842491,0.108464,0.198053,0.223085,0.105611,-0.136925,0.0311176,-0.115767,0.210277,-0.101163,-0.567779,0.438267,-0.771163,0.174289,-0.414074,0.5164,-0.275572,0.0881386,-0.332043,-0.105212,0.0832598,-0.111468,-0.397901,-0.435379,-0.00146189,-0.109543,-0.168329,-0.354119,0.555327,0.162502,-0.0110668,-0.370635,-0.46797,-0.377958,0.154491,-0.375612,0.173089,0.151746,0.129513,0.388294,0.359879,0.623133,-2.27466 +3401.47,0.946443,0.0848144,4,1.48575,0.784967,-1.11456,0.53091,0.794803,0.0614737,-0.0571757,0.107075,0.317697,0.0305887,0.195156,0.154794,-0.267507,0.601486,-0.394866,0.778762,0.461398,-0.0073545,-0.501454,0.21733,0.567681,-0.412741,-1.11875,0.641348,-0.00404172,-0.0755472,-0.201396,0.606356,-0.59995,0.224229,0.786866,-0.770539,0.262542,0.891569,-0.238043,-0.273483,-0.022667,0.290334,0.606313,0.092069,1.08197,0.834818,0.810814,-0.839091,-0.120986,0.579642,-0.668511,0.420904,0.101139,0.382266,0.219243,-0.113254,0.0416737,-0.556311,0.657354,0.0590607,-0.247746,-1.02594,0.320191,-0.828641,0.553486,0.663984,-0.614505,-1.17245,-0.0455141,0.00287923,0.383041,-0.213809,-0.278124,-0.593989,-0.167024,0.520529,0.758444,-0.330309,0.104065,0.18026,0.512622,-0.335454,-0.153686,0.0766842,0.601973,-0.255021,-0.0875597,-1.12526,0.441717,0.465351,-0.177512,-0.0511309,0.200344,-0.106798,0.225476,-0.276607,-0.42541,-0.192572,0.688085,-0.471063,0.132097,-0.308845,0.022688,0.116485,0.0463582,0.346771,0.180338,-0.105316,0.297834,-0.224861,0.309286,-0.280452,0.178989,0.0928334,-0.014238,0.424794,-0.484769,0.288363,-0.378422,-0.166654,0.507259,-0.101528,0.635472,0.181454,-0.159306,0.357505,-0.460139,0.0120084,0.00486345,-0.437644,0.541906,-0.400137,0.615837,-0.0325535,0.038246,-0.254493,0.292007,0.875455,-0.4508,-0.049887,0.075703,0.207637,-0.0585788,-0.278739,-0.802139,0.0307027,-0.631049,-0.14421,-0.54704,-0.158496,0.259641,0.403793,0.334409,-0.0138079,-0.545365,-0.0137857,0.424423,-0.279904,-0.0497976,0.820593,0.334891,-0.381274,0.131408,-0.0772574,-0.187836,-0.0951321,0.588698,-0.365054,0.395727,0.166121,0.272143,-0.487867,-0.36661,0.512127,0.278018,0.363741,-0.150596,-0.275953,0.33988,-0.102595,0.143761,0.498122,-0.195693,0.682229,-0.0434671,0.0135726,0.00636302,-0.655235,-0.113982,0.052639,0.114423,0.019018,0.157591,0.194999,0.0290024,0.411411,0.118519,-0.335508,0.242689,1.2531,-0.22761,-0.811795,-1.11385,0.0209062,-0.0388845,-0.160788,0.343032,-0.162072,-0.43023,-0.167145,-0.427173,1.30335,-0.37786,0.193465,0.201244,0.236282,0.138463,-0.135803,-0.0523219,0.0332547,-0.278531,-0.114469,0.0107373,0.0682137,0.495605,-0.181665,-0.029858,0.0315885,0.110292,0.272537,-0.382858,-0.624655,-0.0573637,0.165369,-0.483679,-0.143861,0.0555206,-0.405684,-0.0165005,0.803334,0.54396,-0.29415,0.796149,-0.356584,0.294199,0.120534,-0.0697656,-0.186238,0.742791,0.335359,0.351264,-0.263762,0.102744,-0.247955,-0.514758,-0.627514,0.174996,0.258572,-0.690132,-0.216862,-0.512427,-0.516871,0.373188,-0.138805,-0.464716,0.771057,-0.198961,-0.276649,0.382588,0.138803,0.206849,-0.310077,0.0930886,-0.0837768,-0.0964998,-0.282964,-0.485499,0.101603,0.0127889,-0.296912,-0.0392549,-0.321069,-0.0104839,-0.006012,0.43417,0.00483792,-0.168203,-0.426058,0.45375,-0.575855,-0.298875,0.403932,-0.00327288,0.0696831,-0.205546,-0.371304,-0.530611,0.752154,-0.380254,-0.230256,-0.996885,0.159224,0.443615,-0.159071,-0.100329,0.168772,0.260428,0.410818,0.510322,-2.47386 +3413.53,0.999695,0.0848144,4,1.4889,0.764952,-1.14119,0.512215,0.738433,0.10081,-0.244483,0.06788,0.371772,0.105993,0.0517469,0.175322,-0.162215,0.434003,-0.336979,0.798876,0.45325,-0.0552831,-0.43714,0.193251,0.346093,-0.523108,-0.876979,0.608055,-0.0225667,-0.0998296,-0.100935,0.700346,-0.559865,0.229383,0.620185,-0.843851,0.125754,0.720863,-0.312076,-0.342413,-0.0593042,0.295834,0.619081,0.111521,0.971266,0.806276,0.56945,-0.719308,-0.280108,0.757446,-0.599021,0.405823,0.136723,0.358742,0.214451,0.100587,0.268629,-0.555002,0.738295,0.12956,-0.0697007,-1.01795,0.358043,-0.658135,0.504422,0.844961,-0.439428,-1.3285,-0.0843861,-0.0385675,0.141414,-0.071639,-0.166137,-0.364554,-0.018436,0.46131,0.737336,-0.395687,0.232736,0.206835,0.491052,-0.1684,-0.121434,0.159811,0.67934,-0.294523,-0.0393545,-1.0215,0.398595,0.320717,-0.153825,-0.0957169,0.284464,0.0559618,0.223025,-0.358522,-0.449179,-0.230358,0.494351,-0.641665,0.136431,-0.296688,0.214862,0.160626,0.179695,0.238021,0.233105,-0.0322664,0.450517,-0.316061,0.241966,-0.344533,0.132068,0.19151,-0.0523064,0.238817,-0.620165,0.155526,-0.4228,-0.273342,0.325194,0.0386294,0.467332,0.250794,-0.191037,0.496541,-0.248381,0.199685,0.0802132,-0.197956,0.468349,-0.189086,0.450097,-0.272733,0.239025,-0.20382,0.372464,0.883486,-0.379902,-0.0541952,0.0849956,0.157249,-0.0612003,-0.278188,-0.817433,-0.125698,-0.405928,-0.15562,-0.469622,-0.14388,0.223251,0.571867,0.435776,0.203975,-0.407214,-0.0595768,0.485601,-0.141521,0.088143,0.921063,0.168242,-0.157297,-0.0256701,-0.0953214,-0.317097,-0.192731,0.590026,-0.209984,0.27074,0.190824,0.210779,-0.473991,-0.359215,0.415095,0.317584,0.264713,0.0748882,-0.295667,0.179049,-0.354637,0.164715,0.400819,0.0260087,0.797321,-0.100285,-0.136753,0.247811,-0.583694,-0.062046,0.00921017,-0.17092,0.090132,0.227804,0.309969,-0.0752747,0.378434,-0.0472133,-0.367208,0.24838,1.24963,-0.271513,-0.885967,-1.02313,-0.041489,-0.0686984,0.118993,0.427917,-0.222525,-0.513316,-0.220183,-0.363318,1.28911,-0.438713,0.336527,0.19519,0.240466,0.291685,-0.160998,-0.212837,0.0991947,-0.459872,0.0601308,-0.221257,-0.119903,0.393341,-0.230778,-0.233071,-0.0191495,-0.155402,0.287464,-0.409529,-0.714609,-0.148018,0.277856,-0.556276,-0.130227,-0.226431,-0.442672,-0.0260453,0.776097,0.704562,-0.406826,0.724502,-0.336539,0.232851,0.316865,-0.0840422,-0.258803,0.771889,0.148292,0.405531,-0.317609,0.340115,-0.332541,-0.457445,-0.356,0.0188772,0.387603,-0.462874,-0.118615,-0.557619,-0.578151,0.628472,-0.0241536,-0.4294,0.884796,-0.266603,-0.391108,0.149349,0.0168773,0.222115,-0.262784,0.228353,-0.0744007,-0.0189924,-0.310948,-0.409753,-0.0607179,0.00625805,-0.179958,-0.108189,-0.169252,0.0804626,-0.0647462,0.55912,-0.0635273,-0.151835,-0.194965,0.490683,-0.502322,-0.412972,0.26326,-0.0643895,-0.118244,-0.2744,-0.296521,-0.500447,0.581447,-0.369371,-0.359343,-1.08304,0.212651,0.378857,-0.385541,-0.0170048,0.167403,0.249451,0.409149,0.49945,-2.22631 +3402.41,0.979864,0.0848144,5,1.50094,0.776284,-1.16626,0.517388,0.751579,0.101595,-0.153246,0.211286,0.341847,0.144578,0.101782,0.140816,-0.151423,0.418923,-0.256117,0.962411,0.43935,0.0466303,-0.340897,0.187341,0.257212,-0.435012,-0.919125,0.642526,-0.120048,-0.0836783,-0.0848348,0.818268,-0.359929,0.293776,0.614944,-0.900504,0.264286,0.754478,-0.390897,-0.392724,-0.0687234,0.144134,0.616804,0.082149,0.985955,0.812576,0.724173,-0.530292,-0.306769,0.896632,-0.619714,0.317708,0.081661,0.247854,0.26855,0.107598,0.229129,-0.495853,0.76398,0.0604864,-0.183558,-1.01485,0.327607,-0.596712,0.533724,0.880541,-0.604952,-1.44708,-0.116465,-0.113454,0.0873639,0.179401,-0.128988,-0.390455,0.0799824,0.504926,0.784098,-0.268703,0.237498,0.275079,0.467921,-0.208636,-0.0644945,0.128591,0.75648,-0.216167,-0.0194987,-1.03666,0.344138,0.344546,-0.110511,-0.0498679,0.356436,0.002363,0.205964,-0.294929,-0.38038,-0.243333,0.524993,-0.661636,0.167366,-0.374937,0.200736,0.148724,0.177915,0.186581,0.318492,0.0161374,0.495887,-0.303228,0.245011,-0.324071,0.144676,0.25337,0.0128442,0.240125,-0.709995,0.221249,-0.446028,-0.219155,0.399629,0.034221,0.569111,0.166897,-0.179313,0.491639,-0.121623,0.210746,0.226811,-0.222803,0.368476,-0.255844,0.370892,-0.144234,0.208897,-0.205731,0.306824,0.904039,-0.319463,-0.174019,0.18207,0.142971,-0.105285,-0.371688,-0.81072,-0.209025,-0.542892,-0.196634,-0.407843,-0.183122,0.247623,0.489751,0.521289,0.218322,-0.375882,-0.197461,0.527969,-0.0597243,0.0285108,1.12414,0.159783,-0.176705,-0.0851799,-0.0880189,-0.440884,-0.0960748,0.553236,-0.122728,0.240727,-0.046852,0.248574,-0.447115,-0.352168,0.446641,0.299526,0.209419,0.0518907,-0.152216,0.0796808,-0.221669,0.230039,0.34839,-0.0308567,0.697366,-0.189568,-0.107218,0.137518,-0.684931,-0.0651576,-0.0234122,-0.249756,0.0685868,0.283565,0.408583,-0.0799821,0.442834,-0.045602,-0.316856,0.299148,1.20928,-0.205008,-1.00098,-1.00414,-0.0246882,0.025019,0.111026,0.364094,-0.126892,-0.577093,-0.220079,-0.273589,1.25526,-0.502796,0.32691,0.226921,0.100101,0.306769,-0.192093,-0.068895,0.00987094,-0.544415,0.000704707,-0.155698,-0.18638,0.297197,-0.236281,-0.300805,-0.104324,-0.130584,0.213412,-0.367663,-0.765494,-0.178458,0.274927,-0.362618,-0.19593,-0.130577,-0.430291,-0.0647462,0.876605,0.607422,-0.364523,0.777254,-0.333866,0.205767,0.287745,-0.204887,-0.249477,0.781802,0.133213,0.265588,-0.321303,0.266319,-0.387559,-0.354536,-0.252579,-0.0554214,0.296922,-0.49184,0.0173797,-0.425545,-0.577685,0.56891,0.0194561,-0.43654,0.772544,-0.24921,-0.3994,0.143208,0.0359784,0.205447,-0.273839,0.181079,-0.171853,0.138693,-0.375942,-0.334321,-0.0209277,0.153908,-0.272847,-0.0655808,-0.132881,0.0612269,0.0930971,0.539578,-0.0912882,0.0558183,-0.107369,0.589241,-0.497755,-0.263183,0.304674,-0.0957979,0.0770897,-0.323327,-0.220036,-0.449211,0.64105,-0.315318,-0.441679,-1.06652,0.133062,0.351754,-0.36397,0.0227644,0.172352,0.237341,0.415154,0.487177,-2.26987 +3406.37,0.572135,0.0848144,4,1.51114,0.841609,-1.29424,0.638735,0.864215,-0.0207426,0.0424693,-0.0888322,0.381578,0.770273,0.307889,0.292169,-0.288626,0.612055,-0.144819,0.981977,0.415439,0.0699208,0.144648,0.0067663,0.0986227,-0.367258,-0.517279,0.386499,-0.165453,0.0510418,0.410779,0.786792,-0.647841,0.123984,0.423462,-0.174059,0.105918,0.814927,-0.466722,-0.419751,9.82088e-05,0.578957,0.573775,-0.20082,0.818462,0.573607,0.243899,-1.08162,0.138765,0.994212,-0.918105,-0.24318,0.128178,-0.316581,0.299037,0.723046,0.100987,-0.964008,0.406237,0.103543,-0.418061,-0.928929,0.0694326,-0.614086,0.252191,0.784641,-0.57563,-0.74483,0.564756,-0.205275,0.104645,-0.111905,-0.161624,-0.383583,-0.389213,0.421991,0.493728,-0.180372,0.394916,0.287408,0.525107,0.254931,-0.197685,0.571131,0.414651,-0.0758454,0.144522,-0.455196,0.193426,-0.0540687,-0.467911,0.484549,0.1697,0.0820428,0.344006,-0.582311,-0.188749,-0.3079,0.172871,-0.0149216,0.147023,-0.193026,0.162651,0.449081,-0.0192692,0.083914,-0.0473037,0.190194,-0.0891426,-0.169665,0.435881,-0.104515,0.189929,0.202663,0.505865,-0.0215105,-0.555522,0.264495,-0.726485,-0.313428,-0.261896,0.379711,-0.0106308,-0.191342,-0.440014,0.431475,-0.316444,0.0845476,-0.0391224,0.441819,0.418918,-0.0219301,0.317544,-0.409683,-0.302876,-0.20204,-0.0420248,0.218502,-0.0744461,-0.426684,-0.0714895,0.638781,0.13781,-0.262383,-0.514878,-0.0169957,-0.678019,-0.203983,0.0162226,-0.138502,0.288742,0.36321,0.361941,0.16612,-0.397577,0.0204517,0.0909057,0.0743338,-0.0710285,0.965598,-0.147066,0.0373094,-0.229536,0.0188253,-0.807103,0.0351304,0.314138,-0.194038,-0.392618,0.322029,0.118953,0.335218,-0.229106,0.422878,-0.462603,0.0915344,-0.218282,-0.507282,-0.313622,0.0519146,-0.152556,-0.161712,0.678124,0.754687,-0.152436,0.158149,0.368367,-0.420224,-0.061944,-0.54773,-0.222423,0.113183,0.204521,-0.103935,-0.271764,0.284883,-0.368352,-0.658926,-0.210157,0.904683,-0.384067,-0.780101,-0.526972,-0.0622364,-0.00931699,-0.16198,0.567112,-0.087146,-0.15787,-0.232307,-0.464164,1.51558,-0.627517,0.330976,-0.385414,-0.0434933,0.0615267,-0.139403,-0.556512,0.185172,-0.699492,0.310918,-0.140441,-0.279382,0.348835,0.0283121,0.242498,0.247974,-0.0663197,0.108198,-0.0450629,-0.691978,0.172583,0.051036,-0.0769308,-0.20237,0.209714,-0.104094,0.0843954,0.693425,0.414856,0.206473,0.466068,-0.895148,0.0982118,0.33428,0.154039,-0.0385869,0.783338,0.0794041,0.286819,-0.440139,0.076784,-0.291215,-0.471262,-0.840735,-0.015819,0.102576,-0.565806,0.00663551,-0.682445,-0.862159,-0.376542,-0.27535,-0.0960393,0.0563345,-0.789339,0.227476,0.197934,0.155091,0.433647,-0.465787,0.642078,-0.126926,-0.00811012,0.246845,-0.543052,-0.165678,-0.06099,0.145509,0.0162978,0.315111,-0.372832,0.150648,-0.13977,-0.510977,0.0979767,-0.278842,0.264022,0.0145176,-0.214291,0.0940165,0.0428766,0.444063,-0.0706792,-0.016955,-0.0497415,0.230875,-0.416625,-0.313977,-0.782684,-0.400225,0.101589,-0.368728,-0.137486,0.116582,0.275692,0.341441,0.525064,-2.76635 +3415.59,0.867412,0.0848144,4,1.50497,0.793407,-1.32261,0.66915,0.849303,0.00593065,0.208032,-0.0785794,0.557192,0.552279,0.235497,0.235516,-0.400171,0.726173,-0.21226,1.1331,0.511811,0.05762,0.337362,-0.182662,0.267004,-0.402031,-0.344045,0.646461,-0.273707,0.116998,0.171023,0.971723,-0.505117,0.0315303,0.578705,-0.24255,0.110464,0.832889,-0.725368,-0.453446,0.137271,0.934103,0.526992,-0.0984748,0.795221,0.575045,0.309598,-1.04983,0.0105926,0.605479,-0.883287,-0.254057,-0.033505,-0.199637,0.270625,0.727194,-0.0537277,0.0282443,0.305559,-0.240486,-0.309968,-1.12615,0.393161,-0.526959,0.487848,0.932452,-0.648286,-0.49789,0.0754384,-0.0429182,0.139769,-0.214117,0.0420927,-0.356445,-0.460766,0.0128216,0.280408,-0.432516,0.51335,0.483033,0.346053,0.395469,-0.0923494,0.277912,0.715837,-0.491801,0.0890321,0.0493313,0.113927,0.173857,-0.143116,0.51946,0.313973,0.119142,-0.0301607,-0.658256,-0.375685,-0.123723,0.213528,0.0653553,0.107154,-0.108827,0.291318,0.628218,-0.263313,0.128874,-0.131318,-0.351949,-0.0587489,-0.307658,0.21276,-0.110681,0.124303,0.462546,0.518072,0.214976,-0.690539,0.383109,-0.488775,-0.164996,-0.10843,0.203928,-0.0660589,-0.236815,-0.543289,0.343082,-0.401909,0.113341,-0.150329,0.0591328,0.374788,-0.0900439,0.704268,-0.462121,-0.0770983,-0.187851,0.147107,0.218365,-0.213494,-0.339344,-0.4338,0.498968,0.246248,-0.0184829,-0.503806,-0.0623464,-0.37258,-0.0868537,0.315056,0.0223756,0.120179,0.381547,0.327561,0.0360444,-0.667981,0.216524,0.0197785,-0.15016,-0.10089,0.857934,0.154095,0.0498901,-0.0960644,0.336413,-0.240633,0.104073,0.0974865,-0.271751,-0.243029,0.305904,-0.0665706,0.184708,-0.519806,0.513167,-0.330187,0.450765,-0.186485,-0.564857,-0.319456,0.157306,-0.101733,-0.0856703,0.59428,0.554771,0.462546,0.108679,0.371882,-0.332583,-0.145816,-0.19908,-0.152291,-0.196931,0.0630833,-0.131484,-0.0821586,0.46889,-0.376497,-0.842818,-0.117489,0.747789,0.0700969,-0.735031,-0.313177,-0.0666181,-0.00807351,-0.339213,0.378756,-0.0807781,-0.0378201,0.0073413,-0.469774,1.32769,-0.4277,0.386729,-0.130874,-0.000798771,0.0181534,0.079204,-0.163369,0.13408,-0.391116,0.252886,-0.166869,0.103132,0.446653,-0.0149927,0.13,0.477954,0.025863,0.394123,0.137018,-0.859371,0.10487,-0.163803,-0.0957948,-0.177938,-0.0364212,-0.413371,0.126315,0.491367,0.0358344,-0.10167,0.688138,-1.03578,0.385709,0.309838,-0.0982883,0.0761823,0.20817,0.0801002,0.421818,-0.514322,0.368868,-0.439011,-0.232008,-0.949988,-0.21263,-0.104328,-0.486915,-0.137907,-0.423952,-0.800772,-0.560905,-0.196106,-0.394645,0.29432,-0.948804,0.137801,-0.0752666,0.105432,0.285178,-0.392537,0.403776,0.187149,0.24177,-0.0915225,-0.339704,0.158897,0.0296586,0.69676,-0.223653,0.0717339,-0.221703,0.187746,-0.390946,-0.429074,-0.00682688,0.0028501,0.367407,-0.0929743,-0.20704,0.134644,0.0700719,0.264333,-0.00406957,-0.0497357,-0.0791539,0.482047,-0.236858,-0.63985,-0.45781,-0.321951,0.199184,-0.172316,-0.153258,0.164745,0.306285,0.405887,0.55343,-2.6584 +3414.27,0.821071,0.0848144,4,1.42948,0.799913,-1.69048,0.70933,0.94484,-0.0639524,0.454221,0.213896,0.631196,0.139379,-0.00660084,-0.113124,0.365869,0.450436,-0.329856,0.88811,0.418985,0.218765,-0.153499,0.0437533,-0.12143,-0.574136,-0.529359,0.465573,0.0346738,0.0781821,0.11785,0.900764,-0.298504,-0.299172,0.589687,-0.584513,0.43951,0.787238,-0.0627394,-0.154137,-0.00804993,0.419455,0.615178,-0.195043,0.849696,0.873508,0.709093,-0.587401,0.383488,-0.222649,0.0477431,0.334131,0.380433,0.0604768,0.151991,0.560151,0.265399,0.346866,0.550172,-0.0472262,-0.0667879,-1.03478,0.0806411,-0.185521,0.350589,1.0425,-1.15124,-0.8325,0.54815,0.367081,0.0810707,-0.397645,-0.243398,-0.00677403,0.243856,-0.238181,0.442568,0.0179921,0.332495,0.194624,0.455501,-0.277956,-0.360931,0.0347375,0.240987,-0.494396,0.137948,0.281538,-0.151372,-0.00281829,-0.140657,0.731065,0.99742,0.0262418,-0.138642,-0.11542,-0.736949,0.151303,0.302979,0.279953,0.440883,0.37745,0.338451,0.603384,0.533224,-0.103556,-0.17823,-0.399687,0.369189,0.0657979,0.51192,-0.11572,0.734141,0.324647,-0.4159,0.0548027,-0.25711,0.38154,-0.351418,-0.0327817,0.0386414,0.143238,-0.0411983,-0.0758632,-0.3764,0.360822,-0.638519,0.243893,-0.199099,-0.162066,0.3459,-0.338395,0.450683,-0.492068,-0.108514,-0.215761,-0.665292,0.0470774,-0.289598,-0.258773,0.135507,-0.00754827,0.471819,-0.905517,-0.0981377,-0.553887,-0.112331,-0.750296,0.156616,-0.347549,-0.113203,0.588809,-0.14786,-0.37351,-0.659304,-0.136133,-0.0936876,0.1172,0.107139,1.0077,0.365025,-0.594593,-0.129027,0.131401,0.143158,-0.305922,0.0604373,-0.11205,-0.239495,0.0904133,-0.0499493,0.0733368,-0.245917,0.405042,0.328993,0.104122,-0.207841,-0.526984,0.141442,-0.0747647,0.139077,-0.339281,0.185008,0.893305,0.388973,0.520574,0.211253,-0.426551,-0.129759,-0.0610351,-0.732916,-0.406265,-0.39228,-0.206699,-0.142565,0.259278,-0.243715,-0.722702,0.154281,0.0396662,0.069593,0.0183458,-0.288328,0.0811723,-0.100324,-0.00851154,0.348878,0.472353,-0.481246,0.0669871,-0.638928,1.24984,-0.0740978,-0.576407,-0.382552,0.0136407,-0.0785143,-0.242748,-0.519792,0.467851,-0.0517876,0.199645,-0.261932,0.0146596,0.329788,-0.217793,0.510361,0.114915,0.0541776,0.246958,0.0897003,-0.296292,-0.0561329,-0.754002,-0.508432,-0.0699385,-0.0773253,-0.383391,-0.0593494,0.645895,-0.127214,0.508108,0.519323,-0.142528,0.140628,0.524064,-0.421108,0.485529,0.439553,-0.258,0.644984,0.230311,-0.0898184,-0.312945,0.448459,-0.643204,-0.195485,-0.229769,-0.419907,0.0451577,-0.40618,-0.939375,0.0581758,-0.242599,0.414816,0.598041,-0.38703,-0.488194,0.043719,0.541428,0.0716098,-0.120998,0.291617,-0.324604,-0.0185726,0.265517,-0.882436,-0.159381,-0.158665,0.249166,0.176521,-0.126091,-0.39374,0.178292,-0.186833,-0.6468,0.0197711,0.164335,0.242125,0.292438,-0.444908,0.133324,-0.058293,-0.713339,-0.146654,0.331004,0.355818,0.6137,0.0633048,-0.61507,-0.0995069,-0.00611475,0.266155,0.340499,-0.292043,0.12336,0.22816,0.351227,0.477661,-2.8899 +3420.82,0.827251,0.0848144,4,1.4614,0.8192,-0.924795,0.426233,0.906291,-0.0915485,-0.0431578,-0.118978,-0.363432,0.840245,0.114729,0.365964,-0.0502782,0.381393,-0.263661,1.1987,0.493166,-0.0748125,0.04191,-0.00995673,0.3956,-0.229992,-0.237978,0.627393,-0.675778,0.213465,0.0249393,0.367815,-0.632013,-0.0783609,1.06837,-0.694272,0.0595851,0.812368,-0.4242,-0.322972,-0.178583,0.328098,0.635396,-0.0585547,0.700827,0.926519,0.441136,-0.385546,0.282884,0.179989,-0.521845,-0.510737,-0.0647692,0.0782328,0.083165,0.701433,0.060242,-0.67713,0.782102,-0.300478,-0.168906,-0.871536,0.407833,-0.277895,0.140824,0.843994,-0.231844,-1.00439,-0.244545,0.332947,-0.638224,0.674574,-0.386461,-0.420332,-0.894667,0.203328,0.443523,0.293195,0.435914,0.453089,0.45656,0.281782,0.0523921,-0.0486622,0.340084,-0.347117,-0.148149,-0.147604,-0.68983,-0.240293,-0.247357,-0.15544,0.0966158,-0.312962,-0.474949,-0.0855116,0.00588004,0.27885,0.302613,-1.00817,-0.378009,-0.193131,0.481247,0.48222,-0.633959,0.478126,-0.350866,-0.727871,-0.0251838,-0.815058,0.631565,-0.167241,0.0592659,0.623207,0.231083,-0.147328,0.192981,0.220962,0.511275,0.125099,-0.578579,0.267731,-0.0629565,-0.0253303,-0.915186,-0.715884,0.29623,0.0575146,0.406746,0.495687,0.242087,0.0505123,0.266581,-0.321337,0.303238,0.100016,0.239565,0.247378,-0.183646,0.22614,0.121717,0.116819,-0.0159406,-0.774891,-0.244478,-0.0747834,0.114288,-0.258563,0.321,0.776293,0.127083,1.07623,0.0030499,0.469751,-0.612488,-0.125058,0.319509,-0.461294,0.407462,0.655715,-0.240491,-0.0649512,0.147436,-0.324571,-0.0820689,-0.218621,0.34614,0.133952,0.0593747,0.551031,0.0635034,0.02227,-0.103136,-0.8393,-0.168986,-0.0441342,-0.0922681,-0.101461,-0.475709,0.551451,-0.550682,-0.139311,0.349711,0.460616,0.11931,-0.119419,0.316656,0.272037,-0.163179,-0.468803,-0.221426,0.0682251,0.294685,-0.95816,0.0671805,0.304807,0.442011,-0.672973,0.270161,0.387402,-0.139281,-0.606341,-0.377782,-0.0225872,-0.405456,-0.2759,0.243517,-0.317791,0.219839,0.496217,0.125481,0.756731,0.556241,0.371647,-0.294938,-0.458884,0.117434,0.383249,-0.61408,0.166875,-0.408014,0.57598,-0.551465,0.0718559,-0.440842,-0.386701,0.139701,0.218477,-0.183688,0.889145,-1.04375,-0.29921,0.141389,0.390924,0.00207993,0.00526324,-0.502739,-0.164404,0.0764756,0.473963,-0.0117264,-0.121332,0.687244,-0.363817,-0.00720319,0.187437,-0.158859,0.0476865,0.266905,0.152401,0.328579,0.0123533,-0.199916,-0.437758,-0.180019,-0.817124,0.400937,-0.338905,-0.137461,0.131249,-0.572461,0.313794,0.0239436,-0.129364,0.283991,-0.144711,0.391098,0.412488,-0.026737,0.206805,0.0344103,0.561186,-0.0161886,-0.237824,0.121376,-0.135197,-0.152017,-0.267773,0.374557,0.0626357,0.359069,-0.147029,0.424299,-0.00988389,-0.59596,0.130717,-0.778947,0.491653,0.0159146,0.096261,-0.216639,0.0409236,0.55225,-0.358983,-0.0271866,0.412229,0.27458,-0.0727584,-0.157838,-0.0803404,-0.223213,0.0268839,-0.0495813,-0.180716,-0.193841,0.121808,0.27815,0.34901,0.5274,-2.89103 +3395.77,0.924551,0.0848144,4,1.53482,0.84581,-1.04697,0.512262,0.817402,-0.0579806,-0.27909,0.230153,0.341099,0.161081,0.401071,0.252491,0.0219986,0.681106,-0.249542,0.872786,0.281496,0.0767009,0.0578333,0.252305,0.269281,-0.424832,-0.27953,0.666937,-0.422033,0.493299,0.282013,-0.214031,-0.227517,-0.210544,0.771841,-0.853215,0.553973,0.700084,-0.315528,-0.115099,0.159013,0.798078,0.666003,-0.182578,0.547294,0.874706,-0.230994,-0.363684,0.34429,0.877515,-0.503427,-0.154182,-0.151323,0.105903,0.232757,0.586586,0.0025211,-0.131175,0.309414,-0.566476,-0.0842386,-0.798801,0.467643,-0.457691,0.0214923,0.948228,-0.153308,-1.33525,0.106739,0.427301,-0.649737,0.159953,0.152945,-0.3186,-0.634437,0.430273,0.388705,0.418227,0.546527,0.087778,0.470569,0.0402813,-0.263289,-0.0912128,0.318898,-0.43392,-0.347764,-0.289394,-0.574567,-0.451423,-0.123924,0.180599,-0.143044,-0.341855,-0.615295,-0.0900245,0.182996,0.202998,0.262658,-0.904394,-0.237592,-0.17276,-0.317961,0.535629,-0.387835,0.462917,-0.772029,-0.431679,-0.222097,-0.265664,0.721175,-0.0174007,0.0581742,0.497471,0.486862,0.136829,-0.141902,0.468307,0.519191,-0.0681591,-0.797953,0.225717,0.061248,0.691777,-0.691072,-0.807453,0.604684,0.112343,0.137861,0.606892,0.397903,0.047424,0.355787,-0.554216,0.100791,-0.269591,0.179029,0.0941197,-0.506223,0.0342947,0.0701939,0.17519,0.0965078,-1.31163,-0.576577,-0.245575,-0.336405,-0.533978,0.124236,0.836891,0.40408,0.877594,0.137452,-0.361322,0.218435,0.350152,0.377299,0.0375855,0.416889,0.437335,-0.0640301,-0.615569,0.246907,-0.00532111,0.421826,-0.147286,0.621628,0.2823,0.895116,0.0464159,0.263202,0.264815,-0.155911,-0.82701,-0.0343114,0.028604,-0.0886695,0.0200608,-0.448783,0.169024,-0.251789,-0.21273,0.69654,0.913485,-0.0450632,0.628048,0.00627047,0.0510484,-0.131456,-0.658389,-0.367407,0.164099,-0.133743,-0.454863,0.0399579,-0.0550171,0.44093,-0.835888,0.0374877,0.0848739,-0.62139,-0.869886,-0.312813,-0.430011,-0.300472,-0.437156,0.439675,-0.297264,0.0614131,0.0357807,0.176557,1.14514,0.302681,0.194893,-0.481577,-0.427283,0.328809,-0.0813186,-0.366371,0.114103,0.0771445,0.271393,-0.0779103,0.124353,-0.14418,-0.860651,-0.0207026,-0.0100632,-0.32561,0.823355,-0.744051,-0.755715,0.340689,-0.0500392,-0.399837,0.220384,0.200276,-0.151272,0.407339,0.558139,-0.164642,-0.0321674,0.563045,-0.415481,0.338161,-0.0552133,0.121327,0.115039,0.533458,-0.13287,0.448554,-0.21533,0.0500018,-0.599648,-0.142024,-0.33914,0.186241,-0.204418,-0.434862,0.209097,-0.867743,0.270682,-0.118271,0.176668,-0.0200979,-0.0345946,-0.0940521,0.725906,0.339412,0.11563,-0.0293663,0.479357,0.279088,-0.407198,-0.209756,-0.538105,-0.952828,-0.159482,0.431079,-0.108878,0.289739,-0.135462,0.375247,0.54217,-0.758774,-0.305904,-0.202799,-0.416676,-0.168753,0.301266,-0.334537,0.0372041,0.342849,-0.29891,0.135494,0.345691,0.140742,-0.6063,-0.280931,-0.265934,0.216762,0.511614,-0.296667,0.0415201,-0.560208,0.203795,0.346343,0.451437,0.588509,-2.59535 +3393.69,0.99987,0.0848144,5,1.56408,0.741185,-1.17351,0.550804,0.627867,-0.0651216,-0.0945502,0.0998473,0.0324102,-0.0409187,0.826777,0.217753,-0.230883,0.3639,-0.0402224,0.46058,0.156682,0.117856,-0.220499,-0.104526,-0.15432,-0.829331,-0.55881,0.356728,0.0497455,-0.0933769,0.298064,0.501008,-0.287154,-0.131156,0.654553,0.0650842,-0.285721,0.127923,-0.437796,-0.196418,-0.0152635,0.272241,0.420905,0.327478,0.477801,0.229716,0.352411,-0.56674,0.100601,-0.431883,-0.388653,-0.0533213,-0.25037,0.290406,-0.209596,0.347236,-0.0789262,-0.730211,0.15952,-0.125451,-0.477353,-0.737845,0.47233,-0.183104,-0.104801,0.97491,-0.679649,-1.05132,0.409084,0.781794,0.183671,-0.397228,0.506936,-0.568541,0.218802,0.171099,0.947239,-0.096188,0.818343,0.325996,0.473452,0.155924,-0.507302,0.0185888,0.893746,-0.301687,0.425283,0.069088,-0.331941,-0.113569,0.285362,-0.218765,0.651729,0.0958572,-0.512053,0.532343,0.081906,0.110629,-0.198128,-0.44333,0.349008,-0.111454,-0.36341,0.509633,0.484248,0.314354,-0.816353,-0.512741,0.106312,-0.262116,-0.0188042,0.280904,0.316378,0.591372,-0.412517,-0.171501,0.458001,0.763618,0.0668205,0.3312,-0.365525,-0.0792172,-0.209383,-0.384674,-0.773682,0.371691,-1.2383,-0.396785,-0.232072,-0.0340143,-0.0330778,-0.0104673,-0.175152,-0.378074,-0.109731,0.309714,-0.281939,1.07295,-0.339506,-0.105152,0.440963,-0.401001,0.478313,0.061822,0.0857224,-0.036538,0.647638,-0.603595,-0.167744,0.482234,-0.96998,0.85888,0.0521588,-0.0122149,-0.897989,0.0853586,0.228828,-0.232241,-0.0798472,0.201504,0.610667,-0.679248,0.326798,0.0393916,0.421428,-0.271696,0.46035,-0.755662,-0.793504,0.753565,0.424872,-0.54732,-0.0184485,0.131242,0.669941,0.0295642,0.395753,0.0355114,0.387702,0.138459,-0.432417,-0.104672,0.387203,0.580381,0.452311,-0.760463,0.0213391,0.257874,0.0255129,0.0553571,-0.269181,-0.873012,-0.245826,-0.0469213,0.190259,-0.525076,-0.606044,-0.415009,-0.00289384,0.719082,0.610096,-0.00444177,-0.47136,-0.6177,0.0153404,0.123492,-0.0309296,-0.370545,-0.236118,0.152411,-0.22844,1.18954,-0.0790036,-0.0033513,0.45659,0.407873,-0.468759,0.0807519,-0.0447525,0.319641,-0.784663,0.510517,0.470837,0.0901847,0.126723,-0.440328,-0.204962,0.326907,0.0386913,0.693593,0.167845,0.193639,0.0377044,0.389577,-0.239889,0.245208,-0.5162,0.135735,-0.976174,0.22455,-0.331024,0.478495,0.459349,-0.965367,0.351375,-0.000273526,-0.309501,-0.464098,0.978509,0.202567,0.17656,0.181068,0.0510953,-0.164848,0.593271,-0.41183,0.114936,-0.0172042,-0.0384316,-0.0809701,0.24301,-0.331567,0.291289,-0.256997,0.145713,0.311238,0.234573,0.156941,0.0911292,0.927305,0.536338,-1.03518,0.252767,0.672303,0.0860624,0.00365947,-0.63985,0.686425,-0.14227,0.0103628,0.372751,-0.0319795,0.0232686,-0.490842,-0.118092,-0.256136,-0.269507,0.434991,0.774343,-0.471936,0.260107,0.314762,0.111242,-0.298715,0.308881,-0.0105678,0.247789,0.505457,0.155255,-0.425788,-0.590599,-0.595081,-0.207328,-0.104647,-0.223341,0.232213,0.110988,0.481885,0.333149,-1.72018 +3385.92,0.801778,0.0848144,4,1.56594,0.824207,-1.0612,0.521929,1.00167,-0.18262,-0.0324844,-0.31631,0.490097,0.0767646,0.193253,-0.192679,0.107022,0.175413,-0.270091,0.922307,0.538138,0.231475,-0.666214,0.137819,-0.207059,-0.651261,-0.500458,0.482796,-0.45306,0.119443,0.158699,-0.286075,-0.338779,-0.290027,0.466141,-0.402559,0.197036,0.434121,-0.423544,-0.0515304,-0.202469,0.627193,0.306478,-0.29429,0.52755,-0.188892,-0.346005,-0.34826,0.101153,-0.361657,-0.359954,-0.32474,-0.412593,-0.0616407,-0.525588,0.405782,-0.239021,-0.039558,0.183223,-0.314488,-0.26591,-0.585459,0.515765,-0.289139,-0.187339,0.814551,-0.471634,-0.437782,0.133947,-0.0246167,0.355091,-0.418371,-0.356351,-0.434197,0.383713,0.244287,0.564862,0.0157236,0.858214,0.337885,0.184929,0.229362,-0.101396,0.534225,0.318586,-0.406677,-0.182151,-0.349821,-0.147923,0.384326,0.385997,0.756384,0.59315,0.0642053,-0.353479,0.0158439,0.477544,0.345266,-0.106601,-0.914948,0.255521,-0.241759,-0.366371,0.153632,0.470264,0.0838449,-0.783847,-0.284847,0.180086,-1.02141,-0.148307,0.167819,0.0226766,0.908604,-0.237651,-0.506429,0.0653016,0.630931,0.470847,0.644055,-0.653129,-0.0277947,0.185869,-0.370226,-0.947035,0.27595,-0.837544,-0.281821,0.0496864,0.0312053,0.0495928,0.319205,0.0899091,-0.224464,0.0206587,-0.183577,0.0279171,0.29213,-0.717137,-0.117256,-0.0879114,-0.0895471,0.71725,0.205616,-0.192215,-0.185783,0.0641576,-0.457896,0.0794266,0.322833,-0.800281,0.652916,0.202185,-0.136569,-0.805837,0.669843,0.408062,-0.321219,0.603296,0.429483,0.788104,-0.00808797,-0.154032,0.0242326,0.684906,-0.39911,0.500697,0.260094,-0.459072,0.706984,0.789199,-0.0257903,-0.0981124,-0.0511328,0.288047,0.158011,0.0938822,-0.0417811,-0.479367,-0.159846,-0.275393,-0.24093,0.658156,0.715737,0.200395,-0.375616,-0.124955,-0.162947,0.879507,-0.0888532,0.287061,-0.352254,-0.259586,0.227282,0.13773,-0.219004,-0.471124,-0.903927,-0.120547,0.201563,0.127673,-0.293295,-0.371677,-0.15865,-0.269463,-0.322859,0.734322,-0.313607,0.432386,-0.155043,-0.424194,1.33092,0.410476,0.270296,-0.201599,-0.487285,-0.139368,-0.207189,-0.324339,-0.0960866,-0.20601,0.776512,1.10165,-0.30217,-0.467045,-0.377078,0.360845,0.378644,-1.02282,0.980842,0.0712271,0.0278318,-0.0673348,0.667285,-0.0615455,0.499889,-0.735955,-0.643729,-0.423914,0.259365,-0.362754,0.47176,0.611473,-1.24447,0.357103,-0.0209007,-0.278322,-0.413157,0.466586,0.605099,0.368048,0.433991,0.142127,-0.174608,0.216308,-0.501123,0.387437,-0.31588,0.902317,-0.340013,-0.301306,0.213654,-0.0683567,-0.024544,0.197727,-0.0258252,-0.482419,0.741938,-0.121021,0.708988,0.41712,-0.235611,-0.0802984,-0.00494264,0.166908,0.354402,0.303826,-0.275899,0.343561,0.228202,0.538748,0.103137,0.182866,-0.585264,-0.442331,0.0179819,0.373399,-0.00324263,0.334466,-0.304149,0.0884039,0.222505,0.016299,0.252495,0.386099,0.223532,0.278162,0.0470552,-0.156037,-0.671752,0.150651,-0.272757,-0.909417,0.108593,-0.491101,0.166827,0.219329,0.408444,0.468326,-3.10828 +3410.82,1,0.0848144,4,1.57159,0.848061,-1.2398,0.552299,0.617472,-0.049752,-0.105269,0.12789,-0.0238471,0.0622616,0.217301,-0.227277,-0.464092,0.381416,0.309106,0.37195,0.135903,0.0633339,-0.230555,-0.216464,-0.350932,-0.602434,-0.766556,0.484791,-0.186097,-0.0589178,0.343671,0.435375,-0.0223878,-0.227163,0.830665,0.0504413,0.689579,0.270339,-0.378682,-0.175843,0.00146799,0.0682547,0.784494,0.0417128,0.656494,-0.198515,0.666847,-0.209241,-0.337984,0.358858,-0.930324,0.565156,0.0813749,0.32074,-0.25152,0.981293,-0.102648,-0.661388,-0.0651995,-0.152428,-0.342142,-0.598951,-0.00487558,0.0729162,0.240453,0.79816,-0.526775,-0.673557,0.257625,0.165616,0.068851,-0.106112,0.0748416,-0.230238,0.249968,-0.330861,0.863666,-0.220798,0.553192,0.255475,0.24303,0.042508,-0.249684,0.139941,0.402464,-0.379587,0.0201008,-0.0444261,-0.52565,0.0468421,0.254119,-0.422802,0.693621,-0.292294,-0.419868,0.242479,-0.46716,-0.104252,-0.150378,-0.498132,-0.319721,-0.402796,0.526137,0.62613,0.710868,0.100254,-1.06243,0.212764,0.0192726,0.444182,0.28522,0.127464,0.216318,0.796872,-0.195945,0.0457784,0.00664316,0.756869,-0.175801,-0.530013,-0.0612684,0.425621,-0.227038,-0.00787129,-1.08243,-0.0718007,-0.318273,-0.724756,-0.378686,-0.0243332,0.393674,0.298306,0.0469237,0.144982,0.312134,0.134915,-0.1639,1.24073,-0.412588,0.0260055,0.102069,-0.329273,0.674534,-0.742191,-0.286839,-0.203592,0.484858,0.171727,-0.624707,0.125946,-0.0713364,0.801605,-0.0791841,-0.47371,-0.285145,-0.282778,-0.237025,-0.413868,0.0378323,0.513648,-0.367817,0.0809794,0.186546,-0.0534266,0.651339,0.0706016,0.699566,0.331693,0.811638,0.42392,-0.031661,-0.241867,0.119859,-0.121888,0.0445536,0.106778,0.450599,-0.00954642,-0.126808,-0.772983,-0.212894,-0.63428,0.113582,0.693051,0.0726061,-0.784885,0.255657,0.0132544,0.243412,-0.0855177,-0.429789,-0.515662,0.230234,-0.485517,0.220721,-0.181297,0.451148,-0.51242,0.0432155,0.296338,0.257475,-0.0968015,-0.453818,0.320675,-0.365055,-0.0757158,-0.0777046,0.0279919,0.653479,0.230064,0.0427342,0.862938,0.123995,-0.215976,0.11174,-0.0990337,-0.296705,-0.335546,-0.38032,-0.0644281,-0.820327,0.174434,1.03302,-0.476053,-0.631071,-0.829003,0.637056,0.231861,-1.10898,0.515533,-0.574351,-0.0310743,-0.0966136,0.204487,0.749427,0.22287,-0.114705,-0.696066,-0.204611,0.730456,-0.531985,-0.314266,0.65753,-0.817277,-0.380073,-0.0977946,0.40748,-0.0526777,0.663211,-0.0279863,0.595188,0.0630881,0.781221,-0.413981,-0.432562,-0.358903,0.24149,0.0613737,0.325117,0.733009,0.0442186,-0.306251,0.044612,-0.237172,0.0632683,0.334688,-0.292943,0.379705,0.0554003,0.150908,0.113263,0.0405878,-0.645706,0.235644,-0.0641936,-0.415272,-0.267055,0.989647,-0.00569073,-0.390846,-0.158753,0.645822,0.33914,-0.382349,-0.0477844,0.00896819,-0.188451,-0.437448,0.0640907,-0.424561,0.159004,0.0418467,0.518899,-0.464577,0.278117,-0.267916,0.323725,-0.173741,0.0839214,-0.586083,-0.11244,0.297841,0.72849,-0.141706,0.30759,0.180315,0.145462,0.424635,0.381395,-1.83754 +3376.45,0.740148,0.0848144,4,1.55522,0.866209,-1.34001,0.594901,0.626418,5.63186e-06,-0.0101785,0.00941111,-0.0544315,-0.0871303,-0.0626442,-0.596324,-0.11786,0.136485,0.352179,0.572505,0.0821572,-0.111402,-0.282756,-0.119727,-0.277737,-0.384063,-0.650511,0.500175,-0.579048,0.0719596,0.914135,0.65845,-0.0631573,-0.362518,0.70058,0.0936411,0.661962,0.510951,-0.149419,-0.141844,0.0849245,0.213895,0.510362,0.0474896,0.707574,0.210672,0.407523,-0.18642,-0.142096,0.569134,-1.13018,0.663354,-0.18989,-0.0176589,-0.125324,1.00899,-0.028854,-0.29449,-0.0988685,0.111115,-0.469328,-0.753059,-0.16058,0.229704,0.37705,0.972963,-0.627698,-0.763608,0.0134994,0.377412,0.451631,-0.73815,-0.017056,-0.115231,0.250878,0.0548704,0.622093,0.0540379,0.717332,0.5675,0.226515,0.240966,-0.171636,0.247639,0.281777,-0.286029,-0.0738871,-0.141783,-0.565566,-0.524291,0.0583621,-0.469231,0.468171,-0.0830625,-0.659998,0.273503,-0.40148,-0.117709,-0.211796,-0.627212,0.0010363,-0.370998,-0.130832,0.63662,0.55562,-0.0588199,-1.0144,0.0327176,0.285331,-0.00491345,0.716166,0.480301,0.284462,0.587862,-0.298588,0.0820059,0.166732,0.642824,-0.439032,-0.485061,-0.023658,0.293816,0.238803,0.113134,-1.16671,-0.44418,-0.260673,-0.719281,-0.650608,-0.00553629,0.197222,0.407445,-0.0262541,0.0402257,-0.0677958,0.250754,-0.119084,0.906071,-0.242881,0.0439024,-0.224452,-0.26858,0.408462,-0.751426,0.0835494,-0.223912,0.90599,-0.203397,-0.655478,0.497688,-0.0501696,0.818884,0.216253,-0.255794,-0.263756,-0.166961,0.229308,-0.279503,-0.229428,0.369983,-0.475704,0.0645929,0.230888,0.166383,0.477518,-0.0730757,0.520008,0.641497,0.699998,0.5217,-0.145501,0.192177,0.149621,-0.222304,-0.00701908,0.0737148,0.438203,-0.113891,-0.251702,-0.562139,0.114063,-0.607915,-0.311894,0.669682,-0.394403,-0.511471,0.255699,0.163754,-0.0306499,0.00862534,-0.67138,-0.157535,0.4486,-0.802179,0.131256,-0.417543,0.594556,-0.371965,0.0422184,0.375551,0.422815,0.0294784,-0.672187,0.320848,-0.37349,-0.395293,0.121572,0.224118,0.207755,-0.0854568,-0.127034,0.857833,0.246632,-0.069959,0.771724,-0.0753728,-0.105536,-0.557044,-0.239578,0.246657,-0.710655,0.206689,1.11389,-0.893244,-0.474483,-0.749654,0.435981,0.307241,-1.00924,0.859137,-0.743568,0.195006,-0.541242,0.398604,0.697381,0.407365,-0.135449,-0.914685,-0.26722,0.864117,-0.235382,0.0361435,0.389615,-0.766717,-0.424042,-0.0635496,0.0786379,0.295756,0.451464,-0.131687,0.521225,-0.34737,0.390965,-0.517253,-0.389207,-0.309658,0.119453,0.109963,0.257155,0.409391,0.344605,-0.430667,0.298247,-0.0776548,0.497336,0.868739,-0.26926,0.337756,-0.0836163,0.237456,0.27054,-0.472783,-0.541798,0.297633,-0.386754,-0.375711,0.177086,0.697872,-0.0616006,-0.393034,0.0127516,0.403463,0.187106,-0.442265,-0.076391,0.121007,-0.443662,-0.359933,0.479483,-0.387416,-0.131575,0.461081,0.64058,-0.825967,0.207354,-0.0868447,0.359121,0.397841,0.25759,-0.218733,0.125334,0.095499,0.692491,-0.283928,0.0291325,0.183714,0.174946,0.428619,0.418266,-1.91589 +3393.59,0.632958,0.0848144,4,1.65966,0.872005,-1.00747,0.498414,0.84018,-0.17882,-0.164119,0.00620408,0.681749,0.307526,0.0221523,0.00867732,0.0274365,0.0956413,-0.550269,0.389887,0.0603363,-0.102669,-0.230419,-0.199431,-0.752723,-0.5948,-0.661971,0.371062,-0.663971,-0.18385,0.467077,0.159815,-0.0591826,0.0488551,0.429354,-0.559498,0.331498,0.118115,-0.475213,-0.0994474,-0.250827,0.448584,0.695447,-0.670353,0.606421,0.184167,-0.226071,-0.505985,-0.0691842,-0.180358,-1.33433,-0.724843,-4.27702e-05,0.260771,-0.418315,-0.137138,-0.129675,0.413118,0.0968044,-0.0157022,-0.103979,-1.13082,0.396483,-0.650514,0.334625,0.951587,-0.581508,-0.397988,-0.127565,0.269094,0.727528,0.192663,-0.00146046,-0.539968,-0.218232,0.535881,0.836845,-0.327343,0.783187,0.401443,0.57898,0.437169,-0.34716,0.546004,0.397977,-0.447317,-0.275477,0.184214,-0.257163,-0.96816,-0.298773,-0.492464,0.484154,-0.209458,-0.890017,-0.749012,-0.553354,0.0522491,-0.439541,-0.679505,-0.082691,-0.100773,0.0279151,0.136104,0.342225,0.193888,-0.779895,-0.330863,-0.1908,0.094308,0.359595,-0.11782,0.240159,0.507508,-0.0821785,0.0248592,0.337583,0.565172,-0.155271,0.494,-0.263683,0.141176,-0.18689,0.0960802,-0.644461,-0.141594,0.11779,-0.384783,0.429148,0.316445,0.468545,-0.140273,0.487127,-0.020539,0.079558,-0.107042,-0.606993,1.04285,-0.122403,0.364842,0.234694,0.0358492,0.984763,-0.905,-0.427434,-0.254683,0.124055,-0.167023,-0.562624,0.548636,-0.303477,0.670801,0.0904374,-0.0136103,-0.11072,-0.107442,0.1401,-0.345706,0.111244,0.256255,-0.304235,-0.276288,0.375895,-0.432001,0.917721,-0.714674,0.714038,0.208746,0.190097,0.618139,-0.0193437,-0.489022,-0.210524,0.324805,0.431829,-0.0981736,-0.171213,0.129481,-0.354465,-0.0461918,-0.254418,-0.474189,-0.196448,0.756891,-0.21703,-0.117154,-0.197486,-0.129761,-0.228946,-1.15932,0.0412341,-0.508583,-0.290312,-0.466948,0.151514,-0.470728,-0.228009,-0.815929,0.455581,0.55166,-0.00499563,0.485148,-0.179288,0.147941,-0.363245,-0.0909366,0.223437,-0.565816,0.186538,-0.503711,-0.164443,1.20424,0.0395563,0.0688397,0.0156558,-0.210585,0.0873009,-0.35729,-0.629318,0.38349,-0.192563,0.339072,0.708778,-0.103599,-0.221384,-0.765087,-0.668297,1.25097,0.0548982,0.450938,-0.484034,0.100927,-0.451929,-0.199193,0.234203,0.14755,-0.410212,0.0457681,-0.0555385,0.541449,-0.0874814,-0.491441,0.307632,-0.11675,0.301418,-0.0910179,0.40155,0.0957447,0.841638,-0.432823,1.02467,0.491579,-0.912693,-0.466981,-0.458771,-0.252986,0.521204,-0.0496668,0.460855,0.322565,-0.0697613,-0.519338,0.237575,-0.278592,0.176621,0.16505,-0.625252,0.00313238,-0.146696,0.427387,-0.0226415,-0.164562,-0.336435,0.0897124,-0.444739,-0.418926,-0.232976,-0.0952691,-0.397944,0.29347,0.203546,-0.00399079,0.272778,0.113557,-0.441418,-0.291367,0.207017,0.702761,-0.101154,-0.337831,-0.0687738,-0.485475,0.306262,-0.0701442,0.202695,-0.321951,-0.265402,0.160063,-0.14059,-0.654339,-0.279222,-0.0381774,0.391307,-0.237108,-0.0109564,0.168727,0.218426,0.410764,0.467361,-2.56985 +3383.08,0.937916,0.0848144,5,1.73451,0.94577,-0.957247,0.383721,1.24512,-0.0902086,-0.116732,-0.371518,0.232359,-0.340845,-0.507709,-0.00655645,-0.147028,-0.00775688,-0.238607,0.524167,-0.492352,-0.660522,-0.642842,-0.21804,-0.705549,-0.615496,-0.696509,0.282852,-0.269739,-0.202796,0.204327,0.170548,-0.432152,-0.325802,0.525387,-0.661566,0.231158,0.481577,0.0193531,0.0373146,0.160816,0.618237,0.315564,-0.611206,0.714323,0.100662,0.200291,-0.147747,0.171746,0.215136,-0.685588,-0.0602359,0.0950821,0.429024,0.0703168,0.514383,-0.173471,-0.644548,0.37579,-0.213543,-0.54033,-1.05146,0.133066,-0.589693,0.332798,0.847564,-0.595929,-1.10592,-0.229045,0.459705,0.32511,-0.135477,0.0964346,-0.135261,-0.34162,0.233057,0.212451,-0.436753,0.661538,0.419083,0.995129,-0.107509,-0.471043,0.440714,0.478026,-0.221304,-0.0698309,-0.580041,-0.585392,-0.119831,0.404317,-0.0833268,0.260174,-0.158919,-0.852045,0.0738182,0.0191644,0.328035,0.0551059,-0.46899,-0.479124,0.406908,0.170601,0.262401,0.252115,-0.219757,-0.788082,-0.586429,-0.449,-1.00782,0.484989,-0.0607234,0.118977,0.293086,0.540487,-0.795779,0.13029,0.319876,0.320121,-0.413682,-0.433364,0.225595,-0.0103842,-0.0514067,-1.00984,0.610605,-0.509164,-0.655004,0.0725288,-0.038515,0.163708,-0.268523,0.895276,-0.469687,0.177381,-0.12567,-0.42325,0.656371,-0.369449,0.6142,0.309724,-0.316177,0.832663,-0.752883,-0.431364,-0.382386,-0.140159,-0.126634,-0.863848,0.592971,-0.14035,0.794851,0.167285,-0.28341,-0.392573,0.249189,0.0027729,-0.587177,0.484028,0.721982,0.0474655,0.907397,-0.0598538,-0.751267,0.58317,-0.241648,0.628449,0.152924,0.0417659,-0.337151,-0.284815,-0.479167,-0.460257,0.367771,0.10758,0.0140024,0.133374,-0.505771,0.455552,0.0661167,-0.421053,-0.354812,-0.518715,0.577696,-0.395116,-0.654899,-0.250102,-0.389981,0.0916153,-0.982201,-0.225684,-0.551034,0.179304,-1.29668,-0.178583,0.128604,0.325405,-0.588469,0.479857,-0.0798727,-0.119715,0.0303698,-0.914117,0.177309,-0.355449,-0.605061,0.293304,-0.497945,0.305622,-0.475002,-0.326316,1.02403,0.179576,0.395405,-0.564788,-0.528909,-0.571254,-0.873806,0.108298,0.530311,-0.0500946,-0.00387225,0.417941,-0.440985,-0.003635,-0.649179,-0.215098,0.756868,-0.201461,0.373885,-0.603635,-0.559067,-0.020602,0.0777816,-0.635651,0.0789954,0.198349,-0.917537,0.384123,0.558998,-0.446128,0.0568061,0.290272,-0.33074,0.0802615,-0.0830289,0.116227,0.53158,0.363962,0.104237,0.697187,0.217751,-0.532041,-0.685011,0.149452,-0.305179,0.749089,0.244278,0.654362,0.268068,-0.0950091,-0.302382,0.0804749,-0.111158,0.508343,0.662453,-0.334876,0.315035,-0.750531,0.589672,-0.139713,-0.106821,0.495556,0.516377,-0.275759,-0.511147,-0.647795,0.194139,-0.249212,0.556345,-0.0697667,0.170982,0.336746,-0.448809,-0.692839,-0.810891,0.363828,0.689776,-0.315533,-0.209374,-0.159187,-0.528529,0.272104,-0.396161,0.0925111,-0.187807,0.340159,0.864465,0.243171,-0.36575,-0.00978229,-0.331205,-0.270467,-0.806184,-0.208779,0.247605,0.17389,0.4976,0.417001,-3.90951 +3373.62,0.825345,0.0848144,4,1.67302,0.960084,-0.679828,0.309069,1.28,-0.251332,-0.456632,-0.187048,0.378997,0.674125,-0.0234985,-0.165875,-0.158817,0.0922047,-0.299536,0.601,-0.281437,-0.660301,0.106276,0.0101893,-0.663837,-0.774146,-0.251097,-0.207374,-0.746324,0.212218,0.252736,0.366557,-0.226533,-0.0272491,0.69424,-0.61362,0.487092,0.408978,-0.157004,-0.0603335,-0.341393,-0.130113,0.0698715,-0.287926,0.661349,0.494831,-0.117178,-0.303435,0.363565,0.271677,-0.260072,-0.501423,0.0506602,-0.0162177,-0.0178167,0.390113,0.50228,-0.555313,0.641597,-1.02431,-0.404631,-1.15356,0.269308,-0.20384,-0.244882,1.16621,-0.689135,-0.748829,-0.662526,0.013291,0.239648,-0.381449,-0.553712,-0.0178937,-0.607456,-0.0723313,0.438246,-0.215027,0.370935,0.822706,0.836979,-0.0691179,-0.63003,0.758487,0.370872,-0.481985,0.0191441,-0.214339,-0.555146,-0.0428444,0.200584,-0.300244,0.559417,-0.336866,-0.25476,-0.0700209,-0.11197,0.366276,-0.317825,-0.807819,0.271968,0.131478,0.233748,-0.00655932,0.156329,-0.651651,-0.982,-0.659318,-0.18899,-0.668849,0.0424146,-0.313923,0.239505,0.148801,0.0519193,-0.0902058,0.330358,0.303612,0.534147,0.304825,-0.0821419,0.471515,-0.533118,-0.407464,-1.26827,0.517735,-0.730998,-0.29916,0.308742,0.394427,-0.0829903,0.0797781,0.7811,-0.446779,-0.138572,-0.0944595,-0.263999,0.756059,-0.286851,0.833156,0.664766,-0.0546268,0.731243,-0.201581,-0.359424,0.320013,-0.11157,-0.566054,-1.25252,0.692298,0.0125421,0.475845,-0.47227,0.491833,-0.558008,-0.0911182,0.108171,-0.718036,0.217484,0.94155,0.455191,0.25834,0.200606,-0.0203322,0.210523,-0.0699925,0.0679598,-0.0235153,-0.0965677,0.545609,0.125239,-0.0491605,-1.11568,-0.366142,-0.34458,0.641216,-0.397874,-0.115488,-0.133076,-0.00145257,-0.18829,-0.280697,0.0864605,0.594983,0.0132337,-0.611741,0.447426,-0.0761308,-0.0395583,-0.574687,-0.594962,-0.609868,0.0304005,-0.858634,-0.23155,-0.201109,0.445957,-0.546816,0.722335,0.268436,-0.534624,0.168096,-0.464052,-0.126078,0.0929908,-0.315682,0.764042,0.151189,0.323305,0.301794,-0.385454,1.03375,0.0879664,0.187654,-0.156384,-0.503317,-0.172042,0.0346424,0.0810042,0.794448,-0.607876,0.405576,-0.310179,-0.0990141,-0.315145,-1.20631,0.280774,0.641836,-0.821971,0.400252,-0.766264,-0.0254806,0.217416,0.165738,-0.3055,-0.0810548,-0.593247,0.340404,0.325562,0.893449,-0.43442,0.424713,0.190117,-0.220135,0.291391,0.200351,0.518342,-0.482379,0.354017,0.287545,0.831991,0.411923,0.265669,-0.218797,0.276221,-0.435286,0.617621,0.522559,0.0778534,-0.208653,0.107645,-0.526681,0.146271,-0.391055,0.341873,0.379267,-0.134277,0.561625,0.118723,0.0778853,0.173889,0.0659239,-0.787906,-0.286892,-0.203016,-0.828378,-0.526292,0.625926,0.780166,0.849793,0.401408,0.448395,0.792434,-0.189403,-0.0716512,-0.00360394,0.211248,0.00835446,0.157033,0.544796,-0.459943,0.353382,-0.223673,-0.107784,0.00205891,0.205784,0.1898,-0.210456,0.256146,-0.724624,-0.194817,-0.514488,-0.301353,-0.629035,-0.220646,0.190851,0.230517,0.436865,0.480122,-4.14677 +3384.59,0.788778,0.0848144,5,1.65928,0.97391,-0.557027,0.236552,1.36898,-0.169945,-0.426795,-0.0348799,0.329066,0.679462,-0.0964641,-0.279304,-0.0992539,0.0630975,-0.126178,0.514736,-0.216151,-0.744925,0.0700875,0.18066,-0.703139,-0.808155,-0.232704,-0.0591712,-0.562243,0.209199,0.471065,0.42479,-0.571149,0.0535978,0.600513,-0.502983,0.60948,0.430198,-0.170893,0.0465502,-0.371077,-0.186587,-0.118816,-0.415289,0.631327,0.352976,-0.138697,-0.227774,0.361466,0.332434,-0.410021,-0.46762,0.0578374,0.119474,-0.0819546,0.365086,0.374506,-0.646956,0.78215,-0.927752,-0.417776,-1.12973,0.171816,-0.329118,-0.199244,1.23111,-0.684632,-0.843454,-0.726634,0.0878007,0.00299619,-0.325849,-0.601332,-0.106316,-0.632182,0.238761,0.39802,-0.312177,0.481244,0.803775,0.684855,-0.292859,-0.785406,0.718169,0.329816,-0.419231,0.031554,-0.141524,-0.382071,0.163144,0.159004,-0.0457603,0.398613,-0.400898,-0.249599,-0.130891,-0.144541,0.39936,-0.387496,-0.858104,0.252412,0.224787,0.191015,-0.0890626,0.0856469,-0.771465,-0.972497,-0.721688,0.023753,-0.727897,0.143937,-0.27183,0.170131,0.241873,0.0374315,-0.478251,0.504288,0.25315,0.532735,0.10626,-0.166476,0.504819,-0.655205,-0.407829,-1.12405,0.676555,-0.843656,-0.216088,0.407147,0.46048,0.12149,0.230864,0.600194,-0.488549,-0.158181,-0.104802,-0.218867,0.636807,-0.355277,1.02141,0.492815,-0.194975,0.770827,-0.251255,-0.47959,0.30159,-0.0255956,-0.656307,-1.24246,0.567336,-0.0715438,0.38679,-0.453666,0.41168,-0.501234,-0.118483,0.300449,-0.721794,0.176366,0.704627,0.565392,0.337548,-0.018928,0.167186,0.363296,-0.439474,0.103202,0.085502,-0.0365244,0.365497,0.00124383,0.017389,-1.1727,-0.485237,-0.236346,0.701243,-0.436668,-0.0626893,-0.100252,0.0836021,-0.199508,-0.256082,0.258025,0.473024,0.0710893,-0.708536,0.436392,-0.254632,0.164566,-0.777767,-0.537446,-0.594741,0.0488595,-0.987066,-0.258929,-0.0350309,0.253136,-0.689736,0.773201,0.252797,-0.427543,0.109363,-0.188362,-0.18985,0.143974,-0.414925,0.775056,0.310477,0.187385,0.118393,-0.256432,1.10033,0.182565,0.0215697,-0.172393,-0.544083,-0.0583735,-0.00696487,-0.041592,0.770723,-0.464047,0.358426,-0.245222,-0.0357911,-0.294321,-1.00169,0.296028,0.724574,-0.819406,0.383109,-0.636369,-0.0305814,-0.0933344,-0.0266543,-0.645705,-0.00521912,-0.177847,0.296854,0.363837,0.945409,-0.223571,0.466605,0.067693,-0.397773,0.117736,0.260461,0.471663,-0.402968,0.413878,0.143314,0.895744,0.717925,0.255304,-0.167554,0.177668,-0.33383,0.7099,0.471341,0.225119,-0.250713,0.272255,-0.242072,0.217317,-0.247159,0.0781749,0.434,-0.0598308,0.348431,0.181738,0.104689,0.260974,-0.291103,-0.639574,-0.227489,-0.112173,-0.947006,-0.717251,0.524212,0.621802,0.568942,0.576901,0.413495,0.783031,-0.245365,0.108887,-0.115027,0.16394,-0.113821,0.114445,0.609586,-0.612302,0.322419,-0.280595,0.0358655,-0.152596,0.387831,0.126954,-0.0305394,0.121247,-0.65337,-0.314139,-0.587139,-0.273215,-0.405152,-0.145907,0.206218,0.244371,0.454113,0.494339,-4.49643 +3409.8,0.776782,0.0848144,5,1.50707,0.989841,-0.509261,0.13965,0.18942,-0.0545569,0.142324,0.284116,0.327572,0.223785,0.25122,-0.51422,0.246231,0.42694,-0.0791229,0.851731,-0.0883488,-0.0711522,-0.0680466,0.0657999,-0.474873,-1.00776,-1.02405,0.0493256,0.093396,-0.250787,-0.0543098,0.58925,0.088809,0.141892,0.904511,-0.241168,0.119126,0.400864,-0.307209,-0.201272,-0.360922,0.110956,0.841361,-0.704625,0.725138,0.660095,0.161627,-0.298633,-0.0511995,-0.742112,-0.900682,-0.270036,0.642775,-0.283463,0.143787,0.204709,-0.129652,-0.624498,0.940359,-0.149126,-0.141624,-1.02357,0.299094,-0.427267,0.319234,0.892358,-0.522318,-1.18938,0.582204,0.344785,-0.0721565,0.414597,0.365724,-0.722271,0.369371,0.206896,0.677806,0.22237,0.755802,0.613913,0.742169,0.109546,-0.300449,0.0190278,0.949863,-0.666807,0.353642,-0.0801137,-0.00631469,-0.470254,-0.305511,-0.242631,-0.302177,-0.340593,-0.144598,0.00744392,-0.244536,-0.436024,0.201115,-0.493477,0.00386315,-0.405958,0.0915772,0.842025,-0.533957,0.351396,-0.712909,-0.13168,0.145982,-0.700661,0.620161,-0.372826,0.473298,0.415613,0.0252605,-0.0964817,0.110074,-0.00387819,0.0156897,0.299122,-0.318975,0.132149,0.521245,0.252664,-0.419345,-0.66453,0.571128,-0.0737645,-0.0913437,0.184759,0.329386,-0.385877,-0.199741,0.269597,-0.173791,-0.196794,0.000280268,0.412262,0.45923,-0.322757,-0.674222,-0.618983,0.687373,-0.775435,-0.0136132,-0.334317,-0.0908813,-0.192378,0.318596,-0.0957659,-0.169755,0.21293,0.119313,-0.531262,0.137492,-0.0498914,0.0539339,0.303569,0.397324,0.680632,-0.12807,0.0805115,0.459602,-0.642728,0.0746698,-0.0438765,0.844955,-0.334193,-0.0090489,-0.0174022,-0.301735,-0.0700575,0.399506,0.00104385,0.332967,-0.347365,-0.203963,-0.328901,-0.0340987,-0.0027424,0.0741683,-0.0100696,-0.172221,0.630792,-0.178371,0.336032,-0.178245,-0.231952,-0.375618,0.479363,-0.447075,-0.095471,0.652029,-0.0068769,0.0202061,-0.0475946,-0.127772,0.106678,0.363141,0.151512,0.109279,0.0768108,-0.627523,0.0687524,-0.191942,-0.204624,-0.320918,-0.461255,-0.821844,-0.479108,-0.534719,0.725178,-0.111462,0.128775,-0.225831,-0.161765,-0.0907262,0.426849,0.336493,-0.259489,0.325095,0.182143,0.318972,0.00724462,-0.156741,-0.2536,-0.513206,0.189391,-0.306766,0.239927,0.435446,-0.825831,-0.162176,0.201994,0.477684,-0.262044,-0.0227901,-0.356057,-1.04735,0.620505,0.313621,-0.441027,0.66069,-0.322474,-0.837873,-0.399895,-0.174219,-0.0152198,0.413971,-0.584874,-0.0380868,-0.295293,-0.662177,-0.629171,-0.307223,-0.704085,0.58714,0.101401,-0.321804,0.428347,-0.143634,0.624125,0.373178,0.380943,0.0638065,0.275095,0.415184,0.36005,0.405556,-0.00905163,-0.27737,-0.404023,0.0620697,-0.0542364,-0.0435456,0.131133,0.00139807,0.077946,-0.499062,0.18788,-0.0224326,-1.11791,-0.0304204,-0.54634,-0.693886,-0.0259566,-0.737069,0.173034,-0.141935,0.248815,-0.214207,0.0999004,0.593319,-0.300206,0.185558,0.234566,0.0029035,0.568189,0.218788,-0.344326,-0.0592121,0.0591802,-0.0188445,0.223053,-0.21897,0.155135,0.231533,0.393872,0.481179,-0.722984 +3421.47,0.841679,0.0848144,4,1.53684,0.904761,-0.536838,0.188773,0.263653,0.061651,-0.221107,0.192586,0.429143,0.244103,0.329885,-0.27131,0.0423707,0.592207,0.0683382,0.80742,0.192,-0.121761,0.0832757,0.310684,-0.223824,-1.05527,-0.960455,0.430796,-0.486476,0.0549481,0.334888,0.430092,-0.163665,0.494045,0.91549,0.294333,0.0943065,0.62005,-0.0239304,-0.116233,-0.49441,-0.000286897,0.0174033,-0.63453,0.550607,1.03128,0.0465038,-0.062605,-0.0972766,-0.110053,-0.0476936,-0.000357165,0.465418,-0.281995,0.202743,0.186817,0.0665132,-0.332422,0.974083,-0.0371279,-0.72532,-0.210954,0.265323,-0.377996,-0.358752,0.656401,-0.731016,-0.694962,0.0363224,0.753035,0.469175,0.127443,0.230577,-0.446736,0.189558,0.0717652,0.427105,-0.279671,0.620259,0.397795,-0.0747699,0.27039,-0.146074,0.490937,0.691561,-0.503477,0.0843687,-0.127888,0.00620676,-0.146766,0.11433,-0.295541,0.0541623,-0.310105,-0.226231,-0.143364,-0.297629,-0.037865,0.104558,-0.260929,0.160514,0.149564,0.463637,0.181873,-0.0387991,-0.718621,-1.17269,-0.526834,0.686589,0.169581,-0.19514,-0.273986,0.483944,0.2956,-0.133761,-0.023158,0.116137,0.349453,0.267258,0.299424,0.232074,0.0472507,0.0384165,0.0803211,-0.690744,0.0319044,-0.423823,-0.227954,-0.0259086,-0.0146159,0.200529,0.517182,0.0306959,-0.23144,-0.0601566,-0.110998,0.00706204,0.47424,-0.242227,0.205228,0.176666,0.106784,0.407744,-0.0418398,-0.235303,0.0041347,0.358107,0.228714,0.175243,-0.0740893,-0.0637596,0.16789,-0.474097,-0.264087,0.0709039,-0.2885,0.0823054,-0.0771925,-0.19709,0.582684,0.144167,0.0758628,0.0215837,-0.326335,0.460317,-0.57969,0.351209,0.775824,0.112974,0.510292,-0.0607715,0.490831,-0.613957,-0.0214481,0.279088,0.227442,-0.295299,-0.408132,0.745168,0.21892,-0.160562,-0.175075,-0.00748099,0.680656,-0.259322,-0.109114,0.360615,0.767455,-0.424388,-0.845081,0.348242,-0.740152,0.262727,-0.0110024,-0.0361691,-0.0337168,0.147222,-0.430294,0.157814,0.30093,0.170373,-0.1052,0.0781002,0.356886,0.0605542,0.101535,0.371852,-0.0463185,0.465089,-0.109108,-0.130204,1.03762,-0.0495213,-0.0136309,0.2566,-0.142091,0.112391,0.0840432,-0.0419042,0.0776196,0.383361,0.316993,0.112656,-1.01,-0.361846,-0.288934,0.00394905,0.0992024,-0.63538,0.18901,-0.663554,0.299856,0.161601,-0.0765843,-0.0860256,0.0245654,-0.414161,-0.173787,-0.226053,0.451907,0.294023,0.107073,0.642944,-0.19952,-0.00697102,0.277563,0.238976,-0.0532889,0.0277881,0.120139,0.0854891,0.109257,-0.104848,-0.547413,0.259249,-1.07661,0.304748,-0.181511,-0.685016,-0.728317,-0.317883,-0.124165,0.128563,-0.276453,0.47973,0.26094,-0.401079,0.0276172,-0.260539,-0.44832,-0.0857716,-0.233534,-0.247858,-0.616648,-0.201895,-0.328176,-0.710585,0.464373,-0.0530394,0.0385418,0.302569,-0.148638,0.438214,-0.363721,0.219776,-0.395027,0.142803,0.555173,-0.268949,0.245874,0.0274571,-0.3966,-0.0648797,0.0178707,-0.680215,-0.097374,0.305772,-0.581502,0.171898,-0.254877,0.198432,0.0447989,0.192687,0.130208,-0.124425,0.125264,0.298427,0.353926,0.546285,-0.85038 +3427.33,0.995327,0.0848144,4,1.54383,0.895388,-0.504626,0.2074,0.611217,0.0326348,-0.0875602,0.0424472,0.698368,0.39022,0.400766,-0.283432,-0.201001,0.710659,-0.0766275,1.08425,0.15322,0.268465,-0.24006,-0.0492118,-0.625365,-0.739842,-0.604221,0.250223,-0.232169,0.18797,-0.422252,0.0466096,-0.00236193,0.153858,0.711697,-0.958136,-0.797492,0.57469,-0.373463,-0.562211,-0.180338,0.418912,0.437594,-0.634495,0.988195,0.482182,-0.294558,-0.134643,0.353877,-0.303026,-0.763922,-0.18585,0.292104,-0.735233,-0.227084,0.57597,0.364327,-0.057845,1.02809,-0.313463,-0.273529,-0.95838,0.125527,-0.217268,0.00916427,1.01716,-0.652909,-0.868895,-0.148914,0.588996,0.44272,0.0952163,0.282391,-0.670116,0.141644,0.306294,0.503436,-0.0350197,0.336513,0.457448,0.749863,0.464192,-0.0747334,0.776244,0.260971,-0.863965,0.0104009,-0.0770646,0.111899,0.194205,-0.396319,0.0380269,0.174275,0.023943,-0.0625032,0.627211,-0.261003,0.0857155,0.252822,0.381384,-0.0057795,-0.313545,0.404494,0.315017,-0.170194,-0.0477512,-0.284512,-0.7429,-0.140171,-0.0180531,0.338002,0.152391,0.80215,0.750434,-0.225923,-0.467137,-0.131655,0.119576,-0.0952977,0.425858,-0.108104,0.0906494,-0.239883,0.365705,-0.683008,0.162955,0.0119094,-0.408849,-0.203342,0.496593,0.702318,0.0101608,-0.0297425,-0.17483,-0.036158,-0.710605,0.140835,0.43944,-0.140727,-0.0737733,0.0772877,-0.0461663,0.642128,-0.0782902,-0.411866,0.0603344,0.290771,-0.486715,0.0959239,0.270716,-0.211643,0.118133,0.16272,-0.225203,0.542715,0.0487176,-0.0141815,0.443937,0.114838,0.812979,0.0404745,0.180031,0.0670354,-0.549284,0.479698,-0.548637,0.242946,0.178123,-0.524851,-0.396454,-0.100185,0.442633,-0.00667682,-0.00388799,-0.33252,-0.421626,-0.131888,-0.607007,0.334666,-0.358638,0.0589478,-0.231159,-0.0189999,0.683873,0.0496897,-0.623647,0.375218,0.68973,0.112235,0.0132104,-0.459901,-0.360543,0.0314216,-0.0417762,-0.175426,0.231968,0.357198,-0.0979685,0.188644,-0.244275,0.0411329,0.299739,-0.448673,0.216014,-0.15498,0.432927,-0.0426025,-0.0217663,0.408578,0.00379216,-0.369586,1.08486,-0.398599,0.225938,-0.301163,0.0448072,0.0152072,0.436952,-0.304552,0.369861,0.270547,0.231595,-0.124275,-0.306081,-0.511069,-0.205315,-0.378223,-0.387962,-0.324901,0.629697,-0.070148,-0.11204,-0.059836,0.118447,0.222194,-0.13902,0.169625,-0.0107942,-0.160886,0.796419,0.101976,-0.330127,0.200675,-0.413994,-0.588746,-0.0122999,0.182367,0.210879,0.245772,-0.23377,0.0915214,0.36807,-0.0297051,-0.695386,-0.0225118,-0.627371,0.481463,-0.376704,-0.104101,0.096819,-0.241262,0.0741456,0.0609794,0.299082,0.401452,-0.210821,-0.106831,-0.167584,0.113165,-0.196928,0.0265589,0.252323,-0.394315,-0.39925,-0.142052,0.0152288,0.368677,-0.0313538,-0.280501,0.290453,0.220224,-0.240244,0.207931,-0.31357,-0.586357,0.431107,0.036526,-0.0182978,-0.159022,-0.0279875,0.0147786,0.207786,-0.171707,-0.463314,-0.0278548,-0.511372,0.273694,-0.297023,0.23672,-0.463018,-0.036521,-0.180877,0.0148537,0.713233,-0.0211985,0.112463,0.229195,0.335355,0.478743,-2.008 +3420.01,0.976122,0.0848144,4,1.6251,0.875993,-0.592558,0.250392,0.406535,0.0666242,-0.250413,-0.00651424,0.589851,0.330125,0.210321,-0.277999,-0.477459,0.594498,-0.00817641,1.21597,0.154672,0.209445,-0.26809,0.0798569,-0.742035,-0.773663,-0.623586,0.280498,-0.410534,0.0579418,-0.230801,0.0473011,-0.180896,0.115366,0.742738,-0.656606,-0.956451,0.651135,-0.147818,-0.428658,-0.428617,0.480668,0.470639,-0.558176,0.959622,0.552382,-0.221162,-0.129495,0.28491,-0.234425,-0.972164,-0.170252,0.0435995,-0.773054,-0.212266,0.451073,0.409733,0.00035793,0.913676,-0.240351,-0.377059,-0.81583,0.262253,-0.301536,0.165274,1.14728,-0.529991,-1.02261,-0.129401,0.638061,0.406468,0.180307,0.334102,-0.788316,0.018248,0.196673,0.339612,-0.100133,0.391835,0.51269,0.494285,0.613581,-0.165132,0.658766,0.141314,-0.854802,0.0216117,-0.0188362,0.201391,0.379708,-0.328623,0.139751,0.239497,0.0481293,-0.159178,0.666468,-0.192303,0.0507484,0.288556,0.490718,-0.0484602,-0.157741,-0.0107243,0.268279,-0.0515094,-0.0927271,-0.343611,-0.653851,0.00180112,-0.0992029,0.276926,0.170043,0.781162,0.533636,-0.135255,-0.362191,-0.380531,0.0989793,0.0419575,0.174476,-0.0191504,0.0800356,-0.397827,0.248485,-0.650025,0.0646164,-0.137716,-0.261394,-0.214473,0.478565,0.486648,0.0823488,0.0134863,-0.213551,-0.195041,-0.660939,0.118658,0.423168,-0.172859,-0.200749,0.240125,-0.154749,0.7223,-0.0503099,-0.460393,0.10031,0.333104,-0.680682,0.177573,0.242191,0.222956,0.208537,0.182696,-0.170528,0.423203,0.0500681,-0.0549588,0.475492,-0.00616615,0.600382,-0.00753772,0.174256,0.0806472,-0.835025,0.394137,-0.673862,0.0679416,-0.155067,-0.538948,-0.416247,-0.152881,0.455302,-0.100989,0.0478101,-0.349338,-0.287661,-0.303303,-0.425449,0.167164,-0.234181,0.151511,-0.179349,-0.0915795,0.54743,0.0101413,-0.729584,0.386481,0.716869,0.0548834,0.036979,-0.353777,-0.35429,0.178028,0.0318932,-0.3253,0.39002,0.232921,-0.0546442,0.112559,-0.040594,0.0418621,0.237359,-0.560621,0.391148,-0.1386,0.452578,0.19865,-0.177127,0.317934,-0.0434582,-0.377525,1.03349,-0.33424,0.280011,-0.176427,-0.14502,0.00624935,0.343231,-0.29785,0.426699,0.0815738,0.152596,-0.193539,-0.173932,-0.632839,-0.189628,-0.534127,-0.20138,-0.0396933,0.580185,-0.0180401,-0.00869459,-0.0325627,0.0530828,0.26978,-0.277369,0.281257,-0.0829128,-0.135692,0.620712,0.098252,-0.16604,0.234431,-0.489699,-0.639617,0.0307087,0.152165,0.35074,0.207372,0.000253437,0.166803,0.580069,-0.00459152,-0.733238,-0.119914,-0.835096,0.339761,-0.236307,-0.170712,0.0486509,-0.183611,0.143592,-0.0201142,0.191328,0.418506,-0.412513,-0.251931,-0.3964,0.296664,-0.0181296,-0.0117503,0.0299081,-0.279174,-0.512665,-0.157672,0.0337407,0.58026,-0.168225,-0.329095,0.329842,0.251732,-0.116729,0.283792,-0.390131,-0.809888,0.157963,-0.0136016,0.0514187,-0.136611,0.0493686,0.109576,0.187697,-0.06363,-0.449752,-0.114346,-0.624681,0.229555,-0.265624,0.242299,-0.744709,0.0853832,-0.217166,-0.0368565,0.883391,0.0526585,0.104841,0.226096,0.323791,0.475495,-1.21601 +3429.99,0.783748,0.0848144,5,1.63681,0.889855,-0.655303,0.25435,0.541062,0.0449749,-0.278402,-0.0445708,0.482151,0.181256,0.304779,-0.279013,-0.532615,0.582981,0.003089,1.21272,0.159014,0.0764509,-0.168861,0.0773115,-0.555962,-0.906345,-0.714853,0.201085,-0.38616,0.0743831,-0.0139328,0.17717,-0.226372,-0.0341221,0.700878,-0.54655,-0.87564,0.56718,-0.148242,-0.48011,-0.511583,0.43093,0.459859,-0.498894,0.850119,0.547039,-0.0860748,0.0302024,0.382824,-0.137328,-0.907774,-0.164424,0.0411905,-0.779455,-0.202086,0.111061,0.412924,-0.0369587,0.888906,-0.200525,-0.399598,-0.85317,0.217559,-0.276297,0.227671,1.05776,-0.544301,-0.968579,-0.129521,0.753156,0.514453,0.0360675,0.247739,-0.774208,-0.0821148,0.326968,0.25681,-0.170741,0.433994,0.530793,0.503557,0.387025,-0.145134,0.713587,0.0610805,-0.764734,-0.0568377,-0.058572,0.177712,0.401185,-0.362646,0.196248,0.166898,-0.0238944,-0.271163,0.600728,-0.216075,0.0433449,0.354216,0.424181,0.0515991,-0.189481,0.101906,0.259275,-0.152278,0.0987832,-0.322698,-0.681789,-0.0715478,-0.140753,0.162257,0.0796704,0.735078,0.497828,0.0371147,-0.30503,-0.259604,0.160893,0.119056,0.277284,0.205599,0.135332,-0.273084,0.26908,-0.916841,-0.101529,-0.172284,-0.148416,-0.176837,0.453497,0.235241,0.214664,0.0938187,-0.303551,-0.112843,-0.693016,0.269146,0.334485,-0.0863751,-0.276338,0.422757,-0.0524975,0.718415,-0.071994,-0.552861,0.117741,0.526738,-0.632678,0.103531,0.346671,0.280312,0.384044,0.0432969,-0.162223,0.475536,0.16239,-0.124661,0.554773,0.13426,0.459095,0.131654,-0.0301965,0.094575,-0.706775,0.28833,-0.495249,0.041948,-0.278754,-0.671136,-0.714687,-0.127191,0.60594,-0.0893406,-0.0832479,-0.316352,0.0105595,-0.21437,-0.471502,0.195709,-0.183433,0.205714,-0.221084,-0.126827,0.431335,-0.107984,-0.867324,0.271711,0.598689,0.138081,0.0393511,-0.127711,-0.246099,0.279392,0.0773969,-0.419376,0.259105,0.251755,-0.14459,0.166465,-0.187225,-0.0330611,0.303422,-0.60759,0.569493,-0.242708,0.373668,0.119946,-0.473503,0.336884,-0.0956149,-0.256289,0.941419,-0.416227,0.316441,-0.268084,-0.325308,0.108525,0.290146,-0.385727,0.244798,0.214728,0.150431,-0.202652,-0.311067,-0.547564,-0.195133,-0.43849,-0.291537,-0.130978,0.731087,0.0439273,0.143225,-0.0720782,0.0835286,-0.0355725,-0.244738,0.351853,-0.119031,-0.0734441,0.613407,0.144762,-0.124964,0.169372,-0.460803,-0.621902,0.180665,0.0816641,0.267683,0.178374,0.018108,0.0722708,0.563212,0.142523,-0.768618,-0.0215551,-0.631065,0.39521,-0.022646,0.0100923,0.0465185,-0.175496,0.248115,0.131248,0.17307,0.457106,-0.31624,-0.227437,-0.4329,0.180165,-0.110759,-0.0793681,0.0432405,-0.131476,-0.598735,-0.105067,0.0266867,0.36861,-0.0707703,-0.219564,0.174995,0.229953,-0.119717,0.140021,-0.402064,-0.56549,-0.0796465,-0.00926629,0.13178,-0.0536494,0.165007,0.266341,0.1179,-0.20153,-0.347873,-0.234563,-0.586403,0.284049,-0.267425,0.328036,-0.479517,0.00107834,-0.157029,0.101419,0.697415,0.00472723,0.127149,0.214303,0.35658,0.462929,-1.64078 +3432.28,0.910025,0.0848144,5,1.6489,1.06794,-0.606472,0.104283,0.522472,-0.0298249,-0.0635646,-0.0731915,0.107839,0.291494,-0.0884013,-0.485056,0.0718655,0.393962,-0.650869,0.9306,-0.085962,-0.437933,-0.296167,-0.183768,-0.665416,-0.855888,-0.566374,-0.204964,-0.456308,-0.232657,0.0138271,0.457349,-0.373902,-0.123833,0.597297,-0.232802,0.547135,0.244213,-0.272297,-0.179638,-0.797464,0.205692,0.144283,-0.182166,0.693911,0.374492,0.513301,-0.816962,0.0819092,-0.0998833,-0.4985,0.255016,0.626197,-0.125482,0.139757,0.614191,0.0233824,-0.763331,0.827256,-0.200207,-0.251438,-0.629077,0.458743,-0.557596,-0.459974,0.811805,-0.140112,-1.22523,-0.12196,0.277695,-0.0990401,-0.17634,-0.0463959,-0.123619,0.0707338,0.277219,0.185932,0.170683,-0.00971594,0.397876,0.209874,0.0360249,-0.607068,0.264736,0.674369,-0.228827,0.471845,-0.783451,0.191483,-0.379843,0.680738,0.00159024,-0.0459435,-0.38239,0.262213,0.484493,-0.199862,0.0521306,-0.00507111,0.436109,-0.241768,-0.0148403,0.0131555,0.697187,0.0410412,-0.130514,-0.209497,-0.494283,-0.340908,-0.314905,0.0218734,-0.292697,0.130754,0.498483,-0.299116,-0.280506,0.142593,0.190939,0.364386,0.387808,-0.145552,-0.133688,0.488385,0.192643,-1.0584,-0.512557,-0.0290028,-0.0250771,0.372826,0.184748,0.47124,-0.193306,0.161295,-0.782903,0.293929,-0.0455978,-0.144904,-0.0851445,-0.103636,0.528148,-0.115166,-0.00860087,0.201382,-0.383938,-0.252323,-0.0306931,0.0152367,-0.45245,-0.409153,-0.360093,-0.128192,0.797717,-0.229718,0.535432,-0.500311,-0.0863357,0.589448,-0.0816799,0.211551,0.274662,-0.0467056,0.142539,0.240639,0.462055,0.170492,0.277791,0.623049,0.427363,0.592402,0.0904227,-0.0185871,0.622134,-0.340328,-0.0414807,0.326048,0.0985374,-0.194867,0.00503866,-0.342618,0.0966013,-0.598075,0.199969,1.03399,0.745487,-0.273792,0.242345,0.170651,0.0863948,-0.0320415,-0.44894,0.083368,-0.311863,0.589261,0.00382551,-0.196057,-0.0766309,-0.542665,-0.468809,-0.134456,0.289574,0.113086,-0.312994,-0.0911953,-0.0734498,0.0651542,-0.216974,0.414896,-0.0894521,-0.196085,-0.016812,-0.508969,0.953228,0.319427,0.0129507,-0.170244,0.417246,0.3306,0.313135,-0.0882186,0.90447,-0.763656,0.368805,0.741767,-0.35846,0.0812349,-0.742481,-0.0668854,1.00757,0.0389455,-0.0128579,-0.327344,-0.196785,0.173597,-0.275612,-1.09681,0.0170463,-0.563197,-0.14615,-0.122157,0.641389,0.100756,0.0364005,0.711877,-0.235071,0.521364,0.207436,-0.107267,0.0987068,0.867366,-0.162904,0.221493,0.108553,0.0653043,-0.678392,-0.493237,-0.280017,0.534594,-0.0327627,0.100921,-0.119186,-0.0903022,-0.284599,-0.619633,-0.139248,0.26836,0.433325,0.49653,0.0391555,-0.193222,0.0400078,-0.406339,-0.382675,0.121961,0.00674156,-0.249417,-0.258944,0.025148,0.171483,-0.214376,-0.205601,0.0173335,-0.406673,0.237462,0.0348237,0.00645386,-0.0296499,-0.234499,0.03854,-0.283131,0.907582,-0.100163,0.52075,0.250511,0.428102,-0.31266,-0.0106972,0.246867,0.276554,0.127705,-0.338797,-0.0452299,-0.201153,-0.0864188,-0.454413,-0.0555853,0.138424,0.24873,0.372054,0.498729,-1.74644 +3407.37,0.710837,0.0848144,4,1.55474,1.05094,-0.636548,0.236756,0.400424,0.026845,0.0748962,-0.546603,0.0949052,-0.0341522,-0.688866,-0.196946,-0.434295,0.502049,0.0232166,1.1322,0.210907,0.155163,-0.174547,0.0261498,-0.232553,-0.779618,-0.836502,0.0337049,-0.193097,0.00020253,0.31255,0.291634,0.240238,0.164973,0.8042,-0.229118,-0.346012,0.541206,-0.764344,0.0207752,-0.90322,0.63033,-0.229541,0.087544,0.933275,-0.0777754,0.294202,-0.441519,-0.269871,-0.429902,-1.26503,-0.313916,0.25732,-0.502023,-0.428907,-0.466613,0.563422,-0.197174,0.67477,0.00965755,-0.358609,-0.765185,0.216098,-0.286917,0.0206892,1.14209,-0.516312,-0.836102,0.163615,-0.250495,-0.0446504,0.570665,0.658804,-0.0722515,-0.330236,0.41944,0.399298,0.443847,0.79269,0.298651,-0.0340944,0.312732,0.152085,0.205798,0.360758,-0.398629,-0.105683,-0.238977,-0.251436,-0.301941,0.37208,-0.264149,0.00372293,-0.240755,-0.0992036,-0.142295,-0.092028,0.114369,-0.369433,-0.0195773,0.0796502,0.206699,0.0990619,0.0318055,0.551699,-0.152809,-0.0276456,-0.205171,-0.234572,-0.627382,0.0390185,-0.184981,0.334711,1.03125,0.381776,-0.395134,-0.158007,0.147339,-0.150631,0.497044,-0.142635,-0.0416127,0.0620981,-0.284328,-0.369152,-0.283611,-0.338092,0.252923,-0.115651,0.354229,-0.0928136,0.469079,0.579145,-0.200277,0.418577,-0.490722,-0.0968295,0.906205,-0.0296183,-0.142228,-0.193387,-0.411966,0.403542,-0.787148,-0.55963,0.0644307,0.703601,-0.149258,0.39673,-0.239758,-0.191763,0.295461,0.174487,-0.404933,-0.168647,-0.350552,0.112533,-0.306359,0.996223,0.335728,0.369147,0.0143483,-0.282087,0.168698,0.181173,-0.332236,0.898744,0.337826,0.319028,-0.00527595,-0.342353,-0.217461,0.0439825,0.190377,-0.434649,0.464946,-0.260981,-0.0413549,0.0473995,-0.19904,0.00819565,-0.515799,0.313627,0.426803,0.0337484,0.118917,0.0811237,-0.0867055,-0.436881,0.114844,0.345317,-0.106063,0.0187713,0.00254194,-0.208217,0.253921,-0.0403864,-0.348704,0.0244444,0.385036,-0.0447765,-0.516707,-0.489968,0.470784,-0.132314,-0.158582,0.040101,0.30373,-0.00226336,-0.0196034,-0.762762,0.972736,0.132875,0.263082,-0.225878,0.163408,-0.107236,-0.228186,0.0849401,0.203608,-0.559569,0.411486,0.612718,-0.253952,-0.432279,-0.818235,0.739245,0.393462,0.415224,0.851287,0.357399,0.228131,0.592236,-0.245754,-0.366677,-0.34509,0.00303612,-0.379084,-0.197925,0.482882,0.521565,0.222749,0.161177,-1.11892,0.0411968,0.407751,0.67678,0.12481,0.0364414,0.510233,1.12487,0.62928,0.331746,-0.582083,0.0138922,-0.981924,-0.250628,-0.263996,0.155641,0.153001,-0.527284,0.111984,0.248749,0.197784,0.202101,0.166319,-0.293352,0.210044,0.00902273,0.114694,-0.00951295,0.359192,0.107948,-0.567636,0.0222177,-0.225529,-0.770545,0.287628,0.271656,0.102328,-0.115011,0.241049,0.378557,-0.511489,-0.0442276,-1.16762,0.0478617,0.0093815,-0.44983,0.445217,0.1467,0.378689,-0.0134172,0.473056,-0.296528,-0.245557,0.159082,0.0228414,-0.017834,-0.369965,0.431286,-0.164059,-0.491106,0.197629,0.26464,0.13136,0.244653,0.362437,0.494624,-1.52938 +3405.28,0.741472,0.0848144,4,1.53724,1.03575,-0.56092,0.246581,0.467364,0.0113592,0.0823854,-0.466439,0.10773,0.0356383,-0.64196,-0.138567,-0.432897,0.491502,0.0150402,1.14012,0.296094,0.152231,-0.168867,-0.0400957,-0.192224,-0.794024,-0.804901,-0.021237,-0.260476,0.07689,0.263584,0.348334,0.263014,0.134555,0.811561,-0.27763,-0.366105,0.558837,-0.763277,-0.0103833,-0.803287,0.656002,-0.251182,-0.0278093,0.998538,-0.0347407,0.284817,-0.47974,-0.317425,-0.457874,-1.34432,-0.290481,0.285715,-0.486474,-0.474915,-0.403353,0.541502,-0.164545,0.739834,-0.0424071,-0.359235,-0.809707,0.142311,-0.282382,-0.00912307,1.21938,-0.499462,-0.813802,0.147634,-0.306624,0.00612777,0.660983,0.629279,-0.0791484,-0.268947,0.420515,0.364758,0.41198,0.7577,0.32842,0.016325,0.304576,0.129342,0.217113,0.415971,-0.508992,-0.147429,-0.261551,-0.279184,-0.250471,0.325009,-0.29462,0.0604984,-0.167353,-0.042849,-0.150888,-0.0458989,0.080352,-0.356523,-0.0274433,0.0232814,0.312316,0.154886,0.104212,0.555205,-0.184284,0.000130237,-0.148462,-0.266125,-0.604779,0.137676,-0.232138,0.278352,1.0189,0.379026,-0.434222,-0.121854,0.169778,-0.122263,0.514463,-0.159312,-0.0478171,0.0195386,-0.328436,-0.444847,-0.283669,-0.347401,0.305656,-0.00870295,0.368919,-0.162955,0.448793,0.547161,-0.189833,0.428887,-0.446931,-0.152197,0.867322,0.0464682,-0.131982,-0.180006,-0.429491,0.401855,-0.815693,-0.52165,0.087581,0.751486,-0.153035,0.356587,-0.226688,-0.294973,0.283667,0.169753,-0.323914,-0.201109,-0.336585,0.129572,-0.291309,1.01105,0.333442,0.375292,0.0208682,-0.279539,0.129906,0.157448,-0.320106,0.955134,0.386815,0.328587,0.0258002,-0.364331,-0.18753,0.0561853,0.208717,-0.403261,0.413234,-0.280261,-0.0653732,0.117356,-0.216137,-0.037563,-0.506615,0.389265,0.437314,-0.0804079,0.115741,-0.0219321,-0.117125,-0.554465,0.197875,0.463594,-0.0237716,0.0305237,0.160341,-0.207017,0.270566,-0.0943822,-0.30515,0.0988997,0.349703,0.0253785,-0.562915,-0.467307,0.497924,-0.108169,-0.173581,-0.0160701,0.297007,0.0657669,0.0421152,-0.746964,0.843069,0.175866,0.289464,-0.19626,0.215494,-0.199877,-0.300195,0.0773705,0.256426,-0.580636,0.38505,0.590242,-0.28747,-0.403761,-0.847399,0.732617,0.41347,0.313168,0.831342,0.308684,0.15774,0.596021,-0.157201,-0.305274,-0.329058,-0.0648816,-0.390224,-0.140159,0.439658,0.652036,0.155379,0.227301,-1.17944,-0.0895142,0.404427,0.725264,0.0155541,0.0831356,0.475403,1.12138,0.613158,0.354728,-0.596911,0.00236884,-0.91335,-0.220071,-0.278376,0.165023,0.186525,-0.558066,0.172307,0.258985,0.254008,0.167838,0.0943114,-0.253775,0.211653,-0.00116849,0.137143,-0.0208781,0.21513,0.193653,-0.501563,0.109294,-0.279458,-0.732951,0.231153,0.25541,0.0888342,-0.0893246,0.237034,0.383073,-0.629733,-0.0726867,-1.0906,0.0170449,0.0788463,-0.391965,0.422205,0.0835087,0.420923,-0.0655482,0.503079,-0.30644,-0.126052,0.225508,-0.0211673,-0.0161957,-0.395678,0.421144,-0.163331,-0.594067,0.122531,0.150667,0.130837,0.251477,0.361713,0.501475,-1.78743 +3446.06,0.998677,0.0848144,4,1.69385,0.945009,-0.520018,0.162973,0.553379,-0.127321,0.0389678,0.297216,0.248119,0.140396,-0.272973,-0.400407,-0.278843,0.512813,-0.317959,0.434192,0.154241,0.0699254,-0.0804078,-0.0872967,-0.541516,-1.23191,-0.417054,0.00384193,-0.36297,-0.484214,0.183382,0.147606,-0.291788,0.120955,0.487147,-0.176907,0.593202,0.431967,-0.483826,-0.16567,-0.136869,0.022874,0.243139,-0.973049,1.06261,0.277074,-0.0345924,-0.506641,-0.569618,0.154098,-0.353241,0.318502,0.398879,-0.180994,-0.146154,0.325546,-0.302457,-0.76301,0.817095,-0.451357,-0.406747,-1.18928,0.150681,-0.379737,-0.0114511,0.741828,-0.242872,-1.14066,-0.368167,0.814194,0.431288,-0.0213332,-0.000174388,0.0368288,0.401626,0.0658078,0.264396,-0.102841,0.4107,0.263894,0.217957,-0.155017,-0.650861,0.0712509,0.65113,-0.00481691,0.344504,0.253953,0.44846,0.164488,0.0173407,-0.457372,0.167671,-0.14582,0.135081,0.175717,-0.323911,0.285732,0.129484,-0.814511,0.240482,-0.387525,0.630944,0.103903,-0.0796448,-0.179177,-0.644742,0.327614,0.217279,-0.0773995,-0.087786,-0.0687326,0.213578,0.628706,0.387004,-0.204607,0.0431916,0.330083,0.179381,-0.174083,-0.0197347,0.141521,0.0835234,0.33105,-0.80124,-0.529958,0.300915,-0.0842871,0.206254,-0.0814041,0.633202,-0.450037,0.564825,-0.254239,0.266939,-0.383,0.0558527,0.275705,-0.638074,-0.414598,0.0439504,-0.261679,0.520283,0.111048,-0.0684187,-0.240823,-0.317006,0.157559,-0.461906,0.479055,0.222362,0.223239,-0.232155,0.167976,-0.0504126,-0.306754,0.352019,-0.0850488,0.219155,0.066987,0.206069,-0.120707,-0.0768099,-0.273902,-0.0648604,-0.18296,0.675532,-0.183028,-0.035878,0.35797,-0.0820106,-0.126068,-0.100684,0.00964596,0.333455,0.215761,-0.152988,-0.366392,-0.0292325,0.179968,-0.398149,0.104644,-0.0679423,0.290651,-0.243239,0.104932,0.381985,-0.233955,-0.435748,-0.489317,-0.522719,-0.0662992,0.286034,-0.281838,-0.160381,-0.404959,-0.00210552,-0.689032,-0.212695,0.407301,0.106217,0.0534318,-0.0461815,-0.24437,-0.00313825,0.0792628,0.474021,0.0020807,0.291064,-0.428667,-0.798827,1.2227,-0.490854,0.125355,-0.332653,-0.603652,0.344025,0.193322,-0.211396,0.558303,-0.118875,-0.275352,0.058791,-0.184795,-0.593823,0.159564,-0.384548,-0.138781,-0.481486,-0.121496,0.189259,-0.0214443,0.268241,-0.0544895,0.37704,0.150787,-0.29593,0.243244,0.00136179,0.336827,-0.630819,0.122096,0.402749,-0.169567,-0.374523,0.0291786,-0.415499,-0.0725886,-0.124641,-0.0891931,0.460851,-0.0953006,-0.0511885,-0.643333,0.0559181,-0.0753146,0.321753,-0.34937,-0.620846,0.428644,0.0693966,0.190934,-0.160537,-0.268653,0.30295,0.390053,-0.171948,0.253871,-0.0222923,-0.0116918,0.156449,-0.109357,-0.0305078,0.00202875,0.0411858,-0.536694,0.199781,0.201142,0.102877,-0.190128,-0.0229243,0.712834,-0.082155,0.287267,0.274379,0.0860054,-0.25265,-0.242558,0.188765,0.205165,-0.0415133,0.208859,0.0922409,-0.155438,-0.068949,0.515224,-0.0349223,0.524904,-0.113863,-0.52135,-0.126264,-0.0580256,0.393112,0.118473,-0.422433,0.0887125,0.183411,0.297846,0.428265,-1.66348 +3451.28,0.979809,0.0848144,4,1.71523,1.06524,-0.153015,0.0374141,0.372744,-0.200681,0.498837,0.211784,-0.223865,0.464347,-0.685619,-0.215956,-0.50343,0.43213,-0.128457,0.991232,0.0467699,0.120397,0.122611,-0.160508,-0.571946,-0.975619,-0.516492,-0.111881,-0.362067,-0.0867234,-0.0665653,-0.0814023,-0.254171,0.081474,0.604305,0.119875,-0.166446,0.397486,-0.53641,-0.242725,-0.732403,0.129863,0.221018,-0.559712,0.870231,0.14474,0.322485,-0.500237,-0.389681,0.21798,-0.293023,-0.227388,0.110947,-0.222321,-0.354624,-0.338749,-0.0580904,-0.450389,0.569073,-0.343904,-0.374623,-0.426434,0.482369,-0.513997,-0.133694,0.66114,-0.365381,-1.02914,-0.323986,0.418427,-0.0896285,0.119801,0.278439,-0.143497,-0.160459,0.82462,0.157104,-0.660036,0.228703,0.291712,0.257555,-0.113584,-0.200258,-0.0505758,0.370785,-0.465587,0.227525,0.207606,0.0807994,0.0744243,-0.176325,-0.667266,-0.109763,-0.598545,-0.242367,-0.0697748,-0.204393,0.137112,0.00675123,-0.40591,0.2449,-0.392687,0.303736,-0.0396471,0.0108019,-0.0814257,-0.483375,-0.102362,0.117683,-0.372021,0.295275,0.0582748,0.147915,0.449253,-0.286042,-0.0635255,0.0994408,0.0728765,0.577906,0.27342,-0.202425,-0.0246175,0.354294,0.5612,-0.423533,-0.106436,-0.0956838,0.600958,-0.0358499,-0.197617,0.375695,-0.131353,0.777355,-0.0101736,0.415275,-0.174682,0.401099,0.104143,-0.159241,-0.345704,0.318722,-0.139518,0.298361,-0.210902,0.2694,-0.213614,0.123248,-0.638919,-0.357063,-0.135057,0.232994,0.205513,-0.192064,0.260704,0.073206,-0.156287,0.0878696,-0.157721,0.0308303,0.567926,0.0970087,0.0588982,-0.248114,-0.0924813,0.216276,-0.110357,0.548443,-0.267809,-0.0196917,0.397252,-0.0388721,-0.0311627,0.0125142,0.497701,0.4372,-0.57387,0.027103,-0.592253,0.0173386,0.139668,-0.0743399,0.106591,0.0456329,0.609499,-0.341976,-0.291479,0.321871,-0.0374729,-0.395863,0.289447,0.212372,-0.0254423,-0.184171,-0.412097,-0.282456,0.245116,0.102736,-0.729727,-0.30722,0.171556,0.159808,-0.186167,-0.00948008,0.00957943,0.0226588,0.161129,0.624144,0.383826,0.163854,-0.0111317,-0.131103,0.684874,0.00818652,0.0790282,-0.544586,0.33452,-0.227715,-0.0662773,-0.466173,0.0291078,-0.574687,-0.54013,-0.145855,0.149258,-0.448986,-0.0836937,-0.0862371,0.0609808,0.00806426,0.302,-0.104594,-0.432892,0.361669,0.173864,0.180282,-0.0236954,0.205697,-0.47221,-0.100452,0.296242,-0.609393,0.133637,0.569918,-0.321372,-0.0686645,-0.0785244,0.252225,0.214325,0.619645,0.229197,0.891013,0.212143,-0.50295,-0.409164,0.0110916,-0.140575,0.117871,-0.127549,-0.295277,0.00902724,0.515508,-0.106134,0.045187,0.145907,0.296494,0.410458,-0.0469041,0.463794,0.555064,0.122601,0.115231,-0.462757,-0.289991,-0.234446,0.344702,-0.238355,0.165863,-0.0583273,0.423491,0.00823353,0.243586,0.11933,-0.0363295,-0.0774246,-0.0574345,-0.222969,-0.297786,-0.28381,0.0885518,-0.337804,0.259815,0.224227,0.239823,0.0689989,0.196171,0.255638,0.0678993,-0.0271675,0.0107286,-0.878432,-0.0768694,-0.309154,-0.0914609,-0.00434162,-0.285452,0.110862,0.216207,0.33296,0.464981,-1.3104 +3439.51,0.932956,0.0848144,4,1.70328,1.11315,-0.131789,0.026653,0.513006,-0.172297,0.0659659,0.478579,-0.0620504,0.334925,-0.507431,0.021468,-0.350759,0.472912,0.0759606,1.07329,0.0180238,0.134323,0.0871562,-0.382889,-0.625908,-0.910782,-0.416914,-0.329852,0.0719414,-0.280036,-0.186756,-0.118433,-0.368218,0.0933379,0.623355,0.00849674,0.0477792,0.134081,-0.252989,-0.323486,-0.298716,0.388116,0.0490752,-0.697185,0.944902,0.266702,0.0486382,-0.471936,0.0339229,0.0507408,-0.231685,-0.270253,0.346309,-0.169834,-0.0290644,-0.234885,-0.136789,-0.71738,0.397894,-0.467842,-0.404214,-1.06273,-0.106734,-0.164767,-0.253308,0.528574,-0.322451,-0.855271,0.0377167,0.357368,-0.344111,-0.0619866,0.267401,-0.403815,0.113156,0.589808,0.204407,-0.379046,0.65611,0.423332,-0.0856149,-0.157669,-0.227766,-0.365197,0.591369,-0.206995,0.0773801,0.471008,0.16955,0.0122631,0.0705509,-0.705967,-0.548278,-0.72057,0.00644853,0.133103,0.0833248,-0.0304198,-0.0139157,-0.559637,0.0655405,-0.350773,0.387925,0.00412693,-0.516158,-0.124457,-0.37459,-0.365788,-0.0152815,-0.307139,0.247304,0.00627549,0.187478,0.405666,-0.587087,-0.0720571,0.507568,0.523648,0.359354,0.438815,0.0387987,0.1539,0.197074,0.464978,-0.82527,-0.506351,0.0655337,0.112989,0.253412,-0.0127928,0.112197,-0.387053,0.526562,0.0977047,0.248759,-0.210119,0.211716,0.137791,-0.411578,0.0255254,0.13286,0.205029,0.214031,-0.351431,-0.208686,-0.0749778,-0.25198,-1.08158,-0.713201,-0.0528931,-0.10704,0.30061,-0.175734,-0.0217674,0.0158848,0.254092,-0.153408,-0.453352,-0.032818,0.0448844,0.298736,0.108343,-0.35892,0.00521012,-0.0235809,-0.070965,0.628235,-0.249745,-0.0191122,0.449652,-0.0200124,0.0929147,0.115266,0.252792,0.138275,-0.475575,0.125282,-0.587788,-0.127576,0.174221,0.0956508,-0.134687,0.523203,0.686456,-0.239589,-0.693991,0.100494,0.246707,0.0582907,0.179755,-0.0643948,-0.0246754,0.0769817,-0.458387,-0.330845,-0.0204359,0.0706478,-0.386818,-0.280575,-0.01511,-0.0569924,-0.169814,-0.58777,-0.221373,-0.029832,-0.334311,0.100792,0.130133,-0.320048,0.0686843,-0.245098,0.88188,0.0396151,0.415917,-0.472293,0.161227,-0.20223,0.044984,-0.430913,0.0151081,-0.776485,-0.468458,0.0290917,-0.477384,-0.818018,-0.396574,-0.157436,0.484567,-0.659217,0.295974,-0.16013,-0.379953,0.450755,0.133608,0.387676,0.0844926,0.36804,-0.362842,-0.165323,0.269844,-0.526036,-0.258225,0.771634,-0.157223,-0.769599,0.19329,0.0430864,0.0127009,0.916181,0.156431,0.8692,-0.225368,-0.557943,-0.690922,0.0685097,-0.191139,0.246549,-0.684448,-0.283862,0.337704,-0.0714667,-0.239954,-0.139638,0.100972,0.411186,0.0639743,0.161633,0.689643,0.358205,0.280891,0.0603182,-0.105119,0.310823,-0.205703,0.0324146,0.0170547,-0.125762,-0.401262,0.015974,0.122493,-0.288881,-0.0213195,-0.062036,0.114118,-0.204669,0.00661673,-0.396459,-0.0305272,-0.0742773,-0.212179,0.387658,-0.112106,0.164951,-0.059989,0.106263,0.0482565,-0.0998479,-0.137681,-0.168908,-0.433801,-0.148103,-0.365928,-0.412843,0.0193279,-0.21587,0.106022,0.160613,0.32561,0.400766,-1.88074 +3442.22,0.908172,0.0848144,4,1.66422,1.01929,-0.229351,-0.062218,0.149511,-0.0393044,0.119611,0.16025,0.221775,0.208153,-0.380333,-0.198237,-0.0404969,0.251253,-0.153931,0.62281,0.204242,-0.164436,0.0212339,-0.0523296,-0.409351,-0.93767,-0.702144,-0.00544981,-0.684053,0.0317427,0.486346,0.444284,0.0966256,-0.00289368,0.47747,-0.327988,-0.227349,0.152835,-0.214531,-0.0189258,-0.561139,0.493788,0.258042,-0.00816708,0.731686,0.354894,0.225843,-0.290574,-0.700263,-0.138719,-1.14126,0.144154,0.751009,-0.194887,0.350186,0.173226,-0.0678518,-0.392895,0.845523,-0.420023,-0.100051,-0.492222,0.498454,-0.624916,-0.281318,0.669401,-0.501844,-0.502822,-0.247794,-0.23194,-0.126666,-0.0694012,-0.0339637,0.117432,-0.378642,-0.141482,0.669739,0.0473683,0.268516,0.131008,0.248073,0.21271,-0.191369,0.285261,0.431147,-0.265065,0.207834,-0.555089,-0.094325,-0.0918511,0.388542,0.169225,-0.162688,0.169746,-0.424569,0.0683407,-0.159442,0.0746845,0.013873,-0.281208,-0.184231,-0.334984,-0.382679,0.314182,0.426418,-0.487106,-0.447672,0.21148,0.253652,-0.435984,-0.108519,-0.551453,0.716304,0.380299,0.468344,-0.112883,-0.651611,0.474055,-0.449454,-0.254017,-0.343951,-0.0395765,0.0967202,-0.551244,-0.144844,-0.221643,-1.01779,-0.678772,-0.148905,0.0778615,0.112766,0.162097,0.454211,-1.04023,0.372682,-0.129968,-0.580843,0.573698,0.0662275,-0.236741,-0.300731,-0.312648,0.378637,-0.357606,-0.342042,-0.0057512,0.316378,-0.313207,0.242881,0.0976454,-0.529287,0.025682,0.129285,-0.158935,-0.209973,-0.236231,0.528691,0.122646,0.541892,-0.31762,0.0232132,-0.190094,0.51832,0.00561006,-0.294293,-0.416777,0.750306,-0.237552,-0.232868,-0.171403,0.0617112,-0.115837,-0.523495,-0.106704,0.18171,-0.321874,0.0286785,-0.145977,0.134937,-0.259296,-0.632452,-0.286952,0.00557399,0.493633,-0.312086,-0.160794,-0.0367798,-0.581392,-0.156033,-0.287263,-0.0888512,0.174439,0.00700255,0.206779,0.153645,-0.154298,-0.242261,-0.454258,-0.0657072,-0.156223,0.0659018,-0.171156,-0.620583,0.0690476,-0.184283,-0.092154,0.310726,-0.339934,0.622055,-0.148078,-0.456412,1.14038,-0.0847111,0.143383,0.526051,-0.43526,0.353802,-0.326616,-0.223084,0.441547,-0.0798855,0.385295,0.286761,-0.139451,0.1868,-0.130411,-0.193105,0.204105,0.21178,0.422805,-0.614568,-0.151759,0.0177723,0.17418,-0.127369,0.191105,-0.468268,0.245918,-0.101798,0.439846,0.52844,0.521017,0.311481,-0.573256,0.633797,-0.25112,0.280563,-0.186019,0.645266,0.241086,0.5115,0.0965619,-0.0541241,-0.17694,-0.0744376,-0.414935,0.330097,0.127466,-0.469482,0.0857417,-0.489959,-0.120314,0.360082,-0.103967,0.287345,0.226636,-0.0121669,-0.245364,-0.189955,-0.0648765,0.0590564,-0.182502,-0.181506,-0.281753,-0.0411833,-0.590972,-0.348344,0.0324224,-0.0851536,-0.0498619,0.347367,-0.315335,0.232606,-0.516092,0.47362,-0.259527,0.168779,-0.118029,0.237063,0.179564,-0.551315,0.231619,0.087042,-0.267167,0.130335,0.539955,-0.0447021,0.305542,-0.417388,-0.187473,-0.0636707,0.171187,-0.312115,-0.664695,0.426942,0.107848,0.249326,0.328401,0.499325,-0.444843 +3445.12,0.999928,0.0848144,4,1.58842,0.998239,-0.349505,-0.0507569,-0.0296075,-0.145112,0.277782,-0.0146426,0.291038,-0.289481,-0.577157,0.117269,0.122176,0.351552,-0.00109679,1.25172,0.104701,-0.102896,-0.150058,-0.38495,-0.28325,-1.17594,-0.833383,0.0123633,-0.263576,-0.152217,0.0381083,0.0585211,0.0315012,0.00017347,0.451021,-0.112219,-0.124483,0.0233634,-0.26807,0.395404,-0.1348,0.702276,0.0231208,-0.209421,0.969243,0.270263,0.280874,-0.469152,-0.509178,-0.0805065,-0.860208,-0.167802,0.295289,-0.0480905,0.439086,0.555601,-0.125509,-0.314213,0.948066,0.0895697,-0.335508,-0.156265,0.744971,-0.0241411,0.432094,0.91427,-0.307802,-0.51148,0.0851247,-0.210768,-0.216007,0.312299,0.277721,-0.0515198,0.00281115,0.121469,0.661323,-0.244351,0.44887,0.338431,0.438304,0.440242,-0.433312,0.039965,0.594566,-0.0705745,0.174338,-0.310272,-0.112437,-0.608181,0.304494,-0.37336,-0.10418,-0.216625,-0.424222,0.386816,-0.203966,0.168557,0.019189,-0.151709,-0.117077,-0.79445,-0.293261,0.41619,0.326163,-0.5669,-0.29575,0.0824986,0.152633,-0.26489,0.779167,-0.538678,0.242729,0.436555,0.531409,-0.126654,-0.33705,0.484084,-0.263826,0.203325,-0.452694,0.161965,-0.146707,-0.683277,-0.500487,0.119115,-0.745287,-0.690312,-0.2224,-0.407611,0.0775333,-0.170082,0.550357,-0.294298,0.377053,-0.182709,-0.119843,0.208317,0.0613315,-0.1742,-0.0576385,0.223194,0.0720337,-0.351903,0.14752,-0.123477,0.0971818,0.027107,-0.101229,0.0010163,-0.345168,0.459283,-0.106568,-0.141792,-0.142584,-0.200045,0.309695,-0.0462233,0.340394,-0.255024,0.00507778,-0.0333849,-0.0531933,-0.0977956,-0.366246,-0.286637,1.24243,0.0497758,-0.156754,-0.399737,0.0289231,-0.0991147,-0.271197,-0.30918,-0.114766,-0.147282,0.0984725,-0.0293851,0.28804,-0.108026,-0.561907,-0.584722,0.201079,0.466487,-0.146165,-0.49364,0.0404609,-0.260214,0.124449,0.0760265,0.0125889,-0.177743,-0.124304,-0.104161,0.0370857,0.0532637,0.39925,-0.61981,0.39007,0.137068,0.250339,-0.427641,-0.901672,0.179775,-0.0709264,0.174374,0.0414324,0.0974214,0.393395,-0.137244,-0.650389,0.95813,0.0932976,0.446007,-0.00738025,-0.194682,-0.0657885,-0.608946,-0.258513,0.459726,-0.502771,0.257502,0.424996,-0.243206,0.186489,-0.00609147,-0.00850362,0.355167,0.0271382,0.504983,-0.57954,-0.145131,-0.120352,0.215507,-0.324587,0.270528,-0.0741507,0.089862,-0.0853293,0.115167,0.23922,0.254345,0.490027,-0.650954,-0.0646084,-0.281273,0.0363188,0.330356,0.428154,0.285697,0.463649,0.105382,0.116886,-0.0165221,-0.213848,-0.147031,0.0795823,-0.463265,-0.279002,0.330552,-0.0649881,-0.532522,0.250194,0.363104,0.562706,0.380654,-0.0786572,2.39396e-05,0.185119,0.154366,0.343367,-0.128268,0.0314463,-0.318767,-0.300659,-0.396998,0.432956,0.376895,-0.0989211,0.274389,0.259176,-0.596816,0.363883,-0.12831,0.450241,-0.0274182,-0.20722,-0.059362,0.532729,0.156785,-0.108137,0.0380887,0.220646,-0.669144,0.097,0.123025,-0.116861,0.420874,-0.383652,0.301495,0.271344,0.29882,0.140693,-0.507429,0.679181,0.125474,0.180452,0.354223,0.424796,0.18992 +3460.31,0.894683,0.0848144,4,1.62658,0.915622,-0.894647,0.144229,0.232805,-0.153946,-0.14928,-0.329125,-0.123515,0.105139,-0.328377,-0.41194,-0.221769,0.254215,-0.492157,0.173258,0.00329451,-0.185709,-0.0239757,-0.015958,-0.540873,-0.848329,-0.55533,0.131348,-0.113217,-0.586116,0.0236412,0.152732,-0.438173,-0.0757965,0.355591,-0.0535963,-0.244386,0.0770802,-0.439881,-0.319816,-0.718802,0.187103,0.25589,0.106756,0.774076,0.591079,0.0765997,-0.433604,-0.15134,-0.161207,-0.264353,0.325885,0.790844,0.308411,-0.0787589,0.0150572,0.599139,-0.0562279,1.08977,-0.0163443,-0.168852,-0.746316,0.595966,-0.519899,0.254756,0.571064,-0.60302,-0.134597,-0.527097,-0.647233,-0.0936346,-0.191908,0.545009,-0.442656,-0.121679,-0.274177,0.280198,0.0422578,0.390579,0.000264392,0.0780841,-0.613077,-0.274101,0.0493697,0.307883,-0.0729393,0.196306,-0.15773,0.0368883,0.041541,-0.191154,-0.0943337,0.237479,-0.0472117,0.0742048,0.0346078,0.0946266,0.658894,0.246542,-0.438846,-0.25109,0.0629967,-0.153982,0.302556,-0.130527,0.333076,-0.232659,-0.537571,0.362687,0.155665,0.0750685,-0.0873233,0.0814769,0.667197,-0.462582,-0.0824057,0.454124,0.312907,0.136469,0.139322,-0.20441,0.0895152,0.26313,0.0715357,-0.36889,-0.29597,-0.220483,0.135538,0.440748,0.0456072,0.558418,0.477788,0.353903,-0.136798,0.00529155,0.0233619,-0.353232,0.481886,-0.367784,-0.346115,-0.215709,0.013629,0.446338,-0.336124,-0.497846,-0.0849311,-0.314553,-0.603839,0.0274464,0.0136562,-0.163766,-0.115772,-0.284602,-0.150686,0.107465,-0.13469,0.278469,-0.0120862,0.330625,-0.0778514,0.0939552,-0.237244,0.121431,-0.0122656,0.412187,-0.0527566,0.529054,0.255353,0.180798,-0.327546,-0.0873294,-0.0820281,0.277959,-0.396782,0.106488,0.290057,-0.0684283,0.0371478,0.0336186,-0.042855,-0.319282,-0.0279219,0.11698,0.921409,-0.0602296,-0.534486,0.569691,0.2249,0.474186,0.112101,0.0190916,0.0206059,-0.203264,-0.636131,-0.0458311,0.29904,-0.126634,-0.314934,-0.259491,-0.0120674,-0.0595795,-0.0198732,-0.0588368,-0.324996,-0.163609,-0.126528,0.22473,-0.469948,-0.25526,-0.22529,0.100182,1.05662,-0.0953892,-0.563482,0.183464,0.0825327,0.160496,-0.251919,0.364435,0.461679,-0.516684,0.346481,0.34097,-0.074573,0.033858,0.0150089,0.172969,0.241039,-0.317973,0.160514,-0.0370243,-0.40115,0.269017,-0.194175,0.196623,-0.0588625,-0.514187,0.203549,-0.696634,0.26052,0.0377676,-0.443064,0.513722,-0.036891,0.0728566,-0.0110237,-0.089335,0.392947,0.237144,-0.0764804,0.424854,-0.220411,0.0525744,-0.371494,0.362079,-0.407794,0.813815,0.112569,-0.353423,0.376634,-0.351823,0.234326,-0.0605847,-0.205281,-0.25078,0.47597,-0.0449899,0.105334,0.323107,0.114106,0.0105646,0.175289,-0.46194,0.292802,-0.0370169,-0.00680073,-0.260378,-0.133887,-0.295743,-0.284283,0.41166,0.00663237,0.371048,0.0817768,-0.180596,0.153809,-0.206231,0.175986,-0.218054,0.117641,0.212888,0.521187,0.104683,-0.386164,0.000833338,-0.192504,0.179576,0.568535,-0.308754,-0.181795,-0.608278,0.0587249,-0.67839,-0.153738,-0.252108,0.0950607,0.166079,0.308319,0.407528,-0.393287 +3446.89,0.984137,0.0848144,4,1.67284,0.922965,-0.498308,0.0936301,0.0990774,-0.196038,-0.0977889,-0.701135,0.297459,0.0780405,-0.268636,-0.459125,0.176685,0.565311,-0.328805,0.486972,0.26305,-0.36193,0.335727,0.0885359,-0.6361,-0.805879,-0.336319,0.242619,-0.125004,-0.334178,0.370781,0.655691,-0.530462,-0.265415,0.588252,-0.594737,-0.29294,-0.192996,-0.467096,-0.342297,-0.855346,0.220847,0.63762,-0.107127,0.878406,0.311542,0.234571,-0.580463,-0.0174359,-0.287768,-1.0252,0.434274,0.809509,0.125695,0.0259101,0.260173,0.222563,-0.911676,0.85516,-0.119599,-0.324787,-0.777398,0.588514,-0.764275,0.488033,0.724171,-0.573731,-0.729808,-0.0605406,-0.0532856,-0.272539,0.412739,-0.0364906,-0.286364,0.124102,0.120851,0.255767,0.480211,0.553107,0.0448073,-0.00368347,-0.399977,-0.605058,0.185943,0.235986,-0.824098,-0.113798,0.106706,-0.0990222,0.104586,-0.477426,-0.144966,0.329935,-0.0972875,0.203635,-0.251229,0.219065,0.111619,0.0316088,-0.0671578,-0.0627877,-0.0703838,-0.4866,0.275875,-0.0492162,-0.184423,-0.153447,-0.405898,0.0906322,-0.25521,0.112991,-0.471485,0.158207,0.666775,0.433784,-0.136545,0.364746,0.150485,0.210777,-0.221247,-0.203294,-0.0922227,0.494852,0.0533888,-0.266906,-0.680515,-0.0941509,-0.112479,-0.185564,0.297063,-0.0531835,-0.0447727,-0.0124474,-0.228115,-0.297835,0.0658699,-0.216222,0.495499,-0.479364,0.00433835,-0.163703,-0.334101,0.67483,-0.796674,-0.0373653,-0.2065,0.159626,-0.356546,0.000908854,0.00134943,0.0678199,0.0101938,-0.0246816,-0.188619,-0.0773418,0.104716,-0.033742,0.217644,0.508943,-0.00382086,0.00612127,-0.0788133,0.120497,0.106278,-0.136532,0.154621,0.673623,0.143834,0.164565,0.0144715,-0.338726,0.157924,0.429582,0.0879607,-0.0241549,0.487107,0.0225227,0.075593,-0.22028,-0.0360104,0.145201,-0.0708834,0.181181,0.929675,0.10433,-0.294075,0.32994,0.20323,0.344235,-0.426521,-0.0548757,0.117029,-0.235249,-0.842591,-0.144068,-0.292147,-0.0850479,-0.811704,-0.144364,-0.0230734,-0.104138,-0.0489125,-0.209741,0.0835734,-0.246579,-0.0714121,0.348918,-0.240038,0.0524932,-0.648645,0.119724,1.00082,0.28655,-0.0419977,0.333853,0.0516748,0.209037,0.227602,-0.169969,0.18822,-0.152651,0.176602,0.686925,-0.129461,-0.217749,-0.169267,-0.299582,0.005321,-0.621961,0.097003,0.0684786,-0.555819,0.197631,-0.398676,-0.60211,0.0303046,-0.123855,0.0700149,-0.902362,0.368964,0.011872,0.291369,0.843666,0.0638702,0.471046,0.705939,0.225032,0.0733363,0.391549,0.0652691,0.387878,-0.00857948,0.0877127,0.154727,0.466262,-0.484143,0.413811,0.452394,-0.141081,0.394381,-0.422395,0.0772928,0.284582,0.0098569,0.313139,0.528796,-0.056138,0.240574,0.137131,0.424255,0.346483,0.405095,-0.289934,0.0159015,0.0608777,-0.160491,-0.0736661,-0.170004,-0.334145,-0.432642,-0.0603419,-0.250377,0.343168,0.073634,-0.0616452,0.172008,-0.0865998,-0.0778847,-0.187954,0.132141,0.237176,0.684141,0.117091,0.393101,0.0639827,-0.195547,0.677371,0.0367093,-0.498109,-0.0395761,-0.300992,0.0636616,-0.759092,0.1625,-0.226991,0.0978514,0.237328,0.312812,0.487163,-0.0657974 +3462.34,0.998855,0.0848144,5,1.61501,0.860412,-1.3758,0.52565,0.439207,-0.0954944,0.116135,0.621426,0.256911,-0.089737,0.0153518,-0.345353,-0.495879,0.319045,0.0174361,0.820195,0.0417508,0.0483545,-0.240281,-0.225403,0.0325316,-0.848893,-0.725515,-0.118122,0.0298028,0.178036,-0.124946,0.291408,-0.666113,0.30407,1.04069,-0.878846,-0.222605,0.298669,-0.267653,-0.228762,0.260613,0.36212,0.385727,-0.578164,1.1744,0.759856,0.54858,-0.611885,-0.0475633,0.519471,-0.522607,-0.0269807,0.0284479,0.281521,0.179919,1.03106,-0.16511,-0.0554258,0.397995,-0.127229,-0.180263,-0.965004,0.168746,-0.338929,0.163039,1.2507,-0.711849,-0.570232,0.272527,0.391105,-0.0613833,-0.0699489,0.180547,-0.195842,-0.0326053,0.429779,0.25506,-0.603707,0.00696899,0.592623,0.0547645,0.262457,0.375574,-0.17562,0.391938,-0.243106,0.144202,0.137833,0.0896589,0.15611,-0.00833598,-0.222526,-0.245445,-0.540912,-0.23467,-0.170268,-0.0980574,-0.15429,-0.00411484,-0.226584,-0.0282999,0.152963,0.0918548,0.0126033,0.266769,0.238271,-0.259295,-0.445562,-0.107241,-0.00861085,0.615949,0.00270912,-0.090391,0.415378,0.158076,-0.309129,-0.196533,0.294314,-0.0380236,-0.38587,-0.475299,-0.102036,-0.282984,0.0763708,-0.364867,0.326858,0.134207,-0.10366,-0.375919,0.25496,0.48757,-0.135215,0.226872,-0.771824,0.101795,0.22274,0.153675,0.265653,-0.0532481,0.334469,0.126236,-0.00778331,0.191787,-0.503436,0.0295997,0.0110118,-0.162903,-0.570533,0.33404,0.297606,-0.0346354,-0.153626,-0.322219,0.0504036,-0.394597,-0.301216,0.204164,-0.246906,-0.049339,0.822242,0.263037,-0.035047,-0.107823,-0.244309,0.246014,-0.057565,0.751724,-0.124869,-0.647997,-0.176492,0.0518662,0.268636,-0.379109,0.233874,0.565415,-0.283624,0.0342803,0.000419669,-0.103574,0.0901636,0.139183,-0.342973,-0.102753,0.1307,0.0592981,0.130596,-0.290291,-0.24735,-0.380303,-0.334948,-0.539857,-0.107784,0.1293,0.133249,-0.0701882,0.00161191,0.116114,-0.313298,-0.169055,0.536256,0.162859,-0.358592,0.277944,0.2193,0.214028,0.0485474,-0.194827,0.13421,0.302881,-0.108742,-0.137671,0.543468,-0.472593,0.245945,-0.0837492,0.0277636,-0.184878,-0.369986,-0.0929711,0.334147,0.259737,0.160403,-0.32747,-0.528301,0.118198,-0.365432,0.50419,-0.440409,-0.0109026,0.810563,-0.155276,-0.629427,0.0663812,0.15645,-0.0108578,-0.019019,-0.170275,0.137228,-0.0204837,0.416658,-0.320837,0.39548,0.249496,-0.698324,0.0896195,-0.552099,-0.19193,-0.340397,0.147886,0.210104,-0.0186251,-0.0639514,0.0525875,-0.344832,0.154486,-0.640444,0.473884,-0.632957,0.089046,0.291908,-0.4643,-0.22632,0.0701769,0.309894,0.280097,0.260989,0.267014,0.171867,-0.117175,0.114879,-0.106529,-0.304344,-0.128058,-0.0780111,-0.749778,-0.186745,-0.476148,-0.240872,0.0917017,0.0789819,-0.315938,0.157214,0.28825,0.000590011,-0.0916634,0.209752,-0.428983,-0.0503361,0.338671,0.220395,-0.0524724,-0.181308,-0.0939523,-0.169033,-0.0568429,0.0110545,-0.0124847,-0.00415803,0.0367528,0.0191693,0.440029,-0.524124,0.292427,-0.453765,0.0394714,0.0875325,0.255796,0.295859,0.505763,-1.11599 +3465.93,0.787498,0.0848144,4,1.4938,0.804111,-1.56728,0.634072,0.49112,-0.111955,0.169803,-0.478074,0.147606,0.428272,0.0703018,-0.22025,-0.390964,0.516577,-0.104724,0.537233,0.0252666,0.260234,0.135448,-0.110625,0.138959,-1.06611,-1.15097,0.421626,0.417324,0.108127,-0.0327336,-0.0957434,-0.293879,0.0385083,0.944624,-0.777894,-0.504899,0.557199,-0.313294,0.335604,0.415739,0.219743,0.736014,-0.816155,1.27964,0.740352,0.191311,-0.480507,-0.343742,-0.160946,-0.277454,0.317084,0.203686,-0.191908,0.399765,0.791489,0.317281,-0.213822,0.53345,-0.168551,-0.182027,-0.679735,0.320183,0.0277472,-0.406427,1.23401,-0.536919,-0.816024,0.646297,0.151969,-0.279433,-0.0355406,-0.287157,-0.311146,-0.234749,0.128367,0.47091,-0.0791126,0.548668,0.270935,0.199795,-0.0310174,-0.0232633,-0.301261,0.274265,-0.0897319,0.275413,0.0178446,-0.00371543,-0.383008,-0.185126,-0.612055,0.040228,-0.523162,0.131711,0.25942,-0.0520275,-0.361384,-0.254854,-0.255138,-0.118976,-0.0621949,0.253032,-0.0178525,0.211122,0.0400823,-0.129848,-0.165145,0.222572,0.45532,0.731638,-0.0532221,0.187897,0.372356,-0.765,-0.522684,-0.284752,0.363599,0.13198,-0.227573,-0.153557,0.0274895,0.0816005,0.436765,-0.391081,0.256467,-0.223439,-0.564545,-0.0728587,0.0480815,-0.329104,0.232674,0.124765,0.122701,0.253255,-0.16745,-0.0414622,0.472707,0.0753784,-0.286583,0.0190245,0.150503,-0.0250647,-0.597634,-0.0737146,-0.103712,-0.165609,-0.475855,-0.47837,0.237914,-0.102852,0.0191894,-0.360178,0.0226931,-0.0263237,-0.143046,0.12245,-0.311593,-0.0668225,0.672979,0.129453,-0.17383,-0.2951,0.152962,0.477519,-0.42426,0.410737,0.0732334,-0.123148,0.304766,-0.265986,0.128706,-0.478049,-0.200575,0.178165,-0.0998292,-0.152721,0.17017,-0.239469,0.425743,-0.0152671,-0.124256,-0.0180756,0.377606,0.27664,-0.165358,0.0546905,-0.179862,0.127002,-0.208711,-0.0025591,-0.00876952,0.301412,-0.232218,0.0409839,-0.0399907,0.329385,-0.511274,0.158113,-0.0738101,0.0454398,-0.967345,0.351424,-0.0715741,-0.0550576,-0.448175,-0.181855,0.176699,0.387719,-0.313358,-0.267143,0.723442,-0.0454916,-0.0389231,-0.483931,-0.0284941,-0.409138,-0.498719,0.155245,0.325782,-0.0882065,-0.114192,0.113248,-0.27438,-0.07983,-0.117678,0.178663,-0.467706,0.191063,0.530212,-0.0523085,-0.409446,-0.0428802,-0.20643,0.0763043,-0.12906,0.0423604,0.0851394,0.167025,0.408805,0.188095,0.000506038,0.459811,-0.84633,-0.326397,0.0341675,-0.216296,-0.266535,0.161142,-0.0507554,0.0910302,0.345083,-0.0674462,-0.0815567,0.116287,-0.75863,0.552324,-0.537592,0.00617024,0.154084,-0.197145,0.284544,0.271589,0.0738428,-0.346627,0.338203,-0.285746,-0.149749,0.235059,0.658747,-0.159219,0.140814,-0.229852,0.00361827,-0.61258,-0.157163,-0.213546,0.0153586,-0.151294,0.166257,0.0302344,0.300032,-0.274677,0.144784,0.150459,-0.0444218,-0.447245,-0.0722627,0.37268,0.0792345,-0.220971,0.0190579,-0.26991,-0.323712,-0.0970795,0.318233,0.255829,0.0191662,0.105574,-0.601532,0.161186,-0.150171,0.0388423,-0.0730576,-0.0726817,0.0797372,0.245686,0.282378,0.495667,-1.3081 +3445.79,0.980088,0.0848144,4,1.45586,0.786755,-1.38433,0.609366,0.459131,-0.23047,0.192256,-0.168453,0.643851,0.0511858,0.378164,-0.183528,-0.200678,0.450661,0.148648,0.702805,0.291061,-0.0850834,0.36228,0.259862,0.200877,-0.871315,-0.84531,0.402589,0.11359,-0.0633528,0.536868,0.60861,0.0572573,0.0761972,1.11716,-0.625106,-0.247357,0.658911,0.0876141,0.195839,-0.0104394,0.607644,0.482402,-0.755711,1.2619,0.734321,-0.0959902,-0.58292,0.190149,0.296905,-0.163339,0.316938,0.263614,0.301388,0.393323,1.07603,0.253712,0.0326028,0.351237,0.136412,0.162625,-0.585544,0.289787,-0.471339,-0.199087,1.13103,-0.342074,-1.08713,1.01525,-0.138881,-0.000780049,0.188432,0.0990282,-0.554737,-0.284628,0.245004,0.371002,0.023764,0.436277,0.408414,0.0589784,-0.132149,-0.00324743,-0.0362951,0.47753,0.106559,0.240756,-0.342329,-0.0606679,-0.169805,-0.205029,-0.927,0.461925,-0.471104,-0.160648,0.193753,-0.024745,-0.00280382,-0.244011,-0.241829,0.221148,-0.427628,0.692325,0.0628881,0.214145,0.190075,-0.14004,-0.560183,0.746591,0.0960576,0.566824,0.149685,0.454072,0.286424,-0.193158,-0.344738,-0.112583,0.298386,0.221181,-0.098074,0.327586,0.0236708,0.014108,0.0115891,-0.540073,-0.515279,-0.27877,-0.407279,-0.105757,0.562508,0.177511,0.0549871,-0.0421558,0.606981,0.196968,-0.199809,-0.228862,0.789149,-0.0779675,0.205874,-0.108105,0.0091123,-0.000539539,-0.269779,0.0727592,-0.0639459,-0.309453,-0.168572,-0.0865359,0.610093,-0.203583,0.354653,-0.0572422,-0.293085,0.147985,-0.121031,-0.114212,-0.255504,-0.222138,0.232575,-0.377917,0.117969,-0.462283,0.366601,0.148887,0.0402563,0.717864,0.128118,-0.265555,0.154689,-0.0933547,-0.17035,-0.171609,-0.000828396,0.23925,-0.219963,-0.0118581,-0.340576,-0.226791,0.383129,-0.243939,-0.13501,0.180704,0.690746,-0.233861,0.0590661,0.109276,-0.301952,0.837638,0.362966,-0.25119,-0.165405,0.0236743,-0.172538,0.316727,0.0876685,0.622597,-0.414501,0.312623,0.44588,0.142567,-0.512688,0.109809,0.491557,-0.203212,-0.389964,0.190546,-0.00177413,0.36164,0.075902,-0.164064,0.778576,0.197764,0.0750235,0.112718,-0.182549,-0.313214,-0.399244,0.307201,-0.0121846,0.483323,0.00604447,0.446611,0.423171,0.000672883,-0.597256,-0.117969,0.239593,-0.0338586,0.231257,-0.289699,-0.541834,-0.117849,-0.188172,-0.146596,0.104234,-0.207374,-0.225273,-0.0882209,0.111897,0.336921,0.449213,0.266811,-0.325869,0.00801811,-0.344239,-0.246922,-0.221819,-0.376991,-0.0512238,0.217217,0.349223,0.178575,0.0830571,0.104627,-0.552542,0.514694,0.249553,0.168891,0.169608,-0.181078,0.347961,-0.125967,-0.0441237,-0.215421,0.0449369,-0.146788,0.0937724,0.172287,-0.00709121,-0.0442379,0.0970666,0.317193,-0.0358374,-0.625123,0.116803,-0.0644842,0.152306,0.209483,-0.386461,0.192215,0.234809,0.0501293,-0.070528,-0.125308,0.117333,-0.23593,-0.511233,0.5947,-0.172822,-0.135944,0.418221,-0.196959,-0.260032,0.159536,0.102923,0.0564294,0.174889,0.542329,-0.590602,0.0561626,0.150551,-0.255461,-0.0317709,-0.49402,0.0994548,0.325544,0.315365,0.570565,-1.25223 +3445.48,0.434155,0.0848144,4,1.35258,0.798318,-1.37133,0.586469,0.313481,-0.196666,0.242117,-0.34377,0.731521,0.336711,0.304146,-0.402421,-0.335188,0.716018,0.282151,0.779524,0.406626,-0.101804,-0.250098,0.0193208,0.359968,-0.875975,-0.733862,0.5973,0.00140288,-0.168248,0.371078,0.466844,0.208788,0.024825,1.16524,-0.410147,-0.247483,0.510306,-0.394201,0.121287,-0.160489,0.691451,0.570661,-0.548911,1.02245,0.385053,0.154864,-0.647923,0.320974,0.34378,-0.093047,0.661179,0.117817,-0.00890974,0.546686,1.21682,0.273734,-0.637988,0.423148,0.208649,-0.000984061,-1.04712,0.406622,-0.330167,0.132245,1.13651,0.103202,-1.11118,1.08892,-0.352941,-0.0693841,-0.20673,0.0823924,-0.719886,-0.221977,0.58318,0.38433,0.214076,0.762467,0.157695,0.337046,0.33965,-0.0400951,-0.0550798,0.556445,-0.0387852,0.300656,-0.174601,0.208794,-0.282913,0.18667,-1.06377,0.175838,-0.154343,-0.23965,0.149261,0.018788,-0.11138,-0.043597,0.188403,0.637153,-0.336143,0.489092,0.115337,0.419104,0.250564,-0.3324,-0.686305,0.649849,-0.101754,0.547973,0.194707,-0.000408243,0.128279,0.295025,-0.294338,-0.159999,0.333423,0.26834,0.00631598,0.176732,-0.0360062,-0.550323,0.283125,-0.536385,-0.148777,-0.310623,-0.173323,-0.121194,0.604905,0.403062,0.243692,-0.219586,0.242134,-0.00529332,0.0377837,0.0649375,0.649563,-0.161214,0.297482,-0.0384771,0.0693867,0.157509,-0.361035,-0.0361797,-0.101293,-0.0661264,-0.432788,0.188858,-0.130592,-0.135151,0.229547,0.058351,-0.407041,-0.057278,-0.240276,-0.0464587,-0.00631799,-0.00779942,0.268974,-0.0204294,0.136846,-0.421148,0.426275,0.0185601,0.142552,0.568513,-0.0593492,-0.0872505,0.150694,-0.215407,-0.413238,-0.329899,-0.0638712,0.183097,0.155068,0.133592,-0.551195,-0.20387,0.588187,-0.23639,0.0662513,0.290624,0.736653,-0.164065,0.269083,-0.0290118,0.0362961,0.735881,-0.0594063,-0.261652,0.0679587,0.0813735,0.0219028,0.315561,-0.124006,0.171704,-0.283342,0.400637,0.104391,0.228911,-0.430277,0.362265,0.267735,0.00356742,-0.250437,0.435024,-0.0855887,-0.0235226,-0.296663,-0.233338,0.722886,-0.0602256,0.102808,0.233296,-0.215075,-0.158251,0.082242,0.144848,0.0368379,0.0919708,0.133086,0.382966,0.716307,0.155912,-0.370662,-0.138109,-0.0757724,-0.148807,0.413596,-0.0226025,-0.474454,-0.373137,0.109671,-0.0932936,0.180943,-0.247759,-0.299727,-0.266755,0.231807,-0.0357603,0.289008,0.339506,-0.378062,-0.396529,-0.12688,-0.394464,-0.14899,0.0359113,0.0515316,0.358053,0.419128,0.167187,-0.217312,0.179016,-0.355659,0.515504,0.167124,-0.289841,0.199891,-0.101467,0.361719,-0.140953,0.13141,-0.371255,0.500383,-0.329866,0.251341,0.502055,-0.0964398,-0.245712,0.028884,0.455549,-0.113659,-0.604277,-0.32148,-0.0980741,0.146472,0.642294,-0.403036,0.0579919,0.257239,0.107972,0.0997539,-0.0781965,-0.00427481,-0.272949,-0.193309,0.681899,-0.0591563,-0.126015,0.534793,-0.252518,-0.212713,0.103266,-0.299216,0.0528417,-0.00787361,0.208026,-0.153588,0.450664,0.117006,-0.506594,-0.125269,-0.0820447,0.092899,0.243238,0.304793,0.493192,-0.885998 +3459.28,0.923918,0.0848144,4,1.41317,0.860162,-1.33379,0.540099,0.264255,-0.263388,0.296596,-0.234158,0.910113,0.456943,0.208827,-0.388234,-0.217801,0.635412,0.165864,0.658484,0.381667,-0.226056,-0.0579401,-0.0257062,0.0273559,-0.657854,-0.89936,0.201415,-0.0887538,-0.27223,0.288682,0.469339,0.269551,0.129052,1.14311,-0.297607,-0.40021,0.475039,-0.280393,0.104719,-0.0544102,0.727387,0.574634,-0.340188,1.03727,0.456078,-0.0928384,-0.658386,0.247146,0.241238,-0.174697,0.387095,0.290448,0.0376269,0.597469,1.30462,0.409043,-0.764347,0.395044,0.254913,0.0880808,-1.13537,0.341027,-0.413195,0.182418,1.14942,-0.118541,-1.05304,1.00846,-0.078091,-0.0723021,-0.217294,0.36488,-0.561649,-0.191393,0.720281,0.376485,0.0934626,0.525821,0.220068,0.430317,0.386388,0.0405135,-0.0181439,0.118879,-0.0600183,0.263782,-0.0159567,-0.0408858,-0.125605,0.189638,-0.753645,0.277946,-0.425369,-0.249419,0.412756,0.209726,-0.0816699,0.181234,0.152483,0.724526,-0.414539,0.318343,0.0461358,0.39614,0.0525539,-0.544281,-0.533484,0.533654,-0.308471,0.26958,0.149673,-0.00268056,-0.0987177,0.329701,-0.195864,-0.255658,0.295522,0.0326915,0.140673,0.0170714,0.0619678,-0.366758,0.341402,-0.425823,-0.0922788,-0.0907789,-0.416862,-0.17325,0.795322,0.396736,0.249492,-0.141541,0.246277,-0.177839,0.0882874,-0.020423,0.502137,-0.263828,0.36783,0.115884,-0.028978,0.306449,-0.381057,-0.0437186,-0.0389656,-0.142913,-0.223881,-0.00924525,-0.167855,-0.143155,0.212176,-0.201857,0.04677,0.0108552,-0.302615,-0.104987,-0.0498951,-0.0608244,0.202194,-0.0374071,0.0223077,-0.378238,0.292997,-0.20924,-0.127287,0.630336,-0.10922,0.0296027,0.244916,-0.0365499,-0.234202,-0.211435,-0.235415,0.129234,0.231797,0.00170731,-0.537858,-0.111278,0.405061,-0.507634,0.225868,0.333171,0.712569,-0.0903699,0.312621,-0.247762,-0.147678,0.448508,0.0523066,-0.376131,0.0161331,-0.201609,-0.103769,0.161607,-0.0548421,0.306831,-0.465908,0.0966579,-0.066509,0.236222,-0.495205,0.43989,0.184382,-0.0256257,-0.142148,0.118334,-0.163814,-0.324458,-0.0609359,-0.298709,0.774899,-0.0563329,0.290264,0.108365,-0.148023,-0.153106,0.0919846,0.186872,0.0593429,-0.00970906,0.0859559,0.613919,0.662075,0.0644228,-0.273951,-0.0320262,-0.303343,-0.526769,0.458368,-0.0614317,-0.500362,-0.303255,0.0381275,-0.3232,0.107337,0.10706,-0.290797,-0.0940434,0.345171,0.136808,0.245375,0.229038,-0.435646,-0.199971,-0.0381319,-0.466346,-0.0743586,-0.0438959,0.0725458,0.421281,0.34768,0.322281,-0.268003,0.265326,-0.234586,0.613981,0.167178,-0.233198,0.377364,-0.205464,0.173543,-0.122032,0.207138,-0.369285,0.494827,-0.460706,0.0910462,0.363794,0.0754131,-0.180399,0.0589138,0.460056,-0.00946922,-0.606227,-0.171265,-0.339395,0.175117,0.719843,-0.40222,0.0204818,0.475966,0.0985786,0.247139,-0.0441995,-0.0515672,-0.0982373,-0.160927,0.547302,-0.0689027,0.0310522,0.327716,0.0108737,-0.0625562,0.094094,-0.314342,0.112506,0.0292509,0.18931,-0.205737,0.666979,0.263681,-0.303583,-0.213257,0.0027483,0.0973267,0.312778,0.311972,0.559265,-0.730395 +3462.56,0.657108,0.0848144,4,1.40523,0.862798,-1.35902,0.538096,0.290162,-0.264467,0.350728,-0.254435,0.811843,0.535846,0.167221,-0.399862,-0.177175,0.662179,0.0450088,0.684259,0.472856,-0.252139,-0.137999,-0.10139,0.0573789,-0.637042,-0.90258,0.288751,-0.100048,-0.274862,0.299094,0.404552,0.341171,0.116924,1.13414,-0.170465,-0.357493,0.454608,-0.249086,0.101682,-0.140504,0.690612,0.54682,-0.240683,1.10514,0.41076,-0.113634,-0.559511,0.168219,0.194385,-0.24831,0.30285,0.314155,0.139521,0.620573,1.23363,0.406041,-0.87285,0.425769,0.256033,0.0209161,-1.20821,0.332402,-0.429895,0.171992,1.21101,-0.134655,-1.05448,0.877594,-0.0682508,-0.141329,-0.225086,0.202754,-0.631496,-0.305439,0.741183,0.374985,0.0513722,0.505967,0.270931,0.406592,0.323252,0.0811896,-0.0245657,0.0893488,-0.124301,0.198543,-0.0931463,-0.0422101,-0.016221,0.153367,-0.759888,0.261975,-0.459678,-0.271092,0.395538,0.220208,-0.058375,0.172531,0.237839,0.732086,-0.369956,0.246837,0.12799,0.287138,0.02252,-0.522897,-0.562846,0.504906,-0.414696,0.196458,0.16728,-0.0582893,-0.122753,0.360854,-0.211314,-0.195595,0.314213,-0.0131628,0.0702499,-0.0379589,0.0617746,-0.374439,0.294629,-0.435876,-0.114899,-0.0762658,-0.48098,-0.217486,0.845817,0.275276,0.173368,-0.170998,0.276809,-0.034262,0.119117,-0.0310646,0.494627,-0.171986,0.39023,0.142905,-0.0549507,0.282052,-0.347728,-0.00249049,-0.0102411,-0.172713,-0.273472,-0.00510361,-0.104888,-0.131753,0.164254,-0.218736,0.0699665,0.0141401,-0.314644,-0.150343,-0.0375461,-0.0485408,0.0970421,-0.10325,-0.00649275,-0.417295,0.311422,-0.108514,-0.125667,0.570495,-0.101818,0.050549,0.178913,-0.096803,-0.177696,-0.196698,-0.148978,0.131947,0.21246,-0.00777258,-0.553036,-0.121178,0.39759,-0.530603,0.251121,0.299601,0.666184,-0.0754025,0.335663,-0.205166,-0.158254,0.453626,0.048199,-0.450578,-0.0323424,-0.247579,-0.0921253,0.124653,-0.0478662,0.254519,-0.439957,0.119597,-0.0469328,0.184696,-0.491708,0.398632,0.113215,0.00330613,-0.107916,0.0635968,-0.206388,-0.312822,-0.113258,-0.278182,0.739858,0.114388,0.278508,0.139433,-0.124937,-0.153008,0.108129,0.156095,0.0610176,0.0174351,0.0499918,0.561868,0.622373,0.0655559,-0.287103,0.00786757,-0.314742,-0.568779,0.430443,-0.0912987,-0.396336,-0.192326,0.0853996,-0.320396,0.103518,0.112147,-0.291679,-0.156811,0.378205,0.146153,0.145181,0.184647,-0.492508,-0.234503,-0.00368389,-0.439898,-0.0684696,-0.0405428,0.0888991,0.518133,0.391713,0.328694,-0.205851,0.430574,-0.22455,0.619379,0.1695,-0.143821,0.312584,-0.280725,0.194603,0.00148005,0.243111,-0.287052,0.417069,-0.507217,0.116367,0.425817,0.16081,-0.176152,0.044626,0.538324,-0.0374306,-0.529919,-0.0907064,-0.275181,0.179442,0.662086,-0.347629,0.0747613,0.422751,0.136249,0.280226,-0.0643167,-0.0974543,-0.0749639,-0.183582,0.58967,-0.025221,-0.0103968,0.243635,-0.075377,-0.00917548,0.0909726,-0.251527,0.1626,0.0623449,0.231758,-0.128827,0.670944,0.303762,-0.26959,-0.169256,-0.0472961,0.097066,0.317112,0.311554,0.563127,-0.813572 +3487.16,0.880786,0.0848144,4,1.57555,1.02812,-0.893702,0.218942,0.653213,-0.226681,0.382681,0.201772,-0.483746,-0.0101684,-0.0361179,-0.394378,0.0253676,0.119592,-0.493272,0.88248,-0.0376953,0.0980001,0.20595,-0.00522267,-0.606411,-1.16328,-0.638029,-0.112008,0.0560273,0.0314698,-0.071608,0.0119192,-0.522317,-0.128825,0.827244,-0.254492,0.255666,-0.0381689,-0.146006,-0.250491,-0.834494,0.364922,0.570413,-0.35218,0.941048,0.525747,0.139446,-0.868328,-0.230101,0.187773,-0.250983,0.363597,0.574887,0.483594,0.0367354,0.396535,-0.247261,-0.0215325,0.569487,-0.302266,-0.00711,-0.538168,0.722352,-0.124517,0.167472,0.799961,-0.366862,-0.895947,0.281561,0.15412,0.486469,0.40644,-0.0420064,-0.269322,0.17802,-0.206237,0.583145,0.0813528,0.275545,0.422342,0.107002,-0.210222,-0.577928,-0.167639,0.22854,-0.741079,0.0858173,-0.125161,0.116747,-0.0348347,-0.108058,0.168883,-0.083409,-0.360798,0.274949,-0.238311,0.0139275,-0.190999,-0.0839277,-0.153939,-0.359009,0.0705036,-0.109786,0.173391,-0.166765,0.275458,-0.0441224,0.294967,-0.332188,0.246691,0.193955,-0.587434,0.0362182,0.563898,-0.452597,-0.0823184,0.155217,0.516934,-0.155927,-0.399349,0.0123803,0.0653667,0.630506,-0.231736,-0.479987,-0.185702,0.218398,-0.138412,-0.125296,-0.366528,0.249214,0.0519079,0.219493,-0.635391,-0.035147,-0.258643,-0.131228,0.352793,-0.0135284,-0.244669,-0.132011,-0.00436085,0.104879,-0.37339,-0.130117,0.00315596,-0.154517,-0.197974,0.117896,0.501073,0.0086919,0.399524,-0.355058,-0.215032,-0.139165,0.588502,0.201512,-0.00611256,0.665009,0.383267,0.196722,0.0521065,0.155345,-0.117649,0.378741,-0.163576,0.522451,0.271291,-0.0503036,-0.215767,-0.131809,-0.158118,-0.232182,-0.0976284,-0.0408435,-0.156279,0.0258716,0.259061,-0.141961,-0.0534664,-0.139969,-0.45949,-0.0258104,0.46087,-0.110062,-0.0361803,0.178757,-0.209432,-0.283886,-0.267589,0.0763402,-0.311358,0.604481,-0.235012,-0.133653,0.084386,-0.152352,-0.549041,-0.252285,0.0681248,0.115757,-0.0880101,-0.602938,0.00705896,-0.0344964,-0.193833,0.0647824,0.178156,0.209408,-0.00777489,-0.0570139,0.549254,-0.241293,-0.124653,-0.0774264,-0.312586,0.357666,0.201625,-0.599686,0.120661,-0.182574,0.153813,0.117813,-0.320898,0.168211,-0.376802,-0.0634017,0.286966,0.227573,0.0415877,-0.689139,-0.126854,0.187994,0.290627,0.353525,0.054041,-0.331401,-0.075718,-0.0576728,0.274149,-0.0368481,-0.0546355,0.604784,0.083609,0.0542713,-0.163289,0.194849,0.0661712,0.362897,-0.0212542,0.225595,0.161725,-0.301672,-0.0435462,-0.0557307,-0.0177828,-0.0497332,-0.206404,-0.297093,0.3052,0.0334755,0.145121,0.555156,0.0847343,0.0977609,0.114248,0.53878,0.595736,-0.268956,0.265221,0.0129047,-0.389637,-0.339725,0.429522,0.141621,-0.104149,-0.103534,0.0619939,-0.450155,0.0673534,0.408432,0.114981,0.555086,-0.0373868,-0.25729,0.116521,-0.26236,0.214499,-0.139704,-0.126706,-0.224531,0.0137818,0.471169,-0.23374,0.316496,0.516008,0.126695,0.343283,-0.202284,-0.427022,-0.078519,-0.335933,-0.0808836,0.166793,-0.0856786,0.0832564,0.221027,0.288542,0.470135,-2.09204 +3475.67,0.705272,0.0848144,4,1.61117,0.971202,-0.720486,0.258288,0.0040792,-0.088297,0.0792459,-0.202249,0.706843,0.499871,-0.126747,0.0198388,-0.0709808,0.526503,0.1977,0.690366,0.135687,-0.026804,-0.455748,0.0510504,-0.267073,-0.842826,-0.624532,-0.0776923,-0.323987,-0.177207,0.220059,0.166509,0.00142887,-0.110657,0.770172,-0.493501,-0.266198,0.141221,-0.551262,-0.0725314,-0.184892,0.679993,-0.0276094,-0.357253,0.89263,0.511389,-0.239221,-0.246559,-0.0857249,-0.344635,-0.35673,0.168546,0.042348,-0.244511,-0.0345964,-0.0515547,0.00565827,-0.563083,0.512541,-0.137698,-0.107854,-1.18731,0.149195,-0.461442,0.221817,0.594882,-0.512011,-0.778573,-0.321818,0.0309156,-0.228158,0.0637215,-0.466266,-0.398382,-0.251796,0.573998,0.502572,-0.197597,0.478448,0.373007,-0.00649666,0.0138662,-0.0120789,-0.0615225,0.503938,0.177263,0.335342,0.0573095,-0.306483,-0.136025,0.168635,-0.345554,0.223235,-0.326328,0.182021,0.402097,-0.145042,0.203194,-0.502312,0.292876,0.131923,-0.115577,0.27585,0.23951,0.139372,-0.0171835,-0.624894,-1.20046,0.289582,-0.72458,0.0607212,0.0276212,-0.217597,0.57556,0.188687,-0.216774,-0.0147291,0.254803,-0.239603,-0.0511366,0.115931,0.203468,-0.285638,-0.122769,0.101024,0.16373,-0.356883,0.123507,0.0127862,0.28073,0.2605,0.0209248,0.0608539,-0.0891715,0.130954,0.435001,0.190734,0.452556,-0.410551,-0.0137239,0.222183,-0.663831,0.296726,-0.0679642,-0.174162,0.0551259,0.186085,-0.562016,0.119319,0.276857,-0.0767065,-0.0826393,-0.0611356,0.164244,0.367431,-0.32969,0.0174275,0.0611712,-0.222957,0.203577,0.0779225,-0.344561,-0.0340744,0.0661652,0.576847,-0.18182,0.402081,-0.0420695,-0.188307,-0.0265288,-0.130658,-0.142105,0.00694155,0.249541,0.029673,-0.126775,-0.100418,-0.0439073,-0.0709511,-0.0473404,-0.206703,0.240122,0.197085,0.872294,-0.260541,-0.405549,0.53605,-0.473517,0.0951505,-0.318097,-0.201939,-0.295968,-0.358298,-0.0831845,0.100294,-0.0215351,0.0377511,-0.337213,-0.0816011,0.341205,-0.216845,-0.290069,0.0876966,0.138026,0.017718,-0.360714,0.222748,-0.158836,0.0585107,0.0380874,-0.239157,0.921358,-0.211956,-0.147132,0.0929912,-0.0157067,0.202968,0.059657,0.115365,0.186262,-0.00696613,0.114012,0.0849263,0.181025,-0.397099,-0.377458,0.135704,-0.262275,-0.909457,0.568518,-0.0802594,-0.121166,-0.339295,0.401994,-0.622713,0.0592937,0.146285,-0.288709,0.174321,0.484553,-0.0222643,0.130566,0.630158,-0.422544,-0.194673,0.52216,-0.0743303,-0.0520421,0.237969,0.366772,0.287624,0.070577,0.192736,-0.307566,0.0284028,-0.58358,0.733058,-0.0749175,-0.16193,-0.0653641,-0.355226,0.0816595,-0.399241,0.0171783,-0.0345722,0.129516,-0.500268,-0.199664,0.404466,0.408288,-0.246332,0.370109,0.495098,-0.105065,-0.255506,-0.0584954,-0.390236,0.174889,0.409917,0.0817145,-0.392179,0.193292,0.00192911,-0.240018,-0.0633875,-0.122731,-0.458578,-0.131251,0.189849,0.315044,0.157118,0.184914,-0.0448436,-0.132936,-0.175121,-0.146944,-0.270147,-0.33241,0.174991,-0.138936,0.252949,0.00506441,-0.508603,-0.111839,0.123102,0.0966796,0.14008,0.310933,0.374272,0.0362636 +3464.26,0.914418,0.0848144,4,1.65732,1.00484,-0.856533,0.31302,0.189923,-0.124136,0.24855,-0.154104,0.673752,0.147206,-0.0457502,-0.0322453,-0.318427,0.461852,0.11248,0.729779,-0.0706291,-0.04667,-0.548903,0.0474251,-0.20078,-0.922016,-0.611109,0.0757478,-0.218302,0.0168141,0.0587802,0.128957,-0.0642625,-0.0142848,0.688112,-0.294755,-0.114634,0.258069,-0.627868,-0.324123,-0.707298,0.213345,0.0602548,-0.10047,0.879385,0.43496,-0.324922,-0.354391,0.245243,-0.477971,-0.189982,0.0551302,0.184687,0.0325259,0.039997,0.0779258,0.0438845,-0.513684,0.391012,-0.565342,0.00365536,-0.969218,-0.0265017,-0.259998,0.0789291,0.614722,-0.293704,-0.56647,-0.123837,0.113195,-0.00835682,-0.205918,-0.614302,-0.375193,-0.618252,0.0511791,0.484284,0.170311,0.344661,0.499896,0.307921,0.0726927,-0.035371,-0.107571,0.509538,0.303531,0.0884539,0.232516,-0.194433,-0.395154,0.406035,-0.275966,0.0900548,-0.338539,0.317242,0.303922,-0.251625,0.238121,-0.402673,-0.0807762,-0.135697,-0.00467162,0.247136,0.480231,0.109835,-0.0197962,-0.765189,-0.599944,0.0744625,-0.527918,-0.158493,-0.1064,-0.225405,0.337382,0.22642,-0.357991,0.105702,0.191318,-0.125126,0.26018,-0.0940866,0.234457,-0.19017,-0.0689078,-0.0481014,0.287486,-0.595799,-0.0488526,0.0717669,0.333632,0.164598,0.199571,0.0793599,-0.0870632,-0.0346908,0.0255473,0.0932456,0.428884,-0.3645,-0.043166,0.0466614,-0.647751,0.120386,0.0402275,-0.497345,0.0973741,0.0783366,-0.397833,0.284317,0.378483,-0.111605,-0.0309007,-0.265314,-0.0236454,0.465955,-0.0771946,0.175592,-0.18742,-0.189315,0.387191,0.175905,-0.0726831,-0.286742,-0.171406,0.623771,-0.591101,0.459196,-0.0592756,-0.630564,0.145727,-0.0979075,-0.113718,-0.17656,0.321446,0.0257179,0.291464,-0.211725,-0.00762322,-0.276277,-0.519666,-0.333264,0.38796,0.273773,0.87735,-0.264715,-0.386334,0.434102,-0.065243,-0.249091,-0.387176,-0.145112,-0.454361,-0.00301938,0.152078,-0.412776,-0.350584,0.21596,-0.470572,-0.0847755,0.34684,-0.35777,-0.419605,0.00476537,0.130956,-0.0305498,0.0819237,0.0514514,-0.158817,0.259835,-0.290172,-0.218134,0.744114,-0.0883039,-0.255181,0.328099,-0.00777322,0.230546,0.16733,-0.344358,0.179057,-0.0419761,-0.0882791,0.100076,0.294696,-0.517599,-0.259954,0.0310501,0.00969186,-0.768327,0.79388,-0.0789404,-0.379415,-0.461297,-0.0530885,-0.43345,-0.0486206,0.160792,-0.398859,-0.101125,0.653411,0.108712,0.159723,0.677283,-0.39579,-0.303109,0.555119,-0.0395492,0.214751,0.296772,0.472877,0.236386,-0.441675,0.186515,-0.241599,-0.00378247,-0.392929,0.582786,-0.274839,-0.363647,-0.180497,-0.274709,0.191821,-0.244807,0.205201,0.0351522,-0.165147,-0.104932,-0.0993819,0.68212,0.142803,-0.18816,0.354463,0.307117,-0.17052,-0.32696,0.0667619,-0.335591,0.083836,0.162347,0.288038,-0.426215,0.456771,-0.15904,0.0900027,-0.0593296,0.2402,-0.165132,-0.345507,-0.0300591,0.292255,0.132837,0.0271609,-0.108896,-0.382181,-0.0478761,0.209878,-0.266049,-0.0710742,0.169474,-0.0627868,0.37919,0.0949247,0.0229027,-0.341337,0.337065,0.095093,0.152668,0.308372,0.390727,-0.565491 +3466.83,0.777442,0.0848144,4,1.67251,0.972382,-0.777397,0.255997,0.293061,-0.170603,0.445493,0.067891,0.200117,0.23954,-0.110997,0.028597,-0.0283309,0.476365,-0.0875179,0.773347,-0.194654,0.263965,0.0766241,-0.0597721,-0.417177,-0.743812,-0.720018,-0.277853,-0.15478,0.0459379,0.115141,0.398901,-0.0483447,-0.10452,0.603431,-0.10148,-0.259894,0.152315,-0.738578,-0.309366,-0.183059,0.642886,0.0301872,-0.545721,0.965703,0.412627,0.0300717,-0.459055,0.196278,-0.570645,-0.23119,-0.351473,0.189463,-0.0653342,0.269901,0.432613,0.142447,-0.319654,0.720401,-0.0772024,-0.0522641,-0.684654,0.190901,0.105965,0.150266,0.585983,-0.423861,-0.675205,-0.0415921,0.0340046,-0.296818,-0.139041,-0.712266,-0.232885,-0.646139,-0.310947,0.152166,-0.0090265,0.692117,0.46694,0.213669,0.157528,-0.16168,0.0741653,0.559889,0.251427,0.407926,0.0582604,-0.23536,-0.365385,0.143583,-0.37388,0.182647,-0.349132,-0.0754345,0.442801,-0.267767,0.339555,-0.509658,-0.0753247,-0.301311,0.093219,0.0137324,0.38944,0.11306,0.121397,-0.712436,-0.544328,0.184469,-0.374819,-0.0887819,-0.0783219,-0.0761981,0.624634,0.606114,-0.246511,0.332718,0.197315,0.209726,0.295572,0.095767,0.0556703,-0.0224953,0.053058,-0.060682,0.118839,-0.458966,0.00103687,-0.00750173,0.402652,0.325186,0.405568,0.110954,-0.0635503,0.12494,-0.0208963,-0.0790823,0.199955,-0.10139,-0.173445,-0.0406357,-0.38001,0.407974,-0.244047,-0.313554,-0.0286903,-0.165399,-0.371501,0.0368621,0.0736677,0.0209438,0.351863,-0.279036,-0.284003,0.470645,-0.0959904,0.302763,-0.216093,-0.0192731,0.529074,-0.264926,-0.365732,-0.234851,-0.225269,0.219948,-0.487908,0.229313,0.0743192,-0.379961,-0.0824734,0.0564694,-0.301775,-0.164627,0.317576,0.0864603,0.106338,-0.236245,-0.0127256,-0.384405,-0.440882,-0.562105,0.249644,0.239214,0.717674,0.0364945,-0.859924,0.322195,-0.0637617,-0.329189,-0.609317,-0.278201,-0.352521,0.0600974,0.0571174,-0.256561,-0.298318,0.0411052,-0.313064,-0.319183,0.367497,-0.398718,-0.3098,-0.106916,0.131052,0.0954592,-0.31317,-0.0621261,-0.0625194,-0.174227,-0.292707,-0.228818,0.907069,0.0128693,0.12489,0.23833,-0.100428,0.226162,-0.0255448,-0.356925,0.266551,-0.236001,-0.0777381,-0.0103941,-0.188583,-0.349741,-0.438991,0.0356311,0.00203739,-0.351424,0.345021,-0.0647054,-0.0418169,-0.533131,0.129631,-0.446991,-0.167758,-0.125522,-0.487348,-0.286807,0.563549,0.131623,0.471124,0.40895,-0.503057,-0.458804,0.175771,0.167005,0.315845,0.213613,0.514771,-0.0121087,-0.0304204,0.0275147,-0.205128,-0.00312231,-0.216559,0.550566,-0.580527,-0.396875,-0.0414682,-0.264126,0.206811,-0.644436,0.191633,0.246983,-0.451873,-0.148512,-0.281331,0.449161,0.203898,-0.17831,0.33172,0.45047,-0.0219083,-0.114859,-0.186059,-0.285378,0.268042,-0.0144294,0.372777,-0.242726,-0.00107055,-0.371053,0.255846,-0.36504,0.109832,-0.238559,-0.128214,0.0698498,0.441993,0.0232253,0.116691,-0.084364,-0.133617,-0.079074,0.0333191,-0.280229,-0.258275,0.373002,-0.20587,0.30492,0.26312,-0.0225507,-0.199786,-0.156495,0.106594,0.16403,0.326487,0.405006,-0.811189 +3447.78,0.831588,0.0848144,4,1.59135,0.966124,-1.00782,0.350697,0.154785,-0.118722,0.269105,-0.0313766,0.0409688,0.259294,-0.28249,-0.0836268,0.291198,0.391436,-0.123441,0.329908,-0.214024,0.0932267,-0.387178,0.0496479,-0.459931,-0.961187,-0.697765,0.129626,-0.0951029,-0.258916,0.0958197,0.329859,0.291989,0.0766792,0.687777,-0.4069,-0.546465,0.239541,-0.811648,-0.296813,-0.368263,0.793183,0.421782,-0.319101,1.12655,0.609497,-0.0366236,-0.602792,-0.17735,-0.109043,-0.157483,0.00273719,0.28337,0.183101,-0.137255,0.564071,-0.0883376,-0.44136,0.50361,-0.0872017,-0.0619212,-0.60653,0.203398,-0.296924,0.0573781,0.477028,-0.340676,-0.506864,0.00651959,0.332419,0.177801,-0.327793,-0.020042,-0.312094,-0.684275,-0.264863,0.523848,0.199295,1.0053,0.832706,0.267971,-0.0580721,-0.172517,0.178205,0.347354,0.142962,0.0571232,-0.0073446,-0.3279,-0.138085,0.117333,-0.558057,0.448262,-0.176734,0.180251,-0.0812284,0.33732,0.185177,-0.0326169,-0.365563,-0.148607,0.35711,0.349584,-0.103722,0.0647858,0.217988,-0.692938,-0.526217,-0.501914,-0.221787,0.026283,0.175542,0.0430986,0.541062,0.524132,0.353141,0.0433778,0.285768,0.734004,0.278478,-0.179203,0.0163394,0.108479,0.00296626,0.162821,-0.353578,-0.676795,0.246834,-0.427404,0.17904,-0.185973,0.593099,0.0094354,0.134523,0.161794,-0.227657,-0.455196,0.321548,-0.0379914,-0.287889,0.00524181,-0.480784,0.404506,-0.14741,-0.702903,0.16881,-0.129749,-0.435533,-0.209977,-0.0291984,-0.236573,0.125821,0.179139,-0.664638,0.248107,0.00771555,0.438203,-0.0407779,0.221259,0.674607,-0.784226,-0.171151,-0.230154,0.0908879,0.381478,-0.20352,0.590485,-0.27764,-0.198992,0.1942,-0.100999,-0.288733,0.04192,0.00730657,-0.0258998,-0.0901603,-0.226879,-0.120526,-0.233274,0.017721,-0.485429,-0.187091,0.140524,0.632474,0.0324652,-0.48604,-0.176295,-0.508186,-0.596151,-0.341173,0.0157719,-0.0777836,-0.313035,-0.327866,-0.115236,-0.0413498,0.0710145,0.118389,-0.463934,0.741205,-0.202676,-0.213613,-0.266973,0.288289,-0.2439,-0.111337,0.0213163,-0.41502,-0.353401,-0.233647,-0.55682,0.850079,0.176969,0.118803,0.0217622,0.161912,0.223951,-0.0253322,-0.043108,-0.105906,0.116522,0.0118847,-0.234325,0.0497324,-0.269322,-0.381422,0.0449607,-0.13384,-0.206463,0.357757,-0.0970518,-0.278107,-0.230033,0.3098,0.346702,-0.381579,-0.187111,-0.355092,-0.0605535,0.530219,0.131287,0.259471,0.453769,-0.321466,-0.100149,0.354003,0.0465771,-0.0294995,0.214629,0.142609,0.166365,0.268464,-0.0691269,-0.118742,-0.443343,-0.563777,0.494617,-0.76969,-0.464713,0.179274,-0.584686,-0.0400986,-0.119573,0.175797,0.23442,-0.0954339,-0.100203,0.113255,0.363337,0.247599,-0.447232,0.0870415,0.365282,-0.192664,-0.0471238,-0.0530482,-0.184577,-0.00615745,-0.291452,0.0268871,0.125966,0.116296,-0.178219,0.0375186,-0.413942,0.589566,-0.325396,0.625621,0.104707,0.105535,0.26384,0.178281,0.155881,-0.0628665,-0.347249,0.088397,-0.10692,-0.0496663,0.27289,-0.204726,0.287504,0.0763537,0.103395,-0.0716083,-0.196696,0.092036,0.154272,0.303374,0.392774,-0.403952 +3455.56,0.973956,0.0848144,4,1.66514,0.889212,-0.786597,0.1918,-0.247171,-0.014568,0.429606,0.658406,-0.0277987,0.112934,-0.0920507,-0.342582,0.116068,0.477399,0.122042,0.758092,-0.00243278,0.165095,-0.141239,0.0886914,-0.191195,-0.730064,-0.706187,0.0878073,-0.0450497,-0.101468,-0.0556422,0.418711,-0.0540897,0.0680148,0.708815,-0.349711,-0.270229,-0.10642,-0.670328,-0.0296406,-1.05215,0.4149,0.0813934,-0.323196,0.751164,0.95006,0.206493,-0.544061,0.190595,-0.146155,-0.614599,0.40435,0.582755,-0.0421901,0.0464872,0.554178,-0.169286,-0.659259,0.758072,-0.0747338,-0.0507633,-0.469905,0.127961,0.0336548,0.55623,1.02791,-0.407902,-0.813464,0.211843,0.1558,0.0469929,-0.757607,0.235684,-0.510264,-0.0734171,0.413862,0.576475,-0.122387,0.68677,0.480384,0.064089,0.110746,-0.0492665,-0.1297,0.687333,-0.468564,0.0941629,0.0623124,-0.219232,-0.38043,0.329943,-0.256819,-0.203089,-0.261005,0.668527,-0.0121359,-0.0223571,0.199543,0.402869,0.0726657,0.0745891,0.07393,0.191303,0.64616,-0.324029,-0.135875,-0.211204,-0.501082,0.240476,-0.230386,-0.0354209,-0.120218,-0.115709,0.685123,-0.181308,-0.0434831,-0.0163043,0.239347,-0.0837249,-0.123468,-0.0151252,0.188283,0.107583,0.175466,-0.12223,-0.0122548,-0.204894,-0.0996119,-0.161111,0.113718,-0.223279,-0.188207,-0.04698,-0.107889,-0.20436,0.12684,-0.374192,0.207889,-0.234613,-0.0939457,-0.0391887,-0.268206,0.373933,-0.685052,-0.330323,-0.100338,-0.140368,-0.0896097,0.0334402,-0.696981,0.0679673,-0.0550201,-0.137064,-0.343414,-0.0531196,-0.160726,0.11831,-0.472742,0.470133,0.75237,-0.599035,-0.0667399,-0.0394089,-0.108063,0.693866,-0.0197059,0.443176,0.0933582,-0.284232,0.0440738,-0.248945,-0.0279737,-0.142242,-0.16975,-0.0954248,0.334696,-0.0611567,-0.0154341,-0.379869,-0.274253,-0.175469,-0.0643609,-0.167691,0.231801,0.296437,-0.340082,-0.147751,0.577717,-0.376853,-0.707473,-0.186696,-0.257568,-0.322949,-0.38242,0.115928,-0.312179,0.0493663,-0.103106,-0.485385,-0.213197,-0.0789487,-0.418074,-0.00487525,0.363351,0.0858731,0.0703315,0.401925,-0.482907,-0.106507,-0.371516,-0.414317,0.811673,0.231167,0.435524,-0.0549358,0.339144,0.052257,0.184021,-0.575042,0.117547,0.00803544,0.360637,-0.0220672,0.198941,0.0280511,-0.634318,0.269968,0.0479087,-0.186311,0.345727,-0.0938935,0.251241,0.219508,0.383675,-0.144843,0.0983685,-0.34933,-0.577503,-0.223508,0.458902,-0.338028,-0.220511,0.505513,-0.408712,0.314764,0.533246,-0.0504365,0.157919,-0.391834,-0.0208192,0.704954,0.306406,-0.19126,-0.30389,0.382018,-0.567827,0.598738,-0.587086,-0.433209,-0.277617,-0.00634165,-0.229389,0.0588271,-0.025608,0.273069,-0.118452,0.232208,0.254331,-0.337895,-0.107443,0.0192224,-0.00766303,-0.00135695,-0.30551,0.111344,-0.370133,0.0306563,-0.347782,-0.360286,-0.0284383,-0.0193809,-0.15899,-0.00486296,0.00808791,-0.327283,-0.290381,0.250421,-0.15453,-0.0893402,-0.347497,-0.0723098,0.00169373,-0.0140414,-0.202734,-0.115265,0.420838,-0.156712,0.0152926,0.0567276,-0.52614,-0.408271,-0.271851,-0.357417,0.0670562,0.131357,0.107719,0.305363,0.328205,0.552597,1.14865 +3445.73,0.915882,0.0848144,4,1.55584,1.04701,-0.931222,0.239259,0.284227,-0.328335,-0.474342,-0.328647,0.71929,0.471504,0.0498338,0.0702066,-0.579462,0.302409,-0.29264,0.680543,-0.174686,-0.103639,0.0713725,0.274844,-0.206714,-1.14332,-0.646521,-0.227951,-0.439604,-0.0404257,0.29548,0.529315,-0.205232,-0.467735,0.490265,-0.403536,0.0686021,-0.0405439,-0.16612,-0.0824036,-0.187312,0.591169,0.607744,-0.132894,1.26129,0.44641,0.23456,-0.741945,-0.454254,0.178324,-0.396639,0.177553,0.403023,0.138045,0.282444,0.0919399,0.751209,0.115437,0.407552,-0.048342,0.294408,-0.50788,0.236073,-0.421768,0.134326,1.07122,-0.637722,-0.570201,-0.0419245,0.22977,-0.0637588,0.595252,0.0821013,-0.170809,-0.228179,0.223321,0.481596,0.232966,0.546211,0.508143,0.193543,-0.106398,-0.639041,0.0355308,0.24375,0.119441,0.174468,0.0699806,-0.0614461,0.204682,-0.702128,-0.233262,0.291657,-0.457978,-0.340547,0.0482472,-0.231449,-0.0126377,-0.349969,-0.345235,0.152941,-0.504132,-0.157111,-0.0816597,0.325341,0.199169,-0.460589,-0.0153475,0.0744557,-0.470989,0.235784,-0.168498,0.368845,0.102239,-0.175932,-0.587809,0.390202,0.4855,-0.0244628,-0.21049,-0.464058,0.0428534,0.460419,-0.397318,-1.05086,-0.434939,-0.227529,-0.00667176,0.1033,-0.0322897,0.376024,0.122771,0.405106,-0.579727,0.650469,-0.170139,0.267662,0.858226,0.307173,-0.393267,-0.367365,-0.212846,-0.0342983,-0.287929,-0.0918195,0.0430574,0.210816,-0.713841,-0.192041,0.240955,-0.159069,0.608587,0.00956493,-0.000328251,0.0502794,0.0849329,0.368649,0.451002,0.523669,-0.241614,0.518334,0.0367195,0.116337,-0.0624543,-0.291159,0.136668,0.598074,0.000392745,0.377215,0.595133,0.165573,-0.249016,-0.217846,0.272064,-0.166265,-0.600552,-0.0162523,-0.377149,-0.354078,-0.270348,-0.140295,0.0272095,0.340937,0.914107,-0.170488,0.328135,0.530661,-0.637288,0.0182104,0.262287,-0.169646,-0.201068,0.360575,0.109614,-0.0596549,0.0161808,0.168175,-0.26766,0.345798,0.145636,-0.225513,-0.354133,-1.02289,-0.101326,-0.223379,-0.414499,-0.251293,-0.264928,-0.258454,0.115517,-0.0203139,0.949911,-0.268041,-0.0968455,-0.211814,-0.181698,0.151132,-0.173347,0.415324,0.36586,-0.475694,-0.0877954,0.305831,-0.536732,0.030711,-0.384864,-0.533155,0.42249,-0.604017,0.343932,-0.454586,-0.602293,0.0997882,-0.604188,-0.241221,0.0210506,0.0949074,-0.101402,-0.363133,0.455572,0.247091,0.275322,0.129069,-0.303658,-0.428353,-0.0186677,0.186921,-0.322383,0.843602,0.316829,0.126074,0.0387982,0.290224,-0.218535,-0.149267,-0.197265,0.562417,0.0844419,0.213899,0.415197,-0.458798,0.37806,-0.187287,0.200823,0.115388,0.162429,0.0141517,-0.50193,0.53388,0.736993,0.213838,0.102065,0.00449793,0.255824,0.107895,0.200532,-0.345426,0.466645,0.263318,-0.0683078,0.107174,0.140469,0.149447,0.305521,0.103973,0.0197749,-0.836075,-0.0141402,0.34631,0.457929,-0.0104104,0.0835884,0.0393215,-0.381991,0.313853,0.0527564,0.0259638,0.355343,0.0863192,-0.0481169,0.23691,0.140435,0.20007,-0.137324,0.0441687,0.12996,0.158125,0.3605,0.397649,-0.894335 +3419.31,0.969152,0.0848144,4,1.54218,1.09683,-0.601753,0.116597,0.443498,-0.0906034,0.10252,0.467729,-0.0900405,-0.0632661,-0.288132,-0.0158943,-0.523665,0.308115,0.00403282,0.643157,-0.216472,0.173728,0.0409605,-0.41736,-0.298749,-0.733103,-0.319119,-0.0673438,-0.32145,0.23654,0.337328,0.708439,-0.348875,-0.354996,0.452262,-0.709829,-0.0232062,0.200359,-0.349602,-0.350816,-0.326208,0.310603,0.296618,0.184318,1.07493,0.502594,0.477095,-0.841558,-0.00645045,-0.353222,-0.267712,0.0544761,0.270815,-0.0509048,0.337068,0.927143,0.28474,-0.275979,0.429734,0.0415499,-0.356634,-0.327902,0.530827,-0.340039,-0.158386,0.824403,-0.0111123,-0.737415,0.142864,0.644437,0.221854,0.361409,-0.313799,-0.662879,0.119268,0.361213,0.416555,-0.208137,0.618079,0.564295,-0.185281,0.205346,-0.160185,0.202797,0.494201,-0.401753,-0.0028634,0.557277,-0.708845,-0.0583689,0.382962,-0.105024,0.566466,-0.110469,0.484817,0.194166,0.0163293,0.0958831,0.277235,0.310669,-0.0631714,-0.188772,0.088069,0.0453044,0.430775,-0.490879,-0.219771,0.344665,0.172837,-0.228655,-0.0367799,-0.320725,0.301614,0.546432,0.0881372,0.0051134,0.615415,0.532498,0.468489,0.299434,-0.439561,0.0986412,0.221281,-0.0785933,-0.585713,-0.186351,0.251017,-0.388216,0.681602,-0.146239,0.470491,0.13151,-0.0655028,-0.328381,0.546559,-0.298213,0.0204626,0.66935,-0.184368,-0.707427,0.412353,-0.0419205,-0.20443,-0.517185,-1.06845,0.0885906,0.616809,-0.580391,-0.278238,0.27095,-0.0967039,0.933147,0.0711841,0.54748,-0.376787,-0.012785,-0.107391,0.270778,0.254874,0.347213,0.266686,0.149887,-0.458919,0.287439,-0.376909,0.57263,0.691179,0.0348066,0.232101,0.577897,0.148598,-0.370207,-0.499261,-0.514122,-0.203024,-0.690417,0.208674,0.389886,-0.17177,-0.0438347,-0.255716,0.697048,-0.0509425,0.392696,-0.877327,0.0471711,0.361808,-0.409961,-0.0846227,-0.247634,-0.703547,-0.235595,0.0818008,0.0412248,0.0477618,0.136644,-0.0584252,-0.665757,0.156815,0.302065,-0.0200301,-0.427136,-0.0706031,0.127465,-0.11902,-0.187919,-0.265496,0.326121,-0.134968,-0.084402,-0.122774,1.13585,0.850974,0.551728,0.251176,0.0778329,0.0236394,0.295127,0.0202744,-0.221731,-0.335192,-0.255278,0.670122,-0.419998,-0.211755,-0.428565,-0.123973,-0.0504981,-0.598059,0.391931,-0.312401,-0.357872,0.110497,-0.176607,0.0239361,0.344656,-0.54451,-0.4791,-0.414898,0.687446,-0.272028,-0.221227,0.843857,-1.04939,-0.00465189,0.493427,-0.137457,0.159554,0.192505,0.356635,0.396427,-0.685101,-0.295693,-0.469934,0.406121,-0.22864,0.494317,-0.2176,-0.280295,0.174873,-0.157791,0.140411,-0.505216,0.159481,0.0819739,0.476,-0.262475,0.0706235,-0.0711395,0.262215,0.0878201,0.132549,-0.205263,0.312044,-0.236269,-0.209303,-0.372314,-0.16896,0.258715,-0.455592,0.0388551,-0.302169,0.0405906,0.41217,0.50045,-0.17154,0.226001,0.276173,-0.0522331,0.454418,-0.419171,-0.0602007,-0.358222,0.0613677,0.287387,-0.431092,0.16001,-0.00651618,-0.0370791,-0.485159,0.20346,-0.101458,-0.00783032,-0.301095,0.100473,0.125142,0.20367,0.353754,0.451299,-1.64104 +3395.58,0.693986,0.0848144,4,1.59573,0.930204,-0.790819,0.242972,0.0773425,-0.201878,-0.23456,-0.0615282,0.269609,0.365279,-0.0723064,-0.545855,0.171301,0.394526,-0.400182,0.745137,0.0388928,-0.018633,-0.59665,0.133612,-0.446541,-0.764621,-0.712503,0.200012,-0.277449,-0.0130679,0.444173,-0.53587,-0.0305744,-0.396916,0.276926,-0.368327,-0.181549,-0.0528183,0.0358297,-0.149853,-0.266901,0.438976,0.349605,-0.641852,0.648568,0.181799,-0.038711,-0.575803,-0.555813,0.520302,-0.608993,-0.177012,-0.0925968,0.213468,0.104768,-0.290451,0.533332,-0.325071,0.20997,0.00374281,-0.240815,-0.917604,0.294937,-0.273123,0.365788,0.7708,-0.564372,-0.594124,0.0495738,0.249236,-0.758527,0.0734369,0.274652,-0.140332,0.0620178,0.279741,0.525166,0.0866712,0.354845,0.530232,0.0652184,0.238796,-0.636689,-0.168701,0.156724,0.0666214,0.193368,-0.249855,-0.294999,-0.478892,-0.579631,0.0219764,0.465154,-0.0973702,-0.104282,-0.0293854,-0.484495,-0.843778,0.198203,-0.377107,0.711671,-0.221639,0.251852,0.495497,-0.244199,0.357291,-0.287148,-0.542891,0.0887623,-0.994254,0.0230077,0.33416,-0.289589,0.405445,0.144434,-0.786347,-0.197791,0.76396,-0.811736,0.341926,-0.898977,0.573426,-0.0556945,-0.010754,-0.554323,-0.131481,-0.252281,0.0518223,-0.576642,-0.0777209,0.501869,0.454269,0.456989,0.160697,-0.0391359,-0.144883,0.0876976,0.190347,-0.0357916,0.387691,0.295973,-0.514914,0.763908,-1.07245,0.144226,-0.267267,-0.224026,-0.618492,-0.554005,1.10428,-0.253873,0.565372,0.294943,-0.38988,0.127842,0.312302,0.144876,0.037151,-0.28799,-0.32685,-0.0613461,-0.431734,0.338425,0.172253,1.04588,-0.279838,0.840864,-0.298323,-0.385404,0.19139,0.412996,-0.521657,-0.166135,0.130599,-0.328046,0.346008,0.383923,-0.604201,0.124519,0.498814,-0.26293,-0.988164,0.29281,0.892091,0.261613,-0.260514,-0.184712,0.20097,0.0973166,-0.497283,-0.109842,-0.454644,0.0717249,-0.0537082,-0.302473,-0.0302616,-0.257133,-0.382418,-0.0837727,0.468999,0.00573427,-0.293,-0.824893,0.048487,-0.12562,-0.291789,0.241062,-0.699594,0.435938,0.0912445,0.0682958,1.39298,0.0247187,-0.1523,0.0247711,-0.623152,0.348036,0.215115,0.144873,0.65862,-0.177866,0.453032,0.0898062,-0.0272668,0.746008,-0.225098,0.0254632,0.577895,0.193525,0.889998,-0.381663,-0.307721,0.12275,-0.194444,-0.124199,0.418397,-0.469817,0.537765,-0.0269711,0.622949,0.0284715,0.313414,0.0942213,0.1776,-0.602213,-0.845831,0.393269,0.208005,0.82782,0.201831,0.3463,0.836552,0.00711053,-0.0632511,-0.619591,-0.626922,0.435551,-0.272074,0.00469954,0.299401,-0.305153,-0.0445678,0.285971,-0.113785,0.407534,-0.272002,0.0838015,0.284526,-0.0148286,0.446482,0.62064,0.152835,0.415233,0.230582,-0.335037,-0.387108,-0.581515,-0.092023,0.0156669,-0.343636,0.273684,-0.232961,-0.156201,-0.141226,-0.281492,-0.308312,-0.276397,0.326203,0.254688,-0.149022,0.266271,-0.167974,-0.143627,-0.572995,0.42355,0.254111,0.057622,-0.0415492,-0.268163,0.00351384,0.0749471,0.233747,-0.519103,0.276356,-0.250324,0.141176,0.160338,0.375735,0.400422,-0.0700345 +3397.95,0.949463,0.0848144,4,1.53308,0.791637,-1.02756,0.423404,0.817988,-0.0385781,-0.345434,0.174311,-0.273908,-0.341502,0.0712996,-0.219808,-0.492356,0.186109,0.141214,0.65298,-0.0274276,-0.0963587,-0.12589,0.128377,0.190041,-0.816942,-0.537529,0.350515,0.0215434,-0.182464,0.367165,0.163723,-0.358877,0.0161927,0.599738,-0.0283935,0.0879056,0.728001,0.0370424,-0.151015,-0.0220686,0.831714,0.421978,0.368768,0.611249,0.526367,0.0898237,-0.744496,0.0531131,-0.193758,-0.0841177,-0.0212401,0.229944,0.403267,-0.308745,0.709444,0.473015,-0.242755,0.49454,-0.0597685,-0.406632,-0.453349,0.653209,-0.563923,-0.136204,0.698963,-0.528725,-0.44627,0.350728,0.236117,0.262599,0.549173,-0.0148615,-0.172009,0.194794,0.694227,0.489836,0.184653,0.731535,0.560435,0.616133,0.449226,-0.387184,0.0546236,0.802047,-0.742838,0.0999252,-0.0422399,-0.398442,-0.186522,-0.512139,0.217823,0.368668,0.347056,-0.265809,-0.0439242,0.113147,-0.136023,0.561136,-0.624956,0.0861226,-0.358032,0.300049,0.433703,-0.245119,-0.381731,-0.068442,0.0443073,-0.120758,-0.881781,0.107596,0.0168359,-0.286078,0.912728,-0.157286,-0.53479,-0.489454,0.604727,-0.708086,-0.285994,-0.215768,-0.351543,0.10553,-0.725296,-0.372958,0.236877,-0.202026,-0.432857,-0.0653037,0.332882,0.899014,-0.19901,0.193564,-0.80187,0.0494221,0.23744,-0.307443,0.477243,-0.0999349,-0.182154,-0.174861,-0.12989,0.32848,-0.0443155,-0.697924,-0.0305278,0.3302,-0.484763,-0.265314,0.655924,-0.367987,-0.090545,0.0138039,-0.215976,-0.366301,-0.348509,0.289011,-0.441932,-0.256592,0.128941,0.161059,-0.694983,0.3759,-0.138552,0.571693,-0.182727,1.2304,-0.707649,0.285018,-0.326356,0.101241,0.121194,0.167123,-0.300407,-0.130038,-0.305399,0.00199205,0.479392,0.366864,-0.135754,-0.415157,-0.11079,0.0418339,0.908321,-0.123068,-0.250275,0.194017,-0.497258,0.298345,0.312332,-0.230276,-0.0794884,0.562423,-0.0574491,0.411607,0.161128,-0.0924578,-0.317073,0.166866,0.101378,-0.171903,-0.275997,-0.924724,-0.143468,-0.210851,-0.0864781,0.26573,-0.718949,0.569128,-0.19343,0.35085,1.2215,-0.258608,0.639849,-0.0302297,-0.430182,-0.158609,-0.444761,-0.846446,0.266906,-0.279301,0.251481,0.393013,-0.243726,0.160833,-0.538977,-0.700415,0.119274,-0.196098,0.658647,-0.31971,0.137514,-0.0661499,-0.741792,-0.442456,0.298095,-0.182063,-0.281728,-0.481178,0.277145,0.530223,0.35296,-0.0413356,-0.896275,-0.297374,0.211846,0.697125,-0.175987,-0.493879,-0.49213,0.278227,0.615491,-0.585187,-0.171355,-0.200979,-0.19037,0.633924,-0.207544,0.384199,-0.0100944,-0.635637,0.262726,-0.302066,0.192198,-0.389809,0.39918,-0.0303032,0.604965,-0.250563,-0.184623,-0.0318103,-0.207724,0.565332,0.0474966,-0.506899,-0.411829,-1.00215,-0.336934,0.521195,-0.501629,0.0488757,-0.245009,0.236882,0.253665,-0.337185,-0.483941,-0.402165,0.283783,-0.349466,0.14682,-0.0217261,0.539982,-0.645216,-0.08452,0.384884,-0.332924,0.259451,0.255794,0.0693849,-0.613532,0.16879,0.35537,-0.23552,-0.560361,0.0624138,0.188483,0.16725,0.434147,0.408962,-2.43404 +3404.62,0.795106,0.0848144,4,1.57129,0.835961,-1.18924,0.486309,0.42142,-0.0175227,-0.268315,-0.297609,-0.495184,-0.304231,-0.0296745,-0.357295,-0.489504,0.497418,-0.196575,0.706497,0.156778,-0.0266582,-0.213167,0.0792177,-0.0739685,-0.837175,-0.134185,0.287527,-0.334869,0.0195831,0.618892,-0.0210105,-0.190948,0.0816366,0.530997,0.121714,-0.0750659,0.15709,-0.441134,0.0829116,0.348551,0.11519,0.317173,0.141413,0.687243,0.815071,0.0116218,-0.506353,-0.0655106,0.464187,-0.151299,0.0936299,0.220789,0.0186683,-0.465389,0.980545,0.454246,-0.679742,0.3503,0.0787714,-0.112918,-0.707803,0.507091,-0.130686,0.031976,0.562422,-0.403939,0.08774,0.249217,0.614184,0.268379,0.242182,0.251033,-0.325437,0.448038,0.447031,0.203485,0.498247,1.18837,0.694091,0.357913,0.211177,-0.02958,-0.0469719,1.05347,-0.212719,0.19841,-0.0211134,-0.170322,-1.01426,0.317101,-0.177796,0.443163,-0.0040892,0.302937,0.294544,-0.222929,-0.0288842,0.296505,-0.668008,-0.0772112,-0.224449,-0.177656,0.540002,-0.476247,-0.244203,-0.318497,-0.312644,-0.609111,-0.96916,0.222484,-0.0224892,-0.144882,1.12134,0.0834606,-0.0449403,-0.199137,0.511346,-0.302085,-0.360915,-0.167848,-0.363964,0.357443,-0.621725,0.0991243,0.278703,-0.667568,-0.518149,-0.513682,-0.00478574,0.213336,0.233666,0.53565,-0.721316,0.236343,0.029938,0.0382219,0.524466,-0.0405929,0.0523958,0.238934,0.237036,0.266005,-0.51914,-0.466681,-0.186295,0.436948,-0.664524,-0.34395,0.461424,-0.173262,0.366724,-0.0769552,-0.459282,-0.14076,-0.232855,0.170579,-0.605518,-0.166047,0.31974,0.564418,-0.4655,0.260776,-0.0612302,0.534564,0.191828,0.921609,-0.438299,0.288126,0.383243,-0.0152348,-0.346257,-0.118355,-0.839223,-0.183093,0.192199,-0.0540485,0.0958925,-0.154312,-0.480437,-0.381182,0.0645496,0.315537,1.18155,0.0427989,0.00131979,0.365154,-0.24919,-0.451333,0.408991,0.11647,0.156428,0.259639,-0.331673,-0.0230852,0.105253,-0.15543,-0.764883,0.205889,-0.0612429,-0.280593,0.0168485,-0.63355,-0.000101299,0.00564977,-0.175726,0.233697,-0.388785,-0.0602542,-0.178345,0.180967,1.28284,0.273997,0.642915,-0.352848,-0.163557,0.00212135,-0.466962,-0.372903,-0.245857,-0.434089,0.0502234,-0.00088405,0.0373555,0.146705,-1.12525,-0.232902,0.451536,-0.935284,0.404665,-0.571535,0.116029,-0.0467016,-0.505857,-0.18628,0.299758,-0.178774,-0.113408,-0.323777,0.0668966,-0.0553894,0.242499,0.600334,-1.4079,-0.355869,-0.0825487,0.13463,0.395605,0.82634,-0.150567,0.564616,0.239842,-0.388329,-0.404814,-0.251486,-0.259476,0.217444,-0.177317,0.566303,0.0567642,-0.522128,0.0842392,-0.723118,0.199239,-0.86701,0.120308,-0.0383825,0.743938,0.0889038,-0.107484,0.237176,-0.807537,0.474368,0.036536,-0.182157,-0.11372,-0.918251,-0.0221752,0.270625,-0.571659,0.335828,0.108954,0.207363,-0.178104,-0.43166,-0.394974,-0.510309,0.0810459,0.0713416,0.0877155,0.25603,0.408405,-0.202025,-0.448132,-0.146023,0.413682,0.0521095,-0.0943243,0.133099,-0.536946,0.145969,0.491463,-0.662296,0.075366,-0.441394,0.162607,0.121666,0.403245,0.348806,-1.13764 +3394.58,0.799717,0.0848144,4,1.56788,0.872751,-1.1498,0.472654,0.598206,-0.011843,-0.224948,-0.29244,-0.525518,-0.298634,-0.00689604,-0.383378,-0.444408,0.57433,-0.252836,0.636318,0.223386,-0.119399,-0.212064,0.0116266,-0.194878,-0.910348,-0.146514,0.296725,-0.518429,0.127371,0.518279,0.0296918,-0.21645,0.0331849,0.545785,0.146275,-0.0775951,0.104917,-0.420894,-0.00746912,0.0891397,0.143854,0.447651,0.261499,0.691205,0.693769,0.17243,-0.529945,-0.19131,0.428257,-0.214449,-0.035864,0.302456,-0.147652,-0.526818,0.894116,0.407162,-0.627601,0.267975,0.030428,-0.0515342,-0.697964,0.443385,-0.132454,-0.0783808,0.646294,-0.521609,0.050128,0.439473,0.609483,0.33419,0.296509,0.237235,-0.306677,0.529159,0.578951,0.223078,0.515622,0.988891,0.669618,0.404999,0.155175,-0.0538718,-0.046616,0.876812,-0.141543,0.130783,-0.00643568,-0.226255,-0.995631,0.272908,-0.197129,0.26398,-0.0431986,0.151265,0.382301,-0.153418,-0.045222,0.355499,-0.667832,-0.037329,-0.230384,-0.00624676,0.478054,-0.366149,-0.241292,-0.368585,-0.328812,-0.822423,-0.9127,0.155221,0.0406602,-0.130881,1.16109,0.0779194,0.0438287,-0.30346,0.465023,-0.199298,-0.327128,-0.0927371,-0.31733,0.346757,-0.624942,-0.0355851,0.182489,-0.736167,-0.572914,-0.503335,0.07189,0.240691,0.247318,0.636839,-0.78096,0.409993,-0.0173842,-0.220237,0.59909,-0.026885,0.0980361,0.224335,0.198797,0.0599906,-0.562488,-0.565346,-0.0988406,0.29149,-0.783696,-0.316551,0.487472,-0.250255,0.219752,-0.055309,-0.405166,-0.111558,-0.32262,0.119228,-0.706659,-0.224128,0.32589,0.525647,-0.608598,0.171431,0.0407302,0.536159,0.0976464,0.952949,-0.338005,0.332736,0.359776,0.0582827,-0.124809,-0.0791291,-0.821312,-0.0132769,0.430241,0.0738091,0.162902,-0.212246,-0.505141,-0.36681,-0.0774326,0.161607,1.30247,-0.0450151,0.0611763,0.392881,-0.0957823,-0.485611,0.394118,0.166741,0.240745,0.203562,-0.260205,-0.0397794,0.127022,-0.184764,-0.845314,0.256585,-0.14469,-0.206068,0.100084,-0.66041,-0.0189959,0.0289093,-0.219312,0.303351,-0.385969,-0.111206,-0.216412,0.113303,1.28687,0.218097,0.622134,-0.296193,-0.253237,-0.0492561,-0.484749,-0.447925,-0.166614,-0.524656,-0.053832,-0.0214256,0.150377,0.165055,-1.0207,-0.316068,0.374432,-0.846544,0.343116,-0.534197,-0.0299596,-0.0459603,-0.448905,-0.16996,0.319022,-0.18273,0.0259206,-0.267412,0.133443,0.0841419,0.179474,0.557041,-1.51774,-0.516615,0.0893137,-0.00950152,0.435877,0.814004,-0.15156,0.688809,0.226049,-0.340913,-0.493921,-0.184435,-0.194621,0.217786,-0.235883,0.586877,0.218718,-0.530302,-0.0266856,-0.785449,0.183669,-1.01782,0.161465,-0.102369,0.746858,-0.084434,-0.0117179,0.201034,-0.754328,0.467985,0.0243754,-0.127245,-0.183241,-0.961023,-0.0877083,0.118914,-0.469616,0.288262,0.213449,0.362046,-0.256324,-0.478697,-0.479856,-0.481293,0.0506983,0.15272,0.138203,0.152792,0.445186,-0.203839,-0.459673,-0.0566151,0.380876,0.045709,-0.0544619,0.250534,-0.403766,0.19975,0.545888,-0.526705,0.35758,-0.134829,0.181469,0.117521,0.425992,0.342814,-1.80217 +3404.2,0.672387,0.0848144,4,1.5999,0.875485,-1.27162,0.509344,0.762322,-0.0923595,-0.0835477,0.156748,0.382992,0.11157,-0.6907,-0.392031,-0.0865418,0.379009,-0.0536247,0.25664,-0.0525541,-0.00990211,-0.266465,0.0504386,0.18196,-0.392649,-0.940631,0.304016,-0.418115,-0.108311,-0.050581,0.157637,-0.190023,0.0947913,0.467172,-0.535775,0.0193301,0.452476,-0.265937,-0.163017,0.123038,0.194663,0.251436,0.0323687,0.945818,0.674309,0.371624,-0.954111,-0.076506,0.419651,0.210444,0.198679,0.0433702,0.352738,-0.0546852,0.489011,-0.0403317,-0.0980988,0.365785,-0.619636,-0.169001,-0.624156,0.215053,-0.477839,0.148733,0.431587,-0.037446,-1.01783,-0.0579508,0.833505,-0.00246023,0.0219085,0.0669157,-0.56755,0.328241,0.647843,0.499794,-0.212691,0.718388,0.249422,0.397583,0.480298,-0.435548,-0.759405,-0.0885327,-0.242294,-0.113392,0.344254,-0.400293,-0.944803,-0.508586,-0.191717,0.0369471,-0.0795754,-0.28214,-0.18934,-0.0910828,0.126925,0.236935,-0.0296246,-0.0919504,-0.223317,-0.31654,0.265505,-0.062383,-0.0196678,-0.121583,-0.555153,-0.333276,-1.25463,0.440869,-0.0619657,0.533603,0.826121,0.0459967,0.293693,0.236313,0.378991,0.359956,0.178583,-0.335698,0.374309,-0.0333612,-0.564819,-1.16357,-0.475282,-0.463686,0.147257,-0.521193,-0.0989334,0.620954,0.404594,0.739163,0.204113,0.109407,-0.0187318,-0.20409,0.961614,-0.322717,0.207565,-0.00542521,-0.320492,0.382512,-0.691411,-0.230691,-0.330067,0.34448,-1.32648,-0.137855,0.237775,-0.325163,0.49698,0.252484,-0.383016,-0.21589,0.429099,0.408937,0.0659026,0.537042,0.41242,0.211494,-0.0531569,0.0616507,0.0255102,0.266549,0.53207,0.859969,0.203943,-0.401507,0.854418,-0.363582,0.180775,-0.156877,0.203054,0.0340147,0.640782,-0.0121226,-0.173907,-0.306403,-0.123518,-0.070558,-0.171009,0.333546,1.15971,0.116094,-0.367813,0.0671262,-0.191907,0.218627,0.073953,-0.691986,-0.0161287,0.243748,-0.0613496,-0.0530423,0.0717374,0.00458189,-0.616375,-0.293282,-0.057974,-0.284088,-0.823777,-0.538617,0.0207123,0.0712717,0.27674,-0.153009,0.104965,0.388677,0.318987,-0.50695,1.1924,-0.380552,0.324283,0.000647915,-0.305118,0.0799622,-0.597987,0.899638,0.394221,-0.570223,0.347407,0.0487703,0.420573,-0.013662,-0.773479,-0.798874,-0.26226,-0.883137,0.822481,-0.755294,0.0681265,0.0409989,0.346494,0.242619,-0.133401,0.546099,-0.079685,-0.199321,0.453132,0.0150072,-0.842013,0.66201,-0.83231,-0.653565,0.304952,-0.416721,-0.0597922,0.326786,0.180947,1.01899,0.557373,-0.428582,-0.773515,0.0871632,-0.588158,0.410394,-0.449581,0.13904,-0.0760189,-0.457413,0.000560707,-0.224324,-0.466678,-0.321823,0.554135,-0.0735139,0.182696,-0.125358,-0.0244972,0.0976688,0.000799726,-0.156945,-0.0053351,0.0112065,-0.351192,-0.835207,0.104883,-0.116608,-0.951094,0.113479,-0.44606,0.33471,-0.271553,-0.583563,-0.0690146,-0.84272,-0.228702,0.252128,0.138966,0.068832,-0.171301,-0.312162,-0.181043,0.128361,-0.136928,0.221478,0.63226,0.013446,-0.452227,-0.132939,0.242363,-0.429324,-0.614996,-0.29913,0.187524,0.184201,0.43304,0.429187,-2.27048 +3425.6,0.704599,0.0848144,5,1.51227,0.951273,-1.25494,0.497679,0.827187,-0.100177,0.0475295,-0.0208628,0.00401386,-0.323565,0.316546,0.162252,-0.261397,-0.0542878,-0.246676,0.738263,0.170645,0.0938651,0.0974701,0.186912,-0.103233,-1.02756,-0.263477,-0.0131304,-0.200547,0.48768,-0.0386725,0.299131,-0.178701,0.0732526,0.642891,-0.4451,0.133272,0.169547,-0.13953,0.266061,-0.628592,0.616069,0.152158,-0.0274626,0.737246,0.0432058,0.303405,-0.541766,-0.251971,-0.136394,-0.579727,0.00888791,0.399984,0.278605,-0.271665,0.237053,-0.136501,-0.154712,0.444341,0.291005,-0.266736,-0.896096,0.130077,-0.676545,0.353904,0.694413,-0.469527,-0.228285,-0.256409,-0.294625,-0.0769011,0.0183933,0.180483,-0.572918,-0.306394,-0.0199022,0.839662,0.0852291,0.547951,0.257744,0.446397,0.0423423,-0.608494,0.439596,0.930978,-0.167951,0.142729,-0.661309,-0.0792243,1.01772,0.601746,-0.98387,0.179971,-0.266919,-0.14203,0.160443,0.198366,-0.0151277,-0.349418,-0.437556,-0.216348,0.217949,0.19416,0.614045,0.296934,0.00738565,-0.304501,-0.0849719,0.617045,0.450905,-0.230676,-0.44526,0.0952142,1.00812,0.182637,-0.0329905,0.212214,0.542292,-0.167782,0.176923,-0.365853,0.143959,0.313702,0.337189,0.0236784,0.169595,-0.352821,-0.115649,0.0269365,0.341549,0.29543,0.079653,-0.363323,-0.680327,0.132055,0.0218861,0.299321,0.216376,-0.342044,-0.179417,0.0701018,-0.758204,0.0691801,-0.666953,-0.220087,0.0603913,-0.141921,-0.588503,0.372282,0.132752,0.113667,0.244963,-0.147409,0.117677,-0.0223052,-0.0444151,0.00802076,-0.335195,0.052978,0.784824,0.733104,-0.261725,0.376853,-0.141201,0.0564317,-0.392664,0.47096,-0.0926016,0.261444,-0.424265,0.155455,-0.620244,0.324785,0.141104,0.665924,-0.299514,-0.0304159,-0.158793,0.344819,0.3387,-0.0893844,-0.359387,0.00733515,0.546096,-0.139053,0.108077,0.309313,0.19033,-0.238264,-0.128791,0.314208,-0.553728,-0.0973386,-0.687378,0.115378,-0.00321786,0.2776,-0.851076,0.279169,0.397079,-0.17378,-0.151568,-0.60012,-0.0250731,-0.412579,-0.310383,-0.185045,-0.0464287,-0.000300796,-0.462544,-0.435264,1.06464,0.590913,0.0205219,0.255365,-0.0104131,-0.0703112,0.83504,-0.512593,0.599179,-0.516473,0.286139,0.556543,-0.796263,0.0756261,-0.326508,0.104666,0.335909,-0.00366563,-0.0280062,-0.650578,0.0879098,-0.0918806,0.0511176,-0.514005,-0.0482,-0.565462,-0.271987,0.0427269,0.744284,0.0665989,0.413317,0.699861,-0.335353,0.432758,0.243987,0.12642,0.0586105,0.268395,-0.0507321,-0.45247,-0.305935,-0.369001,0.135166,-0.334177,-0.770183,-0.152891,0.145338,-0.562556,-0.0851888,-0.388909,0.12886,-0.129242,0.284827,0.672337,-0.225423,-0.00878898,0.444181,0.394827,0.283814,0.185871,-0.10253,0.00614804,0.251637,-0.248899,-0.381555,-0.0321599,-0.0960986,0.45278,0.442583,0.269574,0.531885,0.04738,0.359879,0.312682,-0.482087,-0.31391,0.446474,-0.198097,0.606155,0.211323,0.69322,0.438307,-0.227045,-0.244381,0.282738,0.0621869,0.312531,0.0274945,-0.447669,-0.186972,-0.0786705,-0.117907,0.05351,0.611695,0.151295,0.189151,0.388966,0.434915,-2.70318 +3441.56,0.998102,0.0848144,5,1.47711,0.785975,-1.37031,0.622383,0.549061,-0.207426,0.0709968,0.355094,0.423454,0.244977,0.493061,0.00689974,0.0535082,0.754609,-0.156833,0.660698,0.625699,-0.194047,-0.496988,0.31019,0.087503,-0.21005,-0.798436,0.485762,-0.37264,0.038784,-0.0116219,0.19444,0.0318853,-0.219519,0.995459,-0.518793,-0.403238,0.226567,-0.0406414,-0.188613,-0.117128,0.824844,0.294315,-0.247772,0.453851,0.706872,0.915533,-0.328854,0.0758135,0.360914,-0.753107,0.460519,0.311272,-0.058021,-0.0617973,0.212329,-0.107415,-0.367043,0.247027,-0.283832,0.133175,-0.879909,0.256238,0.244733,0.0992435,0.935509,-0.143996,-1.0319,0.651783,0.255261,-0.337497,-0.072616,0.5779,-0.395069,-0.320764,0.572373,0.271096,-0.644549,0.806805,0.138063,0.214471,-0.0314072,-0.442101,-0.507456,-0.121021,0.00903052,0.164767,0.370373,-0.594974,-0.929801,-0.5436,-0.476872,0.207979,-0.325753,-0.130937,0.0319099,0.150331,-0.650536,-0.258603,0.116746,-0.220861,-0.314574,-0.0519238,0.658751,0.214352,0.11499,-0.636529,-0.523688,-0.164584,0.0195198,0.397825,-0.576363,0.559602,0.363269,-0.189897,0.109532,-0.278179,0.323024,0.0834517,0.0288678,0.0619289,0.152973,-0.231279,-0.239146,-0.627463,-0.400962,-0.197668,-0.224488,-0.35789,-0.142754,0.593011,0.0117719,0.0647307,-0.611076,-0.0950853,-0.294179,0.0338762,0.500108,-0.439856,0.0177329,0.0544798,-0.145424,0.554101,-0.290429,-0.406644,-0.118239,0.201572,-0.283737,-0.124433,0.120698,-0.262291,0.647513,0.0785087,-0.264633,0.593029,0.429902,0.254471,-0.334557,0.0887292,0.172102,0.284191,0.121898,0.715705,0.375016,-0.0199061,-0.195594,0.69872,-0.195451,-0.19071,0.19577,-0.28932,-0.0243551,-0.331989,0.0930185,-0.156405,0.165431,-0.034001,0.0778639,-0.56669,-0.121874,-0.0243757,-0.250825,0.355346,0.758194,0.071974,-0.489979,-0.421114,0.105285,-0.148338,-0.426229,-0.598524,-0.250567,0.0342078,-0.24486,-0.00304792,0.144337,-0.0921711,-0.423554,-0.0527826,0.498658,-0.106266,-0.345342,-0.752984,-0.672226,0.148703,0.306565,0.0611963,-0.100506,0.10289,-0.21286,-0.743667,0.970133,-0.608344,0.479034,-0.12726,-0.326677,-0.310484,0.115329,-0.216017,0.703548,-0.360938,0.708018,0.168606,-0.41337,-0.0668862,-0.286894,-0.350283,0.24324,-0.676392,0.57884,-0.528563,-0.47312,0.34486,0.650275,0.0457737,0.130937,-0.247951,-0.456838,0.236781,0.449797,-0.18234,-0.118765,0.457865,-0.0134132,-0.17288,-0.309636,-0.284648,0.0574619,0.0691651,0.340927,0.473573,-0.0335764,0.170779,-0.46265,0.242903,-0.278481,0.271415,-0.101725,0.369984,0.0248032,-0.234615,-0.244987,0.230566,-0.141392,-0.102556,0.0620207,-0.107011,0.0201702,-0.0330371,0.438356,0.0717787,-0.224311,0.416562,0.163434,-0.0610532,-0.172059,-0.65314,-0.142421,-0.165101,-0.258004,0.368711,-0.128709,-0.0774748,-0.607949,-0.397548,0.0514888,-0.190241,-0.0667166,0.169538,-0.274449,-0.0433469,-0.256286,0.0890214,0.149546,0.3227,-0.410054,-0.21987,-0.042994,0.239383,-0.493746,-0.218597,0.414928,-0.194371,-0.381041,-0.417576,0.139448,0.18273,0.373428,0.427469,-1.55363 +3416.93,0.879454,0.0848144,4,1.57765,0.657812,-1.75638,0.813942,0.639255,-0.275122,0.0962126,0.672684,0.270952,0.169485,0.34488,-0.0964057,-0.062355,0.852664,-0.27,0.75076,0.347641,0.0916823,0.04569,0.239965,0.376946,-0.54625,-0.792832,0.4878,-0.307081,-0.111345,0.118427,0.484197,0.00535591,0.289717,0.675612,0.118236,0.175107,0.245882,-0.223326,-0.187599,-0.459364,1.07114,0.664626,-0.270276,0.44091,0.373353,0.18923,-0.431592,-0.239039,0.310013,0.0665831,0.529559,-0.0171553,-0.0277311,0.267845,0.838473,-0.103408,-0.849251,0.124869,-0.116806,0.415869,-0.971267,0.0795227,-0.217092,-0.0937219,0.895727,-0.477437,-1.01993,0.468312,0.315812,-0.0253708,-0.315479,0.365217,-0.331331,-0.221869,0.317166,0.0388302,-0.571874,-0.14487,0.221336,0.397203,0.0433828,-0.567535,-0.475251,0.310502,0.0382087,0.229665,-0.0159659,-0.591352,-0.446752,-0.377575,0.0260878,0.214651,0.0316697,0.151939,-0.0228995,-0.0266301,-0.419048,-0.549512,-0.384767,0.191404,0.110781,-0.367863,0.639719,0.0534291,0.0220099,-0.271283,-0.619112,0.549659,0.125971,-0.411794,-0.363676,0.0741415,0.40859,0.0683778,-0.0126708,-0.160041,0.377021,0.0366683,-0.669497,-0.955245,0.143682,0.288212,-0.264375,-0.686116,0.0560922,0.174246,0.248645,0.302501,-0.376793,0.280379,0.337791,-0.0700386,-0.709373,-0.274635,-0.247385,0.138235,0.55014,-0.734421,-0.0282002,-0.136788,-0.481093,0.129917,-0.422953,-0.18961,-0.18988,0.350566,-0.901831,0.303949,-0.0476979,-0.00222967,0.678393,-0.0787362,-0.0235126,-0.0973486,0.68818,-0.0843063,-0.513712,0.478411,0.649807,0.223912,0.302398,0.0575593,0.0482368,0.0734391,-0.237633,0.471852,0.0569712,-0.202131,0.0307775,-0.0016985,0.328524,-0.648068,0.265727,-0.451611,0.3839,0.0936653,0.399134,-0.795923,0.161033,-0.443002,-0.00641755,0.17674,0.77523,0.272719,-0.713041,-0.00985356,0.100923,-0.644032,-0.304562,-0.783134,-0.10831,0.211069,-0.0997507,-0.697513,-0.0607991,-0.339823,-0.579774,-0.14903,0.210001,0.11761,-0.346493,0.0633568,-0.0742109,-0.097025,0.0842747,0.0909484,-0.205787,0.0851788,-0.252316,-0.328676,1.0552,-0.648492,-0.243373,0.0303677,-0.50476,-0.345184,0.849403,-0.535967,0.485934,-0.135464,0.533511,-0.2014,-0.1955,-0.102145,-0.431379,-0.00111884,0.104523,-0.635836,0.569472,-0.246136,-0.352024,0.0713061,-0.078383,-0.0991334,0.215592,-0.679791,-0.27328,0.456131,0.662237,-0.349368,-0.208079,0.536592,-0.667938,-0.439835,-0.200626,-0.141704,-0.146581,0.136626,-0.0353025,0.257116,-0.543139,-0.0166803,-0.301224,0.530049,-0.223537,0.368006,-0.171462,-0.238129,-0.0385388,-0.0962462,-0.12568,0.597791,0.249311,-0.250467,-0.0792887,0.17903,0.189633,-0.196321,0.300858,0.348759,-0.564058,-0.268466,-0.193856,-0.256134,0.00270172,-0.39522,-0.195796,0.0879249,-0.298381,0.925278,-0.0120524,0.373171,-0.168975,-0.313901,-0.223376,-0.188805,-0.0512313,0.429223,-0.124133,0.00748252,0.63595,0.392713,0.0197633,0.363898,-0.120108,-0.0557985,-0.0211655,0.242966,-0.175888,-0.116691,0.0388445,-0.484802,-0.195331,0.15635,0.117426,0.215467,0.342674,0.464185,-1.48782 +3368.41,0.385816,0.0848144,5,1.63502,0.696573,-1.2393,0.556955,0.528446,-0.301246,-0.908496,-0.70648,0.204606,-0.378036,0.254673,-0.0738832,-0.400665,0.291453,-0.416506,0.902656,0.273376,-0.0178585,0.285292,0.261917,0.14042,-0.723809,-0.884761,0.496681,0.0885382,0.255145,0.0481753,0.157098,-0.563846,-0.130573,0.707944,-1.03084,-0.328668,0.204634,-0.40541,0.472477,-0.766361,0.526533,0.00577922,-0.373832,0.590969,0.635017,0.324403,-0.676411,-0.0544086,0.000717459,-1.2628,0.000619621,0.41077,-0.162857,-0.429614,0.794207,0.158355,0.379279,0.21119,-0.209625,0.0568661,-0.644107,0.350802,-1.18311,0.44414,1.19688,-0.731683,-0.549688,0.146564,0.842068,0.168741,0.276937,-0.608311,-0.627694,-0.270305,0.382938,0.656637,0.363406,0.8598,0.2603,0.280563,-0.792316,-0.311568,0.0190788,0.321897,-0.925963,-0.180575,-0.649324,-0.0756829,0.458074,0.0667865,-0.381047,-0.165231,-0.699081,-0.298515,0.197517,0.312685,0.333938,-0.364382,-0.325546,-0.627929,-0.773196,0.065505,0.298213,0.26159,0.334761,-0.769019,-4.97583e-05,0.250822,0.0497616,0.460075,-0.198608,0.469419,-0.0134429,-0.344391,-0.0613848,0.0300946,0.680747,0.206525,-0.246662,0.0263855,0.160891,0.898551,-0.291851,-0.968045,-0.582836,-0.381957,-0.348168,0.397726,0.435898,0.0502323,0.407313,0.00232356,-0.138294,-0.199059,-0.21376,-0.150709,-0.131153,-0.0660381,-0.225115,-0.270393,-0.192004,0.110933,-0.986175,0.148268,-0.181483,-0.338314,-0.34057,-0.869379,0.0929781,-0.146224,0.121006,0.0495282,0.00108319,-0.600621,-0.248397,-0.0549256,-0.73909,0.761799,-0.152081,0.304488,-0.480524,0.566523,0.141783,0.394659,-0.45751,0.802977,0.101623,0.356211,0.0731727,0.177162,-0.624068,0.0571996,-0.354012,0.583723,-0.59936,0.301362,-0.707426,-0.101416,-0.178731,0.0482127,0.0326933,0.370003,0.637065,0.352062,-0.726923,-0.289167,0.0352664,0.150477,-0.431668,0.23336,-0.451063,0.218581,-0.470904,0.334407,0.356838,0.16848,-1.04119,-0.240626,-0.62115,-0.645844,-0.765887,-0.746665,0.164416,-0.309602,-0.853881,-0.0561243,0.067275,-0.175555,0.135711,-0.591866,1.01807,-0.122878,-0.0931952,0.32413,-0.0213511,-0.669921,0.350605,0.0567309,0.233488,-0.00233047,0.0884349,0.454545,-0.363916,-0.086593,-0.348121,-0.204099,-0.804332,0.00539493,0.176508,-0.606475,-0.758879,-0.211412,0.0237115,0.0395075,0.362893,-0.220024,-0.970801,-0.595648,0.397628,0.38613,0.422052,0.339172,-0.738622,-0.290359,0.0980379,0.0797713,0.277623,0.282241,-0.142501,0.643664,0.627554,0.432188,-0.273073,0.312618,-0.965067,0.352763,0.370767,0.210703,0.286968,-0.373876,0.161112,-0.137612,-0.0395061,0.0588968,0.688111,-0.301824,0.363964,0.348153,0.178005,0.19857,-0.268169,0.263613,0.204609,0.114275,-0.578129,0.0896578,0.221106,0.835578,0.772805,0.21343,-0.329103,0.310497,0.059903,0.403845,0.133411,-0.0281893,0.104693,0.189167,0.557123,-0.0736822,-0.527761,-0.240835,0.22799,0.614201,0.607971,-0.398937,0.400603,-0.291211,-0.00823705,0.171347,0.0623018,-0.11479,0.495513,-0.862333,0.171651,0.27185,0.414308,0.521392,-1.15255 +3364.59,1,0.0848144,4,1.56854,0.803869,-1.47675,0.454279,-0.175303,-0.22418,0.520584,-0.346219,0.0443188,0.524185,0.052917,-0.281521,-0.455301,0.374412,-0.372299,0.224103,-0.366459,-0.392606,-0.0158775,-0.32653,-0.347528,-0.998534,-0.623063,0.351137,-0.00880697,-0.704543,0.163373,-0.0643514,-0.261205,-0.218718,0.579184,0.0903595,-0.0717957,-0.445941,-0.384912,0.184235,-0.258348,0.848904,0.513492,-0.795548,1.06095,0.23923,-0.0381791,-0.399214,-0.337528,0.0476145,0.307879,0.660542,0.544551,0.0632428,0.565897,0.302877,0.0402907,-0.774293,0.363924,0.0202639,-0.25357,-0.402489,-0.0622626,0.191243,-0.171908,0.986066,0.0124239,-0.976952,0.678558,-0.0225269,0.281406,-0.68746,-0.083122,-0.597082,-0.0690928,0.998681,0.613462,-0.0258568,0.18178,0.805718,0.721762,0.170258,-0.209713,-0.00885603,0.623871,-0.159341,0.153865,-0.564238,0.199303,-1.03157,-0.304995,0.0936826,0.563131,-0.0449987,0.384388,0.067298,0.164026,-0.454253,-0.218261,-0.458562,0.448667,-0.00300586,1.0749,0.396926,0.569313,-0.139171,-0.65658,-0.942356,0.863055,-0.268924,0.296194,-0.606376,-0.197117,0.989802,0.41641,-0.383225,0.438558,0.554643,0.0203861,-0.139445,-0.440828,0.394199,0.390061,0.123013,-0.870043,0.151115,-0.312918,-0.42605,-0.371079,0.116477,0.350189,-0.0488504,0.250081,-0.789327,0.131964,0.237202,0.0622417,0.984765,-0.0694704,-0.0452982,-0.552959,0.170148,0.34002,-0.338739,-0.485754,-0.410112,0.0239921,-1.38546,0.374484,0.269416,0.473308,0.713063,-0.034765,0.398787,0.0966617,0.775713,0.163174,0.188246,-0.239222,0.455114,0.237408,0.718423,-0.432213,-0.113728,0.440837,-0.00588128,0.984831,0.246933,-0.6934,-0.473318,-0.135125,-0.188777,0.0662354,0.124448,0.0183673,-0.197359,0.133341,0.476163,-0.408991,-0.219848,-0.602031,0.0167575,0.389056,0.72282,-0.527374,0.0458834,0.330286,-0.0700485,-0.376671,-0.0889768,-0.679071,-0.455899,0.0466365,0.157981,-0.313592,0.381235,0.163803,0.255737,0.345944,0.315596,0.816947,0.34601,-0.258904,0.0924329,-0.14738,-0.172727,0.240367,-0.0883436,0.493627,-0.702879,-0.392258,1.01507,-0.627163,-0.141325,0.234626,-0.264534,0.0408829,0.365876,-0.0506885,0.564071,-0.165068,-0.0365754,0.628314,-0.665141,-0.183875,-0.0970975,0.173287,-0.055935,-0.502675,0.669178,0.0200591,-0.272283,0.390138,-0.258335,-0.345883,0.341288,-0.171657,0.483928,-0.57784,0.79747,-0.245958,0.105861,0.361251,-0.863445,0.893187,0.0235562,-0.292121,0.724209,0.706448,0.577998,0.351867,-0.162417,-0.368537,0.183518,0.251363,0.0464714,0.951926,-0.493062,-0.842289,0.833913,0.0263296,0.221913,0.225366,-0.0092165,0.037314,0.0261017,-0.488026,0.126047,0.442207,0.65476,0.176528,-0.766812,-0.396014,0.535878,0.253701,-0.238417,-0.0621677,-0.487963,-0.184067,0.149662,0.442562,-0.403008,0.606908,-0.0213488,-0.438267,0.0648022,-0.649624,-1.09972,0.285304,0.689719,-0.360418,0.522104,0.656558,-0.806194,0.335623,-0.209203,0.387391,0.200534,0.866977,-0.0649376,-0.105802,0.217519,-0.404476,-0.65206,0.364767,0.21444,0.174396,0.463077,0.417608,1.13045 +3389.31,1,0.0848144,5,1.64887,0.99496,-0.673832,0.15349,0.244989,-0.258665,-0.395786,-0.263066,0.499855,-0.282848,-0.132932,0.22031,-0.360908,0.0124449,-0.0600604,0.807292,-0.516646,-0.0179272,-0.22729,-0.284284,-0.716268,-0.786293,-0.956808,-0.295448,-0.277806,0.242578,0.0829768,-0.05628,-0.66757,-0.261214,0.477008,-0.713301,-0.181968,-0.214763,-0.307641,-0.145932,-0.194964,0.632237,-0.176379,-0.29741,0.639722,1.05363,0.512457,-0.522074,0.066778,-0.350007,-0.686828,0.528484,0.398314,0.141977,0.225421,0.300108,0.207351,0.191649,0.560102,0.0908952,-0.0406901,-0.572755,-0.0359913,-0.359191,0.371816,0.614608,-1.41815,-0.714133,0.199188,0.509967,-0.239827,0.562864,-0.0921482,-0.676636,-0.402243,0.722612,0.922489,-0.573528,0.904511,0.907609,0.0764378,-0.134147,0.153142,0.58658,0.355603,-0.570097,0.105806,-0.26487,0.0166053,-0.159478,0.854453,-0.0774229,-0.208279,-0.669672,-0.953243,0.0807809,0.364635,-0.562091,0.301266,-0.429374,-0.588681,-0.705211,-0.64738,0.450677,-0.0279185,0.317989,-0.590843,-0.298084,0.094977,-0.0991947,0.104376,0.165647,0.451386,0.0100265,-0.129995,0.134993,-0.105117,0.491943,-0.491447,0.194353,-0.503581,0.532157,0.0225028,-0.0625073,-0.627731,0.355041,-0.709289,-0.596488,-0.342202,0.267468,0.106554,0.381803,0.0221333,-0.150053,0.230259,0.272537,0.471117,0.461434,0.244218,0.0869021,-0.688046,-0.0245354,0.676004,-0.839931,-0.0768983,0.249011,-0.0770373,-0.461763,-0.321599,0.0492883,0.121097,-0.276917,-0.0823248,-0.158441,-0.922073,0.441065,0.461966,-0.259009,0.0741242,0.367752,0.366885,0.591273,0.604846,-0.212377,-0.227416,-0.298579,0.62859,-0.514902,-0.689251,0.0430574,-0.0606083,-0.583779,-0.510917,-0.322635,0.0933005,-0.530793,-0.00108977,-0.280969,-0.111716,-0.239553,0.093223,0.0600173,0.639075,0.804492,0.190207,-0.277144,-0.343078,-0.490871,0.667924,-0.578954,-0.298389,-0.306404,-0.218679,-0.864931,0.298371,-0.259908,0.390684,-0.790903,-0.202228,0.184631,0.0266588,-0.245509,-0.652765,-0.250465,-0.12838,-0.545926,-0.389289,0.231937,-0.00817523,0.549235,-0.474253,0.944253,0.479404,0.614929,0.449245,0.0432295,0.448498,-0.0535668,-0.164953,0.857406,-0.705199,0.682084,0.0489109,-0.53252,-0.167149,-0.833836,0.581866,0.048149,-0.863295,0.150105,-0.534027,-0.715556,0.145334,0.411127,-0.146649,-0.000725884,-0.268611,-0.350001,0.0286879,0.713983,-0.226176,0.322536,0.845592,-0.163008,-0.558854,-0.400048,0.508683,0.350797,-0.388243,0.443173,0.573794,-0.000335898,-0.597429,-0.330883,0.116756,-0.721744,0.626992,-0.866424,0.155291,0.480149,-0.154788,-0.452453,0.585317,0.369107,0.406174,0.540369,0.152969,0.341833,-0.00700679,0.585473,0.146433,-0.508656,0.505077,0.486356,0.0818218,-0.348362,-1.15456,-0.103932,-0.605454,0.138647,0.455936,0.29094,0.737702,-0.205356,-0.142775,-0.0299381,-0.0550094,0.239648,0.121568,-0.322629,0.0611237,0.709804,0.0543614,-0.322354,0.165265,0.16271,-0.121606,0.736046,0.137277,-0.548582,-0.182688,0.341126,0.173972,-0.201159,-0.178259,0.205022,0.269416,0.452793,0.519053,-0.650336 +3386.29,0.814864,0.0848144,5,1.60479,1.02142,-0.899102,0.240457,0.105886,-0.248937,-0.359022,-0.211327,0.356807,-0.28264,-0.0303489,-0.063266,-0.246648,-0.0414461,-0.177386,0.709309,-0.230126,-0.154186,-0.282946,-0.284399,-0.785096,-0.760927,-0.819946,-0.0970022,-0.340282,0.201247,0.22522,0.0423913,-0.68012,-0.433375,0.640238,-0.56554,-0.215877,-0.445668,-0.535937,-0.0291989,-0.247885,0.77661,-0.103532,-0.453153,0.722975,0.669281,0.530979,-0.449265,0.103413,-0.153314,-0.572763,0.849888,0.259356,0.424483,0.0718073,0.0780472,-0.0067348,0.214108,0.450665,-0.059475,-0.181176,-0.812842,-0.085217,-0.520552,0.00173231,0.532775,-1.09929,-0.970974,0.38856,0.537969,-0.197698,0.6214,-0.170072,-0.558923,-0.522329,0.591084,0.823642,-0.535216,0.828835,0.701457,0.0129262,-0.133403,-0.166026,0.339828,0.251656,-0.407382,0.152983,-0.24085,-0.159065,-0.215809,0.630583,0.143753,-0.0935334,-0.793805,-0.97841,0.111111,0.396487,-0.464329,0.0983894,-0.511046,-0.581071,-0.392827,-0.566254,0.346277,-0.135319,0.475156,-0.239434,-0.241737,0.0388587,-0.294374,0.282541,0.19919,0.290186,-0.167592,-0.408111,0.0159279,0.049703,0.388104,-0.438819,0.245272,-0.363374,0.327223,0.212069,-0.314811,-0.731799,0.166465,-0.482614,-0.750811,-0.366531,0.210715,0.0662162,0.453685,0.176841,-0.125027,0.183485,0.246678,0.36492,0.531517,0.339716,0.0459659,-0.991716,0.122352,0.69608,-1.00373,-0.296046,0.226081,0.0306329,-0.188198,-0.299213,0.137345,0.212454,-0.0887481,-0.00904194,-0.212647,-0.82484,0.439571,0.354213,-0.310584,-0.0617912,0.399643,0.303594,0.471108,0.689313,-0.162889,-0.11751,-0.451146,0.352717,-0.914496,-0.361361,0.121416,0.153936,-0.449214,-0.551817,-0.261966,-0.0789286,-0.0390933,-0.0474544,-0.28983,-0.180445,-0.141125,0.17237,0.34006,0.644213,0.970122,0.110519,-0.232018,-0.424084,-0.401549,0.651068,-0.607833,-0.287141,-0.391753,-0.321826,-1.11338,0.387056,-0.21456,0.293478,-0.685712,-0.0649401,0.323999,-0.100574,0.0555617,-0.666243,0.041465,-0.141844,-0.563842,-0.534793,0.149682,-0.20403,0.695739,-0.416398,0.958451,0.730674,0.599516,0.463413,0.00375422,0.319964,-0.123859,-0.344023,1.01119,-0.666831,0.581715,0.137892,-0.322641,-0.352638,-0.79001,0.429773,-0.106486,-0.901534,0.218746,-0.479599,-0.589571,0.375277,0.442453,0.046535,-0.0901922,-0.577416,-0.219882,0.366583,0.861164,-0.23494,0.0422971,0.71887,0.0216903,-0.581554,-0.403722,0.532981,0.158938,0.148763,0.591477,0.354951,-0.0846256,-0.555742,-0.136585,0.206031,-0.689925,0.713578,-0.801994,-0.188516,0.497758,-0.109597,-0.480901,0.558644,0.370675,0.437947,0.317792,0.299941,0.316282,0.0932475,0.466414,0.297598,-0.611627,0.508847,0.323493,0.125067,-0.584889,-1.17874,-0.00158507,-0.763797,0.244629,0.447221,0.284139,0.955048,-0.102879,-0.129702,-0.111078,-0.100651,0.437171,0.121099,-0.544317,-0.041411,0.95641,0.147816,-0.218845,0.0763393,0.503895,-0.0171489,0.643338,0.0656805,-0.30813,-0.359624,0.240146,0.216101,-0.557676,0.100614,0.214346,0.274864,0.462975,0.524275,-0.245951 +3389.36,0.952602,0.0848144,5,1.75926,1.06034,-1.04948,0.283459,0.187587,-0.140192,-0.0151986,-0.328367,-0.163752,0.0694674,-0.422757,0.0416597,-0.125533,-0.190176,-0.171589,0.464865,-0.398442,-0.271251,0.136976,-0.483454,-0.830317,-0.993744,-0.693199,-0.519645,-0.275747,0.103741,-0.0287284,-0.0606668,-0.68638,-0.0468996,0.300101,-0.468457,-0.408218,-0.564929,-0.537406,-0.150245,-0.236392,0.208876,-0.0163101,-0.217779,0.739996,0.630861,0.234236,-0.68632,-0.290553,-0.364705,-0.497974,0.0756703,0.115855,-0.290753,0.414384,0.665759,0.0600537,-0.0677452,0.298505,-0.383601,-0.436628,-0.696148,-0.120743,-0.190231,0.239914,0.78116,-0.740463,-0.116011,0.0780744,0.524812,-0.490558,0.60613,-0.348148,-0.607712,-0.137141,0.608787,0.732284,-0.282807,0.535517,0.449015,0.057209,0.0823232,0.180086,-0.124857,0.710202,-0.212227,0.311857,-0.216941,-0.178425,-0.166579,0.20365,0.167152,0.398265,-0.339673,-0.896884,0.0289044,0.603625,-0.305836,0.260714,-0.684308,-0.590965,-0.217456,0.184814,0.153979,0.387025,0.17541,-0.694167,-0.425162,-0.0631968,-0.69599,0.430681,-0.104565,0.453014,0.451375,-0.116335,0.02878,0.347854,0.394597,-0.18571,0.38462,-0.263053,0.570456,0.591809,-0.759703,-0.586941,0.323121,-0.0961926,-0.638497,0.0726038,0.417043,0.271644,0.686548,-0.0532926,-0.222518,-0.230463,0.317062,-0.0274798,0.473497,-0.339068,-0.578902,-1.23157,0.397268,0.505004,-0.917598,-0.225498,0.161251,0.340301,-0.718673,-0.839993,-0.493344,-0.259394,0.222449,-0.315723,-0.363519,-0.257827,0.667029,0.0558007,0.127482,-0.514972,0.468008,0.454227,-0.0772283,0.0452685,-0.339401,0.342693,-0.29788,0.531505,-1.04999,-0.145864,0.235016,-0.106054,-0.460333,-0.611099,-0.191114,0.270456,-0.382615,-0.153237,-0.7505,-0.274848,0.0603237,-0.0380192,-0.175743,0.0853068,0.823675,-0.149455,-0.419254,0.192396,-0.211317,0.421955,-0.563507,-0.384332,-0.796091,-0.469361,-0.839548,0.347103,0.470699,-0.141269,-0.439336,0.288375,0.0698344,0.109294,-0.121264,-0.703648,-0.0211939,-0.083421,-0.8521,-0.556889,0.305163,-0.321317,-0.0295895,-0.551195,0.90969,0.695789,0.286923,0.199377,0.0452439,0.00912071,-0.0998238,-0.259208,0.340232,-0.288094,0.358993,0.363172,-1.08953,-0.418311,-0.631639,-0.251429,-0.268547,-0.739789,0.887689,-0.445659,-0.474574,0.55643,0.234509,-0.615629,-0.0641468,-0.724541,-0.349299,0.0336114,0.749143,0.0667775,0.702256,0.27374,-0.124541,-0.368999,0.0418371,-0.0746049,0.410991,0.390698,0.59845,0.46893,0.436714,-0.179295,-0.18958,0.481381,-0.390742,0.452312,-0.0448876,-0.687677,0.511451,0.123607,-0.573097,0.377764,0.236096,0.483934,0.211869,0.369284,0.676119,-0.649948,0.664295,-0.250418,-0.0350633,0.119648,-0.0903311,-0.203312,-0.25591,-0.704607,0.0610701,0.308718,0.122453,0.0752066,-0.0630234,0.382291,-0.0419031,0.186024,-0.765246,-0.143323,-0.09161,0.0378678,-0.798693,0.329326,1.27847,0.0749298,-0.170649,0.0386896,0.584558,0.652079,0.104585,0.141707,-0.349005,-0.3263,0.310303,0.0128914,-0.0282782,0.0424058,0.185045,0.187175,0.430168,0.432638,-0.420472 +3386.78,0.586757,0.0848144,5,1.77663,1.02453,0.0188359,-0.0501405,0.0385084,-0.216127,0.0163659,0.195373,0.581883,0.292505,0.0552113,-0.136852,-0.148247,0.449193,-0.408247,0.717242,0.744964,-0.176719,0.0610661,-0.0314012,-0.635166,-0.338593,-0.327531,-0.119357,-0.203902,-0.561554,0.0527363,-0.0979865,0.0694524,-0.406659,0.539785,-0.0810273,-0.112735,-0.112058,-0.262508,-0.421533,-0.43096,0.0650589,-0.0273683,-0.379223,0.449916,0.0130269,0.0706943,-0.487211,-0.204866,0.0181605,-0.469357,0.146056,0.389316,0.0858149,0.0705764,-0.445356,-0.118412,-0.623234,0.443302,0.0139067,-0.0261098,-0.813361,0.133184,-0.632797,-0.150601,0.509133,-0.806229,-1.16488,0.0306542,0.399413,-0.0744467,-0.314363,0.130205,-1.0313,-0.745711,0.21134,0.536434,0.242022,0.834986,-0.00743424,0.293405,-0.228368,-0.485325,0.258648,-0.329306,-1.1695,0.140581,-0.386751,-0.0718164,0.310704,0.587942,-0.30701,0.173039,-0.251021,-0.0794111,0.0753273,-0.0531771,-0.350063,0.350731,-0.28853,-0.255044,-0.608221,-0.427082,0.368185,0.466806,-0.407767,-0.385808,-0.526576,-0.0923789,-0.676826,-0.167017,-0.404407,-0.0832345,0.0941488,-0.91133,-0.310619,-0.695974,0.436978,-0.0737593,-0.189202,-0.00803582,-0.228651,0.432487,-0.791512,-1.21218,-0.162773,-0.492093,-0.0628493,-0.430614,0.311531,0.287094,0.0741817,0.0485895,-1.12071,0.211832,-0.21484,0.218772,0.631078,-0.266551,0.158699,-0.400067,-0.157562,0.668088,-0.981759,-0.296996,-0.0835517,-0.0783273,-0.5228,0.220477,0.862939,-0.0345321,0.233328,-0.357655,-0.0224179,-0.851183,0.343532,-0.264781,0.0341247,0.545569,0.841893,-0.336503,-0.150036,0.162788,-0.292418,-0.560079,-0.147535,0.685842,-0.545394,0.170839,-0.051315,0.212323,0.126494,-0.464848,0.35986,0.211178,0.482279,0.15688,-0.620027,-0.22413,0.250694,-0.108159,-0.271269,0.722787,0.637941,0.258978,0.517665,0.365738,0.157421,0.0658311,-0.852402,0.0250286,-0.651793,0.208288,0.25133,-0.0446559,-0.149319,0.154066,-0.817876,-0.0814878,-0.710455,0.332483,-0.0149835,-0.695135,-0.219471,0.00337776,0.349975,-0.0142679,0.0391408,-0.284438,-0.15751,-0.599416,0.784939,-0.111775,0.417081,0.278097,-0.607964,0.308936,0.425614,0.177076,0.454635,-0.373705,-0.0168966,-0.0739585,-0.841748,-0.308478,-0.889823,-0.157559,0.378889,-0.810743,0.466659,-0.559221,-0.331485,-0.513703,-0.363162,-0.280287,0.246284,-0.60557,-0.244436,-0.776612,0.415673,0.251588,-0.66695,0.610246,-0.403743,-0.904785,-0.0492982,-0.107674,0.206252,0.616736,-0.565196,0.485203,-0.52156,-0.173172,0.218086,0.0496346,-1.19674,0.1408,-0.787134,-0.531083,0.00657026,0.120958,-0.657359,-0.516747,0.126108,0.114632,0.02794,-0.627894,0.552455,-0.535774,-0.379524,0.357463,-0.245198,0.635432,0.390333,-0.167867,0.0446171,-0.939106,0.168368,0.116827,-0.211103,0.566684,0.241147,0.484043,0.0923569,-0.422512,-0.203563,-0.421539,0.575115,0.172856,0.213189,-0.198456,-0.461028,-0.431563,0.0275474,0.268111,0.167952,-0.721916,0.839516,-0.193133,-0.984502,0.241229,-0.531788,-0.0100574,-0.403192,-0.190293,0.199112,0.158726,0.44622,0.398404,-0.0708455 +3422.35,0.74366,0.0848144,4,1.66549,1.00457,-0.65355,0.193468,0.635571,-0.166137,-0.12464,-0.119589,0.0316283,-0.0447689,-0.149009,0.190584,-0.188812,0.365249,-0.0188735,0.631508,0.14137,-0.196938,-0.233799,-0.189242,-0.406153,-0.803236,-0.50953,-0.0178619,-0.238303,-0.145326,0.483601,0.316748,-0.181699,0.0649067,0.430395,-0.14743,0.162699,0.0496609,-0.241499,-0.123465,-0.788804,0.159488,0.289311,-0.11512,0.632956,0.363446,0.0695655,-0.808311,-0.326253,-0.161132,-0.71395,-0.00418461,0.166063,-0.0515221,0.218658,0.11954,0.45131,-0.0833355,0.474359,-0.406123,-0.0309475,-0.883638,0.742242,-0.297245,-0.039332,0.993871,-0.872729,-0.116728,-0.0891972,0.436078,0.201648,0.217476,0.530626,-0.490844,0.120475,-0.16566,0.452544,-0.723326,0.42397,0.408097,0.104579,0.520305,-0.296159,0.144091,0.222626,-0.372712,0.00366108,-0.0824492,0.0401157,-0.703161,-0.35882,-0.432537,0.294167,-0.479012,-0.00353034,-0.0485998,0.0308039,-0.100303,0.084516,-0.66904,0.0968142,-0.0153264,-0.227479,0.567045,-0.128649,-0.331564,-0.479163,0.127372,-0.108828,0.225452,0.0800727,0.0384652,0.0884561,0.390159,-0.462118,-0.413829,-0.309874,0.59681,-0.041443,-0.336367,-0.368768,-0.0738829,0.276842,0.64648,-0.302648,-0.374846,0.404063,-0.257911,0.398476,0.00690576,-0.316854,0.526648,0.354478,-0.595281,-0.147806,-0.38411,-0.166048,0.383254,-0.4073,0.0188741,0.145954,-0.287568,0.389703,-0.112426,-0.253118,-0.318093,0.197755,-0.267506,-0.309434,-0.203259,-0.134948,0.210633,-0.109041,-0.558291,-0.363712,0.144422,-0.0530283,-0.611889,0.0591478,0.0328768,0.163569,0.0970195,0.289873,0.165348,-0.0906808,0.165385,0.814804,-0.287599,0.130298,0.256356,-0.025633,-0.704994,-0.154374,0.126318,-0.475495,-0.291225,-0.00361434,-0.0612945,-0.288495,-0.273176,-0.584717,0.0337082,0.051182,0.523768,-0.516713,-0.656356,-0.562886,0.478206,-0.489573,-0.391917,-0.365922,-0.141978,-0.112514,-0.271504,-0.105397,0.0254888,-0.316521,-1.13581,0.378123,0.264408,0.10083,-0.348548,-0.809573,-0.0654213,-0.140538,-0.41766,0.849075,-0.347945,0.118681,-0.278103,-0.0871689,1.0373,0.0261838,-0.359662,-0.0756799,-0.165772,0.338344,-0.0199896,-0.0400835,0.0163621,-0.177615,0.302935,0.892851,-0.620486,-0.249797,-0.461722,0.533721,-0.0933195,-0.691,0.367488,-1.03826,0.00630765,0.540787,0.0698679,-0.163534,0.0592465,-0.606383,-0.250599,-0.123138,0.088255,0.35462,0.0699331,0.193519,-0.172262,-0.192961,0.16724,-0.400534,-0.13777,0.429646,0.314634,0.185349,0.0850122,0.47036,-0.586821,0.497183,-0.0807198,-0.069023,-0.185319,0.356723,0.566607,-0.375353,0.226061,0.0465777,0.191015,0.21664,0.676382,-0.243757,-0.02875,0.252445,0.995418,-0.0731176,-0.923112,-0.00690675,-0.144935,-0.0419209,-0.730435,0.129946,0.223749,0.214801,-0.0810107,0.24495,0.272828,0.531572,0.0292071,0.130396,-1.0934,-0.623321,-0.334014,0.109772,0.0216279,-0.359358,0.653568,0.221841,-0.144454,0.211837,-0.488012,0.0206397,0.203359,0.0490093,-0.819754,0.238091,0.276907,0.363694,-0.882656,0.705315,0.130484,0.161495,0.361225,0.401865,-2.01905 +3430.41,0.963223,0.0848144,4,1.73995,0.919887,-0.713473,0.244593,0.80566,-0.100395,0.0516769,-0.289806,0.316166,-0.445,-0.229914,-0.503186,0.076548,0.0895599,-0.606042,0.807266,0.148335,-0.0807459,-0.27223,-0.289218,-0.378436,-0.888939,-0.950506,0.0599452,-0.351941,-0.39039,0.342092,0.589956,-0.736282,-0.256364,0.681381,-0.6901,-0.146541,0.430107,0.0517127,-0.32671,-0.168649,0.616597,0.615092,-0.0235724,0.335279,-0.241739,-0.0268643,-0.417891,0.0469106,-0.568755,-1.04752,0.0912556,0.157365,0.235139,-0.543141,0.228056,0.0442729,-0.359,0.549666,-0.141173,0.180858,-0.976948,0.417187,-0.599026,0.304719,0.486939,-0.942066,-1.08546,-0.277008,0.340098,0.0329125,0.065902,0.227172,-0.604316,0.119622,-0.123095,0.34059,-0.326402,0.431128,0.173805,0.404279,0.289964,-0.0153763,-0.554702,0.294658,-0.570992,0.182463,-0.167294,-0.00914713,-0.472996,0.0913346,0.0307841,0.0350217,-0.378744,-0.0237824,-0.206205,-0.0983594,0.024044,0.323134,-0.41658,0.00216444,-0.191908,-0.0573793,0.534746,-0.272438,0.322359,-0.443832,-0.303755,0.0626967,-0.0845365,0.630288,0.0029247,-0.0260956,0.596026,-0.853798,-0.397468,0.0158039,0.395998,0.239533,-0.32365,-0.260868,-0.138749,0.609559,0.253372,-0.486847,-0.562453,0.128303,-0.531687,0.114975,-0.362909,0.0820293,0.0890005,0.54877,-0.178614,-0.0823738,0.122032,0.385789,0.602372,-0.329952,-0.059725,0.124871,-0.374825,0.519564,-0.635134,0.134048,-0.102475,-0.0389451,-0.540645,-0.12683,-0.114497,-0.305532,0.548262,-0.0913688,-0.378693,-0.633377,-0.197011,-0.260113,-0.150562,0.0233471,0.175264,0.224018,-0.558914,0.416899,0.945935,0.4593,-0.0829097,1.08358,-0.241259,-0.103414,0.0497593,-0.244691,-0.333609,0.416626,-0.0996032,0.140338,-0.356841,0.00496419,0.199129,-0.214475,-0.405722,-0.083912,-0.249487,0.195935,0.923465,0.161111,-0.584833,-0.601572,0.113839,-0.476611,-0.0392389,0.175373,-0.245711,-0.0288195,0.0123409,0.00323194,0.0606043,-0.735141,-0.713256,0.207716,0.050993,0.0471959,0.150054,-0.449352,-0.120625,-0.197374,-0.521513,0.711948,-0.0389707,-0.157843,0.322568,-0.29086,0.946935,-0.208572,-0.642766,-0.186384,-0.0663687,0.135935,-0.0552904,-0.172217,0.302128,0.2321,0.584504,0.426002,-0.421841,-0.0979264,-0.391955,0.549325,0.110053,-1.19134,0.596157,-0.541791,0.0981642,0.477556,0.0712068,0.188153,0.198004,-0.198029,-0.332429,-0.137699,0.443849,-0.349154,-0.33392,0.387751,-0.39675,0.125005,-0.234369,0.323827,0.239186,0.599188,0.511339,0.654385,-0.264731,0.0793042,-0.570875,0.24561,-0.253915,0.115131,0.257908,0.104476,0.474959,-0.0971586,0.566322,-0.04574,-0.179257,-0.0346024,0.598678,-0.121575,0.106832,0.333476,-0.192689,-0.0736411,-0.518391,-0.248131,-0.530958,-0.255014,-0.113232,0.26577,0.365729,-0.149979,-0.368297,0.463075,0.0451254,0.281233,-0.0339942,-0.351376,-0.647622,-0.361965,0.659502,0.223308,0.277438,-0.390659,0.607239,0.178129,-0.307456,-0.0673979,0.272132,-0.0945644,0.0359819,-0.317982,-0.392514,-0.212286,0.125364,-0.351369,0.0299476,-0.0456898,0.156191,0.187803,0.39521,0.433363,-2.39298 +3404.78,0.956002,0.0848144,4,1.60339,0.971749,-0.888293,0.324936,1.17236,-0.0544564,-0.0327787,0.321258,0.11645,-0.612258,-0.104083,-0.0168781,-0.177901,0.110866,-0.670544,0.692137,-0.0810345,-0.09269,0.394294,-0.254163,-0.313186,-0.915066,-1.15618,0.0634721,0.130158,-0.407346,0.551357,0.511311,-0.311081,0.004272,0.805946,-0.694098,0.175588,0.649744,0.189045,-0.309511,-0.210117,0.568758,0.826001,-0.326374,0.748432,0.0961519,0.351452,-0.448023,-0.0992825,-0.669692,-0.196649,-0.249696,0.135908,0.194466,-0.15379,0.111631,-0.134243,-0.461509,0.498319,-0.518851,0.205761,-1.1084,0.492874,-0.236734,0.193519,0.568406,-1.00876,-0.569443,-0.0939363,0.0052795,0.602089,-0.0708575,-0.0118944,-0.324955,-0.175914,-0.0813472,0.693446,-0.124812,0.505555,0.347529,0.936534,-0.322111,-0.238249,-0.111049,-0.14022,-0.340756,0.2421,-0.300377,0.274154,-0.604914,-0.354704,0.253155,-0.446479,-0.667855,0.552467,-0.530213,-0.101923,-0.0845413,-0.0339986,-0.781521,-0.185905,-0.494138,-0.166117,0.501132,-0.46082,-0.0606829,-0.357434,0.0415578,-0.477607,0.380608,0.41981,-0.281042,0.252071,0.814367,-0.808219,-0.176756,0.479738,0.442797,0.00299122,-0.190297,0.580405,0.228293,0.17842,0.639198,-0.146938,-0.317565,-0.113487,-0.539322,-0.187236,0.426343,0.175568,0.582307,0.611374,-0.129126,0.373761,-0.234767,0.46631,0.478713,-0.576234,-0.275269,-0.269713,-0.418732,0.381561,-0.162231,0.786133,-0.080647,-0.516686,-0.893878,0.24018,0.159511,-0.986049,0.602405,-0.191467,0.203866,-0.100107,-0.0982311,0.117778,-0.0879197,0.19169,0.668539,0.0988744,0.339109,-0.0232197,0.581365,0.235339,-0.0768237,0.490308,-0.0644291,0.312135,-0.0730707,0.31039,-0.10983,-0.0886418,0.138263,0.120739,0.183306,0.242973,-0.22362,-0.581021,-0.34933,-0.137161,-0.365099,0.127343,1.37643,0.050656,0.2925,0.0210678,0.194878,-0.409086,-0.181247,0.423706,-0.65377,0.131409,0.0959425,-0.623714,0.227209,-0.164612,-0.790588,-0.142957,0.268296,0.0962515,-0.310718,-0.804398,0.133463,0.0536251,-0.20325,0.632474,0.113108,0.16232,0.315126,-0.0452748,0.644005,0.0158221,0.063081,-0.193867,-0.519568,0.0305465,-0.597963,-0.169017,0.627455,0.403089,0.458834,0.693229,-0.760115,0.280316,-0.178602,0.588614,0.139195,0.0169713,0.468908,-0.306772,0.341351,0.435786,-0.302731,-0.118052,0.0094492,-0.293514,-0.47528,-0.179956,0.525244,0.0724035,-0.148183,0.570617,-0.797859,-0.314664,0.106198,-0.257866,-0.0497976,0.336785,-0.0250685,0.757815,0.0701243,0.114084,-0.487198,0.309526,-0.323518,0.315846,-0.297492,0.014407,0.408016,-0.00833017,0.420206,0.349246,-0.0871663,-0.067517,0.26977,-0.436524,-0.0319605,0.0403948,0.108687,-0.344508,-0.333702,0.1729,-0.530285,-0.101503,-0.080122,-0.0353145,-0.283312,0.0382481,-0.0842818,-0.0797127,0.542295,0.454985,0.143974,-0.13577,0.0960796,-0.496598,-0.176028,0.0386723,0.183949,-0.599237,-0.0437484,0.191673,-0.84374,0.0938436,-0.385603,-0.0267192,-0.27105,0.0244096,-0.155506,-0.371593,0.22215,-0.422461,-0.243039,-0.207095,0.122388,0.230187,0.349841,0.479778,-3.83443 +3418.8,0.908101,0.0848144,4,1.56212,0.81833,-1.41271,0.590763,0.884764,-0.163105,-0.255554,-0.522108,0.44469,0.143463,0.354756,-0.381592,-0.262273,0.0977699,-0.508637,1.01593,-0.0283887,0.0337662,-0.389126,0.00645319,-0.0757458,-0.482233,-0.410041,0.207409,-0.395994,0.121416,-0.454086,0.162357,-0.57269,-0.0198261,0.885131,-0.398939,0.176873,0.570793,-0.110993,-0.140391,0.82816,0.613427,0.542764,-0.585076,0.959888,0.577564,0.0111875,-0.363791,0.158811,0.72811,-0.371325,0.277682,0.0948119,0.0286875,-0.405181,0.484178,0.160109,-0.315255,0.370442,0.460781,-0.250427,-0.334366,0.266592,-0.606968,-0.0343512,0.892041,0.238669,-0.871001,0.479434,0.351229,-0.00201802,0.34327,0.546731,-0.271052,0.295994,0.317998,0.230598,0.122799,0.416344,0.207015,-0.19197,-0.0456063,-0.0981071,0.140644,0.484803,-0.0789669,0.150914,0.0352697,-0.0947766,-0.390586,0.440148,-0.18721,0.386927,-0.295357,-0.0855048,0.755752,-0.520189,-0.0694708,-0.134479,-0.717338,0.474757,0.0199886,0.588216,0.136798,0.206896,-0.0711405,-0.467219,-0.438914,0.604775,-0.899346,-0.19735,-0.0504102,0.151449,0.587744,0.69332,0.250955,0.38755,0.436431,-0.131422,0.283933,-0.842536,0.21424,0.205413,-0.145193,0.101427,-0.10764,0.00123354,-0.105475,-0.0908608,-0.445001,0.0839241,-0.186367,0.13198,-0.642349,-0.256588,0.0052584,0.193227,0.209135,0.0155719,-0.281963,-0.151394,-0.235685,0.246731,-0.439573,-0.633585,0.121623,0.157207,-0.380113,-0.18735,-0.0191759,0.23235,0.0599339,-0.61137,-0.339315,-0.14618,-0.107882,-0.283318,-0.132988,-0.29927,0.149324,0.193176,0.0394384,0.00884268,-0.385256,0.518682,-0.379131,0.649454,-0.0381426,-0.483549,0.299994,-0.310255,-0.25652,-0.109319,0.36559,0.268004,-0.185878,-0.223875,-0.760822,-0.00715198,0.196542,0.160397,-0.385292,0.0672226,0.309311,0.365922,-0.397059,-0.0890757,0.0522087,0.475739,-0.185278,-0.254572,-0.0895489,0.0354484,-0.509512,0.562899,0.275336,-0.332831,-0.723154,0.36875,0.08687,0.163089,-0.106542,-0.366636,-0.127541,0.0260064,-0.530399,-0.00289195,-0.712694,-0.181375,0.00603155,-0.145643,0.633633,-0.121556,0.225414,-0.296348,-0.680361,0.427138,-0.0718117,-0.848502,-0.270266,-0.1806,-0.0140892,0.077569,0.0141808,-0.392453,-0.506268,-0.254297,0.325251,0.0404495,0.584435,-0.167809,-0.161273,-0.0460397,0.479261,-0.140273,0.175782,-0.0388181,-0.114753,-0.646138,0.517725,-0.0957428,0.0975746,0.730909,-0.0667112,-0.174223,-0.0252332,0.882395,-0.281863,0.276276,0.590439,0.276921,0.0373703,0.0627407,-0.223415,0.231785,-0.728136,0.196788,0.159534,0.331884,0.0789915,-0.511149,-0.172641,0.178152,0.166687,0.0923187,0.677055,0.307461,0.374575,0.650122,0.391814,-0.234223,-0.023993,-0.212925,0.123376,-0.340035,-0.479334,-0.991536,0.249578,0.0645111,-0.311825,0.253922,-0.744763,0.623498,-0.174139,-0.129324,0.0786996,-0.275504,-0.572827,0.384616,0.364709,0.427326,0.566893,-0.0694739,0.00409341,0.0802073,0.0643567,-0.0382465,0.390059,-0.0051345,-0.871015,0.138688,-0.115187,0.0239156,0.0483033,0.0778218,0.122918,0.155599,0.350597,0.394461,-2.59909 +3461.22,0.998483,0.0848144,4,1.57382,0.833473,-1.49184,0.536982,0.738795,-0.129795,-0.305089,0.245815,-0.132665,-0.160932,-0.0941423,-0.0150951,-0.141216,0.127588,-0.40054,0.827776,-0.198818,0.311308,0.0420043,-0.172938,-0.179668,-0.908477,-0.758678,0.287584,-0.131574,-0.307014,0.310784,0.0466745,-0.402455,0.0318194,0.932202,-0.21541,-0.0597786,0.365827,-0.036641,-0.11151,-0.90335,-0.000188379,0.914848,0.0152049,0.871919,0.423922,0.695736,-0.581105,0.00277146,-0.48343,0.060784,0.170427,0.283697,0.255383,0.228897,0.404437,0.0751624,0.0110295,0.378539,-0.338983,0.0133072,-0.734132,0.584356,-0.110317,0.13848,0.764518,-1.23339,-0.326865,0.0232426,0.205259,0.124373,-0.296882,-0.142644,-0.329165,-0.376695,0.181458,0.853725,0.0599321,0.0516663,0.43079,0.269987,0.0493011,-0.476195,-0.059223,0.0530498,-0.409177,0.179466,-0.135649,-0.358721,0.0276078,0.312248,-0.256541,-0.121342,-0.819737,-0.284499,-0.187367,0.224952,-0.0297014,0.163188,0.0212799,0.44232,-0.38205,0.134323,0.559467,0.114862,0.433946,-0.298412,0.0254582,-0.0495363,-0.194184,0.0858562,-0.27528,0.323521,0.361675,-0.685681,-0.719592,0.0225081,0.381524,-0.396261,-0.108059,-0.0123842,0.0389365,0.0598751,0.0942216,-0.667668,-0.0738435,-0.269413,-0.430973,0.18388,0.355227,0.520489,0.257587,0.304963,0.0489664,0.497233,-0.0632218,0.362707,0.227286,-0.263993,-0.102987,0.428556,-0.297571,0.425297,-0.250082,0.108703,-0.260868,-0.0482406,-0.28521,0.455585,0.171305,-0.345782,0.376272,-0.205371,-0.121385,0.227332,0.0667362,0.0148151,0.140491,0.722562,0.98238,0.196933,0.288412,0.14997,0.367216,0.13043,0.20376,0.469102,-0.121144,0.063033,0.0637972,0.390513,-0.0809842,-0.172639,-0.0108245,0.314929,-0.0608461,0.216547,0.023993,-0.13063,-0.545012,-0.524689,0.0372225,0.12043,0.805182,-0.271061,0.186417,0.287149,0.166595,-0.141006,-0.596245,-0.291367,-0.277877,0.199501,-0.32868,-0.365949,-0.19061,-0.163113,-0.208044,-0.327254,0.480659,-0.213863,0.0777278,-0.320524,-0.128885,-0.204285,0.018118,0.387602,0.203908,0.463139,-0.381469,-0.289115,0.574429,-0.172283,-0.464458,0.0809647,-0.00808472,-0.312156,0.00699677,0.416848,0.305915,-0.267815,0.193952,0.619091,-0.381283,0.188111,-0.460331,-0.340616,0.139054,-0.370154,0.218504,-0.105375,-0.331229,0.552929,-0.400688,-0.101159,0.0349782,-0.417863,-0.0416736,-0.293386,0.29837,0.0781307,0.452777,0.290582,0.014376,0.0462362,0.103765,-0.28422,0.224019,0.67675,-0.444892,0.65445,0.190728,-0.0210655,-0.131139,-0.122724,-0.447114,0.551168,-0.524181,-0.308434,0.283047,0.00767196,0.0979906,0.0949696,0.0828723,0.147516,0.192998,-0.184573,0.105609,0.213273,0.294584,-0.217765,-0.409426,0.163865,-0.101102,0.0462526,0.0848289,0.3566,-0.0325289,0.115013,0.12352,0.216786,0.0459285,-0.12044,0.181378,-0.461471,-0.359074,-0.624553,0.187293,-0.224133,-0.00360175,-0.411927,0.070445,-0.0217696,-0.231427,0.213558,-0.0178919,0.0600974,-0.194742,-0.33821,0.0598231,0.173629,0.165891,-0.00818047,-0.251981,-0.0434678,0.0802245,0.221402,0.283239,0.470533,-2.04533 +3431.76,0.923612,0.0848144,4,1.58396,0.892896,-1.42184,0.539201,0.846237,-0.118732,0.0587214,0.163384,-0.245529,-0.798144,0.146689,-0.176364,-0.539755,0.205845,-0.50972,1.18441,0.0110845,0.0504361,-0.141212,-0.428143,-0.333747,-0.657975,-0.319973,-0.102961,-0.671231,0.00545237,-0.143128,0.263074,0.20321,0.0916348,0.919956,-0.174917,0.254047,0.173053,-0.309076,-0.360924,-0.610453,0.0605459,0.668485,-0.39198,0.510438,0.432986,1.06009,-0.969562,-0.163569,-0.451739,-0.217746,0.245876,0.262109,0.0338182,-0.16331,-0.151093,0.269995,-0.106428,0.219712,-0.0136655,-0.134779,-0.375816,0.412128,-0.382549,0.393046,1.12983,-0.731195,0.000705076,0.1932,0.0952612,-0.312554,-0.127617,0.346159,-0.225683,0.240965,0.435489,0.29621,-0.0490692,-0.0767693,0.359849,0.250173,0.181496,-0.314817,0.259911,0.162306,0.218949,0.208498,-0.0816617,-0.0274697,-0.585422,-0.00645947,-0.226872,0.0676814,-0.29994,0.153401,-0.485914,-0.0616808,-0.315861,-0.113304,-0.0539617,0.778033,-0.371728,0.521786,0.617299,-0.330882,-0.161357,-0.544854,-0.221308,-0.697262,-0.036599,0.439645,-0.0833607,-0.157934,0.45636,-0.322038,-0.511675,0.0981996,0.613855,-0.0481011,-0.302188,-0.622507,-0.0276478,0.0785556,0.18863,-0.438065,-0.00627326,-0.635222,-0.209385,-0.0606457,0.283097,0.259138,0.0518652,-0.0899232,-0.0637527,-0.203331,-0.183348,0.0928805,-0.104706,0.153466,-0.485236,-0.10068,-0.0827875,0.206458,-0.0874722,-0.772347,0.180619,0.50645,-0.332368,0.20839,0.280644,-0.165413,0.187337,-0.426116,-0.149079,0.0208289,0.022113,0.265615,0.384961,0.644275,0.502948,0.158386,-0.271526,0.448082,-0.0836909,-0.152871,0.146127,0.744521,-0.0120865,-0.0921411,0.174315,-0.119615,-0.201964,0.0391558,-0.316257,0.431736,-0.0474329,-0.133621,-0.0321762,-0.19011,-0.0274021,-0.100586,0.0690479,0.124344,0.515618,0.269072,-0.516984,0.39895,0.607502,-0.227508,0.122389,-0.100946,0.059198,-0.704913,-0.13654,-0.550587,-0.58629,-0.428241,-0.374313,-0.171253,0.184777,-0.0222011,-0.148578,-0.437076,-0.43733,-0.0109182,-0.269516,0.121841,0.136424,-0.271213,0.173462,-0.197103,0.679108,-0.406506,-0.704062,-0.0321456,-0.460147,0.28277,-0.155208,0.329038,0.177108,-0.31056,-0.0654478,0.158749,-0.428495,0.36113,-0.366521,-0.0675329,0.275748,-0.405754,0.211188,-0.215921,-0.05159,0.661568,-0.216392,-0.871443,0.217302,0.11447,-0.446014,-0.434661,0.495981,0.22874,0.189492,0.856206,0.101628,0.28037,0.0977689,-0.0798649,0.329828,0.517526,-0.00335655,0.362785,-0.1842,0.327904,-0.0325308,-0.107109,-0.660635,0.149284,0.0663248,0.0581159,0.285191,-0.338355,0.030525,0.380708,0.193026,0.0664801,0.239524,0.210806,0.122245,0.284782,-0.0627603,-0.184268,0.176153,0.329,0.189195,0.0110754,-0.0129192,0.0565666,0.0829475,-0.352893,0.367343,0.465435,0.0319069,-0.322617,0.21528,-0.388208,0.0973927,0.202741,0.15089,-0.314019,0.016064,-0.350749,0.0885332,0.239733,0.229988,-0.087662,0.124063,-0.122949,0.339925,-0.357677,-0.523238,0.33735,0.0230478,-0.354778,0.0576923,0.326551,0.124251,0.205734,0.352493,0.453579,-2.53857 +3432.47,0.752282,0.0848144,4,1.51003,0.768656,-1.28614,0.395769,0.454882,-0.128156,0.200682,-0.138048,0.772429,0.522504,-0.175496,-0.520633,-0.120539,0.434281,-0.277081,0.910087,0.26648,-0.175231,-0.171423,-0.119664,-0.0765277,-1.02073,-0.845385,0.18799,-0.725031,-0.491447,-0.165809,0.352745,-0.510097,0.236368,0.726203,-0.578618,-0.164486,0.177626,0.32815,0.281827,0.244518,1.00348,0.804253,-0.133439,0.960475,1.10903,0.483975,-0.580854,0.0691633,0.907241,-0.468703,0.0197531,0.556184,0.187856,0.387447,0.454959,-0.029582,-0.156314,0.666413,-0.350285,0.179154,-1.17693,0.943987,-0.11366,-0.308705,0.988619,-0.534266,-1.69222,-0.260034,-0.0580971,0.0757194,-0.00106767,-0.307473,-0.301162,0.0549149,0.237499,0.573638,0.40847,0.271427,0.296075,0.227747,0.0448432,-0.0751321,-0.285417,0.537602,-0.778237,0.290042,-0.0871121,-0.190105,0.174141,0.03807,-0.19646,-0.112796,-0.359822,-0.296569,0.519161,0.101578,-0.129721,0.321863,-0.358377,-0.274934,-0.200456,-0.136311,0.19169,0.355235,-0.324627,0.0634343,-0.0474667,0.719601,-0.081818,0.127551,-0.404548,0.0525422,0.224294,0.487074,0.225134,-0.148854,0.388787,0.170886,0.0521729,0.458643,-0.0789499,0.071298,-0.29976,-0.662984,0.106007,-0.00209704,-0.0914385,-0.23578,-0.297525,-0.101488,0.080449,0.516752,-0.250732,-0.04938,0.0460301,-0.207811,0.309306,-0.473635,0.310169,0.0739512,-0.137241,0.410433,-0.633077,0.0445834,-0.0528453,0.419128,-0.32092,0.288381,-0.317467,-0.26225,0.0753735,0.211061,-0.357395,0.0292273,0.301071,-0.309572,-0.567707,-0.463791,0.194762,0.107246,0.160555,-0.183394,-0.0523579,0.206689,0.0685488,0.605938,0.0181779,-0.000284094,-0.0836506,-0.13931,-0.350852,-0.518553,0.432924,-0.253822,0.201997,0.250925,0.0475388,-0.116895,-0.0276761,-0.739159,-0.300744,0.787368,0.845503,0.124829,0.0981746,-0.281481,-0.920303,0.234976,-0.43933,-0.324008,-0.339658,0.810896,-0.395554,0.237258,0.696696,-0.0693799,-0.651903,0.178981,0.132348,0.0985739,-0.465266,-0.161285,0.27765,0.106181,0.486285,0.158871,-0.110242,0.0966713,-0.780454,-0.335619,1.08698,-0.0474029,0.457605,0.0349154,-0.276997,-0.266594,0.304886,-0.105061,0.207064,-0.315233,0.65512,0.172543,-0.0119337,-0.389328,-0.444764,0.173994,-0.0355514,0.0313519,0.340329,-0.618461,-0.501143,-0.0924351,0.415965,0.402875,0.0584101,-0.131301,-0.133692,-0.1306,0.00417161,-0.218684,0.0437465,0.235768,-0.301942,-0.559682,0.106998,-0.0756272,-0.306785,0.0165588,0.382372,0.343908,0.445296,0.0433725,-0.522126,0.17942,-0.655316,0.383099,-0.366871,-0.403952,0.179642,-0.0765718,-0.130507,-0.535376,0.111514,0.258862,0.490183,-0.314995,0.1417,-0.391861,-0.0452686,0.223262,-0.328144,-0.541688,-0.0845386,-0.394659,-0.201883,-0.373264,0.0892734,0.100524,-0.26793,0.0798849,-0.48713,0.226161,0.362272,0.306238,-0.0593748,-0.581291,0.137199,0.408259,-0.278923,0.0304246,0.402711,-0.202261,-0.413528,0.37004,0.169802,0.145438,-0.163031,-0.122455,0.0328635,0.209917,0.0454866,0.302447,-0.531995,0.321029,0.132963,0.300661,0.364641,0.548326,-1.02656 +3434.44,0.991102,0.0848144,4,1.51187,0.814846,-1.21816,0.405754,0.456228,-0.126144,0.142385,-0.167874,0.939394,0.604776,-0.0754141,-0.553368,-0.0242836,0.51808,-0.289644,0.981732,0.35421,-0.167704,-0.134029,-0.116688,-0.115518,-1.12476,-0.912582,0.159797,-0.811738,-0.405184,-0.161046,0.290197,-0.307332,0.19454,0.753918,-0.641955,-0.225378,0.241909,0.339587,0.213037,0.0176103,0.987196,0.697407,-0.176862,0.954387,0.93399,0.390551,-0.547473,0.0439447,0.811521,-0.681989,0.0460216,0.567188,0.26682,0.434326,0.437484,-0.0450251,-0.285556,0.628304,-0.490404,0.263763,-1.18587,0.896828,-0.0679449,-0.296393,1.07661,-0.620474,-1.57112,-0.210343,-0.0776672,0.225974,0.018175,-0.38788,-0.287747,-0.0479563,0.187686,0.567475,0.359343,0.326595,0.269164,0.364939,-0.0326482,-0.121841,-0.230487,0.532998,-0.728257,0.242145,-0.0841194,-0.218686,0.120246,-0.0164083,-0.0434503,-0.144933,-0.418858,-0.350845,0.366585,0.0865469,-0.143998,0.313566,-0.409057,-0.187016,-0.282638,-0.200978,0.227417,0.329384,-0.221504,0.00415,0.113674,0.635646,-0.187495,0.1416,-0.500202,0.259953,0.444981,0.539115,0.241659,-0.11686,0.439563,0.0791965,0.0625224,0.414436,-0.076762,0.138766,-0.190707,-0.677555,0.0947184,0.141898,-0.0912978,-0.0959196,-0.184175,-0.177765,0.028424,0.437342,-0.291659,-0.136335,0.0111009,-0.309542,0.246077,-0.44744,0.32776,0.0810384,-0.226084,0.472731,-0.655293,-0.0401487,0.0423256,0.409603,-0.301571,0.373191,-0.191979,-0.15056,0.0937511,0.169271,-0.286316,-0.108514,0.305382,-0.421621,-0.60637,-0.393536,0.111979,0.0222165,0.216536,-0.228351,-0.147779,0.258843,0.0753464,0.700161,-0.0106865,-0.0139348,-0.0226372,-0.0895676,-0.362574,-0.579843,0.522497,-0.157087,0.280214,0.14663,-0.0267277,-0.0719767,-0.0561418,-0.783787,-0.195662,0.8211,0.862413,0.316035,0.0501621,-0.404495,-0.935659,0.343011,-0.332088,-0.325778,-0.341239,0.716407,-0.311123,0.265425,0.703477,-0.0329353,-0.577677,0.228512,0.179536,-0.0656121,-0.367633,-0.192246,0.359159,0.0751344,0.449153,0.13477,-0.224922,0.109356,-0.819569,-0.40654,1.14478,-0.173317,0.357587,0.00100496,-0.23518,-0.254187,0.33101,-0.0123779,0.0650444,-0.26782,0.610169,0.179042,-0.0734116,-0.410163,-0.473074,0.292528,0.066066,-0.0315406,0.271373,-0.562974,-0.458101,-0.0793852,0.529314,0.450692,0.0576347,-0.288166,-0.245616,-0.131861,-0.0179302,-0.181421,0.0308925,0.216721,-0.311838,-0.625254,0.145865,-0.185701,-0.308276,0.00193683,0.510631,0.352934,0.400568,0.20198,-0.563454,0.116619,-0.655971,0.419542,-0.282505,-0.336923,0.218834,-0.0232724,-0.178623,-0.645315,0.162284,0.252168,0.432436,-0.224749,0.056777,-0.351113,-0.0644106,0.262859,-0.284133,-0.530008,-0.101681,-0.299803,-0.169254,-0.338316,0.0735701,0.0121688,-0.298199,0.176068,-0.610557,0.283238,0.278239,0.38433,0.00992407,-0.532893,0.128472,0.33834,-0.191539,0.0452397,0.559874,-0.209318,-0.443305,0.351609,0.174413,0.206208,-0.198685,-0.145193,-0.058287,0.145485,0.00416373,0.339733,-0.543504,0.267847,0.119791,0.312978,0.346108,0.559445,-1.15654 +3410.59,0.901853,0.0848144,4,1.54783,0.816486,-1.11417,0.337573,0.332346,-0.208692,-0.0143373,0.189231,-0.0528612,0.0119795,-0.042603,-0.390977,0.167924,0.418837,-0.263503,0.817388,0.238755,0.01808,0.0297095,-0.235048,-0.239286,-0.698624,-0.308609,0.303777,-0.55418,-0.0465397,-0.241535,0.205884,-0.365055,-0.274098,0.688261,-0.535093,-0.406011,0.0172888,-0.302829,0.652609,0.0478384,1.36339,0.674829,0.0428193,0.789636,0.773167,0.140055,-0.376668,-0.0608156,0.227509,-0.972222,-0.129919,0.599373,-0.0270534,0.330681,0.598786,-0.220875,-0.172625,0.603542,-0.0579673,0.164919,-1.56015,0.9139,0.243299,0.0284359,0.984537,-0.511734,-1.88033,0.346402,0.15032,-0.453648,-0.127857,-0.212499,-0.336953,-0.240742,0.326203,0.473311,0.0745492,0.27164,0.289521,0.549235,0.29458,0.407691,-0.193448,0.406708,-0.637389,0.0477625,-0.622548,-0.0136813,0.00504585,-0.274036,-0.0448381,0.0175033,-0.180864,0.376263,-0.0603482,0.11353,-0.0260289,-0.697436,0.145007,-0.792676,-0.136165,0.586388,0.443291,0.249648,-0.000691772,-0.306252,-0.268306,-1.15448,-0.528141,0.649037,0.27148,-0.0634431,0.262556,-0.28008,0.193233,0.0998483,0.637351,0.603182,-0.267886,0.0889267,-0.150103,0.191335,0.0914722,-0.868643,0.435355,-0.0271009,-0.00480999,-0.154361,-0.262055,0.160333,-0.218727,-0.236296,0.0106652,-0.33364,-0.214467,0.219995,0.0733271,-0.398849,-0.198243,-0.191892,0.0428797,0.396505,-0.925774,0.0396116,-0.145407,0.424368,-0.206352,-0.104755,-0.193589,-0.0310095,0.752153,-0.0623608,0.0754654,-0.129866,0.161196,0.196139,-0.528069,0.205112,-0.507572,-0.209914,-0.559701,0.309352,0.124235,-0.088621,-0.504575,0.539711,-0.0758276,0.503958,0.429324,0.291252,-0.405549,-0.592754,-0.164432,0.203005,0.604797,0.0578755,-0.0932043,0.0735319,-0.0434993,-0.610804,0.133876,0.34005,0.721841,0.413972,0.186172,0.130867,0.143955,0.244118,-0.300022,0.1228,0.259664,0.753564,-1.27492,-0.493836,-0.0357027,-0.04093,-0.500553,-0.140624,0.293923,0.198707,-0.635402,-0.759051,-0.296632,-0.232669,0.25098,-0.181918,-0.18811,0.0457936,-0.505453,-0.504241,0.900436,0.2341,0.3838,0.339923,0.2588,0.0646847,0.204497,-0.710457,0.360334,-0.20748,0.482579,-0.128836,-0.818083,0.0662489,-0.081301,0.0297936,0.0842955,0.0773285,0.140256,-0.640068,-0.212704,-0.137367,0.0351864,0.31468,0.215332,0.150496,-0.156166,0.154426,-0.0544638,-0.121431,0.255905,0.626706,0.267125,-0.032916,0.465066,-0.0687222,0.159467,-0.0399678,0.363227,0.696421,0.0902146,-0.400245,-0.314394,-0.329565,-0.60248,0.122759,-0.470375,0.0743544,0.558285,0.0278451,0.00563461,-0.179853,0.0136733,0.488081,0.308411,0.101469,0.376674,0.299391,0.21509,0.0572117,0.486067,0.234138,0.132648,-0.394053,-0.743431,-0.420338,-0.0728933,-0.221092,-0.450912,0.722045,-0.260244,0.981828,-0.070445,0.0653821,0.0547223,-0.956916,0.563782,-0.267461,-0.112099,-0.301881,-0.323943,0.102816,-0.134951,0.167053,-0.234027,-0.189047,0.0357053,-0.117997,-0.43999,0.478788,0.0437018,-0.0366378,-0.0215732,0.192841,0.152494,0.378826,0.390505,0.615489,-0.681558 +3394.12,0.813652,0.0848144,5,1.4602,0.839299,-1.27454,0.3864,0.276662,-0.0110562,-0.0254042,0.291944,-0.306107,-0.00890445,-0.0510525,-0.318474,0.257226,0.655807,-0.350384,1.07613,0.255489,0.0605202,0.12641,-0.329777,-0.344994,-0.486941,-0.512706,0.464691,-0.523093,-0.0754995,0.113156,0.523899,-0.714171,-0.113498,0.594613,-0.659576,-0.169958,0.293057,-0.267726,0.43577,0.0468939,1.61889,0.545178,0.777417,1.10172,1.10248,-0.157607,-0.573118,0.0396838,0.0611949,-0.789355,-0.192658,0.545293,-0.226499,0.485366,0.664177,-0.0798897,-0.00676691,0.520182,-0.170391,0.214362,-1.57162,0.979478,-0.122798,-0.11551,0.882533,-0.337853,-1.16013,0.194811,-0.178837,-0.570492,-0.0259104,0.174208,-0.36607,-0.0253339,0.274459,0.520568,0.420134,0.257985,0.231792,0.248873,0.451972,-0.0445809,-0.218392,0.543258,-0.502049,0.0837794,-0.659245,-0.281534,0.240228,-1.02395,0.0236824,-0.114745,-0.15544,0.130762,-0.258142,-0.0837645,0.078703,-0.737142,0.242373,-0.630744,-0.37556,0.517677,0.642781,0.171429,-0.262983,-0.0782552,-0.59181,-0.77639,-0.145152,0.509858,0.143083,0.366442,0.723791,-0.551538,0.178985,0.0778058,0.683059,0.57668,-0.109051,-0.109179,-0.408066,0.0184267,0.279704,-0.764072,0.341686,-0.0713398,-0.0604282,-0.138835,-0.149752,0.188841,-0.0434361,-0.0384422,-0.172656,-0.0746411,-0.321664,0.373729,0.264449,-0.198775,0.0753091,-0.0918354,-0.0529032,0.505009,-1.17815,-0.145399,0.0655003,0.226993,-0.555587,0.0134109,0.0222482,-0.0774053,0.572741,0.0112378,-0.107782,-0.00113712,-0.0291924,0.213674,-0.741813,0.0648459,-0.101907,-0.0527301,-0.558927,0.15342,0.36199,-0.0647767,-0.375312,0.264942,-0.1131,0.108504,0.375652,0.173421,-0.463679,-0.336958,-0.217056,0.0785646,0.455991,0.148307,-0.0310341,0.0881223,0.367529,-0.591424,0.284361,0.444641,0.320962,0.55588,0.569796,0.0765438,0.0992049,-0.0856795,-0.38524,-0.207995,0.115769,0.628297,-0.8551,-0.476054,0.208712,-0.0174756,-0.626596,-0.403034,-0.11368,0.102363,-0.542163,-0.635107,-0.183274,-0.416966,0.0511454,-0.165373,-0.307848,-0.178141,0.0382505,-0.464752,1.05856,0.382121,0.36705,0.207309,0.135656,0.147531,0.250055,-0.864725,0.323962,-0.12342,0.463055,0.256201,-0.537953,-0.411069,-0.0115032,0.44624,0.243384,0.158315,0.399159,-0.636598,-0.0338775,-0.0864225,0.374995,0.412214,0.275872,-0.0923294,-0.0593296,0.145309,-0.116759,-0.130601,0.288024,0.945728,0.245296,-0.0810601,0.568089,0.148797,-0.0506524,0.0863626,0.181608,0.598103,-0.256128,-0.343773,-0.320946,-0.151585,-0.386601,0.138227,-0.182032,0.0290128,0.691588,0.105678,0.240191,0.126091,-0.224287,0.447924,0.361015,-0.0369887,0.586741,0.160319,0.178441,0.0359829,0.193049,0.195262,0.0361131,-0.0225581,-0.526784,-0.828855,-0.36311,-0.371454,-0.350406,0.460373,-0.555977,1.21454,-0.126929,0.155733,-0.00192772,-0.809058,0.445573,-0.265776,-0.0736543,-0.266227,0.111201,0.192082,-0.0207612,0.239614,0.0776596,-0.270915,0.188547,0.169614,-0.195561,0.544805,0.208587,-0.36297,-0.225983,-0.263977,0.128345,0.30227,0.358252,0.549791,-0.636115 +3414.33,0.987537,0.0848144,4,1.53318,0.787999,-1.06417,0.39066,0.268296,-0.0426909,0.139586,0.43487,0.279117,-0.226087,0.261221,-0.070362,-0.0600632,0.790032,-0.142934,0.684783,0.548114,-0.273457,-0.27463,0.0506022,0.105364,-0.910803,-0.271466,0.380931,0.0323125,-0.389864,-0.276836,0.228689,-0.292235,0.0747852,0.775382,-0.310435,0.0502,0.397851,-0.245119,0.525572,-0.0920034,1.17342,0.626514,-0.51739,0.845547,0.91902,-0.0792201,-0.42557,0.272815,-0.0981534,-0.417848,-0.113857,0.54674,0.0110971,0.219109,0.493769,0.0035752,-0.332174,0.689326,-0.0249604,0.178946,-1.13758,0.564821,0.0460927,0.0221531,0.797106,-0.938981,-0.363785,0.0342769,0.118569,-0.641203,-0.267248,0.30797,-0.456893,-0.632099,0.047667,0.254159,0.457758,0.780581,0.0168492,0.168009,-0.0300095,-0.376615,-0.14302,0.0401628,-0.700022,0.221578,0.0801638,0.0929071,0.368162,-0.488435,-0.70347,-0.0393206,-0.192502,0.325336,-0.0585475,-0.129495,0.288598,-0.707112,0.321456,-0.36808,-0.297737,-0.186995,0.114936,-0.261764,-0.277888,-0.548683,0.287675,-0.434047,0.102031,-0.016788,-0.114463,0.527705,0.28378,-0.45682,-0.399239,0.0806966,0.432177,0.418952,-0.196844,-0.194343,0.0255499,0.109489,-0.110851,-0.68034,-0.0547003,0.121095,-0.608184,0.0902186,-0.702731,0.316335,-0.178612,-0.0158012,-0.26906,0.420609,-0.325233,-0.239196,0.33792,-0.217517,-0.0543121,0.222311,-0.0419671,0.455715,-0.284842,-0.0220761,-0.293139,0.200281,-0.723379,0.487583,0.0260852,0.287573,0.998225,0.159219,-0.0347916,-0.0994581,0.170253,0.243347,-0.555521,0.122225,-0.181832,-0.226026,-0.403848,0.305766,-0.205895,0.322891,-0.359714,0.478199,0.0970105,-0.0702144,0.726447,-0.0396905,-0.440333,-0.533186,0.100602,0.443105,0.380457,0.141346,0.332348,0.0208106,0.536505,-0.747634,-0.015304,0.207371,1.42226,0.389544,-0.0159802,0.477424,-0.210959,-0.190679,-0.768094,-0.218042,-0.220898,0.440143,-0.239319,-0.118766,-0.215248,-0.23626,-0.250606,-0.0307818,0.498834,-0.209496,0.00674525,-0.537184,-0.335738,-0.327456,0.117846,-0.478009,0.319349,-0.418284,0.239334,-0.766074,1.16401,0.356712,-0.10045,-0.0936965,0.185616,-0.0291466,-0.597904,-0.195021,0.853622,-0.124889,0.103479,-0.319986,-0.331174,-0.0257599,-0.427192,0.278036,0.0400825,-0.424175,0.474062,0.270072,-0.141591,0.0401054,0.136981,-0.350204,0.234613,0.0303583,-0.0866144,-0.16523,0.300396,-0.48484,-0.0514081,0.50695,0.0983814,-0.791263,0.513936,0.40309,0.0370658,0.430393,0.0996426,0.0156076,-0.117686,-0.282851,-0.420239,0.24165,-0.560461,0.153164,-0.108879,0.0363706,0.423313,-0.397116,0.034991,-0.0860724,0.200537,0.110271,0.39296,0.458644,-0.121433,0.457924,-0.0206468,-0.0219934,-0.0410992,0.29064,-0.138537,-0.610946,-0.488332,-0.288218,-0.45622,-0.448178,-0.58808,-0.0935042,0.0817854,0.355114,0.0729267,-0.83299,-0.0137661,-0.637577,-0.356105,-0.286175,-0.0175201,-0.135599,-0.112123,0.484062,-0.128991,-0.105579,0.0661543,0.160039,0.609382,-0.251911,0.0321181,0.429124,0.0207186,-0.106669,0.322145,-0.879437,0.147584,0.26113,0.384167,0.511009,-0.551332 +3422.62,0.992149,0.0848144,4,1.53032,0.895403,-0.771682,0.270044,0.296455,-0.0250682,0.0932157,0.337001,0.154994,-0.200133,0.289419,-0.0929153,-0.181075,0.706363,-0.324663,0.607289,0.441915,-0.218578,-0.535377,-0.0877522,-0.0391428,-0.815468,-0.541045,0.397482,-0.0878909,-0.245809,-0.282556,0.0584991,-0.184649,0.101717,0.70488,-0.310125,0.144007,0.479702,-0.207854,0.505904,-0.405022,1.17611,0.455093,-0.25909,0.895238,0.751872,-0.00481869,-0.386666,0.234068,-0.232468,-0.398957,-0.0136998,0.575992,0.0269291,0.343176,0.364928,0.00530527,-0.102961,0.469267,0.00578279,0.0906845,-1.10346,0.495183,0.0173073,0.187292,0.707266,-0.925209,-0.588788,-0.106089,-0.0295721,-0.493742,-0.379686,0.407001,-0.453864,-0.473349,0.144085,0.121212,0.413693,0.702495,-0.0833177,0.250538,-0.0763535,-0.39235,-0.166221,0.343356,-0.670394,0.29696,-0.0140538,0.223829,0.457141,-0.23544,-0.573168,0.269313,-0.2788,0.251934,-0.24583,-0.225444,0.498724,-0.422845,0.604063,-0.718188,-0.15158,-0.0696435,0.228515,-0.101369,-0.236611,-0.238607,0.00179029,-0.303327,0.0645006,0.0899687,-0.367815,0.43857,0.180682,-0.467395,-0.358593,0.0217384,0.639348,0.377637,-0.316263,-0.244612,0.00357657,0.314298,0.13912,-0.836219,0.0228323,-0.0231776,-0.445014,-0.107532,-0.505229,0.167289,0.0529185,-0.00619846,-0.17492,0.318488,-0.177034,-0.168971,0.325174,-0.164931,-0.0888451,0.250253,0.0167247,0.47627,-0.0756285,-0.157286,-0.158123,0.266972,-0.752783,0.443657,-0.144629,0.37812,0.882512,0.362093,0.0968503,0.121283,0.167098,0.16707,-0.780349,0.234544,-0.197999,-0.459127,-0.212533,0.349515,-0.134178,0.329288,-0.225772,0.533462,-0.0881071,-0.231195,0.685264,0.117028,-0.199402,-0.215554,0.147334,0.283831,0.188998,0.114557,0.170275,0.11734,0.527352,-0.514873,0.0173301,0.265689,1.28218,0.486684,0.00978422,0.609674,-0.114236,-0.00562114,-0.709747,-0.0393759,-0.262578,0.434678,-0.387867,0.167861,-0.374137,-0.170716,-0.538356,0.0903509,0.457484,-0.240906,0.000742718,-0.581331,0.014144,-0.2515,0.184186,-0.422512,0.382906,-0.191894,0.247103,-0.813558,1.00849,0.333799,0.254085,-0.295237,0.00420339,-0.0802688,-0.756186,-0.146556,1.01853,-0.0890206,0.0775113,-0.0322963,-0.32658,0.0736467,-0.69002,0.136451,0.45747,-0.295155,0.307679,0.306626,0.0205209,0.0961218,0.0489875,0.0222896,0.198485,-0.143262,-0.201109,-0.0637432,0.399615,-0.456189,0.0612603,0.471118,0.0980774,-0.81103,0.226177,0.135833,0.311013,0.467917,0.239445,-0.108588,-0.320736,0.0241737,-0.550428,0.324825,-0.699363,0.282316,0.125886,-0.0834508,0.318952,-0.169487,-0.112404,0.100183,0.0592265,0.203378,0.794644,0.0746722,0.0442673,0.286736,0.0411043,0.107217,-0.0575225,0.179663,-0.03248,-0.745041,-0.588822,-0.242629,0.0098846,-0.275559,-0.760846,-0.0692832,-0.0281405,0.30984,0.038596,-0.818936,0.0130223,-0.660062,-0.368957,-0.282614,0.0199806,-0.125377,0.260415,0.458978,-0.117441,-0.053824,0.025169,0.0765306,0.609682,-0.0558278,0.119075,0.399981,0.0236807,0.0978518,0.0788032,-0.762678,0.116906,0.214836,0.341916,0.463504,-0.881257 +3443.41,0.780415,0.0848144,5,1.60452,0.692267,-1.31522,0.617999,0.430376,-0.0288902,0.0563562,-0.049871,0.168556,0.248306,0.191543,0.0200641,0.0784617,0.596257,-0.158748,0.714543,0.194309,-0.0252014,0.00575867,0.165914,0.0281965,-0.788058,-0.862339,0.511974,-0.526259,0.191899,0.470656,0.277488,-0.209613,-0.0627238,0.877313,-0.561261,-0.272823,0.397403,-0.390426,-0.361201,-0.0839836,-0.112844,0.289317,-0.261307,0.875173,0.496187,0.711205,-0.317162,-0.494508,0.0808477,-0.843256,0.373079,-0.0477923,-0.608043,-0.115067,0.161119,0.0512261,-0.625311,0.390749,-0.10435,-0.622084,-0.396244,0.113723,-0.595053,0.163453,1.09899,-0.441991,-0.981743,0.43043,0.0959435,0.177279,0.360415,-0.199355,-0.456369,0.0570616,0.301725,0.712475,-0.485401,0.205518,0.939057,0.712151,0.351692,-0.214581,0.36713,0.720106,-0.0531042,-0.0051639,0.0489991,-0.596806,-0.673957,0.111564,0.101886,0.0531464,-0.0514415,-0.391468,-0.000426188,0.128741,-0.489661,0.404883,-0.962946,0.7275,-0.0825806,0.163534,0.142527,0.369591,-0.0269084,-0.496231,-0.557474,0.522159,-0.408237,0.267276,0.204902,0.281041,0.738259,0.30344,0.234357,0.277965,0.413697,-0.419582,0.652251,0.10943,0.0616018,0.320166,-0.147056,-0.48106,0.0600969,-0.583285,0.231736,-0.20356,0.587499,0.243653,0.0220572,0.163049,-0.569917,-0.103749,-0.024008,0.217315,0.45509,-0.096439,0.26494,0.118135,-0.417594,0.410787,-0.616458,-0.273119,0.0121699,-0.158375,-0.218842,-0.530417,0.129846,-0.549894,-0.120155,-0.264242,-0.369092,-0.491731,-0.105194,0.1287,0.519712,-0.0494906,0.690106,0.440607,0.28839,-0.250429,0.213593,-0.210397,-0.0849155,0.65465,0.292443,0.107694,-0.426346,0.0675588,0.221394,-0.122905,0.0313427,0.324206,-0.149157,-0.106776,-0.290846,-0.0461422,-0.474933,-0.0168942,0.134871,0.00472013,0.126855,-0.0456972,-0.0875553,-0.477662,-0.0660465,-0.231328,-0.319021,-0.448511,-0.413424,-0.383501,-0.287383,-0.216718,0.419176,0.049217,-0.388189,0.373158,0.129249,0.180569,-0.219875,-0.131172,0.158435,-0.144689,-0.424777,0.270832,-0.472841,0.107222,-0.258242,0.0524836,1.05523,-0.540651,-0.101026,0.18305,-0.26104,0.237623,0.564397,-0.243441,-0.424171,-0.144441,0.159613,0.264658,-0.353452,-0.272003,-0.0655293,-0.155762,0.128217,-0.275063,0.629693,-0.564665,-0.489051,0.065215,0.342343,-0.279769,0.138708,-0.254707,0.145638,-0.492412,0.403258,0.619309,0.0243848,0.487067,-0.491311,0.539129,0.126424,-0.425977,-0.49588,0.207965,-0.30717,0.466048,0.21736,-0.0964378,-0.206137,-0.37541,-0.242231,0.260233,-0.164866,-0.21064,-0.146927,-0.210941,0.178929,-0.0644858,-0.237311,0.0871937,-0.561942,0.00240515,0.03458,-0.126638,0.126486,0.0665205,-0.181547,-0.390576,-0.213519,0.261774,0.0266815,-0.234077,0.108704,0.324096,0.639252,0.0453872,-0.500291,-0.155742,-0.508389,0.379305,-0.185454,0.231465,0.310801,0.465644,0.443304,-0.185166,0.100514,0.0555329,-0.0255526,0.0391531,0.0836698,0.0940315,0.01295,-0.285571,-0.644588,-0.131714,-0.126647,-0.259014,-0.257837,0.29523,0.124139,0.249424,0.352334,0.499423,-0.935953 +3427.89,0.571879,0.0848144,4,1.54388,0.718107,-1.33837,0.624666,0.336966,-0.0566057,0.293084,-0.0317267,-0.118428,-0.0398795,0.162028,0.210441,-0.311773,0.493038,0.375767,0.646174,0.169414,-0.0617126,-0.0185281,0.41345,-0.0628078,-0.541721,-1.06676,0.740619,-0.461334,-0.0555308,0.341646,0.333952,0.0475866,0.225527,0.742819,-0.784468,-0.330577,0.318692,-0.459038,-0.334362,-0.228779,0.436925,0.375987,-0.70286,0.943788,0.452164,0.264481,-0.73027,-0.131498,0.241443,-0.579931,0.522105,0.140309,-0.3334,0.228774,0.257169,-0.423322,-0.571498,0.402639,-0.298027,-0.54304,-0.674384,0.547938,-0.576122,0.272243,0.948695,-0.420509,-1.17361,0.555505,0.0506648,-0.131887,-0.0953242,-0.10653,-0.281689,-0.0656992,0.393654,0.679231,-0.167879,0.0550757,0.550288,0.425654,0.237934,-0.191561,0.126233,0.325049,0.44427,0.158766,-0.358879,-0.647922,-0.327269,-0.144446,0.299082,0.22965,0.0432699,-0.480376,0.253702,0.152917,-0.305782,0.236041,-0.657617,0.118907,0.164692,0.496702,0.469914,-0.0873705,-0.0403735,-0.762893,0.0867398,0.839387,0.0858383,0.295404,0.0353522,0.42469,0.504344,0.241626,-0.0911019,0.351794,0.440237,-0.389288,0.447128,0.238689,0.0352053,0.435597,0.600715,-0.344793,-0.533775,-0.446047,0.340853,0.390132,0.18887,0.633169,0.51128,0.191775,-0.0690504,0.267903,0.0220382,0.516938,0.464719,0.094472,0.0886116,0.254629,-0.504626,0.530921,-0.481841,-0.547484,0.0799714,-0.100578,-0.395711,-0.0142818,-0.169129,-0.765273,0.089715,0.311711,-0.921145,-0.187405,-0.113863,0.358847,0.148939,0.20847,0.0195158,0.561385,-0.121494,0.0164543,0.478653,0.0384745,-0.304269,0.761698,-0.101754,-0.246987,-0.229525,0.327373,0.0621382,-0.202138,-0.090605,0.121374,-0.360456,-0.313285,-0.0803459,-0.332773,-0.763583,0.0339563,-0.214177,0.0392311,0.264498,0.0691236,-0.450968,-0.168172,0.353604,-0.094974,-0.292808,-0.0882169,0.306696,-0.0636227,-0.541048,-0.26871,-0.0950905,0.375234,-0.345345,0.205838,0.343742,-0.0143877,0.014306,-0.350124,0.190701,-0.301199,-0.297142,0.402833,-0.404601,-0.47041,-0.526927,0.0183623,1.08975,-0.427676,0.124643,0.348437,0.0737433,0.319003,0.380588,0.12327,0.0236517,-0.418808,-0.00266414,-0.059108,-0.703128,0.20093,-0.161333,0.0943292,0.108394,-0.188113,0.621281,-0.49042,-0.481758,-0.446629,0.257978,-0.381004,0.0668442,0.0425145,-0.0460496,-0.671873,0.103937,0.107296,-0.223935,0.634935,-0.85642,-0.414759,-0.132712,-0.148593,-0.0509342,0.100005,-0.415253,0.490797,0.200531,0.0396422,-0.403618,-0.193093,-0.170426,-0.0133366,0.195546,0.318815,0.243048,-0.617749,-0.166783,0.132181,-0.145827,0.242632,0.155999,0.4777,-0.0424291,-0.218794,0.106532,-0.0760929,-0.729565,0.414078,-0.0597355,-0.631099,0.0918464,-0.475871,-0.0835029,0.127673,0.174654,-0.0620075,-0.153084,-0.0819298,0.0439209,0.162055,-0.285889,0.224194,-0.000308558,0.201084,0.22763,0.173396,0.255116,-0.147405,-0.704359,-0.0512432,0.252332,0.263586,0.286507,-0.265884,-0.358389,0.0765534,0.0290068,-0.261066,-0.385126,0.0922803,0.117023,0.245376,0.342086,0.495354,-0.719408 +3450.9,0.810237,0.0848144,4,1.63504,0.73746,-1.42348,0.572402,0.34351,-0.117411,-0.358542,-0.202568,0.533612,0.179408,0.221262,-0.609115,0.228756,0.391042,-0.314991,0.62863,0.17471,-0.0329373,-0.0338421,0.0518875,-0.120312,-0.494309,-0.44897,0.459961,-0.0795624,-0.406653,-0.571343,-0.385844,-0.111811,-0.0900781,0.66461,-0.0313801,-0.0577185,0.0463965,-0.548469,-0.471478,-0.486855,0.552008,0.313573,-0.171696,0.984557,0.732298,0.0108099,-0.678264,-0.136191,-0.158483,-0.745148,0.143198,0.290171,0.157089,-0.0307191,0.676224,0.064018,-0.47538,0.634521,-0.476187,-0.260812,-0.733042,0.316501,-0.20733,0.217427,0.683647,-0.859203,-0.0875572,-0.591706,0.152693,0.00196232,-0.130364,0.262784,-0.197143,-0.0606137,-0.0561412,0.412391,-0.141448,0.841863,0.220807,0.213904,-0.326948,-0.164027,0.0363864,0.156182,-0.663727,0.167394,0.254052,0.475222,0.0590535,0.448728,-0.758129,-0.0211852,-0.272349,0.269545,-0.078597,-0.0772621,0.260066,0.17221,0.168241,0.0436361,-0.384253,-0.205975,-0.0519857,-0.00577131,0.0866118,0.100267,-0.251669,-0.609847,-0.193486,-0.0687275,-0.252948,-0.0904716,0.303786,-0.336337,0.226236,-0.0223332,0.122856,0.562833,-0.278961,-0.776308,0.0521009,-0.152938,-0.747943,-0.591901,0.238907,0.0632252,-0.543175,-0.5213,0.394097,-0.461892,-0.172967,0.291052,-0.370855,-0.214758,-0.0348233,-0.646005,0.422618,-0.292854,-0.207347,-0.217797,0.407372,0.203594,-0.375302,0.154506,-0.164891,0.195514,0.14909,0.140836,0.406765,0.237761,0.598726,-0.159991,0.543909,-0.0400289,0.383578,-0.0889357,-0.0902011,0.230353,0.33678,-0.258074,0.256302,0.0113726,-0.628642,0.433596,0.0557089,0.526963,0.185093,0.145723,0.107442,-0.1594,-0.183817,-0.130753,-0.0635337,0.4272,0.402546,-0.193678,-0.0222141,0.161055,0.64279,-0.492446,0.0749133,0.0660087,0.888482,-0.0889518,-0.0188896,0.41629,-0.534184,0.058414,-0.222606,-0.271816,-0.598609,0.417296,-0.110585,0.281517,0.0797571,-0.172141,-0.497147,0.103297,-0.157011,0.209476,-0.319025,-0.468136,-0.0371868,0.097962,0.130762,-0.152704,0.263486,0.663991,0.117169,-0.555008,1.03953,0.269189,0.418288,-0.263162,-0.189862,0.185993,-0.344656,-0.322361,0.263569,0.105891,0.191234,0.394296,0.336412,-0.300863,-0.296756,-0.0960172,0.253764,-0.459589,0.323854,0.0360514,0.0610044,0.388902,0.191545,0.199024,-0.294228,-0.26271,-0.162906,0.194464,0.656251,-0.0874285,0.148252,0.245413,-0.0276231,-0.0625685,0.333343,0.133584,0.0304488,0.139151,0.464658,0.29438,0.0227091,-0.208292,-0.140851,0.0999733,-0.491554,0.523906,-0.389708,-0.573757,0.291098,0.154831,-0.0674931,0.153225,0.0849999,0.0351485,0.379793,-0.309722,0.564275,-0.0561615,0.186134,0.280311,0.361462,-0.37425,0.110615,0.255437,-0.185384,0.145325,0.108479,-0.0770809,0.00208553,0.0707603,-0.109615,0.438387,-0.202045,-0.241099,0.0105746,-0.403866,-0.0566438,0.0526027,0.0192042,-0.423655,-0.0316102,0.365983,0.232371,-0.199815,0.0365216,-0.26661,0.0283443,0.00228336,-0.244444,-0.3514,-0.0610696,0.0518159,-0.0457906,-0.01298,0.106838,0.199857,0.32686,0.447054,-0.574709 +3459.84,0.618338,0.0848144,4,1.49448,0.838855,-1.10399,0.410535,0.000661481,-0.196329,0.606685,0.319169,-0.208065,0.0320878,0.0364186,-0.226857,0.264357,0.521159,0.194999,0.306999,0.299126,-0.164451,-0.00898787,0.00422733,0.232427,-0.568727,-0.525522,0.567412,-0.497994,-0.389172,0.0574759,0.0034467,-0.30048,0.042142,1.02035,-0.882264,-0.0596701,0.45158,-0.468816,0.191013,-0.433759,0.410512,0.045086,-0.222261,0.986229,0.932555,0.455515,-0.718599,-0.509361,-0.177632,-0.186517,0.202477,0.423628,-0.222917,0.217134,0.352455,-0.173754,-0.484115,0.835724,-0.45312,-0.010311,-0.684883,0.223713,-0.163253,0.385761,1.01579,-0.131991,-0.991672,0.246194,-0.092183,0.0654717,0.456793,-0.0128779,-0.729291,-0.0559394,0.0893355,0.601675,-0.21161,0.598919,0.62526,0.319284,0.329621,-0.587642,-0.114419,-0.128509,-0.0403908,-0.116966,-0.129463,0.0400803,-0.25788,0.138424,-0.128666,0.030754,-0.423939,0.0255358,0.0181761,0.0203661,-0.131208,0.0715868,0.122851,0.315539,-0.0929159,-0.338312,-0.127631,0.0304289,-0.242467,-0.68269,0.321273,0.297849,-0.484198,0.430011,0.0852511,0.237814,0.689943,0.0795589,-0.0167222,0.111068,0.0131577,0.0359088,0.242111,-0.478759,0.00437048,0.178804,-0.0580993,-0.480039,-0.138599,-0.148957,-0.272028,0.0943268,0.0217559,-0.0242372,-0.627407,-0.284443,-0.119758,0.102183,0.177969,0.51632,0.738334,-0.121069,0.340063,-0.204948,-0.0400077,0.193203,-0.322503,-0.930757,-0.0686616,0.021468,-0.552171,0.0633716,-0.378319,-0.167451,0.384872,-0.232809,-0.224466,-0.578132,-0.102428,0.309613,-0.169347,0.555141,0.352756,0.401862,0.193772,0.0562319,-0.0498427,-0.120176,-0.154033,1.00661,0.28461,0.0298846,0.184267,0.312471,0.0122455,-0.0731621,0.0996397,0.0723799,-0.034889,-0.472128,0.116909,-0.0685096,0.0874189,-0.0704114,-0.00257735,0.270882,0.525354,0.161366,0.208665,0.149138,0.256453,-0.510961,-0.297284,-0.080716,0.0439743,0.545027,-0.900049,-0.059416,-0.00679899,0.390711,-0.206977,0.410026,0.0899639,0.122942,-0.260983,-0.419636,-0.18216,-0.379567,-0.138523,0.47213,-0.0857882,0.00681446,-0.0974351,-0.123389,0.829895,-0.185097,0.492493,0.165851,-0.447367,0.25415,0.0499095,0.0700696,0.200189,0.108339,0.28752,-0.258584,-0.475909,-0.0705298,-0.170687,0.154296,0.187409,0.115497,0.574172,-0.377808,-0.278691,-0.0232098,0.0127706,-0.381237,-0.171864,0.0682528,-0.0876447,-0.383816,0.297289,0.116191,-0.301019,0.485403,-0.519268,0.154237,-0.327751,-0.212557,0.459978,0.273819,-0.147292,0.61072,0.560557,-0.327722,-0.00967164,-0.469833,-0.405789,0.146968,-0.545982,0.285767,0.236987,-0.526716,0.17228,-0.399201,0.170212,0.440608,0.587278,0.552146,0.20927,-0.302756,-0.227559,-0.0961303,-0.256433,-0.296071,0.0764461,0.0263586,-0.0525224,-0.397306,-0.401633,0.321025,-0.0852053,0.207903,-0.152124,0.0245946,0.447651,-0.257656,-0.372728,-0.0779819,0.133091,-0.0277757,0.29527,0.312095,0.672293,-0.409897,0.41302,-0.201581,0.304107,-0.107095,0.224476,-0.108679,-0.326984,0.322005,-0.0433465,-0.222093,-0.176218,0.0579536,0.0934828,0.172198,0.30575,0.414967,0.249035 +3455.96,0.672779,0.0848144,4,1.52333,0.802697,-1.26443,0.464146,0.0111798,-0.231114,0.404325,0.0870705,0.0271592,0.200441,-0.0800483,-0.161229,0.296714,0.376746,0.0761466,0.594171,0.130032,-0.168434,0.0599881,-0.124397,0.250086,-0.316812,-0.565308,0.486531,-0.227646,-0.591492,-0.340785,-0.0222059,-0.245978,-0.0282415,1.07866,-0.867514,-0.192236,0.372413,-0.321846,0.156285,-0.560376,0.384373,0.393581,-0.333274,0.703023,0.868876,0.422804,-0.75064,-0.546639,0.338361,-0.244312,0.162702,0.377338,-0.073717,-0.0216772,0.193972,0.148368,-0.732953,0.716432,-0.349071,-0.0545467,-0.711456,0.447158,-0.198579,0.21386,0.897725,-0.240617,-0.74916,0.3446,0.0687422,0.00273355,0.21386,0.0370606,-0.611509,-0.107929,-0.204333,0.552268,-0.0756066,0.645627,0.522684,0.254582,0.202984,-0.46292,-0.084834,-0.210119,-0.232144,-0.0463262,-0.04498,0.0642347,-0.197931,0.25163,-0.200041,0.11438,-0.276733,-0.257597,-0.00268364,-0.0256327,-0.226437,0.0642414,0.0322143,0.577195,0.145792,-0.141651,0.0318561,0.086273,-0.316544,-0.766346,-0.0999124,0.535611,-0.495265,0.209804,0.00590291,0.224213,0.858528,-0.0708445,0.129245,0.271184,0.184181,0.0914334,0.235959,-0.241475,-0.0116155,0.0622954,-0.00364783,-0.512967,-0.0650221,-0.134437,0.0935543,0.0632027,-0.387987,0.120242,-0.543908,-0.261008,-0.293169,0.207925,0.227973,0.214853,0.809354,-0.242661,0.305204,-0.158632,-0.0648416,0.330177,-0.45154,-0.863052,-0.123892,0.120539,-0.590742,0.0191819,-0.216115,-0.196224,0.414728,-0.214302,-0.332428,-0.746307,-0.367163,0.264176,0.0135876,0.920284,0.195229,0.137491,0.0751605,0.122075,-0.0102757,0.28815,-0.380085,1.14743,0.306482,-0.0144415,0.226941,0.165201,0.0519373,0.00224613,0.0439894,0.142814,-0.058439,-0.413487,0.16669,0.119713,-0.163482,-0.257986,-0.0940173,0.203585,0.520564,-0.28416,-0.112653,0.426069,0.364031,-0.673495,0.0116885,-0.0998738,-0.0488882,0.550778,-0.58329,-0.0319918,-0.0073589,0.413588,-0.145761,0.338912,0.17735,0.132594,-0.301597,-0.432978,-0.304599,-0.410098,-0.184935,0.581781,-0.0242613,-0.0210911,-0.0412549,-0.207041,0.676845,-0.285184,0.538596,0.0362695,-0.44379,0.40136,0.0452798,0.116638,0.280416,0.131574,0.248163,-0.250376,-0.268344,-0.0558064,-0.172416,0.130188,0.132903,0.132179,0.45205,-0.462444,-0.158179,-0.0448409,0.0136884,-0.335823,-0.208175,-0.0030401,0.0587726,-0.30016,0.406581,-0.253447,0.125063,0.49311,-0.112102,0.231208,-0.354967,-0.137653,0.482272,0.298333,-0.0729277,0.56481,0.524507,0.0167299,0.0752813,-0.598,-0.421997,-0.117859,-0.607176,0.125,0.03298,-0.443318,0.059687,-0.214133,0.169804,0.563102,0.474885,0.477256,-0.0291751,-0.112329,-0.11906,-0.112606,-0.273359,-0.316691,0.129305,-0.0943196,0.22627,-0.317861,-0.23565,0.30465,-0.0675706,0.455984,0.0392223,0.175177,0.235506,-0.165184,-0.267752,-0.199955,-0.216189,0.247646,0.244865,0.488499,0.513891,-0.535594,0.199264,-0.193965,0.13917,-0.142679,0.403314,-0.166658,-0.155041,0.178894,0.231564,-0.267417,-0.124518,0.14074,0.105679,0.296876,0.325083,0.544864,0.349043 +3479.4,0.767139,0.0848144,4,1.69741,0.773657,-1.03807,0.451349,0.550125,-0.0482045,-0.223853,0.076943,0.408546,0.118586,0.231536,-0.383343,-0.369239,0.316652,-0.315215,0.678559,0.361732,0.207238,-0.563541,-0.145668,-0.0663024,-1.2308,-0.636283,0.195235,-0.790698,0.224009,-0.103858,0.540945,-0.540624,-0.169077,0.902559,-0.345034,0.327287,0.233976,-0.459397,-0.466451,-0.209965,0.34081,0.100915,-0.612693,0.805142,0.258664,0.00372467,-1.12333,-0.0468068,-0.120145,-1.03166,-0.110619,-0.0377624,-0.043367,0.0636984,0.584117,0.0680882,-0.237404,0.535223,-0.354858,-0.324612,-0.848461,0.545372,-0.667744,0.0988056,0.907983,-0.975586,-0.762365,0.0475654,-0.111091,-0.0496121,-0.384435,0.030308,-0.263711,0.28328,0.538266,0.605975,0.0661944,0.0115136,-0.0287501,0.0859948,0.122348,-0.0067576,0.118429,0.667412,-0.250355,0.374443,0.233337,-0.181717,0.130825,-0.40341,-0.0988826,0.103079,-0.35975,0.146275,-0.056252,0.00278056,0.183249,0.0509129,-0.273607,-0.230992,-0.324601,0.307771,0.388981,0.0682834,0.256359,0.370091,-0.0131557,-0.379045,0.227591,0.141345,-0.355606,0.234238,0.327835,-0.0785468,-0.29803,-0.0618995,0.195237,0.273511,-0.224187,0.110168,-0.0206417,0.272294,-0.0340264,-0.385153,-0.0437728,0.263061,-0.438891,-0.249499,0.386836,0.0443608,0.389243,0.313537,-0.131007,-0.284515,-0.163529,-0.114007,-0.159214,-0.29633,-0.358929,-0.0297,-0.100875,0.386727,-0.354537,0.331416,0.0774538,0.413088,-0.218882,0.0994383,0.238867,0.224651,0.265749,-0.242227,0.199923,0.00152123,0.542272,-0.113557,-0.0305913,-0.420109,-0.017727,0.0853812,-0.117011,-0.0606411,-0.00242869,0.117084,0.500052,0.256182,-0.351853,0.0330624,0.0330024,-0.0445448,-0.276434,-0.148176,-0.268616,-0.078355,0.209558,-0.0634163,0.0528994,-0.161353,-0.0135515,-0.282023,0.0587419,0.103816,0.633789,0.336917,-0.217976,-0.221242,-0.465823,0.413549,-0.215765,-0.324105,-0.601202,-0.369788,-0.0860199,0.202993,-0.095361,-0.569814,-0.776071,-0.272833,0.164588,-0.107181,-5.97691e-05,-0.43697,0.215077,0.296976,0.333184,-0.178285,0.322394,-0.141504,0.144316,-0.316928,0.864662,0.371021,-0.386141,-0.0046809,0.181605,-0.148569,-0.045953,-0.250385,0.243999,-0.220243,0.143729,0.600766,-0.111548,0.0280164,-0.0852558,-0.0787725,0.344822,-0.597014,0.525872,-0.202563,-0.0218267,0.177471,-0.157703,0.315412,-0.101909,-0.1112,-0.329829,0.0520842,0.188792,0.507238,-0.0373814,0.314018,-0.19543,-0.378405,0.288546,0.0618321,-0.520563,0.0885199,0.0648932,-0.101612,-0.0588264,-0.193717,-0.403704,0.347458,-0.360757,0.372682,-0.0159326,-0.188981,0.324681,0.0818879,-0.250617,0.289348,-0.0793575,-0.215756,0.0438307,-0.122974,0.128963,0.486435,0.545633,0.00144439,0.0774689,0.0976829,-0.17369,-0.206107,-0.383715,-0.0561437,0.414679,-0.209186,0.464184,-0.172695,-0.410557,0.0221562,-0.0972902,0.169211,0.0455048,-0.00152896,0.20496,0.155695,0.0763591,-0.4236,-0.136791,0.364108,-0.279972,-0.282704,-0.255899,0.274033,0.0914165,-0.151235,-0.137472,-0.130731,-0.240308,0.0430608,-0.193833,-0.161073,0.0770373,0.221268,0.277556,0.470391,-1.36725 +3485.32,0.893182,0.0848144,4,1.72737,0.991752,-0.9792,0.429677,0.687731,-0.0238413,0.164156,-0.470796,0.00661694,0.363424,0.0659587,0.083333,0.174445,0.0849226,-0.300909,1.16127,0.0252654,-0.0680628,-0.213358,-0.0378202,-0.347588,-0.757642,-1.59555,-0.259531,-0.231977,0.0401389,-0.0124511,0.414076,-0.861368,-0.377882,0.834219,-1.12563,0.0731232,0.157073,-0.58049,0.0378766,-0.352889,0.122927,0.762475,-0.325836,0.738417,0.558542,-0.231323,-0.621026,-0.198973,0.160842,-0.691745,0.165877,0.052076,-0.0554365,-0.15294,0.49344,-0.35841,-0.618607,0.216863,-0.49385,0.0780709,-0.992647,0.175345,-0.86249,0.328956,0.595836,-0.133474,-0.826917,-0.500308,0.302117,0.0148189,0.148264,-0.150003,-0.505634,-0.328464,0.133952,0.551905,0.0463356,0.479493,0.285585,0.27367,-0.131999,-0.606216,-0.167923,0.425585,0.28869,0.469,-0.274545,-0.273523,-0.0546912,0.275584,0.291365,0.12846,-0.333588,-0.124322,0.261925,0.163515,0.29535,-0.0938653,0.473755,-0.0588205,0.257563,-0.250714,0.195414,-0.304389,-0.32213,-0.520767,-0.374083,0.162269,-0.309606,-0.126075,-0.00954211,-0.161936,0.322255,0.213583,-0.0913606,0.316296,0.211292,0.0682691,-0.195911,-0.366387,0.0397469,0.431915,-0.218383,-0.106159,-0.312308,-0.355799,0.131832,0.160786,-0.0574782,-0.256875,-0.376938,0.0905964,-0.248863,-0.0230426,0.176702,0.0522422,0.376178,-0.268482,0.154494,0.249419,-0.103285,0.308022,-0.0606053,-0.243387,0.124379,0.0825975,-0.577495,-0.0112926,-0.290204,0.0344422,0.442952,-0.33016,-0.398068,-0.372184,0.0950257,0.153828,0.12796,0.448761,0.337432,0.0725314,-0.182209,0.070777,-0.361581,-0.163108,-0.20321,0.629188,0.234093,0.0833462,0.0284655,-0.0198452,0.241569,-0.120117,0.372826,0.424084,-0.091061,-0.27522,-0.0707866,-0.079745,-0.134352,-0.0860051,-0.144714,0.262397,0.550295,0.0118883,-0.0117974,0.277493,0.278008,-0.145649,-0.170392,-0.00565681,-0.250944,0.120262,-0.471366,-0.452477,0.246781,-0.0545399,-0.541406,0.0512041,0.388017,0.0104236,-0.264392,-0.0491518,0.00938928,0.138807,-0.278128,0.566217,0.053825,0.110414,-0.231313,-0.103144,0.522553,-0.662192,0.3354,-0.0917656,-0.0831432,-0.460934,-0.154583,-0.0209223,-0.194604,-0.128401,0.0128394,-0.0319399,0.070032,-0.208367,-0.660528,0.212329,0.0945523,0.12707,0.381821,-0.225689,-0.488838,0.00238681,0.116814,-0.390179,-0.115046,0.0516528,-0.408166,-0.207673,0.384702,-0.120483,-0.19092,0.439532,-0.303643,-0.290841,0.0659178,0.442218,0.284238,0.233969,-0.0863397,0.376098,-0.0654082,-0.120209,0.0456941,-0.387774,-0.344531,-0.191643,-0.268287,-0.22214,0.0567732,-0.304805,-0.0610327,0.207345,0.149986,0.45379,0.162598,0.208295,-0.040759,0.18831,0.30297,-0.37262,-0.24384,-0.0828953,0.0422872,-0.116661,-0.227339,0.0080274,-0.400884,0.155949,-0.0901392,-0.109631,0.243608,0.467313,-0.0320977,-0.421557,-0.214182,0.246994,0.0516277,0.0712328,-0.0785164,-0.0903492,0.274095,-0.06152,0.0683766,-0.137732,-0.139645,-0.293348,-0.25554,-0.183044,-0.0951378,-0.162488,0.194054,-0.425237,0.160658,-0.0561249,0.0649986,0.327561,0.254948,0.572329,-2.19616 +3484.83,0.919896,0.0848144,4,1.71756,0.861668,-0.675449,0.285304,0.629209,-0.130858,-0.267336,0.360477,0.837953,-0.108905,-0.113736,-0.255247,-0.332969,0.196588,-0.168965,0.729807,0.010327,0.15851,-0.0559468,-0.5404,0.0884865,-0.828816,-0.77648,0.174901,-0.123543,0.185514,0.0539348,0.650133,-0.330999,0.196906,0.611634,-0.617053,0.354387,0.285697,-0.580166,-0.307077,-0.854022,0.533845,0.0992598,-0.245445,0.884935,0.359561,0.231952,-1.17681,-0.391041,0.631521,-0.799335,-0.111733,0.0587227,-0.00366296,-0.282491,0.443659,0.0627288,-0.199835,0.794082,-0.256537,-0.275953,-0.536552,0.144307,-0.55073,-0.0177943,0.850441,-1.12525,-1.38927,-0.128213,-0.349657,-0.0412692,-0.114229,0.372,-0.322545,0.0601637,0.165348,0.509683,-0.198399,0.14727,0.216551,-0.07782,-0.272367,0.224213,-0.170927,0.118978,-0.422442,0.188696,-0.0770309,0.101611,0.017455,-0.297747,-0.146535,0.276253,-0.47615,0.44204,-0.32124,-0.133032,0.161349,0.00848482,-0.790818,-0.0713943,-0.620653,0.188924,0.231572,-0.193093,0.313124,0.128363,0.339672,-0.105506,-0.201207,0.193223,-0.189969,0.308891,0.422158,-0.245463,-0.0586166,-0.187622,0.104821,0.102497,0.0496551,0.241189,0.256809,-0.239537,0.0174085,-0.699432,0.209118,-0.00777805,0.0492056,-0.180712,0.199825,0.451782,0.436041,0.212884,-0.194816,-0.0858529,-0.442929,-0.347032,0.137792,-0.00594531,-0.107244,-0.303233,0.305316,0.133024,-0.308795,-0.214022,0.0635498,0.133314,0.0823332,0.179908,0.127068,0.106173,0.242864,0.137044,-0.100999,-0.0361273,-0.0993426,0.606007,-0.444815,-0.00744517,0.313975,0.156933,-0.503668,-0.177847,-0.0719319,0.183984,0.33882,0.512271,-0.148678,-0.161387,0.0717257,-0.174554,-0.368424,-0.0413606,-0.538891,-0.049554,0.239879,-0.202635,0.0314456,-0.250436,-0.153779,-0.0674121,0.109414,-0.258901,0.70484,-0.138685,0.378144,-0.0748056,-0.179695,-0.0457999,-0.133661,0.0805682,-0.0524927,-0.0217064,-0.209385,0.337222,-0.187847,-0.0688,-0.358354,-0.11633,-0.293088,0.204295,-0.34084,-0.59778,0.519521,0.172622,-0.116167,-0.402207,-0.239826,0.020837,-0.0854525,-0.470315,0.97976,0.47135,-0.143367,0.151459,-0.0772182,-0.082663,0.492558,0.0800308,0.166403,-0.176355,0.0819193,0.182283,-0.15341,0.414734,-0.123589,-0.438535,0.224922,-0.494613,0.341208,-0.211152,0.357465,0.253734,-0.157104,0.194065,-0.175879,-0.0857466,-0.00886673,-0.0434038,0.598966,-0.0284395,0.0691053,0.413753,-0.0109008,-0.128684,0.210131,-0.249432,-0.150995,0.182319,-0.206981,0.331519,0.123794,0.0928437,-0.556156,0.374687,-0.313701,0.425992,-0.153009,0.194659,0.428853,-0.248945,-0.26537,0.168176,0.141224,-0.270496,-0.0603153,-0.146429,-0.213377,-0.136221,0.180035,0.136912,0.056939,-0.164839,0.0314719,0.160976,-0.40298,-0.153184,0.104847,0.0638927,-0.0110572,-0.0827821,0.0145228,-0.226859,0.202228,0.176612,0.0443207,-0.846876,-0.303761,-0.0114087,0.229196,-0.118379,-0.195935,0.450798,0.0171416,-0.336654,0.372358,-0.162429,0.0891964,0.266518,-0.466778,0.149684,-0.0732707,0.199502,-0.00546873,-0.249464,0.0746207,0.236187,0.273168,0.485991,-1.77764 +3471.71,0.809833,0.0848144,4,1.66389,0.815764,-1.04654,0.445436,0.608245,-0.172996,-0.1166,0.0204604,-0.00124979,-0.400049,0.163142,-0.17067,0.178733,0.268689,-0.279913,1.0357,0.0583169,-0.0477345,0.374698,-0.159305,-0.320963,-0.464449,-1.14209,0.0580069,-0.146496,-0.0353602,0.0346854,0.140138,-0.302485,-0.165091,0.810097,-0.704924,0.210082,0.324302,-0.285231,-0.371213,0.135559,0.423776,0.293065,-0.204939,0.814366,0.224346,-0.205432,-0.964653,-0.178758,-0.0632524,-1.02847,0.509704,0.380767,-0.162805,-0.194154,1.2888,-0.0491197,-0.370168,0.723164,-0.169227,-0.0407456,-1.5171,0.0570341,-0.581168,0.0501031,0.824691,-1.07163,-1.56383,-0.300719,0.277027,0.123301,-0.147756,0.285629,-0.303312,-0.119135,0.157353,0.5432,0.344805,0.329088,0.458651,0.584225,-0.354324,-0.135205,0.318975,0.300798,-0.435565,0.197735,-0.731504,0.243154,0.060095,-0.0492487,0.0570916,-0.0440914,-0.230026,0.431241,-0.0602897,-0.082694,0.158842,0.0877486,-0.0239322,-0.294409,-0.029261,-0.253735,-0.130087,0.16813,0.123709,-0.277784,-0.363551,0.151377,0.245141,0.401977,-0.0797527,0.187967,0.655708,0.128868,-0.232132,-0.0600312,0.147226,-0.151501,-0.0144491,-0.435579,0.129404,0.156621,-0.258472,-0.28349,-0.226455,-0.133822,-0.657692,0.258704,0.125729,-0.231389,-0.0840082,0.0523966,-0.210352,0.0663105,0.269028,0.142378,-0.48237,-0.0896781,0.116646,-0.245523,0.0066553,0.287316,-0.254071,-0.285357,-0.0923281,-0.208088,-0.38519,0.083396,0.0810434,-0.429117,0.172389,-0.102982,-0.148166,0.0794376,0.041219,-0.0883294,0.161498,0.225226,-0.155384,0.372443,0.236741,-0.132689,-0.150447,-0.214897,0.162692,0.686652,0.0935333,0.0536455,-0.0914862,-0.0414109,-0.208393,-0.121922,0.242296,0.106406,0.331985,-0.31655,0.0854336,0.125782,-0.178283,-0.530365,0.0126597,-0.29292,0.171361,0.254096,-0.0425159,0.153555,-0.0117161,-0.115133,-0.181172,0.198374,0.0990957,0.212412,-0.477847,0.0886753,-0.0414476,-0.437937,-0.25769,0.0669912,-0.0132997,0.173751,-0.59663,-0.349462,0.0275078,-0.181672,0.0883205,0.190218,0.0614047,-0.37818,-0.175232,-0.412163,0.724596,-0.399336,-0.0237714,0.0893127,-0.382079,-0.00891087,-0.138194,-0.368284,-0.0862141,-0.269622,0.0618486,-0.289305,-0.675606,0.0788034,-0.173196,0.341109,-0.19308,-0.0960007,0.265944,-0.424966,-0.248878,-0.338304,0.196396,-0.457947,-0.224609,-0.206288,-0.366521,-0.0551752,0.588223,0.321477,-0.288152,0.288554,-0.0531513,0.176537,0.0574447,0.47241,0.0367551,0.219711,0.166078,0.258965,0.334003,-0.202036,0.161942,-0.28714,-0.33404,0.4712,0.0929425,-0.0693587,0.650201,0.028365,0.170098,-0.174825,0.430798,0.11748,0.0643413,0.237782,-0.188906,0.269256,0.305966,-0.134733,0.0650604,0.0903244,0.186489,-0.397397,0.291386,-0.166075,0.157143,-0.42844,-0.183125,0.169388,0.191328,-0.963166,0.357629,-0.307794,-0.024923,0.289902,-0.208638,-0.04005,0.0875041,0.069645,0.0827225,-0.0596466,-0.132753,-0.0734318,-0.164503,0.38068,0.129376,0.0119158,-0.288303,-0.203762,0.0121257,-0.084943,-0.187591,0.0985786,0.0690979,0.345567,0.262865,0.587849,-1.6269 +3468,0.846073,0.0848144,4,1.6489,0.908619,-0.814543,0.283756,0.351058,-0.324306,-0.0830482,-0.160373,0.24206,0.137577,-0.0815669,-0.563094,0.060076,-0.235014,-0.0186787,1.35285,0.191359,-0.126323,-0.0547713,-0.0845939,0.0372726,-0.867405,-1.48439,0.229585,0.0108734,-0.0154137,-0.524038,0.547546,-0.221882,0.00323052,0.719117,-0.291886,-0.00644513,0.311705,-0.254258,-0.126557,-0.235416,0.289394,0.304958,-0.463318,0.918213,0.312593,-0.277556,-0.718152,0.0213444,-0.135417,-0.618987,0.11652,0.154966,-0.154498,-0.0150581,0.237221,0.356197,-0.94975,0.718959,-0.154273,-0.420831,-0.96334,0.15494,-0.599537,0.690969,1.03984,-0.684677,-1.01087,-0.143528,-0.235216,-0.309051,-0.354315,0.146633,-0.20315,-0.173118,0.202441,0.655155,0.21728,0.155357,0.112558,0.111812,-0.103313,-0.308742,-0.225344,0.288764,0.231713,0.0410778,0.321304,-0.372385,-0.231163,0.0550239,-0.144467,-0.188757,-0.0887812,-0.243174,0.156844,-0.0503952,-0.40037,-0.0509496,-0.169962,0.0550325,0.145891,0.43494,0.303986,-0.145334,-0.254793,-0.134326,-0.279198,-0.364101,-0.505252,-0.147036,-0.163541,0.200381,0.422039,0.0756242,-0.415772,0.353117,0.121136,0.183111,-0.116828,-0.113741,0.364285,-0.0449777,-0.145382,-0.594598,0.0354602,-0.0309345,0.0844239,-0.0278352,0.309437,0.282172,0.429013,-0.0466292,-0.169006,-0.0719922,0.128839,-0.146645,-0.10114,-0.029409,-0.233804,-0.0469219,-0.280381,-0.0709188,-0.620641,0.0694695,-0.0127163,0.00589516,0.079047,0.0272843,0.00964476,-0.522277,0.57922,-0.233052,-0.0873937,0.0884693,-0.595044,-0.28433,-0.108793,0.0324091,0.468094,-0.567203,0.0836562,-0.0198246,0.248219,-0.222508,-0.265782,0.109794,0.212479,-0.341214,-0.38443,-0.515007,-0.450457,-0.307962,-0.467515,-0.0742943,-0.186745,-0.123455,0.0703931,-0.492391,-0.0826041,-0.136755,-0.0160738,0.0234096,0.327464,-0.115812,0.0135275,0.231812,0.204871,-0.0162409,-0.194173,0.167576,-0.363925,0.406064,0.0750507,0.551097,-0.113624,0.0318782,-0.402582,0.0491717,0.108987,0.0241163,-0.300264,-0.385753,0.426164,-0.11251,-0.454712,0.416625,0.224799,0.374881,0.13464,0.062949,0.746722,-0.22204,0.286823,0.0249148,-0.278352,0.0726183,0.263241,0.0755914,0.125802,-0.445475,0.0258235,0.24149,0.0424692,-0.188846,-0.0981699,0.187626,0.176153,-0.303889,0.435079,0.128365,-0.2322,0.0880482,-0.237703,0.339119,-0.283844,-0.141161,-0.0182745,0.131991,0.51683,-0.0829612,-0.0641734,0.220102,0.113843,-0.573745,0.720809,0.0291693,-0.199846,0.445481,-0.137193,0.466628,0.213799,-0.30572,0.248366,0.166298,-0.641599,0.0949582,-0.196233,-0.532851,0.0576018,-0.113165,-0.464198,0.0124179,-0.252669,0.306662,0.106302,0.126932,-0.101077,0.201541,0.0794045,0.402468,-0.179209,-0.173474,0.094405,0.433411,-0.286048,-0.0568273,0.234811,-0.0177568,-0.282273,0.075825,0.000988996,0.33445,0.0916228,0.123553,-0.28971,-0.268793,0.0516611,-0.328602,-0.105976,-0.102613,0.257963,-0.291036,0.286659,-0.00713965,0.147446,0.211607,-0.249861,-0.101528,0.0801928,-0.167247,0.281509,-0.0557449,0.15878,0.0217876,0.0784246,0.256673,0.280044,0.506629,-0.882988 +3455.07,0.980105,0.0848144,4,1.61733,0.92859,-0.728883,0.184795,0.36046,0.0277588,0.135125,0.398276,0.585221,0.0367787,0.00515462,-0.0939241,-0.0321646,0.130231,-0.383744,0.543134,-0.113986,-0.218438,0.0130952,-0.157102,-0.185523,-0.641557,-0.484711,0.0792826,-0.489654,-0.0589652,-0.0551781,0.077594,0.19797,0.357822,0.711676,-0.849196,0.0483754,0.279974,-0.268373,0.0453487,-0.0754873,-0.0348877,-0.129943,-0.0975735,0.957116,0.731164,-0.266581,-0.573961,0.127574,-0.620795,-0.501956,0.272963,0.373543,0.0466073,0.05976,0.184907,0.268023,-0.22168,0.940806,-0.0573561,0.207092,-0.593523,0.404747,-0.993814,0.0919195,0.673984,-0.37223,-0.882114,-0.106519,-0.0620504,-0.139869,0.257387,-0.339703,-0.363889,-0.33986,-0.118633,0.504315,-0.121271,-0.0112125,0.303726,0.393845,0.130894,-0.24198,-0.525542,0.532273,-0.619034,0.0719717,-0.167197,-0.150887,0.29362,-0.246258,-0.392578,-0.0626652,-0.241622,-0.0677333,0.151381,-0.132159,-0.0147629,-0.478879,-0.0517464,-0.0946607,-0.33486,-0.0231481,0.101482,0.330096,-0.232054,-0.370362,-0.628193,0.342819,-0.0218559,-0.508433,-0.20342,0.448945,0.41169,0.139574,-0.0224098,-0.0520859,0.248382,-1.02752,0.0462526,-0.286717,-0.185352,0.213901,-0.27507,-0.0655569,-0.0039407,0.00937298,-0.207347,-0.288195,-0.204061,0.142664,0.0224518,0.0993533,-0.14167,0.14151,0.0906662,0.320148,0.141715,0.0225271,0.33518,0.222043,0.125632,0.0588167,-0.317208,-0.66555,-0.312764,-0.164354,-0.468884,-0.0565744,0.206931,-0.215091,-0.439123,0.0102746,0.497702,-0.0993311,0.253417,0.154406,-0.222476,0.104418,0.423983,0.347995,0.0237038,-0.134638,-0.664033,0.384476,0.149975,0.119767,-0.423684,-0.0357849,-0.0692023,-0.275667,-0.0183725,-0.092732,-0.375144,-0.168611,-0.32331,-0.252189,-0.549708,-0.0022951,0.149913,0.0806796,-0.178023,-0.308892,0.767168,0.5025,0.138403,0.211332,-0.0991181,0.0878061,0.0355046,-0.486578,0.00972461,-0.255847,-0.26228,0.140404,0.0544692,-0.0611141,-0.571032,0.184232,0.245329,0.227499,-0.609478,-0.448516,-0.0480143,-0.241776,-0.44191,0.0696288,-0.363667,-0.231842,-0.152492,-0.539689,1.0484,-0.057013,-0.210821,-0.29015,-0.154905,-0.171078,-0.117693,0.114544,0.335905,-0.0975937,0.000708152,0.00242147,-0.284065,0.0530273,0.0260275,-0.0427379,-0.0561367,-0.0253639,0.429455,-0.291568,-0.322008,-0.21392,-0.0268004,0.285514,-0.0851606,-0.0519842,-0.377232,-0.00563484,0.579643,0.20432,-0.383364,0.299595,-0.0408036,-0.270184,-0.0154768,0.232953,-0.41436,0.262988,0.36159,0.301339,0.19202,-0.243429,-0.0905545,-0.203734,-0.0511128,0.407938,0.00619741,-0.0765683,-0.107331,-0.58182,0.12388,-0.0579195,0.247368,0.179403,-0.038944,0.504684,0.214201,0.103177,-0.212749,-0.23678,-0.252527,-0.021813,0.133769,0.082947,0.0764102,-0.684079,0.673628,0.16439,-0.0699764,-0.325819,0.00898075,0.363982,0.0834182,-0.263314,-0.457344,0.138059,0.279336,0.413171,-0.144547,-0.138105,-0.255811,-0.0671293,0.293849,-0.342949,-0.469543,0.0218259,0.106538,-0.0788944,0.298166,-0.182481,-0.408219,-0.0086957,0.0677146,0.123582,0.104065,0.178461,0.322591,0.422447,-1.02025 +3470.96,0.946757,0.0848144,4,1.58758,0.974055,-0.74589,0.185224,0.610062,-0.0872008,0.0692063,0.0912188,0.616138,-0.0380094,0.0157388,-0.0441682,-0.202606,0.313534,-0.335839,0.894331,0.0644261,-0.264435,-0.0129833,-0.209882,-0.0676375,-0.647938,-0.739772,0.176488,-0.428248,-0.00471517,-0.0237903,0.177494,0.135831,0.43637,0.580592,-0.847529,-0.312979,0.00803012,-0.232957,0.324123,-0.143443,0.136666,-0.0618535,-0.164446,1.25718,0.737515,-0.0864693,-0.535003,0.229535,-0.294016,-0.578421,0.152763,0.417546,0.297003,0.283996,0.387232,0.13017,-0.423609,1.00932,0.300826,0.0384729,-0.769087,0.405279,-0.826684,0.0283396,0.972646,-0.727616,-0.653711,-0.355872,-0.138174,-0.186487,0.0117124,-0.0852434,-0.503249,-0.516781,0.1521,0.514426,0.0244065,0.151135,0.450381,0.447336,0.0178088,-0.257845,-0.268518,0.518324,-0.755451,0.014427,-0.068882,-0.0364037,0.531221,-0.237743,-0.356242,-0.236227,-0.487788,0.0657519,-0.0642145,-0.0776992,-0.233894,-0.883344,-0.0142475,0.0994846,0.0639055,-0.0255285,0.105307,0.492298,-0.0997664,-0.504916,-0.610042,0.41727,-0.0788956,-0.129071,-0.375032,0.529078,0.324233,-0.0161937,0.00611819,0.165363,0.183863,-0.69321,-0.189061,-0.351569,0.128608,0.12703,-0.32785,-0.651139,0.196423,-0.130646,-0.353051,-0.390764,-0.231955,-0.0623142,0.164271,-0.069062,0.127401,-0.16942,0.031473,0.166927,0.284129,0.0297046,0.410607,0.13381,-0.121117,0.213119,-0.195879,-0.417867,-0.290434,0.243343,-0.853395,0.0494251,0.219548,-0.18363,0.147783,0.156169,0.225018,-0.0388507,0.387165,-0.00851745,-0.233273,0.248703,0.534478,0.17951,-0.390621,-0.140652,-0.495326,0.232069,-0.101047,0.487548,0.0169691,-0.402875,0.132972,0.00427569,-0.206119,-0.187739,-0.0822954,-0.0239387,-0.213343,-0.405538,-0.291879,-0.247541,0.000184978,0.0828766,-0.0693572,-0.200847,0.745314,0.552124,0.184452,0.109708,-0.113562,-0.277158,-0.201011,-0.470395,-0.445155,-0.121043,-0.418963,0.189421,-0.139567,0.00534564,-0.807844,-0.132256,0.324311,0.159812,-0.558685,-0.625845,0.0604131,-0.206838,-0.265604,0.162468,-0.247675,-0.340243,-0.148712,-0.271054,1.00731,0.146763,-0.32677,-0.466469,-0.127243,-0.322028,-0.0846845,0.0818814,0.23638,0.164653,0.00185977,0.00891774,-0.257964,0.29579,-0.32408,0.406017,0.0569614,-0.093203,0.555433,-0.50409,-0.0307748,0.0557949,-0.0451734,0.0562336,-0.274459,0.025126,-0.106822,0.147434,0.447197,0.194515,0.0673147,0.259968,-0.344239,-0.651764,-0.00391959,0.388207,-0.0895037,0.201743,0.0158271,0.280536,0.221101,0.339294,-0.271157,-0.0152027,-0.173668,0.195441,-0.732422,0.0992895,0.33218,-0.390527,-0.133219,0.158097,0.108593,0.219701,0.160698,0.443549,0.198729,0.0624599,-0.0567029,-0.144997,-0.0940233,-0.169589,-0.053105,0.0742305,-0.0210443,-0.6573,0.174003,0.559744,0.26316,-0.29199,-0.00782757,0.268047,-0.142567,-0.0675279,-0.27154,0.0550673,-0.0868726,0.583827,-0.131768,-0.153574,-0.300201,0.0789585,0.31659,-0.333519,-0.300228,0.0721275,-0.153633,-0.0939844,0.206074,-0.191994,0.0821686,-0.277984,-0.161403,0.164043,0.0930627,0.187555,0.305062,0.433076,-1.92173 +3456.74,0.985576,0.0848144,4,1.59878,0.810042,-0.47409,0.105683,0.530157,-0.298209,-0.143954,0.122885,0.121809,0.274969,-0.0599358,-0.00882017,-0.0943756,0.109526,-0.126556,0.732691,0.143932,-0.156056,-0.553537,-0.0110204,-0.0222119,-1.0537,-0.449787,0.328233,-0.367947,-0.280405,-0.138709,0.450473,-0.329945,-0.117303,0.914683,0.0208973,-0.116776,0.771679,0.0339083,0.262423,-0.458186,0.256016,0.328368,-0.109074,0.723546,0.389708,0.0760042,-0.314168,-0.50851,0.149107,-0.660383,-0.0423928,0.539841,-0.0193801,-0.0451295,-0.323616,0.312743,-0.396018,1.20994,-0.523312,-0.183578,-0.52699,0.318764,0.0611603,0.624018,0.747286,-0.456122,-0.952888,-0.066144,0.00431196,0.0915005,-0.107153,0.520081,-0.591279,-0.0698679,0.346532,0.851074,-0.0368998,0.627736,0.433436,-0.0221313,-0.266677,0.105563,0.100377,0.476503,0.0226531,0.247329,0.171511,-0.294482,-0.339526,0.17428,-0.109914,-0.13335,-0.118773,-0.14895,0.155592,-0.169321,0.239539,-0.0791958,0.312491,-0.0412187,-0.0637544,-0.152739,0.19549,-0.218531,0.336811,-0.196974,0.410322,-0.363497,-0.388152,0.227105,-0.19169,0.0153095,0.542143,0.0767143,-0.128936,0.0931612,0.13429,0.293043,0.4167,0.0974144,0.258087,0.320709,-0.348272,-0.2168,-0.534118,-0.314341,0.280866,0.660119,0.318359,0.0555973,-0.34888,0.201079,-0.736873,0.410627,0.219724,0.276759,0.220648,0.0127013,-0.263715,-0.296728,0.0736747,-0.0878864,-0.447116,-0.141269,0.242731,0.424092,-0.0749636,0.0454274,0.0727739,-0.143802,0.207848,-0.441727,-0.418,-0.177391,-0.269969,0.207707,-0.292479,-0.105402,0.244098,0.289137,0.293447,0.303512,-0.0790728,-0.0332663,0.015792,0.945995,0.0794447,0.0431501,0.317963,0.146621,-0.290313,0.186055,-0.123297,0.014884,-0.548327,-0.0987813,-0.163761,0.00547497,-0.0542776,-0.309556,-0.181128,0.170431,0.541566,-0.61976,-0.395059,0.375846,0.162447,0.0920237,-0.257416,-0.0127797,-0.194298,-0.184449,-0.412062,0.19105,-0.102429,-0.335873,0.0532078,0.696393,0.342451,-0.0622727,-0.100522,-0.587172,-0.225582,-0.115047,0.011231,0.29266,0.180677,-0.0107248,-0.261116,-0.857386,0.703293,-0.774877,0.713828,-0.137977,0.110656,0.243766,0.29158,-0.0687003,0.243421,-0.48813,-0.0193789,0.166602,-0.119591,-0.422722,-0.319364,0.118185,0.545494,-0.23057,0.255374,-0.113216,-0.255624,-0.312332,0.15362,0.068175,-0.105449,-0.0294909,-0.370436,-0.0882825,0.400971,-0.216864,0.0194582,0.404833,-0.0759126,0.014488,-0.0349079,-0.159605,0.140729,0.441483,-0.108182,0.266502,0.0987487,-0.494396,0.223613,0.248995,-0.149232,0.324102,0.077341,-0.0769083,0.208587,-0.239703,-0.0283741,-0.0979825,0.139696,0.340726,0.40545,-0.127795,-0.154023,0.168875,0.138931,0.287928,0.257561,0.169948,-0.00869667,-0.13811,-0.835206,0.282579,-0.17334,-0.203326,-0.134523,0.593473,-0.265449,0.434073,0.43522,0.330199,0.121031,0.184754,0.0834471,-0.0416168,0.164932,0.437688,0.788251,-0.146895,0.00215554,0.126109,0.580119,0.344141,0.315581,0.388176,-0.427144,-0.289095,0.140428,0.14209,-0.303006,0.118247,0.102339,0.226848,0.319905,0.476286,-1.36992 +3463.85,0.81841,0.0848144,4,1.53882,0.900003,-0.487839,0.0592444,0.328238,-0.153207,0.182508,-0.0153259,-0.0205897,-0.143215,0.123252,0.0597549,0.14696,0.276853,-0.402945,0.90617,0.0126815,-0.0802649,0.212777,-0.0275695,-0.133192,-0.716041,-0.611775,0.0515189,-0.412149,-0.159122,-0.109417,0.213686,-0.699199,0.407401,0.718964,-0.483754,-0.181079,0.323177,-0.327678,0.00623959,-0.746526,0.601087,0.326789,-0.281341,0.872569,0.10246,0.0971596,-0.127224,-0.483227,0.0170212,-0.651583,0.129535,0.593402,0.152163,-0.268278,0.0774125,-0.0504497,-0.103148,1.11185,-0.663487,0.164511,-0.670024,0.486691,-0.511047,0.181597,0.964237,-0.598876,-0.68537,-0.0593088,0.144112,-0.0898978,0.0486969,-0.0532635,-0.613396,-0.0151622,0.487477,0.658029,0.266143,0.605876,0.454129,0.263964,-0.320778,-0.0215812,-0.309294,0.268054,-0.11292,0.264865,-0.176416,-0.0412243,-0.444852,-0.458376,-0.0328234,-0.161999,-0.653572,-0.567298,0.0221542,-0.387566,0.25019,0.15448,-0.114516,0.0523739,-0.218135,0.35196,0.630761,0.189738,0.0774423,-0.050104,0.19576,0.0139231,0.346867,0.197913,-0.414671,-0.150253,1.1801,0.221851,-0.0311064,0.167039,0.416849,0.0293674,-0.0167863,0.298369,0.294573,0.0815882,-0.2332,-0.536829,0.00853664,-0.18282,-0.0594691,-0.0563357,-0.296164,0.689081,-0.216224,0.418987,-0.168157,0.21938,0.26092,-0.155473,0.255059,0.0330317,0.129244,-0.0321075,-0.0364978,0.00191866,-0.654175,-0.248198,-0.0286614,0.290841,-0.28336,0.475291,0.27304,0.191449,0.153747,-0.0071341,-0.144296,0.29289,-0.272184,0.123465,-0.176864,-0.354294,-0.00915887,0.535692,-0.687759,0.465436,-0.0985521,0.343128,-0.118723,1.00263,0.318654,0.568143,0.143969,-0.107668,0.191341,-0.113398,-0.384744,0.243989,0.0646886,0.0923629,-0.147486,-0.238606,-0.169511,0.179411,0.337365,-0.220413,0.544536,-0.222551,-0.361702,0.0567032,-0.146059,0.0989292,-0.0470337,0.225349,0.00202213,0.135059,-0.246147,-0.0883189,-0.00254401,-0.341914,-0.372169,0.0783682,0.172002,-0.0921396,0.0580175,-0.567655,0.0261525,0.0260157,0.252068,-0.194407,0.136573,0.30085,-0.191475,-0.332185,0.881122,-0.126376,0.169562,-0.133939,-0.0598683,0.0683375,0.0487562,-0.409143,-0.0935124,-0.21979,-0.0414735,0.169185,-0.278538,0.0260988,-0.46796,-0.163808,0.424331,-0.292512,0.465431,-0.0169721,0.236579,0.422552,0.205303,-0.451696,-0.0293516,0.375274,-0.177489,-0.0763989,0.509039,-0.234197,-0.410386,0.505416,-0.268584,0.358864,0.07125,-0.275158,0.143068,0.730937,-0.0442132,0.39204,-0.000893185,-0.487501,-0.152095,-0.50402,-0.605733,0.412086,-0.118552,-0.0135099,0.20702,0.130637,-0.0988673,-0.169216,0.455765,0.175002,0.396098,0.00695671,0.0145392,0.112238,-0.0434302,0.0456344,0.005588,0.326067,-0.344825,0.293381,-0.394547,-0.395581,0.344324,0.796739,0.0512607,0.133801,0.0546624,-0.287541,-0.0390546,0.372845,0.0399463,-0.514896,0.294277,0.0261323,0.485293,-0.223127,0.509518,0.214086,-0.0315452,0.131056,0.101828,0.15591,-0.339683,0.396764,-0.531147,-0.221246,0.0584008,-0.151675,0.157089,-0.023968,0.0989708,0.247303,0.314596,0.497296,-0.903591 +3433.86,0.550981,0.0848144,4,1.59578,0.842909,-0.750394,0.21018,0.418287,-0.130737,0.00246951,-0.0216487,-0.151477,0.239431,0.0898776,-0.649071,-0.220372,-0.0105836,0.0862945,0.450065,-0.0337628,-0.0991808,-0.510706,-0.282595,-0.129511,-0.456516,-0.389219,0.116198,-0.185591,-0.291519,0.175429,0.010001,-0.376059,-0.123169,0.60325,-0.195464,-0.319269,0.542579,-0.183935,0.0115493,0.0286674,0.502419,0.504527,-0.828739,0.626544,0.224105,0.291003,-0.367346,-0.169693,-0.319875,-0.716703,-0.13561,0.371594,-0.0495242,0.287074,0.298188,0.264844,-0.513364,0.970414,0.408622,-0.507618,-0.525775,0.315048,-0.299014,0.416888,0.680273,-0.27094,-1.06977,-0.477669,0.162736,0.293331,0.0367832,0.0872468,-0.304271,0.0285443,-0.133901,0.748488,-0.360866,0.636589,0.430282,0.235668,0.312235,-0.375881,0.136127,0.255055,-0.343413,0.29653,0.31203,0.118118,0.161396,-0.101359,-0.104777,0.181848,0.0619083,0.379767,0.38118,0.143389,0.425493,0.00410962,-0.0651956,-0.694447,-0.123193,0.175769,0.118223,0.202462,0.0153308,-0.67066,0.0654703,-0.22562,-0.270079,-0.515571,-0.0867436,0.459166,0.0327577,-0.764954,-0.222393,0.026035,0.384409,-0.00343978,0.283215,-0.18423,0.314966,0.318302,0.145935,-0.331312,-0.433364,-0.529833,-0.238133,0.301112,0.423748,-0.151648,0.0344034,-0.119931,0.103724,-0.0102357,0.241332,0.329315,0.494135,0.0409169,-0.155651,-0.248253,0.250728,0.563054,-0.597697,-0.100972,0.0754777,-0.077238,0.106606,-0.0816326,0.747033,0.27739,-0.124129,-0.121743,-0.0455065,-0.0875651,0.20797,0.25838,-0.154331,0.50997,0.18665,-0.58791,0.200169,-0.0638492,0.664037,-0.500341,-0.0974792,0.88719,-0.528963,-0.247721,0.389195,-0.0267959,-0.0798235,-0.0158699,-0.323326,0.0512891,-0.157315,-0.107681,-0.261319,0.105404,0.182574,-0.177028,-0.742053,-0.0676277,0.675427,0.0510105,-0.065108,0.589007,0.0716947,-0.0457642,0.0985588,-0.151812,-0.521794,0.48956,-0.198283,0.307259,-0.286359,0.128747,-0.842024,0.261992,0.596032,0.410513,-0.4589,-0.382275,-0.285356,0.0764106,-0.525743,0.271533,-0.834059,-0.115402,0.474408,-0.0971683,1.05008,-0.0990459,0.108725,-0.102711,0.523353,0.0771391,-0.591316,-0.572759,0.425475,0.155165,0.410116,0.249833,-0.00876115,-0.23476,0.168146,0.739337,0.536722,-0.216771,0.246941,-0.141931,-0.36275,-0.331116,-0.0603184,-0.236797,0.184943,-0.584238,-0.109131,-0.286371,0.610909,0.267659,0.219703,0.362018,-0.206078,-0.814907,0.242439,-0.109949,-0.0612954,-0.190041,-0.0352799,0.217092,0.312162,0.211164,0.0755296,0.344694,-0.0104243,0.461332,-0.204711,-0.275567,0.268956,-0.415756,0.232931,0.262733,-0.0275095,0.318241,0.412472,-0.213357,0.598707,0.34504,0.243999,0.163924,0.0526076,0.195332,-0.238097,0.0474172,-0.0950511,-0.294245,-0.741302,-0.375802,0.619558,0.585446,0.0519611,-0.0186538,0.101174,0.0428441,-0.353095,-0.0375979,-0.0713278,0.303,0.0418429,0.201933,0.14914,0.338415,-0.164357,-0.0154439,-0.0507349,0.424047,0.646844,0.000841765,0.378253,0.364796,0.140053,-0.167812,0.0263041,-0.137645,0.140652,0.129017,0.375036,0.359189,-1.05544 +3435.4,0.975395,0.0848144,5,1.59364,0.772031,-0.526684,0.115037,0.53689,-0.102199,-0.292276,-0.241465,0.179679,-0.508303,-0.00221829,-0.764882,-0.247201,0.252791,-0.0653204,0.511261,0.181721,0.157637,-0.447497,-0.11854,0.0330537,-0.873318,-0.4216,0.31149,-0.237287,-0.130145,0.432426,0.0670345,-0.192024,0.101443,0.627389,-0.182133,-0.0792708,0.231962,-0.242412,-0.0621012,-0.0475475,0.671775,0.893855,-0.505857,0.797532,0.314713,0.296462,-0.340886,0.0624429,0.165617,-0.700357,-0.28312,0.343945,-0.187771,0.450535,0.427844,0.132657,-0.262982,0.971171,0.207941,-0.429579,-0.807866,0.555181,-0.621199,0.280406,0.887483,0.0237872,-0.494347,-0.449631,-0.335534,0.0222272,0.290417,0.472665,-0.180555,0.183307,-0.00975534,0.797473,-0.54459,0.581209,0.403721,0.238622,0.263644,-0.723073,-0.0600992,0.490425,-0.321466,0.212132,-0.191234,-0.0358432,-0.113795,-0.161226,-0.0474063,0.117008,-0.212044,0.0725253,0.29107,0.0230691,0.268796,0.040148,-0.330373,-0.601565,-0.891507,0.26609,0.0506305,0.196108,0.658647,-0.404215,-0.310197,-0.397209,-0.336064,0.168047,-0.0713881,0.497031,0.0255836,-0.290998,-0.0105149,0.00148022,0.6098,0.164266,0.0676502,-0.4869,0.294339,0.22092,-0.147181,-0.301991,-0.492269,-0.752471,0.200392,-0.193815,0.134756,-0.38184,0.0353643,0.242715,-0.343499,-0.389315,0.260945,-0.106456,0.406854,0.0977898,-0.0835854,-0.0365718,0.389491,0.32207,-0.480842,0.252379,0.20443,-0.025189,-0.539519,-0.452379,0.644658,0.200938,0.0266491,0.130604,-0.374698,0.0265993,-0.0169192,0.461154,-0.0558491,-0.0350983,-0.0218143,-0.610869,0.144114,0.0668591,0.199801,-0.336922,0.029645,0.820148,-0.200205,0.366012,0.470051,0.14225,-0.323007,-0.302823,-0.267853,0.16204,-0.131678,-0.0582448,-0.451701,-0.0697629,-0.0874105,-0.152662,-0.363298,-0.0751946,0.653452,0.118787,0.601289,0.415419,0.146237,-0.0207355,-0.228637,-0.435316,-0.700016,0.602453,0.203666,0.180589,-0.0952856,0.562402,-0.562309,0.224063,0.766811,0.430408,-0.364263,-0.236277,-0.488313,0.0582315,-0.839413,0.0758364,-0.394081,-0.27566,0.305006,-0.546247,1.23518,-0.0941585,0.00162988,0.130052,0.508647,0.172617,-0.115267,-0.650778,0.311575,0.152079,0.273847,0.215224,-0.145518,-0.242111,0.0232333,0.799083,0.41754,-0.373081,0.553519,0.192371,-0.267557,0.142114,0.284254,-0.111783,0.255377,-0.573308,0.0225193,-0.33209,0.392259,0.4278,-0.274568,0.568039,-0.348346,-0.2952,-0.321092,-0.0869512,0.0623819,-0.27038,-0.0920946,0.366192,0.544738,0.0831683,0.268877,-0.0863367,0.0606247,0.441399,-0.179931,0.101166,0.281595,-0.383435,0.0539423,0.244826,0.00755461,0.0385191,0.195718,-0.370742,0.217866,0.767179,0.261419,-0.095182,0.237228,-0.0157051,-0.035868,0.280532,-0.377777,-0.437686,-0.142401,-0.300072,0.419785,0.630795,0.195551,0.0289123,0.794152,-0.0972274,-0.157908,-0.225701,0.157058,0.461996,0.0832972,0.156378,0.622656,0.112767,-0.209035,0.380207,-0.219108,0.253036,0.205838,-0.254147,0.15621,-0.142315,0.165782,-0.467376,-0.111305,-0.00322626,0.109873,0.187394,0.331471,0.43289,-1.36045 +3435.29,0.915964,0.0848144,4,1.55036,0.732629,-1.22545,0.393879,0.400407,-0.166843,-0.00851821,-0.116987,-0.197222,-0.712356,-0.000891495,-0.402009,-0.183421,0.0734809,-0.178307,0.342116,0.0733998,0.249606,-0.373641,-0.152462,0.0698701,-0.592782,-1.0285,0.351809,-0.108897,-0.0608833,0.419713,0.272593,-0.463363,0.184423,0.63887,-0.101645,-0.277566,0.102158,-0.353739,-0.272272,-0.662043,0.69766,0.648263,-0.269035,0.810616,0.0265503,0.417225,-0.472582,-0.111739,-0.119212,-0.732839,0.203153,0.39166,0.0629328,0.367564,0.0117332,-0.108856,-0.7572,0.696633,-0.207476,-0.221321,-0.69001,0.481606,-0.683633,0.554939,0.832496,-0.489581,-0.468093,-0.318164,-0.353455,0.0237636,0.130138,0.689447,-0.109753,-0.286648,0.301679,0.750046,-0.41049,0.869564,0.35507,0.110688,0.283408,-0.382251,0.0989949,0.828182,-0.183912,0.379085,-0.0870521,-0.445506,0.131839,-0.0905779,-0.293771,-0.196487,-0.313561,0.0262797,0.125506,0.157731,-0.0905526,0.230107,-0.236824,-0.0471953,-0.586916,0.249114,0.121808,0.0963328,0.412843,0.05418,-0.329716,-0.276239,-0.468223,-0.113044,-0.285143,0.450251,-0.140704,0.0760984,0.0480068,-0.271913,0.430635,0.158477,0.0884149,-0.337439,0.210179,0.267835,-0.1123,-0.169912,-0.146511,-0.745187,-0.0825837,0.171568,0.132211,-0.117088,0.271963,0.348807,-0.568496,-0.477143,0.0323021,-0.188039,0.546129,0.0448898,-0.342383,-0.299327,0.338025,0.241138,-0.314276,-0.13708,-0.141764,-0.211326,-0.457861,-0.328993,0.67081,0.369301,-0.19784,-0.0152437,-0.459642,0.0887481,0.233765,0.553394,0.230419,0.160052,-0.316063,0.018418,0.284231,0.397816,0.303056,-0.089706,-0.184083,0.755308,-0.404772,0.546229,0.35797,0.359852,-0.194155,-0.0466645,0.198967,0.658613,0.334891,0.196396,-0.0285315,0.379523,-0.376743,-0.160363,-0.261652,0.0257984,0.748929,-0.152418,-0.290341,0.550782,-0.423528,0.116295,-0.0193343,-0.409766,-0.546943,0.791685,-0.250885,-0.0922119,-0.250507,0.271609,-0.220031,-0.015103,0.850015,0.48746,-0.268914,-0.600679,-0.397692,-0.186826,-0.36477,0.367743,-0.534851,-0.288651,0.28214,-0.522859,1.14276,-0.590255,-0.367874,0.028718,0.467967,0.459768,-0.0194723,-0.535338,0.512633,0.0842032,0.349186,0.545783,-0.228106,-0.126456,-0.13017,0.362909,0.630158,-0.355315,0.805709,-0.362416,-0.167576,0.321723,0.234871,0.717776,0.239932,-0.14847,-0.05106,0.0775153,0.503697,0.428332,-0.291402,0.701409,-0.655829,-0.180922,0.289237,0.00381568,0.168257,0.0355097,-0.0415494,0.253496,0.680614,-0.140354,0.0317932,-0.109936,-0.0924083,0.537423,-0.154577,-0.380733,0.13523,-0.359925,0.593914,0.362268,-0.170386,0.407728,0.328992,-0.425256,-0.448123,0.30718,0.241846,0.174706,0.086368,-0.240925,0.272492,0.0565805,0.0709748,-0.702414,-0.135023,-0.284744,0.550775,0.597463,0.127358,0.204862,0.471747,-0.233887,-0.204871,-0.264711,0.285015,0.452269,0.398747,-0.0833863,0.0860168,-0.0506465,-0.176012,0.189169,-0.231058,0.136611,0.0114001,-0.487181,0.391915,0.0358068,-0.0154205,-0.208927,-0.437857,0.271015,0.138855,0.165593,0.372633,0.406931,-0.762108 +3410.35,0.971492,0.0848144,4,1.58129,1.00839,-0.798138,0.143527,0.653105,-0.166576,0.000673433,-0.154266,0.144185,0.540693,0.122496,-0.55766,0.0817357,-0.187197,0.00398067,0.50908,-0.106249,-0.188195,-0.228399,-0.767177,-0.317756,-1.09891,-0.387404,-0.250789,0.032119,0.269612,0.040999,0.0816933,-0.621522,-0.314379,0.747987,-0.821409,0.325641,0.327959,-0.329412,-0.411003,0.493919,0.337571,0.626315,-0.0284053,0.9726,0.438839,0.187319,-0.406564,-0.010858,0.513782,-0.332947,-0.332371,0.121167,0.102008,-0.280534,0.770861,0.267325,-0.23951,0.408365,0.242616,-0.185881,-0.731409,0.428613,-0.059283,-0.231709,0.284283,-0.109448,-0.575929,-0.0971113,0.188149,-0.807459,0.265326,-0.202832,-0.767454,0.242252,0.297173,0.537914,-0.154831,0.864066,0.47443,0.193781,0.0813608,0.293768,-0.0348535,0.328261,-0.172525,0.0744824,-0.354049,-0.708152,-0.180495,0.224739,0.306025,0.415871,-0.44973,0.00472967,0.0555447,0.0616957,0.100655,0.344472,0.0719842,0.240843,-0.0690589,-0.168698,0.39451,0.265044,0.0258151,-0.260419,-0.589091,0.465431,-0.310025,0.448282,0.277082,0.280027,0.999864,-0.076537,-0.0171186,0.221264,0.984864,-0.684666,-0.259394,0.138277,0.0619115,0.0638309,-0.604813,-0.0271204,0.253918,-0.255298,0.398213,-0.11356,-0.152693,0.18913,0.189032,-0.289246,-0.248736,-0.161627,0.261447,-0.293979,0.590297,-0.2896,0.283707,0.120852,0.0938863,0.496797,-0.677022,-0.0327273,0.253511,0.0538822,-0.685956,-0.361365,-0.385163,-0.344016,0.342924,-0.295962,-0.412809,-0.247396,-0.222841,0.801366,0.146803,0.08897,0.568132,-0.237373,-0.178781,-0.0654999,-0.168714,-0.0755724,0.31037,0.899367,-0.502673,-0.291345,-0.530367,-0.0590196,-0.382762,-0.323901,-0.867805,-0.0288103,0.443641,0.343519,-0.562513,0.324975,0.332336,-0.084618,-0.524012,-0.0260594,1.25999,0.188235,-0.073488,-0.0619915,-0.153278,-0.0128681,-0.752537,-0.411573,-0.111774,0.161761,-0.64343,0.258896,-0.190534,-0.0141505,-0.766741,0.0035877,0.241373,0.230297,-0.510867,-1.09024,0.362142,0.0141578,-0.696285,-0.126416,0.242521,0.738676,-0.387629,0.0227635,0.66951,0.414412,0.430421,0.257069,0.152339,0.448273,-0.0755687,-0.22813,0.00797568,-0.729444,0.234156,0.207556,-0.800664,0.128615,0.200498,-0.513187,0.239773,-0.145996,0.277743,-0.366157,0.168503,-0.130359,-0.0307516,-0.313881,0.503026,-0.10395,-0.0162091,0.0935606,0.44604,-0.194363,0.669805,0.869902,-0.0936134,-0.0465197,-0.0883769,0.232335,0.16593,0.869837,0.528174,0.363199,0.35167,-0.146591,-0.0153469,0.128416,-0.276828,0.452014,-0.493994,0.154838,0.933077,-0.501662,-0.207927,-0.654605,0.350737,-0.529881,8.47128e-05,-0.392598,0.447951,0.819539,0.614159,-0.128572,0.22517,0.48165,0.215711,-0.179658,0.0563315,-0.0792266,-0.29029,0.0500159,-0.565989,-0.046652,0.182493,0.135205,-0.253538,-0.106633,0.231313,-0.0228638,0.501413,0.044004,0.482208,0.256349,-0.540273,0.182653,0.651927,0.492899,0.268591,-0.00459399,0.114065,0.179172,-0.811242,-0.187942,0.706299,-0.745491,-0.444718,0.382033,0.168246,0.176994,0.410178,0.420706,-2.04477 +3411.59,0.836853,0.0848144,5,1.57385,0.825097,-1.22009,0.570154,0.960241,-0.131155,0.100817,0.187315,0.410162,-0.4106,-0.16677,-0.237976,-0.259294,0.191045,-0.399792,0.927002,0.137927,0.0699173,-0.278168,-0.248357,-0.106484,-0.801598,-0.853107,0.118488,-0.601777,-0.148137,-0.319304,0.556801,0.0343397,-0.141997,1.02994,0.0228111,0.0588822,0.267502,-0.30328,-0.342839,-0.388968,0.854316,0.581352,-0.0801312,0.929017,0.894332,0.608988,-0.0693544,-0.0987787,-0.55505,-0.320399,0.241981,0.0446766,0.35129,0.0622374,0.407075,-0.0440348,-0.24458,-0.0163139,-0.494237,-0.105888,-1.01636,0.443312,-0.597558,0.47823,1.20083,-0.626833,-0.871569,-0.000777659,0.271445,0.694397,-0.336927,0.515151,0.00979316,-0.58862,-0.0464596,0.80004,-0.162771,0.633197,0.320181,0.38201,0.452013,-0.358531,0.0477371,0.590824,-0.724865,0.530929,0.105451,0.017511,0.0542964,-0.026066,-0.698529,0.190161,-0.66973,0.035294,0.0426987,0.193799,-0.00624638,-0.146142,-0.816519,-0.114308,-0.40704,0.0172078,0.127081,0.0450798,0.190857,-0.96763,0.121375,0.109437,-0.329311,-0.127418,-0.658211,-0.0726933,0.264777,-0.372266,-0.373107,-0.142153,0.686826,0.329912,0.279133,-0.598031,0.0602236,0.303206,0.696412,-1.14936,-0.228323,0.265586,-0.752136,-0.117449,0.415088,0.156491,-0.201034,0.637761,-0.662238,0.35907,0.0310977,-0.114191,0.685798,-0.14019,-0.408238,0.254681,-0.329045,0.265091,-0.34164,-0.78473,-0.0367147,0.236067,-0.377953,0.546571,0.0046878,-0.266585,0.82768,-0.514639,0.218019,-0.00156966,0.690571,-0.426486,-0.168561,-0.0297448,0.342958,0.597773,-0.079627,0.172605,-0.402286,0.187997,-0.693087,0.867276,-0.275743,-0.132002,0.539057,-0.0450736,-0.18021,0.15204,0.532827,0.32324,-0.24163,0.302764,-0.0611209,-0.611985,-0.706393,-0.538417,0.21173,0.352159,0.244688,0.184383,-0.300313,0.29352,-0.103838,-0.40623,0.277424,-0.337081,-0.452278,0.000715882,-0.16615,0.108579,-0.0336649,0.287963,-0.442748,0.132343,0.40435,0.32428,-0.13706,-0.102961,-0.520041,0.0230826,-0.287459,0.258928,-0.409687,-0.0722198,0.0116482,-0.537357,0.749894,-0.569866,0.101225,-0.0381965,-0.459501,-0.061388,-0.144407,-0.275292,0.594355,0.0896081,0.028922,0.280417,0.158921,-0.420117,-0.86359,0.395061,0.49175,-0.919806,0.439298,-0.421175,-0.416556,0.305756,0.00356231,-0.15127,0.239489,-0.473184,-0.383143,-0.542331,0.207173,0.180483,-0.399427,0.27859,-1.15126,-0.608054,0.451101,-0.0572831,0.0554234,-0.127672,0.183028,0.700891,-0.0439611,-0.0649556,-0.125865,-0.563789,-0.513543,0.321918,0.115267,-0.24548,0.277109,-0.00713664,0.288959,0.962941,0.116332,1.05689,0.497654,0.75293,0.496668,-0.152814,0.196638,-0.162961,-0.253335,-0.456976,0.114273,0.12135,-0.267106,-0.615831,0.424907,0.194151,0.101159,0.351131,-0.652529,0.208256,0.166545,0.246452,-0.566215,-0.363062,-0.597415,0.247987,-0.251243,-0.184241,0.504023,0.0667399,-0.507988,0.514474,-0.422741,0.0500608,-0.00995945,-0.279837,0.00958587,0.504765,-0.598759,0.204171,0.0511938,-0.106903,0.174934,0.311682,0.418251,0.558285,-2.93954 +3405.13,0.616285,0.0848144,4,1.51117,0.81164,-1.38715,0.657752,0.730792,-0.188661,0.45224,0.0847212,0.117927,-0.336415,0.268165,-0.11947,-0.20443,0.147124,-0.102035,0.673768,0.196321,0.266241,0.174794,-0.15875,0.0364106,-1.17471,-0.539345,0.248763,-0.570309,0.0733448,-0.281002,0.572618,-0.0371083,0.0526241,0.957914,-0.350936,-0.130001,0.214126,-0.282575,0.0834142,-0.489975,0.637612,0.14607,-0.326971,0.874133,0.625582,0.492811,-0.352217,-0.552034,-0.324317,-0.400004,0.408373,-0.050315,0.132393,-0.0841842,0.411709,0.0692074,-0.142091,-0.38153,-0.381547,-0.388003,-0.514395,0.192597,-0.818478,-0.0319616,0.953536,-0.711635,-0.728908,0.284782,-0.0220767,0.634231,-0.54033,0.26664,0.0890474,-0.277555,0.368213,0.834269,-0.129205,0.433559,0.655235,0.394537,-0.0915647,-0.0898275,0.0710904,0.719261,-0.776798,0.255956,-0.200536,-0.110533,0.236793,0.134935,-0.794125,0.661477,-0.747133,0.309622,0.222277,0.5104,0.190452,-0.0876216,-0.715731,0.566117,-0.198105,-0.450726,-0.0186578,0.46597,-0.0777922,-0.868431,-0.028881,0.0611427,-0.162658,-0.215323,-0.66306,0.110379,0.180401,-0.320297,-0.112942,-0.254177,0.815069,0.0108213,0.184447,-0.835989,-0.00893358,0.538617,0.424669,-0.867702,-0.159788,0.246101,-0.345665,-0.0732613,0.67471,-0.0241329,0.129211,0.459935,-0.67349,0.411453,0.0741037,-0.46094,0.65746,-0.0433716,-0.19961,0.256543,0.0630588,0.403072,-0.445357,-0.613576,-0.0606113,0.621224,-0.406444,0.601129,-0.167577,-0.127517,0.683265,-0.463686,0.329469,-0.758458,0.511784,-0.254241,-0.0530693,0.0457703,0.613568,0.690895,0.0424538,-0.144363,-0.566381,0.258266,-0.616986,0.871058,-0.120642,-0.218268,0.134692,0.103976,-0.174117,-0.229422,0.206219,0.403221,-0.384737,0.306559,0.0075783,-0.126333,-0.492105,-0.0358153,0.17041,0.326878,0.701957,0.116414,-0.428596,0.174674,0.0234841,-0.049226,0.295838,-0.117305,-0.369388,-0.159288,-0.405868,0.071671,-0.526616,0.152965,-0.571257,0.19491,0.00203244,0.401715,0.0374616,-0.409839,-0.876535,0.231931,0.00341033,0.185493,-0.128786,0.0559903,-0.367639,-0.352127,0.884391,-0.373099,0.256574,-0.0654734,-0.209265,-0.0574426,0.161623,-0.486013,0.226399,0.258283,0.124316,0.570439,0.110731,-0.251884,-0.991277,0.846024,0.875989,-1.01045,0.462773,-0.340803,-0.522697,0.300566,0.1021,-0.262218,0.38151,0.192614,0.00503509,-0.922547,0.435135,-0.193966,-0.151129,0.555549,-0.963015,-0.606239,-0.0371299,0.320466,0.279517,-0.420361,0.46018,0.443689,0.340316,0.344933,-0.031487,-0.669911,-0.43843,0.28206,0.050513,-0.258959,0.438821,-0.0773217,0.462711,1.01872,0.163334,0.606047,0.487249,0.551009,0.477604,-0.00829578,-0.00548406,0.034109,-0.321906,-0.674651,0.309287,-0.586555,-0.349863,-0.259058,0.152861,0.266772,0.112467,0.358365,-0.54374,-0.0193227,-0.000908449,0.25299,-0.561925,-0.610582,-0.244584,0.716502,-0.432154,-0.21878,0.730827,0.0367956,-0.680544,0.669376,0.130332,-0.121259,0.306992,-0.189099,-0.00117468,0.0835602,-0.623451,0.51791,-0.287116,-0.635007,0.179955,0.29861,0.424211,0.546452,-2.19763 +3407.68,0.968991,0.0848144,5,1.50031,0.782786,-1.36111,0.670466,0.647342,-0.192769,0.217356,-0.117961,0.27627,-0.0570665,0.0935654,0.0359638,-0.218377,0.107669,-0.0171294,0.702229,0.178703,0.216539,0.368399,-0.0139775,0.19816,-0.849782,-0.391814,0.392221,-0.351792,0.196236,-0.354673,0.353735,-0.197893,0.000782207,1.10726,-0.4091,-0.0103635,0.0986437,-0.487131,0.127958,-0.677432,0.465438,0.0131232,-0.122249,1.06317,0.694334,-0.101418,-0.0828977,-0.622093,-0.344785,-0.716124,0.562625,-0.0634505,0.0332844,-0.0415916,0.73211,-0.116666,0.0139034,-0.0989084,-0.260378,-0.441954,-0.406487,0.223271,-0.903697,-0.130025,0.604641,-0.841567,-0.448142,0.569889,-0.174475,0.52559,-0.505294,0.167164,-0.262118,0.0226648,0.672559,0.860145,-0.436745,0.192073,0.677019,0.280493,0.0940735,-0.161711,-0.0723615,0.638065,-0.864261,0.0822517,-0.102805,-0.194762,0.266951,0.409806,-0.763152,0.415658,-0.515329,-0.117639,0.103199,0.332193,-0.0624313,-0.128562,-0.816207,0.378639,-0.297525,-0.522554,0.264585,0.38994,-0.165468,-0.937886,0.00624129,-0.0701579,0.136503,-0.440715,-0.706567,0.0712898,0.324298,-0.543772,-0.143342,-0.300913,0.848407,0.349027,0.277448,-0.641827,-0.12385,0.43346,0.482738,-0.680158,-0.38698,0.171026,-0.276096,-0.282825,0.345942,0.131649,0.162173,0.412792,-0.379928,0.485646,-0.0132044,-0.377346,0.463541,-0.13916,-0.501896,-0.30049,-0.196562,0.58978,-0.413365,-0.610575,-0.127747,0.583987,-0.322748,0.496896,0.0158909,0.0932862,0.416885,-0.387697,0.27911,-0.438461,0.295762,-0.223425,0.096489,0.523037,0.385842,0.596039,0.386799,-0.249688,-0.753042,0.163094,-0.106172,1.22009,0.0395433,-0.0720845,-0.0902216,0.2817,-0.0858571,-0.305578,-0.196173,0.1352,0.0400787,0.192687,-0.0416496,-0.093721,-0.33129,0.0275806,0.0677985,0.503325,0.909197,-0.269509,-0.499345,-0.0353425,-0.0610566,0.0602465,0.145686,-0.438142,-0.26676,-0.22581,-0.671878,0.254891,-0.496059,0.295999,-0.66161,0.214958,0.119903,0.678796,-0.49857,-0.30378,-0.864506,0.150708,-0.00851885,-0.0919875,-0.193971,0.0604623,-0.141577,-0.207682,0.808436,-0.160413,0.379575,0.236578,0.0348168,-0.160426,-0.00919538,-0.104781,0.405501,0.287295,0.042502,0.247535,0.0826844,-0.374538,-0.645316,0.962328,0.812538,-1.15937,0.369956,-0.402024,-0.546228,0.283159,-0.178205,-0.555915,0.427594,-0.0339175,-0.0263538,-0.878739,0.607162,0.0209343,0.344938,0.701843,-0.594831,-0.523464,-0.0319554,0.243612,0.0515482,-0.069637,0.267455,0.550881,0.325855,0.110065,-0.101748,-0.715794,-0.464023,0.242951,0.247617,-0.0120291,0.505482,0.0384913,0.503409,0.512487,0.422475,0.515617,0.298681,0.437825,0.556338,0.122035,-0.0754467,0.0499515,-0.29527,-0.891385,0.651042,-0.906511,-0.191674,-0.23804,0.067108,0.183663,0.450032,0.366393,-0.291257,0.0800604,-0.239944,0.170823,-0.582723,-0.260972,-0.359215,0.834707,-0.103019,-0.210153,0.756868,0.128234,-0.417773,0.534257,0.252563,0.135363,0.139325,-0.117891,-0.209095,0.209957,-0.506972,0.301902,-0.353855,-0.490211,0.18222,0.253998,0.426872,0.503982,-1.90516 +3405.07,0.987245,0.0848144,4,1.52608,0.803072,-1.33514,0.701954,0.679258,-0.173632,0.0699063,-0.065941,0.205253,0.10393,0.0699817,0.126962,-0.178055,0.388068,0.107136,0.7673,0.335035,0.180826,0.409343,-0.0657227,-0.0114221,-0.762204,-0.501231,0.343775,-0.311236,0.202072,-0.412104,0.36758,-0.229497,0.081379,1.16859,-0.369641,0.0827814,0.064175,-0.429413,0.221764,-0.842689,0.362521,0.133046,-0.258104,0.960886,0.659296,-0.0890893,-0.184477,-0.444106,-0.377421,-0.828309,0.56487,-0.0812395,0.123162,-0.079128,0.808113,-0.055279,0.0532683,-0.317392,-0.421534,-0.440502,-0.330452,0.135417,-1.01443,-0.137451,0.615941,-0.926916,-0.639805,0.446446,-0.223488,0.522362,-0.352974,0.0759689,-0.256388,0.073226,0.536932,0.774372,-0.313348,0.247818,0.795194,0.255489,-0.115515,-0.0441659,-0.0551021,0.598172,-0.853541,0.188185,-0.214097,-0.0712608,0.132244,0.425981,-0.653889,0.416024,-0.546837,-0.104792,0.10565,0.317813,-0.0462816,-0.198348,-0.802516,0.359999,-0.394061,-0.538122,0.272101,0.31012,-0.236933,-0.760753,-0.190712,-0.00373002,0.0156377,-0.492254,-0.582272,0.0787562,0.325152,-0.67422,-0.0917909,-0.0512637,0.719374,0.206964,0.236658,-0.48608,-0.126513,0.478781,0.621362,-0.534274,-0.515838,0.299226,-0.32992,-0.248399,0.244306,0.126443,-0.164848,0.332115,-0.354303,0.463892,0.116019,-0.469395,0.450964,-0.0835731,-0.561564,-0.170245,-0.216901,0.610179,-0.489869,-0.699123,-0.14856,0.530229,-0.281847,0.558657,-0.0437462,0.0254905,0.401237,-0.264808,0.214572,-0.353405,0.281399,-0.169503,-0.0454527,0.555338,0.580233,0.820283,0.312602,-0.265369,-0.837063,0.346923,-0.257269,1.30152,0.0894863,-0.154957,-0.071738,0.269826,-0.130502,-0.423473,-0.147789,0.0470521,0.044277,0.195455,0.013049,-0.205295,-0.31988,0.191371,0.26048,0.547111,0.767007,-0.266043,-0.433044,-0.0309574,-0.102243,-0.134732,0.0557196,-0.547497,-0.25135,-0.0147961,-0.576985,0.409879,-0.487387,0.248509,-0.608657,0.239306,0.0827634,0.698522,-0.520298,-0.377685,-0.82636,0.122547,0.0729806,-0.117762,-0.168407,-0.0834661,-0.246806,-0.307451,0.72809,-0.191417,0.453846,0.206512,0.117826,-0.250843,-0.0816132,0.0260101,0.211014,0.109669,-0.132705,0.360264,0.172914,-0.447971,-0.562691,0.989423,1.16231,-1.07317,0.509426,-0.470482,-0.408204,0.389031,-0.266012,-0.466181,0.532233,0.0248298,-0.174654,-0.70177,0.690045,-0.0803435,0.219997,0.780946,-0.451651,-0.456013,0.0462471,0.350427,-0.235726,0.111058,0.11316,0.639234,0.497796,0.223992,-0.19499,-0.650645,-0.322802,0.400519,0.0461122,0.15736,0.466041,0.070153,0.667994,0.478727,0.378179,0.574908,0.34866,0.586884,0.542898,0.0493959,0.103023,-0.0217045,-0.399985,-0.657503,0.818627,-0.912364,-0.134515,-0.13027,0.169135,-0.0225233,0.499733,0.454682,-0.392,0.0480086,-0.345063,0.178195,-0.701584,-0.313541,-0.418458,0.807888,-0.0805451,-0.232301,0.694136,0.15638,-0.554506,0.559773,0.184314,0.297199,0.0957132,-0.14202,-0.0726954,0.212416,-0.419286,0.480386,-0.108869,-0.454432,0.191964,0.250339,0.438137,0.500339,-2.0695 +3387.17,0.973555,0.0848144,4,1.54283,0.706509,-1.11059,0.593238,0.54918,-0.308356,0.149045,0.693508,0.725714,-0.148538,0.444961,-0.496091,-0.434026,0.487927,0.372139,0.629054,0.116282,0.234903,0.0557248,-0.448157,0.255921,-0.765034,-0.424958,0.600862,-0.203044,-0.495752,-0.0239264,0.519014,0.138433,0.447343,1.16221,-0.344056,-0.158836,0.0067013,-0.327998,-0.171998,-0.002388,0.768546,0.331227,-0.740477,0.86538,0.459079,0.577903,-1.06706,-0.734471,-0.118698,-0.759958,0.697218,-0.0392507,0.231141,0.349242,0.738882,0.104406,-0.534585,0.0385919,-0.373391,-0.23628,-0.403059,0.199044,-0.320055,-0.0146663,0.674061,-0.754157,-0.609231,0.197471,0.111827,-0.498371,-0.449173,0.666551,-0.734166,-0.235577,0.665326,0.532328,-0.252584,1.16434,0.675748,0.488711,-0.0550881,-0.0417166,0.111375,1.23319,-0.779845,0.707532,0.212485,-0.26603,-0.00370351,-0.132783,-0.591863,0.276866,-0.810433,0.0107254,0.306375,0.214696,0.0687576,-0.188456,-0.558163,-0.188159,-0.445623,0.203199,-0.217764,0.0235538,-0.197695,-0.726592,-0.410682,0.00232147,0.0850175,-0.19638,0.15155,-0.149412,0.506787,-0.00651278,-0.520381,0.413092,0.685611,0.346676,0.0153171,-0.332179,0.0842284,0.263676,0.144207,-0.380199,0.0578783,-0.278548,-0.2324,-0.207486,0.3498,0.0194582,-0.290109,0.180707,-0.425514,-0.105771,0.20573,-0.087532,0.675293,-0.125734,-0.380901,-0.781468,-0.144997,0.259294,-0.567969,-0.400654,0.436451,0.569559,0.64337,0.61386,-0.323271,0.0876325,-0.0451385,-0.183752,-0.0897889,-0.0975971,0.83581,0.146319,-0.50199,0.183999,0.632577,0.43031,0.298241,0.00470417,0.155615,-0.104518,0.474953,0.730438,-0.217981,0.286728,-0.182944,0.57327,-0.293457,-0.342136,0.19778,-0.218154,-0.0530389,0.291356,0.00787932,-0.590352,-0.57974,-0.398902,0.367275,0.636485,0.802014,-0.28917,-0.218613,0.279221,-0.447869,-0.556794,-0.144224,-0.451407,-0.177082,0.181674,-0.259683,0.145314,-0.164765,0.0284797,-0.296295,0.301548,0.0666799,0.710927,-0.215455,0.219512,-0.382568,-0.00761247,-0.312315,0.304445,0.366883,-0.194128,-0.565398,-0.342971,0.917867,0.534969,-0.0468228,0.559433,-0.195982,-0.223864,-0.225879,-0.233127,0.242894,-0.165378,-0.230534,0.107256,-0.33819,-0.2803,-0.0529055,0.31349,0.548545,-0.277734,0.528192,-0.515982,-0.505723,-0.489885,0.237678,-0.368134,0.339984,-0.083274,0.184,-0.740799,0.43641,0.636533,0.414914,0.955822,-0.632196,-0.615068,-0.0795895,0.0979905,0.351888,0.213196,0.437598,0.682338,0.463811,-0.326345,-0.164596,0.194039,-1.00828,0.684184,-0.162552,-0.201917,0.591584,-0.301077,0.44725,-0.283784,0.0425631,0.285605,0.893638,0.575049,-0.0186271,0.00652768,0.214046,0.223529,-0.385279,0.645964,0.816281,-0.414064,-0.600097,-0.424246,0.437211,0.301625,-0.414195,0.409826,-0.308983,-0.143653,0.231834,-0.267896,-0.0392241,-0.803132,-0.782257,0.20146,-0.383745,0.0144987,0.00506333,-0.0269003,0.271432,0.524297,-0.144768,0.0729343,0.347752,-0.224908,-0.860798,0.537788,0.195367,0.388418,-1.39771,-0.246129,0.192602,0.180912,0.438864,0.425338,-1.4314 +3379.3,0.964219,0.0848144,4,1.58567,0.798251,-1.53235,0.719648,0.736837,-0.203731,0.38393,-0.0268044,0.0741083,-0.0266897,-0.25907,0.128201,-0.0440174,0.510335,-0.423395,0.507545,0.271721,-0.00682812,0.537828,0.194546,-0.19198,-1.05589,-0.222556,0.168971,-0.0577391,-0.0589448,-0.670269,0.249091,-0.515206,-0.0434325,0.947917,-1.0896,-0.296502,-0.0632642,-0.851072,-0.203311,-0.435604,0.422328,0.0478366,-0.363638,1.12242,0.389949,0.327209,-0.890803,-0.00280641,0.116527,-0.0999886,0.196715,-0.0357188,0.0238009,-0.0754578,0.79856,-0.0265415,-0.64977,-0.311075,-0.055894,-0.286541,-0.822309,-0.133622,-0.705814,-0.0752786,0.885885,-0.150439,-0.070905,-0.246859,-0.0621594,-0.293973,-0.292173,0.280703,-0.425859,-0.291461,0.426117,0.692962,0.467853,0.727603,0.561218,0.435858,-0.833159,0.103489,-0.325238,0.147089,-0.261587,0.167886,0.175366,-0.37361,0.128954,0.613291,-0.359716,-0.142696,-0.435509,-0.168343,-0.378313,0.122214,-0.0521269,0.311748,-0.22437,0.291992,0.167236,0.0572164,0.318397,-0.109968,-0.178004,-0.468599,-0.0696745,-0.000123957,-0.103746,-0.475799,0.233699,0.681064,0.153614,-0.290526,-0.0846098,0.427324,0.746128,-0.467949,-0.080655,-0.363599,0.51037,-0.0909462,0.0826538,-0.539622,0.526654,-0.06487,-0.0422212,-0.351357,-0.0760898,-0.0985236,0.330888,0.558148,-0.447349,0.393674,0.195089,0.574639,0.686803,0.0901827,-0.3622,-0.185993,-0.145598,0.253986,-0.275013,-0.354773,0.0236521,0.357991,0.0268309,0.0305544,0.491195,0.167713,0.848864,0.136356,0.237072,-0.406834,0.221114,-0.0120067,-0.00960112,-0.274469,0.609547,0.346945,0.212923,-0.511147,-0.0849487,-0.00838578,0.109166,0.681215,-0.382774,0.0696372,-0.222416,-0.0360361,-0.906488,-0.235746,0.101345,0.0500104,-0.445804,0.218688,0.261896,-0.150121,-0.0900803,-0.0161365,0.206892,0.932563,0.544302,-0.0784983,-0.217399,0.682034,0.388087,-0.0588252,-0.0191483,-0.474897,0.224634,0.459147,-0.213372,-0.265657,0.161495,-0.00862617,-0.57501,-0.223191,-0.0268908,0.285136,-0.084975,-0.556354,-0.105217,-0.285139,-0.553625,1.07128,-0.254908,-0.0825064,-0.253327,-0.234513,0.815262,0.629254,-0.330045,0.439284,0.108726,-0.585209,0.341172,-0.0597836,0.793516,-0.361778,0.0389789,0.374707,-0.884817,-0.611719,-0.168062,0.0331535,0.351855,-0.314139,0.60972,-0.331768,-0.782417,0.00293922,0.0218803,-0.422304,0.391257,-0.860483,-0.441288,-0.960616,0.755853,0.104684,-0.301464,0.410933,-0.531428,-0.743777,0.0504796,-0.423804,0.274489,0.310569,0.3966,0.646448,0.325194,-0.0645709,0.0815463,0.0974687,-0.489151,0.582468,-0.31173,-0.245073,0.486889,0.443415,0.678802,0.409946,0.6461,-0.0210035,0.640781,0.403832,-0.168676,-0.0825098,-0.273185,-0.0339869,-0.674006,0.0164463,0.500539,0.236694,0.318645,-0.652642,0.256087,0.764814,0.00280045,0.207684,0.0204612,0.107774,0.0436846,-0.0111919,-0.347404,-0.723644,0.486103,0.282384,0.210077,0.258145,0.0966396,0.464273,-0.226578,0.538372,-0.589053,-0.457427,0.655737,-0.341718,-0.457944,0.400635,-0.0587413,0.20019,-0.474045,-0.0548767,0.166221,0.276117,0.407703,0.525469,-2.09817 +3382.77,0.968395,0.0848144,4,1.579,0.824036,-1.50101,0.698204,0.443173,-0.273889,0.21613,-0.204153,0.46051,0.222376,-0.3211,0.292062,0.250025,0.302651,-0.440646,0.52765,-0.0450158,0.0775458,0.36786,-0.0737775,-0.087023,-1.11821,-0.296883,0.27211,-0.105401,-0.0546748,-0.689051,0.117473,-0.539442,0.160287,0.893674,-0.904992,-0.19082,0.0564779,-0.712612,-0.474521,-0.563692,0.270489,-0.185656,-0.0952802,0.968421,0.493931,0.449676,-0.717294,-0.162937,0.295786,0.0356644,0.45844,-0.146591,0.127673,0.223819,0.38974,-0.119335,-0.375531,-0.259818,0.0112469,-0.174174,-0.877702,-0.0946427,-0.815443,-0.32355,0.907752,-0.00622797,-0.352746,0.0990488,-0.061944,-0.0513887,-0.243118,0.142517,-0.273791,-0.514424,0.376542,0.492828,0.546592,0.629102,0.475534,0.643599,-0.632369,0.22502,-0.367835,0.0782256,-0.127556,0.222128,0.0794118,-0.276179,0.0117975,0.462663,-0.337949,0.0704132,-0.316673,-0.307459,-0.198784,0.215713,-0.107677,0.147465,-0.0551102,0.173636,0.471931,-0.256896,0.116108,0.502901,-0.136377,-0.756458,-0.0136665,-0.128641,-0.0342645,-0.416006,0.173582,0.417634,0.126593,-0.184386,0.0394086,0.197513,0.510084,-0.633906,0.144766,-0.23206,0.514541,-0.317211,0.3811,-0.556194,0.616289,0.0701607,0.298799,-0.389955,0.0249031,-0.300983,-0.0758967,0.567261,-0.504376,0.241529,0.261131,0.304638,0.619005,0.0135155,-0.654302,-0.45881,-0.35463,0.396141,-0.0630123,-0.530335,0.168475,0.357514,-0.0691706,0.108614,0.544712,0.322778,0.958251,0.161485,0.396833,-0.405086,0.120811,0.260284,-0.0292184,-0.381149,0.418658,-0.0458564,0.175652,-0.280057,-0.0672643,0.0856569,0.174075,0.778536,-0.588926,0.22773,-0.337589,0.101721,-0.902147,-0.7283,0.104118,0.103274,-0.519123,0.3739,0.0859206,0.146411,0.00220057,-0.110049,0.347727,0.610972,0.549231,-0.0171371,-0.040356,0.778144,0.264981,0.0263848,-0.2111,-0.0838251,0.270751,0.0642191,-0.0371127,-0.220684,0.100772,0.119801,-0.640515,-0.161385,-0.0482848,0.103524,-0.431411,-0.548366,0.00469822,-0.119455,-0.428269,1.13328,-0.130104,0.0310943,0.000423593,-0.277918,0.707734,0.633731,-0.270836,0.497122,0.249133,-0.3724,0.0137453,0.241191,0.801269,-0.44094,0.0770313,0.507502,-0.931597,-0.856285,-0.228791,0.0753274,0.258946,-0.262508,0.447785,-0.0400706,-0.66039,-0.16183,0.131309,-0.359464,0.441558,-0.652067,-0.626598,-0.779179,1.14844,-0.123321,-0.209947,0.437566,-0.407045,-0.465845,0.169343,-0.682601,-0.127887,0.336451,0.470833,0.913484,0.305791,0.354788,-0.216449,0.081202,-0.517221,0.567862,-0.128766,-0.638376,0.414126,0.383421,0.663251,0.381735,0.48615,0.363306,0.533212,0.43255,-0.223421,-0.194504,-0.365394,-0.078822,-0.538308,-0.0186664,0.397228,0.2562,0.0554259,-1.01904,0.0735621,0.463338,0.0183817,0.0631969,0.243196,0.0873228,-0.0501349,-0.0130122,-0.260925,-0.264764,0.196814,0.55212,0.503467,-0.0880253,0.0691242,0.408211,-0.142307,0.448421,-0.346869,-0.342116,0.552926,-0.263839,-0.110011,0.122627,0.120471,-0.288833,-0.407528,-0.137586,0.170537,0.202403,0.412961,0.449892,-1.15411 +3410.26,0.993388,0.0848144,4,1.52707,0.7916,-0.972614,0.456654,0.665657,-0.203474,0.021079,0.0796302,0.535872,0.204178,0.0843403,0.14982,-0.518665,0.624977,-0.28751,0.910115,0.125961,-0.0738956,0.427613,0.108838,0.0948559,-0.916795,-0.427564,0.187528,-0.29321,-0.379795,-0.0613936,0.279237,-0.472439,0.0690967,0.987736,-0.402493,-0.119139,0.477082,-0.812961,-0.051167,-0.381691,0.0288713,0.125109,-0.159431,0.974967,0.157255,0.158588,-0.364434,0.175521,0.283236,-0.200187,0.179697,0.362226,-0.134531,0.2601,0.862578,0.00219943,-0.881961,0.180768,-0.114038,-0.354415,-1.04376,0.0796542,-0.0667084,-0.324724,0.882007,-0.61613,-0.515118,0.3442,-0.141852,-0.308558,-0.460735,0.40554,0.201884,-0.500633,0.60663,0.556934,0.0742848,0.395515,0.350566,0.516424,-0.754436,-0.327025,-0.0610632,-0.194179,-0.560532,0.506049,0.35171,-0.29417,0.494887,0.558928,-0.242116,0.0673959,-0.428753,0.0348214,-0.0674838,-0.121802,0.286393,0.145712,-0.338408,0.0833194,0.158679,-0.187801,0.331422,0.114006,-0.212418,-0.816721,-0.243264,-0.455287,-0.108201,-0.485269,-0.215224,0.324666,0.0335915,-0.206217,0.147348,0.208552,0.80776,-0.30419,0.337398,0.0879892,0.316431,0.333942,-0.585568,-0.511427,0.269006,0.452628,0.00649857,0.112572,0.116141,-0.300317,0.628215,0.390052,-0.154755,0.1659,-0.11045,0.569887,0.565961,0.312521,-0.530045,-0.312034,0.141142,0.242358,-0.689649,-0.445882,-0.151209,-0.277824,-0.398601,0.143011,0.385204,0.400699,0.629201,-0.110734,0.0841847,0.0161812,0.254951,0.536492,0.0378783,-0.347039,0.556444,0.317944,-0.040081,0.152458,0.0477216,0.0995725,0.270569,0.250673,-0.778729,-0.0577898,-0.464683,0.0432725,-0.596179,-0.625855,-0.507994,0.149469,-0.201359,0.163803,-0.006621,-0.071431,0.101613,0.0365093,-0.0257935,0.873449,0.760714,0.0671981,-0.197283,0.210147,0.562715,-0.487219,0.506959,-0.257898,0.26899,0.250032,-0.21275,-0.28152,0.402541,-0.695419,-0.717081,0.00763545,-0.393864,-0.70535,0.0442323,-0.131946,0.406969,-0.0785802,-0.230481,0.471179,-0.00407232,-0.413238,0.632629,-0.331368,0.935985,0.103247,-0.246994,0.145222,0.165054,-0.726476,0.0878407,-0.286926,0.642557,-0.28758,0.0312338,0.187488,-0.773878,-0.559718,-0.362878,0.632315,0.44605,-0.546404,0.34417,-0.271716,-0.419309,-0.39931,-0.311043,-0.444489,0.304954,-0.227097,-0.20606,-0.118673,0.567346,0.353112,0.558945,0.438324,-0.18569,-0.669222,-0.162984,0.120711,0.0628719,0.555059,0.230624,0.541295,0.0926772,0.0200152,-0.378365,0.304849,-0.565777,0.950495,-0.467174,-0.0560709,0.271241,-0.274908,0.142408,0.231154,0.484614,0.640505,0.59305,0.381716,-0.150481,0.206452,0.116701,-0.137125,-0.935553,0.373198,0.237755,0.424093,0.165285,-0.112339,0.0973255,0.421542,-0.245622,0.0611276,0.325729,0.289344,-0.0950679,-0.0454117,-0.318826,-0.765092,0.0314814,0.128842,0.329879,-0.117591,-0.369953,0.136906,-0.092244,0.550768,0.509637,0.253661,0.520574,-0.32844,-0.280554,0.0902311,0.384304,-0.396207,-0.251073,-0.511805,0.141195,0.278433,0.375759,0.527668,-1.95346 +3389.18,0.946456,0.0848144,4,1.52714,0.678394,-1.15337,0.428111,0.287071,-0.0995381,-0.337575,0.229955,0.140918,0.0473674,-0.0795047,0.189894,-0.133321,0.936433,-0.892899,0.930273,0.197136,0.0110641,-0.334197,0.165304,0.319025,-0.672819,-1.08776,0.424134,-0.699834,0.034147,-0.00759791,0.235177,-0.918199,0.0454083,0.976563,-0.581921,0.310859,0.261103,-0.240094,0.329092,-0.244655,0.323905,0.435784,-0.211292,0.863844,0.449318,0.281063,-0.327603,0.0804339,0.408163,-0.976437,0.520684,0.442348,0.11604,0.635472,1.12079,0.396129,-0.528761,0.404861,-0.385832,-0.362679,-0.490625,0.640475,-0.739955,0.248008,1.00185,-0.892017,-0.437216,0.0512413,-0.435469,-0.343457,0.37569,-0.738404,-0.515407,-0.14393,0.788117,0.562337,0.371267,0.406033,0.496881,0.758153,-0.376357,-0.126979,-0.29107,0.240347,-0.427911,0.350549,-0.051163,-0.0392904,0.110559,0.239084,0.154557,-0.0562354,-0.0643981,0.652428,-0.21095,0.228111,0.22771,-0.104507,-0.65566,0.00846689,-0.110665,-0.054922,0.247923,-0.00564703,0.000396087,-0.461537,-0.12135,-0.906799,0.333971,-0.118029,-0.502586,0.192955,0.174745,0.0950274,-0.195427,0.42827,0.736503,0.387885,0.319739,-0.365727,0.394359,0.562061,-0.296583,-0.849231,-0.608296,-0.148158,-0.688986,0.149646,-0.0149068,0.0746085,0.158531,0.600074,-0.170117,0.0230032,-0.410825,0.698736,0.164288,0.070947,-0.130201,0.250561,-0.0218814,0.0378462,-0.198245,-0.399472,0.556068,-0.176734,-0.382174,-0.290699,0.223484,0.547529,0.421876,-0.64266,-0.312286,-0.36075,0.355356,0.445194,0.0911744,-0.214126,0.686172,-0.405685,0.242158,0.207613,0.226464,0.157844,-0.0314258,0.065675,0.306074,0.1632,0.0383273,-0.156184,-0.935246,-0.292721,-0.413194,-0.050224,0.067651,0.516571,0.79816,0.80332,0.439266,-0.648092,-0.361965,0.49222,0.529061,-0.160082,-0.336742,0.00711373,0.490802,-0.207233,-0.189359,0.0353804,-0.105402,-0.624595,0.0136268,-0.408516,0.0522743,-0.300339,-0.779095,-0.0931742,-0.0991252,0.335564,-0.382333,-0.606757,-0.232303,-0.113708,0.705636,0.236651,-0.0148309,-0.0658095,0.684737,-0.861167,0.877727,0.577856,-0.0398078,-0.129739,-0.20199,-0.422068,0.254241,-0.678298,0.468691,-0.361878,0.195763,0.458275,-0.655312,-0.589939,-0.188151,-0.296843,0.397417,0.482918,0.491278,0.0193916,-0.180558,-0.391689,0.0737649,-0.245055,0.674682,0.495033,0.29578,0.0076373,0.471719,0.0267483,0.20787,0.225049,-0.406741,-0.952011,-0.384476,0.157919,0.152071,0.27632,-0.313326,0.38601,-0.150831,-0.149717,-0.556531,0.449005,-0.203577,0.573993,-0.508735,0.3446,0.427941,-0.362245,0.0761982,0.225272,0.457551,0.373015,0.265013,-0.270499,0.210503,-0.399009,0.35666,0.170432,-0.534768,0.297269,-0.305856,-0.0287936,-0.469562,-0.158863,0.617893,-0.108032,0.443088,0.169282,0.191855,-0.303804,-0.269907,0.106128,-0.324877,-0.391606,0.0518816,0.469917,-0.170069,0.00823115,0.484075,-0.226337,-0.0541196,0.26271,0.240926,0.170515,0.361368,-0.15642,-0.0957358,0.230778,0.191149,-0.0872667,0.302066,0.103774,0.151282,0.254422,0.38895,0.504403,-0.400364 +3400.6,0.533589,0.0848144,4,1.57813,0.781779,-1.33979,0.602382,0.509282,-0.152057,0.266716,-0.0907097,0.185599,0.238452,0.0567552,-0.0667062,-0.470971,0.806874,-0.00317066,0.489136,0.236037,0.334676,0.252612,-0.129075,0.175934,-0.685518,-0.275771,0.206111,-0.424001,-0.1917,-0.131492,0.0649773,-0.156846,0.0918195,1.10254,-1.11149,-0.136341,0.224132,-0.556991,-0.0336683,0.00512991,0.424784,0.654408,-0.121324,0.717347,0.309933,0.1563,-0.504654,-0.205633,0.00265238,-0.56412,0.241748,0.327124,0.0418373,0.0761337,0.38062,0.101458,-0.319418,-0.181933,-0.360254,-0.943186,-1.46537,0.36666,-0.212276,-0.144146,1.10378,-0.256788,-0.638306,0.367319,0.332889,-0.041767,-0.807997,0.0740175,-0.494381,-0.245167,0.495493,-0.0757114,0.00270902,0.907093,0.309595,-0.613466,-0.00509303,-0.430013,-0.0194796,0.256811,0.150912,0.463518,0.419819,-0.250431,0.140481,-0.0545798,0.0958269,-0.705229,-0.770433,-0.103563,0.273489,0.138061,-0.0225649,-0.17062,-0.434125,0.201026,-0.276044,0.0938914,0.401847,0.630797,-0.218755,-0.73366,-0.37515,0.559105,-0.424303,0.058504,-0.00927388,0.270978,0.35173,-0.201167,-0.676095,0.23716,0.905479,0.0384666,0.540803,-0.303876,-0.272906,-0.0794499,-0.37154,-1.02591,-0.3403,-0.761911,0.414248,-0.242979,0.268301,0.532262,0.275587,0.0198267,-0.574942,-0.169878,-0.164846,-0.00362051,0.749461,-0.424496,-0.384496,-0.3291,0.176686,0.168171,-0.256318,-0.546194,-0.261362,0.599248,-0.73767,0.439678,-0.331472,0.0487276,0.555888,-0.048304,-0.11967,-0.490723,0.0951976,0.100299,-0.732828,-0.0285246,0.492133,0.174789,-0.647932,0.320129,0.303781,0.579303,-0.371996,0.862642,0.139538,0.283955,-0.342712,0.0575477,0.0879081,-0.287366,-0.806375,-0.0155382,-0.310244,0.245224,-0.0981684,-0.233429,0.19474,-0.146513,0.0670423,0.258752,0.599667,-0.0911169,0.14232,0.139441,0.139958,-0.476883,-0.402548,-0.698194,-0.161966,0.552052,-0.552436,-0.209042,0.814105,-0.302179,-0.413492,-0.0608296,-0.00483942,-0.57589,-0.854878,-0.351156,0.341997,0.43801,-0.325196,0.111354,-0.0381469,-0.287744,-0.249395,-0.17746,0.533029,0.416566,-0.159452,0.368757,-0.00801422,-0.11332,-0.372403,-0.307911,0.0590504,0.106091,0.336957,0.307787,-0.540533,-0.287304,-0.362577,0.0368565,0.686473,-1.12984,0.390171,-0.395148,-0.912558,0.213808,0.10814,0.0303033,0.262763,-0.148496,0.183978,0.354067,0.311591,0.0959368,0.358241,0.792205,-0.108712,0.0210377,0.431297,-0.605461,0.187183,0.507175,0.328512,0.455492,0.0513401,-0.453124,-0.713205,-0.515956,-0.928842,0.311591,-0.0308983,-0.164304,0.454292,-0.573357,0.0554708,-0.0955113,0.00106206,0.295947,0.266008,0.133265,-0.309178,0.444921,-0.158141,-0.690064,0.0831747,-0.269537,0.284014,-0.255791,0.0299873,-0.120448,-0.125317,-0.280338,-0.084228,0.00089763,0.228427,0.327625,0.233448,-0.0569788,-0.569613,0.062284,-0.15698,0.0984089,0.242492,-0.433675,-0.524332,0.0641438,-0.103368,0.624767,0.367992,0.874409,0.576508,0.0320508,0.0754247,-0.0663718,-0.620844,-0.399747,-1.11387,-0.0870055,0.153055,0.260454,0.391223,0.510347,-1.32404 +3408.27,0.982721,0.0848144,5,1.59581,0.776968,-1.40762,0.599219,0.401117,-0.13336,0.108138,0.0560211,0.157874,-0.298965,0.0674477,0.0435163,-0.34577,0.753691,-0.371401,0.772696,0.193042,0.115157,-0.0860434,0.234179,0.208279,-0.462862,-0.675374,0.16895,-0.226041,-0.0668104,-0.110205,0.490992,-0.177021,0.247497,1.03694,-0.602275,-0.0858013,0.136684,-0.352982,0.162458,-0.00153097,0.936239,0.466296,-0.123031,0.739958,0.0283299,0.168772,-0.672639,-0.494736,0.174406,-0.686881,0.392051,0.21079,0.0335879,0.115991,0.510116,0.160672,-0.392051,-0.0652415,-0.381564,-0.462288,-1.2613,0.434016,-0.435387,0.285383,0.787306,-0.176462,-0.72483,0.293713,0.128504,-0.457038,-0.337716,-0.253761,-0.436918,-0.396369,0.227259,0.321981,0.235983,1.10662,0.354079,-0.234553,0.0637915,-0.375004,0.114987,0.20833,0.120436,0.0835292,0.708822,-0.477156,-0.0344875,-0.465942,-0.000838015,-0.0119178,-0.669447,0.624514,-0.175959,-0.179456,-0.414745,-0.0885625,-0.13727,0.482532,-0.241065,-0.0120661,0.198626,0.19159,0.04126,-0.525004,-0.369334,-0.245036,-0.720547,-0.810735,-0.0899442,0.408173,0.568443,0.223407,-0.0931514,0.302666,0.656785,-0.070813,0.399702,-0.632995,-0.405762,0.0513099,-0.110353,-1.40385,0.171978,-0.676274,0.4665,-0.296203,-0.210003,0.373926,0.542088,0.481681,-0.502404,-0.496834,-0.124085,-0.222683,0.565914,-0.150097,-0.52465,-0.70731,0.00701954,0.199422,-0.80447,-0.343163,0.409264,-0.18205,-0.767248,0.184882,-0.0678868,-0.169091,0.199499,0.0520967,-0.542501,-0.214596,-0.204676,0.152499,-0.730541,-0.238903,0.637744,-0.102129,-0.340202,0.0931744,-0.00650632,0.448074,-0.17297,0.82652,0.674697,0.1198,-0.453509,-0.109443,-0.24855,-0.0543645,-0.4484,-0.408409,0.0261809,0.198024,-0.253234,0.156708,-0.358105,-0.208733,-0.0533339,0.448269,1.14773,-0.102543,0.0553116,0.182178,-0.298056,0.073293,-0.327255,-0.36148,-0.0381261,0.260848,-0.0520763,-0.511536,0.519766,-0.40359,-0.396179,-0.181029,0.0529289,-0.278518,-0.873265,-0.401238,0.217714,0.311435,-0.464973,-0.833527,-0.0469621,0.00516062,-0.272594,-0.334713,0.862058,0.202172,-0.23124,0.351514,-0.185599,-0.24496,-0.401995,-0.451244,-0.0196716,0.475205,0.286298,0.613067,-0.352937,0.143003,0.00249101,-0.162015,0.799661,-0.623983,0.370831,-0.610971,-0.276763,0.262068,-0.180345,0.407645,0.411813,-0.294869,-0.250251,-0.248287,0.18669,0.0937369,0.213061,0.598541,-0.130167,0.592561,1.00933,-0.277553,0.0863026,0.343328,0.117829,0.589356,0.0401403,-0.128209,-0.480851,-0.532589,-0.807167,0.376304,-0.157518,-0.0909525,0.00523234,-0.847774,0.0255208,0.151597,0.113523,0.172755,0.052685,0.181672,0.172471,0.389434,-0.0356396,-0.549868,0.268905,0.170004,0.287298,0.169648,-0.242161,0.0739502,-0.324447,-0.714445,0.141596,0.0766347,0.337251,0.127936,0.227361,0.368305,0.138109,-0.0967652,-0.000391483,-0.0965581,0.211836,-0.353235,-0.103364,-0.14327,-0.216909,0.659482,0.0584921,0.53524,0.221704,-0.22844,-0.526928,-0.00772329,-0.325171,-0.385908,-0.638563,0.0723664,0.175081,0.140496,0.418427,0.374828,-0.904806 +3411.93,0.923862,0.0848144,4,1.61869,0.853484,-1.23349,0.521214,0.469926,-0.0745337,0.146124,0.119815,-0.0280953,0.31777,-0.208381,-0.151555,-0.131058,0.323445,-0.148838,0.781121,-0.0847513,0.292748,0.315828,-0.0779327,0.0751343,-0.678523,-0.553446,0.134818,-0.252535,0.112792,-0.00384599,0.405031,-0.00696283,0.0124901,0.639561,-0.698566,0.256595,0.224509,-0.471032,-0.0184239,-0.0503405,0.514621,0.702273,-0.475071,0.857118,0.33433,0.213032,-0.748007,-0.266275,0.00733589,-0.575913,-0.181319,0.318273,-0.33864,-0.329981,1.01959,0.0831063,-0.342734,-0.0742988,0.427689,-0.530607,-0.64887,0.407483,-0.259535,0.458994,0.73973,-0.641535,-0.666767,-0.367153,0.102484,-0.742097,-0.516464,-0.104734,-0.391881,-0.281643,0.0532491,0.49784,0.357845,0.548386,0.676291,-0.371656,-0.338128,-0.862453,-0.278537,0.494866,-0.296219,0.342034,-0.136211,-0.375195,-0.51094,-0.535939,0.188014,-0.0136039,-0.241629,-0.00955973,-0.172628,-0.422936,-0.196922,-0.30612,-0.193728,0.338344,-0.657176,-0.000103626,0.257332,0.124412,0.0768655,-0.572797,-0.293345,-0.579083,-0.446513,-0.644181,-0.292012,0.240014,0.572139,-0.185199,-0.0934878,0.00626004,0.595489,-0.235141,0.279555,-0.50916,-0.369232,0.100476,-0.0511287,-1.11355,0.179319,-0.40673,0.0812255,-0.486273,-0.271189,1.03525,-0.0299076,0.135209,-0.385128,-0.225555,-0.011884,-0.420342,0.275568,0.220625,-0.270821,-0.659391,0.182992,0.347352,-0.743184,0.249353,-0.142753,-0.016094,-0.414373,0.831876,-0.0675063,-0.0864542,0.20741,-0.0521614,0.310009,-0.278683,0.163555,0.404101,-0.533197,0.110235,0.65984,0.244197,-0.014583,0.147996,0.302299,0.838156,-0.133698,0.502225,0.798151,-0.0596965,-0.48064,0.146932,-0.375453,0.0821092,0.000355831,-0.251747,0.114253,0.506548,-0.0345638,0.3392,0.0987676,-0.327985,-0.558019,0.775195,0.902244,0.390477,-0.1652,-0.127233,-0.238445,-0.0866773,-0.00380675,-0.285423,0.265499,0.00184749,-0.0694409,-0.0150759,0.0973136,-0.175126,-0.511735,-0.162487,-0.256869,0.19422,-0.494341,-0.141168,-0.324933,0.110423,-0.113032,-0.805119,-0.0574572,-0.0307932,-0.425492,-0.225634,0.867466,0.145322,-0.18996,0.0393124,-0.472373,-0.0864703,-0.204532,0.0565596,-0.217056,0.029543,0.225395,1.05484,-0.877001,-0.031527,0.0800985,-0.622598,0.0754925,-0.388192,0.565068,0.260118,-0.363427,0.101477,0.0340391,-0.150885,0.509556,0.397193,-0.482716,-0.134217,0.342783,0.116876,0.347045,0.47826,-0.64779,0.360315,0.607017,-0.403046,-0.176475,-0.0710689,0.263499,0.521443,-0.338143,-0.429255,-0.295524,-0.401704,-1.11096,0.294461,-0.366504,0.0398585,0.351828,-0.555303,-0.0866967,0.443959,0.132703,-0.0714801,0.0709096,-0.0301603,0.0581722,0.721765,-0.106636,0.261546,0.112527,-0.129656,0.0487083,0.0131419,-0.104001,-0.0367132,0.0112657,-0.64417,-0.113516,0.157578,0.30838,0.396477,-0.0860538,0.306023,0.472662,0.0267794,0.0401258,-0.194812,0.278198,-0.72084,0.589197,0.356647,-0.334588,0.380995,-0.17479,0.114517,0.0629395,-0.25845,-0.705715,0.402963,-0.289771,-0.393199,-0.0343429,0.446493,0.134065,0.162592,0.366149,0.403227,-1.27785 +3394.44,0.957894,0.0848144,5,1.56983,0.68495,-1.33572,0.607244,0.441842,-0.153027,0.0148542,-0.28807,0.00770873,-0.28768,-0.00965938,-0.396067,-0.0248049,0.314389,-0.00895753,0.549042,0.00846145,0.317431,-0.254117,0.330207,0.242598,-1.00336,-1.01825,0.684138,-0.0982642,-0.162068,-0.0401696,0.319556,-0.894689,0.33577,0.785883,-0.182972,-0.094828,0.593341,-0.229471,-0.0612638,-0.269806,0.311291,0.413199,-0.473841,0.77639,0.206918,-0.0591654,-0.3524,-0.382267,-0.658859,-0.256549,0.486976,0.475902,0.0925246,0.274269,-0.192303,0.0841358,0.0311689,-0.0403251,-0.793623,0.0996616,-0.941075,0.428233,-0.0455632,-0.185023,1.09592,-1.06383,-0.215307,0.351842,0.0582453,-0.234375,0.101653,0.237923,-0.451082,-0.178356,-0.040769,1.04819,-0.373154,0.449446,0.785159,0.329582,0.165036,-0.151667,-0.237376,0.558068,-0.520046,0.0117486,-0.581647,-0.304775,0.234778,-0.187419,0.386316,0.119492,-0.171624,-0.041873,-0.315875,0.0775355,-0.502036,0.197781,-0.338262,0.288492,-1.11451,0.503273,0.51917,-0.0383007,-0.31925,-0.376806,0.225074,-0.00330354,-0.143677,0.663819,-0.276863,0.0370906,0.540381,-0.272143,-0.123191,0.0326996,0.958066,-0.390338,0.172824,0.246929,0.240886,0.234039,0.500982,-0.599959,1.20927,-0.365796,-0.0248773,-0.0104478,0.560677,-0.193888,-0.183496,0.54176,0.0672425,-0.0379893,0.230963,-0.1648,0.508132,0.110977,-0.549727,-0.202121,-0.221341,0.055884,0.563254,-0.0821403,-0.0777571,-0.0514386,-1.29334,-0.667424,-0.0230201,-0.192976,0.186655,-0.122617,-1.09562,-0.607657,-0.0848227,-0.457145,0.0806294,0.142298,-0.174881,-0.0183886,-0.595792,0.0649922,-0.0657064,0.238667,-0.203281,0.793987,-0.253381,-0.126425,0.776153,0.0206772,0.151989,0.0413439,0.290972,0.352362,-0.27384,0.235276,-0.00771318,-0.585201,-0.35027,-0.420089,-0.34456,-0.48624,0.642727,0.00110512,-0.97596,0.373273,-0.0177993,0.244659,0.151052,0.162668,-0.328024,0.573582,-0.250296,0.0407563,0.160141,-0.016182,-0.372658,-0.541714,0.0831337,-0.331269,-0.166537,-0.888381,0.305167,-0.272953,-0.471433,0.732794,-0.0584762,-0.141761,0.521385,-0.832916,1.10894,-0.00886715,0.177316,-0.00831968,0.0574253,0.0922201,0.0700746,-0.362584,0.390077,0.0816624,0.366417,-0.0258441,-0.421897,-0.428404,-0.691953,0.0898512,0.523589,0.221149,0.158533,-0.606296,0.156599,-0.476634,-0.105757,-0.482382,0.431165,-0.594478,-0.762844,0.171584,0.356695,-0.157233,-1.09164,0.237575,-0.666022,-0.934818,0.11274,0.387559,0.475494,0.580873,-0.00254517,0.864914,0.438827,-0.116742,-0.060482,0.0889075,-0.298147,0.769981,-0.358671,0.0591609,-0.0134312,-0.382869,-0.195601,0.34139,0.0397228,0.304676,0.626932,0.0182564,-0.355257,-0.204429,0.0676472,-0.123046,-0.609635,0.198897,-0.0542747,-0.0345615,-0.486937,-1.24603,0.336454,0.230452,0.194834,0.246652,0.155714,0.708032,-0.220952,0.0947359,-0.237023,-0.849537,-0.145694,-0.320612,0.24072,-0.0901307,-0.103779,-0.352058,0.0631153,0.522441,0.367226,-0.0346648,0.393167,0.027848,-0.620667,-0.0885375,-0.0365724,0.566908,-0.306022,-0.314331,0.165159,0.208144,0.406398,0.456228,-0.943774 +3388.7,0.943439,0.0848144,4,1.62591,0.479341,-1.28644,0.632365,0.399368,-0.17845,-0.812561,-0.0417481,-0.0526973,-0.14198,-0.110466,-0.587318,-0.0224041,0.583859,-0.0937557,0.234256,0.335573,0.404305,-0.0578484,0.189791,0.492017,-0.69063,-0.70639,0.432017,-0.663402,0.168536,0.0886843,0.250222,-0.430908,0.310896,1.23794,-0.0983101,-0.291279,0.518986,-0.230997,-0.0731705,-0.594562,0.489279,0.511145,-0.653695,0.825838,0.368227,0.662997,-0.441751,-0.342989,0.213032,-0.256016,-0.633156,0.506422,0.217484,-0.019846,0.329352,0.253806,-0.310028,0.397089,-0.48956,-0.0566895,-0.961477,0.193088,-0.0202681,0.362753,0.833384,-0.945489,-0.556695,-0.0185154,0.195669,-0.554854,-0.574504,0.494962,-0.849254,-0.361623,-0.126154,0.463604,-0.293543,0.696876,0.517246,-0.253656,-0.0325044,-0.236111,-0.304475,0.78833,-0.21664,0.652902,-0.195841,-0.401763,0.424292,-0.30553,-0.462035,-0.191739,-0.354991,-0.602252,0.199795,-0.242768,0.134215,-0.183463,-0.245432,0.687048,-0.498496,0.509075,0.214329,-0.699843,-0.241973,-0.428162,0.181801,-0.0131992,-0.186534,0.752856,-0.192543,-0.119865,0.409009,0.0988732,0.197503,-0.289917,0.497086,0.141658,0.413143,0.238825,0.111515,-0.412039,-0.0425748,-1.32447,0.766534,-0.128871,0.180531,-0.23167,0.368454,0.389807,0.0290112,0.58208,-0.0728728,0.257422,-0.0117076,-0.275233,0.965971,-0.0164413,-0.48609,-0.355444,0.105379,0.447797,0.0917356,0.0549064,0.233046,0.392199,-0.887619,0.0984185,-0.0748758,0.0638439,0.2569,-0.0157819,-1.01913,-0.869538,-0.234817,-0.325269,-0.12762,0.130634,0.20361,-0.152098,-0.274083,0.128619,0.263723,0.0962677,-0.439396,0.964716,-0.311431,-0.206855,0.0866731,-0.405698,-0.373165,-0.261457,0.258181,0.188965,-0.0581809,0.23724,-0.140827,-0.848986,-0.243096,-0.168266,-0.413962,0.261038,0.852084,-0.0619479,0.326727,0.262646,0.0412848,-0.201581,-0.56145,-0.164637,-0.125636,0.314391,-0.492331,0.208098,0.0301866,0.00790454,-0.265073,-0.116373,0.233214,0.217681,-0.562422,-0.321952,0.460778,0.162728,-0.567729,0.151426,0.192762,-0.481049,-0.34813,-0.456164,0.831492,0.0237521,0.131177,-0.0722714,0.0790041,0.164504,-0.550242,-0.442813,0.0766148,0.197996,0.287569,1.073,-0.603483,-0.345238,-0.598163,0.42978,-0.309991,0.279974,0.69666,-0.0250388,-0.713651,-0.588018,-0.0643368,0.136355,0.296421,0.576279,-0.453914,-0.475295,0.554458,-0.384092,-0.045653,0.344636,-0.597185,-0.732071,0.576994,0.496847,-0.412974,0.761058,-0.104096,1.08565,0.889392,-0.65534,0.276813,0.326533,-0.542783,0.609321,0.0277563,-0.210289,0.295402,-0.825318,-0.731951,-0.532241,0.427753,0.267474,-0.137086,-0.227446,-0.0273521,0.156472,-0.339601,0.202008,-0.0924345,0.571908,-0.169531,-0.192489,-0.211749,-0.872555,-0.105444,-0.135129,0.26889,0.329528,-0.062817,0.629812,-0.133242,-0.288655,-0.402423,-0.293278,-0.201345,-0.0727991,0.107012,-0.494026,-0.166813,-0.394113,0.128622,0.410424,1.07066,-0.00445747,0.15298,-0.0121553,-0.84964,0.0725536,-0.00793156,0.460968,0.406207,0.26146,0.216062,0.251544,0.464825,0.501542,-0.426539 +3386.47,0.99045,0.0848144,4,1.6187,0.498809,-1.61872,0.700412,0.372447,-0.158577,-0.587343,-0.256783,0.136033,0.0116122,-0.0426854,-0.767108,-0.199231,0.48835,-0.0866978,0.175251,0.261442,0.331134,-0.0951986,0.036993,0.384949,-0.965719,-0.662544,0.578762,-0.421529,0.319161,0.0367772,0.0483527,-0.431816,0.442103,0.995678,-0.0047995,-0.410132,0.683481,-0.326262,-0.16235,-0.313658,0.115827,0.468892,-0.61495,0.842674,0.453191,0.570118,-0.333617,-0.500476,0.458712,-0.262807,-0.656369,0.341985,0.15817,0.25978,0.399725,0.217075,-0.144644,0.446046,-0.622635,-0.0970919,-1.04683,0.267437,0.0155938,0.405916,0.869414,-1.01349,-0.477639,-0.062378,0.0835254,-0.707042,-0.606511,0.477613,-0.656119,-0.375464,-0.00549659,0.691996,-0.152668,0.857065,0.624737,-0.160548,-0.336296,-0.362903,-0.204824,0.813802,-0.307585,0.619167,-0.343019,-0.142981,0.403244,-0.479625,-0.522469,-0.377597,-0.395394,-0.475678,0.465757,-0.218115,0.172508,0.00394729,-0.195348,0.617341,-0.420434,0.387869,0.189911,-0.805563,-0.204492,-0.51765,0.173844,0.34816,-0.389604,0.664251,-0.400744,-0.281854,0.476622,0.399512,0.271122,-0.391812,0.523799,0.0442481,0.270229,0.295386,0.00360733,-0.321431,-0.0398438,-1.18873,0.874921,-0.0516728,0.0673699,-0.31805,0.295655,0.470751,-0.012486,0.690971,-0.0599157,0.361994,0.193112,-0.381025,1.02229,-0.0667487,-0.483634,-0.0458771,-0.00226042,0.57941,0.148024,0.0302367,0.143065,0.365022,-1.00868,0.0619723,-0.0786547,0.0827585,0.430003,-0.0612928,-0.988242,-0.78499,-0.309881,-0.237933,-0.0206384,0.271305,0.167656,-0.0615975,-0.420293,0.104335,0.300741,0.110961,-0.473392,1.07795,-0.159595,-0.244158,0.276005,-0.280851,-0.249184,-0.21311,0.211274,0.0714919,-0.289291,0.03799,-0.154379,-0.748466,-0.26842,-0.211578,-0.635335,0.358953,0.919648,0.00543632,0.214323,0.135102,0.214729,-0.261448,-0.521635,0.0760068,0.211955,0.512002,-0.696972,0.147361,-0.0746154,-0.15996,-0.245628,-0.075551,0.247384,0.213853,-0.318196,-0.168745,0.382655,0.218293,-0.72023,0.15637,0.390296,-0.527671,-0.230879,-0.385298,0.783668,0.0311829,-0.154207,-0.192578,-0.135477,0.217669,-0.41971,-0.541524,-0.153159,0.184508,0.252731,0.867458,-0.482142,-0.270692,-0.656247,0.251662,-0.351591,0.0603662,0.721773,-0.215573,-0.792088,-0.661635,0.086486,0.143777,0.38269,0.703496,-0.348634,-0.562846,0.374213,-0.398333,-0.226602,0.426627,-0.605273,-0.480668,0.337431,0.394682,-0.596664,0.669375,-0.344503,0.818115,1.13681,-0.572117,0.13717,0.0577574,-0.522221,0.654368,0.175629,-0.336795,0.46335,-0.900663,-0.526453,-0.61765,0.296174,0.361524,0.0330194,-0.373071,0.111624,0.339653,-0.49866,0.215193,0.00654377,0.859052,-0.14038,-0.0603804,-0.059666,-0.599377,-0.339746,-0.238773,0.424246,0.309643,-0.156079,0.339289,-0.082428,-0.539614,-0.596494,-0.429965,-0.360054,-0.173985,0.23288,-0.44808,0.23119,-0.366095,0.0580612,0.28344,1.3145,0.112643,0.200523,-0.187169,-0.920601,0.267629,0.128819,0.159723,0.267111,0.208349,0.209742,0.251882,0.457976,0.501878,-0.273706 +3410.64,0.386911,0.0848144,5,1.50717,0.861209,-0.748007,0.308979,0.279469,-0.102445,0.461047,0.402652,0.394274,0.576986,0.29574,0.39492,0.066265,0.32467,-0.123927,0.962165,0.670285,0.175336,-0.135336,0.314272,-0.257929,-0.329321,-0.481099,0.216115,0.0463763,-0.943702,-0.0902277,-0.560643,-0.1677,0.120634,0.815383,-0.721103,0.32583,0.250994,-0.316123,-0.26939,-0.445168,0.978736,0.442318,0.00532034,0.808412,0.803675,-0.0762252,-0.375853,0.116058,-0.439608,-0.628352,-0.0519889,0.340034,-0.0583289,0.00572723,0.142501,0.0835795,-0.708327,0.786707,0.189119,-0.233656,-0.372818,0.0864431,-0.758607,-0.0397754,0.963485,-0.26485,-0.667872,-0.179688,0.226474,0.223608,0.291545,-0.208201,-0.0778584,0.300368,0.544687,0.862434,-0.104261,0.515867,0.181065,0.553529,0.450508,-0.306573,-0.00994549,0.0725431,-0.432029,0.230316,-0.232491,-0.182251,-0.647554,0.171878,-0.10959,0.354658,-0.155618,0.589849,-0.0246314,0.092582,-0.186623,0.25683,-0.242838,-0.571927,-0.319615,-0.202242,0.504454,0.611697,0.210157,-0.774472,-0.82835,-0.0857736,-0.498393,-0.279709,0.107242,0.641001,0.49141,-0.362334,-0.820561,0.644075,0.367331,0.0981979,-0.133717,-0.685952,0.123979,0.328765,-0.0109455,-0.466788,-0.905042,-0.386352,-0.531156,-0.0874431,-0.102868,-0.195579,0.269967,-0.00836057,-0.603246,-0.136834,0.296272,0.189134,0.183647,-0.461091,-0.0725614,0.196706,-0.476096,0.313975,-1.22497,-0.758147,-0.0350383,-0.268415,0.168664,0.055296,0.0566786,-0.246542,0.108597,-0.25303,0.636528,0.114183,0.175074,0.501819,0.132795,0.200198,0.222443,0.0972061,0.308203,0.0332716,-0.316633,0.394263,-0.10384,0.167892,-0.0201372,-0.0946869,-0.0523422,0.385134,-0.10308,-0.158772,-0.44783,0.107906,0.433674,-0.0494326,-0.00346427,0.50739,0.120753,-0.179066,0.0652691,-0.001393,0.496318,0.20746,-0.437229,0.271622,-0.26493,0.0194144,-0.0745284,-0.54429,-0.577442,0.104031,-0.246401,0.337995,-0.05837,0.219886,-0.942516,-0.0056407,0.298706,-0.203874,-0.319823,-0.956864,-0.370838,0.0245587,0.0596666,0.18938,-0.566677,0.367883,0.00664308,-0.679626,1.19884,0.0602498,0.66484,-0.024598,-0.105373,0.249888,0.327628,-0.627526,0.421525,-0.701544,0.132807,-0.376063,-0.366423,-0.358641,-0.370651,-0.346405,0.478584,-0.927865,0.188292,-0.570339,0.245006,0.670193,-0.249224,-0.253106,0.0793007,-0.891781,-0.0490597,-0.0318522,0.728419,0.00407954,0.370505,0.408089,-0.323509,-0.155471,-0.0258954,-0.303682,0.173107,0.0143421,0.665615,0.388237,-0.394029,0.27918,-0.226222,-0.129892,-0.526452,0.160671,-0.714831,-0.299351,-0.0832345,0.135534,0.43091,0.314658,0.475363,-0.0436923,0.642306,0.478532,0.137107,0.0653523,0.647873,0.268575,-0.193409,-0.553315,0.0129601,-0.103672,-0.15509,-0.175323,0.180166,0.104093,-0.460281,0.169385,0.23282,0.240619,-0.298957,0.180259,0.200226,-0.210076,0.322083,0.638045,-0.000153083,0.315363,0.228677,0.463072,-0.88217,-0.0451795,-0.931969,0.0873637,0.32316,0.175136,-0.211038,-0.00810419,-0.206615,-0.265133,-0.592747,-0.30429,0.134987,0.255263,0.367406,0.505236,-0.817581 +3423.24,0.8988,0.0848144,4,1.57291,0.888732,-0.801771,0.29899,0.208788,-0.20373,0.333158,0.0787528,0.44447,0.377815,0.165015,-0.028543,0.114631,0.21647,-0.0538372,0.783683,0.446641,0.27541,0.0390063,0.434243,-0.305722,-0.645086,-0.83043,0.00498852,-0.0333896,-0.737406,0.00918897,0.147124,-0.298854,-0.0831064,0.70657,-0.496151,-0.395536,0.324951,-0.346244,-0.207425,-0.564436,0.796582,0.29221,-0.46506,0.966893,0.763891,-0.405982,-0.517074,0.241124,-0.179547,-0.092231,0.245611,0.0477741,0.126344,0.0261041,0.272608,0.295844,0.0961263,0.575404,0.131695,-0.536336,-0.635548,0.491077,-0.00223511,-0.556478,1.0512,-0.647473,-0.156813,0.416916,0.125661,0.349982,-0.0112479,-0.281124,-0.144374,-0.239683,0.210448,0.643474,0.292184,0.416138,0.119137,0.0037391,-0.129732,-0.252788,0.0858314,-0.211446,-0.193177,0.436785,-0.600342,-0.340874,-0.080045,0.326079,-0.000685815,0.120858,-0.509709,0.29437,-0.405727,-0.109011,-0.163043,-0.0769994,-0.366571,-0.289375,0.0936542,0.145645,0.508715,-0.131059,0.213671,-0.314844,-0.149085,0.100718,-0.721758,0.426128,-0.198231,0.380934,0.589676,-0.766345,-0.269818,0.202633,0.415205,-0.0737501,0.43018,-0.506525,-0.0471364,-0.111498,0.525583,-0.56849,-0.26341,-0.292437,-0.276207,0.000451251,0.481952,0.182458,0.419057,-0.188005,-0.660893,-0.0956186,0.623453,0.0204131,0.263161,-0.102386,-0.191748,0.365684,-0.649794,0.708849,-0.78112,-0.537745,0.0351729,-0.129965,-0.147857,-0.357665,0.0121477,-0.3581,0.0562906,0.104039,0.310489,0.324273,0.258418,-0.160777,0.389115,-0.0238384,0.382349,0.138427,0.109398,0.219907,0.365763,0.617014,-0.026852,0.55957,0.0553589,0.0190383,0.26764,0.215259,-0.498964,-0.304543,0.312599,0.0946441,0.119778,-0.0243811,-0.276738,0.0615426,-0.289676,-0.644625,0.24329,0.272102,0.321528,-0.172673,-0.144459,0.364008,0.107511,-0.117434,-0.0890156,-0.49007,-0.519234,0.216231,-0.949258,0.0360408,0.125169,0.0260451,-0.708112,-0.123076,-0.0154497,-0.31772,-0.21914,-0.873909,-0.55476,0.291402,0.240452,0.4279,-0.366104,0.165901,-0.25187,-0.595025,0.910665,0.00506379,0.146647,-0.509743,-0.0677061,0.268276,0.515013,-0.430112,0.488662,-0.911337,-0.0181149,-0.000324334,-0.0792475,-0.32563,-0.721851,-0.236429,0.0824521,-0.325533,0.376277,-0.84932,-0.335003,-0.0528617,-0.419004,0.180575,-0.053126,-0.891634,0.183081,-0.308815,0.543988,0.104738,0.764903,0.232875,0.536215,-1.04118,-0.320043,-0.390251,0.416742,0.174377,0.442588,0.157631,-0.448029,1.00269,-0.2328,-0.328147,-0.699024,-0.0419892,-0.149457,-0.41576,0.201001,0.0678291,-0.0172884,0.467992,0.264513,-0.0893477,0.332651,-0.257095,-0.0969868,0.00689647,0.45389,-0.112156,-0.642395,-0.0653914,0.279212,-0.198099,0.188428,0.514575,0.247168,-0.297658,-0.270821,0.0824822,-0.434135,-0.0634736,0.00442929,-0.230207,0.0970477,-0.407181,0.135562,0.588705,0.243982,-0.134381,0.168809,0.327011,-0.609616,0.139031,-0.280678,0.457284,0.203689,0.0800214,-0.426358,0.327832,-0.31354,-0.797426,-0.523394,-0.0476348,0.157703,0.238469,0.397119,0.488333,-0.502813 +3433.68,0.784946,0.0848144,4,1.53348,0.919179,-0.685762,0.200008,-0.0445242,-0.0807499,0.194778,-0.0182191,0.374374,0.147601,0.0057439,0.236068,-0.121713,0.621298,0.110287,1.06009,0.0735552,0.134377,-0.178051,-0.0514315,-0.340475,-0.667689,-0.348435,0.0570874,-0.462577,-0.552265,-0.0160279,0.348117,-0.230479,0.180957,0.659847,-0.550207,-0.102766,-0.122433,-0.340397,-0.508092,-0.295784,0.184055,0.409412,-0.278191,1.06754,0.628687,-0.00796908,-0.532371,-0.543103,0.201761,-0.140573,-0.16265,0.536879,0.194563,0.201496,0.321394,0.121869,-0.70712,0.481603,0.222246,-0.393972,-0.290814,0.0943201,-0.117028,-0.293216,1.08334,-0.0584292,-0.34751,0.187687,0.0300179,0.293738,0.107153,-0.50931,-0.782107,-0.830952,-0.349963,0.671496,-0.195276,0.630149,0.508313,0.287414,-0.244244,-0.275667,0.292397,0.875656,-0.129143,0.218851,0.170647,-0.192863,0.164341,-0.137451,-0.0832541,0.108761,-0.612417,0.842113,-0.139128,0.275855,0.440784,-0.490532,-0.273535,0.151235,-0.644435,0.16775,0.211029,-0.490149,0.36212,-1.01866,-0.0977625,0.209921,-0.546872,0.218519,-0.0786541,0.0930111,0.702559,-0.304285,-0.290504,-0.17483,0.542224,-0.259268,0.107468,-0.124727,0.386358,0.309319,0.404191,-1.26972,-0.266554,-0.281413,-0.580445,-0.347186,0.00340752,0.191015,0.429131,0.0708756,-0.391967,0.0406253,-0.0507267,0.044296,0.188493,0.182657,-0.39237,-0.154822,-0.296065,0.364402,-0.764656,-0.251298,0.337619,0.41401,-0.347074,0.226517,0.327773,0.431899,0.655278,-0.251855,0.509884,0.171421,0.250465,0.117893,0.727065,0.202228,-0.184252,0.20649,0.119306,-0.0581589,-0.187657,0.0903493,-0.243792,0.748737,0.400418,-0.66586,0.364511,0.203531,-0.466407,0.33173,0.504499,0.215958,0.188535,0.224129,0.12003,0.488834,0.0661027,-0.0604352,-0.249302,0.911188,0.878904,0.030738,-0.450298,0.268154,-0.281449,0.144212,-0.393341,-0.0605838,-0.38269,0.0308555,-0.371283,0.135615,-0.252868,0.0229561,-0.220799,-0.337289,0.0337884,-0.307772,-0.0893118,-0.467906,0.245547,0.141237,0.0559309,0.578462,0.281656,-0.0914868,0.328894,-0.362052,0.997808,0.309923,0.364675,0.449668,-0.0986595,0.55394,0.0089113,-0.386418,-0.0898704,0.00190056,-0.151356,0.357244,-0.405189,0.500056,-0.302131,-0.471409,-0.54862,0.411263,0.374108,-0.613953,-0.0629531,0.140833,-0.151552,0.0726048,0.328891,-0.364553,-0.346197,-0.340525,0.571299,-0.36143,0.0333792,0.289736,-0.482405,-0.45893,0.231272,-0.086571,0.544804,0.0752095,0.230189,0.475998,0.198337,0.409826,-0.510748,-0.139871,-0.707176,0.536301,-0.639961,-0.986721,0.619594,-0.266393,0.272361,0.092576,0.324605,0.428422,1.17978,0.229979,0.0521189,0.235071,0.0204883,0.266896,0.524852,0.364062,-0.0281796,-0.333381,0.140914,-0.474056,0.406332,0.0737552,-0.0305059,0.125752,0.14878,-0.145225,-0.109116,0.205699,-0.318703,-0.730697,0.0258859,0.337397,0.0653157,0.127166,-0.172708,0.0607691,-0.109399,0.165454,0.0916156,0.357508,0.35435,-0.149548,-0.54489,0.0634128,-0.567311,-0.378505,-0.4942,-0.0989677,0.16415,0.159067,0.405155,0.398832,0.247046 +3433.43,0.993707,0.0848144,4,1.59006,0.901684,-0.553437,0.203409,0.16101,-0.105265,-0.0109112,0.00515236,0.216553,0.383098,-0.0901406,0.251427,-0.234514,0.0381459,0.406019,0.639792,0.142877,0.11194,0.102514,0.0988014,-0.294563,-0.897064,-0.0959928,-0.0459405,-0.418882,-0.563729,-0.098943,0.0948139,-0.606017,-0.0220982,0.698306,-0.889143,-0.154322,-0.0388859,-0.139147,-0.613195,-0.952163,0.62137,0.0855296,-0.398748,0.855322,0.232192,0.220866,-0.700602,-0.109301,-0.335274,-0.163133,0.32815,0.123871,-0.161687,-0.111206,0.190737,0.0399692,-0.741643,0.552197,-0.343816,-0.484421,-0.609644,0.388085,-0.266076,-0.210494,0.8088,-0.823695,-0.795529,-0.211624,0.418569,0.582774,0.453564,0.319673,-0.562509,-0.350068,0.107127,0.852642,-0.471562,0.651355,0.530016,0.0161841,-0.172095,-0.144682,0.174691,0.490635,-0.703013,0.348504,0.119585,-0.21736,0.204286,0.17348,-0.310218,-0.0987644,-0.248523,0.635009,-0.313579,0.6046,-0.151775,-0.143878,0.155398,0.372346,-0.647245,-0.160359,0.510467,0.513113,0.337577,-0.60837,0.246107,0.28879,-0.8765,0.273033,-0.242987,0.410837,0.254238,-0.884762,0.100156,0.112148,0.61449,0.310001,0.385304,-0.394767,-0.12358,0.212909,0.65415,-0.524684,0.213994,-0.143896,0.226339,-0.0478868,0.522301,-0.184266,-0.306846,0.281878,-0.769567,-0.124787,0.586824,0.232275,0.303378,-0.130638,0.00560944,0.130044,-0.21539,0.477208,-0.476535,-0.207424,0.371634,-0.123053,-0.3492,0.281433,0.250137,0.135368,0.134743,-0.00329806,0.140368,0.0369966,0.423886,0.0688004,0.649183,0.337142,0.142622,0.200474,0.218589,0.0361519,0.0865846,0.315533,0.185399,0.754441,0.281945,0.143964,0.396133,0.345981,0.0491583,-0.235547,-0.0187572,-0.0712624,-0.337454,0.123741,-0.216497,-0.391878,0.476879,-0.0770702,-0.823766,0.479034,0.511958,0.148574,-0.768123,-0.146537,0.0354354,-0.0398944,-0.63762,-0.404138,-0.305141,-0.0693928,-0.022396,0.367744,-0.651028,-0.100341,-0.523386,-0.190963,0.341705,0.484825,-0.12655,-0.803075,0.335,0.167583,-0.349527,0.542958,-0.21578,0.601283,0.296985,-0.0749479,1.08689,0.387716,0.320796,0.0388369,-0.561488,0.0183067,0.502236,-0.450012,0.110002,0.020895,-0.0426972,0.0852046,0.132826,0.0886294,-0.0157176,0.377069,0.409253,-0.0114014,0.561069,0.276504,-0.243142,-0.189173,0.399723,-0.0158715,0.131132,-0.135224,0.373907,-0.872333,0.495401,0.1833,0.472432,0.274799,0.315763,0.0439786,0.212697,0.154569,0.629518,0.200062,0.375807,0.575529,-0.316019,0.386644,0.0169869,0.0151619,-0.498277,0.540787,-0.354949,-0.475829,0.310582,-0.130643,-0.0555552,-0.119955,0.530005,0.599432,0.488588,0.107015,-0.0440587,0.469224,0.145091,0.0622028,0.388861,-0.196864,0.389692,-0.427423,-0.108182,-0.305707,0.314356,0.23001,-0.441663,-0.144349,0.758686,-0.112214,-0.115354,0.125914,-0.46137,-0.0663945,-0.148343,-0.0804447,0.144357,-0.132838,0.0778289,0.236252,-0.638983,0.0990752,0.454212,0.332698,0.0599108,0.293701,0.0682519,0.169315,-0.294083,-0.357845,-0.387138,0.29751,0.13492,0.185981,0.367315,0.431255,-0.4144 +3412.5,0.827845,0.0848144,4,1.57901,0.967126,-0.664191,0.165579,0.24682,-0.0343202,-0.286763,-0.0534151,0.483945,-0.114705,0.20097,0.238079,-0.313616,0.146716,0.198049,0.868845,0.00593303,-0.0582078,-0.442625,-0.333342,-0.678624,-0.56581,-0.409728,-0.228442,-0.289106,-0.158622,0.0141307,0.174006,-0.339765,0.109348,0.56873,-0.502972,-0.407128,-0.0139444,-0.0871579,-0.180465,-0.19386,0.501832,0.229942,0.0438862,0.933638,0.164903,0.0577248,-0.581309,-0.297939,-0.194805,-0.206755,-0.0322873,0.599082,-0.137555,0.288043,0.149008,-0.0334639,-0.381999,0.675282,-0.496112,-0.556198,-0.221885,0.242362,0.0698223,-0.0250746,1.04268,-0.965423,-0.809383,-0.118376,0.821689,0.246813,0.476095,0.571063,-0.269537,-0.102422,0.336165,0.736084,-0.162199,0.725633,0.641094,0.248825,0.00671832,-0.127719,0.0865585,0.607498,-0.814212,0.47262,-0.224232,0.0651319,0.00789998,0.254326,-0.324618,-0.242959,-0.129474,0.752831,-0.210627,0.301487,-0.248446,0.183244,0.22754,0.437138,-0.700811,0.0306133,0.189065,0.420869,0.797758,-0.529864,-0.449412,0.0879802,-0.773883,-0.0706126,0.0434303,0.394054,0.466312,-0.305563,-0.424766,0.222322,0.476213,0.286377,0.333522,-0.0435189,0.133764,0.220191,0.141248,-0.378447,-0.143948,-0.158213,-0.213743,0.748187,0.215321,-0.320085,0.18491,0.0543002,-0.518695,-0.464748,0.31677,-0.0202875,0.394594,-0.228502,-0.283521,0.149725,-0.258593,0.426585,-0.419207,-0.436401,0.328955,-0.225329,-0.571298,0.244573,0.435467,0.205429,0.557729,-0.434226,-0.298064,-0.25161,0.207696,0.112862,0.437881,0.310635,0.117852,0.338834,-0.276319,-0.0479453,0.142625,0.3467,0.16413,0.693448,0.361596,-0.0949641,0.528143,0.288325,0.415306,-0.331206,0.0295294,0.0530216,-0.290953,-0.0289655,-0.369811,-0.550499,0.445862,-0.130316,-0.566408,0.38083,0.904067,0.342524,-0.608839,0.220708,-0.0587989,-0.136386,-0.833092,-0.605123,-0.2515,-0.48935,-0.3671,0.512091,-0.468084,-0.157614,-0.424162,-0.249081,-0.0538758,0.369546,-0.233634,-0.833538,0.785736,-0.0816945,0.228777,1.02009,-0.259048,0.312817,0.177985,-0.369764,1.05854,0.559536,0.612445,-0.107648,-0.435083,0.0629439,0.605733,-0.594262,-0.201886,-0.284949,0.538673,-0.295692,0.21876,0.023169,0.0565666,0.452112,-0.178426,-0.57691,0.566027,-0.0939557,0.0849123,0.265426,0.717442,0.0594993,0.0818255,-0.265615,0.700442,-0.888756,0.416414,0.0604839,0.212845,0.334638,-0.0175114,-0.563829,0.0716958,-0.0687453,0.377482,0.45898,0.46035,0.337287,-0.238448,0.158556,-0.26558,0.171568,-0.165995,0.383747,-0.573731,-0.547041,0.430754,0.014962,-0.0523583,-0.0794851,0.48105,0.363973,0.238496,0.00314971,0.567437,0.354066,0.214185,0.218465,0.407424,-0.176231,0.440778,-0.112603,-0.0276085,-0.0606781,-0.128593,0.502335,-0.671588,-0.404127,0.63983,0.407113,-0.15958,0.0235287,-0.252741,-0.025691,-0.204051,-0.428257,0.204524,-0.168235,0.0569652,0.207038,-0.708979,-0.0659263,0.23598,0.550389,0.225331,-0.278639,-0.158626,0.280197,-0.30395,-0.0130962,-0.400258,0.213971,0.169456,0.126235,0.411651,0.355295,-0.749688 +3418.8,0.993699,0.0848144,4,1.57823,0.901655,-1.03604,0.440351,0.742496,-0.0661624,-0.583214,-0.192668,0.226989,0.163661,-0.0435917,-0.253776,0.30193,0.274278,-0.31732,0.707954,0.0867798,0.319893,0.199719,-0.189834,0.00766308,-0.759001,-0.928614,-0.0172411,-0.200892,-0.371044,-0.115545,-0.168475,-0.271523,0.0443276,0.849435,-0.610653,0.339115,0.209743,-0.522318,-0.315373,-1.07765,0.528258,0.430724,-0.523298,0.855982,0.109192,0.0119218,-0.552831,-0.0254067,-0.0408137,-0.482885,0.348936,-0.0227666,-0.138498,0.0635536,-0.142986,0.106401,-0.136642,0.478008,0.308131,-0.310382,-1.05179,0.436157,-0.673746,0.251568,0.796546,-0.178659,-0.0509544,0.559324,0.779767,0.332639,-0.0651511,0.453458,-0.485144,-0.0473671,-0.0980016,0.697277,-0.322871,0.315466,0.584417,0.172921,0.0112384,-0.581645,-0.266376,-0.146784,-0.0719907,0.381323,0.552472,0.0913327,-0.312132,0.212139,0.382015,-0.084733,-0.293656,0.296106,0.34902,0.0682845,0.349037,-0.576737,0.241693,0.286521,0.0790403,-0.0726632,0.258969,-0.0655109,0.22729,-0.326345,-0.435888,-0.0558324,-0.485359,0.411234,-0.186293,0.468321,0.36343,0.423572,0.175508,0.0740905,0.298401,-0.0808632,0.359886,-0.341402,0.0006332,0.325271,0.126943,-0.756867,-0.647009,-0.639916,-0.259128,-0.384066,-0.629052,-0.0105004,0.0403888,0.118805,-0.571154,0.208096,-0.0475242,-0.103298,0.311762,-0.317974,-0.305386,0.151309,-0.141921,0.392294,-0.493698,-0.119802,0.296659,0.28699,-0.0683611,0.336327,0.503887,0.0608487,0.104953,-0.112245,0.0153922,-0.328262,-0.174529,0.0370158,0.241722,0.67552,0.286803,0.462639,0.0236985,0.0971851,0.430607,0.464054,-0.0993197,0.608812,-0.237147,0.203665,-0.70163,-0.0310147,-0.158704,0.205741,0.023493,0.407578,0.0574054,-0.0155173,-0.52188,0.510217,-0.413244,-0.143175,0.170314,-0.0938848,0.441394,0.217803,-0.122822,0.553226,0.0308381,0.61932,-0.18174,-0.938433,-0.491194,0.215915,-0.258317,-0.192519,0.129887,-0.112873,-0.501965,-0.144262,0.27567,0.110641,-0.107509,0.0313614,-0.257441,0.521218,-0.50997,-0.142235,0.418687,0.0364945,0.0267194,-0.537099,0.951363,0.148951,0.0841358,0.285726,0.233954,0.157764,0.615427,0.205165,0.651829,0.178118,-0.185811,-0.0432967,-0.495901,-0.179975,-0.440812,0.0881989,0.104889,0.0884473,0.27328,-0.778073,-0.664247,-0.0686851,-0.376499,-0.282851,0.0244714,-0.262253,-0.37384,0.490271,0.407866,0.156012,-0.442828,0.519586,-0.71979,-0.0367362,-0.509338,0.0732705,-0.0531267,0.218767,0.338558,0.123171,0.465063,-0.276367,-0.400869,-0.201071,-0.582652,0.313281,-0.343329,0.385814,0.643221,-0.566305,-0.132969,0.426499,-0.124975,0.168388,-0.0182208,0.0682353,-0.413387,-0.173693,0.129736,-0.221069,-0.022322,0.223601,-0.235099,-0.281849,0.000837877,-0.0109068,-0.179318,-0.445502,-0.346212,0.222795,0.232627,0.611871,0.0607463,0.154711,0.0938832,-0.18974,0.247363,0.359625,0.267417,-0.879832,0.620861,-0.23269,0.706308,0.0695142,0.105529,0.195069,0.496391,-0.30384,-1.05614,-0.0495052,-0.352322,-0.128491,0.0985745,-0.0193362,0.123121,0.189039,0.350886,0.434786,-2.33749 +3409.23,0.660547,0.0848144,5,1.5916,0.897357,-1.04395,0.466029,0.562477,-0.0423969,-0.543318,-0.17642,0.406844,0.202683,-0.00949116,-0.125852,0.330084,0.26355,-0.148542,0.868283,0.0767018,0.43713,0.232328,-0.182225,0.0634252,-0.892404,-0.829506,0.0228029,-0.490445,-0.347461,-0.265674,-0.287436,-0.116641,0.0649546,0.73504,-0.564868,0.246126,0.223813,-0.191925,-0.32412,-0.97369,0.51132,0.602045,-0.55158,0.696718,0.289234,0.0206236,-0.762357,-0.0195402,-0.0423797,-0.179036,0.197876,0.00255946,-0.0965652,0.0240257,-0.0593999,0.0178529,-0.0943319,0.367644,0.115963,-0.276469,-0.929038,0.438935,-0.611746,0.263332,0.769651,-0.329981,-0.296395,0.526255,0.730244,0.560493,-0.241791,0.360841,-0.709556,0.0218285,-0.155535,0.558167,-0.432143,0.404466,0.621865,0.162151,0.0567752,-0.795918,-0.133501,-0.265575,-0.291693,0.336386,0.524724,-0.0992901,-0.135875,0.228315,0.532581,0.199558,-0.340505,0.129857,0.384271,0.108463,0.428855,-0.549462,0.209738,0.303079,-0.0618245,-0.217877,0.248421,-0.332458,0.253665,-0.227671,-0.29502,-0.134405,-0.64019,0.549043,-0.0757252,0.502008,0.343462,0.321606,0.0729613,0.380054,0.397311,-0.0071987,0.213013,-0.30431,-0.0712586,0.361562,0.087304,-0.946924,-0.687781,-0.35308,-0.292306,-0.335963,-0.602365,0.105168,0.103949,0.136438,-0.810916,0.189096,-0.109374,0.152317,0.392961,-0.408755,-0.319095,0.0828797,-0.255034,0.227671,-0.448339,-0.133396,0.312657,0.105561,-0.117396,0.116947,0.460926,-0.109725,0.161134,-0.175496,-0.403599,-0.191446,-0.00101212,-0.0450827,0.270353,0.744393,0.284214,0.306303,0.165497,0.00946266,0.468371,0.617317,0.142944,1.03069,-0.228009,-0.0812597,-0.690481,0.0441612,-0.0979808,-0.0103469,-0.150205,0.445209,0.0779578,-0.10145,-0.406819,0.523432,-0.385941,-0.285288,-0.09404,-0.0526288,0.480908,0.344232,-0.227134,0.466825,0.33395,0.584602,-0.127475,-0.835826,-0.547079,0.224787,-0.352628,-0.356498,0.232259,-0.00345692,-0.358158,-0.270479,0.229598,0.0319379,-0.118048,-0.0461917,-0.00639047,0.515201,-0.442109,-0.178334,0.314123,0.239452,0.102664,-0.547043,1.06075,0.256482,-0.0368954,0.325649,0.270268,0.158655,0.850229,-0.111758,0.59981,0.228897,-0.0961037,0.0683733,-0.245122,-0.150746,-0.337792,-0.0251088,0.2113,0.345991,0.240531,-0.85925,-0.696074,0.233647,-0.351689,-0.335255,-0.0255379,-0.0970362,-0.201629,0.26211,0.160891,0.361931,-0.343241,0.569322,-0.696773,-0.245406,-0.238535,0.114338,-0.140542,0.0374633,0.220579,0.0429037,0.475226,-0.228149,-0.349866,-0.284073,-0.755335,0.237939,-0.346828,0.474422,0.636315,-0.658342,-0.282466,0.513246,-0.037094,0.221619,0.118594,0.271622,-0.166076,0.0493642,0.344428,-0.213056,-9.66415e-05,0.101195,-0.0685818,-0.478306,0.0707048,-0.096713,-0.0614308,-0.556163,-0.375987,0.228875,0.146973,0.726827,-0.107054,0.0951527,0.174689,-0.515339,0.443861,0.541222,0.404003,-0.820795,0.338067,-0.299543,0.625569,0.0767771,0.124157,0.144355,0.608332,-0.240773,-0.890121,-0.17084,-0.240656,-0.0135673,0.151304,0.0490415,0.152509,0.171882,0.390523,0.414586,-1.74505 +3389.49,0.99301,0.0848144,5,1.55118,0.675222,-1.50587,0.71523,0.471103,-0.0806421,0.245856,0.0390201,0.266712,0.0262093,-0.33612,-0.232863,-0.874211,0.659238,0.0631543,1.03667,0.299497,-0.0161772,-0.407425,0.32165,-0.0476536,-0.65356,-0.826907,0.55291,-0.116247,0.111421,-0.00153343,1.22988,-0.52865,0.0758543,0.873335,-0.708813,-0.0510812,0.209322,-0.537023,-0.269261,0.328784,0.471452,0.272576,-0.357905,0.808483,0.688061,0.687073,-0.81159,-0.471373,0.730276,-0.863451,0.41274,-0.118147,-0.212355,0.173714,1.01684,0.169274,-0.530333,0.618962,-0.398074,0.114991,-0.55297,-0.0560136,-0.0117732,-0.0788131,1.01972,-0.861076,-1.33272,-0.0190979,-0.278207,-0.587019,0.081384,-0.254713,-0.00366802,-0.0685495,0.968291,0.582594,0.0397076,0.293697,0.424051,0.454941,0.00948433,0.148737,0.347277,1.1236,-0.0973002,0.261949,-0.75285,-0.0397823,0.347138,-0.218541,-0.671383,0.125166,-0.0979753,0.30464,-0.445115,0.28504,-0.256029,0.576088,-0.481268,-0.00306639,-0.192874,0.295015,0.26027,0.435321,-0.0546193,-0.27203,0.297539,0.263659,0.38132,-0.0394531,0.101044,-0.164177,0.266655,-0.354737,-0.0862177,-0.282073,0.087064,0.226848,-0.192381,-0.191522,0.149844,0.280417,-0.108749,-0.489196,0.645967,-0.20314,-0.172313,0.34359,1.06805,0.05907,0.0370095,0.130956,0.393295,-0.0762948,0.0588772,-0.159428,0.223798,0.326761,0.183065,0.051277,-0.166359,0.64383,-0.338239,-0.184878,-0.157136,0.00905799,-0.55845,0.255545,-0.524721,0.135917,0.617678,0.0753175,0.37146,-0.0920834,0.59598,0.53697,-0.35504,-0.111837,0.770381,0.426216,-0.412797,0.129462,-0.459169,-0.186115,-0.0423392,0.791568,0.0761216,0.0744813,0.468432,0.18476,-0.175378,-0.593369,-0.11347,-0.0674686,-0.115651,-0.363297,0.152469,-0.814745,0.206482,-0.180491,0.119509,0.484893,0.332109,-0.28539,-0.0527948,-0.481013,-0.515216,-0.483789,-0.532056,0.52189,0.0821173,0.242323,-0.128463,0.352365,-0.289786,-0.295168,-0.418357,0.346341,0.167618,-0.0798382,-0.273242,-0.815142,0.203594,-0.328936,-0.137222,0.506224,-0.15502,-0.210682,-0.15173,-0.0150908,1.04699,-0.10469,0.209888,-0.0385606,-0.305406,0.0686341,-0.647822,0.0932767,0.0889193,-0.780666,0.35516,0.429293,-0.234815,0.260786,-0.361436,-0.211368,0.216572,-0.960098,0.798047,0.102036,-0.0694579,0.0266685,0.43531,-0.174848,-0.207,-0.0451613,-0.193106,-0.706591,0.55415,-0.349017,0.405769,-0.0063852,-0.132061,-0.0537867,0.485786,0.0106871,0.453451,0.461038,0.196185,0.782498,-0.136888,-0.00773194,-0.234466,0.221209,-0.652913,0.691433,-0.131175,-1.01231,-0.458122,0.303834,0.352471,-0.0909058,0.421338,-0.048138,0.437075,-0.27654,0.193972,0.395857,0.0716942,0.249821,0.0758466,-0.345744,0.476089,0.367789,-0.492592,-0.290123,0.186848,0.875588,0.287257,-0.158048,0.157271,-0.225703,0.263567,0.0925106,-0.484659,0.112971,-0.603796,-0.00680096,-0.125104,0.266738,0.115295,0.492256,-1.06174,-0.332145,0.0511822,-0.250405,-0.452431,0.062363,0.290533,-0.232757,-0.177805,-0.0477561,-0.293173,-0.00125533,0.151239,0.335293,0.388895,0.579045,-1.07347 +3403.38,0.653126,0.0848144,5,1.57753,0.686367,-1.61645,0.682129,0.105196,-0.172923,0.0421335,-0.047667,0.345298,-0.182838,0.0446669,-0.335584,-0.514523,0.542244,0.0676308,0.919125,0.150578,0.0650147,-0.679385,0.429913,-0.257092,-0.665349,-1.04428,0.64685,-0.21474,-0.263776,-0.109957,0.441846,-0.106598,0.189029,0.957866,-0.25458,-0.341057,-0.272143,-0.748425,-0.064406,0.467911,0.709893,0.0982594,-0.422148,0.865788,0.680217,0.689999,-0.92325,-0.378677,0.781036,-0.76144,0.160474,-0.0924913,-0.143666,0.156378,0.760857,-0.0374374,-0.434295,0.629738,-0.341896,-0.143387,-0.866738,0.147294,-0.120359,0.36039,1.21442,-0.765758,-1.34471,0.138787,-0.210554,-0.301051,-0.277101,-0.265846,-0.134392,-0.060425,0.607033,0.615037,-0.221652,0.288303,0.174644,0.31131,0.0999404,0.0318216,0.364771,1.02209,-0.277317,0.113287,-0.682675,0.195656,0.0617093,-0.216884,-0.525382,0.326949,-0.31166,0.254639,-0.708787,0.28705,-0.348624,0.366735,-0.244712,0.303074,-0.413985,0.227568,0.401046,0.503414,-0.439131,0.0702454,-0.335985,0.326117,0.104839,0.262825,-0.121904,-0.062176,0.417149,-0.0130499,-0.514735,-0.229922,0.0250748,0.0251453,-0.224787,-0.0901886,0.22927,0.255144,-0.282604,-0.442274,0.386516,-0.419196,-0.113513,0.388337,1.06693,0.301081,0.282884,0.29431,0.00357281,-0.298607,-0.047149,-0.116981,-0.0276891,0.0442751,-0.209234,-0.266067,-0.235512,0.524754,-0.375733,-0.706637,-0.133231,-0.0928452,-0.30152,0.464335,-0.186464,0.0128671,0.833292,-0.14735,0.274466,-0.370822,0.535311,0.290001,-0.486544,-0.262007,0.992068,0.546648,-0.0855057,-0.190042,-0.35403,-0.207151,-0.330638,0.811508,-0.124213,0.231199,0.322794,0.168495,-0.217785,-0.515225,-0.16887,0.244048,-0.117329,-0.501867,0.0781235,-0.865781,-0.0896682,0.00383062,0.22537,0.414286,0.29202,0.103143,0.410332,-0.710183,-0.504055,-0.249155,-0.476555,0.766056,0.0520834,0.277255,0.0463803,0.189409,-0.129722,-0.421338,-0.375153,0.217846,0.481098,-0.40416,-0.134976,-0.45169,0.311992,-0.25322,-0.272356,0.355675,-0.122544,-0.109057,0.130403,0.317646,1.0687,0.132712,0.660057,-0.0314171,-0.31543,0.16234,-0.248067,-0.0423191,0.0317288,-1.01437,0.62509,0.330429,-0.580795,0.242409,-0.254682,-0.238119,0.331449,-0.75281,0.853032,-0.185285,-0.332951,-0.122817,0.144443,-0.207841,-0.311297,-0.247387,-0.20458,-0.526514,0.674036,-0.232313,0.504429,0.153888,-0.257228,-0.243976,0.244764,-0.478743,-0.0332644,0.0595713,0.219896,0.559562,0.0380086,-0.0947268,-0.275687,0.307298,-0.781119,0.620808,-0.0358897,-0.634607,-0.406427,-0.100101,0.307887,0.00382607,0.217584,-0.053894,0.446881,0.422588,0.237377,0.708259,-0.159891,0.14004,-0.267802,-0.458547,0.37105,0.33169,-0.619777,-0.20203,0.171951,0.680697,0.540399,-0.0341952,0.326913,0.0940812,0.120839,0.306748,-0.39856,-0.0190856,-0.364766,0.304765,-0.149802,0.251014,0.0256239,0.209954,-0.583454,-0.290589,0.280707,-0.0162178,-0.35297,0.194265,0.370486,-0.366696,-0.20624,0.147649,-0.32614,0.0965774,0.182267,0.336149,0.426928,0.579784,0.260472 +3388.37,0.970765,0.0848144,4,1.48887,0.778234,-1.35673,0.59692,0.26352,-0.189738,0.253439,-0.4966,0.751805,-0.262127,0.147101,-0.138919,-0.413547,0.439516,-0.168087,0.7148,0.310178,0.152318,-0.869146,0.606079,0.106383,-0.794422,-0.75359,0.553998,-0.0300387,-0.191036,0.073085,0.288018,-0.400932,-0.377582,1.13098,-0.240891,0.0643938,0.25722,-0.479499,-0.187697,0.087983,0.511009,-0.133789,0.104626,1.05813,0.542314,0.8384,-1.11443,-0.32965,0.517144,-0.333518,0.238541,0.345905,-0.0198621,-0.0817595,0.935809,0.235886,-0.127073,0.743323,-0.120211,0.136955,-1.05112,0.00946052,-0.116892,0.4724,0.941371,-0.833549,-1.10938,0.0905576,0.0158266,-0.044365,-0.28073,0.294916,-0.503105,-0.263232,0.845086,0.890874,-0.213226,0.0757267,0.423417,0.232724,0.122521,-0.0274909,0.373076,0.549097,-0.292755,0.134986,-0.855411,0.126102,-0.163321,-0.266252,-0.949348,0.119364,-0.441433,0.353358,-0.698203,0.189094,0.10376,0.0894109,-0.366738,0.119358,-0.112153,-0.21594,0.65977,0.425199,-0.214583,-0.432257,-0.325809,-0.459353,0.143419,0.398617,-0.172837,-0.213522,0.64677,-0.386692,-0.160739,-0.304695,0.118235,-0.0142737,-0.317242,-0.0857166,0.187586,0.31832,0.0842507,-0.646858,0.705936,-0.156979,-0.571876,-0.070813,0.6064,-0.00460813,0.0943336,0.3629,-0.087794,-0.317736,-0.119101,0.0191561,0.0201399,0.291016,0.0614747,0.240341,-0.283886,0.40757,-0.130083,-0.733188,-0.165985,-0.208451,-0.227999,0.0149653,-0.180927,-0.00314513,0.835631,-0.265468,0.243376,-0.438263,0.5522,0.273643,-0.22207,-0.578692,0.999692,0.732346,-0.263639,-0.115543,-0.430807,-0.160354,-0.395071,0.617625,0.219085,-0.453324,0.43836,0.173371,-0.101458,-0.268435,-0.368896,0.200051,-0.0165053,-0.413089,0.0944711,-0.815389,0.00140021,-0.117237,-0.032283,0.299777,0.0758907,0.261599,0.436574,-0.169348,-0.510705,-0.107682,-0.621811,0.688703,0.0678505,0.330474,0.490913,0.197091,0.204842,-0.259835,-0.462426,-0.0570518,0.0340463,-0.437506,-0.024357,-1.0789,0.308388,-0.234967,-0.462162,0.490806,0.0090332,0.00523807,0.125707,-0.0654162,0.5994,0.195109,0.499672,-0.0747385,-0.0806506,0.316488,-0.582687,-0.171263,0.542607,-1.17095,0.14183,0.366861,-0.657509,-0.140795,0.0645488,0.069254,0.450965,-0.999197,0.76995,0.195755,-0.10328,0.421933,-0.0209607,-0.35023,-0.375211,-0.409633,0.174052,-0.408374,0.386668,-0.206234,0.0252577,0.736803,-0.463671,-0.343151,0.515782,-0.289782,0.271979,0.271419,0.464826,0.740791,0.06318,-0.00237686,-0.0981154,0.346942,-0.58431,0.341777,0.0843516,-0.511716,-0.509006,-0.132239,0.334102,-0.227916,0.0378747,-0.441703,0.914385,0.441813,-0.0833587,0.666684,-0.283608,0.0885758,-0.265236,-0.145876,0.355154,0.377457,-0.136197,-0.318909,-0.277264,0.671527,0.272199,-0.0883065,0.470304,0.593142,0.142564,-0.000196677,0.351261,0.0210981,-0.203485,0.504889,-0.181843,0.00149565,0.563314,0.427883,-0.87141,-0.236268,0.154086,-0.145117,-0.00841291,0.125926,0.204487,-0.567458,-0.203966,0.493487,-0.293101,0.191618,0.150847,0.466398,0.388391,0.682933,-0.567659 +3417.74,0.992046,0.0848144,5,1.43202,0.779952,-1.85167,0.855108,0.484928,-0.0379206,0.363026,-0.10991,0.218014,-0.212971,0.225307,-0.286788,0.108254,0.453695,-0.245476,0.793494,0.259482,0.00631171,0.469727,-0.128613,0.201449,-0.482207,-0.252254,0.487845,-0.204757,-0.283793,-0.264344,-0.0333633,-0.242597,0.371673,0.984729,-0.655878,0.373423,0.294312,-0.721686,-0.205479,-0.25611,0.906783,0.824262,0.158911,1.05491,0.597061,0.543615,-0.526802,-0.568285,0.0756779,-1.33597,0.0727703,0.12605,0.107273,-0.0448072,0.721401,-0.0385954,-0.15535,0.260575,-0.391708,-0.210867,-0.599192,0.187834,-0.434643,0.0421363,0.992179,-0.578461,-0.893927,-0.07928,-0.232703,0.771797,-0.193254,0.673147,-0.248714,0.371496,-0.198951,0.524343,0.578557,0.617213,0.496746,0.424658,0.194695,-0.776101,0.0573169,0.240046,-0.206884,0.0298787,0.415512,0.168716,0.0156643,0.331532,-0.451636,0.144136,-0.472453,-0.714779,0.0154541,0.198902,-0.108775,0.101639,-0.32523,0.610782,-0.451345,-0.645663,0.0428129,0.268465,0.222942,-0.0738195,-0.0864451,0.26068,-0.0688174,0.241578,-0.0535176,0.200886,0.645383,0.0578103,-0.0956023,0.607043,0.0332329,0.193139,0.200024,0.367823,-0.106839,0.0347969,-0.0258328,-0.718088,-0.509645,-0.0899728,0.0619772,-0.267097,0.302739,0.0862761,0.0713389,0.210203,-0.118973,-0.0328788,0.335882,0.133615,0.502955,-0.347612,-0.524892,-0.19207,-0.315127,0.405939,-0.775638,-0.222142,-0.0446119,0.614251,-0.590399,0.27475,0.29371,0.0213362,0.426343,-0.425806,-0.292985,-0.364332,0.186273,0.215829,0.167285,0.657814,-0.190399,-0.697605,-0.143816,0.263547,-0.0364429,0.0208542,0.411234,1.1305,-0.534808,0.575559,0.357602,0.24204,-0.169622,0.0207999,-0.284145,-0.122307,-0.0495543,-0.304412,0.522244,-0.00941356,0.124732,-0.432529,-0.0328375,0.163589,1.00973,-0.0133641,-0.240707,0.140932,-0.216468,-0.33352,-0.311038,-0.185651,-0.225366,0.277682,-0.594257,0.051399,0.110402,0.297797,-0.477491,0.122588,0.0866744,0.234079,-0.494401,-0.102918,-0.750827,-0.043767,0.0262807,0.285286,-0.0229978,0.078401,-0.103855,-0.434289,0.832268,0.102604,-0.2273,0.501293,-0.0618369,0.219035,0.9152,-0.413633,0.277895,-0.205695,0.0413977,0.59758,-0.22633,-0.291188,-0.291676,-0.348433,-0.238591,0.319739,0.473671,-0.954263,-0.0491609,-0.817104,0.0386508,0.00826024,-0.105833,0.066051,-0.55581,0.106558,0.339196,-0.0598005,0.354603,0.201227,-0.552915,0.188076,0.592975,0.0513122,-0.0053211,-0.293139,0.120121,0.20613,0.2896,-0.37137,-0.325862,-0.213051,-0.507607,0.477894,-0.263274,0.346392,0.632942,-0.00281497,0.127612,-0.257526,-0.0316222,0.134682,-0.42358,0.094591,0.190557,0.186468,0.143527,-0.345806,-0.333125,-0.611346,-0.0180905,-0.396295,-0.455033,-0.523582,-0.23304,-0.0225013,-0.344504,0.361792,-0.293228,-0.23675,-0.349622,0.133999,-0.594172,0.0883687,0.877498,0.42931,0.613589,-0.177268,-0.147425,-0.0222527,0.000997139,-0.256624,0.355988,-0.0336718,0.0198333,-0.289204,-0.816441,0.294833,0.0672707,0.0118965,-0.239405,0.454296,0.129861,0.185447,0.360363,0.430636,-1.38533 +3417.7,0.951819,0.0848144,4,1.60869,0.629915,-1.57142,0.774247,0.753108,-0.20031,-0.657556,0.161065,0.209217,-0.204949,0.0780521,0.0155242,-0.107766,0.612912,-0.109073,0.104401,0.146034,0.255971,-0.923311,-0.032664,-0.0631454,-1.10964,-1.18486,0.410942,-0.31872,0.24605,0.228392,0.249278,-0.571498,-0.208362,1.02717,-0.579966,-0.477208,0.273964,-0.272737,-0.233272,-0.0317642,0.484931,0.565966,-0.450229,1.18394,0.689316,0.418088,-1.01727,-0.339423,-0.651829,-0.078419,-0.0113101,0.159215,-0.179638,-0.0727133,0.808532,-0.0944538,-0.367833,0.307251,-0.105984,-0.152296,-1.30347,-0.303535,-0.134265,0.702533,0.642543,-0.830528,-0.451915,0.528068,0.527544,-1.0121,-0.0608944,-0.498221,-0.30634,-0.55046,0.351431,0.507705,-1.04321,0.479925,0.404677,0.217555,0.102892,0.320341,0.413494,0.813139,-0.449453,0.53496,-0.737071,-0.109962,-0.0977457,-0.177864,-0.462512,0.147445,-0.372035,0.437469,-0.317177,0.345282,-0.00966823,0.142066,-0.310439,-0.223603,-0.0471107,0.531138,0.0767491,-0.254259,-0.203118,-0.39511,-0.11727,0.0221688,-0.0201574,0.169705,-0.202846,0.416692,0.11613,0.0152792,-0.0620546,-0.209409,0.131923,-0.252715,-0.376313,-0.749915,0.309521,-0.00515921,-0.261666,-0.345252,0.431124,-0.258884,-0.526075,0.408589,-0.111656,0.126042,-0.165665,0.332779,-0.156678,-0.173421,-0.397524,-0.00928601,0.470238,0.229436,0.341452,0.460177,0.370261,0.680102,-0.144118,-0.237246,0.179666,-0.333693,-0.226965,-0.362293,0.00298651,0.159021,0.175689,-0.0334356,0.0997699,0.215522,0.53158,-0.010468,-0.0710643,-0.379321,0.648246,0.560175,0.0265827,-0.469846,-0.376808,0.424488,-0.250422,0.710621,0.747617,-0.370949,0.167201,-0.192428,-0.0292543,-0.348506,-0.211398,0.40964,0.136257,-0.145326,-0.486669,-0.397346,-0.122514,0.0652633,-0.244366,-0.152151,0.219268,0.11815,-0.235463,0.00229267,0.00325879,0.123871,-0.211168,-0.177787,-0.0381367,0.01749,-0.228931,-0.0920659,-0.0654479,0.0288336,-0.370016,-0.0269314,0.316045,0.019061,0.201168,-0.585307,0.491671,0.119629,-0.332038,-0.208123,-0.0930956,0.0730597,0.179012,-0.218992,0.627292,-0.065612,0.52685,0.0659442,-0.132023,-0.320898,-0.704066,0.02836,-0.130571,-0.22628,-0.0556086,-0.0079435,-0.485142,0.227413,-0.103232,0.447811,0.665753,-0.467546,0.394144,0.11421,-0.471488,0.672451,-0.0710335,-0.574835,-0.151672,-0.22129,-0.0706685,-0.668265,0.512296,-0.047688,-0.293173,0.713557,0.162257,-0.544364,-0.406859,0.0405705,-0.146199,0.624055,-0.00753242,0.757828,0.121974,-0.118617,-0.288107,0.191601,-0.163923,0.326425,-0.150956,-0.616275,-0.248192,-0.0925426,0.0650296,0.550374,0.323692,-0.0558668,0.700392,-0.223365,0.216855,0.166905,-0.166573,0.0958037,0.0278493,0.547624,0.513953,0.0341805,0.141319,0.0930783,0.2496,0.0155641,0.0197583,-0.414734,0.121153,0.411393,0.316769,0.168326,0.537347,-0.481334,-0.495164,-0.143523,0.000469042,-0.169656,0.446798,0.392245,0.00432482,0.0306303,-0.0326133,-0.124296,0.212397,0.247973,-0.172112,-0.3325,0.0163475,0.0358115,0.021503,-0.69287,0.107526,0.265943,0.327911,0.515697,-1.86367 +3419.72,0.958366,0.0848144,5,1.66951,0.610643,-1.6611,0.75884,0.624622,-0.147269,-0.546917,0.0515251,0.0357975,0.0749475,0.132002,0.0334806,-0.38822,0.845569,0.0675976,0.134179,0.157972,0.326602,-0.820042,-0.0670086,-0.112587,-1.01443,-1.04953,0.377184,-0.310092,-0.0377128,0.399758,0.0745974,-0.540908,-0.232967,1.09314,-0.652822,-0.608976,0.140295,-0.252443,-0.385381,0.139107,0.487955,0.459327,-0.476094,1.33621,0.719724,0.52498,-1.06382,-0.230156,-0.682712,-0.0906607,0.0956645,0.292178,-0.213329,0.00675286,0.713834,-0.0344164,-0.150465,0.349963,-0.0441795,-0.191173,-0.988717,-0.289931,-0.297627,0.851035,0.726771,-0.792091,-0.626409,0.997468,0.556645,-0.875728,0.092203,-0.595057,-0.269102,-0.624389,0.209455,0.486791,-1.05664,0.509498,0.320745,0.202188,0.145052,0.316043,0.447799,0.742606,-0.07095,0.314564,-0.760146,0.0323532,-0.361991,-0.393352,-0.307427,0.130714,-0.299614,0.298135,-0.230567,0.429276,0.035125,0.169961,-0.311497,-0.218408,0.0800568,0.583298,0.0354354,-0.52164,-0.207321,-0.355859,-0.195124,0.0222094,-0.0571438,-0.0374506,-0.267545,0.313218,0.0340067,-0.0137363,-0.206809,-0.250712,0.255709,-0.146727,-0.270578,-0.825758,0.392577,-0.113027,-0.372263,-0.300782,0.492551,-0.293819,-0.509302,0.267307,-0.151942,0.195109,-0.248314,0.338949,-0.443182,-0.158967,-0.352579,0.0365024,0.471301,0.0961382,0.283355,0.436432,0.332099,0.547059,-0.204943,-0.564152,0.185882,0.0996062,-0.364689,-0.243574,-0.0962183,0.120613,0.139883,-0.135155,0.194001,0.200831,0.366354,-0.121815,-0.159486,-0.418432,0.473108,0.529861,-0.0462664,-0.451319,-0.49521,0.571585,-0.431122,0.785039,0.47972,-0.242966,0.0521727,-0.159979,-0.09155,-0.512378,-0.163784,0.602951,0.342483,-0.0861982,-0.473572,-0.43831,-0.162451,0.0474816,-0.105894,-0.160575,0.233906,0.0744231,-0.042951,-0.145564,-0.101795,0.0456966,-0.178402,-0.251246,0.0728286,0.203285,-0.307866,-0.105122,-0.141304,0.164402,-0.389016,0.0549388,0.180763,-0.0440588,0.0358719,-0.359667,0.45621,0.119118,-0.270794,-0.301208,-0.0225849,-0.108658,0.387717,-0.197634,0.810163,0.0850789,0.545647,0.104084,-0.0709164,-0.138329,-0.651688,0.103054,-0.2368,-0.148605,-0.0884459,-0.104971,-0.364204,0.0494724,-0.409606,0.325716,0.542613,-0.514715,0.532106,0.0615,-0.530463,0.466498,0.0349319,-0.571637,-0.134741,-0.328523,0.157399,-0.25225,0.465904,0.0661795,-0.21402,0.786548,-0.0647886,-0.417926,-0.52451,0.217838,-0.204356,0.642721,-0.0215725,0.763517,0.236889,-0.23772,-0.338844,0.0652943,-0.140475,0.504414,-0.0556376,-0.746718,-0.218992,-0.00340643,-0.0570054,0.672698,0.236454,-0.0742491,0.395294,-0.188062,0.297104,0.243646,0.126855,-0.119652,0.00280279,0.642322,0.589171,0.211476,0.0728835,-0.131466,0.237958,0.238333,0.35003,-0.287797,0.0105323,0.168601,0.20912,0.163449,0.592944,-0.490582,-0.346009,-0.178547,-0.0848636,-0.0756386,0.314157,0.393386,0.0473042,0.00997826,-0.0512408,-0.000370472,0.195825,0.117199,0.111543,-0.522831,0.0367695,0.0750175,-0.107852,-0.581851,0.116145,0.31459,0.340801,0.560883,-1.29376 +3410.36,1,0.0848144,4,1.52255,0.580374,-2.44946,0.916426,0.197221,-0.112732,-0.100804,-0.25781,-0.288246,-0.32425,0.0491127,-0.365145,-0.536068,1.01376,-0.0365362,0.557574,0.0214894,-0.561165,0.0156752,-0.278667,-0.109977,-0.187514,-0.829313,0.186183,-0.153397,-0.57961,-0.98108,-0.336466,-0.681185,0.359632,0.954881,-0.942832,0.0983208,0.00351504,-0.304953,0.111945,-0.302365,0.851378,0.588988,-0.350958,1.44779,1.0794,0.764851,-0.486348,-0.535774,-0.220128,-0.6904,0.890639,0.829918,0.042746,-0.0204651,1.03646,0.04657,-0.978353,0.477156,-0.335689,0.0968561,-0.207827,0.256714,-0.254857,0.647467,1.15683,-0.446636,-0.211286,0.622809,0.146712,0.598933,-0.262965,-0.166396,-0.395231,0.321306,0.602985,0.0332468,0.362405,0.674368,0.826922,0.633885,-0.0208523,-0.496862,0.0747382,0.0644415,-0.357737,0.392889,0.231033,-0.359244,0.229923,0.154542,0.0575082,-0.0495445,-0.423989,0.285441,0.0733422,-0.127926,-0.116507,0.133838,0.390854,0.200955,-0.372767,-0.0767482,-0.489074,0.151649,0.323381,-0.269905,0.326634,0.482439,-0.473516,-0.133495,-0.306331,0.492812,1.04357,0.126925,-0.0355273,0.276503,0.23927,0.421727,0.375508,-0.111506,-0.0207918,0.528798,-0.552075,-0.327162,-0.592374,0.0318511,-0.330025,0.025057,-0.0135532,0.269037,0.131757,0.338428,-0.489452,0.428555,-0.329633,-0.40557,0.629454,-0.167025,-0.236154,-0.300503,-0.0561201,0.345392,-0.61368,0.0752423,0.0382502,-0.447405,0.0218996,-0.22202,0.565371,-0.0739837,0.185522,-0.347024,-1.1092,-0.843697,0.374098,0.154191,0.466186,0.111859,0.530077,0.197346,0.711764,0.233851,0.302512,-0.324799,0.340743,0.98244,-0.452771,0.329748,0.43074,-0.290643,0.200194,0.374546,-0.641966,0.00829832,0.0105122,-0.206893,0.405027,-0.139598,0.0459524,-0.371093,-0.0375595,-0.0105091,1.06928,-0.0235901,0.0801722,-0.560052,-0.175244,-0.114267,-0.327723,0.232628,-0.39554,0.0202815,-0.455274,-0.539287,-0.262054,-0.250779,-0.75835,-0.193579,0.158616,0.496146,-0.220984,-0.905162,-0.14889,0.0867902,-0.202584,0.49178,0.235989,0.0429921,-0.106757,-0.422837,0.779255,0.220381,-0.396321,0.352267,-0.33698,0.32426,0.658151,-0.724761,0.507076,0.309551,-0.211604,0.357565,-0.214715,0.260383,0.142255,-0.436059,-0.00164717,-0.718207,-0.0140548,-0.117641,0.238312,-0.345578,0.221434,0.290073,0.0374767,-0.262715,-0.644365,-0.604794,0.545162,0.366398,-0.084393,0.452814,-0.684206,0.0663739,-0.26206,-0.192612,0.209749,0.0544664,0.0982101,0.40358,0.0822668,0.242423,-0.596782,-0.530186,-0.746377,0.588025,-0.423394,0.64987,0.623914,-0.365624,-0.490498,-0.314794,0.339038,-0.106471,0.362028,-0.0789446,0.142152,0.176882,-0.415569,-0.12534,-0.184608,-0.308779,0.0668049,-0.539368,-0.64938,-0.405999,0.328274,-0.0405354,-0.664403,0.0143922,0.140825,0.363996,0.112576,0.301605,-0.349662,-0.214802,0.0205698,0.0597015,0.339132,0.0612266,0.181046,0.120581,0.0427194,-0.0914506,0.387356,0.255959,0.207605,0.103402,-0.733307,-0.120196,0.105094,-0.044777,-0.493163,0.0179207,0.15186,0.312727,0.389692,0.55922,0.287811 +3391.07,0.88752,0.0848144,4,1.56145,0.493173,-2.25238,0.836524,0.126801,-0.0413465,-0.534701,-0.384761,-0.0921534,0.0611074,-0.0811442,-0.178344,-0.484682,0.714212,0.102041,0.137236,0.353683,-0.297261,-0.769929,-0.159844,-0.102706,-0.923511,-0.830074,0.661113,-0.433783,-0.54487,0.203485,-0.149926,-0.506698,-0.154083,1.18515,-0.0322955,-0.171851,0.0219168,-0.157875,-0.0527578,0.0916427,1.35283,0.761563,-0.556111,1.25054,0.369842,0.633811,-1.41663,-0.137373,-0.173818,0.0492141,0.26645,0.505274,-0.357137,-0.348581,1.42262,0.171174,-0.837541,0.781292,0.00555273,-0.2504,-0.213194,0.0184735,0.170247,0.554358,0.978917,-0.00177922,-0.870169,0.595233,0.546569,-0.446263,0.210323,-0.0976199,-0.0788347,-0.0652333,-0.0416848,0.486948,-0.307171,0.219183,0.289742,0.685265,0.366328,0.430052,0.10409,0.530754,-0.490032,0.0338649,-0.316882,-0.399882,0.0531701,-0.228307,-0.215402,0.0843966,-0.548193,0.00934708,-0.492608,0.640972,-0.35209,0.0232124,0.535815,-0.254704,-0.279591,0.705968,0.340345,0.0784695,-0.208974,-0.0506608,0.0573713,0.318527,0.0438191,-0.110899,-0.477298,0.388356,1.18019,-0.20347,-0.200202,0.242453,0.249901,-0.0506179,0.395638,-1.09167,0.528083,0.214833,-0.463363,-0.00177269,-0.555432,-0.0819575,0.375647,-0.219434,0.410325,0.0391364,-0.297709,0.333079,-0.298005,-0.115482,-0.407175,0.0443002,0.962108,0.128542,0.367046,-0.405397,-0.458269,0.535238,-1.01757,-0.571278,0.0308738,0.47222,0.243689,-0.0561308,-0.167956,0.321581,0.348156,-0.540374,-0.729,-0.659987,0.28724,-0.11801,-0.275913,0.211445,0.317605,0.0418398,-0.534002,-0.238715,0.306127,0.229456,0.2052,0.737292,0.535685,0.156192,0.388605,0.0267103,0.389464,0.347153,-0.836507,0.49089,0.0374423,-0.156287,0.464884,-0.482881,-0.0997659,0.00497469,-0.0428572,0.251365,0.423366,0.272982,0.988286,0.208702,0.41373,0.266395,-0.103301,-0.752327,-0.257726,-0.0302694,-0.567947,-0.0977072,-0.25207,-0.22432,-0.627593,0.334753,0.643919,0.380759,-0.327898,-0.38924,-0.266803,-0.0409063,-0.405142,0.488029,-0.340618,-0.318728,0.252819,-0.656322,0.676059,-0.108141,-0.0632481,0.267612,0.0179266,0.228462,-0.498942,-0.0944933,0.394068,-0.13459,-0.0960588,0.900497,-0.018698,0.314791,-0.183674,0.410355,0.260205,-0.0725215,0.636888,0.478956,-0.00924987,0.346495,0.442816,-0.285455,-0.227904,0.211645,0.106853,-0.137405,0.722809,-0.720599,0.590507,0.956961,-0.235678,-0.507072,0.260148,-0.234316,-0.0550936,0.0987292,0.465313,0.502207,0.343395,-0.473389,-0.733397,-0.369754,-0.337308,0.348052,0.414958,-1.16144,0.496849,-0.220414,0.271132,0.775865,0.0523693,0.0498598,-0.0863646,0.178386,0.131965,0.325801,-0.253527,-0.191351,0.0647381,0.188307,-0.285357,-0.0435537,-0.225438,-0.234232,-0.742784,-0.0823377,0.549907,-0.33542,0.383502,0.354119,0.294693,0.333355,0.0417154,-0.375238,-0.115496,0.235227,0.121226,0.197817,0.363287,0.11683,-0.149359,-0.140386,0.318845,-0.0696413,0.278107,-0.0133236,0.074801,0.195514,-0.0671618,-0.652245,-0.0956201,-0.229662,0.150626,0.372,0.388105,0.609918,0.669044 +3394.87,0.924811,0.0848144,4,1.56816,0.533613,-2.31249,0.854524,0.221638,-0.0787618,-0.522516,-0.351165,-0.0570364,0.095318,-0.0825868,-0.122414,-0.399449,0.671448,0.110033,0.239105,0.389921,-0.27878,-0.795698,-0.237986,-0.182481,-1.09114,-0.843504,0.636321,-0.300832,-0.539142,0.15101,-0.202344,-0.601628,-0.144445,1.15119,-0.16026,-0.0686265,0.00984013,-0.307112,-0.100599,0.241099,1.28731,0.716835,-0.514133,1.19038,0.381941,0.629775,-1.23745,-0.056458,-0.142802,-0.0122532,0.225237,0.44964,-0.437666,-0.351467,1.46839,0.186362,-0.675999,0.729024,0.0215708,-0.236721,-0.170762,0.0231204,0.113236,0.473269,0.965786,-0.0315381,-0.945656,0.611239,0.594681,-0.54855,0.189945,-0.0375534,-0.126264,-0.0776037,-0.229701,0.430714,-0.323905,0.294503,0.204977,0.69805,0.479736,0.408336,0.0720234,0.562649,-0.487829,0.0980664,-0.303289,-0.470863,0.0955139,-0.395227,-0.14681,0.069699,-0.405233,-0.0105396,-0.387778,0.576848,-0.350551,0.0613892,0.389701,-0.218948,-0.26058,0.819408,0.360991,0.181053,-0.259205,-0.0144298,-0.0105462,0.27094,-0.0605398,-0.161673,-0.549277,0.31782,1.16145,-0.302319,-0.290583,0.311709,0.235934,-0.0290691,0.388436,-1.00303,0.60539,0.303409,-0.534467,0.0958837,-0.564561,-0.167451,0.355074,-0.221165,0.462859,-0.0781827,-0.274914,0.388761,-0.372914,-0.286808,-0.362173,-0.119279,0.912866,0.0851352,0.387577,-0.333592,-0.451399,0.530098,-0.972092,-0.546825,-0.0303649,0.516204,0.413491,-0.0608854,-0.00054228,0.422755,0.417702,-0.460919,-0.683931,-0.580983,0.269772,-0.0289611,-0.362133,0.319291,0.317863,0.0791824,-0.481893,-0.151094,0.301581,0.346276,0.218717,0.76623,0.403307,0.236738,0.299728,-0.0547162,0.242605,0.373971,-0.751931,0.559141,0.137951,-0.221067,0.45498,-0.526335,-0.020749,0.0264501,-0.0949497,0.278599,0.323219,0.175834,1.00176,0.0512052,0.440311,0.150442,-0.152679,-0.754754,-0.222283,-0.0156753,-0.62414,-0.124214,-0.319016,-0.13517,-0.661295,0.437884,0.649409,0.31363,-0.197454,-0.399534,-0.121604,-0.0437119,-0.35167,0.484703,-0.295156,-0.131497,0.270917,-0.645741,0.634903,-0.185956,-0.0461331,0.276587,-0.0293547,0.185027,-0.335739,-0.144085,0.32088,-0.141915,-0.0904315,1.08392,0.112094,0.252787,-0.162252,0.334102,0.271361,-0.0966286,0.651137,0.380248,0.0136394,0.244958,0.46093,-0.284175,-0.20779,0.120814,0.0281171,-0.181866,0.786849,-0.730028,0.608864,0.979097,-0.227704,-0.396998,0.250196,-0.279826,0.00708682,0.192556,0.459675,0.532066,0.291353,-0.509037,-0.609205,-0.475869,-0.339656,0.503283,0.173472,-1.18109,0.490392,-0.230315,0.299313,0.659072,0.0046218,0.137019,-0.0773107,0.17685,0.094264,0.414355,-0.283782,-0.108456,0.13154,0.201064,-0.148471,-0.0802793,-0.196795,-0.185758,-0.642189,-0.212062,0.534022,-0.350296,0.442738,0.475393,0.355437,0.319767,-0.0226903,-0.395071,-0.140043,0.206411,0.128397,0.161636,0.208548,0.298017,-0.17543,-0.0853092,0.301868,0.0614865,0.352956,-0.0577523,0.101263,0.134527,-0.0125912,-0.685337,-0.00787137,-0.268496,0.164551,0.371585,0.405649,0.609578,0.313281 +3388.46,0.915264,0.0848144,4,1.48967,0.752134,-2.14178,0.810778,0.636884,-0.129018,-0.117446,-0.196355,-0.385748,-0.16694,-0.0279558,-0.0779715,-0.179671,0.509763,0.0226874,0.454773,0.206763,-0.590816,-0.984234,-0.263998,0.0594936,-1.03899,-1.21093,0.444789,-0.242803,-0.399526,0.0278116,-0.275292,-0.79978,0.21832,1.09534,-0.455701,0.0549143,-0.0724826,-0.191237,0.399175,-0.335296,1.43547,0.989309,-0.151284,1.16628,0.228641,0.562679,-0.671764,-0.416764,-0.52349,-0.153003,0.281228,0.119534,-0.377773,-0.0245612,0.890672,0.049294,-1.19251,0.562253,0.113283,-0.29112,-0.66436,0.298557,-0.162109,0.0580474,1.01784,-0.646015,-1.09401,0.723475,0.462694,-0.353756,-0.382932,0.306074,-0.192697,-0.181902,-0.276593,0.328131,-0.248856,0.161297,-0.152966,0.716579,0.0348536,0.121329,-0.0740981,0.937089,-0.286409,-0.0241543,-0.153867,-0.436352,-0.00128607,-0.209615,-0.705865,-0.0953006,-0.769584,0.300883,-0.412853,0.0266441,-0.00839716,-0.187118,0.126572,-0.0673689,-0.0367152,0.155658,0.203777,0.518665,0.296887,-0.0737264,-0.0484274,0.353288,0.274422,-0.214407,-0.630332,1.11997,0.917566,-0.255638,-0.0875992,0.189696,-0.0256229,0.383751,0.596382,-0.387597,0.526163,0.197724,-0.698206,-0.184894,0.56085,-0.464685,-0.153331,0.201847,0.138896,0.0827489,-0.302822,0.423132,-0.732138,-0.479662,0.0236705,-0.649485,0.913112,-0.192987,0.0640069,-0.330113,-0.124353,0.42445,-0.87245,-0.675006,-0.313314,0.317943,0.0352911,-0.649447,0.0871307,0.510165,0.721182,-0.501808,-1.35354,-0.589788,0.565653,-0.0910947,0.00880025,0.516741,0.780362,0.301459,0.34365,-0.310777,-0.0775476,0.355043,0.238833,1.14297,0.0876009,-0.284878,0.333759,0.13814,0.151162,0.0161197,-0.458836,0.365727,0.587226,-0.412296,-0.370274,-0.446706,0.149512,-0.344914,-0.437251,0.17132,0.612119,-0.352405,0.579316,-0.181061,-0.000512076,0.485712,-0.21935,-0.356043,0.326133,0.0850122,-0.413809,0.0245648,-0.655158,-0.0663588,-0.625865,0.475915,0.708158,0.0915218,-0.129246,-0.0492446,-0.365645,-0.279736,-0.149123,0.0536435,-0.236861,0.496935,0.254012,-0.824241,0.543218,-0.0603018,0.23852,0.578241,-0.338813,-0.209548,-0.396287,0.0729405,0.446139,-0.112037,0.107361,0.962404,0.464846,0.10427,-0.154748,-0.119855,0.286791,0.140603,0.634705,-0.033286,-0.0693279,0.658812,-0.0681853,0.0343938,-0.241566,0.0527563,-0.015507,0.167511,0.429367,-0.0832989,0.580251,0.604577,-0.384304,-1.10738,0.422613,-0.116761,-0.168642,0.318117,0.446349,0.542434,-0.364432,-0.551718,-0.395446,-0.43353,-0.409512,0.08907,0.0311575,-0.630508,0.129712,-0.690363,0.0730026,-0.0334266,-0.219289,0.365941,0.548659,0.126057,0.366767,0.480814,-0.103354,-0.0988976,-0.0449647,-0.124628,0.173333,-0.36303,0.0345945,0.167248,0.106312,-0.259,0.720795,0.119658,0.401752,0.619424,0.0597776,0.219566,-0.0810904,-0.799392,0.571305,0.583394,0.435385,-0.0773452,0.0215583,0.121179,-0.396918,-0.340203,0.120985,-0.218449,0.44327,0.0152318,-0.040199,0.203077,0.313941,-0.589917,0.12481,0.0332678,0.16238,0.318665,0.402964,0.564504,-1.56571 +3373.84,0.943528,0.0848144,4,1.55415,0.648814,-2.2992,0.78822,0.495599,-0.0501924,-0.10987,-0.31181,-0.469486,0.132738,-0.18943,-0.231348,0.100749,0.218016,0.18902,0.401293,0.226265,-0.464415,-0.407672,-0.174259,-0.102707,-0.93235,-1.54495,0.417053,-0.489062,-0.316057,-0.000770546,-0.350775,-1.05197,0.122001,1.06465,-0.680161,0.033451,-0.0658445,-0.0596835,0.26734,-0.106303,1.28474,1.20041,-0.0544122,1.30514,1.03726,0.581551,-0.773117,-0.251211,-0.277609,-0.430252,0.248227,0.259607,-0.28182,0.0978134,0.846908,-0.122966,-1.10727,0.784415,0.131381,0.125415,-0.860027,0.363545,-0.377038,0.286807,0.936747,-0.0479135,-1.405,0.672699,0.140271,-0.0507272,-0.581807,0.25183,-0.26475,-0.139203,-0.280085,0.341357,-0.469877,0.424468,0.596337,0.491735,0.323062,-0.444456,-0.272922,0.853963,0.182312,-0.0421225,0.149037,-0.0778053,-0.497644,-0.346162,-0.526678,0.136922,-0.748588,0.0945751,0.0423905,0.338961,0.0370799,-0.288406,0.272913,-0.26665,0.0201302,0.151375,0.185279,0.404715,0.624118,0.106719,-0.0134783,0.311952,-0.104769,-0.563166,-0.0627265,0.873677,0.352438,0.035419,-0.134461,0.0487186,0.230016,0.526355,0.0271683,0.197558,0.382657,0.268504,-0.666246,-0.22641,0.711791,-0.348605,-0.612397,0.179632,-0.0263096,0.343582,-0.903053,0.369949,-0.494146,-0.12747,-0.0738873,-0.465882,0.918343,-0.54707,-0.349538,-0.524415,-0.139038,0.352126,-0.633055,0.170839,-0.290827,-0.149316,-0.333007,-0.438123,-0.0851506,0.00327482,-0.0445945,-0.637696,-0.484495,-0.965263,0.151385,0.0693087,0.244152,0.237887,0.304799,-0.212248,0.951989,-0.0849884,-0.0922739,0.163659,-0.27658,1.07591,-0.220553,0.309659,0.668341,0.112503,0.132593,0.016664,-0.417661,0.515374,0.474386,-0.0665617,-0.571938,0.0784474,-0.350905,-0.556707,-0.380012,0.0962674,1.12198,-0.377907,0.193225,0.328884,0.120081,0.143042,-0.398947,-0.36953,-0.322658,0.224775,-0.373348,-0.161285,-0.143437,-0.317698,-0.448123,0.0570509,0.650961,0.392645,-0.300896,-0.484799,-0.436749,-0.0383045,-0.00544819,0.507813,-0.315975,0.941835,0.60676,-0.494303,0.384402,-0.207276,0.632242,0.468584,-0.277785,-0.0465439,-0.246708,-0.21432,-0.320984,0.294505,-0.0782358,0.966061,0.951372,-0.193725,-0.499582,0.434828,0.535251,0.264627,0.707976,-0.349263,-0.188005,0.317077,0.38406,-0.308655,-0.212246,-0.785852,0.226475,-0.095653,0.264386,-0.235382,0.767521,0.54091,-0.332883,-0.476598,-0.325745,-0.354507,-0.221672,0.303409,0.548005,0.424918,-0.208301,-0.701352,-0.464539,-0.512307,-0.263463,0.0984798,-0.124228,-0.319993,0.175981,-0.721357,-0.164632,-0.274389,0.0419238,0.032485,0.278944,0.0606911,0.2374,0.950387,-0.493281,-0.021113,-0.375205,-0.00792872,0.194999,-0.559376,-0.547605,0.222308,0.416486,-0.285454,0.332437,0.090459,-0.0188181,0.426064,0.600858,0.520781,-0.351296,-0.394037,0.21029,0.401609,0.275413,0.0958286,-0.205124,0.248739,-0.60706,-0.182079,0.471799,-0.452439,0.03546,0.479457,-0.0921298,0.204786,0.720202,-0.577933,-0.261462,-0.0817056,0.173471,0.41975,0.416499,0.647881,-0.765133 +3411.19,0.901241,0.0848144,4,1.52201,0.773668,-2.01084,0.798133,0.633695,-0.107644,-0.0891398,-0.234356,0.320058,-0.107517,0.0997941,-0.16988,-0.10125,0.241943,-0.265742,0.102815,-0.201758,-0.117207,-0.36471,-0.244699,0.0283784,-1.02647,-1.5822,0.412492,-0.576369,-0.18014,-0.181342,-0.542092,-1.02334,0.283375,0.885285,-0.52122,-0.361713,0.0273625,-0.435488,-0.00987661,-0.0197008,0.750611,1.19754,-0.449405,1.14537,0.768208,0.558817,-0.841276,-0.42109,0.33319,-0.67869,0.741173,-0.0502796,-0.128084,0.258124,1.56376,0.345721,0.00770517,0.365234,-0.0882671,-0.0374825,-0.799455,0.428791,-0.111336,-0.0233373,0.968473,-0.550658,-0.941917,0.00841786,-0.318238,-0.0475493,0.0422234,0.321805,-0.240992,0.435465,-0.0262297,0.512699,-0.307829,1.1456,0.517533,0.918498,0.510998,-0.198871,0.106067,-0.0626962,0.0717476,-0.0819911,0.577341,-0.384381,0.176517,-0.0248796,-0.575807,0.164522,-0.171051,0.193145,0.0587802,0.115469,0.493568,-0.115467,0.145441,0.36931,-0.441644,-0.199481,0.00685577,-0.362484,0.124171,-0.452403,-0.328715,0.00100244,0.0725507,0.305984,-0.403479,0.900047,0.311723,-0.301565,-0.00548982,-0.251075,0.279109,0.0893886,-0.313098,-0.531383,0.0154927,0.812909,0.114761,-0.652325,0.323822,-0.285933,-0.192339,-0.310962,0.367593,-0.290658,0.430709,0.148758,-0.42947,-0.0165563,0.0730919,-0.751803,0.429184,-0.0290745,-0.149003,-0.181201,0.160446,0.276703,-0.803124,-0.423124,-0.196805,0.176484,-0.536477,0.545834,-0.321515,0.214582,0.14728,-0.509864,-0.402214,-0.39267,0.432708,0.18559,-0.530948,-0.0949282,-0.0705426,0.161972,0.0685315,-0.0934131,-0.100556,0.394892,0.0269212,0.809423,-0.356308,0.151906,0.410777,0.101303,-0.24168,-0.066373,-0.443782,-0.100821,-0.26314,-0.437359,-0.539555,0.178946,-0.460362,-0.220437,-0.173867,0.10514,0.687529,0.412526,0.00471197,0.282943,-0.219103,-0.492216,-0.127542,-0.543124,-0.131904,-0.283607,-0.82592,-0.177955,-0.0905844,0.542734,-0.554168,0.248229,0.427809,-0.0656217,-0.293749,0.00843751,-0.375517,-0.304176,-0.25939,0.516701,-0.0705063,0.689944,0.257545,-0.618002,0.90626,-0.500692,0.404681,0.272342,-0.250667,-0.139016,-0.396516,-0.243306,0.122497,-0.0695326,0.080535,0.262306,-0.031706,0.0539726,0.349358,0.279666,0.804305,-0.507364,0.848825,0.437392,-0.262858,0.389774,-0.0413874,-0.0306471,-0.11022,-0.575351,0.191063,0.335021,0.553876,0.421281,0.0434669,0.896232,-0.387993,-0.421867,0.203913,-0.249896,-0.182878,0.268759,-0.0653729,0.655273,0.517797,-0.670817,-0.387954,-0.314359,-0.466685,0.401988,-0.157271,0.337583,0.443196,-0.509246,0.776602,0.0393633,-0.186386,0.130863,0.430771,-0.47754,0.479725,0.58064,-0.377853,-0.152796,0.0904901,0.195174,0.496737,-0.0684224,-0.351066,-0.620779,0.17029,-0.313605,0.490009,0.0172704,-0.195551,0.121972,0.0320861,0.0431024,-0.0847755,-0.524302,0.219391,0.344875,0.662258,-0.596799,0.624778,0.142527,0.0323705,-0.223405,-0.255293,-0.32224,0.155939,-0.101404,-0.340515,0.41566,0.177535,-0.921413,-0.41579,-0.0500202,0.136925,0.35879,0.370033,0.598991,-1.62301 +3404.7,0.949589,0.0848144,5,1.55918,0.652143,-2.3135,0.929271,0.867358,-0.130358,0.0994476,0.0805404,-0.0243358,-0.13488,-0.138779,-0.349509,-0.0617181,0.261722,-0.0649194,0.0575649,-0.112685,0.0945138,-0.478996,-0.0355767,-0.407977,-1.06037,-1.47673,0.530833,-0.410203,-0.162674,-0.315312,0.0834564,-0.726682,0.498936,0.667246,-0.149892,-0.160471,-0.201446,-0.524207,-0.00369471,-0.0459066,0.762047,0.603069,-0.651109,1.04156,1.34165,0.441388,-0.580758,-0.246011,-0.0814419,-0.835582,0.197045,0.027348,-0.220203,0.0702055,1.03824,0.373652,0.327154,0.263474,-0.29087,-0.490789,-0.830648,0.439516,-0.621286,0.0299318,1.00993,-0.626229,-0.519606,-0.234623,-0.458165,0.0847037,0.0522217,0.126484,0.075713,0.352921,-0.34813,0.713828,-0.206491,0.658031,0.938545,0.600178,0.337279,-0.302303,-0.190451,-0.0589779,-0.217062,0.117622,0.386981,-0.404678,0.212142,0.231872,-0.446293,0.179572,-0.289679,0.133519,-0.500641,0.34514,0.649774,-0.199056,0.0488423,0.200259,-0.380531,-0.239095,0.464533,0.0988721,0.436806,-0.121926,-0.0119383,-0.347451,-0.608597,0.442918,-0.162395,0.763614,0.356754,-0.879156,0.195194,0.158975,0.254002,0.156536,-0.0131019,-0.620748,-0.0848823,0.357202,0.191372,-0.333402,-0.116933,-0.258838,0.278802,-0.431428,-0.0746444,-0.0113528,0.0307316,0.269871,-0.51043,-0.0302029,0.0217323,-0.588425,0.704486,0.146861,-0.08097,-0.0348783,-0.148961,0.682872,-0.706884,0.189708,-0.0637692,0.117169,-0.38086,0.378084,-0.376774,-0.0421472,0.382867,-0.286302,-0.338619,0.052113,0.3843,0.143287,-0.476996,0.0276237,-0.318075,0.199852,0.349344,0.122615,-0.672714,0.0217005,-0.101975,0.80831,-0.560377,0.178337,-0.107264,-0.0849875,-0.198457,-0.414832,-0.636345,0.0336417,-0.0599903,-0.0436522,-0.253597,-0.242013,-0.361878,-0.253724,0.0444882,0.43847,0.704961,0.139849,-0.171322,0.194421,-0.173614,-0.448902,-0.310735,-1.08747,-0.411493,-0.0458574,-0.485309,0.202379,-0.406115,0.403084,-0.287846,-0.220592,0.822179,0.29272,-0.148964,-0.172671,-0.14148,-0.159421,-0.308385,0.366318,0.0978353,0.470431,-0.0551835,-0.570156,0.940075,-0.148662,0.704709,0.335238,-0.46607,-0.114887,0.221522,-0.183375,-0.137725,0.0263449,-0.219001,0.225711,-0.186309,0.285655,0.343081,-0.459583,0.48409,-0.460216,0.741931,-0.134263,-0.35537,0.275478,-0.0755584,-0.564689,-0.087017,-0.422261,-0.186928,0.0112216,0.274438,0.502227,0.304453,1.1232,0.0449068,-0.0961834,0.306682,-0.640727,-0.302992,0.52471,0.128785,0.54258,0.227108,-0.534936,-0.0450565,-0.346776,-0.203472,0.467788,-0.1578,0.778683,0.466038,-0.151247,0.151773,0.174806,-0.28381,0.157867,0.552885,-0.118446,0.224619,0.101864,0.0504156,-0.136443,-0.17994,-0.559213,0.607433,-0.0988882,0.00347267,-0.34074,0.318413,0.0613779,0.580124,0.348834,-0.0853828,0.480214,0.326365,0.46547,0.376645,-0.125274,0.297186,0.391638,0.721825,0.101598,0.624794,-0.166057,-0.0712706,0.16511,0.182349,-0.0374583,0.229022,-0.0415848,-0.578812,0.621604,0.0454147,-0.919155,-0.0284138,-0.0648387,0.146069,0.378413,0.38219,0.615153,-2.10636 +3426.51,0.999378,0.0848144,4,1.54591,0.745947,-1.6073,0.65936,0.930113,-0.234945,-0.0546339,0.261203,-0.506576,-0.525859,0.285405,-0.382633,-0.102418,0.130764,-0.286396,0.205391,-0.181663,-0.168137,-0.551206,-0.124792,0.167961,-0.931029,-1.32186,0.351458,-0.17205,-0.312131,-0.606432,0.25171,-0.506864,0.125812,0.591536,-0.296508,0.376703,0.303442,-0.320493,0.0442985,0.211701,0.94628,0.907178,-0.0297141,0.955355,0.82086,0.380345,-0.758114,-0.443532,0.353703,-0.346164,0.214168,0.170603,-0.101651,0.218679,0.46754,-0.00591175,0.106228,0.319834,-0.846875,0.00223751,-0.546294,0.545012,-0.651295,0.160313,0.881216,-0.205112,-0.390127,0.122877,-0.274803,-0.326426,-0.0741564,0.586179,0.0471876,0.463857,0.0730892,0.412973,0.241717,0.739662,0.420594,0.432358,0.446076,-0.162114,0.0156075,0.53471,-0.528459,-0.0489578,-0.0142769,0.10669,-0.288325,-0.225481,0.0211556,-0.280045,-0.199306,0.0446594,0.0288054,0.5747,0.0352256,-0.167478,-0.0381895,0.0384577,-0.169199,0.436082,0.226876,0.0855146,0.166766,-0.458243,0.13498,0.0796387,-0.292945,0.316166,0.042042,0.459897,0.596646,-0.475456,0.200288,0.221805,0.574516,-0.278165,0.0570444,-0.370985,0.400789,0.310236,-0.154993,-0.870938,0.136279,-0.422617,-0.11787,-0.426246,0.0358333,0.0584578,0.145999,0.063072,-0.29253,0.434682,-0.200555,-0.360097,1.16378,0.0778687,-0.162902,0.549371,-0.0837645,0.413264,-0.385044,0.23343,-0.0874127,0.116135,-0.517797,-0.0102282,0.256465,-0.38467,0.0260957,0.042554,-0.359583,-0.123885,0.186397,0.294035,-0.0906559,0.15966,0.223562,0.481186,-0.20685,-0.230508,-0.793746,-0.142691,-0.775077,1.21004,-0.0352394,-0.480896,-0.33524,0.126287,0.451264,-0.395943,-0.149024,0.052569,-0.0905652,-0.199698,0.177507,0.126992,-0.445451,-0.423962,0.53318,0.675193,0.707648,0.197047,-0.0432257,0.271146,0.0770973,-0.59532,0.302843,-0.812535,-0.2447,0.05734,-0.61787,-0.0988043,-0.0587672,0.0540444,-0.0600102,0.14871,0.569213,-0.338813,-0.469339,-0.0827259,0.0309619,0.180513,-0.305012,0.538814,0.171433,0.368661,-0.15419,-0.290285,1.26588,-0.218946,0.6957,0.123444,-0.277036,0.123364,0.295803,0.121588,0.164609,-0.397019,0.00144268,-0.170745,-0.600262,-0.0621415,0.421511,0.125856,0.242327,-0.783871,0.281938,-0.0653184,-0.346915,0.447991,0.288111,-0.164558,0.0668342,0.0906968,0.132129,-0.335633,0.210114,0.0930308,0.189127,0.259921,0.383823,-0.116939,-0.286492,0.559621,0.0952527,0.428038,0.576774,0.825511,-0.00803624,-0.261126,0.0864455,-0.416584,-0.0286294,0.567324,-0.402103,0.132468,0.433344,-0.199169,0.719012,0.41414,-0.00408499,0.235791,0.187774,-0.115929,0.0854405,0.0995493,-0.0614808,0.352874,-0.467868,-0.189427,0.322267,-0.117414,-0.050145,-1.01179,-0.05024,-0.23299,0.112938,0.043722,-0.206372,0.544832,0.0588672,0.226282,0.145866,-0.204481,0.352255,0.324671,0.287611,0.281008,0.343643,-0.0506104,-0.0967692,0.155526,0.724268,0.0360196,-0.0822985,-0.269658,-0.617396,0.0552857,-0.117613,-0.446338,-0.502874,-0.197624,0.124837,0.201778,0.353323,0.449197,-2.58274 +3429.36,0.988759,0.0848144,5,1.68718,0.877187,-0.795763,0.262049,0.473945,-0.0253862,-0.376052,-0.0557064,0.229156,0.372874,-0.0252053,-0.106585,-0.250074,0.36617,-0.151426,0.371845,-0.49827,-0.0269502,0.181103,-0.153718,-0.419718,-1.2179,-0.209503,0.143681,-0.389642,-0.393563,-0.121408,0.326558,-0.693244,0.152265,0.836703,-0.964917,-0.748029,0.306667,-0.318167,-0.396029,-0.58831,0.145486,-0.100278,-0.837562,1.07585,0.58408,-0.03852,-0.327354,-0.448087,-0.0217225,-0.0915199,0.0142625,0.440135,-0.152465,0.234118,0.286,0.372273,-0.93837,0.824366,0.137017,-0.457168,-0.720004,0.238084,-0.436386,0.0675516,0.73684,-0.830474,-0.881299,-0.137774,0.752449,0.0592155,-0.269043,-0.267277,-0.875037,-0.720224,0.320785,0.416888,-0.223068,0.870377,0.853482,-0.04983,-0.356,-0.315621,0.323854,0.804672,0.0925549,0.2721,-0.0603096,-0.0583616,0.156249,-0.00583539,0.234335,0.14,-0.254972,-0.0810846,-0.104234,-0.40798,-0.0318627,0.20958,-0.295105,0.0612389,0.207356,-0.0769242,-0.0824808,-0.0633859,0.0822905,-0.591996,-0.0777002,0.0687661,-0.556438,-0.0442537,-0.624153,0.367218,-0.0952419,0.241065,-0.517342,-0.0424315,0.0746765,0.209439,0.14854,-0.129015,-0.179149,0.507056,-0.314164,-0.364403,-0.456677,-0.192,0.130897,0.201356,-0.0151024,0.752728,-0.0517056,0.370662,-0.10459,-0.451582,-0.0224962,0.0319186,0.0962323,0.230658,0.253624,-0.0821791,0.0835888,0.50556,-0.501051,-1.06323,-0.0765123,0.0464893,0.0144019,0.283437,-0.253048,0.180884,0.186523,-0.0978262,0.200441,-0.180574,0.24668,0.203513,-0.178989,0.204978,-0.0352941,-0.219393,0.745861,0.0690926,0.20781,0.666656,0.275605,0.822965,-0.292596,-0.130755,0.255278,-0.262602,-0.671791,0.218034,0.177418,0.0151592,0.131087,-0.144286,-0.234963,-0.0456392,0.0292175,-0.0410538,-0.719839,-0.0636641,0.486221,0.020402,-0.403924,0.123018,0.175856,0.153879,-0.266018,0.36809,0.00535179,0.295482,-0.451821,-0.186178,0.00546215,0.228527,-0.698976,-0.057718,-0.66556,0.494,-0.239767,-0.434236,0.0646996,-0.388803,-0.54437,0.380031,0.37358,-0.310966,0.498919,-0.642731,0.784682,0.183224,-0.0219081,0.000939533,-0.116477,0.147523,-0.208256,-0.264385,0.515774,0.109974,-0.147971,0.0430565,0.0173202,-0.681643,-0.155724,-0.316663,-0.252937,0.343188,0.325574,-0.447021,-0.276484,-0.181539,-0.430552,0.407944,-0.0420016,-0.230348,-0.118216,-0.413144,0.677103,-0.343875,-0.131518,0.690452,-0.584813,-0.229778,0.0241988,-0.301834,-0.336389,0.622596,-0.322603,-0.112889,0.182881,0.247454,-0.741066,0.274625,-0.852345,0.512953,0.333244,-0.459813,-0.0411445,0.048681,-0.103768,-0.107793,0.0476617,-0.0864082,0.591647,0.174575,-0.0968518,0.478741,-0.0714419,-0.119102,0.346872,0.521809,-0.127276,-0.119575,-0.00889017,0.382723,-0.0820066,-0.0640073,-0.0145248,-0.195207,-0.38417,0.0103656,-0.21738,-0.0191308,-0.394837,-0.215952,-0.707389,-0.0961358,0.383998,-0.494768,0.18788,0.100477,0.239635,-0.197407,-0.292623,0.200712,0.385881,0.251774,0.143905,0.132818,0.112319,-0.0721716,0.250083,0.02421,0.127725,0.234451,0.357386,0.484202,-1.2611 +3420.51,0.916722,0.0848144,4,1.57747,0.973552,-0.593082,0.164062,-0.0125281,-0.0797042,-0.30924,-0.0331544,0.191473,0.056078,-0.532231,0.17292,0.058318,0.5177,-0.230203,1.27961,0.0526237,0.0830733,-0.103136,0.306416,-0.336118,-0.630523,-0.852316,0.13296,0.284059,-0.190419,-0.344632,0.0497024,-0.0506303,0.000116415,1.19253,0.0100537,0.66268,-0.158596,-0.385196,-0.102584,-0.515071,1.11125,0.482016,-0.209255,1.01147,0.400503,0.072869,-0.677961,-0.311001,-0.599174,-0.999914,0.273006,0.234426,-0.0258622,0.52672,-0.0925935,-0.0308303,0.117175,0.766392,-0.307113,0.0807527,-0.990652,0.575603,-0.48007,0.178264,0.792511,-0.658882,-0.70614,-0.0945958,0.293693,0.138119,0.394514,0.264579,0.394439,0.253097,-0.00606967,0.315932,0.234137,-0.166576,0.316745,0.260314,-0.00634058,-0.234793,0.0343038,0.0106085,-1.05192,-0.0763653,-0.278404,-0.494899,0.044971,0.0187333,-0.181414,-0.239287,-0.7663,0.351924,-0.0468062,0.550444,-0.266116,0.232247,-0.0955013,-0.363378,-0.24277,0.228047,0.203318,0.181579,-0.101654,-0.354225,-0.25768,-0.0904504,-0.0658175,0.357708,0.317889,0.114384,0.588961,0.0688971,-0.0634618,0.237499,0.221762,-0.289489,-0.0262733,-0.141628,0.147535,-0.0890037,-0.27817,-0.823515,0.350315,-0.24434,-0.280407,0.391602,0.314573,-0.345235,0.231877,0.100933,-1.10723,0.4967,-0.302785,-0.121781,0.573232,-0.270947,-0.643911,-0.320028,-0.255293,0.416341,-0.338892,0.000407393,-0.0744824,-0.275808,-0.358619,0.0930026,0.42334,-0.300704,0.194825,-0.574107,-0.440131,-0.231503,-0.0659722,-0.0652033,0.178246,0.0731704,0.0182439,0.308889,-0.922986,-0.303197,-0.469774,-0.167284,-0.713109,0.260935,0.0489289,0.0463627,-0.251918,0.299073,0.0657676,-0.683185,-0.360376,0.0487761,-0.544351,-0.290296,-0.595042,-0.0104869,0.278161,-0.443247,0.311529,0.212658,0.934948,-0.11667,0.290409,0.165844,-0.125827,0.0703522,-0.165073,-0.827276,-0.335896,-0.437342,0.197572,-0.0834823,0.32232,-0.374796,-0.158902,-0.15736,0.601089,-0.608338,-0.109254,-0.344806,0.0306082,0.164537,0.0602886,0.0238237,-0.0867473,0.26309,-0.385311,-0.403239,0.566213,-0.0454496,0.0811525,0.182151,-0.0581892,0.377604,0.245111,-0.343691,-0.0979141,-0.328375,0.120431,0.288408,-0.208068,0.203656,-0.456901,0.687019,0.27975,-0.739988,0.560875,-0.225805,-0.357247,0.234823,-0.0227932,-0.719172,-0.199079,-0.120798,-0.320063,0.313304,0.104269,0.53539,0.118992,0.363524,0.323436,-0.212879,-0.0991692,0.696596,0.167823,-0.35573,0.602131,0.884104,-0.335606,-0.874576,-0.0717298,-0.144135,-0.818157,0.498531,-0.891291,-0.564645,0.303745,-0.333758,-0.0608483,-0.0416494,-0.0923222,0.0865671,0.108891,0.230297,0.146011,-0.129331,-0.00561433,-0.343692,-0.168587,-0.538647,0.19684,-0.125773,-0.272251,-0.390798,-0.349661,-0.195154,0.35742,-0.0465488,0.463321,0.438517,0.0520933,-0.183021,0.589916,-0.181548,0.567932,0.300544,-0.075984,-0.437183,0.393312,-0.219907,-0.516845,-0.148255,0.271984,0.0257153,0.0336449,-0.453047,-0.582275,0.263642,-0.230391,-0.108426,-0.361802,0.190844,0.139882,0.2431,0.374008,0.493052,0.0738204 +3394.79,0.469654,0.0848144,4,1.54807,1.13352,-0.330287,0.0859871,-0.0435483,-0.0430084,0.0530874,0.201624,0.0225642,-0.0729977,-0.286735,0.376204,0.492105,0.52427,0.0372592,1.22362,-0.145436,-0.0875254,-0.213613,0.123895,-0.433011,-0.75983,-1.31757,-0.0717687,0.177513,-0.461357,0.04972,-0.00492959,0.0730273,0.00832904,1.13746,-0.279501,0.477205,-0.435706,-0.482456,-0.148103,-0.376378,0.43444,0.252451,-0.355288,1.10735,0.0938267,0.143653,-0.855693,-0.359004,-0.575227,-0.624543,0.221433,0.0443596,0.0831167,0.657578,-0.221974,0.325998,-0.499601,0.803174,-0.212946,0.222841,-1.33331,0.153751,-0.382532,0.3626,0.90651,-0.61084,-0.0572698,0.196313,0.0910981,0.353385,0.430681,0.00481147,-0.0632787,0.0517572,-0.089346,0.40284,0.146331,-0.160303,0.393613,0.461791,0.189602,-0.456094,-0.0031059,0.17634,-1.31389,0.106343,0.0611863,-0.521125,-0.0215179,0.40801,-0.196553,0.107018,-0.587132,-0.0300037,0.134922,0.806739,-0.411513,0.0264983,-0.100404,-0.519883,-0.024216,0.252333,0.0973707,0.166803,-0.259935,-0.174633,-0.302727,0.0314735,-0.0219953,0.275737,0.144473,-0.0924439,0.358996,-0.11,-0.248427,-0.0280803,0.109822,-0.101343,-0.335656,0.168289,-0.218115,-0.425105,-0.274245,-0.588726,0.0731749,-0.169742,-0.234197,-0.18409,0.528369,-0.287217,0.0557836,0.000355667,-0.569202,0.378038,-0.399691,0.0110935,0.412588,-0.0647242,-0.45589,0.0648735,0.0595073,0.279254,-0.095342,0.15819,0.0486027,-0.250252,-0.814762,-0.0697312,0.3376,-0.0416382,0.388075,-0.274602,-0.216391,-0.465207,0.0202599,-0.106346,0.429169,-0.232288,0.107328,0.355543,-0.646715,-0.0594802,-0.185684,-0.0689797,-0.502548,0.00885569,-0.0712015,0.160778,0.0378082,0.408609,-0.115404,-0.240111,-0.326682,0.0328027,-0.646486,-0.172178,-0.378007,-0.121167,0.257766,-0.586953,-0.318248,0.301501,0.884488,-0.0550674,0.0551045,0.190843,-0.0494595,-0.374041,-0.297757,-0.391255,0.103492,-0.612289,-0.170506,0.000605052,0.205188,-0.201418,-0.359108,-0.274237,0.518944,-0.24276,-0.250767,-0.506659,-0.0922684,0.247196,-0.598304,0.141178,0.0813812,0.0759461,0.013432,-0.44678,0.363155,-0.74975,0.388551,0.458055,0.385469,-0.127375,-0.272797,-0.428735,0.380842,-0.43626,0.432118,0.538219,-0.242422,0.124189,-0.399055,0.62701,0.548102,-0.549592,0.906774,-0.310753,-0.626281,0.664556,-0.12553,-0.515611,-0.210129,-0.216803,-0.177887,0.213504,0.378967,0.205267,0.0283947,0.535231,0.275615,0.192361,-0.668463,0.276019,-0.219933,-0.100796,0.453509,0.529928,-0.547223,-0.83366,-0.0763734,-0.176038,-0.52759,0.787933,-0.872727,-0.274084,0.432929,-0.272393,-0.188851,-0.106128,-0.11612,0.0197391,0.528107,0.253892,0.0294779,-0.381843,0.22838,-0.613226,-0.213597,-0.712963,0.219969,-0.193231,-0.395754,-0.1746,-0.247306,-0.00190504,0.650453,-0.20564,0.423776,0.905371,0.0235152,-0.200095,0.41222,-0.0466908,0.231237,0.196741,-0.326149,-0.658021,0.472492,0.21873,-0.306362,-0.377912,0.620341,0.210844,0.173755,-0.324836,-0.337625,0.210646,0.0299743,0.294769,-0.265124,-0.00472301,0.139486,0.260689,0.373478,0.510577,-0.208631 +3408.57,0.996351,0.0848144,5,1.63919,0.768676,-0.244767,0.0777635,0.14899,-0.0747216,0.269646,0.220034,0.726998,0.946952,0.051011,0.446806,-0.512184,0.851765,-0.0860068,0.982896,0.234789,0.301509,0.0756231,0.163216,0.311677,-0.567529,-0.672682,0.388739,-0.138361,0.102079,0.115345,0.392777,-0.394258,-0.223739,1.14583,-0.0165489,0.17137,0.0454818,-0.289112,-0.0594485,-0.380074,0.291736,-0.00927684,-0.37052,0.769163,-0.129499,0.200849,-0.935206,0.425919,-0.325373,-0.426108,-0.253852,0.0918702,0.112536,0.418223,-0.245999,-0.0244896,-0.302291,1.28961,0.452037,-0.146215,-0.61053,0.306577,0.209361,-0.288377,0.451692,-1.08959,-1.22966,-0.0437286,0.496939,-0.298208,0.0140596,0.286441,-0.404513,-0.435507,0.822297,0.214063,-0.108715,0.61403,0.751619,0.0215615,-0.55158,0.0794779,0.00541492,0.418627,0.00452718,0.498343,-0.525228,-0.107403,-0.166752,-0.212909,-0.444827,0.676596,-0.448463,0.264947,0.0343649,-0.227431,-0.115328,0.14789,0.0412201,0.337284,-0.205285,0.171476,0.278099,0.675779,0.218622,-0.474796,-0.58531,0.0879176,0.0298419,0.691345,0.394677,-0.14992,-0.0263944,0.0353551,0.0536813,-0.323349,0.0952755,-0.355028,0.0932766,0.0821843,0.440695,0.0637681,-0.0297986,-0.929383,-0.571761,0.00288437,-0.50299,-0.122776,-0.199277,0.047978,-0.226605,0.566209,-0.78591,0.491194,0.0449178,0.480195,0.347115,0.0881554,-0.334325,-0.0663023,-0.387865,0.271719,-0.839577,-0.30066,-0.114823,0.381016,0.0740998,0.147325,0.0287913,-0.0918956,0.315816,-0.452739,-0.274557,-0.531856,0.783089,0.0974514,0.0436897,0.312168,0.227831,-0.277709,-0.0183244,0.19638,0.251829,0.0253091,0.60344,0.36645,0.0734699,-0.198106,0.81218,0.316675,-0.230319,-0.253037,-0.000729667,-0.217249,-0.528066,-0.437991,-0.286527,-0.157297,-0.0845929,-0.213547,-0.029313,0.443507,0.753317,0.485885,-0.933636,0.563704,-0.252243,0.505486,-0.172729,-0.518313,-0.489036,0.118792,-0.349141,-0.17897,-0.202441,-0.209544,-0.344682,0.194072,0.0547453,0.000909228,-0.703859,-0.98946,-0.158379,-0.0378976,-0.348054,0.154555,-0.444268,-0.0931137,0.137518,0.373644,0.796498,-0.250505,-0.451949,0.474916,-0.00777568,-0.19638,0.463999,-0.439302,0.0363486,-0.219365,0.0964103,0.499769,-0.32887,0.435014,-0.227613,-0.369746,-0.37034,-0.0215315,0.472141,-0.190292,-0.83926,0.316329,-0.223863,0.266819,-0.241561,-0.844292,-0.570863,-0.420216,0.564932,0.0628337,-0.0965319,0.888304,-0.00370881,-0.717897,0.042064,0.0255975,0.22391,0.718794,-0.288182,0.288426,-0.494045,0.394647,-0.934084,0.358979,-1.05108,0.46406,-0.11474,-0.119578,0.157352,-0.759432,-0.0763558,0.103356,0.279452,-0.32246,-0.00293062,0.486027,0.679663,-0.127373,-0.113519,-0.0617417,-0.245965,0.106095,0.354901,-0.0291451,-0.253713,-0.703864,0.302414,0.416338,-0.3278,0.23626,-0.00812633,-0.108405,0.607148,-0.0537384,-0.291333,-0.618383,-0.317944,0.481348,0.0533607,-0.0686874,0.455771,0.0424101,0.116294,-0.220666,-0.220565,-0.498377,0.300506,-0.283527,-0.27531,0.0697736,0.0276686,0.428255,0.286253,-0.00711336,0.141563,0.257117,0.376248,0.507068,-0.14087 +3403.54,0.995594,0.0848144,4,1.47441,0.921693,-0.581233,0.183948,0.0462308,-0.000989805,0.0386943,0.241613,-0.376699,-0.251561,-0.315973,-0.0474345,0.140448,0.781406,0.0494547,1.18136,-0.0186202,-0.0357344,-0.00187435,-0.0589297,-0.196416,-0.304713,-0.186725,0.237515,0.28125,0.262965,0.184709,0.60684,0.192605,0.248625,0.853528,-0.524714,0.0397008,0.375369,-0.624105,-0.111247,-0.998382,-0.552689,0.569892,-0.0646953,0.860187,0.431379,0.0248355,-0.815814,-0.281382,0.364178,-0.12856,0.147417,0.867158,-0.0583737,0.366723,-0.174698,0.504828,-1.02874,0.806342,-0.663735,0.0626403,-0.739638,0.445521,-0.893229,0.57136,0.876829,-0.985565,-0.926682,0.0646749,0.0868516,0.0136352,-0.184323,0.428046,-0.191398,0.0296277,0.647333,0.664919,0.0497882,0.704602,0.871258,0.760461,0.206343,-0.0594073,-0.0374372,0.245494,-0.689918,0.127289,-0.308354,-0.411288,-0.326614,-0.16201,-0.215972,-0.0305035,-0.336555,0.288702,0.504108,0.328999,0.475583,0.0235467,-0.108442,1.03076,-0.356318,-0.396986,0.563087,0.0190876,-0.0799211,-0.319912,-0.151916,0.267376,-0.483167,0.074795,-0.780591,0.621059,0.820276,0.678636,-0.575112,-0.269071,0.419843,0.297964,0.147576,-0.575939,-0.362985,0.141433,0.12329,-0.297416,0.818646,0.0930386,0.184366,0.216409,0.320233,0.72328,0.373463,0.198858,-0.264634,0.337899,-0.213625,-0.536457,0.843956,0.27273,-0.243673,0.0232528,0.0414058,0.337535,-0.849268,-0.515292,0.347678,-0.0148195,-0.814426,0.133234,0.40206,-0.397072,0.811871,0.083667,0.372185,0.126606,-0.00665465,0.574463,0.0210738,0.433195,1.47883,0.380417,-0.0302163,0.118008,-0.0172805,0.592139,0.0923351,0.728302,-0.291462,-0.442308,0.0535252,-0.373557,-0.49081,-0.483887,0.300964,-0.105015,0.335801,0.0891804,0.293829,-0.430516,0.127309,-0.273327,-0.377158,0.0201592,0.967648,0.245595,0.558246,-0.137003,-0.103871,-0.0100231,0.390385,-0.0137271,0.146013,0.00441679,-0.0979316,-0.0840782,0.593703,0.0065037,-0.318423,0.137806,0.730421,0.62649,-0.132276,-0.240498,0.369353,0.273404,0.25003,0.0635314,0.234785,-0.443718,-0.0216121,-0.449631,0.983351,0.404539,0.775764,-0.029515,-0.184245,0.411479,-0.126408,0.082019,0.453896,-0.404955,0.273489,0.563698,-0.273044,-0.033191,-0.757714,0.183136,0.175768,-0.422029,0.332264,-0.506275,0.24948,-0.327372,0.206473,-0.0322341,-0.103435,0.0146379,0.0464061,-0.0582117,0.237749,0.358936,-0.0809212,0.5581,-0.624942,-0.0189591,0.247743,0.212702,0.230725,0.53727,0.33384,0.742007,0.360571,-0.85171,-0.322038,0.0876131,-0.71401,0.896119,-0.0600167,-0.200859,0.228564,0.0453917,-0.15391,-0.0548504,-0.0196503,0.29089,0.0641545,0.249297,-0.231826,0.688166,0.395091,-0.249778,0.135664,-0.193048,-0.0975632,-0.353682,-0.36617,-0.0981917,0.361238,-0.405667,0.151059,0.190688,0.729742,0.390389,0.0716416,-0.646579,-0.388735,-0.605945,-0.253832,-0.721353,0.493902,-0.514943,0.615275,0.194508,0.416918,-0.249806,0.198865,0.304289,0.118708,-0.354715,-0.607087,-0.138802,0.205659,-0.124479,-0.468154,0.00992408,0.154293,0.217368,0.392802,0.466227,-0.177387 +3405.94,0.998805,0.0848144,4,1.42987,0.954181,-0.476562,0.26749,-0.0468069,-0.0709131,0.18215,0.143064,-0.154993,-0.0420896,-0.0979601,-0.215241,0.117808,1.10918,-0.0772854,1.21052,0.124158,-0.339879,0.271386,0.184732,-0.0877186,-0.486262,-0.073876,0.0998513,0.187023,0.251345,0.30338,0.744496,0.179464,0.240957,1.05152,-0.576618,-0.240762,0.44369,-0.586368,0.0342791,-0.687679,-0.474717,0.57537,-0.343021,0.774105,0.402492,0.13901,-0.653796,0.0095325,0.37544,-0.356159,0.214904,0.890403,0.044514,0.253305,0.0677885,0.439183,-1.00274,0.595042,-0.647477,-0.0761112,-0.786363,0.392866,-0.891184,0.41371,0.891491,-1.04038,-0.693409,0.0254813,0.125172,0.113061,0.0262002,0.378254,-0.205761,0.105914,0.645267,0.546285,0.127038,0.63701,0.777064,0.640015,-0.0406817,-0.242004,0.113638,0.406412,-0.65426,0.0763363,-0.233711,-0.348311,-0.46563,-0.202704,-0.34701,-0.0228995,-0.450694,0.102663,0.403736,0.330622,0.256548,0.0133962,0.0756039,0.84484,-0.369962,-0.311622,0.569367,0.00686693,0.0358734,-0.426779,-0.143207,0.38928,-0.307844,0.151552,-0.740919,0.683353,0.762391,0.414126,-0.393175,-0.268434,0.324778,0.44903,0.0609919,-0.347255,-0.254762,0.158538,0.0229926,-0.275023,0.63274,-0.263557,0.336664,0.338679,0.293233,0.80613,0.348809,0.290478,-0.318807,0.280691,-0.287494,-0.376071,0.793341,0.435762,-0.547208,0.135483,-0.0425867,0.383998,-0.821688,-0.232224,0.403022,0.157036,-0.880593,0.188342,0.333909,-0.364662,0.93656,0.210144,0.506971,0.346297,-0.0317938,0.537667,-0.0508039,0.415011,1.21864,0.242294,0.0621489,0.166892,-0.228052,0.927852,0.223366,0.789749,-0.138741,-0.661633,0.0771261,-0.393948,-0.423336,-0.534117,0.247426,-0.0856201,0.349869,0.0383763,0.186654,-0.416807,0.0619744,-0.30922,-0.370542,0.174333,0.963706,0.32899,0.278281,0.0205173,-0.248145,0.251121,0.350556,-0.0277982,0.0366803,0.045664,-0.115499,-0.0575817,0.336165,-0.183076,-0.305195,0.223357,0.833472,0.542569,-0.109045,-0.256431,0.297859,0.31102,0.213419,-0.0314451,0.359129,-0.0244289,0.284977,-0.212971,1.08579,0.377452,0.676126,-0.0787635,-0.359159,0.497193,0.0177938,0.299154,0.443271,-0.613748,0.33084,0.410918,-0.173437,0.0302243,-0.519531,0.125811,-0.00458666,-0.43622,0.308227,-0.614412,0.123302,-0.208524,0.404953,-0.129702,-0.11608,-0.100216,0.0570569,-0.177991,0.130048,0.320042,0.00571561,0.449137,-0.618462,-0.00778213,0.443294,0.072914,0.316437,0.405437,0.541707,0.632576,0.330053,-0.782717,-0.321973,0.256682,-0.318514,0.815778,0.00384785,-0.436127,0.44152,0.0691268,-0.153871,-0.258253,-0.00884924,0.396401,0.33129,0.0417937,-0.449181,0.748115,0.196676,-0.263213,0.0296776,-0.0990688,-0.158091,-0.454887,-0.117016,0.0711109,0.448748,-0.332843,0.398354,0.241127,0.667773,0.513923,0.149149,-0.773971,-0.221128,-0.866927,-0.138461,-0.577191,0.281646,-0.470332,0.304733,0.336261,0.12263,-0.230536,0.154291,0.450133,0.15118,-0.324994,-0.515394,0.00377875,0.199321,-0.198115,-0.293013,0.0516194,0.14781,0.241424,0.38446,0.491349,-0.0872477 +3394.83,0.894823,0.0848144,4,1.44689,0.934338,-0.777538,0.299993,0.105336,-0.0583378,0.142035,0.194219,0.39506,0.355774,-0.0330969,0.00901297,0.228373,0.736527,-0.180267,1.20959,-0.082206,0.205196,-0.263519,-0.122825,-0.0599319,-0.73958,-0.520007,0.235864,-0.319869,0.071971,0.299514,0.688286,-0.221231,-0.169851,0.910999,-0.429113,-0.180124,0.557331,-0.717059,-0.0980357,-1.39661,-0.180943,0.117238,-0.30441,0.789884,0.571232,0.209694,-0.74029,-0.218977,-0.0491127,-0.217305,0.449035,0.661121,-0.190687,0.14028,0.222442,-0.0865675,0.0116843,0.577352,-0.254233,-0.315767,-0.772948,0.464907,-0.287328,0.257732,0.590276,-1.54864,-0.55036,0.611199,0.648348,0.525857,-0.294855,0.960873,-0.136647,-0.212577,-0.139587,0.38997,0.447647,0.108006,0.663576,0.18963,0.269599,-0.463455,-0.0195231,0.43449,-0.434237,0.574802,0.597289,-0.656513,0.245504,-0.063713,-0.340866,0.0353181,-0.478805,-0.140733,0.231532,0.0543309,0.0865075,0.19978,0.114736,0.579196,-0.19824,0.106656,0.476,0.105227,0.115364,-1.01812,-0.397391,0.589542,-0.495603,0.820493,-0.364596,0.122463,0.589633,0.551316,-0.452729,0.451261,0.289009,0.134676,0.16094,0.105504,0.290864,0.737794,-0.0816037,0.127561,0.0778402,-0.554029,0.30198,-0.0264263,0.412865,0.636152,0.462376,0.404787,-0.528368,0.296317,-0.194187,-0.191445,0.660239,0.278343,-0.694297,-0.0257968,0.34155,0.411266,-0.488622,-0.289393,0.184588,0.069429,-1.22265,-0.0710036,0.322784,-0.717338,0.836322,-0.247579,0.412564,0.17952,-0.188689,0.189274,0.229466,1.09058,1.21308,0.176677,-0.0623251,0.170724,0.483037,0.777116,0.386123,0.891128,0.608561,-0.445282,0.368174,-0.27002,-0.340901,-0.537553,0.664488,-0.148784,-0.00744389,-0.316347,0.08612,0.101972,-0.549478,-0.140198,-0.289127,0.788598,0.936294,-0.0859568,-0.853189,0.0403657,-0.0918066,0.269067,-0.0179426,-0.0358951,-0.126,0.330537,-0.00290917,-0.297409,0.549037,-0.135263,-0.139051,-0.06127,0.659649,0.0576578,-0.251659,-0.516265,-0.135775,0.198924,0.247864,0.103735,0.000882211,-0.139515,-0.166096,-1.04787,1.02462,0.905943,0.864145,-0.104758,0.214284,0.271849,-0.294902,0.425135,0.436358,-0.263942,0.570395,0.650336,-0.819821,-0.1998,-0.41482,-0.19826,0.0286873,-0.508034,0.259111,-0.140426,-0.171684,-0.108035,-0.191164,-0.250621,0.134658,0.31881,0.137027,-0.277088,0.590058,-0.19308,0.207128,0.703042,0.0347749,-0.768242,0.781326,0.106453,0.180352,0.407785,0.11762,0.631467,0.347577,0.736493,-0.316262,0.207378,-1.00283,1.04791,0.0473393,0.217425,0.315448,-0.279444,-0.173718,0.128086,0.0719485,0.240531,0.402319,0.175753,0.247581,-0.0173318,0.374503,0.26953,-0.078681,0.0589803,-0.447459,-0.118723,-0.361997,-0.607245,-0.447342,-0.251125,0.453356,0.224158,0.158519,0.448771,0.351151,-0.492915,-0.25399,-0.276668,-0.1321,-0.45581,0.0943936,-0.013026,-0.288558,0.618071,0.00512573,0.0904031,0.667216,0.311431,0.44002,-0.413935,0.359044,0.13789,-0.0804756,-0.45426,-0.293047,0.105737,0.208356,0.300285,0.456461,0.547983,-0.416055 +3405.83,0.815921,0.0848144,5,1.45688,0.817523,-1.40638,0.609284,-0.170695,-0.0155263,-0.0307237,0.190886,0.0976373,-0.0169532,-0.15056,-0.167511,-0.0820614,0.957973,-0.100687,1.37694,0.140294,-0.291969,-0.237292,0.248151,0.0979659,-0.634558,-0.59966,0.193942,-0.659437,0.0851744,0.0275217,0.650678,-0.350529,0.0272957,0.976014,-0.446731,-0.25915,0.412843,-0.651968,-0.271929,-1.10523,-0.38696,-0.154628,-0.238548,0.902444,0.760929,0.13452,-0.707702,-0.195434,0.327632,-0.649803,0.617593,0.557674,-0.197493,0.269814,0.142389,0.043521,0.10263,0.147937,-0.39126,-0.21374,-0.59234,0.084183,-0.223878,-0.101385,0.850314,-0.741982,-0.705634,0.0544147,0.55213,0.340744,-0.339228,0.119209,-0.290399,0.151511,0.415501,0.518012,0.211504,0.0805167,0.792237,0.501431,0.131504,-0.500014,-0.125407,0.521462,-0.57123,0.359211,0.649244,0.0905437,0.22865,-0.338877,-0.351113,0.027029,-0.412415,0.0752004,-0.0295752,0.46701,0.17583,0.517701,-0.512038,0.0973334,-0.0264186,0.435105,0.201164,0.331464,-0.00248031,-0.878451,-0.108961,0.182959,-0.436322,0.649227,-0.387532,0.780281,0.721324,0.912291,-0.273413,0.291024,0.402482,0.061731,0.215006,-0.154447,0.377725,0.114652,0.201867,-0.376208,0.284132,-0.419909,0.0652712,0.0550572,0.275489,0.63148,0.358709,0.214695,-0.772379,0.0974378,-0.398783,-0.121452,0.455422,0.152768,-0.469989,0.217373,0.310097,0.350014,-0.502966,-0.719848,0.0682617,-0.0784141,-1.16808,-0.173235,-0.172276,-0.719622,0.742935,-0.173495,0.312422,-0.184927,-0.0177487,0.420316,0.0387242,0.841998,0.872979,0.0780373,-0.0599445,-0.227386,-0.180301,0.55875,0.294284,0.897668,0.0669568,-0.752766,0.251031,-0.304647,-0.0414084,-0.208054,0.96815,0.0186232,-0.188269,-0.110699,-0.0712645,-0.035316,-0.326427,-0.447173,-0.226962,0.785072,0.575343,0.453827,-0.940372,0.234426,0.0100157,0.189015,-0.408828,-0.289218,-0.162942,0.315896,-0.189176,-0.0585866,0.306646,-0.461443,-0.100719,-0.267735,0.629935,0.288898,-0.745458,-0.387608,0.16512,0.175655,0.0979427,0.0225788,-0.17303,0.515996,-0.10905,-0.474214,0.993928,0.122451,0.54919,0.00184026,-0.0164219,0.130125,-0.209801,0.0282545,0.798283,-0.096708,0.565888,0.346796,-0.604089,-0.309513,-0.276877,0.236963,0.425037,-1.11296,0.526096,0.0844465,-0.266733,-0.290363,-0.284731,-0.821409,-0.00623356,-0.203201,0.113491,-0.0348267,0.32213,-0.51881,0.509321,0.679978,0.361656,-0.738393,0.59896,-0.72034,0.27333,0.316201,0.440171,0.611566,0.513099,0.0448891,-0.26737,0.45942,-0.825566,0.858551,-0.281405,-0.0114525,0.41959,-0.117021,0.00358792,0.145357,0.272246,0.588088,0.390211,0.494197,0.456136,0.140792,0.274877,0.0558336,0.178565,-0.325264,-0.520354,0.0020744,-0.295478,-0.633428,0.0810951,0.165439,0.395273,0.19225,-0.148196,0.266706,0.0341616,0.0292158,-0.428817,-0.667336,0.485135,-0.140778,-0.0106956,-0.103647,-0.226607,0.566204,-0.206528,-0.141565,0.423046,0.294201,0.185552,-0.766701,-0.0384776,-0.348361,-0.16123,0.228487,-0.229841,0.228298,0.155765,0.210908,0.394671,0.459247,0.743198 +3377.45,0.977033,0.0848144,4,1.49696,0.831281,-0.895783,0.381574,-0.100454,-0.0839963,-0.0588019,-0.226064,0.858086,0.210184,0.243119,0.0927706,0.0487311,0.746938,0.169741,0.827618,-0.0030666,0.448848,-0.222494,-0.316155,-0.149827,-0.718666,-0.318524,0.506435,0.0391809,-0.513983,0.453813,-0.289018,0.601534,-0.167895,1.106,-0.178514,0.208807,0.546891,-0.391308,0.2338,0.409284,0.511086,0.219718,-0.3479,0.88012,0.407879,0.680391,-0.961042,-0.228544,0.0415829,-0.623658,0.293022,0.66539,-0.56785,0.220703,0.297671,0.318836,-0.157558,0.653551,0.400948,-0.460177,-0.29648,0.587759,-0.366101,0.107619,0.901731,-1.43396,-0.210154,0.36194,0.955865,-0.678212,0.0356027,0.683623,-0.100315,-0.222049,0.226151,0.767029,-0.1197,0.418855,1.13185,0.253966,-0.109423,0.440479,0.0327577,0.620923,0.0387919,0.0855548,0.530766,0.404894,0.146424,-0.131441,0.0423229,0.489999,-0.403446,-0.0863202,0.174015,-0.385389,-0.7653,-0.171759,-0.442452,0.389981,-0.432124,-0.182193,0.387537,0.589156,-0.422547,0.0333192,-0.353556,0.49883,-0.750796,0.0572437,-0.240592,0.762203,0.385635,0.194884,-0.272124,-0.0112987,0.2454,-0.262226,-0.0210594,-0.806883,-0.538294,0.199605,-0.200498,-0.774437,0.27444,0.0441181,0.172446,0.423048,0.74846,-0.154406,0.372424,0.501509,-0.216051,0.292628,0.0721408,0.296026,0.314238,0.57228,0.595386,-0.422661,0.181428,0.771061,-0.836285,0.0346027,0.0184948,0.262845,-0.849027,-0.232765,0.723371,0.0769445,0.296869,-0.0757937,-0.0840636,-0.502441,0.03158,0.459734,-0.23692,-0.467394,1.27622,0.564422,0.10759,0.414726,0.353967,-0.551676,-0.411622,0.589787,0.421645,0.609285,-0.241772,-0.257698,0.0937463,-0.0552968,0.129867,-0.0323817,-0.154267,-0.116017,-0.170933,-0.49161,0.345303,-0.427165,-0.348868,1.03678,0.891413,0.271478,0.059617,-0.0555352,0.310828,-0.189793,-0.584381,-0.175125,-0.127829,0.500659,-0.430964,0.155873,-0.175404,0.0406529,-0.384378,0.0830074,0.547615,0.147285,-0.197864,-0.474026,-0.197822,-0.145202,-0.401512,0.402857,0.138064,-0.601361,-0.138976,-0.503226,0.865309,0.102689,0.148602,-0.10542,-0.772973,0.300087,0.375518,0.295131,0.617849,-0.538659,-0.0754291,0.452968,-0.121617,0.487667,-0.847164,-0.890664,-0.00852502,0.268438,0.095743,-0.52797,-0.531833,-0.413221,-0.328724,-0.706555,-0.028405,-0.0133356,-0.119807,-0.940289,0.19949,0.620107,0.253937,0.517132,0.523148,-0.185354,0.371497,-0.242729,0.203621,-0.176764,-0.0171274,0.449979,-0.182056,-0.217063,-0.336749,-0.00950048,-1.06107,0.480235,-0.903801,-0.019655,0.633598,-0.105203,0.276685,-0.0760823,-0.116071,-0.385511,0.588093,-0.115049,0.400178,-0.336227,0.854595,-0.122654,-0.49694,-0.609393,0.0126194,-0.13289,-0.915867,-0.0626195,0.558347,-0.461318,-0.478959,0.178519,0.0680796,-0.0832846,0.0197611,-0.361548,-0.283497,-0.34864,-0.80773,-0.162211,0.332025,-0.151208,0.797787,-0.166545,-0.62395,-0.14383,-0.513902,0.17625,0.0254981,-0.375209,-0.20133,0.0744087,-0.462782,0.131298,0.120825,-0.382192,0.208958,0.301741,0.45712,0.549309,0.490569 +3368.05,0.860622,0.0848144,5,1.2963,1.08442,-1.66058,0.737433,0.100402,-0.0827444,0.287018,0.703046,0.262836,0.104261,-0.100956,-0.031846,0.34481,0.427717,-0.0481102,1.06814,0.0206643,0.148458,0.294875,0.0800908,-0.181919,-0.953201,-0.821959,0.319408,-0.0982698,0.405338,-0.0940777,0.33578,-0.0811459,0.273259,0.724567,-0.125473,0.555055,0.389355,-0.296992,0.0581733,-0.512987,0.552327,0.0575028,-0.395384,1.30748,0.772025,0.983063,-0.946061,0.000808483,-0.429511,-0.827432,1.36289,0.338788,-0.0551166,0.348843,0.523932,0.260435,-0.495882,-0.106587,0.0873656,0.314985,-0.0937092,0.329367,-0.263683,0.0890696,1.48012,-0.625488,-1.66834,0.632112,0.550735,-0.360812,0.739284,0.12426,-0.563722,-0.284614,0.576691,0.691789,0.197007,0.624611,0.649999,0.135294,0.65559,-0.0892117,0.0883464,0.697119,-0.527819,0.0984005,0.456672,-0.0934513,-0.0335126,-0.274259,-0.734994,-0.0835255,0.132481,-0.213297,-0.0484182,-0.140129,0.0194092,-0.0113657,-0.461595,0.491592,-0.774306,0.0208347,-0.171045,0.199269,-0.0426598,-0.0439203,-0.159961,0.419758,-0.240428,0.0375903,-0.579482,0.325654,0.343453,0.266795,-0.161237,0.27936,0.304721,0.241009,0.353784,-0.90601,-0.242447,0.580463,-0.074126,-1.00304,0.110742,0.193668,-0.159582,-0.166768,0.347899,0.374376,0.744427,0.340311,-0.551835,0.380988,0.13295,0.351154,1.06851,-0.143968,-0.776286,0.694787,-0.0275276,0.475992,-0.590746,-0.428692,-0.174838,-0.130203,-0.353374,0.448615,1.05189,-0.978133,0.697259,0.0965059,0.223223,-0.226719,-0.206805,-0.524175,-0.0109108,0.0940788,0.92172,0.975254,0.57504,-0.15151,0.425262,0.205002,-0.445836,0.702611,-0.555068,0.456268,-0.196981,-0.177811,0.071648,-0.473493,-0.0563345,0.465518,-0.39133,-0.280017,-0.790128,-1.20119,-0.811394,-0.627068,-0.170264,0.657117,0.442173,0.616742,0.147503,0.767516,-0.279513,0.0585713,-0.512468,-0.612514,-0.502365,0.0469459,-0.357218,0.163599,0.536568,0.348808,0.152923,-0.424274,-0.00969041,0.626341,0.0629929,-0.898059,-0.0240075,-0.252399,-0.69113,-0.43665,0.0517764,0.237027,-0.57106,-0.183879,1.25534,0.235166,0.438394,-0.0269367,-0.679447,-0.203463,-0.131124,0.069499,0.697712,-0.0347543,-0.0843006,0.588524,0.110735,-0.00984557,-1.23325,-0.0123192,0.0717067,-0.827574,0.237655,-0.263597,-0.188121,-0.0917514,-0.191854,-0.393578,-0.131894,-0.173361,-0.54141,-1.0933,-0.0742534,-0.0602227,0.426502,0.432811,0.0357036,0.446593,0.336193,-0.502274,0.417065,0.838566,-0.105652,0.375743,0.707777,-0.599753,-0.160761,-0.0408538,-0.635167,0.98457,-0.631987,-0.748354,0.568681,-0.48889,0.594779,0.321389,0.18738,0.237379,0.228306,-0.0186655,0.028567,0.96015,-0.0938758,0.16938,-0.65116,0.11001,0.29032,-0.731468,-1.05529,-0.257712,0.373104,0.212755,-0.0963869,0.00629621,0.289392,-0.0468697,-0.178538,-0.507795,-0.543462,-0.434769,0.129297,0.243818,0.736591,-0.0893984,-0.0233735,-0.77252,0.359661,-0.0823694,0.0675891,-0.0394417,0.0213478,-0.432213,0.00315377,0.267704,-0.20138,0.387113,0.195398,-0.29922,0.198299,0.280278,0.445308,0.529413,-0.760394 +3380.21,0.943316,0.0848144,4,1.42185,0.949845,-1.69653,0.675603,0.058611,-0.0925941,0.970675,0.690668,0.680891,0.272293,0.332626,-0.171137,-0.0818188,0.546646,-0.463547,0.731749,-0.0947656,0.467204,-0.50853,0.0686024,-0.468238,-1.06872,-0.67192,0.222936,-0.690662,0.179305,0.34601,-0.074061,-0.0917497,0.133351,0.592773,-0.698408,0.46164,0.349144,-0.504105,-0.220906,0.506307,0.672764,0.570354,-0.456353,1.11602,0.805558,0.339263,-1.48682,-0.4511,-0.133618,-0.489651,0.831024,0.343738,-0.237029,0.25295,1.0029,0.512251,-0.357341,0.0436359,-0.159374,0.0167762,-0.41133,0.429683,0.309281,0.612175,1.20437,-0.937165,-0.0844925,0.769618,-0.214531,-0.282597,0.625472,0.204471,-0.482971,0.196967,0.577667,0.698975,0.0999973,0.67279,0.78511,0.201473,0.234534,-0.403185,0.426891,0.740264,-0.286065,0.316168,-0.107061,-0.293013,0.016835,0.35727,-0.718303,-0.000769255,-0.136362,-0.07335,-0.214372,-0.388055,-0.279113,0.42546,-0.0462109,0.0473199,-0.93576,-0.0252436,0.0126466,0.439141,0.292004,-0.271432,-0.183398,0.666969,-0.207339,-0.490696,0.174644,0.264491,0.512831,-0.264985,-0.102646,0.447627,0.314933,0.60888,-0.561919,-0.894372,-0.0143913,0.200593,-0.181901,-1.01828,0.143863,-0.596811,0.0848421,-1.17864,-0.158457,0.0771426,0.59273,0.0257886,-0.59011,0.405497,0.188234,0.412482,0.348347,0.216646,-0.140404,0.311706,0.29063,0.564441,-1.19195,-0.0524088,0.122055,0.0947469,-0.730742,0.576713,0.377795,0.303935,0.185344,0.0261345,-0.312676,-0.233788,0.109719,-0.0838364,0.323922,0.0997895,1.03579,0.181565,-0.0193594,0.0474759,-0.508404,0.400161,0.524854,1.01264,-0.116123,0.171676,0.0958077,-0.474422,0.024101,-0.785387,0.328837,-0.219795,0.209138,0.0411924,-0.373471,-0.504235,-0.452565,-0.488284,0.220223,0.498256,0.755587,0.277869,0.130928,0.339698,-0.663232,0.0212457,-0.264017,0.0418394,-0.336937,-0.0156555,-0.0998387,0.107808,0.354899,0.346362,-0.0633785,-0.117115,0.257148,-0.404035,-0.15652,-1.60674,0.51738,-0.12853,-0.321243,-0.159278,-0.688228,0.437081,-0.329419,-0.692256,1.13444,-0.0668537,0.0385368,0.0964525,-0.525371,0.300844,-0.432233,0.489759,0.333652,0.0509232,0.112779,0.839303,0.0113546,0.394803,-1.06063,-0.512231,0.475591,-0.868148,0.566568,-0.7182,-0.00309228,0.894421,-0.27978,-1.09604,0.163595,0.0695246,-0.468524,-0.303702,0.57829,-0.17885,-0.0330407,0.3886,-0.0466759,-0.489385,0.331581,0.17808,-0.505225,0.713287,-0.0858496,0.243869,0.387257,-0.384947,-0.320546,-0.474408,-0.946821,0.547392,-0.693771,-0.133915,0.155455,0.122549,0.380877,0.0211312,0.167042,0.312542,0.306452,0.877648,0.303421,0.726894,0.150644,-0.00370646,-0.752528,-0.280109,-0.183339,-0.411556,-0.260553,-0.438837,0.160122,0.515428,0.165664,0.135596,-0.249431,0.7564,0.750382,-0.0991647,-1.14898,0.433487,0.207912,-0.00563407,0.110861,-0.376067,-0.172369,-0.429827,-0.110814,-0.0772077,-0.260052,-0.437714,-0.270995,-0.406234,-0.12834,-0.272415,-0.764629,0.407207,0.747891,0.0185725,0.214108,0.484765,0.462718,0.696251,-0.17819 +3398.19,0.820377,0.0848144,4,1.43622,0.765376,-1.72184,0.846295,0.073663,0.0539782,-0.124727,0.294454,0.331925,-0.0173081,-0.166966,0.060172,-0.112321,0.900502,0.00167701,0.837936,0.35538,0.308946,0.050867,0.385073,-0.0625062,-0.523623,-0.803246,0.692539,-0.0381251,-0.303664,-0.275056,0.0279857,-0.428446,0.421565,1.28712,0.31473,-0.211293,0.430498,-0.148035,-0.525916,-0.653514,1.04359,0.496513,0.274339,0.97993,0.799481,0.519042,-1.04596,-0.0248765,0.807271,-1.0782,0.570201,0.17,0.455253,0.515773,0.800808,0.0885951,-0.446221,-0.259836,-0.0668508,-0.13644,-0.8328,0.114573,-0.346293,0.285434,1.12557,-1.05566,-0.663992,0.4359,0.333472,0.334166,-0.716539,0.0145802,0.209924,0.0303728,0.329241,0.567853,0.466284,0.822577,0.577037,0.0973331,0.439379,-0.0439814,-0.0371234,0.600542,-0.703187,0.0906168,0.325224,-0.257517,-0.290914,0.420591,-0.267651,0.296792,-0.351017,-0.00392084,0.601981,0.422807,-0.620533,0.00939152,-0.496548,-0.0207222,0.453704,0.28508,-0.113925,-0.0532768,-0.087095,-0.805829,-0.315549,-0.0404112,-0.20844,0.427251,-0.504126,-0.189226,0.049653,-0.321226,-0.0218392,0.203358,0.48419,0.0572525,0.442212,0.289925,0.149803,-0.249996,0.231578,-0.726776,0.145275,-0.0124717,-0.0795012,0.299044,-0.154006,-0.261686,0.0698842,0.559127,-0.568031,0.25392,0.1292,-0.0488446,0.789175,0.0659602,-0.346464,0.165784,-0.551312,0.541326,0.199726,-0.12551,-0.039783,0.856472,-0.115358,0.0143471,0.296702,-0.0439982,0.235287,-0.216079,-0.0143102,-0.164733,0.0577113,-0.206136,0.453136,0.0925257,0.0866309,0.105633,0.132164,0.170574,0.55933,0.316521,0.268017,0.476417,0.174552,0.256365,-0.112812,0.451737,-0.553426,0.0710649,-0.0370922,0.0176099,-0.0384522,-0.0318657,0.49248,0.101253,0.336402,-0.115367,-0.0585896,-0.283291,0.363821,0.319245,-1.09582,0.124028,0.302295,-0.182979,-0.371753,0.377936,-0.578111,0.679078,-0.436247,-0.102992,0.387792,0.129567,-0.92474,-0.350306,0.483777,0.56702,-0.0489211,0.177519,0.415901,0.0992842,-0.127539,-0.0734907,0.552982,0.536346,0.301765,-0.458338,0.733201,-0.0163689,0.218534,-0.101676,-0.590773,0.193736,0.294836,-0.0782314,-0.0426505,-1.04487,0.197655,0.419362,-0.734462,0.162167,-0.637628,0.483582,0.220822,-0.362282,0.126229,-0.825452,-0.79026,0.00932123,-0.0612598,-0.40402,0.00797751,-0.10982,-0.117326,0.277309,0.402774,-0.442755,0.457439,0.448248,-0.597897,-0.0763198,-0.13599,-0.0888941,-0.236559,-0.167253,0.716807,0.75994,-0.133049,-0.0611672,-0.100286,0.975602,-0.594822,0.557966,-0.331858,0.0988494,0.264067,-0.243154,-0.0832243,0.323698,-0.107903,0.457392,0.72001,-0.249553,0.485565,0.345802,0.124141,-0.205666,0.104218,0.0623762,0.104949,-0.77078,0.00898947,-0.129635,-0.252387,-0.22747,-0.708771,0.0917262,-0.186535,0.298839,-0.184815,-0.231323,-0.326253,-0.0680304,0.242692,0.0696802,-0.0910884,-0.116264,0.397256,-0.199013,0.255998,0.148678,0.32246,-0.043592,0.537686,-0.00149487,-0.876817,-0.0666947,0.265012,0.485445,-0.944126,-0.611488,0.153865,0.212342,0.392256,0.460805,-0.0728854 +3396.42,0.925281,0.0848144,5,1.42169,0.768253,-1.71154,0.868279,0.0455903,0.0221053,-0.113799,0.188739,0.370249,0.000368884,-0.128458,0.108752,-0.104014,0.797908,0.0366855,0.760289,0.286444,0.304242,0.0514617,0.298266,-0.144913,-0.592166,-0.65678,0.65226,0.0257021,-0.370617,-0.240606,0.000841839,-0.523574,0.495063,1.31478,0.360367,-0.336931,0.389486,-0.0890022,-0.566791,-0.645661,1.05949,0.567441,0.283666,1.01212,0.814028,0.405251,-0.991304,-0.0702877,0.81244,-1.09345,0.616273,0.123671,0.356029,0.552606,0.828945,0.145509,-0.490771,-0.208134,-0.0190789,-0.122268,-0.917289,0.165559,-0.214525,0.323586,1.14086,-1.03346,-0.649044,0.33881,0.290594,0.327439,-0.974068,0.0310839,0.252828,0.0078388,0.385619,0.617945,0.487055,0.754419,0.611692,-0.0460759,0.480218,-0.109721,-0.0664645,0.583506,-0.886159,0.185228,0.483362,-0.187301,-0.262875,0.511416,-0.379259,0.401303,-0.351021,0.162059,0.445597,0.379232,-0.569037,0.0781488,-0.432301,-0.163231,0.359732,0.363895,-0.111377,-0.0173819,-0.109525,-0.621953,-0.338953,0.000787442,-0.273754,0.387849,-0.501387,-0.11987,0.169973,-0.499001,-0.0758313,0.12985,0.493721,-0.0322827,0.413864,0.246911,0.220537,-0.179523,0.221378,-0.604233,0.244173,0.0873762,-0.0943621,0.187149,-0.0807541,-0.258985,0.210449,0.49263,-0.642011,0.276045,0.131002,-0.19408,0.80909,0.0754547,-0.33568,0.253934,-0.524917,0.552917,0.16775,0.0229923,-0.041189,0.882339,-0.132738,0.103461,0.307855,-0.0436383,0.416089,-0.326263,-0.0400125,-0.193979,0.00942,-0.332123,0.477596,0.0763107,0.145562,0.207935,0.183402,0.269404,0.484717,0.224063,0.255701,0.562012,-0.0322142,0.171382,-0.309794,0.458063,-0.478802,-0.0160064,0.00930654,-0.0616795,-0.153809,-0.0238166,0.412888,0.116543,0.38859,-0.182521,-0.176958,-0.344775,0.371176,0.266705,-1.15652,0.18664,0.230804,-0.271816,-0.564257,0.196354,-0.456779,0.640537,-0.391657,-0.0534506,0.282225,0.104551,-0.874798,-0.270373,0.470379,0.632721,-0.215732,0.0290899,0.394583,0.213079,-0.196754,-0.10752,0.544221,0.509332,0.421376,-0.526274,0.737433,0.112874,0.190326,-0.11269,-0.544229,0.329652,0.377893,-0.137996,0.0516389,-1.12025,0.247827,0.410234,-0.722961,0.233089,-0.74511,0.356146,0.26739,-0.344435,0.175124,-0.912953,-0.694312,0.10361,-0.226189,-0.225168,-0.0395935,-0.154717,-0.0559635,0.307838,0.417847,-0.501745,0.496985,0.3031,-0.531782,0.177389,-0.0719256,-0.062896,-0.211895,-0.0487065,0.717413,0.753336,-0.221064,-0.0380098,-0.144405,0.941018,-0.688134,0.506639,-0.331459,0.246881,0.310653,-0.297227,-0.0672386,0.24654,-0.160988,0.517245,0.800271,-0.199148,0.360504,0.339827,0.116869,-0.211499,0.215994,0.208418,0.177268,-0.67317,-0.0649694,-0.256152,-0.275981,-0.331928,-0.697669,0.0771187,-0.227222,0.314435,-0.0450773,-0.232699,-0.374401,-0.112237,0.285757,0.0169451,-0.0550523,-0.194061,0.446464,-0.302743,0.260074,0.130232,0.293698,-0.0860668,0.333113,-0.0139604,-0.815659,-0.0538052,0.228822,0.323811,-0.937312,-0.419255,0.158756,0.234276,0.398441,0.48402,-0.0175967 +3400.9,0.988948,0.0848144,4,1.54771,0.874377,-0.860339,0.443826,0.50591,-0.0779998,0.143054,0.376818,0.94541,0.26578,0.0232153,0.084717,-0.196228,0.546389,-0.16216,0.55543,0.458778,0.387385,-0.316598,-0.0919731,0.344759,-1.19249,-0.277696,0.414,-0.496299,-0.196844,0.686264,0.0374197,-0.215754,0.0384203,0.941663,-0.553131,0.112943,0.479786,0.198285,-0.408427,0.276211,0.836835,0.326075,-0.385327,0.991509,0.774404,0.666905,-1.13499,0.0367867,0.157577,-0.38244,0.315977,0.395353,-0.145176,-0.141127,0.219902,0.334152,-0.147589,0.238911,-0.394791,-0.28088,-0.964973,0.44332,0.159694,-0.00438016,0.927717,-0.802767,-0.978614,0.534652,0.368962,-0.179245,-0.111651,0.024693,-0.0366055,-0.319916,0.133162,0.544929,-0.31895,0.509932,0.470354,0.26809,-0.580086,-0.00893557,0.0818085,0.582381,-1.08536,0.112818,-0.525869,0.0950864,0.176926,0.527681,-0.466725,-0.255697,-0.403003,-0.430627,0.14001,0.0813788,-0.670551,0.440081,-0.740193,-0.126159,-0.131217,0.031262,-0.056996,-0.88389,-0.166806,-0.454762,-0.593259,-0.0941923,-0.217656,0.271861,0.354838,0.524912,0.544234,0.0920717,-0.387471,-0.504027,0.42649,0.113999,-0.111512,-0.00551104,-0.109495,0.503695,0.0991923,-0.723155,-0.0958212,-0.412898,-0.341748,-0.217465,-0.313378,0.602172,-0.38881,0.550087,0.0942624,-0.147481,0.167033,0.0214463,0.809931,0.22156,-0.29007,0.3119,-0.488472,0.350758,0.498033,-0.315077,-0.137158,0.00174164,0.162631,-0.393296,0.623965,-0.244086,0.256972,-0.116991,-0.329657,-0.186366,0.105707,-0.449309,0.257345,0.246452,0.0830637,-0.0538274,-0.826027,-0.0705811,-0.0273643,-0.0681573,-0.308108,0.567035,-0.284321,0.868359,0.262099,-0.0710633,0.0639462,-0.181464,0.215379,-0.692825,0.43093,0.00489081,0.159677,0.0348126,0.416576,-0.402679,-0.349742,-0.0502152,0.688267,-0.257201,0.249657,0.528524,-0.491677,-0.196279,-0.495682,0.265577,-0.271123,-0.05172,-0.688829,-0.0610656,0.300173,-0.170542,-0.297391,-0.0655952,0.447558,0.147168,-0.491639,-0.21703,0.182867,-0.0969486,0.00375692,-0.275568,-0.109998,0.539348,-0.103587,-0.358898,0.781308,0.24593,0.116979,-0.314722,-0.751714,0.647481,0.181856,-0.289979,0.111017,-0.061298,0.215368,0.276028,0.00635575,0.884342,-0.682927,0.0304024,0.33623,-0.643067,0.403662,-0.624229,-0.361323,-0.888766,-0.107007,-0.674886,0.284712,-0.345256,-0.305814,-0.555766,0.297305,-0.791706,0.266382,0.457741,-0.247579,-0.168103,-0.538414,0.0122085,-0.122255,0.081384,0.465357,0.722636,0.106893,0.470356,-0.329992,-0.314443,-0.691155,0.0753009,-0.566412,0.235114,0.418237,-0.473186,0.142607,0.214144,-0.102744,0.231568,-0.0160974,0.0771029,-0.24519,0.456586,-0.182881,-0.193109,-0.722891,-0.257554,-0.252644,-1.05854,0.132054,-0.07556,-0.162408,-0.0796526,-0.557895,-0.0997555,-0.229394,0.118144,-0.186902,-0.252609,0.439436,-0.291235,-0.193628,-0.123211,-0.110799,-0.416243,0.443414,0.0112085,0.217381,0.00804302,-0.106254,-0.110103,0.493357,-0.382975,-0.807015,0.0581001,-0.447819,-0.28424,-0.293849,-0.227721,0.140505,0.325601,0.37484,0.570614,-1.62704 +3397.02,0.998611,0.0848144,4,1.55642,0.950691,-0.985367,0.413641,1.04345,-0.0495748,0.13635,0.194785,-0.104557,-0.327631,-0.067707,-0.115461,0.111456,0.176491,0.0806766,0.695366,0.0976035,-0.0256743,0.0213553,-0.281167,0.025461,-0.724141,-0.646146,0.562108,0.196662,-0.0194666,0.18221,0.166596,-0.323581,0.490453,1.02743,-0.341871,0.156374,0.69811,0.0843867,-0.570348,-0.464556,0.589293,0.20832,-0.236704,1.17701,0.346516,-0.0858976,-0.317177,-0.186144,-0.234669,-1.09105,0.131927,0.10002,0.0708725,-0.261793,1.0164,0.0327939,-0.625089,0.339215,-0.161035,-0.46354,-1.08158,0.467341,-0.993259,0.340563,1.14558,-0.434354,-0.699671,-0.440307,0.281691,0.19253,0.0992997,0.69893,-0.560183,-0.710416,0.155616,0.543066,-0.236641,1.06402,0.640122,0.296435,0.774887,0.139017,-0.0853823,0.740427,0.0800358,-0.296534,0.35691,-0.320583,-0.867239,-0.392091,-0.444093,-0.0263283,-0.690958,0.566857,0.174326,-0.339893,-0.384412,-0.102908,-0.78701,-0.19679,-0.469113,-0.109022,0.05525,0.498349,-0.40445,-0.181163,-0.0974821,0.267982,0.368177,-0.18958,-0.789997,0.174164,0.936012,0.0398577,-0.0717555,0.435989,0.569241,-0.138765,0.304207,0.302074,-0.343973,0.0744314,0.0341874,-0.386395,-0.49656,0.224688,-0.314071,-0.260232,0.371891,-0.0312096,0.198873,0.542205,-0.455979,0.170578,-0.214387,-0.239044,0.481765,-0.330533,-0.420596,0.115526,0.383353,0.0707209,-0.859811,-0.0884171,-0.481833,-0.0351855,-0.219515,-0.267981,0.199063,0.395076,0.0980823,-0.542683,0.354757,-0.290931,-0.3943,-0.317694,0.455722,-0.20344,0.365427,0.207739,0.722954,-0.131773,0.148466,0.661523,0.119695,0.396928,0.157636,-0.480475,-0.126147,0.141486,-0.222239,0.305174,-0.462847,0.501602,0.209629,0.108661,-0.268283,-0.0978832,-0.171083,-0.233465,0.422092,0.331483,0.272411,0.716368,-0.428468,0.596584,0.362608,-0.462672,-0.126435,0.0433581,-0.100957,0.355348,0.197158,0.0565164,-0.255465,0.0909324,-0.6678,0.414849,0.280629,0.553927,-0.291644,-0.276266,-0.0606406,-0.579342,-0.470904,-0.0934785,-0.681295,0.13102,0.359346,-0.330676,0.553343,-0.559522,0.43953,0.156157,-1.11248,-0.0303404,-0.390426,-0.321622,1.07006,0.185713,-0.0904314,0.361019,-0.95918,-0.630699,-0.240802,-0.0910042,0.192617,-0.205913,0.492612,-0.337581,-0.229397,0.0252226,0.0692612,0.0643087,0.0990482,0.357573,0.543716,0.346368,0.290442,0.326988,-0.506081,0.242275,-0.105266,-0.567126,0.015079,-0.174531,0.0103825,-0.0550206,-0.251375,0.618444,0.0110218,-0.447173,-0.442626,0.336138,-0.299006,0.639319,-0.153559,-0.255342,0.216249,-0.180566,0.0353946,-0.495445,-0.474509,0.10951,0.882701,-0.356204,0.840358,-0.00651608,0.0556571,-0.380932,0.379416,0.220426,-0.145653,-0.289916,-0.0742506,-0.0634132,0.317297,0.445312,0.373771,-0.200708,-0.474248,0.344432,0.284641,-0.00510841,-0.588346,-0.666795,0.18335,0.242697,0.538553,-0.142726,-0.148305,-0.167808,-0.516964,0.0824438,0.344322,0.538248,0.120464,0.0200742,-0.231506,0.146883,-0.535399,-0.26338,0.129988,0.0650188,0.159428,0.27502,0.399285,0.524424,-3.45054 +3426.65,0.945977,0.0848144,4,1.66598,0.709315,-1.20586,0.466525,1.05125,-0.221474,-0.212234,-0.0884823,-0.0353469,0.0325079,0.0823406,-0.24099,-0.709271,0.244642,-0.336329,0.177624,0.0475694,-0.262671,-0.211474,-0.328955,0.106215,-0.643342,-1.15241,0.537756,-0.613125,-0.27849,0.174046,0.0860876,-0.251681,0.383661,1.07769,-0.703917,0.729686,0.692051,0.10799,-0.244972,-0.398512,0.317879,0.473467,-0.686812,0.964931,0.411459,0.369881,-0.593427,-0.113735,0.37814,-0.796392,0.163645,0.479085,0.0330945,-0.526279,0.867307,-0.0963366,-0.269319,0.435533,-0.380967,-0.179684,-0.803588,0.735111,-0.567027,-0.0570317,1.19814,-1.25143,-1.22837,0.0334325,0.701776,0.234035,-0.554713,0.101166,-0.0679506,-0.151414,0.518002,0.680284,-0.0336333,0.974469,0.247269,0.347154,0.137875,-0.574953,-0.238714,-0.0529208,0.093172,-0.0761729,-0.107446,-0.0564459,0.141803,-0.363219,0.0317821,-0.218618,-0.368893,0.141834,0.0287241,-0.328207,-0.304305,0.0266191,-0.388173,0.203362,-0.163263,-0.0258707,-0.164227,0.351148,-0.19653,-0.251741,0.112034,-0.134106,0.539207,-0.133505,-0.166061,0.349367,0.847858,-0.565269,0.0989561,-0.435398,0.658114,0.270784,-0.0993915,-0.316178,-0.0602322,-0.123609,-0.168503,-0.666325,-0.404214,-0.519814,-0.049902,-0.290116,0.270251,-0.0870174,0.306703,0.353062,-0.271904,0.212852,-0.0238828,-0.0939667,0.954012,-0.036966,-0.00811478,-0.0151661,-0.434611,0.354928,-0.846004,-0.517544,-0.414794,-0.162287,-0.762365,0.0194957,0.307446,-0.302341,0.235201,-0.114894,-0.242321,-0.633967,-0.15038,0.263629,0.183786,0.221667,0.431356,0.571204,-0.147415,-0.268355,0.186596,0.545219,-0.247373,0.884501,0.419768,-0.180416,0.3866,-0.14649,-0.123064,0.290072,-0.668215,0.228306,0.229834,0.290753,-0.221718,0.106935,-0.0316112,-0.605607,0.339625,0.14298,0.247983,0.562782,-0.396894,0.398859,-0.347132,-0.477151,-0.472189,0.0418619,-0.541171,0.0809156,-0.311407,0.00258318,-0.412041,0.193716,-0.480243,-0.0580431,0.335117,0.0843707,-0.426837,-0.731678,-0.0513073,-0.367344,-0.227137,0.506958,-0.635174,-0.02253,0.0510245,-0.907157,0.821,-0.258987,0.307498,-0.466498,0.204838,0.222237,-0.214291,0.114814,0.0287818,-0.0196991,-0.338477,-0.0448422,-0.575601,-0.459219,0.179819,0.211937,0.6833,-0.394446,0.135186,-0.202181,-0.131697,-0.0617318,-0.17802,-0.42931,0.297104,-0.562423,-0.590487,-0.216458,0.0721247,-0.0805278,-0.262353,0.492743,0.35425,0.23762,0.183961,-0.331552,-0.0782801,0.630637,0.250778,0.466389,-0.120468,0.201136,-0.633608,0.402575,0.101991,0.0697484,-0.210465,-0.217321,0.481589,-0.398889,0.341498,-0.219729,-0.147497,0.693076,0.107978,-0.456744,-0.0245638,-0.420728,-0.154943,-0.190795,0.0773475,-0.242488,-0.148757,-0.739577,-0.0605037,-0.935948,-0.0190822,0.419668,0.729772,-0.0447238,-0.324906,-0.339925,-0.0905277,-0.161847,0.00691415,-0.373751,-0.163386,-0.173019,-0.0620821,0.0417426,0.598477,0.471375,-0.589025,0.450424,0.163853,0.411325,0.32604,-0.0480771,-0.537637,0.441077,-0.695869,0.317895,-0.111785,-0.46471,0.135225,0.294314,0.36773,0.542507,-2.83148 +3441.79,0.988726,0.0848144,4,1.42937,0.744035,-1.5663,0.542092,0.269958,0.0720586,0.255111,-0.0675058,0.428505,-0.439261,-0.0255345,-0.251299,-0.0343633,0.336361,-0.0908853,0.970226,0.225225,0.47071,-0.192376,0.0721886,0.0811414,-1.14439,-1.02628,0.0258923,-0.0853057,-0.240443,0.537767,0.476788,-0.574539,-0.185837,1.19161,-0.438342,-0.43708,0.15843,-0.301188,-0.243469,0.49138,0.694961,0.234806,0.343177,1.21015,0.430605,0.485865,-0.392017,-0.108398,-0.272921,-0.724228,0.379985,0.717742,0.0655245,0.458033,0.0109034,0.303152,-0.809597,0.600581,-0.094339,0.262767,-0.595664,0.210664,-0.247783,0.487932,1.07131,-0.502509,-0.674246,0.236548,-0.418467,-0.201775,0.333405,0.460891,-0.774989,-0.164746,0.309487,0.725666,-0.457606,0.326826,0.379048,0.0772137,0.0407789,0.366938,-0.199263,0.849892,-0.281093,0.49268,-0.0475406,-0.0513748,-0.538488,-0.0367792,0.0451856,0.128831,-0.531606,0.134298,0.0509159,0.126729,0.0736937,0.434883,-0.394219,0.329974,0.0819965,-0.0948924,0.243635,0.24241,0.362129,-0.443172,-0.0206312,0.16023,-0.278646,0.560069,-0.0856786,0.229031,0.425844,-0.0652019,-0.154888,0.630618,0.538628,0.0306135,0.133306,-0.237619,0.298476,0.425976,0.0415144,-0.533916,0.0801025,-0.126914,0.139608,0.0689806,-0.139339,0.29302,0.211581,-0.0502456,-0.205661,0.00423612,0.352419,0.194281,0.260018,-0.577195,-0.275177,-0.37992,-0.114171,-0.0721088,-0.173844,-0.205892,0.393218,0.195056,0.122261,-0.451284,-0.099267,0.364696,0.440978,-0.332295,0.150111,-0.176549,0.113052,-0.0949941,0.0713699,0.140994,0.522241,0.471248,-0.0124495,-0.0201082,0.386089,-0.3082,0.380666,0.490658,-0.146827,0.54423,-0.111482,0.131706,0.210384,-0.164714,-0.478975,0.474755,-0.350183,0.0683585,0.259973,-0.3483,0.238431,0.185405,-0.143599,0.251554,0.817617,0.148427,0.662641,0.300003,0.0499484,0.0941416,-0.715673,-0.394381,0.0900735,0.380826,-0.317909,0.45443,0.363231,-0.0585893,-0.409027,-0.101849,0.267826,0.0789079,-0.352438,0.0710953,0.418647,0.376147,0.058458,-0.0735377,-0.107215,-0.0503146,-0.303175,-0.306763,0.818679,-0.114008,-0.439488,0.168073,-0.430084,0.380427,0.0405037,-0.0993661,0.670603,-0.198378,0.200829,0.602224,-0.430501,0.315368,-0.23277,-0.551231,0.0203383,-0.265518,0.611896,-0.0486927,-0.0788222,0.146785,0.142126,0.184588,0.261327,0.353637,0.352051,-0.188449,0.791829,0.571402,0.539351,0.269769,0.0924644,-0.415451,0.0737443,-0.131152,0.0271047,0.109136,0.219904,0.134913,0.415849,-0.368506,0.131031,-0.220562,-0.727859,0.324679,-0.324081,0.0707677,0.0927342,-0.570976,0.301033,0.558414,0.202437,-0.336947,0.551288,-0.423235,-0.00367457,0.498802,0.354452,-0.19934,-0.473071,-0.120303,-0.025239,0.352716,0.154371,0.213597,0.0445595,-0.196713,-0.394191,-0.341958,0.557784,1.00178,-0.275214,-0.0381013,-0.562033,-0.295896,0.256828,0.0179639,0.0852409,-0.11985,0.0201398,-0.126087,0.185399,-0.160451,0.517941,-0.468988,0.273318,-0.225963,0.0479157,-0.164691,0.176762,-0.212392,-0.161241,0.45771,0.104253,0.277221,0.322882,0.526518,-0.491399 +3448.08,0.997192,0.0848144,4,1.51982,0.930332,-0.385675,0.0857945,0.812465,-0.0311415,0.0679596,0.436562,0.364725,0.16362,0.116785,-0.094869,0.0516683,0.0290937,-0.274165,0.940916,-0.0454546,-0.18376,-0.00160719,0.051055,0.0980548,-1.05286,-0.83736,-0.106133,-0.241275,-0.19031,0.0179704,0.521084,-0.391377,-0.21151,0.998542,-0.172454,0.615737,0.108302,-0.201309,0.0556373,-0.136007,0.304383,0.710843,-0.291413,1.23462,0.614052,0.232221,-0.693484,0.0148932,0.214989,-0.160834,-0.141276,0.40733,-0.0532927,0.211878,0.0289355,0.296002,-0.266398,1.06817,-0.394471,-0.505862,-0.414489,0.66953,-0.552644,0.450117,0.996458,-0.337157,-0.956645,-0.296447,-0.160776,-0.248683,-0.394894,0.00122678,-0.244394,-0.0959291,0.307651,0.767044,0.0639573,0.363408,0.599428,0.0587934,-0.0423484,-0.78634,-0.242131,0.477013,0.0344255,0.492014,0.167395,-0.105322,0.144292,-0.177892,0.0568217,0.392439,-0.207245,-0.196111,0.0423026,-0.048827,0.169327,-0.0272649,-0.938472,0.138482,-0.191937,0.146773,0.0812294,0.130172,-0.145778,-0.489379,-0.253564,0.379433,0.0665785,0.167492,-0.089127,0.661341,0.476256,-0.329767,-0.816076,0.12656,0.425734,-0.0936596,0.401156,0.0366688,0.0504471,0.464688,-0.186424,-0.747404,-0.0389099,0.504415,-0.766758,0.0608285,-0.265176,0.347655,0.372853,0.422683,-0.0444414,-0.370184,0.201296,-0.628743,0.302483,0.326184,-0.169664,0.0286139,-0.457106,0.462793,-0.40032,-0.499758,0.304903,0.169676,-0.303943,-0.0441902,-0.185357,-0.36239,0.65977,-0.226135,-0.22422,-0.40205,0.634314,0.661009,0.276978,-0.285445,-0.244888,-0.135085,-0.29684,-0.0704702,-0.084742,0.19452,-0.142108,0.873339,0.241904,-0.294221,0.0856785,0.0104276,0.214367,-0.231369,0.729373,0.302354,0.090898,0.0513795,0.586628,0.34737,-0.165812,-0.425954,0.567636,-0.144091,0.744607,-0.0222852,-0.590204,-0.557572,0.19687,-0.0621536,0.035852,-0.0640164,-0.206458,0.295312,-0.164154,0.0537142,0.268986,0.398919,-0.19018,0.103508,0.555554,0.078673,-0.539904,-0.401716,0.232312,0.0968921,-0.0831102,-0.20593,-0.00575481,-0.120371,0.20326,0.0967732,0.818923,-0.512396,0.51484,0.216598,-0.0392523,0.312452,-0.385813,-0.41564,0.274941,-0.103239,0.0414666,0.472434,0.0136589,0.302928,-0.0246821,0.0908435,0.289133,0.10604,0.318583,-0.737578,-0.363209,-0.182105,-0.15031,0.225999,0.0408835,-0.307803,-0.0183715,-0.21904,0.264941,-0.0440385,-0.205358,0.539969,-0.338673,-0.224402,0.438473,-0.172613,0.383422,0.394173,0.494075,0.315816,-0.120818,0.241907,0.0299102,0.0440569,-0.934987,0.277323,-0.0488141,-0.34751,0.225214,-0.447421,0.177939,0.0862125,0.193,0.0933439,-0.103634,0.568566,-0.0719625,0.10095,0.385205,-0.473009,-0.198878,-0.231802,0.186864,-0.444726,-0.468083,-0.774121,-0.254852,0.134879,0.311054,-0.190186,-0.407528,-0.058823,-0.0697913,-0.154832,-0.471547,0.297605,-0.288282,0.0428931,0.243619,-0.17889,1.00459,-0.117999,0.328853,0.0356443,0.0394445,0.314916,-0.250086,0.0382254,-0.537903,-0.497523,-0.0702861,0.199488,0.134642,0.555778,0.126866,0.216404,0.356183,0.465192,-2.69311 +3437.49,0.845478,0.0848144,4,1.47422,0.890481,-1.12589,0.436959,0.512568,-0.0293431,0.0298435,0.00795581,0.612951,-0.10839,-0.0755491,-0.0610152,0.124106,0.149569,0.26795,0.935239,0.145482,-0.0377271,0.19402,-0.201178,0.0419989,-0.830781,-0.606633,0.0994862,-0.0354444,0.272594,0.342476,0.684831,-0.125147,0.0944823,1.01014,-0.114406,0.147696,0.299538,-0.0459382,0.0749655,-0.143203,0.298976,0.675824,0.295063,1.03646,0.435488,-0.375001,-0.57381,-0.00398768,-0.16737,-0.621674,-0.24847,0.338457,-0.144814,0.242008,0.17421,0.519711,-0.119012,0.698323,-0.240573,-0.710225,-0.394642,0.511235,-0.595606,0.151479,0.879754,-0.50847,-0.78629,0.172503,-0.324762,-0.0509125,-0.924365,-0.157859,-0.0503138,-0.123113,0.145706,1.0657,-0.249682,-0.0692484,0.111644,0.187338,0.385683,-0.10889,-0.222897,0.908045,-0.348954,0.470322,0.4653,-0.585301,-0.838838,-0.308249,-0.346929,0.359241,-0.615984,-0.361309,-0.291002,0.163921,-0.481467,-0.378095,-0.672764,0.362369,-0.432139,-0.562711,0.0851189,-0.078495,0.319164,-0.241073,-0.108489,0.653911,-0.220288,0.30571,-0.389827,0.431526,0.23217,0.27722,-0.491377,0.0975529,0.255319,0.294243,0.841375,-0.186698,0.208425,0.408963,0.138927,-0.752749,0.186222,-0.00690814,0.092423,-0.620971,-0.010808,0.223518,0.330092,0.25597,-0.50423,-0.142942,0.286836,-0.419211,0.322337,-0.0185587,0.0858368,0.159928,0.230921,-0.0561385,-0.620736,-0.219302,0.0827101,0.267867,-0.264486,0.362999,-0.239673,-0.0557143,0.711387,-0.312758,0.198939,0.310434,0.181147,0.218443,-0.199192,0.0399959,-0.198179,-0.159869,-0.276931,-0.0271142,0.237997,-0.24819,-0.0570338,0.602374,0.46692,-0.0829249,-0.019342,0.302335,-0.136477,0.0152484,0.123575,-0.344966,-0.590149,-0.255627,0.00719211,0.425402,-0.518771,-0.258811,0.00435625,-0.344523,0.803168,0.36492,-0.160474,0.19784,-0.173576,0.0338852,-0.0869718,0.256173,-0.365955,0.220143,-0.261148,-0.0359025,-0.176438,0.628724,-0.442875,0.2757,0.0377468,0.217344,-0.366807,-0.396788,-0.197314,0.152614,0.186918,0.59154,-0.418751,-0.198921,0.494859,0.0602797,0.937814,0.212314,0.023154,0.0261655,-0.0790656,0.210389,0.0261873,0.370716,0.233295,-0.0924713,-0.0637263,0.40664,0.165987,0.160832,-0.278319,0.184151,-0.0245025,0.177223,0.34257,-0.562163,-0.0273844,0.0690704,0.330955,-0.652311,-0.0161027,0.0760709,-0.18782,-0.436068,0.292159,-0.00523643,0.0853949,0.339467,-0.250485,-0.249496,0.558836,0.0927374,0.274669,0.20967,0.238626,0.670171,0.643004,-0.223388,0.0320275,-0.214452,-0.697586,0.477678,0.265636,0.175627,0.67061,-0.526258,0.256764,-0.192909,0.278471,-0.23851,-0.0424042,0.777318,-0.401021,0.454493,0.107207,-0.207146,-0.374746,0.289424,0.0424864,-0.531084,-0.262219,-0.168496,0.243114,-0.145895,-0.287947,-0.199849,-0.124784,0.0107632,-0.0162103,-0.168147,-0.128283,0.0645167,0.230794,0.0484966,0.404186,-0.472091,0.222983,0.265242,-0.0236453,-0.21519,0.0118647,0.341496,-0.361395,-0.177978,0.0415294,0.0771069,0.190923,0.123876,-0.151301,0.579229,0.118486,0.200687,0.344218,0.44798,-1.61722 +3457.85,0.998839,0.0848144,4,1.6048,0.843275,-0.975298,0.391377,0.524519,-0.0897935,0.0951532,-0.13781,0.445134,0.399486,0.0288059,-0.349496,-0.118949,0.352704,-0.0129116,0.94049,0.176151,0.0342755,-0.147679,-0.17109,0.0594756,-0.744134,-0.395216,0.141193,-0.095207,0.299549,0.161153,0.413119,-0.094051,-0.338793,0.969931,-0.788565,-0.0211831,0.323949,-0.248836,0.0125771,-0.293691,0.55623,0.712974,-0.144814,1.1965,0.577628,-0.209833,-0.796384,-0.0324165,-0.6516,-0.45892,-0.448087,0.27944,-0.00502423,0.22659,0.30067,0.0717782,-0.128588,0.704635,-0.0622613,-0.530398,-0.394804,0.507843,-0.522272,0.300246,0.96264,-0.429893,-0.461075,-0.635139,-0.39293,0.139987,-0.345247,-0.405239,-0.0745429,-0.0598623,0.00149867,0.403474,-0.28859,0.266374,0.548372,0.0348583,-0.121112,-0.371876,0.0274041,0.703338,-0.48022,0.357851,0.165458,-0.52489,-0.507259,0.0894315,-0.15811,0.230883,-0.483706,-0.174914,-0.160917,-0.139148,-0.359828,-0.452366,-0.46742,0.238967,-0.329413,-0.460666,0.372819,0.151227,0.125465,0.132008,-0.233326,0.337176,0.0782719,0.562424,0.038058,0.342406,0.188591,0.118594,-0.50878,-0.361922,0.155788,0.215929,0.676528,0.119266,-0.054198,0.53926,-0.169806,-0.668154,-0.436388,0.144949,0.348253,-0.0781214,0.350599,0.241648,0.0804614,0.200959,-0.262548,0.0650876,0.0483096,-0.245313,0.312498,-0.122307,0.0521758,-0.0820637,0.166816,0.327514,0.0752809,-0.269881,0.123002,0.312954,-0.670768,0.101102,0.0209167,-0.0473604,0.335611,-0.400772,-0.220032,0.265418,0.105255,0.0945717,-0.466626,0.131561,-0.104009,0.227009,-0.17548,-0.133335,-0.0738471,-0.121341,0.142969,0.798345,-0.285347,-0.0671583,-0.0895673,0.29305,0.194768,-0.0955516,-0.30655,-0.102744,6.37221e-05,-0.280234,0.442719,0.130717,-0.239154,-0.290263,0.39609,0.0768619,0.606694,-0.0126543,-0.506746,0.374319,-0.0747047,0.228029,0.0854644,-0.243551,-0.288445,0.0881679,-0.37067,0.28589,-0.160562,0.103986,-0.44204,-0.217788,0.119575,0.256538,-0.610573,-1.00576,0.144588,0.124802,-0.0329776,0.0156855,-0.550025,0.314286,-0.0311667,-0.55822,0.717723,0.454226,0.173238,0.125629,-0.643311,0.504985,0.0259309,0.0293979,-0.293935,-0.26327,0.115221,-0.0518162,-0.111038,-0.0156826,-0.37525,-0.154681,0.260433,-0.0979344,0.386507,-0.657117,-0.250175,0.0862108,0.0342313,-0.678668,-0.0308301,0.00595795,-0.346874,-0.231365,0.0889921,0.197493,0.271703,0.539869,-0.550184,0.117008,-0.00866607,-0.357233,-0.354951,0.114303,0.201758,0.574255,0.182939,-0.207261,-0.235193,-0.302664,-0.0402325,0.594368,0.0270487,-0.128974,0.565508,-0.105756,-0.35808,0.307413,0.279301,-0.463876,-0.16985,0.206454,-0.321888,-0.0686315,0.522665,-0.133638,-0.747588,0.233158,0.0584037,-0.662281,-0.585812,0.322567,-0.107195,-0.140333,-0.149304,-0.423382,-0.103312,0.373284,-0.372264,-0.0511104,0.201152,-0.0808585,0.00410294,0.131586,-0.0168648,-0.295098,0.439017,0.330333,0.00760446,-0.119965,-0.200276,0.199651,-0.140738,-0.109974,-0.29831,-0.176074,0.0220928,0.483077,0.350319,0.797731,0.108626,0.32279,0.329585,0.568146,-1.46364 +3453.61,0.892106,0.0848144,4,1.62662,0.783948,-1.09069,0.372381,0.503343,-0.051692,0.229695,0.0699643,0.00214435,-0.0387714,0.168703,0.0412063,-0.330154,0.145728,-0.212971,0.851948,0.356523,-0.374737,0.0123295,0.120712,-0.121008,-0.719784,-0.84357,0.234738,-0.460421,-0.490043,0.0106904,-0.127845,-0.385127,0.207889,0.942752,-0.573304,-0.17717,0.222616,-0.272741,-0.43045,-0.270181,0.0952347,0.313403,-0.645155,1.10598,0.442533,0.19031,-0.519454,-0.0276604,0.413504,-0.740255,0.0380973,0.0907744,0.144731,0.000774688,-0.0722633,0.0833739,-0.319956,0.76229,-0.209174,-0.210352,-0.809084,0.517972,-0.378635,0.333338,1.00706,-0.629132,-1.35423,0.362328,0.336808,-0.152211,0.173831,0.555846,-0.514799,0.0818443,0.383247,0.507002,0.204335,0.2471,0.217187,0.872032,0.0634692,0.0442352,0.217069,0.145926,-0.124402,0.0765164,-0.158764,0.13057,0.0359622,0.0882724,-0.361178,0.315183,-0.322913,0.289518,0.387185,0.226977,-0.0588093,0.458079,0.146113,-0.104187,-0.254657,0.635889,-0.0622381,-0.123347,0.120454,-0.737483,-0.0902633,-0.233107,-0.717166,0.339343,-0.131143,0.131263,0.63858,-0.128593,0.155737,0.334862,0.38881,-0.180203,-0.227746,-0.672302,0.0177799,0.0525162,-0.0576675,-0.52729,-0.0710118,0.0492025,-0.248031,-0.153381,-0.133008,0.0636347,-0.207246,0.275654,-0.276737,0.0605648,-0.160737,-0.0398901,0.0726935,-0.122054,-0.183923,0.0866002,-0.108329,0.42644,-0.770738,-0.157925,-0.082585,-0.136591,0.069929,0.0101265,0.228594,-0.23675,0.31138,-0.0701263,0.323858,-0.45506,0.0258574,-0.120438,0.720686,0.192669,0.597167,-0.196145,0.155454,-0.0287622,0.204295,0.459613,-0.281099,0.415733,0.243038,0.245028,0.236977,-0.276056,-0.373573,-0.109864,0.20151,0.346773,-0.156508,0.0265042,-0.72512,0.0562763,-0.442537,-0.300643,-0.442109,-0.429034,0.471163,0.00378624,0.387948,0.124263,-0.151188,-0.331178,-0.695401,-0.283964,-0.0248096,0.143304,-0.177775,-0.348731,-0.017609,-0.5056,-0.387068,0.776243,0.101707,-0.00174334,0.137441,0.2464,-0.170568,-0.127401,-0.251614,0.252786,0.0272378,-0.213642,0.0749043,0.169546,0.783182,0.035157,0.0759615,-0.0379358,0.235676,-0.184703,-0.00869544,-0.182705,0.548556,-0.263543,-0.0979724,-0.116085,0.0998569,0.127445,-0.358962,0.300834,0.127283,-0.228812,0.570516,0.0961773,-0.00695963,0.0943999,0.00935084,0.190736,0.0914308,-0.274799,0.376946,-0.00539167,0.53379,0.0890595,-0.384796,0.170758,0.101547,-0.340585,0.179162,-0.0091414,0.0905999,0.330386,-0.153165,0.214043,-0.00619538,-0.0467648,-0.395803,0.0255096,-1.15843,0.0383156,-0.0613179,-0.173787,-0.106478,-0.303632,0.224487,-0.170371,-0.114519,0.646007,0.555489,-0.131497,0.568176,0.188134,-0.0456668,-0.171649,0.351493,-0.21698,0.046712,0.0208161,0.641027,-0.938359,0.206452,-0.0180956,0.180813,0.32862,0.149493,0.0005386,0.483084,-0.0207372,-0.455597,-0.149534,0.564384,0.226078,0.331887,0.094915,0.0428643,-0.570317,-0.505979,0.0555017,0.0652053,0.139934,0.419248,-0.174654,-0.287716,-0.0912618,-0.192858,-0.533104,-0.375711,-0.661278,0.119965,0.203863,0.34636,0.451511,-1.19751 +3454.25,0.938948,0.0848144,4,1.61764,0.808843,-0.793927,0.318457,0.385621,-0.0591468,-0.00225857,0.119055,0.303199,0.181138,-0.373064,-0.740763,0.0345646,0.48688,0.0144625,0.887487,0.661651,-0.131779,-0.100363,-0.124091,0.0910229,-0.761422,-0.31237,0.166986,-0.250154,0.262402,-0.0920272,0.331846,0.303322,-0.169556,0.944248,-0.407589,-0.15372,0.288307,0.0868996,-0.00357565,-0.439229,0.256226,0.455013,-0.160141,0.588594,0.211961,-0.114712,-0.505943,-0.0904001,-0.618921,-0.32766,-0.0934312,0.253929,-0.174283,-0.0258842,0.516259,-0.125327,-0.339207,0.630922,0.171142,-0.429069,-0.703357,0.317003,-0.567117,0.326081,0.754129,-0.795779,-0.625501,-0.00368758,-0.00124068,-0.312667,-0.167566,-0.211712,0.133887,0.0535305,0.0262206,0.141242,-0.481637,0.516232,0.256956,0.227391,-0.0774577,-0.464363,-0.303906,0.399281,-0.444951,0.117799,0.286757,-0.575048,0.0303452,0.00658549,-0.700886,-0.00106108,-0.403762,-0.550082,-0.0941377,-0.420391,-0.15324,-0.192434,-0.0685274,0.216275,0.0134478,-0.188972,0.558892,0.176651,0.132973,-0.0461848,-0.429044,0.461828,0.060079,-0.0648435,0.082849,0.518661,0.460442,0.183492,-0.145768,-0.260353,0.411968,-0.0857421,0.789991,-0.172713,-0.0497212,0.264246,-0.264321,-0.819327,0.339636,-0.092253,-0.456029,-0.208947,0.41831,0.123787,0.214629,0.40282,0.235724,-0.0731401,-0.17338,0.194071,0.456112,-0.387255,0.0735896,-0.15255,-0.000765919,0.0544083,-0.157914,-0.518264,-0.0853664,0.0480357,-0.636648,0.0611717,0.161693,-0.35236,0.530466,-0.393024,-0.692804,0.293384,0.0977577,0.0583438,-0.580992,0.288381,0.402688,0.434724,-0.124926,0.273934,-0.093482,0.113169,0.188182,0.785147,-0.23706,-0.272595,0.221186,0.187621,0.145416,0.0221859,0.255737,0.111128,-0.149544,-0.150843,0.196913,0.163621,0.378584,-0.142338,0.33676,0.0923451,0.723748,0.159381,-0.37491,-0.0314329,-0.1773,0.0663485,-0.151603,-0.134608,-0.09419,0.418717,-0.237376,0.0619319,-0.26396,0.125121,-0.774335,-0.255652,0.262681,-0.0172186,-0.575231,-0.72174,0.122818,-0.0658023,0.147955,0.107098,-0.525735,0.231989,-0.518482,-0.698822,0.77648,-0.149078,0.227501,0.00513858,-0.956335,0.320868,0.0118632,0.313581,-0.189957,-0.326016,0.469674,0.850591,-0.544528,-0.33675,-0.313189,-0.137368,0.377832,-0.25604,0.514442,-0.716775,-0.572189,0.117246,-0.071529,-0.0438875,0.101399,-0.222729,-0.357046,-0.304468,0.220347,-0.034582,0.260233,0.843161,-0.29024,-0.019599,-0.0367705,-0.539498,-0.228019,0.269291,0.124243,0.815785,0.175816,-0.129398,-0.486648,-0.255015,-0.343644,0.254352,0.0945295,-0.496019,0.49288,-0.180204,0.0456426,0.179595,0.0984688,-0.359879,-0.0716033,0.370643,-0.0566632,-0.058587,-0.0678005,0.0513182,-0.319161,0.0292012,-0.0778376,-0.518808,-0.785669,0.575221,-0.0264198,0.116186,-0.0433155,-0.184478,-0.202271,0.428329,-0.452124,0.0186854,0.200368,-0.321341,-0.45417,0.288099,0.170435,-0.122743,0.262308,0.868809,-0.0111367,0.108451,-0.0850405,-0.135357,-0.0799577,0.163011,-0.190758,-0.151006,-0.00970547,0.516173,-0.156171,-0.0153174,0.125463,0.184975,0.354208,0.430088,-0.962619 +3452.69,0.938089,0.0848144,4,1.62833,0.812344,-0.867447,0.257675,0.522354,-0.10504,0.0413022,-0.129043,0.516435,0.0311336,0.0473065,-0.2411,-0.194267,0.589223,-0.0348684,0.348807,0.168199,0.129829,-0.241077,-0.315088,-0.138626,-0.769757,-0.351077,0.207617,-0.29697,0.0996194,-0.315372,0.408728,0.0625363,0.126382,0.743384,-0.916985,0.176082,0.278105,0.182398,-0.334541,-0.177767,0.164212,0.324896,0.222795,0.57956,-0.0514852,0.419582,-0.171444,-0.104394,-0.508894,-0.692843,0.30417,0.130086,-0.114698,0.279595,0.349059,-0.161509,-0.211722,0.808405,0.12545,-0.279235,-0.291646,0.657789,-0.647518,-0.0554803,0.833611,-0.683196,-0.87287,-0.31633,0.273161,-0.366801,-0.436255,-0.18041,-0.571502,-0.0734123,0.392162,0.217299,-0.268225,0.403646,0.0423605,0.227611,0.0477165,-0.206809,0.157488,0.349222,-0.019072,0.194729,-0.0831788,-0.771569,-0.105768,-0.357222,-0.623099,-0.123159,-0.424558,0.371053,-0.298277,-0.262936,-0.314012,-0.0518408,-0.282716,0.459712,-0.290725,0.0810572,1.0736,0.102523,-0.360559,-0.321752,-0.191269,0.221812,-0.501969,-0.234513,0.278467,0.620358,0.388814,0.27945,0.00935752,0.242015,0.636703,-0.0055428,0.124227,-0.506331,0.00935309,0.213881,-0.0517333,-0.758058,0.197088,-0.176636,-0.556059,0.168937,-0.372236,-0.338562,0.11144,0.217485,0.0010866,-0.304019,-0.209955,0.0823404,0.423688,-0.381992,0.174487,-0.0433138,-0.247072,0.0230295,0.349976,-0.200285,-0.00761724,0.147458,-0.468181,-0.309858,-0.128343,-0.0641286,0.168817,-0.442305,0.409325,-0.220516,0.0610473,0.117031,-0.287701,0.288691,0.4859,0.319933,-0.328727,0.310385,-0.329247,0.0119799,0.254135,0.838814,-0.130162,-0.0958193,0.154777,0.308832,0.0562463,-0.262792,-0.0961127,0.385418,-0.441861,0.0910165,0.28817,-0.0124713,-0.371659,-0.26529,0.028428,0.0624254,0.693224,-0.235988,-0.298036,0.195572,-0.383916,0.00351129,-0.401471,-0.484647,-0.0542864,0.211308,-0.745427,0.149379,-0.172225,0.0981369,-0.910834,-0.15297,-0.00467181,0.307616,-0.434752,-0.552389,0.0346631,0.0294489,0.237587,-0.0217608,-0.460586,-0.240259,0.164904,-0.556115,0.90955,0.254747,0.159896,-0.246017,-0.61186,0.320933,-0.234642,-0.207017,0.309425,0.101481,0.393548,0.884032,-0.124267,-0.0657587,-0.187366,0.422293,0.53935,-0.327244,0.676825,-0.161648,0.328646,-0.139036,-0.493612,-0.0905716,0.0263092,-0.359084,-0.0121121,-0.0665364,0.320389,0.147972,-0.235498,0.649202,-0.390606,-0.286694,0.114899,-0.0679271,-0.499407,0.141133,-0.011223,0.370771,-0.101717,0.348169,-0.251416,0.0668197,-0.575158,-0.166808,0.00981121,-0.107066,0.376956,-0.311146,0.155278,-0.0433579,0.314173,-0.552724,0.0889495,0.591432,-0.00555102,0.144385,0.155066,0.0118818,-0.00879903,-0.0958585,0.00131849,-0.542506,-0.380386,0.348551,-0.0118273,-0.0416224,0.0101654,-0.0954467,-0.314016,0.270727,0.0662373,0.0511028,0.0387587,-0.120227,0.29267,-0.230333,0.422678,-0.110023,0.572355,-0.0152881,0.0437221,0.121578,-0.108015,-0.052678,0.291833,0.189369,-0.134132,0.094769,0.043002,-0.316307,-0.308834,0.296135,0.0978911,0.120945,0.312876,0.347772,-1.30429 +3457.42,0.974913,0.0848144,4,1.62061,0.79163,-0.526493,0.0690491,0.371096,-0.0630859,-0.251989,-0.267203,0.384641,0.0713369,-0.0264228,-0.302098,-0.436092,0.324903,-0.354709,0.511534,0.500493,0.11464,-0.183662,0.0728674,0.15625,-0.904163,-0.959981,0.152934,-0.507169,-0.0294419,-0.260249,-0.036462,-0.0967538,-0.315119,0.970997,-0.339552,0.468146,0.377409,0.162012,0.0308563,-0.54287,0.222317,0.579585,-0.0743457,0.629706,0.318219,-0.115944,-0.383895,0.021536,-0.293376,-0.829499,-0.110033,0.460072,-0.193518,0.449978,-0.0253723,0.151156,-0.772891,1.15555,-0.266717,0.0321077,-0.268102,0.414941,-0.0530904,0.0399119,0.840495,-0.224031,-0.740485,0.245262,0.0411096,-0.00673903,0.0790261,-0.425574,-0.603658,-0.121247,-0.0716271,0.490869,-0.1523,0.446311,0.132702,-0.0465098,0.34975,-0.215802,-0.106632,0.611039,0.0666436,0.0991372,-0.0990525,-0.392954,0.341794,-0.0221217,-0.660157,0.576183,-0.835202,0.197707,0.0929721,-0.0227691,-0.0330837,-0.123945,-0.268403,0.411312,-0.0919778,0.239468,0.768873,-0.0588362,-0.274422,-0.401167,-0.357809,0.27509,-0.353163,0.0928309,0.116068,0.585318,0.507993,-0.419975,0.167415,-0.0492048,0.430301,0.212567,0.176871,0.115663,0.0100662,-0.0687854,0.137369,-0.482616,0.0372302,-0.024425,-0.638341,0.37104,0.112383,0.130335,0.119839,0.252606,-0.158498,0.0840267,-0.248156,0.180632,0.350956,-0.292027,-0.194422,-0.203942,-0.109294,0.208566,-0.350643,-0.144355,-0.235194,0.00991707,-0.17892,0.0308023,-0.0903022,0.0542829,0.29904,-0.185895,-0.00594894,-0.514266,0.0405081,0.0990716,-0.124381,0.122993,0.619528,0.0965886,-0.275514,0.293616,0.0201985,0.0239352,-0.204394,1.03036,-0.118572,-0.212394,-0.148195,0.197829,0.14986,-0.365423,-0.132201,0.520038,-0.0633285,0.0524839,-0.122139,-0.172776,-0.150293,-0.112734,0.0300481,0.378156,0.309961,-0.00851141,-0.411552,0.0702529,-0.0105844,0.0345158,-0.408348,-0.63225,-0.149434,-0.122643,-0.649453,-0.177541,0.312291,0.133304,-0.348233,-0.399929,0.718942,-0.101236,-0.51334,-0.34384,0.548912,0.170153,-0.16238,0.174942,-0.571738,-0.149656,-0.289496,-0.864397,0.721514,0.0706608,-0.0674176,-0.402936,-0.326616,0.298273,-0.332514,0.264786,-0.171129,0.493871,0.260604,0.72605,-0.344403,0.347501,-0.262533,-0.0512281,0.690224,-0.0796105,0.585967,0.0594815,-0.119825,0.000931172,-0.291966,-0.44304,-0.0343829,-0.06636,-0.028256,0.394016,0.575355,0.609609,-0.122252,0.462265,-0.100856,-0.46471,0.0796674,0.291573,-0.376609,-0.0176007,0.164384,0.459203,0.0327681,-0.0838439,-0.32038,0.203475,-0.185224,0.169548,-0.730278,-0.2657,0.153172,-0.785569,0.216197,0.258034,-0.170676,-0.359444,0.0897183,0.127859,0.330741,0.164627,0.0802662,-0.311043,0.262913,-0.0103051,0.0496465,-0.754109,-0.10576,0.0637152,-0.10666,-0.427291,-0.392006,-0.304193,0.216751,0.458521,0.0106282,0.10095,0.206841,0.0312746,-0.0840162,0.0177262,0.281489,-0.559021,0.14558,0.115455,0.505033,0.0577601,-0.175335,0.093022,0.0591163,0.23464,0.0137814,0.55469,-0.163237,-0.14932,0.000398125,0.256355,0.11352,0.189512,0.336927,0.43533,-0.783998 +3447.13,0.698257,0.0848144,4,1.58922,0.756451,-0.847656,0.27839,0.126799,0.0433079,-0.229718,-0.0747887,0.209798,0.369486,-0.186039,0.0245559,-0.507509,0.747919,-0.102764,0.979459,0.0212382,-0.0802102,-0.574021,0.150354,0.127419,-1.00124,-1.03211,0.545271,-0.340498,-0.181535,-0.290335,0.184058,0.366343,0.222006,0.907798,-1.00546,-0.206193,0.472418,0.33155,-0.230029,-0.0560537,-0.102824,0.205234,-0.878686,1.01745,0.463333,0.550392,-0.649405,-0.485941,-0.0710759,-0.623788,-0.00221692,0.391193,0.104168,0.265113,0.429365,0.170659,-0.534803,0.884422,-0.287891,-0.146607,-1.08717,0.548904,-0.424232,-0.35978,1.01611,-0.149412,-0.572099,0.0201618,-0.29935,-0.221021,0.000814997,-0.14153,-0.193014,-0.598551,-0.109011,0.566894,0.000552882,0.268238,0.421779,0.382044,-0.00247503,-0.527815,-0.142998,0.547109,-0.343268,0.186832,0.0380491,0.0373499,0.0907938,0.156467,-0.345626,0.563747,-0.43982,0.480571,-0.0552578,-0.492735,-0.0545984,0.0871152,-0.230908,0.31876,-0.0272654,0.399466,0.321547,0.365917,0.106651,-0.357424,0.0182462,0.307589,-0.675979,0.284735,0.0660857,0.512476,0.454594,-0.265471,-0.112581,0.300008,0.375537,0.213701,0.191054,-0.374892,-0.15223,0.175113,0.564708,-0.375838,-0.171516,0.122782,-0.214633,-0.21508,0.361387,-0.299291,-0.210029,0.314,-0.00807976,0.0310678,0.196216,0.301987,0.477199,0.0950627,0.189793,-0.0177531,-0.0064092,0.144208,-0.673796,-0.330527,-0.0986663,0.387895,-0.31832,0.287082,0.070117,-0.445098,0.200255,0.116626,-0.0242743,-0.249214,0.247198,-0.150891,0.138403,-0.447145,0.00759119,-0.264429,-0.161583,0.29271,-0.134128,0.0407456,-0.176212,0.999705,-0.0695535,-0.0866238,0.404148,0.371787,-0.105402,-0.639815,-0.117321,0.110926,0.208586,0.0769526,-0.0148995,-0.332891,-0.00953791,-0.408947,0.408754,0.398468,0.52267,-0.124056,-0.199391,0.620905,0.116762,0.263678,-0.283509,-0.630741,-0.242303,0.0765162,-0.528404,0.0439883,0.585137,-0.505598,-0.490078,-0.248895,0.595378,0.0304954,-0.502801,-0.0834433,-0.145632,0.0603171,0.0641154,0.20209,-0.744087,0.132904,-0.583314,-0.688017,0.91867,0.499003,0.0535363,0.112866,-0.487517,0.340494,0.223858,0.086724,0.156552,-0.202023,0.433232,-0.0620485,-0.610666,0.309217,-0.0772151,-0.0128263,0.0585889,-0.0926401,0.536893,-0.138262,-0.0535593,0.131136,0.0878568,0.180029,0.183742,-0.0710505,0.037253,0.531557,0.428087,0.36412,-0.181789,0.356071,-0.30828,-0.117659,0.314972,-0.371259,-0.146307,0.411035,-0.056021,0.694519,0.286677,0.303938,-0.651679,0.274898,-0.222537,0.338196,-0.304997,0.0551609,-0.0170746,-0.870259,0.201329,-0.365607,0.00945166,0.013071,0.606711,0.535995,0.0463453,-0.143975,0.128425,-0.355088,0.510603,0.389996,-0.32533,-0.565753,-0.0814401,-0.133367,0.273097,-0.273461,-0.166848,-0.0823572,0.0563037,0.283743,0.376795,-0.505296,-0.0422956,-0.461378,-0.564096,-0.268329,-0.00186543,-0.309577,0.176875,0.330031,0.215697,-0.194785,-0.236336,0.00642418,-0.135916,0.125566,-0.150613,0.447074,-0.0168992,-0.600833,0.0494385,0.494753,0.106391,0.265679,0.326176,0.515441,0.00143173 +3428.49,0.526085,0.0848144,4,1.55403,0.731605,-1.18175,0.471806,0.334075,-0.107936,0.141941,-0.625336,0.493316,0.0533922,0.190734,-0.178505,-0.427057,0.161837,-0.465669,0.688923,0.296156,0.16118,-0.330334,-0.0134026,0.247361,-0.560931,-0.65612,0.135641,-0.333411,-0.611979,-0.350518,-0.425749,-0.205663,-0.127396,0.861121,-0.600067,0.204379,0.552721,-0.528998,-0.0373648,-0.1481,-0.0791503,0.565569,0.122508,0.884034,0.763155,0.180235,-0.589656,-0.345636,-0.14146,-0.472557,0.377704,0.281642,0.0481271,0.250673,0.248273,0.215593,-0.5082,0.71979,0.0893152,0.00500475,-0.747061,0.38183,-0.337912,-0.0501836,1.14134,-0.0366615,-0.588897,-0.277466,-0.0341461,0.263312,-0.179102,-0.108607,-0.164307,-0.296397,0.501364,0.689514,0.254966,0.44394,0.565772,-0.0215133,0.816698,-0.534149,-0.196204,0.344515,0.0668575,0.329483,0.276658,0.242398,-0.204343,-0.507543,-0.89797,0.0283658,0.117791,0.160503,0.232052,-0.382519,0.307266,0.222149,-0.451317,0.58298,-0.00456627,-0.0513529,0.241168,-0.0477891,-0.31081,-0.253511,0.102893,0.0719547,-0.631021,0.0104884,-0.183984,-0.140044,0.742399,0.0577434,-0.29007,-0.0757051,0.376801,0.0652931,0.21669,0.0786957,0.348505,-0.0822275,0.439175,-0.642045,0.167231,0.103321,-0.623145,0.264094,0.499102,-0.00511889,0.00549928,0.147677,-0.300551,-0.331999,0.163185,0.00913494,0.0689989,-0.28293,-0.0989194,0.481494,-0.105427,0.335179,-0.671489,-0.199798,0.0161448,0.105728,-0.293568,0.360078,-0.00648475,-0.192324,0.00484836,-0.0346153,-0.925035,0.0342805,-0.121819,0.536352,-0.23814,0.279515,0.969779,0.648134,0.109704,-0.0160053,-0.0705573,0.47325,0.533153,0.849924,0.179759,0.0503401,0.460075,-0.0108483,0.155774,-0.250452,-0.235328,0.264119,-0.104532,-0.146892,-0.0632313,0.141875,0.0864875,-0.484179,-0.182279,0.189195,0.131794,-0.248029,-0.134242,0.23441,0.63252,0.226913,-0.488371,-0.181263,-0.113161,-0.202151,-0.157601,-0.0360103,0.10567,-0.123786,-0.612178,-0.224131,0.416553,0.0684633,-0.396203,-0.108456,-0.151748,-0.114358,-0.389157,0.403672,0.294727,0.70327,-0.445962,0.248269,0.993177,0.886418,-0.108345,-0.0598336,-0.125112,0.18522,0.0421778,0.306084,0.0685586,0.0924107,-0.0512301,0.0965448,-0.309747,-0.110299,0.197955,-0.41019,0.00313892,-0.485326,0.619238,-0.328999,-0.890591,-0.0828608,0.098551,-0.0190505,0.0179409,-0.250802,-0.533326,-0.487628,0.536693,0.202126,0.415428,0.622498,-0.753745,-0.396498,0.130492,-0.0131319,0.150601,0.155426,0.369103,0.298601,0.178753,-0.0318711,-0.51491,0.202748,-0.352604,0.325387,-0.0896667,-0.0399137,0.76992,-0.48672,0.354923,0.337879,0.304857,-0.419244,0.195719,0.530605,-0.0901558,-0.232482,0.0354584,-0.17084,0.0860429,-0.405748,-0.668515,-0.21302,-0.137994,0.243476,-0.189858,-0.282238,-0.211249,0.202558,0.128608,0.152367,-0.160108,-0.24695,-0.0883812,-0.735911,0.13548,0.222239,0.120902,-0.263978,-0.325099,0.260721,0.167395,0.147396,0.0334568,0.598303,0.0462433,0.112095,-0.768684,0.0441061,-0.477728,-0.308468,-0.359985,0.111687,0.147595,0.230685,0.384181,0.480297,-0.64802 +3429.93,0.948735,0.0848144,4,1.58013,0.771765,-1.01597,0.346396,0.564363,-0.210017,-0.351832,-0.662271,0.186126,0.189856,0.237563,-0.0509014,-0.242119,0.35446,-0.393028,0.749987,0.15533,0.17254,-0.569733,-0.192133,-0.172626,-0.795754,-0.528373,0.261713,-0.292805,0.0249754,-0.249532,-0.07362,-0.336321,0.0260431,0.623855,-0.345112,-0.34284,0.557187,-0.330353,-0.132552,-0.272863,0.309571,0.663403,-0.0113797,1.02904,0.888579,0.163763,-0.604759,-0.3764,-0.352467,-0.236799,0.247304,0.42903,0.311301,0.290936,0.214215,0.10356,-0.470182,0.730802,-0.332328,-0.103386,-1.00667,0.461585,-0.45172,-0.103522,1.28474,0.0379328,-0.992845,-0.197496,-0.1539,0.38537,-0.421691,0.022232,-0.202192,-0.00621878,0.850469,0.576683,0.17652,0.176534,0.299264,0.0511403,0.36385,-0.21705,-0.0701181,0.333614,-0.00866151,0.26843,0.070181,0.237697,0.182336,-0.356358,-1.02169,0.0625969,-0.219174,-0.0605059,0.318596,-0.3986,0.301998,0.317419,-0.392778,0.39861,-0.208164,-0.0313955,0.336857,-0.24728,0.0112582,-0.219132,-0.204083,0.111801,-0.552688,0.237624,0.0376636,0.0181687,0.387122,0.459685,-0.134494,-0.331634,0.41933,0.376151,-0.0824695,0.143131,0.445333,0.103618,0.406022,-0.619833,-0.0369045,0.151834,-0.390709,0.34982,0.691747,0.108425,-0.363814,-0.084535,-0.466108,-0.00582087,0.420484,0.0391596,0.219807,-0.157527,-0.141088,0.57082,-0.34058,0.0396793,-0.828528,-0.21163,0.182474,0.465638,-0.148897,0.354624,0.076906,-0.190167,0.240345,0.0528722,-0.502442,0.0900731,-0.101155,0.359206,-0.488666,0.203479,0.676298,0.734316,0.0369989,0.153634,0.0119611,0.532993,0.759882,0.883591,0.0293706,0.0356684,0.153149,0.062277,-0.006188,-0.0046145,-0.340208,0.154976,0.143516,0.0101067,0.416844,-0.323013,-0.0374461,0.0638753,-0.256168,-0.0775282,0.587475,-0.594355,-0.115016,-0.0392218,0.453534,0.0939661,-0.985287,-0.323655,-0.392191,0.34541,0.123357,0.0452374,0.132708,0.364405,-0.756693,-0.456355,-0.0689858,0.389174,-0.346361,-0.179622,0.0967692,-0.247747,-0.221754,0.500989,0.22864,0.474661,-0.569461,0.386761,0.727027,0.474971,0.11766,-0.250347,0.162938,0.298521,-0.186922,0.467919,-0.0286238,0.022111,0.225067,0.482345,-0.130146,0.0111593,0.229422,-0.489977,0.401976,-0.525052,0.624442,-0.376076,-0.321451,0.284147,0.18632,0.0225416,0.193373,-0.233397,-0.33105,-0.372474,0.330785,0.339145,0.530545,0.402227,-1.04205,-0.414261,0.0679919,0.217314,0.570534,0.0866678,0.294219,0.219065,0.111653,-0.132459,-0.41031,-0.158713,-0.546591,0.555452,-0.496139,-0.142948,0.39355,-0.467651,0.204066,-0.241489,0.295379,-0.188525,0.286681,0.69894,0.0439968,-0.612138,0.127302,0.0542788,-0.368446,-0.282224,-0.560589,-0.268196,0.170709,0.339066,0.0694011,-0.325227,0.245736,-0.105693,-0.175943,0.156955,0.368719,0.135312,0.00241923,-0.608834,0.405461,0.5034,0.0346601,-0.0975473,-0.148212,0.252436,-0.0301169,0.329426,0.0463699,0.507207,0.196681,0.19073,-0.762064,0.116514,-0.148843,-0.362184,-0.203814,-0.184412,0.12037,0.194569,0.346943,0.4411,-1.40008 +3421.86,0.64826,0.0848144,4,1.62793,0.773452,-1.14177,0.418327,0.484687,-0.270661,-0.0889144,-0.391188,0.0512581,0.161067,-0.0272962,-0.365185,0.234152,0.0369752,-0.378718,0.259661,0.00906806,-0.0242534,-0.496391,-0.0588559,0.250826,-0.655334,-0.995389,0.336692,-0.146685,-0.796796,-0.83794,0.430362,0.094098,-0.474221,0.963841,-0.858749,-0.738427,0.473623,-0.465396,-0.376931,-0.320012,0.535797,0.458326,-0.0481524,1.12485,0.752023,0.278699,-0.673432,-0.0358883,0.190209,-0.849016,-0.0667888,0.304893,0.252875,0.0560647,0.262683,0.232216,0.155534,0.585919,-0.474596,-0.289296,-0.584636,0.173954,-0.373721,-0.144726,0.969302,-0.77701,-1.29222,0.166793,0.733239,-0.636056,0.278338,-0.251327,-0.297607,0.114754,-0.401324,0.679555,0.0798726,0.542494,0.705373,0.347512,-0.299088,-0.470748,-0.0242025,0.0383858,-0.852449,0.160203,-0.538585,-0.417231,0.04793,-0.0197639,-0.542748,0.0466898,-0.569168,0.03684,0.16914,-0.400433,0.249097,0.247591,-0.353536,-0.954339,-0.177369,-0.295622,0.0740514,-0.835245,-0.179915,-0.493769,-0.126045,0.467304,-0.826045,0.281669,0.0938664,-0.00749855,0.488428,-0.381116,-0.0921122,-0.0247625,0.380911,-0.409638,0.112151,0.0685378,0.269641,0.688382,-0.298414,-0.811157,0.27326,0.368654,-0.26175,-0.208075,0.261207,0.167619,-0.346605,-0.0460729,-0.228811,-0.382678,-0.0564258,0.177434,0.320989,-0.0216477,0.0534925,0.0203758,-0.123697,0.204794,-0.374834,-0.319172,-0.162364,0.0420686,-0.0605202,-0.0856681,0.0505314,-0.259961,0.351006,-0.196418,0.249382,0.186876,-0.206273,0.403405,0.236079,0.00458694,0.595517,-0.00235892,-0.115225,-0.215484,-0.781835,-0.0375219,-0.0946021,0.879163,0.327473,0.288723,-0.0890067,0.172996,-0.135784,0.385158,-0.130349,0.113222,0.45642,0.00408428,0.192114,-0.0196854,-0.0818365,-0.302184,-0.022198,0.337308,0.42946,0.197933,0.0754495,-0.0136683,-0.219228,-0.164375,-0.364215,-0.1298,-0.15571,0.0397661,-0.810448,0.276566,0.0821149,0.049143,-0.431099,-0.0896933,-0.277084,-0.0528899,-0.504656,-0.0313047,-0.0602964,0.270378,-0.0960245,0.544527,-0.353865,-0.0437691,0.110745,-0.284506,0.95241,-0.0795568,0.644774,-0.0856768,-0.227876,0.752575,-0.196734,-0.428887,-0.377511,-0.895139,0.0611968,0.0778822,0.209332,-0.119063,-0.0931365,0.0371641,0.103335,0.16325,0.258847,-0.609232,-0.311991,0.0130308,0.331233,-0.270013,0.0312403,-0.536496,-0.17792,-0.303559,0.47961,0.600991,0.119871,0.112101,-0.83553,-0.645515,-0.674085,0.0379729,0.463811,0.540026,0.31208,0.588067,0.0929707,-0.176969,-0.0114533,0.675092,-0.574928,0.493329,-0.337115,0.310846,0.412902,-0.33402,0.0879083,0.155482,0.23299,-0.170581,0.310474,0.243936,0.272768,0.478012,0.0488568,-0.183477,-0.721306,0.293697,-0.0344955,0.406459,0.0859493,-0.382601,0.591179,0.303681,-0.334217,0.267143,-0.587947,0.0495656,-0.00196214,-0.025641,0.565841,0.448991,0.41281,0.0807469,0.348487,-0.0347139,-0.110537,0.0707516,0.179031,0.269087,-0.185397,0.334276,0.0210075,0.111938,-0.422662,-0.0695541,-0.189803,0.00301791,-0.0884245,-0.249937,0.139896,0.309367,0.374027,0.556208,-1.0777 +3373.32,0.914909,0.0848144,4,1.49451,0.770315,-1.63879,0.560378,0.0696034,0.0422592,-0.953058,-0.100219,0.139746,0.0101845,-0.105265,-0.300965,-1.14866,0.35873,-0.465019,0.547669,0.0817111,-0.454519,-0.442493,-0.0177133,-0.0543549,-1.36825,-0.494844,0.371273,-0.39174,0.108,0.112023,-0.654369,-0.603559,-0.0627602,0.906033,-0.373021,-0.567584,0.0697414,-0.372148,-0.239032,0.294764,0.310982,0.549564,0.0325375,1.13297,0.849147,0.596389,-0.648708,-0.0343197,-0.225888,-0.84261,0.370641,0.609087,-0.263253,0.302657,0.95648,0.709858,-1.37742,0.531709,0.322983,-0.257257,-0.605143,0.511402,-0.35128,0.617372,0.894066,-0.340337,-0.978101,0.417528,0.296893,0.595396,-0.514585,-0.105834,-0.320313,-0.512289,0.365903,0.563852,-0.707221,0.214626,0.728165,0.442533,0.421352,-0.084712,0.10203,1.02686,-0.199746,0.326733,-0.0349475,0.08401,0.273115,0.103407,-0.904757,0.391443,-0.162244,-0.778773,0.389085,0.305141,0.185442,0.564011,-0.342909,0.459745,-0.402274,-0.0949254,0.337794,0.284192,0.0451475,-0.115506,-0.0908417,0.265458,-0.271408,0.54942,-0.662354,0.663931,0.478451,-0.030129,-1.08393,0.262499,0.469845,-0.300475,0.558682,-0.22795,-0.171084,-0.305378,-0.0857391,-0.205938,-0.339048,0.194273,0.0293376,0.368473,0.0487398,-0.459061,0.212384,0.4086,-0.256591,0.497591,0.15267,0.413701,0.621554,-0.123827,-0.0446946,0.258909,-0.309872,0.344884,-0.491174,-0.140411,0.246441,-0.631742,-0.228604,-0.461234,-0.0195318,-0.376832,0.660988,0.0395693,-0.450604,0.270348,0.302038,0.112044,0.32746,0.119699,0.571303,0.0711632,0.111769,0.065256,0.245616,0.151951,0.266438,0.483081,-0.32356,0.141854,0.402267,-0.064288,0.403581,-0.648407,-0.328798,0.0726659,-0.614139,-0.0167103,-0.226807,-0.0122611,-0.361691,-0.315009,0.0630101,-0.0951499,1.14774,-0.0390627,-0.257692,0.032801,0.203336,-0.392351,-0.52387,-0.870566,-0.362322,0.324672,0.258026,-0.0768473,-0.0531019,-0.0801237,-0.0478343,0.580306,0.700685,-0.159849,-0.106989,-0.625717,-0.17767,-0.225039,0.0786163,-0.417881,0.0429954,0.0811519,-0.56517,-0.230918,0.95948,0.248619,0.183997,-0.284033,0.472869,-0.121443,-0.065669,0.28766,0.862082,0.0578146,0.20202,0.117697,-0.897235,0.0842642,-0.783346,0.290382,0.571109,-0.490605,0.412529,0.180854,-0.611495,0.267347,-0.801711,-0.354371,0.141472,0.421425,-0.0209096,-0.72518,0.284705,-0.114273,-0.046402,1.12198,0.596097,-0.00205483,0.655241,0.209382,-0.170443,-0.126279,-0.472849,0.0164903,0.233121,0.362792,-0.326782,-0.183579,-1.06731,0.905358,-0.0200974,-0.045734,0.148207,-0.111299,0.463597,-0.243152,0.0395259,0.0556466,0.117041,0.493927,0.0483908,-0.353546,0.381471,0.290991,0.323975,-0.0941531,-0.178621,-0.201365,0.0853257,-0.66849,-0.238629,-0.451291,-0.196293,-0.127155,0.63795,-0.398077,0.0885689,-0.147327,-0.788054,-0.0962266,-0.939608,0.272426,0.101082,0.0617978,-0.0764026,-0.854641,0.0664682,-0.0602804,0.354613,0.33466,0.638411,-0.368148,-0.222167,-0.0305164,-0.138911,-0.551165,0.468644,-0.053252,0.198312,0.301025,0.445323,0.548657,0.220601 +3387.13,0.980684,0.0848144,5,1.43142,0.883191,-0.397957,0.070418,0.762008,-0.063349,0.248003,-0.550694,0.238133,-0.241541,0.312615,-0.567819,0.637335,0.368275,0.15078,0.571144,0.318996,0.236806,-0.242725,0.160859,0.374728,-0.357318,-0.911143,0.316614,-0.454472,-0.399049,-0.336141,0.283718,-0.00644642,-0.0340174,0.676438,-1.01088,0.109917,0.653908,0.11853,0.177165,-0.60035,0.159491,0.866372,-0.677543,0.713787,0.0107994,0.512158,-0.378977,0.398376,0.689237,-0.53696,-0.0180027,0.514867,-0.00706342,0.0750192,-0.548,0.232265,0.375268,1.43451,-0.394624,-0.0216608,-0.298684,0.812179,-0.176081,-0.561958,1.25041,-0.780847,-1.1399,-0.0577436,0.523785,-0.450725,0.612128,0.260088,-0.678723,0.546964,0.376183,0.629816,0.428825,0.784266,0.588959,0.315089,-0.2565,-0.549508,-0.303582,0.192116,-0.64557,-0.0972769,-0.527898,-0.632544,-0.231081,0.150717,0.348872,0.179906,-0.303222,0.506902,-0.380557,-0.326623,0.0889739,-0.37594,-0.288711,-0.0617397,-0.169559,0.503468,0.526233,0.431287,-0.454034,-0.108254,-0.648622,-0.239527,-0.0263335,-0.108048,0.231765,0.361098,0.461866,0.000622529,0.255069,-0.0495847,0.146307,0.337877,-0.116233,-0.519069,-0.0560152,0.577861,0.390462,-0.826265,0.014857,-0.494163,-0.514136,0.139109,0.482212,0.76519,-0.181828,-0.356338,-0.0762315,-0.356106,-0.105735,-0.474716,0.169731,0.16265,-0.0397117,0.0391204,-0.0185617,0.255018,-0.370872,-0.682392,-0.373949,0.418429,-0.430981,0.456149,0.612141,0.118545,0.511195,0.0641865,0.118968,-0.394271,-0.133773,0.63487,-0.277653,0.516477,0.660965,0.245788,0.182479,0.404216,0.334673,0.0773897,0.183507,0.706574,0.320027,0.309379,-0.0755821,-0.0073922,-0.356111,0.175645,-0.0352773,-0.35554,0.84951,-0.109831,0.0928001,0.134123,0.0318017,-0.460637,-0.210143,0.768415,0.626856,0.272887,-0.39668,0.251769,-0.160064,0.34098,0.0110199,0.254576,-0.402319,0.351319,-0.872132,0.22471,-0.0129015,-0.108353,-0.625912,-0.348651,0.0457297,0.165635,-0.668264,-0.340167,0.00904289,0.0473401,-0.795434,0.728918,-0.243349,0.160909,0.291543,-0.450511,1.0773,-0.0302241,0.0570231,0.0712353,-0.347176,0.386344,0.34182,0.0319936,-0.420617,-0.247074,0.446057,0.808263,-0.0514551,0.387269,-0.149104,-0.767268,0.300995,-0.341026,0.445132,-0.412216,0.03535,0.561476,0.244029,0.0341014,-0.0174266,-0.808886,0.0096587,-0.0546925,0.294665,0.143683,0.507714,0.316957,-1.20188,-0.358823,-0.516997,0.218693,0.323501,0.7097,0.408835,0.464559,0.278311,-0.537767,-0.285299,0.0160502,-0.217838,0.269774,-0.354655,-0.237323,0.0745019,-0.733933,-0.160008,0.112912,0.0366396,-0.249889,0.55731,-0.14663,0.203223,0.383896,0.166672,-0.115757,-0.623949,-0.198502,0.0370442,0.243294,-0.495122,0.0628627,0.465358,0.259615,0.697491,0.535239,-0.473501,0.517507,0.272597,-0.291338,0.0787533,-0.126115,0.858394,-0.297568,0.784883,-0.584426,0.676439,0.341165,-0.317751,-0.194386,-0.194163,-0.0747807,-0.381186,-0.173586,-0.610226,0.299469,0.303461,0.0291352,-0.335226,-0.0680182,0.172868,0.258421,0.415773,0.508352,-2.50158 +3416.39,1,0.0848144,4,1.44378,0.841945,-0.924886,0.300893,0.733379,-0.0909056,0.361888,-0.581154,0.0603806,-0.190773,0.351039,-0.569403,0.113369,0.26292,-0.308479,0.897761,-0.136187,0.192009,-0.0867198,0.0896899,0.217284,-0.439447,-0.533628,0.363406,-0.118646,-0.345135,-0.0676075,0.0110403,-0.21608,0.219961,0.664231,-0.741928,0.169869,0.497217,0.0715882,0.27291,-0.496855,0.222848,0.582385,-0.849985,0.999835,0.320254,0.542028,-0.643765,0.162009,0.618412,-0.943254,0.23392,0.453274,0.270916,0.0686571,0.096208,0.103621,-0.323478,1.06095,-0.469638,0.119783,-0.148077,0.939172,-0.327519,-0.40583,1.356,-0.655256,-0.795719,0.0343893,0.762834,-0.512131,0.54232,0.362425,-0.26654,0.123016,0.337753,0.623613,0.271134,0.870294,0.562528,0.382424,0.054587,-0.536409,-0.382882,0.0563589,-0.508713,0.165234,-0.1892,-0.0471927,-0.465386,0.0633687,0.289457,-0.0957888,-0.223348,0.00354305,-0.250412,-0.314513,0.071589,-0.0371017,0.12912,-0.0301342,0.155663,0.345716,0.304996,0.22037,-0.0767541,-0.401244,-0.487636,0.10257,-0.447873,-0.202708,0.0901288,0.284687,0.428899,-0.00376489,0.244227,0.197934,0.184399,0.398733,0.0876911,-0.405565,0.120509,0.499914,0.0782214,-0.756296,-0.0716035,-0.586035,-0.201484,-0.0492258,0.783148,0.247373,0.0475792,-0.244305,0.273947,0.154783,-0.00960442,-0.194514,0.315556,-0.183185,-0.0940238,0.286195,-0.0677019,0.118446,-0.230128,-0.504243,-0.0838295,0.406919,-0.164995,0.216476,0.461355,-0.0372946,0.0578302,0.0996198,-0.270407,-0.985278,-0.193876,0.292959,-0.100785,0.508222,0.916789,0.380819,0.141705,0.341458,0.25241,0.418464,0.252736,0.884651,0.208171,-0.222643,-0.00448537,0.0351558,-0.0858739,0.0728694,0.158909,0.0468397,0.28148,-0.0148605,0.278322,0.23792,0.368122,-0.314781,-0.0742499,0.209228,0.24313,0.123028,-0.733076,0.4815,-0.256963,0.738468,0.0149644,0.036442,-0.101289,0.326789,-0.768793,-0.179362,-0.368377,0.0500562,-0.760826,-0.230565,0.373173,-0.136174,-0.918631,0.00660948,-0.08467,-0.060933,-0.589704,0.568864,-0.348037,0.326753,0.0522857,-0.426402,1.13615,0.243947,-0.102746,0.279107,-0.137338,0.0188132,0.068581,0.11847,-0.512925,-0.21286,0.34499,0.998763,-0.0764019,-0.0080822,0.0140555,-0.969777,-0.0567944,-0.329913,0.231704,-0.565736,0.0354171,0.409497,0.110819,-0.237611,-0.199852,-0.7988,-0.0415089,0.251013,0.170914,0.215263,-0.0366869,0.193809,-1.03199,-0.223758,-0.247573,0.119946,0.284421,0.219229,0.499061,0.136396,0.489158,-0.461036,-0.23511,0.441389,-0.261719,0.466483,-0.197972,-0.34021,0.25078,-0.456184,-0.230898,0.139389,-0.0770695,-0.0962578,0.83908,-0.14004,0.380007,0.0427691,0.113453,0.607016,-0.583773,-0.683042,0.3004,0.440747,-0.0638739,0.12714,0.508535,-0.107249,0.423037,0.293479,-0.114913,0.456296,-0.0451267,-0.331986,-0.238297,-0.616034,0.424956,0.0191137,0.708936,-0.324273,0.911271,0.12191,-0.425278,-0.218948,-0.109654,-0.137014,0.114248,0.0369856,-0.436672,0.102203,-0.158068,-0.199362,0.287076,-0.0349159,0.153683,0.213555,0.392024,0.46212,-2.25607 +3408.38,0.992945,0.0848144,5,1.50736,0.915364,-1.23288,0.443585,0.174495,-0.196613,-0.221943,-0.00549364,0.52388,0.148406,-0.133461,-0.30267,-0.0436153,0.599707,-0.329019,0.688556,0.211257,-0.0491729,-0.468398,-0.0313617,-0.245998,-1.26821,-0.656748,0.201806,-0.233052,-0.34347,0.530798,0.330757,-0.279477,0.0317566,0.525783,-0.0518858,0.353335,0.0846761,-0.48883,-0.146328,-0.570442,0.281642,-0.214248,0.140946,1.15503,0.294228,-0.0443552,0.132482,-0.332095,-0.598677,-0.030232,0.269893,0.278545,0.340301,0.61711,0.334401,0.00421802,-0.291826,0.612186,0.0147205,-0.31064,-1.17312,0.376341,-0.256988,0.652384,0.748608,-0.0923262,-0.857989,0.335031,-0.326169,0.178708,-0.277926,0.447611,-0.797425,0.196915,-0.23166,0.588771,0.236575,0.244064,0.0137605,0.15662,-0.216603,-0.00692086,0.144527,0.851772,-0.264018,0.16781,-0.268092,-0.146664,0.0859665,0.0722303,-0.295269,0.0719314,0.0651261,0.0395169,0.017988,0.22141,-0.220863,-0.09738,-0.333784,0.0355991,-0.160466,-0.127945,0.297821,0.398557,0.0596596,-0.436001,-0.117428,0.400666,0.0991144,0.377237,-0.0286386,-0.161863,0.346377,0.224155,-0.396682,0.441571,0.133374,0.198598,-0.229779,-0.391425,-0.200587,0.158904,-0.0631977,-0.407572,-0.230639,0.120198,0.270891,-0.117419,0.184929,-0.156311,0.328548,0.324401,-0.128747,-0.191314,-0.0194992,-0.149016,0.499858,-0.320782,-0.155311,-0.0766135,-0.534374,0.201137,-0.571987,-0.187888,0.0426415,-0.395486,-0.605288,-0.298362,0.215505,-0.00167147,0.423568,0.290701,0.331046,0.409583,0.548119,-0.0797027,-0.406032,0.344039,0.665723,0.221895,0.0781165,-0.229747,0.196465,0.0642428,-0.64597,0.826274,-0.374839,-0.1016,0.240285,0.236952,-0.507867,-0.518936,0.217735,0.537495,-0.430049,-0.369458,-0.319352,-0.320819,-0.473447,-0.459772,-0.538435,-0.0387186,0.976196,-0.180922,0.51872,-0.235315,-0.242048,-0.109982,-0.94911,-0.382206,-0.358325,0.357164,0.0939466,0.191397,0.671352,-0.226923,-0.40886,0.187835,0.369523,0.0113155,-0.456061,-0.767587,0.339511,-0.0550637,0.190296,0.412903,-0.433412,-0.447937,-0.166118,-0.102949,1.31828,-0.226375,-0.230316,-0.204258,-0.268776,0.126165,0.66904,-0.0511842,1.19985,-0.257587,0.197257,0.00665819,-0.343907,-0.542694,-0.697098,0.191474,0.621685,-0.931421,0.680151,-0.554856,-0.685852,0.0111527,0.349731,0.102492,-0.102064,0.198448,-0.297997,-0.679085,0.469985,0.272987,0.538013,0.549508,0.113307,0.374083,0.0895628,0.0211895,0.738079,0.339319,0.289565,0.672911,0.348972,0.334344,-0.0780329,-0.00279819,-0.634667,0.0932138,-0.210184,0.833051,0.365511,-0.251964,0.384529,0.144425,0.176663,0.63407,0.276543,0.220235,0.225299,0.067831,0.15574,-0.00319548,0.484807,0.0772818,-0.103021,-0.597632,-0.64508,-0.0638644,0.00274346,0.765318,0.0172516,0.172327,-0.0566106,0.00180725,-0.406884,0.369458,0.364057,0.187578,0.0185002,0.478443,-0.958062,-0.145283,-0.126121,-0.167915,0.0942843,0.0795196,0.55264,0.418024,0.626896,-0.35489,-0.362951,-0.0415603,0.058999,-0.111254,-0.287444,-0.0564309,0.165276,0.17028,0.406541,0.41265,-0.413995 +3407.66,0.97004,0.0848144,5,1.55629,0.888326,-1.11907,0.387325,0.00858603,-0.161616,-0.0770095,0.0125281,0.644605,0.0272303,-0.282581,-0.325889,0.00693078,0.434148,-0.262279,0.785211,0.403582,-0.108534,-0.571367,0.0813626,-0.304749,-0.895975,-0.562134,0.155687,-0.50176,-0.320413,0.447556,0.332623,-0.240755,0.151625,0.309963,-0.282502,0.264049,0.0526628,-0.400591,-0.154512,-0.515296,0.60182,-0.071018,-0.00888406,0.963847,0.376063,0.164503,0.0735082,-0.198616,-0.530995,0.112824,0.323306,0.311779,0.230272,0.519339,0.13917,0.137408,-0.324952,0.517675,-0.18188,-0.386285,-0.771999,0.536309,-0.123006,0.496291,0.729491,-0.159501,-0.431627,0.201063,-0.0533081,0.205502,-0.101402,0.425034,-0.860524,0.129614,0.0625618,0.50584,0.226986,0.148464,-0.0427441,0.210717,-0.400123,0.0896535,0.311824,0.761359,-0.244399,0.112301,-0.260672,-0.0642465,0.0260673,0.10524,-0.437414,-0.0729051,0.132021,-0.120824,-0.073148,0.31282,-0.106336,0.147642,-0.290543,0.27005,0.133064,-0.187332,0.157587,0.462879,0.0236832,-0.523968,-0.349096,0.532772,-0.0927487,0.184784,0.116627,-0.00514279,0.315057,0.488282,-0.210374,0.345026,0.104696,0.00236671,-0.0271151,-0.314502,-0.37947,0.579314,-0.389415,-0.586513,-0.403588,0.161135,0.295508,-0.205689,0.153255,-0.184512,0.243736,0.233567,-0.311737,0.0457265,-0.0242722,-0.129567,0.491797,-0.507812,-0.206398,0.0353152,-0.736946,0.465103,-0.338518,-0.145963,0.127445,-0.502478,-0.522926,-0.47452,0.320551,0.123469,0.182173,0.329015,0.299879,0.209125,0.690818,-0.0369304,-0.298273,0.284187,0.903861,0.171519,0.00655997,-0.045098,0.385191,0.039187,-0.68047,0.957523,-0.682286,-0.146367,0.415842,0.230049,-0.778764,-0.584224,0.31811,0.740722,-0.333282,-0.310432,-0.061713,-0.386383,-0.413202,-0.443633,-0.566535,-0.0125833,1.07916,-0.30828,0.507344,-0.209572,-0.289709,-0.0839802,-0.765007,-0.0719687,-0.359624,0.551614,0.0256991,0.322308,0.505505,-0.150004,-0.482331,0.0936399,0.438265,0.0402783,-0.255997,-0.699783,0.504109,-0.0806694,0.163167,0.574569,-0.306128,-0.559098,-0.414583,0.0185172,1.28273,-0.272638,-0.452747,0.0737914,-0.324396,0.183212,0.860932,0.020519,0.959781,-0.139529,0.174582,-0.131127,-0.279616,-0.507567,-0.617827,0.06825,0.667968,-1.00051,0.804404,-0.487783,-0.792542,0.129086,0.609596,0.00189318,0.0125412,0.26803,-0.232415,-0.705779,0.482135,0.37113,0.350591,0.403765,0.187078,0.155881,0.183697,-0.194882,0.40718,0.33928,0.115032,0.531948,0.162806,0.260966,0.00347681,0.0187365,-0.563421,-0.039045,-0.224138,0.632145,0.337532,-0.329483,0.366591,-0.00375997,0.294636,0.660526,0.223332,0.196419,0.108252,-0.222067,-0.102118,0.0653329,0.355076,0.0185144,-0.0984681,-0.590194,-0.668244,-0.11451,-0.251361,0.853707,0.0792789,0.20098,0.013546,0.0850778,-0.666384,0.35878,0.288444,0.0561455,-0.132224,0.50717,-0.572181,-0.0930064,-0.163422,0.0332329,0.204958,0.0141293,0.563839,0.470185,0.923306,-0.224655,-0.578662,-0.353894,0.0420817,0.00513923,-0.386852,-0.202019,0.163167,0.145927,0.403939,0.382004,0.218323 +3417.19,0.993696,0.0848144,4,1.58071,1.07052,-0.700702,0.199308,0.545637,-0.0717319,0.169108,0.215322,0.442479,0.135724,0.24478,-0.388766,0.217575,-0.0398826,-0.159976,0.526845,0.190016,0.00806749,-0.235272,-0.282781,-0.488112,-1.15095,-0.692542,-0.355802,0.134829,-0.196653,0.244711,0.552601,-0.0537287,0.0199392,0.406218,-0.349464,-0.389514,-0.0981424,-0.153629,0.141543,-0.258171,0.187651,-0.00531238,-0.378218,0.808577,0.422213,0.149204,-0.306152,-0.276671,0.000603429,-1.10956,0.103898,0.0508125,0.516701,0.31353,0.706597,-0.103634,0.243284,0.458869,-0.161743,-0.0982698,-0.16244,0.65877,-0.441352,0.454665,0.728632,-0.625264,-0.692584,0.548758,0.292517,-0.495503,0.0641639,-0.442902,-0.752323,0.129626,0.163776,0.8713,0.769039,0.627935,0.408097,0.517397,0.0219969,-0.545346,0.185362,0.559691,-0.0564585,0.449612,-0.0141735,-0.345484,-0.448981,-0.600138,-0.490446,-0.109274,-0.18434,0.120462,0.316019,-0.189747,0.293574,-0.207093,0.53017,0.0647323,0.212233,0.324481,0.692976,0.121716,-0.607277,-0.840501,0.0695016,-0.542899,-0.404006,0.203197,0.0484296,0.0783643,0.514288,-0.292338,-0.204536,-0.0373205,0.436114,0.790937,0.233726,-0.437111,-0.112659,0.414667,-1.01187,-0.675967,0.0652978,-0.050203,0.079242,0.279081,0.232608,0.397819,0.33471,0.150334,0.221163,0.212119,0.0977705,-0.0261782,1.10843,-0.119518,-0.216336,0.864061,0.157601,0.388655,-0.249238,-0.502879,0.206636,0.353725,-0.394684,-0.42381,0.473484,-0.122721,0.354607,0.226925,-0.520854,-0.462446,0.175797,0.12624,-0.48353,0.682063,0.521551,0.686215,-0.0988197,-0.0346562,0.617446,0.217628,-0.592481,0.617072,-0.180786,-0.199363,-0.243821,0.127808,-0.514022,-0.942278,0.039056,0.131559,0.297164,-0.00358253,0.316299,0.0673626,-0.223022,-0.319585,0.576889,0.213897,0.940999,-0.341289,-0.424717,0.111806,-0.0906411,0.131163,-0.57247,-0.240384,-0.458732,0.0741595,-0.270353,0.292383,-0.168084,0.344574,-1.24726,-0.528799,0.640419,0.301649,-0.234323,-0.471253,0.189752,0.242377,-0.192824,0.311817,-0.716232,0.0795175,-0.0203585,-0.169094,0.960151,0.0256654,0.163978,0.165782,0.0273301,0.0706584,0.508107,-0.36399,-0.0342792,0.177915,0.282873,0.41965,0.0280241,-0.103938,-0.806167,0.0299048,0.546171,0.233548,0.574522,-0.3333,-0.676281,-0.0156683,0.0602965,0.134288,-0.0783049,0.0340311,-0.0488173,0.00284975,0.107255,0.109535,0.0733505,0.897982,0.0394814,0.219693,-0.0902414,-0.380779,0.223903,0.0221469,0.365158,0.116184,0.306673,-0.224316,0.0180186,-0.136052,-0.422173,0.278907,0.123942,0.0340985,0.535752,-0.713239,0.224715,-0.397182,0.235021,0.194193,0.909846,-0.184411,-0.628221,0.0248102,-0.18427,-0.0837989,-0.309974,-0.053783,0.0857993,0.0152417,-0.0397189,-0.368064,0.427206,0.10472,0.150897,0.419134,-0.37654,0.450691,-0.210026,0.156512,-0.0986784,-0.171114,0.276369,-0.126337,-0.167848,-0.214094,-0.576376,-0.344103,-0.37378,-0.0696621,-0.236449,-0.0292396,0.094189,-0.492068,-0.256108,0.233536,0.359208,-0.458944,0.0137326,-0.0179559,0.147152,0.156611,0.383604,0.395741,-1.92623 +3407.93,0.987137,0.0848144,4,1.60318,1.02878,-0.63458,0.178658,0.518009,-0.044241,-0.138799,0.205508,0.356312,0.507871,-0.0332472,-0.0167387,-0.0827356,-0.291497,-0.378305,0.399677,-0.00159031,-0.216086,-0.241341,-0.140476,-0.403812,-0.668798,0.0941565,-0.21303,-0.435108,-0.160777,0.14158,0.449316,-0.192229,0.265567,0.567517,-0.15006,0.0521901,0.207361,-0.60598,-0.302475,-0.127468,0.633051,-0.165672,-0.68726,0.471801,0.284718,-0.196169,-0.42942,0.127487,-0.621652,-0.871831,-0.461031,0.192796,0.0280289,0.0562284,0.630411,0.0989368,-0.468529,0.695601,-0.42604,-0.0534586,-0.697605,0.474572,-0.191393,-0.0396369,0.722024,-0.214693,-0.777907,0.332613,0.352817,-0.177819,0.0191386,-0.354376,-1.01,-0.100194,0.283702,0.768416,0.923683,0.795918,0.0969626,0.496442,0.456999,-0.990652,0.136699,1.00285,-0.308747,0.313023,0.478944,-0.27955,0.314478,-0.474867,-0.251094,0.000552968,-0.253663,-0.0344674,-0.109147,-0.0162146,0.143833,0.0763302,0.191778,0.21644,-0.49931,0.424917,0.420973,0.466773,-0.372456,-0.756971,0.0936779,-0.369258,-0.269526,0.241718,-0.0934079,0.385235,0.816398,-0.148731,-0.269918,0.172353,0.365473,0.685788,-0.112106,-0.545121,-0.286477,0.14986,-0.300551,-0.682452,0.526374,-0.0527287,-0.0326758,0.270334,-0.281306,0.395345,0.451974,-0.173931,-0.460394,0.394205,0.321235,0.0959999,1.03115,-0.156031,0.0392407,0.707648,-0.120335,0.344951,-0.670234,-1.0935,0.0160312,0.170141,-0.602339,-0.621382,0.678006,-0.198932,0.459726,-0.160405,-0.142411,-0.172291,-0.0737066,0.5111,-0.412291,0.686085,0.170555,0.693942,0.225477,-0.0782625,0.187591,-0.285188,-0.452306,0.815543,-0.368656,-0.0551373,-0.0508414,-0.0533635,-0.642478,-0.480827,-0.56309,0.426636,-0.0332915,-0.306294,0.398487,0.0522669,-0.0193031,-0.520659,-0.415273,0.385797,0.818806,0.209861,-0.328328,-0.0276614,0.249062,0.0478029,-0.468415,0.346679,-0.264628,0.0674323,-0.74757,0.453812,-0.52603,0.529699,-0.718629,-0.506553,0.427264,0.0532387,-0.290635,-0.876468,0.553813,0.045446,0.222792,-0.114081,-0.369512,-0.0626941,0.207717,-0.0719428,0.978384,0.128439,0.475581,0.0543659,-0.0792744,0.236524,0.893373,-0.479638,0.519619,-0.339865,0.419039,0.307717,0.315361,0.0788122,-0.554504,0.458744,0.380578,-0.608373,0.360697,-0.744168,-0.553099,-0.109787,0.306243,0.0108963,0.0259264,-0.318402,-0.355879,-0.235728,0.408334,0.203845,-0.14753,0.200069,-0.223132,0.521291,-0.254474,-0.395534,-0.161979,0.567018,0.0772256,0.0455836,0.0732842,-0.159988,0.304254,-0.184941,-0.514899,-0.0123597,-0.299423,0.329177,0.274763,-0.38684,-0.0311493,-0.388868,0.271214,0.245712,0.4763,-0.510178,-0.524861,0.061378,-0.0622795,0.255498,-0.390929,-0.178602,-0.094181,-0.0732209,0.385036,-0.360737,0.180985,0.673096,0.188087,0.129449,-0.575461,0.27673,0.143894,0.0754812,0.0823897,-0.178073,0.132237,-0.0984982,0.238529,-0.44496,-0.30657,-0.250673,-0.0825306,-0.0982415,-0.0729059,-0.168596,0.427377,-0.12003,-0.516673,-0.160915,0.0750548,0.13402,-0.397071,-0.506535,0.170837,0.127815,0.413324,0.357512,-1.76029 +3391.44,0.729428,0.0848144,4,1.53081,0.914589,-0.425102,0.0894654,0.546957,-0.0979426,0.33802,-0.105974,0.150747,-0.216145,0.243925,-0.0851682,-0.194558,0.0821798,-0.0592255,0.683104,-0.0596612,0.237977,-0.419481,0.0307289,-0.193206,-0.552292,-0.814611,0.43672,-0.000869657,0.275953,0.207468,0.0884759,0.0245804,-0.303273,0.676325,-0.480253,-0.237517,0.104541,-0.141392,-0.00456043,-0.794899,0.537686,0.614766,-0.0537959,1.14357,0.502203,0.590313,-0.735593,-0.273683,0.354936,-0.162939,0.441329,0.751532,0.406009,0.03276,-0.257112,0.325885,-0.398495,1.14704,-0.338395,0.127203,-0.273932,0.325458,-0.38623,0.382357,0.911365,-0.921372,-0.781333,-0.2623,0.262877,-0.306845,-0.0469682,-0.0161426,-0.238498,-0.260241,0.514086,1.02888,-0.363984,1.07707,0.832923,-0.259947,0.305123,0.444447,-0.17075,-0.684262,-0.693796,-0.0206148,-0.586917,0.0926742,-0.473432,0.237261,-0.273296,0.356083,-0.146116,0.0454169,0.317885,0.0804766,0.270407,-0.130128,-0.349315,-0.696905,-0.369601,0.107539,0.0491794,-0.311017,-0.0639867,0.347984,-0.664207,0.916673,0.12659,0.29697,-0.359797,0.184743,0.434626,-0.155512,-0.442763,0.568276,0.217157,-0.331347,-0.240624,0.115561,0.417529,0.326336,-0.0464999,-1.00437,-0.647299,-0.426254,-0.0719784,-0.369066,0.899736,0.163061,-0.453429,0.085543,-0.223353,-0.128528,0.249179,0.270587,0.773164,-0.201981,-0.681936,-0.113785,-0.186571,0.236135,-0.54133,-0.748756,-0.136461,-0.0380035,-0.3338,0.176346,-0.0942576,-0.237453,0.064358,0.190838,0.335605,0.259891,0.0963725,0.129768,0.219559,-0.0640475,-0.20177,-0.458154,0.203114,0.126613,-0.310093,0.473434,0.134738,0.827903,0.0123818,0.366789,0.422989,-0.173772,-0.240357,0.130458,0.385641,-0.0747677,-0.171273,-0.0881136,0.308583,-0.165008,-1.08804,0.0695426,-0.388065,0.0821219,0.392554,-0.377406,0.00681312,-0.0039466,-0.254753,0.192869,-0.343874,-0.26521,-0.634599,-0.281743,0.0258214,0.229047,-0.154958,0.287162,-0.616734,0.402127,0.476292,-0.363778,-0.239462,-0.454262,-0.805646,-0.277628,-0.608974,-0.415178,0.208796,0.264068,-0.441044,-0.413074,1.21882,-0.553075,0.653417,-0.0388962,-0.0519198,-0.0184266,-0.337037,-0.903201,0.386118,-0.306406,0.0531683,-0.00234321,-0.948758,0.617151,-0.297784,0.0129129,-0.377786,0.0216369,0.365321,-0.55687,0.0757019,0.27025,-0.316846,-0.227793,-0.141377,0.38506,-0.245799,-0.427018,0.419741,-0.366909,0.0714458,0.662265,-1.12408,-0.411352,0.194619,-0.213429,0.213554,0.428062,-0.171889,0.159273,0.0845292,0.301577,-0.488391,-0.392545,-0.68853,0.710389,-0.550489,-0.584326,0.174544,-0.135148,-0.0205736,-0.384591,-0.24707,-0.177532,-0.129229,0.420782,0.863804,-0.222548,0.294851,-0.0975014,0.0693751,-0.269223,0.204993,0.264747,-0.786769,-0.106824,-0.237782,-0.382908,-0.00399412,0.156146,0.381066,0.198039,0.202196,-0.547702,-1.04146,-0.237919,-0.0397166,-0.00280516,-0.0117412,0.112678,0.915103,0.32592,0.156598,-0.127993,-0.13863,0.0724043,-0.188329,-0.298557,-0.106921,-0.439372,-0.206064,0.181364,0.403356,0.0972691,0.182124,0.30256,0.42676,0.550055,-1.73892 +3395.11,0.991986,0.0848144,4,1.53309,1.037,-0.664236,0.119752,0.7038,-0.0102766,0.14981,0.158141,0.660852,0.896332,-0.362228,-0.0381772,-0.0446625,0.350802,-0.12759,0.741604,-0.603455,0.316206,-0.28955,-0.0501976,-0.539235,-0.565904,-0.830421,0.0378236,-0.0475496,-0.0389038,0.0858809,0.129575,-0.178413,0.0755815,0.383945,-0.737166,-0.221985,0.204536,-0.144193,0.0200581,-0.437685,0.58579,0.919665,-0.193716,0.987557,0.55665,0.216572,-0.518585,0.202533,0.105844,-0.347179,-0.699014,0.425709,0.0949376,0.119955,-0.109946,0.4895,-0.637754,0.817672,-0.234451,0.141235,-0.337424,0.388654,-0.424282,-0.0192381,1.19642,-0.386956,-0.800887,-0.42013,0.584943,-0.0594507,0.332922,-0.00531445,-0.253736,-0.280628,0.506116,0.43089,-0.807746,0.390996,0.793644,0.280865,0.2586,-0.909536,0.572269,-0.212917,-0.78456,0.0924578,0.145527,-0.376792,0.294879,-0.213277,-0.0747293,0.122815,0.0730821,0.768983,-0.357083,0.342364,0.0557544,-0.015413,0.527318,0.0554557,-0.443867,0.279172,0.193149,0.311452,-0.248167,0.26095,-0.243177,0.517404,-0.599263,0.601543,-0.451141,-0.155122,0.127655,-0.324154,-0.421362,0.188852,0.455675,-0.398639,-0.204024,0.250347,0.230009,0.603399,0.651268,-0.824519,-0.243818,-0.881991,-0.358644,0.0100994,0.560994,0.227581,0.242532,0.209356,-0.244299,-0.251452,-0.0234495,-0.0589184,0.721021,0.802178,-0.975506,0.0728794,-0.13706,0.289199,-0.391838,-0.0891961,-0.0488529,0.134065,-0.461907,-0.429594,-0.312482,-0.587167,0.609766,-0.159851,-0.812248,0.181493,-0.0761272,0.0975509,0.196589,0.220626,0.232099,-0.214914,0.277172,0.122128,0.0765917,0.510236,-0.0707019,1.15353,-0.199749,-0.318123,-0.454234,-0.01801,-0.00648366,0.164668,0.496301,0.0270172,0.317697,-0.0491235,0.00235246,-0.536054,-0.434528,0.228113,-0.307525,0.102358,0.670483,-0.133064,0.408641,-0.0282181,0.0923333,0.125675,-0.0416999,0.418431,-0.159472,0.221346,-0.158934,0.0162741,-0.143233,-0.0617424,-0.359826,-0.203802,0.254029,-0.0129001,-0.417094,-1.20158,-0.482372,-0.152095,-0.28843,0.171693,0.0333309,0.109835,-0.0212307,-1.26289,1.03696,-0.538071,0.62773,-0.370863,-0.0608396,0.257491,0.0554052,-0.401943,0.43744,-0.669699,0.452727,0.379991,-0.649765,0.0712315,-0.277987,-0.157568,-0.149183,0.520617,0.614455,-0.308757,0.458934,0.127352,-0.536659,0.357507,0.183042,0.425668,-0.646271,-0.654492,0.702373,0.326711,0.256648,0.458731,-0.144434,-0.75111,0.706749,-0.0856605,0.0443389,-0.210406,0.200155,0.562054,-0.234504,0.585231,-0.205386,0.0714777,-0.595085,0.473734,-0.243039,0.012549,0.362868,-0.12428,-0.320532,0.17053,-0.116589,0.228979,0.0292841,0.306997,0.0305672,0.51036,0.41153,-0.0405319,-0.367311,-0.90569,0.0814009,-0.134585,-0.335294,-0.0696791,-0.494018,-0.0529916,-0.182369,-0.0481797,-0.016251,0.469162,0.0225853,-0.169486,-0.281552,-0.872913,0.564202,-0.0932074,-0.130601,-0.191464,0.595261,-0.105794,0.0131959,0.0825537,-0.121344,0.10576,0.353067,-0.141118,-0.164417,0.0854326,0.132801,-0.923785,-0.682067,-0.114698,0.151566,0.18796,0.389315,0.433544,-2.39875 +3400.33,0.706308,0.0848144,4,1.57173,1.01318,-0.329838,-0.015647,0.556793,-0.212889,0.11009,-0.139258,0.148498,-0.400447,-0.385805,-0.265203,-0.134953,0.0538375,0.149963,0.668864,-0.18121,0.504826,0.339158,-0.0920906,-0.420019,-0.751364,-0.513283,-0.0597389,-0.202578,-0.194513,0.0196917,0.459285,0.105633,0.15929,0.444316,-0.142133,0.331425,0.137731,-0.0188636,-0.141747,-0.481187,0.344382,0.370509,0.00866182,0.886962,0.295715,0.108171,-0.212327,-0.261071,0.310568,-0.429003,-0.0553909,0.54072,0.360154,0.0773196,0.276113,0.388347,-0.331121,1.04332,-0.0508901,0.145914,-0.831515,0.488967,-0.290556,0.353499,0.58336,-0.689961,-0.0747319,-0.439845,0.181424,0.179183,0.100286,-4.74375e-05,0.0166187,-0.363086,0.0427723,0.591347,-0.333163,0.982332,0.892854,-0.488992,-0.494633,-0.631514,0.27316,0.749164,-1.17066,-0.105562,0.36622,0.318192,-0.040652,-0.175055,-0.583933,0.191697,-0.225915,0.325641,0.365999,0.156719,0.496845,0.034363,0.492185,-0.2007,-0.0434664,-0.114275,0.138029,0.512733,-0.370199,-0.520787,-0.0612841,-0.0439726,-0.743936,0.869676,-0.206394,0.260799,0.770771,-0.457089,-0.246991,-0.511689,0.475226,-0.432291,0.0727289,-0.631135,-0.146462,0.417466,0.0767478,-0.425024,-0.328374,-0.769933,-0.491247,0.414462,0.460643,0.044669,-0.00150692,0.146617,-0.169867,-0.172078,0.120957,-0.0286251,0.889014,-0.0528609,-0.437471,-0.278099,-0.619691,0.573871,-0.501807,-0.129279,-0.0665849,-0.0599374,-0.593056,0.41873,-0.0149764,-0.181937,0.147431,0.101895,-0.533104,-0.383568,0.0746243,0.114799,-0.212604,0.592605,0.405612,0.383497,0.631651,0.286644,0.166422,0.417794,-0.14485,0.404474,-0.274162,-0.566868,0.168912,0.0317076,0.0888535,0.173679,-0.337394,0.238202,-0.122457,0.106734,-0.461592,-0.123639,-0.428343,-0.311883,-0.627544,-0.124919,0.832259,0.473133,-0.361736,0.647126,0.0990971,-0.329348,-0.310763,-0.690455,0.0333994,-0.0114452,-0.442258,0.114426,-0.644353,0.265104,0.267873,-0.977562,-0.0540158,0.154588,-0.130073,-0.797505,-0.416162,-0.295568,-0.320499,-0.35471,-0.0303615,-0.193654,-0.197001,-1.29439,1.13441,0.057268,-0.0549097,-0.14073,-0.340635,0.275941,0.297519,-0.495755,-0.343651,-0.061816,-0.111175,-0.0551101,-0.111963,0.00401997,-0.91236,0.247632,-0.162166,-0.040152,0.30128,0.218406,-0.614357,0.220231,-0.0734071,0.385194,-0.00896967,-0.21717,-0.453921,-0.413669,0.787415,-0.274173,-0.59169,0.486145,-0.0457482,-0.474633,0.0442207,-0.03163,-0.224451,-0.375245,-0.117832,1.0171,0.16561,0.0982264,-0.535233,-0.160083,-0.988573,0.563631,-0.613224,0.253378,0.454405,-0.520875,0.170894,0.600544,0.0642093,-0.196802,0.524179,0.480002,0.57582,-0.51162,0.132201,0.24216,-0.307845,-0.39769,0.0135955,0.0580275,0.00159579,-0.924415,-0.538254,-0.0173467,0.157043,0.455157,0.989488,0.199521,0.309782,-0.138027,-0.0805727,-0.592053,0.559021,0.0732298,-0.35903,-0.325731,0.631795,0.123979,-0.182553,0.140019,0.0902751,0.162125,-0.431805,0.044328,-0.647956,-0.485881,-0.140594,0.0322633,-0.864538,0.271366,0.210919,0.17113,0.459259,0.413679,-1.8266 +3395.26,0.980131,0.0848144,5,1.60117,0.859072,-0.781554,0.188089,0.493562,-0.156948,-0.454017,0.404624,0.251622,0.285076,-0.150248,-0.421646,0.0129032,0.177961,-0.542035,0.628166,0.078295,-0.082189,-0.0694588,-0.340634,-0.374195,-0.704433,-0.534086,0.115919,-0.496897,0.144524,-0.240942,0.185545,-0.355567,0.0274749,0.966916,-0.587334,0.088869,0.135015,-0.0826754,-0.0726027,0.0549328,0.453587,0.474163,-0.82862,1.17911,0.172997,-0.0399553,-0.655026,0.258614,-0.697332,-0.0322993,-0.28485,0.443357,-0.0662622,0.090784,0.0237926,-0.0159536,-0.180544,0.797057,-0.079987,0.417234,-0.137791,0.502059,-0.204144,0.27996,0.432321,-0.099752,-0.964957,0.227362,0.923166,-0.613174,-0.103974,0.272512,-0.412748,0.304508,0.208798,0.709084,-0.0146962,0.693866,0.323918,0.721982,0.278812,0.11717,0.0421489,0.164469,-0.110321,0.240693,0.202144,-0.203235,-0.328331,0.307418,-0.132851,-0.127861,-0.543858,0.104129,-0.544634,-0.401635,0.0205716,-0.0800004,-0.381972,-1.25134,-0.451673,0.478982,0.153207,-0.437009,-0.560649,-0.498145,-0.0433221,-0.0271064,-0.093915,-0.668332,-0.317702,0.259046,0.640581,-0.125178,-0.193129,-0.18939,0.506566,-0.0609776,-0.563637,-0.191892,0.385271,-0.012596,-0.40755,-0.316547,-0.472589,-0.321545,0.145422,0.293856,-0.113752,0.0360598,0.746481,0.584068,0.236938,0.568172,-0.179917,-0.194988,0.509145,-0.243461,0.0256962,-0.260218,-0.109146,0.45731,-0.420833,-0.854362,-0.211395,0.304467,-1.22514,-0.239634,0.236485,-0.0637997,0.345077,-0.39151,0.63668,-0.155492,0.0335303,0.53722,0.419106,-0.411286,0.722715,-0.115594,-0.0239332,0.165757,-0.257966,0.771354,0.271167,0.967617,-0.294727,0.0755074,0.108226,0.0560059,-0.331699,-0.409758,-0.359588,-0.243981,0.334614,-0.135335,0.212512,-0.576887,0.00215721,-0.174825,0.196314,-0.0905753,1.1516,0.0311919,-0.638527,0.0168556,-0.146482,-0.0896691,-0.370964,0.398057,-0.0843367,0.73662,-0.842946,0.0346386,0.422142,-0.278406,-0.911052,-0.46695,-0.296775,0.0150371,0.118356,-1.10929,0.0580272,-0.132589,-0.181988,0.338384,0.379761,-0.273168,-0.0671296,0.0713939,0.655694,-0.247706,0.26653,-0.0148148,-0.267563,0.0492195,0.062043,-0.194669,0.845939,-0.19465,0.219237,0.449986,-0.373013,-0.147325,-0.4209,0.00489713,-0.0132203,0.119381,0.631258,-0.719806,0.36475,0.0918824,0.270364,-0.603954,0.142984,-0.307395,-1.07634,0.0398516,0.0699642,-0.389852,0.0676176,1.07224,-0.978118,-0.472299,0.268542,-0.0345868,-0.00216834,0.943126,0.323519,0.384963,-0.14986,-0.28515,-0.191814,-0.512949,-0.265021,0.660248,-0.179894,-0.490377,0.0372303,0.446606,-0.299003,0.260054,0.096656,0.524784,0.0660224,0.25061,-0.294283,0.469868,0.158006,-0.249339,-0.421295,0.0198716,0.138146,0.305988,-0.274761,-0.940045,-0.470153,-0.0735786,0.460833,0.189946,-0.0424547,0.228021,0.255406,-0.171594,0.392251,0.174854,0.0949896,0.651974,0.594967,0.463582,0.0140003,0.0983033,-0.498101,0.190048,0.223114,-0.241152,0.414472,-0.0313094,-0.0643355,0.176592,0.294731,-0.384681,-0.289591,-0.256091,0.199048,0.147551,0.446147,0.384124,-1.28464 +3392.8,0.998994,0.0848144,4,1.5448,0.892233,-0.575904,0.0754855,0.200286,-0.275897,-0.147929,0.271768,-0.310712,-0.430815,-0.442507,-0.59571,-0.146237,0.140372,-0.180737,0.722277,0.0680722,0.0219122,0.233481,0.0526083,-0.726666,-0.562556,-0.343647,0.26115,-0.426289,-0.276603,-0.199128,-0.0335501,-0.36912,-0.114121,0.982959,-0.354705,-0.13423,0.0856359,-0.297118,-0.121055,0.0370423,0.341656,0.159168,-0.355703,0.894037,0.0358631,-0.0793688,-0.518451,0.166625,-0.748155,-0.2984,-0.27348,0.360755,-0.0340004,-0.107579,0.157105,0.057324,-0.216357,1.15078,-0.0486786,0.533597,-0.348729,0.491922,-0.0415633,0.555073,0.386317,-0.12608,-1.08688,-0.0571164,0.498266,-0.117985,0.198378,-0.000906974,-0.610019,0.708453,0.0968191,0.922116,0.0610046,0.442708,0.519217,0.536895,-0.291341,-0.451108,0.427298,0.402208,-0.360191,0.231239,0.13882,0.0702124,-0.677543,0.484962,-0.392916,0.146662,-0.596958,0.34466,-0.781764,0.126938,0.151918,-0.00506211,-0.518166,-0.562752,-0.18702,1.09346,0.481717,-0.491276,-0.0581188,0.0583608,-0.155098,-0.299217,0.137564,-0.447397,-0.223217,0.116395,0.724514,-0.086082,0.275741,-0.302481,0.289332,0.232687,-0.229328,-0.040626,0.0253806,-0.0161689,-0.20311,-0.825332,-0.507269,-0.315472,0.165141,0.449437,0.312508,0.132361,0.954085,0.408487,-0.426736,0.385204,-0.0741296,-0.215117,0.570834,-0.152326,-0.227979,-0.117151,-0.211845,0.680183,-0.81225,-0.671537,-0.265554,0.479658,-1.02483,-0.159954,0.190337,0.260924,0.517298,-0.366176,0.322713,-0.514896,0.495235,0.441955,0.116647,-0.407359,-0.0962923,0.481711,0.608962,-0.017845,-0.00212334,0.497465,0.044487,0.808257,-0.169978,-0.127514,-0.035742,0.143154,0.0954093,-0.0588555,-0.316277,0.0636225,0.431506,-0.155453,-0.0234185,-0.16607,-0.203291,-0.212403,0.237929,0.256068,1.27976,0.470582,-0.459886,0.32316,-0.460875,-0.813903,-0.987699,0.29611,-0.437329,0.818946,-1.24794,0.362739,0.557468,0.0397823,-0.939432,-0.14201,-0.156703,-0.0156951,-0.0467127,-1.01993,0.375924,-0.257265,-0.587979,0.555898,0.144032,-0.406049,0.207419,-0.155393,0.482448,-1.1032,0.596184,0.16618,-0.0622187,-0.152468,0.154306,0.103332,0.342474,-0.0688573,0.276783,-0.083702,-0.222288,0.0878397,-0.339324,-0.0982646,-0.143771,0.0895433,0.55257,-0.43598,0.312268,-0.0770538,0.393157,-0.852519,0.00424183,-0.483825,-0.691561,0.0436888,0.319744,-0.416331,-0.272316,1.36213,-0.873408,-0.180679,0.299471,0.493945,-0.157236,0.629901,0.345638,0.516586,0.442153,-0.0832017,-0.180101,-0.280275,0.00877506,0.567991,0.060383,-0.0405503,-0.13001,-0.0378802,-0.295397,-0.166548,0.163685,0.853994,-0.653278,0.285716,0.301337,0.0881633,0.205589,-0.0981283,-0.345688,0.323975,-0.121134,0.38985,-0.276492,-0.882823,-0.0911873,-0.383955,0.481192,0.217675,0.000637477,0.400227,0.197047,-0.413645,0.236434,0.0987459,0.0446443,0.655053,0.359649,0.0629134,0.364643,0.159192,-0.203106,0.203431,-0.0861773,0.0573858,-0.165152,0.205446,0.0415107,0.0422664,-0.248303,0.285559,-0.171271,-0.302503,0.158395,0.16255,0.397989,0.403175,-0.397557 +3412.43,0.860119,0.0848144,5,1.60285,0.986553,-0.311954,-0.0416758,0.123956,-0.0504683,-0.0500852,-0.341294,0.284508,-0.0755945,-0.131878,-0.112143,-0.226836,0.234277,-0.0209017,0.563,0.229856,-0.0351688,0.149935,0.123605,-0.279211,-0.736773,-0.66117,-0.0932475,-0.27063,-0.0150729,0.179105,0.0443374,-0.352244,0.0176761,0.841834,-0.400672,-0.0055478,0.181855,-0.364648,0.229655,-0.224087,0.90258,-0.102611,-0.567368,0.670165,0.332614,-0.218695,-0.506676,0.0953674,-0.344104,-0.606427,0.65026,0.324785,0.208325,0.48703,0.500157,-0.133107,-0.385065,1.20793,0.188153,-0.17761,-0.580292,0.552081,-0.0713303,-0.138205,0.530432,-0.497871,-0.440678,0.114281,0.116559,0.138077,-0.525218,0.279442,-0.375153,0.570539,0.271796,0.834663,0.299567,0.676996,0.0999735,0.326215,0.0147759,-0.520975,0.0892276,0.593354,-0.329631,0.421204,-0.536299,-0.0316112,-0.265196,0.247373,-0.186853,0.170886,-0.430763,0.0248298,0.250283,0.147188,0.236067,-0.315214,-0.0789637,-0.256337,-0.212243,0.298829,0.414238,-0.0979158,-0.0274018,-0.434507,-0.596655,-0.266272,0.121555,-0.388791,-0.00252427,-0.136918,0.333545,-0.0746848,-0.22211,0.332844,0.139421,0.207556,0.166319,-0.0628129,0.264447,0.309303,-0.0165552,-0.42974,0.0169311,-0.589421,0.554209,-0.0573699,0.089344,0.613714,0.692978,0.447192,-0.391471,0.439849,0.0251474,-0.11268,1.05195,-0.447198,-0.0398781,-0.374258,-0.000290054,0.407941,-0.873031,-0.731306,-0.445927,0.872225,-1.29074,-0.650308,0.36589,0.549891,0.399411,-0.429677,0.10856,-0.777266,0.308565,0.505111,0.357046,0.229942,-0.0173223,0.642202,0.536746,0.00106749,0.191367,0.295732,0.317336,0.598526,0.0345586,0.250754,0.0119066,-0.0840766,-0.238893,-0.50916,-0.29531,-0.148571,0.231726,-0.234103,-0.0153726,-0.446606,-0.0156163,-0.390078,-0.268183,0.290418,1.10939,0.221921,-0.588784,0.113841,0.306642,-0.440482,-1.0817,0.373302,-0.587492,-0.192891,-1.08973,0.115442,0.169994,0.095357,-0.715594,-0.0629939,-0.364829,0.181432,0.0868516,-0.498672,0.587717,0.241166,-0.0611931,0.262692,0.369613,0.0969807,-0.0902887,-0.28082,0.908399,-0.423681,0.0944098,0.0521985,-0.0125383,-0.301547,-0.268329,0.198639,0.335512,-0.0830015,0.582764,0.422981,-0.348279,-0.344793,-0.407909,0.0928196,-0.268807,-0.363976,0.568158,-0.169285,-0.117032,-0.375994,0.381841,-0.370394,-0.134084,-0.0123525,-0.795626,-0.153461,0.574548,-0.22094,-0.24567,0.72019,-1.15121,-0.378735,-0.331783,-0.032962,-0.145594,0.626482,0.451274,0.376368,0.819698,-0.191298,-0.197109,-0.230914,-0.579633,0.216828,-0.123125,0.140252,0.399353,-0.207803,0.0930083,-0.440954,0.172124,0.426281,-0.269036,0.310529,0.574935,0.00262065,0.166903,-0.128174,-0.0822952,0.128581,-0.42323,0.350312,-0.461276,-0.828527,-0.150675,-0.929748,0.14672,0.681014,0.365106,0.172067,0.173003,-0.289055,0.0812327,-0.129916,-0.293199,0.591413,0.544176,-0.0307003,0.328077,0.459812,-0.460878,0.0536274,-0.370197,0.0817073,-0.155327,-0.071359,-0.385343,0.207041,-0.0142761,0.000598172,0.195197,0.188178,0.199624,0.150674,0.446793,0.388168,-0.336793 +3393.99,0.971976,0.0848144,4,1.617,1.06249,-0.213905,-0.0673097,0.143146,-0.124099,0.123444,-0.26996,0.260311,0.0204566,-0.0699117,-0.118184,-0.502249,0.144395,0.134887,0.53507,0.327147,-0.134615,-0.152622,0.0484471,-0.458754,-0.961903,-0.496651,0.0672668,-0.332413,-0.072025,0.421241,0.247191,-0.5827,-0.225202,0.720903,-0.342143,-0.23787,0.1557,-0.594118,-0.137897,-0.324714,0.681617,-0.342728,-0.62769,0.665806,0.223091,-0.193677,-0.512989,0.00350829,0.26824,-0.539525,0.683527,0.177888,0.0929639,0.502517,0.431237,-0.0683728,-0.42852,1.15067,-0.0163132,-0.348147,-0.421928,0.419384,-0.192882,-0.154558,0.622022,-0.499414,-0.295602,0.106595,0.186712,0.177471,0.00948384,0.189366,-0.550582,0.64496,0.300791,0.702539,0.180698,0.824465,0.0755495,0.445744,0.0578879,-0.719487,-0.0826976,0.351183,-0.123865,0.347541,-0.448055,0.0200069,-0.581774,0.596539,-0.194183,0.530191,-0.489828,-0.113933,-0.019561,0.0599029,0.296453,-0.723588,-0.173971,-0.226442,-0.12838,0.0520471,0.194352,-0.0649441,0.0721624,-0.560602,-0.403605,-0.0765305,-0.0651971,-0.38828,-0.0802323,0.0599958,0.316841,-0.0719916,-0.327664,0.214498,0.29067,0.243441,0.341681,-0.477604,-0.0223555,0.389201,-0.18771,-0.411744,-0.135134,-0.431011,0.619279,0.163947,0.11454,0.0319394,0.640333,0.169174,-0.532433,0.32568,0.0466899,-0.323238,1.00599,-0.605221,-0.210246,-0.310318,-0.234771,0.310225,-1.01795,-0.884271,-0.42903,0.658977,-1.17176,-0.489435,0.0539438,0.0566075,0.329122,-0.405752,-0.173859,-0.621689,0.233137,0.536403,0.575693,0.126614,-0.167941,0.254199,0.58888,0.240612,0.308381,0.420529,0.275752,0.618963,0.174433,0.123515,-0.166313,0.00480413,-0.261111,-0.383572,-0.421748,-0.0977481,0.520887,-0.132808,-0.0724402,-0.550927,0.107368,-0.438515,-0.128522,0.479332,0.961706,0.347368,-0.657604,0.203882,-0.0910744,-0.247803,-1.01469,0.600251,-0.612272,-0.473278,-0.869124,-0.0499728,0.300957,0.19267,-0.587172,0.0975803,-0.261341,-0.0123267,-0.062329,-0.409079,0.837298,0.119284,0.0472386,0.176694,0.418233,0.311259,-0.0329563,-0.280445,0.660064,-0.600095,-0.0251806,0.0127358,-0.0644001,-0.57218,-0.288827,0.279838,0.377505,-0.209355,0.618967,0.46771,-0.537104,-0.143459,-0.32051,-0.109765,-0.333429,-0.119778,0.663459,-0.018455,-0.185586,-0.566398,0.539586,-0.413578,-0.242048,0.073765,-0.761988,-0.187593,0.613534,-0.038944,-0.324455,0.479078,-1.28664,-0.730772,-0.12797,0.137353,0.0225132,0.669858,-0.0304984,0.24409,0.904067,0.101479,-0.206054,-0.449761,-0.425163,0.194209,-0.190384,0.224532,0.377042,0.156518,0.0936414,-0.731332,0.0508316,0.226953,0.0703481,0.0209627,0.600221,-0.0049811,0.109218,-0.164906,0.0279743,-0.0333424,-0.307705,0.211691,-0.468823,-0.692237,-0.0585325,-0.802347,-0.0731339,0.865867,0.419316,0.267179,0.347119,0.147984,0.314131,-0.595926,-0.387302,0.553873,0.799465,0.0732335,0.214357,0.18864,-0.15647,-0.0765023,-0.251883,-0.0707489,-0.233936,0.042002,-0.245351,0.0356151,-0.153184,-0.11661,0.123831,0.255003,0.167985,0.168889,0.409859,0.410961,-0.529398 +3378.92,0.593216,0.0848144,5,1.5584,0.868862,-1.67211,0.709989,1.02042,-0.0354823,0.0592168,0.25239,-0.28505,0.452414,-0.0330505,0.252128,-0.132037,0.392445,-0.515386,1.18641,0.0939816,-0.0803207,-0.143741,-0.00203464,0.106588,-0.778553,-0.701291,0.129753,0.484978,-0.201627,-0.108823,0.397221,-0.378076,0.217267,0.8084,-0.522045,0.542612,0.42944,-0.375866,-0.786601,-0.302718,0.356658,0.837508,-0.322004,0.440049,0.37561,0.591161,-0.448404,-0.149579,-0.205147,-0.348158,-0.0864753,0.426867,0.233519,-0.080373,-0.156975,-0.438392,0.128104,0.413726,-0.0326354,-0.730855,-0.709957,0.45251,-0.312058,-0.0662123,0.803064,-0.397092,-0.730073,0.400157,0.130763,-0.562024,-0.232237,-0.146895,-0.041116,-1.24528,0.126796,0.0933714,-0.213269,0.124919,0.644412,0.43013,-0.315594,-0.180366,0.00357393,0.236911,-0.423966,0.275826,-0.282831,0.054805,0.278006,-0.470146,-0.194227,-0.387502,-0.481505,0.0941567,-0.0301977,-0.239045,-0.126305,0.83368,-0.26256,0.451113,-0.371022,-0.0496681,0.708198,0.584469,-0.182676,-0.323986,-0.0106834,0.4484,-0.661913,0.998946,-0.319429,0.539531,0.707763,0.29323,0.300935,-0.0382019,0.154385,-0.0998863,-0.383411,-0.347941,0.172761,0.027281,0.223648,-0.801234,-0.447524,-0.0354635,-1.15054,-0.298677,-0.0264437,0.298165,-0.55732,0.376708,-0.344092,-0.31574,-0.169008,0.528722,-0.249017,-0.0815224,0.195186,0.0659577,-0.277193,0.028302,-0.179452,0.28926,0.113117,-0.86284,0.077067,0.387462,0.340096,-0.294002,0.238061,-0.141702,-0.138126,-0.249216,-0.0012007,-0.0124235,-0.668001,0.326538,0.987437,0.0592906,-0.611937,0.272105,0.00860878,-0.0362293,-0.389721,0.859078,-0.0222532,-0.143655,0.248415,-0.179711,0.0382975,0.0210693,0.536907,0.571604,-0.604732,-0.253915,-0.117477,0.383353,-0.546297,-0.179405,-0.136405,0.168584,0.726767,-0.642005,0.486494,0.0156043,-0.0514363,-0.0846763,0.206648,-1.23679,0.232254,0.511033,-0.0375276,0.153247,-0.184012,-0.447093,-1.13905,0.203692,0.34929,-0.135671,-0.730938,-0.840877,-0.670808,-0.436698,-0.810774,0.423733,-0.876669,-0.139451,-0.202449,-0.666482,0.928787,0.398478,0.222968,0.116762,-0.0210042,0.811588,0.357435,-0.814997,0.144814,-0.330347,-0.0167034,0.548218,-0.0559288,-0.00715176,-0.493965,0.286185,0.839407,-0.568819,0.13043,-0.63771,-0.349727,1.03721,-0.328068,0.213315,-0.3649,-0.423025,0.435908,-0.689508,0.2936,0.0804775,0.386733,0.641882,0.397417,0.350074,0.31379,-0.150057,-0.161476,-0.130124,0.0799201,0.945386,-0.841509,-0.459807,-0.271654,0.647026,-0.868827,0.469394,-0.0103183,-0.809617,0.027188,-0.758201,-0.0934655,0.885396,-0.0589591,-0.21392,0.803289,-0.19664,-0.0886145,0.348041,0.249622,0.00944733,-0.274914,-0.0874889,0.425391,-0.405102,-0.0168014,0.179414,0.318212,0.67985,0.119375,-0.0290966,0.153115,0.16179,-0.261005,-0.195629,-0.49179,-0.167034,0.714423,-0.323368,-0.441139,-0.268218,0.488232,0.258585,-0.0602074,-0.322419,0.495184,0.286713,0.395934,-0.171509,-0.520775,0.0971474,0.383017,-0.638893,-0.466092,-0.282439,0.211324,0.227728,0.4597,0.477208,-3.15118 +3367,0.993328,0.0848144,5,1.52148,0.842982,-1.63573,0.729836,0.835116,-0.0327327,0.179915,0.347994,0.0960876,0.431368,0.0117553,0.120482,0.204852,0.497842,-0.473416,1.33838,-0.0271688,0.120955,0.0835367,-0.241262,0.23586,-0.647566,-0.595275,0.104689,0.376531,-0.254055,-0.149786,0.679109,-0.339088,0.426922,0.872612,-0.751326,0.190084,0.344891,-0.349326,-0.36641,-0.471833,0.427599,0.693917,-0.242443,0.860946,-0.0190529,1.0813,-0.8777,-0.307197,-0.240613,-0.598943,-0.171115,0.19012,0.0945205,0.104082,-0.124388,-0.294619,0.262993,0.333508,-0.266564,-0.545317,-0.729601,0.374118,-0.782313,-0.0103316,1.05757,-0.324815,-0.503406,0.207157,0.0961909,-0.558597,-0.140442,-0.353486,-0.235872,-1.17729,0.539139,0.330012,-0.244679,0.294994,0.672626,0.297546,0.0385527,0.108717,-0.234527,0.25191,-0.278494,0.428275,-0.378601,-0.016184,0.389184,-0.904839,-0.153321,-0.198131,-0.0993269,-0.0335321,0.128546,0.109914,-0.0869957,1.14562,-0.169109,0.66806,-0.0878823,0.541481,0.896079,0.488627,-0.475989,-0.345032,-0.177674,0.107537,-0.298976,0.747419,-0.223444,0.572257,0.398816,0.00844249,0.0319859,-0.0694765,0.223694,0.353731,-0.0445133,-0.288215,0.129156,-0.225115,0.249659,-0.782952,-0.221873,-0.356063,-0.934285,-0.503061,0.0764859,0.0031474,-0.823946,0.537231,-0.456074,-0.408262,-0.292452,0.502573,-0.155984,0.00716885,0.0544353,0.0359095,-0.690527,0.356004,-0.280412,-0.19974,0.471934,-0.952982,-0.48484,0.305682,0.472031,-0.189518,0.700095,-0.0132011,-0.392645,-0.273574,0.0721977,0.115927,-0.823033,0.779892,1.01727,-0.0999746,-0.427727,0.404373,0.0477166,0.126133,-0.657275,0.855578,0.568225,0.0193616,0.118529,0.0288608,0.117121,-0.232125,1.06772,0.370839,-0.561224,-0.202169,-0.0379779,0.623942,-0.466092,-0.264929,-0.364316,0.50342,0.843593,-0.721903,-0.272796,0.269986,-0.0839025,-0.151031,0.419804,-0.996307,-0.138716,0.183575,-0.0150732,0.145605,0.389961,-0.165636,-0.851287,0.0413954,0.291351,-0.198233,-0.292751,-0.971515,-0.739637,-0.272807,-0.662357,0.484372,-0.735606,0.0289497,-0.00791287,-0.584072,0.797791,0.291363,0.567883,0.0187871,-0.497205,0.486179,-0.14625,-0.776776,-0.0694691,-0.702805,0.0635311,0.617958,-0.210862,-0.110168,-0.750598,0.617063,0.735392,-0.342939,0.139072,-0.46352,-0.301499,1.00789,-0.251443,-0.296812,-0.0685984,-0.35763,0.222626,-0.887662,0.156851,-0.0770224,0.240754,0.805383,0.382736,0.261901,0.0713127,-0.299402,-0.213427,0.709068,-0.130864,0.874639,-0.938401,-0.336867,-0.466517,0.192668,-0.726541,0.544416,-0.196689,-0.54585,-0.0276802,-0.421917,0.0408003,0.930284,0.175836,-0.128623,0.797848,-0.160271,-0.209204,0.69128,0.140941,0.228194,0.0366388,0.139888,0.2941,0.0612125,-0.259551,0.252519,0.632809,0.396436,0.0715316,0.288817,0.116082,-0.059023,-0.234629,-0.0996058,-0.815596,-0.474759,0.928556,-0.339153,-0.142927,-0.152578,0.550817,-0.0547635,-0.420701,-0.186402,0.166525,0.647268,0.0818635,-0.524605,-0.452597,0.131753,0.0198369,-1.21095,-0.301888,-0.220384,0.205252,0.228277,0.453047,0.477783,-2.56581 +3352.75,0.658302,0.0848144,5,1.54108,0.846272,-1.5225,0.689679,1.04952,0.0169035,-0.0751182,0.393844,0.329851,0.138186,0.0313075,-0.24971,0.0203471,0.438643,-0.522581,1.0237,0.215451,0.15779,0.0381846,-0.154464,0.0336128,-0.641544,-0.944192,0.253304,0.129509,-0.0880289,-0.079907,0.734253,-0.268812,0.32794,0.945492,-0.188139,0.272397,0.216885,-0.152011,-0.605493,-0.10283,0.515168,0.973324,-0.0563491,0.553257,0.0460449,0.944468,-0.702247,-0.0770886,-0.0394546,-0.720714,0.146804,0.166083,0.0301262,0.157106,0.157032,-0.154988,0.155107,0.513052,-0.200524,-0.766728,-1.02148,0.412198,-0.624239,0.429635,0.896669,-0.49878,-0.487923,0.60787,0.164104,-0.163072,-0.240288,-0.292903,-0.24455,-0.932117,0.718462,0.218938,0.0451264,0.222987,0.765542,0.399031,-0.496301,0.271589,-0.126867,0.297957,-0.110999,0.506804,-0.47946,-0.196908,0.299234,-0.731646,-0.248774,-0.192124,-0.159068,-0.0406531,0.599643,-0.291737,-0.0906571,0.889145,-0.00881537,0.591906,-0.397834,0.47526,0.623315,0.90161,0.0644558,-0.516738,-0.423018,0.581141,-0.46007,0.707806,-0.40757,0.263173,0.434067,0.123443,-0.130169,-0.164176,0.363561,-0.104293,0.0070935,-0.516168,0.280947,-0.171145,0.230743,-0.583577,0.07724,-0.906026,-0.850901,-0.664956,-0.136055,0.00566811,-0.567402,0.402068,-0.462055,-0.19315,-0.248904,0.287794,-0.210586,0.0144494,-0.214331,0.17558,-0.620803,0.484503,-0.284714,-0.153393,0.114039,-0.865402,-0.25894,-0.0911557,0.322143,-0.0743269,0.482717,-0.0400076,-0.176187,-0.0563459,-0.139087,0.324299,-1.03834,0.884714,0.842088,-0.0144239,0.0564929,0.311813,0.362704,0.344769,-0.758477,0.933266,-0.111045,0.54165,0.120218,0.144778,-0.288876,-0.432079,0.805411,0.43739,-0.274564,-0.301168,0.0878185,0.338826,-0.613654,-0.252975,-0.402683,0.73513,0.620749,-0.4795,-0.115943,0.666629,-0.217818,-0.247868,0.626473,-1.10156,-0.273184,0.428941,-0.328603,-0.235399,0.503061,0.0362642,-1.17575,-0.124596,0.151035,-0.335358,-0.319396,-1.03126,-0.855248,-0.338531,-0.406907,0.499416,-0.602617,-0.011038,-0.0880009,-0.678825,0.813228,-0.0794445,0.753267,0.0812061,-0.485893,0.680729,-0.472551,-0.782529,-0.24777,-0.885404,-0.019062,0.423964,0.061902,-0.0132065,-0.560142,0.560352,0.621289,-0.162835,-0.224051,-0.597259,-0.575397,0.581191,0.135301,0.0196923,-0.221694,-0.231693,0.222694,-0.843935,0.143559,0.213397,0.455008,1.1423,-0.00544134,0.0749252,0.147263,-0.366817,-0.255521,1.20363,-0.226045,0.505074,-0.670556,-0.562229,-0.415617,0.188592,-0.661394,0.4418,-0.560969,-0.598861,-0.091461,-0.343406,0.114415,1.34827,0.125206,-0.174786,0.897077,-0.0688912,-0.241519,0.6321,-0.0572252,-0.138889,-0.0739792,0.240835,0.210831,-0.0818732,-0.0748478,0.677494,0.47339,0.664924,-0.0747748,0.102123,0.363008,0.290551,-0.269729,-0.275294,-0.332944,-0.609662,0.635113,-0.079263,-0.172919,-0.726419,-0.0444877,0.0875189,-0.468066,-0.38565,0.385694,0.540402,0.128062,-0.325837,-0.63904,0.390136,-0.198616,-1.04511,-0.432936,-0.115201,0.232109,0.215533,0.481776,0.464256,-3.29762 +3364.53,0.949364,0.0848144,5,1.51961,1.01292,-1.51793,0.773569,0.851808,-0.100702,0.504338,0.794041,0.114121,0.757824,0.203293,0.360577,-0.0713777,0.119125,-0.43163,1.47541,-0.148187,0.264208,0.818003,0.24759,-0.270938,-0.613263,-0.820936,-0.171017,-0.150426,0.282375,-0.0422975,0.503585,-0.204659,0.223068,0.737638,-0.494767,0.298889,0.753685,-0.496082,-1.34896,-0.87569,-0.00746247,0.777124,-0.474401,0.862405,0.574287,0.589163,-0.58011,-0.451929,-0.419175,-0.464161,-0.117026,0.0478224,0.0927936,0.178035,0.691077,-0.186772,-0.352738,-0.171238,-0.25645,-0.280873,-0.702759,0.116275,-0.391557,-0.334504,0.43917,-0.598738,-0.537988,-0.0412527,0.593517,0.0232693,0.22201,-0.496113,-0.171154,-0.206857,0.450016,0.669281,0.511224,0.318047,0.446816,0.0987642,-0.442678,0.17059,0.124278,0.0752469,-0.491138,0.29317,-0.473191,-0.0691174,0.635724,-0.0033325,-0.308625,0.0198715,-0.142733,0.0269225,0.260343,-0.14934,-0.743038,1.05254,0.277439,0.569939,-0.160029,0.0534836,0.182956,0.511707,-0.444134,-0.0220005,0.00414842,0.599544,-0.0317133,0.897559,-0.161336,0.331605,-0.21185,0.46129,0.144498,0.369605,-0.0600852,0.0341925,0.403338,-1.16952,-0.168284,-0.056439,-0.399277,-0.371174,-0.518147,-0.481054,-0.467215,-0.389171,-0.0753979,0.225934,0.0472763,0.0867359,-0.392094,0.434314,0.110871,0.399852,0.133682,-0.288657,0.231798,0.11413,-0.653033,0.357796,-0.499537,-0.637809,-0.0167043,-0.875724,-0.696625,-0.401857,0.68313,0.0981807,0.563573,-0.345828,-0.21327,-0.75506,-0.10088,-0.147886,-0.0666574,0.674641,1.0605,-0.0453196,0.028715,-0.0529174,0.0740249,-0.162556,-0.032822,0.843301,-0.268938,-0.0341798,0.611784,0.157226,-0.026906,-0.140415,0.754122,0.381642,-0.564656,-0.329952,-0.836786,-0.208251,-0.361884,-0.769461,-0.451482,0.69656,1.14509,-0.210574,0.103963,0.191356,-0.198488,-0.432162,-0.193649,-0.698429,-0.31445,-0.312941,0.315271,0.00591259,0.200119,-0.0835041,-0.41566,0.291423,-0.0731384,-0.385303,-0.34576,-0.14194,-0.042231,0.0487473,-0.0205498,0.23158,0.0645676,-0.511152,-0.261288,-0.900567,0.873699,-0.576364,0.677028,-0.207607,-0.811863,1.0946,-0.415514,-1.06273,0.308112,-0.742193,0.306027,0.296702,-0.627722,-0.934713,-0.368192,-0.351849,0.809977,-0.538212,0.125826,-0.679984,-0.605893,-0.0116912,0.268999,-0.352853,-0.0165764,-0.264032,-0.0228631,-0.392138,0.431901,-0.275725,0.584372,0.864684,-0.612063,0.106499,0.133384,-0.322774,-0.78078,0.546285,0.0214608,0.33877,-0.163878,-0.426228,-0.49416,-0.133449,-0.958087,-0.00542967,-0.17719,-1.03844,-0.489139,0.00565658,0.11883,0.40358,0.218418,-0.489874,0.485069,0.44987,0.105564,0.615385,0.355936,-0.114828,-0.177193,0.242844,-0.0466408,-0.325842,0.172984,-0.101632,0.415281,0.0175053,-0.424134,0.00993073,-0.109142,-0.160642,-0.124392,-0.70906,-0.23263,0.0377371,0.0553915,-0.185563,0.338978,-1.00333,-0.187527,-0.514137,0.153188,-0.0474592,0.656617,0.258783,0.0955851,-0.094455,-0.592883,0.397871,0.226209,-0.722953,-0.290794,-0.325054,0.194136,0.268031,0.440609,0.517717,-3.00991 +3366.63,0.973875,0.0848144,5,1.57474,1.04207,-1.3097,0.668021,1.18038,-0.104708,0.448536,0.920847,0.290989,0.877939,0.293081,0.342852,-0.278164,0.123443,-0.494006,1.52014,-0.0265245,0.131854,0.829641,0.205174,-0.394157,-0.49538,-0.842093,-0.332404,-0.223098,0.257343,-0.0262581,0.327766,-0.0814246,0.302757,0.764982,-0.305151,0.396369,0.774254,-0.391086,-1.29829,-1.05716,0.0945876,0.826898,-0.457988,0.821744,0.485346,0.822886,-0.479301,-0.293756,-0.558816,-0.385492,-0.212345,-0.0173536,-0.136426,0.201068,0.484874,-0.164356,-0.369513,0.00162169,-0.259376,-0.194845,-0.784927,0.113029,-0.366748,-0.275683,0.400173,-0.659184,-0.534319,-0.00740694,0.444873,-0.1052,0.153604,-0.338748,-0.240105,-0.305358,0.494995,0.637508,0.428256,0.286818,0.417062,0.26168,-0.34239,0.179496,-0.10208,0.31606,-0.416448,0.202108,-0.551703,-0.0243887,0.659052,-0.0705707,-0.541095,-0.0444227,-0.0443465,-0.0633026,0.118878,-0.167006,-0.697114,0.94786,0.267428,0.4711,-0.153604,-0.0979696,0.218894,0.404535,-0.501706,-0.0177273,-0.00637689,0.855876,0.0114109,0.907182,-0.0762729,0.31565,-0.215165,0.238462,-0.0326173,0.354545,0.111897,0.0807268,0.25163,-0.999518,-0.116055,0.0200673,-0.327599,-0.286706,-0.464964,-0.52186,-0.431106,-0.511186,-0.161528,0.0536479,-0.0138738,0.0937828,-0.462235,0.393288,0.219125,0.477446,0.0472897,-0.230156,0.320716,0.0569324,-0.698345,0.22314,-0.58198,-0.583986,-0.00317452,-0.671665,-0.615419,-0.210716,0.750745,0.0418002,0.346712,-0.272571,-0.20754,-0.758704,-0.276868,-0.0117867,-0.299211,0.657743,1.04386,-0.176256,0.0751283,-0.000557807,-0.161231,-0.087798,-0.0705605,0.852084,-0.293005,-0.0629343,0.582364,0.0673571,0.00605574,-0.187033,0.673211,0.226381,-0.524485,-0.296322,-0.744753,-0.1843,-0.336964,-0.677571,-0.50017,0.593339,0.956789,-0.283548,0.225654,0.265686,-0.170755,-0.624249,-0.273746,-0.8246,-0.283101,-0.422939,0.100999,-0.0235213,0.110437,0.0813226,-0.340961,0.41499,-0.236781,-0.479258,-0.403711,-0.323492,-0.151505,0.0319112,0.102973,0.222529,0.13744,-0.582861,-0.0779336,-0.934029,0.936961,-0.642205,0.669305,-0.120227,-0.801379,1.00838,-0.347802,-1.06091,0.225854,-0.675585,0.263568,0.347509,-0.436427,-0.99472,-0.439645,-0.317178,0.7,-0.289118,0.198945,-0.626945,-0.83408,-0.135393,0.427299,-0.181887,0.0936875,-0.201648,-0.231355,-0.318827,0.628965,-0.369689,0.728699,0.923203,-0.375101,0.0463923,0.289934,-0.255247,-0.766965,0.516102,0.0477207,0.367073,-0.0773678,-0.325369,-0.563531,-0.031611,-0.930589,0.0408722,-0.199071,-1.26335,-0.460151,0.0697691,0.0848876,0.136106,0.191563,-0.421086,0.592095,0.515682,0.194269,0.830234,0.170862,-0.109486,-0.300306,0.00125747,-0.115414,-0.186228,0.11266,0.118874,0.34951,0.0552686,-0.474154,-0.0427357,-0.2556,-0.183556,-0.323418,-0.851263,-0.0264359,-0.00551187,0.143802,-0.123646,0.377245,-1.03446,-0.178638,-0.42404,0.023825,-0.162012,0.441358,0.336389,0.0730305,-0.097661,-0.673294,0.558964,0.192864,-0.932075,-0.425228,-0.0886817,0.188467,0.279223,0.434128,0.528415,-4.10541 +3396.34,0.992588,0.0848144,5,1.62709,0.878517,-0.635952,0.249191,0.437675,0.0051649,-0.315748,-0.22429,0.431154,0.0395095,-0.118213,-0.464539,-0.39331,0.327623,-0.0562683,0.886482,-0.168121,-0.288319,0.0901803,-0.0282792,-0.124617,-0.96651,-0.377507,-0.254854,0.157635,-0.15674,-0.243045,0.649877,-0.227583,-0.136926,0.927777,0.189733,-0.15906,0.10464,-0.1871,-0.36999,-0.435886,0.351623,0.645037,-0.482684,0.824312,0.388191,-0.0501097,-0.959059,-0.471703,0.529415,-0.87727,-0.280436,-0.363742,-0.313336,-0.448929,0.530507,-0.0290899,-0.0712069,0.602495,-0.244369,-0.521569,-0.962943,0.481959,-0.504809,-0.226683,0.797754,-0.53455,-1.53964,-0.154046,0.67303,-0.583718,-0.081048,0.110543,-0.331836,0.119102,0.897228,0.746665,-0.307815,0.847956,0.485496,0.902817,0.102693,-0.673224,0.0803012,0.625928,-0.323134,0.512058,-0.0728164,-0.00826007,0.3266,0.0333074,-0.272824,0.205521,-0.63135,-1.03872,0.647121,0.167344,-0.0161792,0.269446,0.0172775,-0.190753,-0.524036,0.692192,0.451988,-0.529548,0.215168,-1.35732,-0.247341,0.10249,-0.671838,0.24093,0.149741,0.291856,0.860442,-0.20503,-0.156549,0.251079,0.477851,-0.148184,0.0851239,-0.0147238,0.148952,-0.0791245,0.202996,-0.698074,0.212903,-0.179965,-0.391388,-0.0396899,0.69853,0.821542,-0.175294,0.149866,0.133467,0.810913,0.124003,0.0408423,-0.249442,-0.00135697,-0.366935,-0.613528,0.39812,0.435999,-0.714562,0.0204764,0.288435,0.507545,-0.55993,0.505453,-0.0539366,-0.152624,0.77891,-0.184677,-0.43482,0.230849,0.314589,-0.0342064,0.295135,0.281813,0.608289,-0.0988212,0.205821,0.217929,0.284942,0.157341,0.326255,0.671304,0.383929,-0.276023,-0.284564,0.39065,-0.140701,-0.0704853,-0.596722,0.363186,0.156453,0.127048,0.210746,0.108801,0.0641232,0.155237,0.171873,0.628153,0.793854,0.625198,0.216459,0.326432,0.347754,-0.498737,-0.790153,0.0334293,0.00614993,0.362519,-0.751983,0.255951,0.163208,-0.650643,-0.810354,-0.0949053,-0.132294,0.275569,-0.0487704,-0.913971,0.215867,0.261391,-0.390441,-0.03682,-0.372928,0.142927,-0.411923,0.13662,0.909853,0.115627,0.34136,0.283087,-0.0375362,0.415247,0.588473,-0.248243,-0.375603,-0.195008,0.0632051,-0.263616,-0.46812,0.249906,-0.484695,-0.449,0.527787,-0.0990238,1.22295,0.197037,0.104865,0.224306,-0.473913,-0.65868,-0.0589432,0.158183,-0.0156973,-0.172697,0.280146,-0.0343728,-0.218045,0.79198,-0.0937552,-0.0791378,0.0338647,0.129196,0.440381,0.692478,-0.148951,0.438806,0.307499,0.122506,-0.0574795,0.0725117,-0.836919,0.675973,0.186139,-0.293198,0.672019,-0.675511,0.254211,0.209534,0.065505,0.090237,0.250515,0.330651,0.079862,-0.452126,0.0866459,-0.016109,-0.333469,0.0610053,-0.114094,-0.864908,0.0903187,-0.729973,0.108821,-0.488443,0.423353,0.339015,0.0305067,0.709714,0.533605,0.758292,-0.061099,-0.841312,0.291127,0.319479,0.52674,0.663533,0.370636,0.256423,-0.36469,-0.0739626,-0.537172,-0.516556,0.258045,-0.116583,0.0795199,0.257956,0.292631,-0.170202,-0.044439,-0.0215112,0.178871,0.269012,0.422932,0.518664,-1.28255 +3400.25,0.996716,0.0848144,4,1.6168,0.855371,-0.74452,0.307616,0.248023,-0.143664,-0.283394,0.32859,-0.189079,0.269052,0.422964,-0.368676,-0.347851,0.429618,-0.183564,1.30153,0.0150742,0.230207,-0.022855,-0.234602,-0.211829,-1.03562,-0.548918,0.0512291,-0.454883,0.181779,0.285965,0.230199,-0.228243,0.0512322,0.888312,-0.0783633,-0.0420788,-0.237632,-0.266802,-0.231508,-0.284467,0.236776,0.353679,-1.06669,0.810299,0.714098,-0.0080773,-0.600216,-0.614584,-0.476972,-0.436418,0.100814,0.0615882,0.214709,-0.442233,0.00367127,-0.149175,-0.570862,0.726157,-0.288068,-0.176328,-0.838281,0.293863,-0.483518,0.049405,0.635875,-1.0293,-0.808689,0.152335,0.636139,-0.225063,0.0681973,0.319672,-0.480489,-0.427999,0.531009,0.704295,-0.0470667,0.297538,0.619259,-0.0744231,0.121379,0.500938,-0.0544729,0.708475,-0.703643,0.185414,0.0670042,-0.0987456,0.166968,-0.129685,-0.0997957,0.338747,-0.143871,-0.27263,0.0715385,0.496849,-0.178351,0.278042,-0.526448,-0.181031,0.27253,0.701756,0.422027,-0.444996,0.466582,-0.64124,0.338661,0.111788,-0.666613,0.157893,0.322951,-0.130825,1.17871,0.122311,0.205301,-0.258279,0.203788,0.391441,0.263668,-0.923783,0.0297002,0.589803,-0.179921,-0.367394,-0.331938,-0.189907,-0.221226,0.239143,0.295358,0.265186,0.864628,-0.313613,0.0645517,0.161035,0.00479897,0.184748,0.252143,-0.190939,-0.415178,0.132829,-0.571846,0.288519,0.238949,-0.232985,0.187337,-0.15696,-0.227776,0.124423,-0.301119,0.175073,0.244439,-0.226496,-0.0366452,0.0789973,0.36555,0.205467,-0.106935,0.432648,0.153636,-0.171072,-0.0111615,-0.116093,-0.493724,0.911971,0.379117,1.31324,0.272041,-0.00172663,0.78929,0.380617,-0.484748,-0.112211,-0.463544,0.222687,-0.176314,-0.296671,0.159596,-0.353947,0.818818,-0.46782,0.178742,-0.00213692,0.687792,0.0748956,-0.303231,0.499112,0.230154,0.0911002,-0.623325,0.158281,-0.628302,0.635399,0.0285088,0.379292,-0.0457204,-0.0428005,-0.392159,0.441986,0.60844,0.25013,-0.302661,-0.212226,-0.210498,0.0930935,-0.552676,0.063556,-0.223875,-0.218898,0.133199,-0.65669,0.933052,-0.5898,0.674414,0.065647,-0.538829,0.17437,-0.140278,0.0116958,-0.0464307,-0.123323,0.643158,0.394784,-0.888881,0.0686938,0.384566,0.264036,0.433134,-0.0779898,0.620764,-0.382039,0.128433,0.0163052,0.0266555,-0.523273,0.0635041,-0.202138,0.468399,-0.193576,0.383679,-0.111833,0.131612,0.36933,-0.718037,-0.131966,0.515246,0.363899,-0.260451,0.57189,0.224363,0.28088,0.979978,0.0509012,-0.688025,0.217112,-0.65115,0.542601,-0.317123,-0.754363,0.165726,-0.125378,0.190729,-0.334396,-0.104479,0.23693,0.460016,-0.203312,0.179888,0.0152087,0.54867,-0.0547216,-0.329742,-0.436036,1.04364,0.011829,-1.03496,-0.934564,0.0554688,0.256771,0.785992,-0.0250995,0.351048,-0.157736,-0.525493,-0.128973,-0.641833,-0.998382,0.430197,0.416354,-0.110571,0.0383741,0.338753,0.264701,-0.150359,-0.0690326,0.348989,0.210532,-0.0761483,0.0671797,-0.289716,0.541858,-0.307923,0.544444,0.118132,-0.335526,0.169568,0.194574,0.411786,0.441105,-0.583473 +3393.16,0.825792,0.0848144,4,1.55117,0.842427,-0.731697,0.212481,-0.00146911,-0.146469,-0.43308,0.0502717,0.475673,-0.191187,0.111194,-0.395492,-0.57591,0.607628,-0.235995,0.660348,0.646025,-0.535926,0.00862022,0.159761,0.0130788,-0.716806,-0.431835,0.314804,-0.0487533,-0.225976,0.135496,0.606245,-0.324578,0.0763505,0.60139,-0.515655,-0.189366,-0.168254,0.0793971,-0.192927,-0.207007,0.542981,-0.238279,-0.0762263,1.02451,0.597003,-0.163486,-0.800374,-0.857103,-0.474904,-0.152523,0.227641,0.29493,-0.0488398,0.196589,0.603066,0.195063,-0.260409,0.811852,-0.336248,-0.40603,-0.410375,0.227299,-0.363841,0.157263,0.827461,-0.920549,-0.790924,-0.130821,0.293106,-0.256204,-0.181746,0.40907,-0.368656,-0.28612,0.575419,0.431355,-0.262174,0.218528,0.100097,0.736191,-0.313214,-0.526951,0.120547,0.863999,-0.383621,-0.0305815,-0.590863,-0.113821,0.139952,0.0338876,-0.30308,0.161851,-0.0131924,-0.346416,0.25729,0.261168,-0.205406,0.482198,-0.891212,0.0562697,0.105445,0.204628,0.328837,0.307,0.440291,-0.311389,0.607579,-0.27647,-0.256794,0.364406,-0.417881,0.314985,0.597464,-0.294941,-0.0220921,-0.144182,0.524644,0.211618,-0.10739,-0.12081,-0.0168235,0.57913,0.223063,-0.714965,0.537769,-0.219953,-0.054829,0.255754,0.34856,0.873487,0.00473535,0.120049,-0.462639,0.711344,0.0755871,0.0780529,0.465693,-0.379193,0.144497,-0.123967,-0.0546169,0.265876,-0.843029,-0.310186,-0.350265,-0.0134609,-0.865408,-0.00594266,-0.0543413,-0.454218,0.101188,0.189212,0.799063,-0.420709,0.105936,-0.429175,0.440087,-0.0806901,0.591649,0.167854,-0.122823,-0.0308487,-0.067808,0.466377,-0.205211,0.934524,0.300528,-0.46592,-0.10278,0.0899685,-0.129564,0.134557,-0.682657,0.147274,0.346801,0.19632,0.276077,-0.115413,-0.210963,0.23333,0.327392,0.41021,1.03113,0.301981,0.0300562,0.43944,0.0953474,-0.631493,-0.447867,-0.273173,-0.259869,0.541293,0.174826,-0.0854202,-0.0310634,-0.27411,-0.488093,0.0386163,-0.131363,0.541938,-0.471797,-0.994178,0.508994,-0.151118,0.433075,0.137359,-0.262632,-0.0857814,0.00404766,-0.536855,1.38696,-0.375692,-0.378452,1.09342,-0.14357,0.0269789,0.0357722,0.0448798,0.441039,0.083716,0.0325493,-0.301563,-0.368766,0.420513,-0.132787,0.302242,-0.284197,-0.750864,0.517759,-0.30145,-0.276912,-0.297287,-0.0397899,-0.376625,-0.0356259,-0.347654,-0.0454098,-0.444774,0.520723,-0.0308826,-0.109304,0.601232,-0.609225,0.501563,-0.212684,0.142731,-1.08895,0.489787,0.733449,0.199496,0.0587309,0.471115,-0.0133711,0.587139,-0.648979,0.283659,-0.405721,0.372063,0.47173,-0.631505,-0.154503,-0.156713,0.177849,-0.14669,-0.0677954,0.417392,0.242711,0.548153,-0.112894,0.562971,0.49473,0.271795,-0.00317554,-0.695071,0.706003,0.726944,-0.139823,-0.13342,0.00106258,0.220724,-0.0641787,0.912928,0.165696,0.804218,0.165399,-0.595907,-0.289929,0.633942,0.352984,0.485112,0.103496,0.182501,0.437614,0.110662,-0.173528,0.192156,-0.0931466,0.230725,-0.769005,-0.578871,0.238667,-0.548189,0.621575,-0.525298,0.160677,0.26784,0.400845,0.517533,0.286229 +3411.42,0.980209,0.0848144,5,1.58401,0.771637,-0.948218,0.283109,0.0136159,-0.175122,-0.258771,0.27397,0.306861,-0.222928,0.00606744,-0.312119,-0.765544,0.676013,-0.460534,0.929421,0.553795,-0.467855,-0.0518856,-0.0598997,-0.086627,-0.526041,-0.295896,0.617285,-0.160228,-0.00395322,0.211935,0.275353,-0.0876813,-0.136769,0.385037,-0.347768,-0.122991,-0.213095,0.0353075,0.0742803,-0.365415,0.708751,0.0176623,-0.280431,0.834745,0.601306,-0.049418,-0.565464,-0.521617,-0.25164,-0.298167,0.179153,0.416618,0.0110821,0.189237,0.700348,0.069959,-0.184345,0.804951,-0.050937,-0.294284,-0.204692,0.273889,-0.687639,0.525062,0.724923,-1.12196,-1.13563,0.20098,0.181955,-0.309347,-0.409084,0.178316,-0.605184,0.110748,0.58884,0.592701,-0.605699,0.47615,0.326792,0.971896,-0.124727,-0.726326,0.234277,0.360304,-0.485276,-0.0758228,-0.635587,-0.0305003,0.109864,0.130191,-0.102979,0.0340129,-0.068761,-0.727893,0.0406117,0.13611,-0.239106,0.380722,-0.731262,0.291113,0.192535,0.0714547,0.566219,0.345974,0.287572,-0.093294,0.390283,-0.12662,-0.366394,0.511629,-0.263953,0.490545,0.763265,-0.39657,-0.0275397,-0.455746,0.500712,0.297202,0.0901608,0.0209458,0.0223904,0.468338,0.302876,-0.966963,0.178367,-0.263406,-0.230777,0.33837,0.192809,0.67709,0.241727,0.24611,-0.466524,0.613571,-0.0793032,0.191261,0.323213,-0.133472,-0.0130806,-0.270108,0.0225992,0.45152,-0.961843,-0.213824,-0.257737,-0.117569,-0.783407,0.00351118,-0.27234,-0.414422,0.3154,0.0740171,0.805784,-0.0980396,-0.0104737,-0.263361,0.465131,-0.160243,0.386038,0.194598,0.0527815,0.00102218,0.116029,0.167007,-0.22273,1.2299,0.217516,-0.266438,-0.126173,0.0352473,-0.671066,0.0730742,-0.763084,0.0241668,0.0107382,-0.086657,0.0825973,-0.129636,-0.709943,-0.0638794,0.252495,0.515072,0.971514,0.095537,-0.295311,0.263057,-0.219772,-0.501848,-0.4963,-0.303155,-0.204074,0.179513,-0.207646,-0.260526,0.0562673,-0.0364652,-0.600915,0.192763,-0.150496,0.351469,-0.384728,-0.905135,0.32943,-0.36824,0.176414,-0.0429442,-0.39188,-0.0601678,0.0920233,-0.552168,1.22153,-0.375537,0.109302,0.883576,-0.243455,0.247929,0.117153,0.144778,0.214176,-0.0423926,0.231111,-0.233598,-0.329789,0.305026,-0.642071,0.384182,-0.234275,-0.372834,0.522643,-0.00391486,0.174606,-0.382936,0.153808,-0.772327,0.0613088,-0.515869,0.0278627,-0.121179,0.830802,0.177778,-0.578571,0.912285,-0.962194,-0.110198,-0.000478656,-0.153792,-0.840918,0.264762,0.882056,0.541922,0.0590876,0.421625,-0.177883,0.563084,-0.657258,0.151152,-0.282573,0.398257,0.219016,-0.451345,-0.0512201,-0.0200915,0.138177,-0.0653211,-0.127603,0.235895,0.366756,0.565166,0.176461,0.498459,0.323369,-0.0716231,0.115799,-0.735547,0.37469,0.726548,0.273419,0.176426,-0.38827,0.183035,0.00779531,0.726092,0.409354,0.603053,0.161992,-0.668181,-0.0949943,0.643182,0.237696,0.614618,0.134207,-0.0546741,-0.00766795,0.0349558,-0.0406617,0.162078,-0.409641,0.010685,-0.641713,-0.614694,0.428788,-0.219249,0.506125,-0.173382,0.15741,0.337315,0.396749,0.580788,0.448093 +3433.76,0.943061,0.0848144,5,1.62246,1.04658,-0.77845,0.218597,0.50684,-0.063277,0.477386,-0.0595486,0.25188,0.246387,0.144322,-0.259062,0.726959,0.173955,-0.1395,0.360388,0.186918,-0.423142,-0.330766,-0.460922,-0.380594,-0.952106,-1.10889,-0.104629,0.170326,-0.152779,-0.298136,0.766038,-0.337124,0.151466,0.374385,-0.128068,0.0194767,0.0539474,-0.254285,-0.0742312,-0.168546,0.165845,0.402259,0.0765206,0.457121,0.453816,0.340661,-0.971303,0.128185,0.0154876,-0.760906,-0.0555092,0.231627,-0.390747,0.0780927,-0.0588469,0.10508,-0.43154,0.672126,-0.237838,-0.328178,-0.586347,0.397029,-0.0421668,0.282435,0.862654,-0.688979,-0.624207,0.660855,0.0877496,-0.00249872,0.372088,0.0934137,-0.434703,-0.377909,0.022417,0.499063,-0.119903,0.736362,0.121425,0.195737,0.185495,0.284862,-0.0629146,0.419946,-0.208987,0.193924,-0.0820131,-0.404849,-0.0965876,-0.335126,-0.532453,0.0806621,-0.279579,0.600312,0.638025,-0.0160034,-0.142397,-0.0972815,0.0565591,0.135653,-0.241723,-0.176588,0.269499,0.113547,-0.0309957,-0.167573,-0.469965,0.227171,-0.592857,0.00722483,-0.0735271,0.234778,0.663485,0.668002,-0.0870535,0.587214,0.34714,0.0399506,0.105385,-0.936989,0.199008,0.309436,-0.610767,-0.209164,0.0929671,0.278588,-0.451196,-0.315139,-0.129771,0.0552108,0.0833893,-0.0902398,-0.438851,-0.277407,-0.0699466,-0.218614,0.791833,-0.700981,0.359988,0.446528,0.00407864,0.448257,-0.175605,-0.0864904,-0.0500577,-0.0538298,-0.520291,0.0957355,0.250316,0.333696,0.38977,-0.054927,-0.818291,-0.195391,0.319578,0.257149,-0.315382,0.156346,0.616575,0.135614,0.041565,0.438422,0.311993,0.335137,0.474146,0.595594,-0.262828,0.160609,0.138698,0.122049,0.636712,-0.032244,0.974797,0.36709,0.404591,-0.480671,0.0974263,0.00625921,0.271564,-0.375132,-0.0541965,-0.266394,0.659756,0.0575748,0.401904,-0.183577,0.136649,0.20493,-0.254041,-0.191513,-0.593815,-0.101641,-0.531066,0.192527,-0.184452,0.289062,-0.7027,0.464331,0.75576,-0.0905463,0.00669946,-0.170703,-0.310331,-0.0872885,-1.02774,-0.183571,0.237824,-0.307355,-0.194844,-0.303146,0.952084,-0.200915,0.259007,-0.808606,-0.273747,0.250484,0.169125,-0.120321,0.690104,-0.547689,0.397577,0.891498,-0.0437351,0.00841324,-0.0344601,-0.382662,0.714126,-0.157144,0.465678,-0.665857,-0.356563,0.320541,-0.0237275,-0.116354,-0.0159552,-0.0675178,-0.373839,-0.729028,0.258097,-0.052845,0.486842,0.477037,0.0657674,0.160198,-0.178624,0.022963,0.63351,0.068592,-0.221472,0.0759363,-0.083368,-0.639275,-0.396126,-0.554897,-0.175441,0.34621,0.319103,-0.429113,0.461559,0.128759,0.0264309,0.247811,-0.181934,0.116127,0.422422,0.384788,-0.418063,0.195036,0.0322843,-0.0369388,-0.41004,-0.163657,0.11809,0.266861,-0.510452,-0.831399,0.0607903,0.164722,0.269766,0.398931,0.055106,0.219985,-0.0975737,-0.601069,-0.141768,0.19112,-0.105263,-0.19702,0.541227,-0.452318,0.321527,0.27459,-0.401195,-0.185721,0.348742,0.0973533,0.164942,-0.0175801,-0.323357,0.23575,-0.171512,-0.303449,-0.43241,-0.180538,0.148092,0.175891,0.384827,0.419393,-1.69292 +3440.96,0.310078,0.0848144,5,1.62018,0.902159,-1.20043,0.437098,0.756442,-0.113909,-0.289161,0.0202822,-0.0783296,0.266898,-0.186879,0.129286,-0.622515,-0.0131664,0.103877,0.90376,0.321956,0.217211,-0.506469,-0.101146,-0.393615,-0.59706,-0.318914,0.389623,-0.372833,0.112009,-0.703091,0.28863,-0.221208,-0.205286,0.707193,-1.03976,0.0720823,0.525541,-0.291506,-0.297195,-0.0884625,0.641117,0.0748087,-0.79865,0.753197,0.21317,0.0586046,-0.568452,0.00870998,0.295951,-0.450715,0.0126399,0.242473,-0.0644098,0.0433061,0.247941,0.0292299,-0.261756,0.827737,-0.168342,-0.0544498,-0.246589,0.534326,-0.937431,0.104698,0.662749,-0.090657,-0.927152,-0.129773,0.209979,0.149054,0.103018,-0.630436,-0.438788,0.00612542,0.013366,0.850361,-0.0952268,0.404255,0.393637,0.467813,0.527737,-0.380824,0.216637,0.1781,-0.37847,-0.210399,-0.0320489,0.255497,0.742651,-0.100787,-0.436866,0.0409013,-0.441035,0.661687,-0.243758,-0.334545,0.128077,0.154929,-0.437892,0.117535,0.412956,0.228724,0.61029,0.184193,-0.605076,-0.026379,-0.0165912,0.364065,-0.54523,-0.0304572,-0.333031,0.569197,0.367629,-0.0939771,-0.621347,0.0720678,-0.126892,0.191353,0.042627,0.00976064,-0.141327,0.24498,0.182779,-0.34289,-0.0341641,-0.137564,0.108506,-0.0929137,0.242503,0.559133,0.190337,0.3358,-0.340767,0.520621,0.0105085,-0.53486,0.388619,-0.0769375,-0.487421,0.125789,0.00169337,0.353739,-0.515678,-0.938546,-0.226562,-0.170013,-0.590294,0.246063,-0.178254,0.0451397,0.331339,-0.244698,0.0401191,-0.199185,-0.128505,0.126403,0.284543,0.326092,0.602095,0.164193,-0.17183,-0.0457152,-0.569036,0.345388,-0.0393345,0.342393,0.150035,-0.111707,0.107276,-0.130183,-0.324903,0.00272489,-0.0828675,0.12632,-0.141571,-0.186443,-0.784082,0.0499369,-0.631702,-0.292212,0.124579,-0.187837,0.892489,0.126145,-0.0408623,-0.552246,0.0475746,-0.158858,-0.217473,-0.432181,-0.0188243,0.301195,0.107584,-0.0591323,-0.362773,0.030534,-0.645768,-0.354037,0.0532824,-0.0135912,-0.276255,-0.500272,0.0140993,-0.183775,0.102439,0.129611,-0.284544,-0.157696,-0.0138546,-0.443722,0.843783,0.144417,0.0268807,0.0553079,0.213965,0.196911,0.202886,-0.45385,0.361952,0.0242178,0.562142,0.163751,-0.930852,0.0818262,-0.764256,-0.280489,0.409609,-0.257138,0.559247,0.194724,-0.078966,0.0721413,-0.290502,0.239573,-0.444387,0.0525842,-0.11366,-0.94416,0.276098,0.352185,-0.306966,0.585783,-0.973079,-0.430055,0.0599091,0.104595,-0.376803,0.270842,0.080466,0.433523,-0.26331,-0.466252,0.0537941,0.455148,-0.535269,-0.139426,-0.732401,0.519814,0.0855863,-0.401696,-0.531977,0.471133,-0.101452,-0.13808,0.112114,0.616566,0.357002,-0.221854,0.375039,0.0349794,-0.0698227,0.0904536,-0.0970934,-0.524252,0.0597437,-0.144626,0.297417,0.18615,-0.307147,0.202436,0.0034256,0.544386,0.366664,-0.135263,-0.399975,-0.10134,0.484845,0.287078,0.415206,-0.400093,0.259972,0.21345,-0.0345975,-0.413444,-0.199431,-0.0267068,-0.106863,-0.386542,-0.302351,0.456835,-0.0392438,-0.135988,-0.117726,-0.0144898,0.126119,0.198459,0.355132,0.445488,-2.24135 +3429.26,0.771688,0.0848144,4,1.60327,0.784317,-1.12117,0.5383,0.819878,-0.0729676,-0.659834,-0.317824,0.177349,0.0825401,0.121514,0.173091,0.121671,0.292656,-0.0658906,0.785773,0.0434796,0.0080644,-0.405077,0.0836019,0.01536,-0.491301,-0.719813,0.493557,-0.5328,-0.0515842,-0.184189,0.28717,-0.0436829,0.362138,0.771333,-1.03352,0.191793,0.465855,-0.248517,-0.421601,0.200503,0.216009,0.448484,-0.526446,0.632531,0.521421,0.178436,-0.662419,0.0653773,-0.267578,-0.0054826,-0.149904,0.457537,-0.0956892,-0.0332397,1.07803,-0.0664061,0.184426,0.773851,0.013196,-0.335068,-0.403656,0.572067,-0.236036,0.0010832,0.622801,-0.114759,-1.30388,0.101351,0.636885,0.0415529,0.0138087,-0.184112,-0.281505,0.0011562,0.220908,0.771692,-0.0852654,0.486593,0.473856,0.170177,0.369714,-0.564028,0.263739,0.236636,-0.540324,0.118765,-0.187451,0.450342,0.177789,0.409318,-0.160655,0.147195,-0.195759,0.50051,-0.321761,-0.439052,0.0806644,0.323531,-0.653167,0.706231,-0.150661,0.340401,0.266976,0.532226,-0.42229,-0.473445,-0.129763,0.772251,-0.258134,0.276531,-0.465383,0.464946,0.514833,-0.164499,0.1578,0.496177,0.100983,-0.663548,-0.076482,-0.128226,0.190467,0.173054,-0.0790806,-0.542141,-0.475182,0.153349,0.166247,-0.282948,-0.356032,0.17638,-0.47962,0.474132,-0.385934,0.429855,-0.0815808,0.0152277,0.0850985,-0.357244,-0.497896,-0.065215,-0.383424,0.452925,0.0926542,-0.506194,0.0762964,0.284504,-0.692739,0.369274,-0.0168007,0.123445,0.453944,-0.169999,0.333753,-0.916781,0.242655,0.196122,0.205841,-0.0137607,0.22153,0.204186,0.269123,0.168536,-0.0492307,0.363259,-0.124393,0.579338,0.481927,-0.470099,-0.086998,-0.446101,0.033063,-0.0551831,0.366955,0.413206,-0.659505,-0.518594,-0.937336,0.0112758,-0.375782,-0.374798,-0.0912218,-0.48934,0.919236,-0.238111,-0.0215199,-0.284924,0.607887,0.51583,-0.560708,0.0460029,-0.272222,-0.146614,-0.0845893,-0.341067,-0.385753,-0.0464744,-0.906019,0.0939719,-0.00755702,0.253631,-0.20059,-0.41899,0.171625,-0.0818913,0.255261,0.138471,0.165536,-0.268249,-0.232419,-0.354614,0.844548,0.114488,0.2015,-0.136607,-0.261279,0.653599,-0.0392174,-0.432936,0.216512,0.12057,0.383979,0.611478,-0.541503,-0.465972,-0.705396,0.0720267,0.479542,-0.439296,0.127367,-0.498915,-0.120741,-0.13214,0.037556,0.209976,-0.313784,-0.0372647,0.0659324,0.168502,0.172468,-0.198241,0.144129,0.664516,-0.917703,-0.320176,0.208149,0.618863,0.105432,0.582791,0.0842471,0.49854,-0.444948,-0.664262,-0.0874645,0.0884172,-0.363494,0.282104,-0.844822,0.478376,0.319897,-0.239881,-0.302735,0.251575,-0.22971,-0.427509,0.044805,0.343809,0.181347,0.370212,-0.36604,0.184741,-0.0731361,0.140936,-0.0668326,-0.295195,0.180925,0.0657929,-0.0347476,0.340047,0.0859349,0.225252,-0.174451,0.458797,0.331069,0.167493,-0.120132,-0.245364,0.572029,-0.288276,0.15881,-0.479368,0.621733,-0.144301,-0.281268,-0.375162,-0.344142,0.107512,0.00324544,-0.456578,-0.315215,0.200634,0.206711,-0.393483,0.147744,0.334029,0.149552,0.167476,0.38672,0.409238,-2.40837 +3413.99,0.985945,0.0848144,4,1.5421,0.822617,-1.62282,0.642345,0.583773,-0.172287,-0.648538,-0.147093,-0.00562518,0.48219,0.0258925,-0.0866969,-0.271706,0.320056,-0.350059,0.862037,0.238137,0.0105962,-0.276886,-0.0620791,-0.302935,-0.413238,-0.794474,0.161824,-0.377772,0.0246207,0.0758001,0.451281,0.0658355,0.016468,0.723884,-0.256435,-0.123191,0.48162,-0.181962,-0.612469,0.0453368,0.355613,0.40499,-0.478404,0.732359,0.328902,0.187549,-0.528472,-0.0659294,-0.155934,-0.459521,-0.0581074,0.676091,-0.0721734,-0.269912,0.410338,0.0280015,-0.454756,0.568241,0.0313609,-0.265556,-0.697752,0.330818,0.180007,-0.259571,0.71827,-0.219281,-0.754897,0.0717578,0.310641,0.745092,-0.639666,-0.361763,-0.0869809,-0.083012,0.0903841,0.529534,-0.0235275,0.441839,0.233598,0.559624,-0.0096329,-0.179277,0.246794,0.0467794,-0.0760816,0.161499,-0.129827,0.00201023,-0.226212,0.403567,-0.067673,-0.13258,-0.549614,0.266698,-0.14985,-0.350449,0.0337288,0.48281,-0.666298,0.798006,0.105337,0.0948822,0.118151,0.570329,-0.465654,-0.559901,-0.249847,0.849011,0.154215,0.322626,-0.760532,0.340836,0.400357,-0.132151,-0.151278,0.581821,-0.0160586,-0.575311,-0.237797,-0.0118376,0.0219405,0.28802,-0.074297,-0.164135,-0.0972172,-0.291469,-0.188785,-0.00297073,-0.674282,0.0591671,-0.0579718,0.286258,-0.371778,0.45736,0.102081,0.263817,0.443633,-0.258093,-0.441585,0.0629295,-0.532253,0.300495,-0.701162,-0.400056,-0.355056,0.560914,-0.635993,0.0258364,0.070687,0.0928469,0.547069,0.0437237,-0.324963,-0.667947,-0.00863302,0.151274,0.219724,-0.14035,0.239372,0.467531,0.454257,0.388106,0.409428,0.418952,0.152396,0.447598,1.08368,-0.0666248,-0.0609697,-0.563972,0.112544,0.179221,0.193855,0.356169,-1.03034,-0.29168,-0.660326,-0.333265,-0.028312,-0.516664,-0.0243511,-0.341025,0.988118,0.353301,0.0249532,-0.0387248,0.0317247,0.568822,-0.435998,0.0963995,-0.541738,0.19046,-0.0760877,-0.493042,-0.478696,-0.0393824,-0.922268,0.45264,0.0417328,0.0160076,-0.384847,-0.483048,0.0700031,-0.0458235,0.00964638,0.0441551,-0.0996746,-0.135851,-0.582537,-0.727895,0.982966,-0.0441464,0.192611,-0.0690075,-0.677218,0.92002,0.0890783,-0.222574,0.333656,0.335462,0.418436,0.336412,-0.459739,-0.419875,-0.767131,0.569027,0.511167,-0.40686,-0.0195698,-0.313144,0.11939,-0.420508,-0.111952,-0.157799,-0.276934,0.488084,-0.0300756,0.141199,0.261603,0.278872,0.314597,0.82855,-0.734151,-0.258713,0.180398,0.617629,-0.0491564,1.25503,-0.20362,0.30286,-0.48689,-0.666278,0.0619229,-0.128587,-0.457582,0.381371,-0.597373,0.0490198,0.525752,-0.0123041,0.18536,0.227837,0.15416,0.0301475,0.178744,0.0623452,0.0942922,0.0693843,-0.510953,0.211622,0.184357,-0.32372,-0.477317,0.143181,0.0779697,0.41251,-0.0939073,0.00666368,-0.0626845,0.311857,-0.431737,0.180493,-0.0105058,-0.201684,-0.0452427,-0.359083,0.331177,-0.192475,0.0796294,-0.575605,0.3849,-0.0973157,-0.0062093,-0.421655,-0.0668031,0.202197,0.343904,-0.0997443,-0.516977,0.267722,0.252693,-0.20949,0.0871523,0.0596959,0.134008,0.138526,0.36607,0.37219,-1.5637 +3408.61,0.982454,0.0848144,4,1.63417,0.681613,-1.0503,0.55603,0.794599,-0.11604,0.00814662,0.00997107,0.39625,-0.0603807,0.532869,0.221436,0.322908,0.62988,0.0777288,0.71274,0.0357713,0.0511478,0.0295329,0.162984,-0.131259,-0.398208,-0.548825,0.652729,-0.155687,0.304727,-0.310934,0.224561,-0.528295,0.571957,0.944894,-1.0325,0.0742704,0.511693,-0.7569,-0.644179,-0.240457,0.764529,0.354188,-0.655372,0.405149,0.178874,0.41906,-0.887697,0.414323,-0.299212,-0.377501,-0.0658994,-0.0435925,-0.0520109,-0.0791308,-0.0602857,0.107747,-0.438347,0.81233,0.171439,-0.197515,-1.22278,0.32918,-0.499949,0.397049,0.386789,-0.495074,-0.865567,0.0807417,0.126026,0.286847,0.203366,0.698809,-0.207247,-0.398875,0.369647,0.415299,0.160664,0.891337,0.424082,0.499665,0.264274,-0.468818,0.000984252,0.335552,-0.263866,-0.108534,0.379338,-0.474373,0.447428,0.0186062,-0.192246,0.104668,-0.103345,-0.526586,0.163652,0.0179136,0.56288,-0.177147,-0.162266,-0.252631,-0.0549325,0.193022,0.188314,0.262469,0.014701,0.188223,-0.944529,-0.251996,-0.363432,-0.158481,0.285734,0.138851,0.558772,0.0139989,0.0135787,-0.228183,0.108741,-0.354361,0.19272,0.130806,0.188016,-0.697532,0.0832849,-0.809657,-0.154495,-0.458543,0.0715798,0.0609788,-0.0336386,0.106541,-0.004996,0.0151807,-0.433787,-0.651414,-0.258729,-0.23283,0.0179002,-0.549694,0.282176,-0.311941,-0.202865,0.314341,-0.302778,0.523522,0.0109548,0.381856,-0.772704,-0.0910423,-0.193249,0.261456,0.290801,-0.290649,-0.0331492,-0.209596,0.32664,0.184656,0.652277,0.0381787,0.212861,0.058398,0.068518,-0.0796185,-0.008292,-0.197557,0.353535,0.0918509,0.0883961,-0.33038,0.133489,0.225748,-0.140976,-0.00812891,-0.00706507,-0.08299,-0.0676218,-0.458285,-0.40037,-0.030185,0.0831551,-0.304681,-0.603255,-0.802987,1.12671,0.183333,-0.118647,0.174071,-0.0841683,0.0140493,-0.32602,-0.535888,-0.353309,0.199431,-0.627199,-0.0036027,-0.23182,-0.0232703,-0.300936,-0.171293,0.568266,-0.0447581,-0.0146193,-0.607473,-0.127794,-0.388247,-0.322461,0.293628,-0.371459,0.568032,0.0454763,-0.464526,0.840742,0.0887254,0.356759,0.141947,-0.452478,0.221581,0.189604,-0.232189,-0.144115,0.713068,0.34125,0.336075,0.0490878,-0.369167,-0.0644683,0.343053,0.0935063,-0.285938,0.135978,-0.231544,-0.268705,-0.218321,-0.0999519,0.39899,-0.251587,-0.580036,-0.198243,-0.260819,0.651757,-0.480995,-0.190213,0.690468,0.0010992,-0.145461,0.173374,-0.169951,0.581665,-0.328339,-0.190778,0.0350137,-0.0423194,-0.287525,-0.513672,0.0329007,-0.310977,0.624634,-0.428521,0.0757174,0.0542212,-0.183268,-0.83779,-0.0768346,0.0277855,-0.0612561,-0.0294644,-0.0537225,-0.151263,-0.132354,-0.272159,-0.0725828,-0.00630854,-0.401686,0.0942566,-0.0985081,-0.0952959,-0.653488,0.412231,0.00806021,0.100223,0.510284,0.0663184,0.490579,-0.42737,-0.53521,0.152089,0.0174968,-0.361145,0.0534514,0.322372,0.0347515,-0.302969,0.090198,0.343393,-0.137211,0.241943,0.3497,-0.961828,-0.18064,-0.829395,0.335125,0.257343,-0.19051,-0.384364,0.794356,0.152132,0.24429,0.390041,0.494257,-2.15525 +3399.54,0.900863,0.0848144,4,1.62853,0.525706,-1.23022,0.584983,0.490342,-0.0258706,0.0958195,-0.26237,-0.960138,-0.059543,0.790099,0.103496,-0.0914626,0.547307,-0.573285,0.570299,0.420039,0.485247,-0.333891,0.382346,0.477558,-0.317827,-0.955146,0.660833,-0.652205,0.268604,-0.0950415,0.336481,-0.36113,0.0307305,1.05066,-0.119619,-0.708647,0.244784,0.0414515,-0.501425,-0.538146,0.547632,0.166875,-0.583022,0.795044,0.700251,-0.0864367,-0.680393,-0.100422,0.0471656,-1.01982,-0.186756,-0.123449,0.0667773,-0.234067,0.22926,-0.414156,-0.780194,0.853978,-0.358483,-0.0877884,-0.817409,0.300316,-0.110052,0.406489,0.489904,-1.05009,-1.71623,-0.821413,-0.40472,0.192191,-0.147377,0.45212,-0.617334,0.352928,-0.075183,0.644865,0.0757365,0.562659,0.582579,0.118194,-0.214783,-0.237638,0.197973,-0.086692,-0.845888,0.208107,0.324346,-0.301171,-0.0283021,-0.400618,-0.285744,-0.112742,-0.532513,0.66055,0.00376866,0.0622451,0.198661,0.109475,0.307421,-0.261252,0.245768,0.410555,0.298548,0.0937084,0.145442,-0.245929,-0.102493,0.360819,-0.137114,0.572428,0.0368997,0.0318022,0.676054,-0.182717,-0.296722,0.680062,0.240137,0.0599749,-0.064252,0.370786,-0.0772801,0.558524,-0.627373,-0.722427,0.0572162,-0.247453,-0.33892,-0.781078,0.411282,0.341655,0.114146,-0.248961,-0.733383,0.356357,-0.0313002,0.166926,0.812646,-0.345847,-0.611465,-0.0824955,-0.780583,0.464785,-0.323488,-0.524261,-0.0467407,0.102767,-0.557302,0.275553,0.148041,0.099387,0.482392,0.0623643,-0.433048,-0.0244847,0.371476,-0.0676402,0.308526,0.786967,0.367528,-0.235506,-0.249543,0.509548,-0.481355,0.608795,0.336731,0.594441,0.418508,0.417003,0.502358,0.230606,0.0748879,-0.350938,-0.253594,0.337535,-0.258754,-0.127533,-0.344245,-0.265627,0.113871,-0.538467,0.361211,0.314457,0.934173,0.190824,0.763827,0.458155,0.110526,0.100452,-0.311219,-0.302232,-0.830686,-0.283667,-0.163653,0.0022028,-0.407242,-0.00725531,-0.0837058,-0.111007,0.360691,0.294955,-0.604002,-0.680013,0.0808828,0.15252,0.09273,-0.261525,0.492328,-0.0296048,0.275808,-0.436591,0.894923,0.0518335,0.49039,0.207832,-0.0869435,0.396014,0.258311,-1.45233,0.451996,-0.427561,0.184248,-0.0066996,-0.201062,0.0405981,-0.641261,-0.271281,0.0260132,-0.639817,0.977875,-0.564631,-0.478915,-0.132646,0.0764192,0.32066,-0.0440092,-0.49729,-0.428034,0.00233217,0.109101,-0.398361,-0.0333577,1.00188,-0.655949,-1.00749,0.720739,0.506187,0.158548,1.06181,0.0456639,0.031191,-0.250085,-0.699528,-0.40383,-0.373951,-1.04355,0.0644496,-0.195333,0.23928,-0.143857,-0.544434,-0.0291303,0.11877,0.169659,0.0250733,0.158965,0.0705407,0.367575,0.0485551,-0.34474,-0.152256,-0.266392,0.186813,0.16695,-0.414968,-0.117057,-0.700067,-0.274939,0.273676,-0.0147005,-0.00817882,-0.223042,-0.169988,0.00554842,-0.834673,-0.321037,-0.0445577,0.369404,0.594864,0.164732,0.091326,0.465778,0.43642,0.00956916,-0.201477,-0.529319,-0.492768,0.376367,-0.146984,-0.169142,-0.450769,0.497226,0.169945,0.202415,0.0624916,0.163537,0.322122,0.404397,0.567558,-0.830656 +3398.29,0.84631,0.0848144,5,1.62335,0.513191,-1.19336,0.613409,0.493301,0.0516308,0.0550785,-0.053978,-0.891194,-0.600882,0.827709,-0.0232229,0.14023,0.693693,-0.661311,0.616896,0.392393,0.291344,0.0561129,0.316277,0.268079,-0.615281,-0.758901,0.666266,-0.387589,0.512421,-0.130945,0.51971,-0.489032,0.405841,0.951776,-0.828258,-0.923533,0.454623,-0.36582,-0.117716,-0.437065,0.291631,-0.144395,-0.520335,0.627066,0.722074,0.0363551,-0.687621,0.0197026,-0.0348138,-0.661376,0.182203,0.138663,-0.0397768,0.383597,0.334895,-0.0625623,-1.69214,0.739595,-0.0423162,-0.135278,-0.636909,0.615787,-0.637867,0.421887,0.633065,-0.831694,-1.05943,-1.08797,-0.468212,-0.18925,-0.054059,0.385281,-0.562673,0.105933,0.0118306,0.73639,0.24941,0.800219,0.171752,0.225991,-0.0191314,-0.33271,0.0743122,0.185014,-0.57188,0.219668,-0.414743,-0.570998,0.0741238,-0.582705,-0.393516,0.246036,-0.464644,0.823063,0.0629038,0.33863,-0.00205706,0.164027,0.292353,-0.154317,0.703615,0.572384,0.581496,0.269442,0.0585185,-0.0159359,-0.276511,0.136669,-0.358763,0.416904,0.0954811,0.587151,0.193625,-0.609343,-0.412573,0.447904,0.308865,0.13435,0.0248202,-0.159629,0.260634,0.179776,-0.64431,-0.558699,-0.0734705,-0.36647,-0.431737,-0.827407,-0.0143771,0.364788,0.483804,0.01433,-0.655342,0.194434,-0.158952,0.238443,0.579226,-0.368201,-0.12572,-0.292671,-0.66957,0.476366,-0.0514965,-0.812954,-0.0194196,0.288708,-0.522355,0.213671,0.0876107,0.178189,0.374794,0.136617,-0.067095,0.411976,0.3594,0.133295,0.279104,0.844098,0.41961,-0.424775,-0.0583926,0.510024,-0.692898,0.384261,0.475958,0.541469,0.179054,-0.161487,0.560243,-0.155721,-0.0462189,-0.505641,0.120289,0.0300831,0.0510946,-0.111805,-0.241393,-0.0381417,-0.106506,-0.273491,0.441275,-0.04451,0.79607,0.0909534,0.513157,0.344534,0.221044,-0.0906233,-0.30696,-0.229258,-0.855158,-0.328761,-0.70849,-0.0180642,0.00718875,0.0664654,-0.360599,0.241092,0.400944,0.303316,-0.559271,-0.409666,0.328562,0.156543,-0.145998,-0.290272,0.615696,-0.212515,-0.388525,-0.717698,1.22601,-0.155676,0.746212,0.204889,0.0263074,0.511822,0.212787,-1.23372,0.694371,-0.703507,0.239284,0.0451189,0.0246623,0.0708777,-0.269228,-0.814222,0.0102188,-0.413777,0.926892,-0.443981,-0.724657,-0.336147,0.376476,0.29338,-0.000185407,-0.0482035,-0.2251,-0.508219,0.245349,-0.171814,0.0602917,0.969917,-0.855644,-0.705434,0.762308,0.0617806,-0.141808,0.999336,0.0857004,0.075583,-0.151698,-0.516221,-0.143932,-0.316347,-1.21065,0.187114,-0.76363,-0.188206,-0.258286,-0.0904822,0.117375,0.410563,0.30632,-0.327204,0.04918,0.237926,-0.0291332,0.268754,0.00125381,0.0988455,0.139336,0.240953,0.468076,-0.52558,-0.363593,-0.433639,-0.207666,0.238032,0.00477149,-0.0125186,-0.382379,-0.0684221,0.322509,-0.72955,0.13158,0.0662653,0.052583,0.260569,0.0855297,0.103379,0.234807,0.163927,0.10952,-0.197852,-0.635942,-0.609876,0.14164,-0.364897,0.00775368,-0.282106,0.276792,-0.119155,0.0725729,0.081928,0.167249,0.276322,0.408961,0.525663,-0.88923 +3391.55,0.811223,0.0848144,4,1.65839,0.532601,-1.0375,0.467192,0.354441,-0.015749,-0.0462118,-0.328163,0.00191006,0.11018,0.41332,-0.00907985,-0.291214,0.46557,0.0129339,0.482279,0.559717,0.213063,-0.0187252,0.379319,0.400457,-0.573474,-0.937058,0.55729,-0.23464,-0.46214,-0.336923,-0.528771,-0.55088,0.115972,0.983806,-1.25144,0.0663439,-0.0896786,-0.172759,-0.569623,-0.201051,0.91756,0.696403,-0.913812,0.429087,0.191781,0.0240773,-0.708945,0.000886355,0.107972,-0.6857,-0.278061,-0.19124,-0.156986,0.335544,-0.0365444,0.142978,-1.05758,0.720678,-0.34099,0.0706909,-0.782772,0.382571,-0.530943,0.187141,0.476217,-0.258277,-0.668401,0.196256,-0.0490484,0.442844,-0.23905,-0.636551,-0.920579,-0.349913,-0.0789272,0.68408,0.0329993,0.254133,0.576663,0.0288613,-0.0664647,-0.480242,0.0335395,0.302719,-0.046636,0.489817,0.16469,-0.219499,0.211584,0.562364,0.245764,-0.133779,-0.0327581,0.663385,-0.191683,0.523994,0.0600609,0.098991,-0.835349,0.16751,-0.814339,0.136917,0.57361,-0.084563,0.438918,-0.335449,-0.303588,0.646707,-0.686101,0.124817,0.169896,0.193655,0.239544,0.246421,-0.454022,-0.176565,0.391205,-0.327873,0.22111,-0.418935,0.126902,0.503982,-0.229383,-0.558123,0.245344,-0.00655306,0.045886,-0.379357,0.243953,-0.0681819,0.21904,-0.0937888,-0.308692,0.0366223,0.275157,0.282638,0.448408,-0.302186,0.115482,-0.510323,-0.253971,0.165365,-0.263049,-0.416944,0.059317,-0.587145,-0.249769,-0.321018,0.275635,0.436025,0.20865,0.358641,0.55722,-0.111356,0.590713,0.50179,0.240483,-0.0293422,0.178506,0.192174,-0.334939,0.581757,0.131051,0.305492,-0.1848,0.62038,0.246324,-0.19957,-0.156708,0.52273,0.452515,-0.657125,-0.0206654,0.339902,0.866351,-0.00134812,0.227518,-0.249048,0.413471,-0.0775439,-0.428832,0.454182,1.21634,-0.0578631,-0.58854,0.0252738,-0.072796,0.127526,-0.304283,-0.524535,0.177903,0.0453154,-0.590852,-0.0526872,0.543473,-0.619277,-0.505815,-0.396044,-0.147241,-0.0783566,-0.38882,-0.485131,0.0499322,-0.117221,0.0453946,0.326803,-0.601096,0.0114322,-0.201418,-0.99325,1.0748,-0.478836,0.343587,0.37235,0.0230823,0.362455,-0.489443,-0.935248,-0.227097,-0.992484,0.547648,0.571291,-0.246216,0.332062,-0.460056,-0.401965,1.39354,-0.151661,0.571198,-0.150136,-0.275095,0.414448,-0.296408,-0.306606,0.0401033,-0.222331,-0.0629926,0.149055,0.640779,0.600174,0.0367726,0.494075,-0.779926,-0.46427,-0.301387,-0.638472,-0.0866832,0.590764,0.124409,0.158667,0.416331,-0.246232,-0.124373,-0.0368116,-0.966638,0.166459,-0.272954,-0.326925,0.175539,-0.3836,0.461074,-0.349877,0.0573867,0.254407,0.181345,0.0609305,0.0396168,0.126107,-0.150687,0.165964,-0.00887287,0.103336,-0.271765,-0.213017,-0.221485,-0.393365,-0.532198,-0.134878,-0.122318,0.458645,-0.350653,0.491052,-0.219363,-0.294052,-0.301578,-0.694158,-0.448373,0.569749,-0.576699,-0.480406,0.0350958,0.295629,0.525423,-0.0996238,0.55701,-0.57982,0.274427,-0.662674,-0.898021,-0.75397,-0.0451826,-0.569488,0.100333,0.282873,0.154088,0.301207,0.392541,0.548824,-0.353906 +3377.41,0.535912,0.0848144,4,1.55015,0.600194,-1.50853,0.641318,0.415134,0.0391034,0.500805,-0.327204,0.0746003,-0.0321922,0.554264,-0.0876545,-0.910017,0.537702,-0.406307,0.740546,0.234025,-0.0994538,-0.108476,0.2015,0.214137,-0.587685,-0.604248,0.849193,-0.380158,-0.148701,-0.326624,0.073479,-0.534636,0.494919,0.942617,-0.360793,-0.599037,0.289636,-0.581963,0.146001,-0.378493,0.595733,0.784998,-0.334057,0.625993,0.363992,0.341412,-0.346555,-0.417183,-0.239029,-1.3106,0.0708222,0.102746,0.298735,0.615768,0.499955,0.10637,-0.222118,0.369927,-0.249385,-0.127805,-0.53939,0.49402,-0.51601,-0.174318,1.07859,-0.188958,-1.29756,-0.0366544,0.500372,0.473692,0.423716,0.539223,-0.447692,0.472695,0.452014,0.909365,-0.348315,0.611416,0.505447,0.0455667,0.177987,-0.367052,0.588809,0.63909,-0.930292,0.258982,0.0121412,0.030229,-0.0888259,0.401465,-0.407363,-0.0304676,-0.839273,0.25581,0.0730066,0.143807,0.0352627,0.376297,-0.526246,-0.58431,-0.46371,0.175139,0.32939,0.369416,0.686328,-0.751666,-0.212699,0.528425,0.422152,0.733147,-0.129663,0.363567,0.120682,-0.303426,-0.141447,-0.0752534,0.432828,0.0606533,0.0847049,0.198001,0.0296748,0.935895,-0.0722021,-0.466736,-0.511079,-0.301086,-0.364957,-0.48202,-0.0339126,-0.0830074,0.437486,0.198727,-0.200476,0.525008,-0.0364076,0.337223,0.546833,-0.118182,0.378715,0.121575,-0.666529,0.236522,-0.193988,-0.568419,0.302739,-0.225443,-0.189098,-0.641432,-0.248678,0.840095,0.406334,-0.0571188,0.479704,-0.42338,0.496636,0.292392,-0.220929,0.205966,0.408528,0.0339184,-0.0195665,0.54107,0.290044,0.355017,-0.617381,1.24291,0.0916714,0.115121,-0.351165,0.700181,-0.126903,-0.547103,-0.363401,0.288954,0.111817,-0.0454785,0.571289,-0.325039,-0.0695793,-0.221118,0.338713,0.105117,0.595607,0.225882,0.190399,-0.393217,-0.127974,0.0368715,0.116336,-0.400278,-0.280086,0.159676,-0.43544,-0.302418,0.019106,-0.549947,-0.450493,-0.53613,0.0978722,0.295245,-0.722157,-0.190597,0.271852,-0.0878085,-0.318542,0.654912,-0.0720948,0.261196,-0.355011,-0.434362,0.902682,-0.33169,0.608451,0.424828,0.271648,0.21474,0.291033,-0.808552,-0.535021,-0.375957,0.698711,0.573734,0.265631,0.243097,-0.317763,0.279006,1.28216,-0.708936,0.840768,-0.434812,-0.40476,0.0821967,-0.132725,-0.548505,0.0802307,-0.308481,-0.202177,0.00872446,0.500561,0.333074,0.254865,-0.00868288,-0.52749,-0.187425,0.083401,-0.353947,0.0311176,-0.305603,0.00164194,0.0921773,0.0152153,-0.350576,-0.00477148,0.00114697,-0.891159,0.25277,-0.490831,-0.383861,0.139638,-0.381479,0.188425,-0.404156,0.136245,0.939677,0.227323,0.241778,0.0692404,-0.265089,-0.313368,0.0914212,-0.389474,0.333009,0.23445,0.0714421,0.0148065,-0.228324,-0.750351,-0.234573,-0.228898,0.399847,-0.580512,-0.120034,-0.0750086,-0.275856,-0.227284,-0.584804,-0.413348,0.375213,0.102033,-0.491646,-0.113609,0.21161,0.0941633,0.11258,-0.0210742,-0.342543,-0.00509341,-0.778428,-0.766339,-0.429224,-0.110969,-0.290381,-0.366566,-0.149352,0.190744,0.180528,0.436743,0.424885,-0.714493 +3388.19,0.963843,0.0848144,5,1.55733,0.867618,-0.947391,0.427604,0.567382,0.0349647,0.0332194,0.302856,0.058297,0.610239,0.339705,0.181979,0.351244,0.59472,-0.14766,0.831366,0.567346,-0.0489278,-0.0145439,0.151931,0.104162,-0.892259,-0.680471,0.309619,0.199758,-0.157655,0.40519,0.459601,-0.334683,0.0334337,0.849267,-0.583902,0.795705,0.696306,-0.607469,0.102772,-0.0610515,0.497906,0.178254,-0.186654,1.2628,0.531536,0.102028,-0.833745,0.256584,0.263068,0.0869125,-0.152169,0.703414,-0.316547,-0.50239,-0.0944866,0.582442,-0.739945,0.300198,-0.227542,-0.511042,-0.751393,0.145103,-0.636069,0.168586,0.694757,-1.02806,-0.712705,0.171197,-0.36804,-0.577216,-0.475441,-0.258551,-0.359522,-0.493397,0.0968062,0.27085,0.347406,0.50098,0.255692,0.382448,-0.174317,-0.206082,-0.612072,0.596373,0.331476,-0.14016,-0.409313,0.124273,-0.276047,-0.343337,0.0206385,0.259301,0.269931,-0.307146,-0.123791,0.154818,0.0959037,-0.169693,-0.154902,0.503266,0.172407,-0.161859,0.0406044,-0.0407265,-0.747408,0.202379,-0.500123,-0.354653,-0.657451,-0.328447,-0.0686867,0.301478,1.22332,0.273497,-0.483633,0.204123,0.494993,-0.0210583,0.0658756,-0.747991,0.308128,-0.485383,-0.012495,-0.775776,0.299001,0.114929,-0.0883289,0.382724,0.279643,0.453267,-0.265984,0.0194377,-0.398007,-0.364331,0.000630355,-0.212752,0.566119,-0.15485,-0.58308,-0.0421137,0.390838,0.144623,-0.586212,5.08649e-05,-0.109217,0.171567,-0.280049,0.443904,0.344996,-1.1575,0.335328,-0.246739,-0.745273,-0.145409,-0.00772766,0.370857,0.321155,0.0894201,0.1661,0.457284,-0.264471,-0.271082,-0.123801,-0.0490317,0.631274,-0.149248,-0.167755,0.0123015,0.591542,-0.557077,-0.0532061,0.51435,0.455649,-0.432738,-0.248478,0.0306612,-0.713625,0.186723,0.170727,-0.234112,-0.326006,0.26102,0.715164,-0.182651,-0.4424,0.540993,-0.139594,-0.168176,-0.65185,0.0184978,-0.350383,0.304752,-0.333093,0.101978,-0.115531,0.626588,-0.535132,0.436962,0.319912,-0.143953,0.0603491,-0.592024,-0.167462,0.178729,-0.276461,-0.0941685,-0.260931,-0.258355,0.0842209,-0.309635,1.36463,0.349334,-0.395401,-0.283552,-0.260974,0.182405,-0.0656529,0.22166,1.11368,-0.312624,-0.338274,0.211001,-0.788233,-0.116031,-0.68234,-0.372431,-0.600636,0.0708367,0.280204,0.039912,0.20513,0.201466,-0.125444,0.180074,0.327545,-0.0382122,-0.114035,-0.321689,0.672164,-0.0785706,-0.237983,0.718343,-0.0779264,-0.108349,-0.0425993,0.187512,-0.177731,0.861688,0.257606,0.223143,0.281836,0.0324852,-0.714467,-0.0405814,-0.171117,0.219729,-0.0663499,0.0452837,0.191584,-0.351582,0.0353896,0.45167,0.0163645,-1.11085,0.546648,-0.397917,0.0773749,0.341837,0.407791,-0.164464,0.152855,-0.506026,-0.227481,-0.192713,-0.389371,-0.219764,0.66932,0.314939,-0.0474378,-0.339527,0.366602,0.435883,0.160255,-0.378499,-0.198637,0.136785,0.404413,-0.209898,0.251386,0.411448,0.583562,-0.467201,-0.464781,0.040946,0.0309667,0.429923,0.476315,0.596443,0.17538,0.1634,-0.109754,-0.0687792,0.0271495,-0.0589307,0.164859,0.258433,0.406028,0.508363,-1.77665 +3408.35,0.978824,0.0848144,4,1.50633,0.932023,-0.969333,0.509178,1.03865,-0.142791,0.154168,0.271626,0.418712,-0.140716,0.373892,0.21306,0.342946,0.565361,-0.0996235,0.637596,0.526554,0.135332,0.280657,0.0236646,0.386594,-0.497254,-0.873932,0.31603,-0.201353,-0.0690479,0.31374,1.06938,-0.224967,0.0344387,1.09357,-0.219873,0.415682,0.586507,-0.0913518,-0.384774,-0.0184157,0.537439,0.0343376,-0.744905,0.957051,0.527839,0.273398,-0.9857,0.251906,1.37307,-0.509166,-0.126128,0.125287,0.0588321,-0.460283,0.459209,0.3861,-0.915119,0.368774,0.207577,-0.397456,-0.514951,0.118931,-0.291693,0.0992846,0.929204,-0.606348,-0.492977,-0.115736,0.6928,-0.286397,0.00641531,-0.15069,-0.491445,0.0541856,-0.282824,0.512491,0.0403421,1.18722,-0.0939508,0.111957,0.312868,-0.448308,-0.386809,0.849591,-0.131024,0.477399,0.0119332,0.705871,-0.510416,0.130181,0.0505983,0.475837,-0.270827,0.557703,0.336746,-0.359281,-0.308549,-0.168942,-1.19945,-0.0232653,-0.255106,0.309647,0.133124,-0.481786,-0.221373,-0.211637,-0.43822,-0.286322,-0.532052,0.554759,-0.345184,0.349467,0.834311,-0.0429131,-0.383459,0.880598,0.357122,0.0173641,0.733516,-0.128335,0.25378,0.242321,-0.0269728,-0.525472,-0.0307698,0.351359,-0.106811,0.307556,0.602493,0.159708,-0.0365342,0.319947,-0.69495,-0.0294291,-0.527796,0.254215,0.385294,-0.496825,-0.142958,0.645956,-0.0367776,0.141218,-0.278794,-0.0928997,-0.308739,0.446024,-0.637434,-0.313973,-0.306311,-0.0803073,0.347237,0.0154389,0.029175,-0.738033,0.0276695,0.174506,-0.131094,-0.213232,0.607043,0.072754,0.155526,-0.180867,-0.856765,0.218422,0.316978,0.507991,0.239481,-0.545227,0.466307,-0.467682,-0.412322,0.00434426,0.522661,-0.363943,0.32316,0.0270934,-0.298036,0.267534,-0.535588,0.132681,-0.172321,-0.054305,0.760881,-0.256264,-0.0579772,-0.0849269,-0.38299,0.199973,-0.564176,0.206819,-0.690547,0.0528957,-0.161835,-0.136664,0.120357,0.0893335,-0.854003,0.119239,0.47916,0.228965,-0.992984,-0.395609,-0.4833,-0.171252,-0.301343,0.256708,0.0210717,-0.505904,0.0728908,-0.476093,0.895667,0.220937,-0.0314977,0.0377572,0.094813,-0.334583,-0.219349,-0.179807,0.649604,0.320607,0.187024,0.535527,-0.37317,0.191939,-0.376197,-0.102717,0.429316,-0.0870715,0.43477,-0.14839,0.109156,0.572347,-0.388446,-0.738699,-0.150813,-0.409701,-0.0957554,-0.0573999,0.581202,0.129648,-0.472277,0.640132,-0.293141,0.007993,-0.103516,0.243269,-0.160902,0.361011,-0.27878,0.396902,-0.236996,-0.297087,-0.376877,-0.337555,-0.442679,0.210654,0.412729,-0.448063,0.0808174,-0.506813,-0.0801947,-0.0460601,-0.0158344,-0.087793,0.646317,0.0864749,-0.32999,0.4577,0.601967,-0.0980267,0.279143,0.105816,-0.260887,-0.0693721,-0.451361,-0.185905,-0.110161,0.493738,0.185731,-0.201291,-0.103355,0.734237,-0.369081,-0.12292,-1.16797,-0.788866,0.751538,-0.173197,0.463006,0.166586,0.680152,-0.191605,-0.103847,-0.109644,-0.312911,0.185804,0.386326,-0.0531377,-0.425742,-0.0428255,0.0929948,-0.390591,-0.136192,0.117434,0.145219,0.244239,0.381076,0.494206,-3.52741 +3383.87,0.815689,0.0848144,5,1.4635,0.886391,-0.635726,0.24521,0.776498,-0.0829209,0.0973508,0.258042,0.364695,0.344156,0.171469,0.0914892,0.239575,0.591066,-0.179944,0.796956,0.339932,0.364153,0.11692,0.143369,0.287657,-0.955912,0.088291,0.33901,-0.0716815,-0.251674,0.108605,0.759953,-0.470476,0.320527,0.732368,-0.631787,0.102751,0.725337,-0.280748,0.141896,-0.355549,0.431703,0.944521,-0.832477,0.885398,0.95577,-0.360655,-0.136631,-0.153558,-0.401612,-0.306077,-0.310356,0.31533,-0.125725,-0.00101567,0.0462786,0.365343,0.183684,1.25544,-0.221939,-0.169663,-1.01543,0.143421,-0.134484,0.238739,0.824551,-0.622029,-1.50728,0.191095,-0.34789,-0.710126,0.0674178,0.671956,-0.0552799,-0.390765,-0.0163021,0.307954,-0.29879,0.443242,0.361262,0.557747,-0.404643,-0.551812,-0.327707,0.171791,-0.321045,-0.0115253,-0.581289,0.11482,-0.349631,-0.775602,0.237382,-0.103687,-0.0256958,-0.254945,-0.124733,0.0189816,0.403628,0.363436,-0.693233,0.0164003,0.0461955,0.835565,0.614617,-0.642489,-0.215262,-0.180391,-0.220902,-0.388936,-0.546405,0.916722,0.1067,0.681371,0.76768,0.118272,-0.405931,-0.0416612,-0.00552487,-0.020293,0.183918,-0.667731,0.498746,-0.115086,0.20024,-0.532463,-0.675492,0.160869,0.0684523,-0.422607,0.174529,0.761763,0.187339,0.284501,-0.525758,0.190794,0.301652,0.0520285,0.880609,-0.310338,0.147606,-0.569048,-0.186069,-0.057624,-0.707194,-0.242482,0.15488,0.144277,-0.0406789,0.049354,-0.399398,0.134013,0.443217,0.0626975,-0.313256,0.564778,-0.38418,0.33169,-0.277216,0.222104,0.461553,0.448553,0.657033,0.0347414,0.311229,0.692625,0.0221189,0.609896,-0.732145,0.378894,-0.572502,-0.0832903,0.0688015,-0.462831,-0.109515,-0.0990068,0.207634,-0.5445,-0.0549182,-0.0546849,0.154445,-0.0398077,-0.30741,0.195656,0.741557,0.987182,0.142802,0.0599204,-0.282192,-0.458101,-0.249133,0.191003,-0.253686,0.271209,-0.895502,0.0572278,-0.0534224,0.301,-0.819285,-0.442959,0.00290002,0.117016,-0.320482,-0.528566,-0.299077,0.0640711,-0.720077,0.765968,-0.146249,0.252423,0.598228,-0.569202,1.36306,-0.367403,0.621249,-0.206903,-0.60226,0.390491,0.773956,0.148,-0.0673202,-0.324043,0.0417369,-0.230037,-0.574397,-0.798425,-0.200704,0.364037,0.241037,-0.186845,0.360668,-0.274623,-0.335222,0.204679,-0.111493,-0.2027,-0.17247,-0.787917,-0.473747,-0.411924,1.05662,-0.687583,-0.16164,0.566109,0.218874,0.0254317,0.608992,-0.0796266,0.385876,0.611787,0.326588,0.369687,0.188544,-0.0276995,-0.851864,0.67319,0.244938,-0.0569853,-0.913128,-0.420856,0.277799,-0.224773,0.0288798,-0.180109,0.160267,0.513918,0.569864,0.204774,0.134299,0.20124,0.159271,0.392278,-0.731171,-0.23946,-0.0947371,0.228398,-0.348666,-0.437109,0.050286,-0.261312,0.312185,0.263215,0.0211035,0.729444,0.531546,0.0637581,0.439837,-0.316551,-0.498397,0.440131,0.144822,-0.184338,-0.327474,0.358967,-0.355067,-0.268639,0.16982,-0.244061,-0.286606,0.570496,-1.1185,0.0482721,-0.128676,-0.400805,-0.160726,-0.832977,0.175828,0.303137,0.419318,0.550579,-2.5592 +3379.79,0.988949,0.0848144,4,1.51642,0.965931,-0.588517,0.225226,0.655786,-0.0824553,0.302079,0.487508,-0.266023,-0.0521062,-0.0306803,-0.393723,0.374898,0.493328,0.0389266,0.707454,0.339387,0.0339017,0.597158,0.0538421,-0.02865,-0.393814,-0.205186,0.240177,0.221464,-0.491651,0.222334,1.25219,-0.356514,0.434631,0.293224,0.31503,-0.00645116,0.529389,-0.145583,-0.267335,-0.61497,0.249368,0.203387,-0.34541,0.95074,0.726984,0.0255904,-0.46493,0.107751,-0.773136,-0.0312944,0.459992,0.0738497,0.596037,0.377131,0.483849,0.469971,-0.584543,0.81707,0.371215,-0.156271,-0.850239,0.0186244,0.016918,0.222464,0.855991,-0.664748,-1.29104,0.0566245,-0.397416,-0.430145,0.815918,0.617193,-0.459661,0.278378,-0.443992,0.638186,0.0519991,0.898322,0.560148,0.0631723,-0.394873,0.0766014,-0.037781,0.145792,-0.839051,0.265068,-1.05747,0.376559,-0.814801,-1.14455,0.469412,-0.164834,-0.0840485,0.195937,-0.0567854,-0.194006,0.218122,-0.106496,-0.187291,-0.0791525,-0.48216,0.659627,0.334577,-0.59466,-0.287567,-0.436017,-0.618095,-0.0116376,-0.34139,0.199735,-0.142892,0.160532,0.31136,0.236253,-0.209377,0.236289,0.294037,-0.236071,0.0987677,-0.639365,0.330778,-0.38459,-0.67304,-0.339767,-0.661338,-0.597347,-0.116875,-0.413468,0.16857,0.7634,0.0163344,0.360003,-0.618888,0.582786,-0.472833,0.180332,0.543431,-0.408269,-0.15073,-0.640234,-0.534691,0.026916,-0.858598,-0.174694,-0.202873,0.0752127,-0.201043,0.375132,-0.00831505,0.0727239,0.477468,0.414668,-0.596167,-0.206672,-0.207143,0.0934483,-0.511688,0.175883,0.0721339,0.286602,0.511878,0.245545,0.241133,0.212316,0.111239,0.854435,-0.475655,-0.0609729,-0.353372,0.0212574,-0.360534,-0.371708,-0.0167362,-0.492366,0.83366,-0.373512,0.367629,0.194947,0.245412,-0.165996,0.139113,-0.191235,0.935151,0.741967,-0.316212,0.630534,-0.359,0.364419,-0.453954,-0.320754,-0.469146,0.590428,-1.16344,-0.21524,-0.185738,-0.0550973,-0.792305,0.249828,0.159263,-0.0533262,-0.195598,-0.83278,-0.0200409,-0.0926317,-0.568585,0.570191,-0.0247987,0.148263,0.0770851,-0.131386,1.3554,-0.362212,0.552312,-0.260668,-0.0415829,0.42163,0.467965,-0.59697,-0.25057,-0.452572,0.003383,-0.21154,-0.586971,-0.50334,-0.181107,0.19963,0.351474,-0.331301,0.780961,-0.149868,-0.651289,0.365071,-0.461777,-0.128079,-0.198985,-1.15352,0.0492569,-0.151505,0.746222,-1.00763,0.313488,0.607028,0.425323,0.126443,0.636469,0.134672,-0.282295,0.426134,0.517082,0.70004,0.499795,0.130229,-0.391177,0.66875,-0.379178,0.259081,-0.366588,-0.0651881,0.204541,-0.496442,-0.272443,-0.23412,-0.0764647,-0.124667,0.459497,0.00547378,0.151292,0.33473,-0.138966,0.103155,-0.220058,-0.569122,-0.14712,-0.385398,-0.562792,-0.938137,0.0962903,-0.199895,0.387712,0.0814313,-0.306549,0.269765,0.208808,0.00315904,0.560381,-0.805571,-0.0704455,0.270943,0.021725,-0.512162,0.235182,-0.0812944,-0.0200783,-0.137088,-0.528839,-0.258808,0.130884,0.788866,-0.702137,-0.385229,-0.237803,-0.457385,-0.626787,-0.113582,0.213614,0.409854,0.462184,0.640198,-2.25213 +3404.1,0.797694,0.0848144,4,1.53075,0.668901,-1.78654,0.773436,0.836558,-0.130915,0.183769,-0.049692,0.271342,0.279176,0.135942,-0.17767,-0.363162,0.575982,-0.111192,0.604743,0.214105,0.0879732,-0.156331,-0.293746,0.148823,-0.996441,-0.762592,0.317479,-0.0961147,0.129061,0.295365,-0.025606,-0.227296,0.224044,0.453493,-1.08789,-0.12398,0.33011,-0.372773,0.11688,0.0695527,0.612238,0.702243,-0.540926,0.959801,0.289858,0.738709,-0.354032,-0.364719,0.368307,-0.618096,0.0701745,0.147013,-0.358651,0.293259,0.216457,0.253406,-0.190167,0.871471,-0.443802,0.0590749,-0.768281,0.117481,-0.365116,0.523179,0.470054,-0.471699,-0.138955,0.170689,0.350275,-0.112138,-0.246568,-0.0257569,-0.197307,-0.22088,0.789592,0.0684545,-0.357644,0.532388,0.314233,0.486471,-0.141814,-0.466631,-0.199593,0.414608,-0.587263,0.0764353,0.281594,-0.315223,-0.658961,0.402909,-0.575704,0.128926,0.121629,-0.282762,0.283959,0.162825,-0.124908,0.255911,-0.0686357,0.280828,-0.00734505,-0.018204,0.149077,0.634214,0.00562978,-0.111257,0.0367065,0.545701,-0.524714,0.339524,-0.300696,0.440574,-0.0841931,-0.160157,-0.285625,0.0260965,0.0644952,-0.0790416,-0.121402,-0.260893,0.537905,0.530545,0.100455,-0.645291,0.28906,-0.7009,-0.343924,-0.301488,0.253899,0.37701,0.170703,0.418141,0.00662039,-0.379844,-0.0174253,-0.239394,0.637938,-0.169375,0.0791518,-0.183969,0.362948,0.490043,-0.359767,-0.580011,0.0929315,-0.0669393,-0.658121,-0.183002,-0.531392,-0.500802,0.14006,0.0504736,0.596881,0.542051,0.299608,0.315514,0.123359,0.711593,0.776173,0.591725,0.0606535,-0.152194,-0.140369,-0.0619353,-0.253784,1.20921,1.06523,0.184393,-0.306612,0.114883,0.441161,-0.750606,0.868384,0.268586,-0.0926257,-0.531494,-0.821962,-0.427706,-0.0396826,-0.204492,-0.597261,0.64882,1.1064,-0.0443076,-0.0046669,-0.0829583,0.112835,-0.766902,-0.380354,-0.71448,0.239034,0.262321,-0.164227,-0.165588,-0.123151,0.152998,-0.178813,-0.204407,-0.0273121,0.353373,-0.413035,-0.263402,-0.188203,-0.0658382,-0.244344,0.29109,-0.336628,-0.725342,-0.0840033,-0.687358,1.30311,-0.172171,0.372041,0.225276,-0.171161,-0.0210527,-0.220552,0.0726607,0.242599,-0.415522,0.00547254,0.77026,0.156411,0.557807,0.18699,-0.299853,-0.0416063,-0.44741,0.229816,-0.662931,-0.867386,-0.338215,0.352137,0.359423,-0.460006,0.258605,-0.659215,-0.260319,0.88644,0.258111,-0.574627,1.09477,-0.667889,-0.283294,-0.322872,-0.213374,-0.0986721,0.902093,0.0195233,0.607399,0.136173,-0.381177,-0.781954,-0.581522,-0.670696,0.52276,-0.382026,-0.634566,0.423851,-0.337127,0.331973,0.517857,0.234479,-0.608068,0.464332,-0.270782,-0.423297,0.282315,0.0699867,0.679889,0.0885138,0.247052,-0.0577663,-0.00627771,0.0508192,0.242038,0.558515,0.244274,-0.221978,0.122666,0.201528,0.247108,-0.143641,-0.0530109,-0.717812,-0.00401421,0.184015,0.195254,0.470043,-0.385186,0.280627,0.233898,-0.552386,-0.493841,1.02491,0.484883,0.689907,-0.0207059,0.119389,-0.0969107,0.239363,0.224865,-0.178404,0.00102438,0.183854,0.172899,0.428782,0.415811,-2.19112 +3409.94,0.913646,0.0848144,5,1.50868,0.673037,-1.71902,0.773418,1.02786,-0.209776,0.0531028,0.0587719,0.205167,0.152986,0.255345,-0.331145,-0.454034,0.402332,-0.0617449,0.646698,0.181701,-0.0228308,0.0155715,-0.376469,0.154396,-1.19379,-0.443014,0.468236,-0.312205,0.338346,0.0536142,-0.0893923,-0.471411,0.176241,0.73377,-0.825483,-0.0243982,0.306552,-0.229743,-0.0428538,0.0567839,0.461278,0.503196,-0.197082,0.886612,0.429254,0.319372,-0.69309,-0.248929,0.64104,-0.54374,0.318927,0.420415,-0.124545,0.427202,0.434533,-0.0460339,0.4782,0.918571,-0.506004,0.00362442,-0.649455,0.259469,-0.412072,0.308245,0.701217,-0.459669,-0.297306,0.119131,0.416992,0.038495,-0.351447,-0.0059766,-0.150347,-0.127481,0.544174,0.146629,-0.0800654,0.637154,0.292508,0.799772,-0.186723,-0.499299,-0.435506,0.612752,-0.515923,0.115606,0.0765608,-0.2496,-0.524513,0.340756,-0.24297,0.0875592,-0.000712455,-0.34679,0.56862,0.311095,-0.266335,-0.136235,-0.0114988,0.296288,0.0455769,0.0908542,0.183175,0.802758,-0.188945,-0.0467885,-0.19231,0.796238,-0.339733,0.561069,-0.129978,0.921846,-0.0745793,-0.245143,-0.0196719,0.248445,-0.142088,-0.362415,-0.296765,-0.315381,0.68561,0.479808,0.209983,-0.575012,0.306991,-0.826172,-0.324851,-0.449267,0.1399,0.594645,0.508297,0.55432,-0.0335863,0.350919,-0.0725681,-0.150068,0.713385,-0.261171,0.261727,-0.426378,0.570371,0.330603,-0.562103,-0.774835,0.160938,-0.103068,-0.567651,-0.0351357,-0.371204,-0.464543,0.0430034,0.0830329,0.27002,0.442189,0.0301083,0.31698,0.292598,0.600458,0.628632,0.622148,-0.163987,0.0809037,-0.307049,-0.0191471,-0.0921632,1.14541,1.14502,-0.0495903,0.0620489,0.087517,0.355907,-0.639768,0.7253,0.371853,0.39311,-0.516757,-0.736105,-0.421103,0.0511649,-0.0281739,-0.45918,0.388641,0.949233,-0.183315,-0.302397,0.267606,0.238286,-0.423157,-0.630588,-0.6155,0.0460481,0.0670747,-0.34367,0.0883396,0.00853074,0.00340428,-0.344538,-0.190437,0.16432,0.158329,-0.354643,-0.449576,0.108676,-0.068793,-0.190498,0.100957,-0.158312,-0.54378,-0.189885,-0.576522,1.14943,0.306287,0.107999,0.233017,-0.190268,0.193829,-0.140435,-0.0487968,0.400502,-0.757578,0.0332841,0.662725,0.177896,0.329108,-0.091794,-0.21137,0.0813581,-0.131877,0.667362,-0.425189,-0.732797,-0.172995,0.0296494,0.244071,-0.481456,0.171122,-0.63061,-0.108672,0.650043,0.190584,-0.596307,0.850865,-0.705614,-0.39727,-0.447705,-0.0660975,-0.246116,0.562281,0.049964,0.77489,0.0815685,-0.37612,-0.656806,-0.505876,-0.735318,0.422455,-0.183807,-0.784792,0.196038,-0.279879,0.331021,0.471656,0.173608,-0.467736,0.541934,-0.280245,-0.126167,0.164643,0.105447,0.324202,0.170991,0.50039,-0.0621017,-0.0682821,0.12254,-0.145668,0.634309,0.154568,-0.017755,0.252762,0.0254814,-0.00687531,-0.105512,-0.421253,-0.475465,0.112897,-0.143352,-0.0100958,0.647689,-0.0941428,0.181709,0.508318,-0.707937,-0.476607,0.935439,0.390447,0.392598,-0.22989,-0.0117379,0.0520876,0.462797,0.13386,-0.302166,-0.0816073,0.180051,0.255258,0.424324,0.50523,-2.87132 +3398.51,0.833271,0.0848144,4,1.50812,0.830283,-1.16477,0.485167,0.813391,0.0916144,-0.260104,0.0429859,-0.088769,-0.329975,-0.33299,-0.113485,-0.0538938,0.35622,-0.726462,0.568437,-0.0379475,-0.511056,0.509337,-0.00197662,0.223141,-0.5363,-1.02661,0.202314,-0.0617751,-0.116272,-0.196016,0.538788,-0.108121,0.557393,0.706949,-1.12239,-0.23856,0.549995,-0.216655,0.00946186,-0.580844,0.425471,0.372783,0.243268,0.913523,0.278667,0.583392,-0.348206,0.210239,-0.213926,-0.385114,-0.357187,0.176968,0.1919,0.305791,0.607013,0.106166,-0.850465,0.860764,-0.0299363,0.077799,-0.831657,0.405686,-0.79664,0.350135,0.747552,-0.329083,-0.680441,0.256814,0.536444,0.227789,0.813471,0.481566,-0.573296,-0.248631,0.0354358,0.597111,0.476875,0.338208,0.540186,0.541029,-0.767684,0.0282343,0.317266,0.832375,-0.375501,0.241829,-0.228347,-0.2274,0.785627,0.00618285,-0.379716,-0.424754,-0.222073,0.185615,-0.225034,-0.21403,0.45229,0.285626,-0.41813,0.613271,-0.634628,0.288239,0.262528,-0.291519,-0.180948,-0.34751,-0.602277,0.195679,-0.256436,0.758764,-0.0409542,-0.40086,0.676842,-0.311284,-0.106193,-0.514865,0.175778,-0.51781,-0.329222,-0.547025,0.045663,0.801878,0.0266596,-0.496004,0.0863609,-0.0168283,-0.310811,0.177434,0.219449,0.0321148,-0.111804,0.585993,0.135876,0.268096,-0.0396045,0.779081,0.445265,0.00681478,0.342015,0.190682,0.0201412,0.0822857,-0.171736,-0.770986,0.00225547,-0.10691,-0.439053,0.317813,-0.87747,-0.432816,0.112052,-0.00923866,-0.134665,-0.18955,-0.114102,0.235676,-0.6258,0.158199,0.59591,0.490481,0.080083,0.0284117,0.0936953,0.484614,0.0110303,0.573381,-0.0496144,-0.0291668,0.327876,-0.262519,-0.0512556,-0.00823287,0.399737,0.410512,0.546315,-0.274253,0.197521,0.336302,0.370169,0.200788,0.384689,0.149816,0.954052,-0.121643,0.00872267,-0.00190229,-0.207779,-0.0327543,-0.0977755,-0.407326,-0.0897032,-0.310477,-0.19045,-0.331238,0.245957,0.392168,-0.274513,0.58154,0.069638,-0.00412857,-0.213502,-0.480056,-0.434233,0.170737,-0.0152522,-0.0762029,-0.153558,0.335203,-0.0306919,-0.517036,1.15792,-0.216556,0.121393,-0.0918376,0.0210483,-0.479476,0.643035,0.187714,0.695278,-0.35448,0.149189,0.0688372,-0.440619,0.0829968,-1.06655,0.660788,0.490644,-0.336272,0.460441,-0.243971,-0.543207,-0.203188,0.277734,0.287446,-0.138396,0.137832,-0.0717152,-0.209984,0.815566,0.723245,-0.0422635,1.03622,0.302683,0.148016,0.133944,0.159623,-0.0985558,0.472406,-0.050342,0.38953,0.62379,-0.575945,-0.21738,-0.482113,-0.79521,0.600502,0.399404,-0.454068,0.325814,-0.561003,0.0335995,-0.265198,-0.00373964,0.286365,-0.31333,0.0304699,0.746943,0.153345,-0.313865,-0.150933,0.350756,-0.658829,0.0514074,-0.231891,-0.274293,0.648759,0.0742703,0.0999784,-0.285873,0.0702986,0.388461,0.303693,0.0447452,0.380681,-0.654655,-0.397491,0.75035,0.361619,0.27912,-0.649035,0.621531,-0.0633675,0.0911557,-0.266232,-0.427121,0.0303003,0.346431,-0.0780685,-0.915027,-0.051794,0.0106369,0.184567,0.0378499,-0.220088,0.152173,0.180637,0.390094,0.425014,-2.53109 +3370.46,0.712162,0.0848144,5,1.55324,0.794129,-1.47274,0.514102,0.987207,-0.0434854,-0.389374,-0.072408,-0.673045,-0.173052,0.234582,-0.157857,-0.515744,0.203532,-0.17439,0.787196,-0.34186,-0.193602,0.309605,-0.291154,-0.195036,-0.537998,-0.419442,0.15189,-0.0646773,0.749233,0.0232312,0.240865,-0.169272,0.400444,0.561308,-1.1229,-0.40047,0.3142,-0.307155,-0.263424,-0.0582416,-0.141409,-0.0148315,-0.0503601,0.984241,0.439201,0.450292,-0.0525608,-0.0028657,0.31542,-0.71806,-0.225917,0.324076,0.338633,-0.0270746,0.279213,0.0107063,-1.05796,0.823636,-0.0428272,0.189884,-1.1014,0.304394,-0.435211,0.184083,0.636542,-0.309851,-0.798419,0.621905,0.407538,0.117078,0.591934,0.572993,0.051724,-0.251729,0.511822,0.209893,-0.0295407,0.362222,0.651192,0.698767,-0.432651,-0.231292,-0.225091,0.552711,-1.00824,0.215818,0.092796,-0.0987876,-0.0295382,-1.1831,-0.947938,0.136585,-0.231109,0.498969,-0.0924797,-0.368731,0.531349,0.566048,-0.281894,1.28695,-0.752785,-0.245974,0.321023,0.18333,0.324828,-0.491366,-0.434514,0.272952,-0.0572058,-0.0783837,-0.384977,0.275132,0.54042,0.476579,-0.732338,-0.731511,0.215532,-0.751701,0.0616303,0.152554,0.663692,0.418294,-0.469074,-0.188611,-0.030384,-0.239649,-0.156077,0.354873,-0.11015,0.308941,0.266365,0.446601,0.249183,0.524022,0.0633684,0.583942,0.521703,0.302446,0.333374,-0.169334,0.235068,0.150642,-0.541904,-0.801806,0.276968,-0.148551,-0.337614,-0.121922,-0.499003,0.170364,0.186981,0.315846,0.088836,0.233456,0.593395,0.614368,-0.373405,0.595714,0.454382,0.620927,-0.145307,0.0784785,-0.130187,0.298452,-0.601226,1.0215,-0.219231,0.400973,0.555002,-0.200075,-0.347911,-0.330958,0.279656,0.84223,0.699589,-0.379195,0.376341,0.108518,0.104973,-0.0689525,0.421598,0.180341,0.891213,0.122299,0.0682091,0.0128206,-0.321947,-0.12746,-0.445099,-0.318402,-0.246647,-0.27444,-0.41574,-0.0715151,-0.00338422,0.264514,-0.552004,0.708588,-0.0808865,-0.00917614,-0.0248336,-0.860343,-0.289036,0.0478306,0.16303,-0.0894895,0.421312,0.244428,-0.409838,-0.704719,1.13357,0.176372,0.343988,0.0475606,-0.198649,0.313139,0.147731,0.960695,0.468754,-0.0960725,0.415574,0.180862,-0.295239,0.229603,-0.460432,-0.161373,-0.015662,-0.424203,0.725353,-0.212799,-0.38396,-0.33685,0.407017,-0.0690555,-0.0225484,0.0244991,-0.415268,0.249575,0.430796,0.807906,0.0951163,0.836718,0.00324455,-0.0710117,0.288124,0.359564,-0.0829221,0.452805,-0.119516,0.550763,0.0187064,-0.180575,-0.208674,-0.95881,-0.140945,0.581181,-0.158102,-0.349819,0.0826382,-0.664999,-0.288305,-0.60035,0.101864,0.0673543,0.158941,-0.410847,-0.292922,0.264905,-0.0753267,-0.0360567,0.173429,-1.13826,-0.470537,-0.506468,-0.317132,-0.354739,0.477483,0.195318,-0.224142,0.224019,0.0346923,0.61966,-0.551945,0.166723,-0.209077,0.373381,0.288829,-0.0294115,-0.0388702,-0.020608,0.295961,-0.157613,-0.442582,-0.301235,0.0018807,0.0159013,0.253419,-0.0123085,-1.26758,-0.288024,0.566195,0.301807,0.049269,-0.257244,0.188548,0.241338,0.434221,0.491262,-2.83094 +3427.96,0.693886,0.0848144,4,1.60693,0.816956,-1.16773,0.523918,0.882417,0.124189,0.0291761,0.127665,0.388952,0.155916,-0.0710508,0.0295673,-0.202422,0.304052,-0.233786,0.578093,-0.0204319,-0.176275,-0.207025,0.216572,0.0796714,-0.548754,-0.349175,0.308312,-0.83505,-0.418392,-0.319539,0.676105,-0.0609713,0.13152,0.687386,-0.574559,0.0405357,0.837558,-0.336069,-0.29728,-0.466412,0.272095,0.455747,-0.304536,0.724562,0.652219,0.440966,-0.620793,-0.35225,-0.190085,-0.420293,-0.099756,0.206585,0.262288,-0.138868,0.493208,-0.155455,0.0384642,0.871066,-0.311214,-0.308856,-1.12445,0.591962,-0.891853,0.138194,0.860552,-0.817738,-0.442216,0.18072,0.451803,-0.0107024,0.306438,-0.0845088,-0.34083,-0.196684,0.330629,0.940329,-0.390104,0.874267,0.740842,0.540524,0.0839362,-0.244252,-0.196279,0.367577,-0.256712,0.292614,-0.0996813,0.157744,-0.00436389,0.301535,-0.699046,0.0808462,0.0346321,0.26111,0.409475,-0.323707,0.149149,0.0397011,-0.960808,0.644993,0.0468359,-0.0911323,0.366108,-0.579867,0.326774,-0.185349,-0.509156,0.330038,-0.149698,-0.444121,-0.485327,0.298877,0.696913,-0.0800206,0.0295953,-0.0100743,-0.0919525,0.00465605,-0.0249617,0.328211,-0.308408,-0.0535997,0.133454,-0.627176,-0.508796,-0.28579,-0.242896,0.0556977,0.365265,0.275942,0.190844,0.673748,-0.688571,0.691241,-0.257604,0.159509,0.510488,-0.0437129,-0.0348188,-0.286764,-0.260551,0.667666,-0.560299,-0.576889,-0.140733,-0.223416,-0.395668,-0.0829697,-0.0774964,-0.19049,0.266745,-0.466981,-0.0194386,-0.130024,0.108483,0.422586,0.072526,0.0401231,0.374523,0.62005,-0.342629,-0.0518937,0.320863,0.473194,0.377858,0.842211,-0.00900775,-0.0637297,0.263221,-0.0520788,-0.456694,-0.120087,-0.0712412,0.275102,-0.189552,-0.360082,-0.16711,-0.50209,0.279437,-0.480472,0.266992,0.424606,0.757139,0.359439,-0.157307,-0.263177,-0.0658405,0.103582,0.0142811,-0.134821,-0.449948,-0.17363,-0.842191,0.136306,-0.190803,0.246953,-0.741587,0.44483,0.427222,-0.0560887,-0.270512,-0.665566,0.254796,-0.0362595,-0.606817,0.131097,0.199638,0.309808,0.112875,-0.512332,1.23326,-0.0699799,0.288683,-0.31244,-0.15883,0.107289,0.119736,-0.0556337,0.656452,-0.286206,-0.0187041,0.145124,-0.692411,-0.520438,-0.38965,0.134051,-0.769924,0.170002,0.0826068,-0.454338,-0.630972,0.563529,0.147608,-0.472797,-0.485646,-0.34421,-0.199623,-0.437162,0.289061,-0.227137,0.482967,0.655288,-0.526738,0.42816,-0.331707,0.265878,0.114114,0.821688,-0.465372,0.141106,0.375845,0.38646,-0.520335,-0.197941,-0.685371,0.311217,-0.301932,0.154379,-0.148385,-0.101253,0.279053,-0.176798,-0.308829,0.568577,0.178127,-0.14741,-0.441134,0.22686,0.0759876,0.232807,-0.472478,-0.300592,-0.47786,-0.397032,-0.629524,0.287952,0.244784,0.450865,-0.183828,-0.163922,-0.190903,-0.139075,-0.166786,0.0772342,0.033334,-0.142832,0.520916,0.21125,-0.250745,-0.29673,-0.0712778,0.153592,-0.296019,-0.583395,0.156081,0.0642865,0.50926,0.0727653,0.198308,-0.0637467,-0.282163,0.22468,-0.177034,-0.468285,0.146758,0.173953,0.38309,0.417076,-2.68121 +3431.93,0.885118,0.0848144,4,1.55961,0.776251,-1.24261,0.511148,0.625678,-0.262209,-0.150965,-0.184511,0.145336,0.162275,0.388821,-0.116729,0.139347,0.407502,-0.0399864,0.843743,0.0915606,-0.0312099,0.0433795,-0.121662,-0.263081,-0.541104,-1.04802,0.176077,-0.0083928,-0.244671,0.339872,0.458497,-0.621817,0.624197,1.14932,-0.588573,0.462514,0.471588,-0.281607,-0.502457,-0.167121,0.411755,0.412843,-0.189278,0.93429,0.231526,0.401549,-0.684515,0.148869,0.414773,-0.189452,-0.0805737,0.44627,0.17213,0.0730863,0.585754,-0.146161,-0.399081,0.898134,-0.152286,-0.123557,-1.04536,0.30682,-0.644001,-0.108812,0.711742,-0.616858,-1.33248,0.265014,0.175883,-0.294192,-0.135251,0.309255,-0.428784,0.00407554,-0.123551,0.261934,0.228176,0.326304,0.0750796,0.0658822,0.02624,-0.0785562,0.340499,0.154196,-0.052688,-0.0200853,-0.265209,0.511715,0.467794,-0.403951,0.193102,-0.263186,-0.708858,0.257938,-0.577311,0.00118566,-0.172664,0.157759,0.0177751,0.0108624,-0.258126,-0.08715,0.270613,0.660554,-0.23707,-1.0427,-0.379961,-0.812632,-0.652426,0.964427,-0.0631094,-0.222433,0.14864,-0.0508696,-0.0170615,0.131821,-0.129143,-0.04042,0.110803,-0.698275,0.444024,0.707665,0.0385754,-0.707659,0.176441,0.0630101,-0.426617,-0.155432,0.105177,-0.193045,-0.178702,-0.567041,-0.291601,-0.47134,0.368531,0.0485266,0.213366,-0.127104,0.038698,0.130542,-0.0299385,0.253645,-0.312873,-0.280625,0.0204253,0.737125,-0.239243,-0.213194,-0.0242424,0.203674,0.133489,0.0660474,0.046645,-0.408224,-0.228439,-0.0226954,-0.124138,0.260318,0.413273,-0.480863,0.349286,0.0983941,-0.670665,-0.672893,-0.679271,0.299172,0.0389581,-0.289558,0.288611,-0.163257,-0.0229758,-0.135207,-0.14906,0.166274,-0.0165608,-0.580922,0.334524,0.266724,-0.0817806,-0.129755,0.128509,0.171487,0.988516,0.207508,-0.274097,0.234333,0.290381,0.0342569,-0.603088,-0.306374,-0.12379,0.309105,-0.467497,-0.135286,0.189907,0.058841,-0.61598,0.205858,0.115087,0.137891,0.0733824,-0.567734,0.162354,-0.115517,0.0428494,0.735692,-0.466608,-0.591174,0.207459,-0.561957,0.544016,0.0764394,0.129154,0.0354736,0.0167458,0.519047,0.331596,-0.0574936,-0.170817,0.0774218,0.117448,0.530524,0.0438279,0.0494948,-0.590373,-0.0858213,0.0439953,-0.502741,0.29416,-0.362012,-0.0671561,-0.298962,0.388925,0.26931,-0.280985,-0.333543,-0.00472526,0.30171,0.446046,0.282051,-0.250015,0.709935,-0.144312,-0.432752,0.129754,0.0220307,0.145127,0.00467397,0.564232,0.507746,-0.0737271,-0.39619,-0.122574,-0.0587514,-0.282123,0.436657,0.119344,0.142568,0.429883,-0.245044,-0.21599,-0.0846413,0.368913,0.27211,0.840058,-0.250963,0.129894,0.114202,-0.227306,-0.200688,0.148039,0.046717,0.141264,0.289053,0.279152,-0.314449,-0.0390859,-0.409275,0.041899,0.354741,-0.0756017,0.105435,-0.222878,-0.319232,0.146354,-0.459108,-0.443689,-0.270269,0.252381,-0.259333,-0.0827831,-0.297152,-0.302406,-0.194248,-0.0495214,0.0224721,0.261291,-0.442332,-0.184117,-0.132983,0.251517,-0.257416,0.187938,0.356839,0.111071,0.30539,0.333273,0.552621,-1.6562 +3427.28,0.990901,0.0848144,5,1.56573,0.764812,-1.45428,0.613733,0.756985,-0.192715,-0.0734807,0.0450292,0.236431,0.478362,0.270842,0.00856837,-0.0312219,0.364113,-0.0280894,0.532016,0.124853,-0.00356149,-0.184404,-0.134544,-0.161585,-0.447746,-0.946627,0.451315,-0.204425,-0.528711,0.532902,0.1813,-0.655244,0.388608,0.915465,-0.781102,0.227161,0.381955,-0.14756,-0.429227,0.0874461,0.19957,0.854134,-0.0847471,0.724019,0.446856,0.0822129,-0.291269,-0.080171,0.395671,-0.0457554,-0.0258702,0.295167,0.0363996,0.148633,0.439457,-0.0651478,-0.42126,0.706076,-0.0971989,-0.218901,-0.870987,0.230946,-0.755155,-0.338283,0.611912,-0.530953,-1.17327,0.0501077,0.358319,-0.114524,-0.0745573,0.0767893,-0.288699,0.037888,0.00300674,0.382491,0.339211,0.33135,-0.0103913,0.292731,-0.284927,-0.486556,0.17042,0.323162,-0.0749654,0.128194,-0.195544,0.311577,-0.0192343,-0.592189,0.244282,-0.437426,-0.565797,0.498658,-0.28306,0.00213145,0.225929,0.0345895,-0.140306,-0.252469,-0.192764,-0.260154,0.196937,0.488855,0.0343139,-1.06119,-0.430131,-1.07845,-0.536029,0.823946,-0.208256,0.0803408,0.404729,0.0170671,0.0429848,0.252856,-0.0279259,0.158754,0.311179,-0.843351,0.355457,0.243034,0.0489233,-0.893729,-0.0598699,0.195938,-0.545707,-0.0560457,0.664456,-0.348016,-0.120632,-0.152573,-0.230153,-0.329014,0.0419006,0.197261,0.518036,0.185959,0.0907773,-0.154747,0.159723,0.2278,0.164924,-0.361019,-0.0969388,0.246156,-0.379213,-0.275925,0.0498892,-0.0309569,0.202656,-0.263976,-0.265924,-0.246406,0.0210434,0.15176,0.187036,0.225592,0.498911,-0.323309,0.20081,0.127486,-0.490879,-0.875428,-0.430975,0.609997,-0.0921456,-0.604912,-0.143656,0.0173943,-0.28633,0.125072,0.08416,0.3837,0.0380148,-0.516695,0.0981835,0.00137629,0.0760746,-0.0421482,0.0786997,0.125252,1.01722,-0.222241,-0.58613,0.364172,0.0914009,0.334243,-0.563497,-0.410409,-0.316258,0.0480846,-0.493285,-0.162895,-0.217096,-0.041957,-0.81464,0.00696325,-0.377224,0.161396,0.0188267,-0.0840881,0.0916505,-0.00233324,0.161907,0.335609,-0.551385,-0.253621,0.301541,-0.837451,0.537645,-0.0810034,0.211963,0.0168753,-0.296339,0.536789,0.526734,0.0609591,-0.597299,-0.121055,0.145461,0.521165,0.311243,-0.0357108,-0.50221,-0.231115,0.234,-0.884613,0.107941,-0.0269681,0.0389356,0.147689,0.430634,-0.0129416,-0.348389,-0.100773,0.0896501,0.385167,0.385201,0.278919,-0.464658,0.652506,-0.298048,-0.0512736,0.379267,0.216735,-0.0382098,-0.366398,0.323468,0.59852,0.0910042,-0.736613,-0.131024,-0.0388166,-0.42836,0.272162,-0.235223,0.148912,0.508487,-0.206917,-0.0771586,-0.367864,0.179532,0.212798,0.0735256,0.0667812,-0.0232812,-0.188467,-0.189585,-0.241751,0.0264071,-0.262969,0.242252,0.0152277,0.240449,-0.152581,0.0186674,-0.51857,0.339751,0.213558,0.255643,0.170024,0.14609,-0.0745605,0.303273,-0.889073,-0.179943,0.307988,0.224766,-0.106826,-0.105848,-0.176345,-0.195412,-0.295436,0.243647,-0.152869,0.269574,-0.344821,-0.249628,0.464611,0.123112,-0.157739,0.186871,0.0503401,0.120257,0.290238,0.346782,0.538738,-2.0692 +3419.23,0.99954,0.0848144,4,1.54949,0.767104,-0.743589,0.266189,0.528215,-0.0797703,-0.651849,-0.106495,0.129143,0.0811531,0.114709,-0.00588742,0.209097,0.578465,-0.757391,0.817336,0.44451,-0.00871652,-0.249337,-0.204132,-0.0155499,-0.423268,-1.18254,0.328184,-0.157614,-0.0703618,0.409639,0.651565,-0.368475,0.437015,0.981462,-0.421935,-0.452511,0.034217,-0.319822,-0.670975,-0.626496,0.658072,0.656575,-0.530938,0.837858,0.582208,0.25323,-0.424833,-0.0941779,0.283227,-0.268414,-0.438448,0.352272,-0.38137,-0.0156934,-0.307063,0.0711792,-0.694337,1.27581,0.430037,-0.0574318,-0.826349,0.612159,-0.411865,0.436459,0.821941,-0.48443,-0.93389,-0.0728077,0.182214,0.137195,0.460046,0.0469984,-0.0736221,-0.369944,-0.171945,0.503496,-0.1135,0.433696,0.303268,0.310373,-0.318713,0.259855,0.255278,0.0208946,-0.565027,0.459875,0.0580014,0.164556,-0.0392879,-0.0600129,0.18008,-0.312937,-0.373522,0.137687,0.839499,0.568284,0.25633,0.310461,-0.614292,0.145058,-0.746678,0.455744,0.192013,0.298427,0.201755,-0.327082,-0.248913,0.283924,-0.69852,0.435184,-0.0926171,1.10819,0.391428,0.609823,-0.19921,-0.149344,0.199228,-0.314925,0.14592,-0.516959,-0.0758516,0.353739,0.11264,-0.577674,-0.162485,0.0154783,-0.131918,0.218722,0.507008,-0.211786,-0.401134,0.296569,-0.520997,-0.609414,-0.0834204,-0.0443205,0.475337,-0.175945,0.227028,-0.0603854,-0.0284934,0.666833,-1.23429,-0.0912547,0.0802713,-0.152056,-0.128106,-0.875499,-0.230037,0.115008,0.151793,-0.558553,-0.236003,-0.175008,-0.00537072,0.465238,0.434011,0.138263,0.638356,0.0974818,0.112967,0.258644,-0.31156,-0.187445,-0.259509,0.944334,-0.387074,-0.0978636,0.0304012,0.0270789,0.664461,-0.198858,-0.075749,0.377749,0.172138,-0.233598,-0.0415888,0.295684,0.0137983,-0.289912,0.448831,0.0187987,0.59059,-0.0452297,0.68575,0.466818,0.8933,0.113958,-0.237641,-0.158825,-0.30019,0.304687,-0.314922,-0.183631,0.0599816,-0.0346272,-0.339873,0.082295,-0.0913501,0.249023,-0.293288,-0.479948,0.437206,-0.0899993,0.317392,0.481568,-0.465502,0.767616,-0.0969031,-0.604066,0.982024,-0.427114,0.0594227,0.3001,-0.218292,0.429298,0.432691,-0.480431,0.240033,-0.540873,0.487333,0.407666,-0.384584,-0.263123,-0.647416,0.0290615,-0.069941,0.017702,0.451548,0.0233444,-0.908085,0.389047,-0.123936,-0.110995,-0.284957,-0.634009,-0.663682,-0.230513,0.464792,0.523617,0.528479,0.786061,-0.1246,-0.0650223,0.440335,0.822963,-0.147689,0.274604,-0.138197,0.437716,0.134727,-0.578593,-0.272966,0.0662836,-0.329474,0.364721,0.0626019,0.254831,0.0977992,-0.324063,-0.244817,0.0796013,0.0133409,0.320895,-0.0326502,0.178176,-0.422742,-0.086871,-0.149939,0.170355,-0.246934,0.541609,0.319093,-0.509383,-0.00887803,0.0935797,0.245967,0.0825674,0.493743,0.491915,-0.23897,0.437374,-0.264986,0.269125,-0.346462,-0.251171,-0.40902,0.0949088,0.569976,-0.00772262,0.219443,-0.123273,-0.177579,-0.209925,-0.518412,0.0503479,-0.254214,0.152461,-0.340655,0.174012,0.0437638,0.356477,-0.339512,0.0959859,0.131609,0.239014,0.36278,0.488891,-1.40208 +3406.31,0.554083,0.0848144,5,1.56498,0.851437,-0.691996,0.256406,0.579517,-0.0570498,-0.417547,-0.0115497,0.394572,-0.0767222,-0.0108263,-0.240963,0.407035,0.384229,-0.461616,0.651968,0.0359614,-0.0941175,0.148593,-0.150487,-0.0996284,-0.054254,-1.56814,0.492956,-0.488547,-0.00411809,0.598726,0.109144,-0.299502,0.263015,0.78112,0.132722,-0.320044,0.0158382,0.0526131,-0.349312,0.0394432,-0.0509961,0.328363,-0.33698,0.710355,0.823839,-0.0104697,-0.411393,-0.0308547,-0.00207889,-0.890598,-0.277754,0.620931,-0.776494,0.285094,-0.690396,0.291088,-0.149023,0.835164,-0.178126,-0.272289,-1.04289,0.27051,-0.643712,-0.223402,0.819816,-0.621434,-0.920835,0.157502,0.32785,0.020724,0.0254298,0.394606,-0.167678,-0.3174,0.795964,0.53147,0.671354,0.380666,0.191385,0.657743,-0.113399,-0.0667734,-0.0233471,0.185045,-0.90209,0.177345,0.514699,0.127687,-0.324358,-0.475666,-0.077348,-0.273796,-0.525117,0.0434973,0.00504319,0.570236,-0.0691015,0.100183,-0.391286,0.712088,-0.138901,0.182007,0.280215,-0.122857,-0.0123031,-0.298791,0.141262,0.227925,-0.432231,0.293081,-0.381863,0.861764,0.692629,-0.619667,-0.214511,-0.483535,0.250428,-0.0971653,0.703294,-0.0925202,0.641048,-0.284101,0.439514,-0.889137,-0.331719,0.334906,-0.0544569,0.109143,0.368831,0.164283,0.435716,0.420524,-0.784768,-0.246333,0.118653,-0.0639868,0.726964,-0.23864,-0.595025,0.150056,0.0886296,0.260766,-0.503152,-0.204331,-0.164353,0.464737,-0.224797,-0.197846,0.352921,0.0939077,0.491148,0.208542,-0.848134,-0.177247,0.54585,0.438652,0.319921,0.706631,0.485235,-0.167005,0.0276131,0.00167961,-0.836955,-0.420165,-0.15303,0.736484,-0.113908,0.352183,0.153943,-0.322933,0.560954,-0.311394,0.187163,-0.0889201,-0.0241243,-0.191323,-0.100422,-0.018434,0.0213134,-0.41266,0.203566,0.273354,0.355644,0.270321,0.621215,0.0422875,0.440909,-0.0883489,0.0874018,-0.386942,-0.210141,0.300041,-0.771531,-0.0614419,0.21061,0.324502,-0.191309,0.493758,-0.388235,0.149005,-0.142843,-0.285913,-0.289738,-0.262623,0.0188721,0.58006,-0.629724,0.650308,0.0637763,-0.341757,0.903426,-0.24864,0.529984,0.205892,-0.174838,0.486843,0.0298228,-0.345345,0.449677,-0.152642,0.195301,-0.163806,-0.408037,-0.420525,-0.204479,-0.433365,0.104993,-0.449703,0.420725,0.202195,-0.500179,-0.238069,0.102155,-0.383958,-0.0813592,-0.157683,-0.32743,-0.271581,0.417288,0.522445,0.361986,0.388817,-0.388338,0.166908,0.421642,0.646881,-0.105171,0.4496,0.323182,0.508853,0.116385,-0.0701667,-0.411885,0.1841,-0.468457,0.384378,-0.556752,-0.147696,0.992095,-0.655533,-0.109707,0.188132,-0.334197,0.411694,-0.0292125,0.0160931,-0.0880319,0.128892,0.103076,-0.11282,0.204484,0.375684,0.572536,-0.177444,0.287534,-0.00924863,0.0474191,-0.330399,0.150966,0.456409,-0.204809,-0.289588,-0.0195947,-0.380944,0.0212581,-0.312064,-0.31902,-0.413705,0.354119,0.176824,-0.00285309,-0.345865,-0.54926,-0.125463,-0.24564,-0.18936,0.332515,0.169785,-0.220611,0.167146,0.399873,0.473872,-0.319188,-0.779643,0.154414,0.268467,0.392955,0.518138,-1.72951 +3421.35,0.984243,0.0848144,4,1.48434,1.04952,-0.489974,0.0836897,-0.0826331,-0.0887455,0.0245106,0.359932,0.0650989,0.309349,0.0909014,0.0695624,-0.145175,0.55029,-0.151525,0.744375,0.195925,0.436912,-0.0320924,-0.0487117,-0.469776,-1.22007,-0.148274,0.252289,-0.427868,-0.800132,0.444833,0.720006,-0.148786,0.0990912,0.683696,-0.507662,0.0332703,-0.0699191,-0.798047,-0.0794774,-0.638523,0.596509,0.312101,-0.227264,0.7515,0.731344,0.417359,-0.657278,-0.391257,-0.144237,-0.599933,0.211184,0.589231,-0.0461709,0.203976,0.264801,-0.00466787,-0.556012,0.873626,-0.232933,-0.633425,-0.446866,0.353261,0.215102,-0.265916,0.94701,-0.4981,-0.678665,-0.0972206,0.579586,-0.390332,-0.244215,0.22167,-0.431389,0.10302,-0.309968,0.644391,-0.00135271,0.850365,0.59823,-0.399872,0.213783,-0.207115,0.200661,0.334845,-0.210951,-0.151391,-0.197724,-0.0110457,-0.469722,0.251423,-0.645874,0.0900036,-0.0872173,-0.365194,0.639214,0.118498,0.129025,0.223013,-0.735092,0.108166,-0.304911,0.0187249,0.571154,-0.217089,0.280136,-0.328696,-0.175931,0.184696,-0.711701,0.083368,-0.310515,0.554014,0.390642,0.515668,0.297697,0.275971,0.343482,0.529319,0.319477,-0.327863,-0.17225,0.260933,-0.0215451,-0.706988,0.122319,-0.0215447,-0.367866,0.102011,0.296376,0.319517,-0.115418,0.0674033,-0.424643,0.083455,0.0215505,0.529827,0.663764,-0.0546494,-0.00976201,-0.0105188,0.348527,0.341647,-0.423404,-0.367246,-0.209983,0.608816,0.547311,0.0540317,-0.137022,0.237122,0.294425,-0.458079,0.306015,-0.155087,0.162189,0.23623,-0.136059,0.131024,-0.0714793,-0.0611513,-0.365837,0.152519,-0.0402631,0.363906,0.262398,0.657645,0.0842163,0.0568211,0.229078,0.0171508,-0.233559,-0.559775,-0.147563,0.211303,-0.0556745,-0.128515,-0.234937,-0.584384,0.418354,0.238498,-0.711624,0.892604,0.959409,0.208386,-0.347239,0.542441,0.303893,0.39762,0.380677,0.352147,-0.425965,0.179448,-0.30735,0.185058,-0.00849707,0.357156,-0.463649,-0.336615,0.448196,0.264828,-0.211502,-0.590674,0.10118,-0.303693,-0.0915118,0.200688,-0.0310853,-0.551157,-0.274558,-0.619296,0.982515,0.527954,0.475255,0.354937,0.339838,0.152123,0.256645,-0.466099,0.19455,0.0894451,0.386625,0.312864,-0.491021,0.189602,-0.0265164,-0.209451,0.473148,0.0244658,0.0598289,-0.157484,-0.493324,-0.0602047,-0.193497,-0.235036,-0.0474963,0.0715314,0.533783,-0.291109,0.740501,-0.164774,0.428171,0.523724,-0.770597,-0.250744,0.0990171,0.285913,0.00101791,-0.0218187,0.480409,0.307601,0.299583,-0.371556,-0.371051,0.316643,-0.570631,0.138918,-0.196976,-0.47062,-0.403695,-0.00321757,-0.259051,-0.744593,0.162996,0.253193,0.858005,-0.278508,0.376229,0.151901,-0.0119917,0.10502,-0.332855,0.176233,0.0659272,0.381885,-0.433081,-0.928613,-0.0130274,0.487957,-0.556835,-0.215111,-0.254157,0.721503,-0.038343,0.248824,-0.050668,-0.0149238,0.479391,0.0641418,0.535896,-0.449283,0.99467,0.332288,-0.0106512,-0.2095,0.524504,0.804391,-0.121357,-0.416252,-0.831955,0.137985,-0.289594,-0.449621,-0.390245,0.230629,0.149503,0.209218,0.386656,0.457404,0.103416 +3405.55,0.996046,0.0848144,4,1.61589,1.07569,-0.504923,0.0424666,0.0619005,-0.139908,0.208945,-0.133526,0.610907,0.0740597,0.168936,-0.400123,0.345237,0.394535,-0.0628934,0.483581,0.294632,-0.625875,0.0236706,0.0915576,-0.623835,-0.836481,-1.04798,-0.109158,-0.0780043,0.108173,0.287956,0.501663,-0.137277,-0.122788,0.883809,-0.0589603,-0.182642,-0.288562,-0.448004,0.0992049,-0.0507597,0.503119,-0.0790672,-0.370623,0.896645,0.577059,0.114245,-0.999467,0.153224,0.276902,-0.475768,0.46533,0.494386,0.0338954,-0.224978,-0.012064,0.380174,0.00776624,0.799444,0.13824,-0.047839,-0.749533,0.43214,-0.218568,0.505539,0.840024,-0.544373,-0.703413,0.286852,-0.0751211,0.289567,-0.159023,0.0792207,-0.841353,0.00616829,0.769614,0.754775,-0.401864,0.962554,0.0604146,0.706003,-0.330057,-0.350784,0.00985359,0.609335,-0.577169,0.227135,0.101788,0.154361,0.188278,-0.415049,0.149029,-0.0823148,-0.84074,0.164944,-0.739882,0.264606,0.285473,0.140512,0.0784773,-0.0293141,-0.622915,0.309551,0.105038,0.335859,-0.320299,-0.0313547,-0.220402,0.288576,-0.0615188,0.372638,-0.206919,-0.169711,0.541542,-0.218717,-0.59207,0.151789,0.216205,-0.147353,-0.021543,-0.362773,0.479482,-0.0147333,-0.191276,-0.640823,-0.0347827,0.411599,0.257449,0.223136,0.330477,0.311167,0.267636,-0.0922676,-0.352822,-0.0215281,0.112327,-0.44918,0.951803,-0.43287,-0.60812,-0.175921,-0.627283,0.461914,-0.608787,-0.136125,-0.0834871,-0.156094,-0.943615,-0.309078,-0.379306,-0.486979,0.155233,-0.0831914,-0.16126,0.127949,0.434312,0.279028,0.0953848,-0.0475754,0.807727,0.605352,0.0665257,0.121178,-0.09531,0.233888,0.0326085,0.666784,-0.471519,-0.148917,-0.145128,-0.151426,-0.126492,0.177971,0.273513,0.0548231,-0.0612689,-0.184859,-0.0865104,0.678631,-0.287142,-0.652254,0.328321,0.285139,0.722961,-0.370602,-0.248807,0.190099,-0.16786,-0.99421,-0.988716,-0.804622,-0.644918,0.313233,-0.306523,-0.00364949,0.110272,0.379112,-0.707004,0.122484,-0.212789,-0.256158,-0.251532,-0.486702,-0.335682,-0.00171296,-0.453771,0.328923,-0.197259,0.225705,0.142539,-0.268604,0.653139,-0.067057,-0.199411,0.0254772,-0.356219,0.399331,0.159215,0.169451,0.412176,-0.48161,0.00208418,0.356841,-0.168053,0.0426201,-0.812516,0.200002,0.193282,-0.687143,0.672157,-0.707243,-0.0154484,-0.0224229,0.0960405,-0.387175,0.0509998,-0.62442,-0.205575,0.0690588,0.323075,-0.152509,-0.500749,0.840464,-0.474642,-0.691225,0.0101771,-0.439867,0.214186,0.761264,-0.22633,0.00676582,0.0507586,-0.127007,-0.138199,-0.175285,0.0390465,0.31589,-0.56015,-0.00981438,0.473483,-0.456052,0.346693,1.14034,-0.321755,0.138514,0.0176001,-0.3479,-0.71899,0.232889,0.0112935,-0.401998,0.163792,0.159678,0.263671,-0.348327,0.204804,0.481243,0.146342,-0.482384,0.778764,0.497627,0.138994,-0.574752,0.523065,-0.393087,-0.089714,-0.512482,-0.385513,-0.229282,-0.138984,0.205676,-0.433329,-0.247279,-0.595557,-0.202075,-0.34923,-0.0621306,0.585633,0.386015,-0.164368,-0.367882,0.401348,-0.140219,-0.519645,-0.367831,0.172038,0.241934,0.414774,0.491867,-0.23138 +3418.17,0.994754,0.0848144,4,1.42442,1.01404,-0.778033,0.184252,0.345261,-0.108048,0.181012,0.578987,0.0581442,0.449817,-0.0936393,0.0456788,0.0991705,0.706875,0.311881,0.766892,0.243168,-0.0601441,-0.135489,0.191681,-0.0595455,-0.681278,-0.28157,0.345193,-0.392573,-0.655703,0.205457,0.402366,-0.292683,0.0362303,0.643167,-0.208157,0.395674,0.372866,0.0661671,-0.0598186,-0.222396,0.69682,0.879002,-0.463027,0.840845,0.648886,0.589287,-0.480673,-0.0166274,0.127441,-0.300152,0.0561123,0.530612,0.19762,0.064045,0.500189,0.409601,-0.356898,0.978454,-0.127278,-0.128543,-0.551355,0.186483,0.00561232,0.506226,0.915434,-0.351348,-0.492491,-0.176601,0.393134,-0.139746,0.361243,0.389619,-0.311317,-0.317769,-0.586623,0.185663,-0.217338,0.989003,0.411533,0.0212534,0.298707,-0.269393,-0.0817249,0.141878,-0.295013,-0.254742,0.540351,-0.111789,-0.687421,0.247976,-0.0745401,0.23325,-0.0922426,-0.559397,0.451778,0.0257222,-0.208712,-0.149692,-1.15328,-0.337826,-0.23163,0.296036,0.530278,0.00464463,0.0622513,-0.144723,-0.0460858,-0.0179095,-0.35551,0.0954258,-0.0842919,0.379675,0.688173,0.10172,0.216711,0.0596853,0.173837,0.171878,0.175376,0.334553,0.247259,0.453682,-0.300315,-0.72558,0.0925331,-0.289218,0.196455,-0.0269041,0.221541,0.367552,0.395554,0.0768579,-0.368656,-0.0673364,-0.263384,0.13005,0.612264,-0.331569,0.459959,-0.00378449,-0.0405866,0.203934,-0.420217,-0.783731,-0.312059,0.0499518,-0.560018,0.350074,0.608947,0.427497,0.591989,-0.437304,-0.480195,-0.393699,0.0660596,-0.0398553,0.204685,0.285417,0.293574,-0.0762127,0.426961,0.362603,-0.111989,-0.00463797,0.0193004,0.614947,0.87669,-0.567646,0.66775,-0.0944623,-0.603706,-0.00541273,0.483219,0.0528791,0.053591,-0.208768,-0.184293,-0.654066,0.146073,0.641046,-0.801893,-0.0359784,0.938186,0.344353,0.0736412,0.81464,0.156475,0.345537,0.43083,-0.362727,-0.162481,0.235564,-0.66427,-0.13646,-0.326929,-0.0922755,-0.803727,0.220547,0.289341,-0.0766812,-0.444415,-0.524317,0.150264,-0.483954,-0.355961,0.488965,0.253963,-0.24761,-0.200722,-0.192788,0.937261,0.24058,0.619372,-0.182702,-0.303946,-0.0930559,-0.02478,-0.811415,0.368707,-0.0961697,0.458445,0.474399,-0.569996,0.367007,-0.052512,-0.451714,0.622836,-0.613586,0.16844,-0.130103,0.105393,0.312537,-0.65333,-0.230506,-0.189136,0.359406,-0.142852,-0.312141,1.08368,0.273441,-0.704917,0.315059,-0.66276,-0.223736,0.264025,0.235963,-0.529983,0.137331,0.723926,0.332814,0.296485,-0.712172,-0.473125,-0.273155,-0.172407,-0.0215298,0.280707,0.0509166,0.012325,-0.365686,-0.72235,-0.080963,0.0289868,0.319491,0.817801,0.270167,0.296447,0.133398,0.435077,0.0896795,-0.088598,-0.730042,-0.229929,-0.175622,-0.54877,-1.01294,-0.145651,0.16071,-0.0741899,0.0784066,-0.18223,1.16803,0.154584,0.382811,-0.0106037,-0.028688,-0.326866,0.520839,0.0627597,0.00389638,0.796372,0.367244,-0.0564734,-0.0472498,0.175293,0.347434,0.419272,0.149589,-0.541279,0.178464,-0.376814,-0.276268,-0.32439,0.379886,0.173608,0.184253,0.416663,0.429247,-1.25347 +3402.11,0.692742,0.0848144,5,1.47489,1.04917,-0.373542,0.113536,0.550925,-0.103295,0.0721778,0.285131,0.443605,-0.176894,0.148419,-0.302325,0.683782,0.177932,0.215527,1.0416,0.343095,-0.354249,-0.133271,0.0341823,-0.359754,-0.373796,-0.4914,0.173867,-0.24573,-0.0278969,0.171641,0.030253,-0.280857,0.13145,0.517707,0.395834,-0.0384764,0.383274,0.212945,-0.16349,0.270343,0.744463,0.162858,-0.343954,0.957344,0.699013,0.0777845,-0.427846,-0.111249,-0.373927,-0.268739,-0.288821,-0.000266316,0.172181,-0.0221064,0.16279,0.199168,0.449598,0.762836,-0.66955,0.0483885,-0.622656,0.0386914,-0.564607,0.154454,0.945395,-0.914143,-0.924237,-0.444128,0.11303,-0.653768,0.269533,0.128262,-0.615808,-0.222504,0.410197,0.670554,-0.150656,0.264059,0.0405214,0.412657,0.71375,-0.254711,-0.127005,0.401686,-0.872851,0.208742,0.0766907,0.479137,0.201759,0.307984,-0.213101,0.168436,-0.0994038,-0.709897,0.101214,-0.166042,-0.317232,0.377313,-0.515372,-0.0787844,-0.778014,-0.325671,0.0695727,-0.89429,0.271261,-0.287132,0.0630576,0.595662,-1.15405,0.496281,0.0906308,-0.194426,0.491602,-0.490892,-0.322308,-0.275467,0.519543,0.446431,0.130709,-0.312919,0.276599,0.0231122,-0.493303,-0.510365,0.0544828,0.19015,-0.148274,0.365847,0.542321,0.827519,0.505261,0.190769,-0.104124,-0.202712,0.0557501,-0.708344,-0.0131499,0.000297287,0.314118,-0.141807,-0.52998,0.612661,-0.0119505,-0.763109,-0.0107543,-0.0275358,-0.182266,0.202548,0.653621,0.0281564,0.291131,0.462664,0.421701,0.20549,-0.0305426,-0.245908,0.210402,-0.651703,0.476744,-0.0925103,0.35598,-0.181359,-0.220973,0.0197711,-0.418765,0.614292,0.84778,-0.304952,0.561073,0.23558,-0.265626,-0.143445,-0.226741,-0.0318653,0.0112825,0.00142986,-0.697969,0.296543,0.429281,0.0244653,0.11344,-0.0686896,0.570475,0.0709309,0.717635,0.197942,-0.0142976,0.141819,-0.254338,0.235451,-0.380082,-0.130774,0.262623,-0.179351,0.117112,0.355707,-0.847871,0.195842,0.38699,0.0537438,-0.640068,-0.618624,0.483035,0.266766,0.349995,0.573853,0.0216009,0.235562,-0.530101,-0.0760661,1.25647,0.163229,0.0770321,0.0137479,-0.358061,0.237692,0.358074,-0.084569,0.445852,0.385822,0.0831606,0.445725,-0.849986,0.00213259,-0.437168,-0.277055,0.235422,-0.351947,0.824698,-0.591042,0.315708,0.319872,-0.397292,0.0238558,0.128208,0.0244941,-0.141551,0.335829,0.78942,-0.032992,-0.0119444,0.586479,-0.644856,-0.0432668,0.484261,0.22866,-0.691152,0.881598,0.338196,0.40953,0.26477,-0.49665,-0.182877,-0.398701,-0.682307,0.391778,0.211115,-0.0602295,0.15964,-0.232687,-0.688835,0.410031,-0.183416,0.156393,0.35476,0.0439154,-0.28554,0.362686,-0.104104,-0.0310628,-0.70484,-0.035795,0.059538,-0.664653,-0.372402,-0.503052,0.104393,-0.147552,-0.125527,0.171239,-0.498352,0.077276,-0.0447931,0.00509783,-0.340992,-0.0827125,0.459404,0.311715,0.0936642,-0.2782,-0.146452,0.126232,-0.603313,0.124964,0.23877,0.0084839,-0.122715,-0.206937,-0.508034,-0.0698401,0.161776,-0.420753,0.143457,0.309304,0.14435,0.177689,0.379935,0.421531,-2.09453 +3417.04,0.974245,0.0848144,4,1.60749,0.990856,-0.335207,0.0344278,0.423699,0.0389465,-0.355343,0.090861,-0.0219024,0.0984491,-0.436028,0.226526,-0.11,0.312728,0.210604,1.20015,-0.00249377,-0.123949,0.117897,0.279261,-0.621828,-0.924909,-0.308223,-0.0029291,-0.0609856,-0.127927,-0.102161,0.675201,-0.540896,-0.0682505,0.61987,0.0743654,-0.123041,0.273361,0.363254,-0.489955,-0.401909,0.497021,0.685407,-0.226354,1.00214,0.293876,0.464733,-0.415811,-0.247699,-0.0899547,-0.708767,-0.212542,0.27369,0.144698,-0.168035,0.174148,0.188122,0.0240622,0.83425,-0.134407,-0.226635,-0.811604,0.249993,-0.432138,0.0191479,0.703386,-0.3727,-1.06839,-0.112166,0.336942,0.117607,0.262821,-0.272363,0.00416049,0.155242,0.198894,0.534315,-0.364884,0.612065,0.342458,0.724062,0.193932,-0.382382,0.366605,0.531145,-0.284309,-0.0509645,-0.0520782,0.106296,-0.376715,-0.02392,0.526376,0.165699,-0.223326,-0.60568,0.432054,-0.0103225,-0.919351,0.4524,-0.692077,-0.76867,-1.04676,0.0872454,0.127035,-0.595669,0.279095,-0.0344971,0.233887,-0.292618,-0.0899495,0.465442,-0.315802,0.465105,0.822367,-0.604195,-0.140638,-0.351584,0.444444,-0.203198,0.335256,-0.326411,0.252159,0.119615,-0.897634,-0.426766,0.731737,-0.420201,-0.84048,0.244053,0.81314,0.724042,0.252159,0.200042,-0.627203,-0.216222,-0.0491423,0.0117682,-0.120516,-0.129996,0.059459,-0.260438,-0.541466,0.651307,-0.606557,-0.50303,0.0765396,0.133227,-0.467507,0.141496,0.672495,0.514281,0.339486,0.037454,-0.357188,-0.0159345,-0.194438,-0.0207348,0.529362,-0.026416,-0.146395,0.36472,-0.221691,0.0728655,0.0805962,0.436495,-0.0384111,0.614308,0.448691,-0.678603,0.638225,0.319932,0.0550399,0.0953528,-0.143651,-0.286166,0.0155537,-0.0204842,-0.0814007,-0.251747,0.144977,0.139272,-0.0679572,0.822503,0.778089,-0.0408731,-0.0309778,0.730386,-0.393436,-0.0811335,-0.439758,-0.45907,0.433127,0.101288,-0.331487,0.120733,-0.274568,-0.0315116,-0.510778,0.270255,0.174777,-0.0941789,0.0380688,-0.575032,0.0722984,-0.137222,0.0521652,-0.108936,0.0735071,0.440788,0.111008,-0.432971,0.909869,-0.216206,0.175211,-0.0961375,-0.316367,-0.0367741,0.211899,-0.493358,0.212998,-0.236476,0.15579,0.169908,-0.290994,0.073267,-0.594223,0.446739,0.176771,0.121065,0.389155,-0.365396,0.256693,0.0594656,-0.413138,-0.0208344,0.0599372,-0.164597,-0.360711,0.0120721,0.95932,0.203641,-0.297271,0.621559,-0.385189,-0.745356,0.13465,0.615547,0.189711,0.273155,0.00428833,0.697467,0.143125,-0.0947256,-0.411689,-0.542672,-0.555385,0.10448,-0.19468,-0.23923,-0.124815,0.294654,-0.0485029,0.140129,-0.012604,0.542307,0.717012,0.0287277,0.497481,0.728775,0.222373,0.0417856,-1.10002,0.810695,0.239121,-0.876573,0.161041,-0.611702,-0.368157,0.0655269,0.065296,-0.01076,0.107296,-0.111103,0.0752537,0.0413639,-0.304777,0.45342,0.104378,0.402636,-0.211948,0.008144,-0.0366698,0.332242,-0.752341,-0.103368,0.151381,0.0107972,-0.375095,0.175817,-0.0380205,-0.0889474,-0.284442,-0.462595,0.0927582,0.42423,0.179934,0.209575,0.424186,0.457793,-1.41715 +3404.77,0.998488,0.0848144,4,1.53209,1.06067,-0.363222,0.0787325,0.588047,0.00699972,-0.23026,0.100909,0.123761,0.119692,-0.467934,0.0426172,-0.110208,0.355477,0.148786,1.04754,-0.00803212,-0.420299,-0.00118402,0.252269,-0.678322,-1.12541,-0.309476,0.00760873,-0.0074962,-0.248206,-0.0971435,0.556795,-0.453573,-0.0507841,0.647236,-0.0607225,0.0768518,0.292261,0.0321882,-0.568692,-0.462125,0.445815,0.347156,0.0863102,1.05504,0.565544,0.506258,-0.54605,-0.0394984,0.144093,-0.836808,0.0770797,0.250913,0.0977131,0.172802,-0.0437254,0.216226,-0.0672943,0.731044,-0.182795,-0.332307,-1.20243,0.173498,-0.623401,0.148414,0.783278,-0.510144,-0.896725,-0.281972,0.0336322,0.284793,0.324155,-0.415111,-0.339811,0.274006,0.366871,0.556796,-0.517512,0.499257,0.557697,0.733305,0.217352,-0.238428,0.472408,0.804294,-0.415517,-0.0327624,-0.0610464,0.107488,-0.374116,0.0939615,0.751841,0.100152,-0.321835,-0.259527,0.399669,0.0222718,-0.823686,0.286623,-0.59076,-0.611369,-0.725023,0.184842,0.242775,-0.386699,0.0385872,-0.230355,0.373845,-0.15444,0.11914,0.293866,-0.159038,0.371306,0.923821,-0.248851,-0.14798,-0.377436,0.564689,-0.429864,0.519917,-0.408089,0.121712,0.287511,-0.253639,-0.409669,0.880235,-0.190298,-0.645791,0.0266932,0.864318,0.774151,0.353851,0.236677,-0.495953,0.127819,-0.23386,0.0771449,0.100031,-0.302979,0.249877,-0.588692,-0.54844,0.563802,-0.618963,-0.640706,0.237193,0.121312,-0.410492,0.25188,0.461353,0.548165,0.296733,0.0690189,-0.321821,-0.243213,-0.0477621,0.169435,0.47008,-0.175395,0.0428136,0.389144,-0.231165,0.166974,-0.0317108,0.435159,-0.0771577,0.600909,0.906607,-0.622517,0.799411,0.302182,-0.141606,0.0859693,-0.270877,-0.436622,0.0971192,-0.101432,-0.0638639,-0.440925,0.262589,0.248061,-0.152449,0.49107,0.704761,0.105945,-0.179706,1.00601,-0.424919,0.0157144,-0.304514,-0.408934,0.172487,-0.07483,-0.394447,0.207801,-0.279983,-0.0697747,-0.236602,0.326221,0.535327,-0.213001,-0.00938751,-0.752573,0.323485,-0.00635605,-0.132317,-0.00553377,0.458447,0.110908,-0.0258547,-0.0851216,0.96524,-0.360129,0.208267,-0.174306,-0.365778,0.0122816,0.408185,-0.291415,0.299334,-0.418347,0.025828,0.268658,-0.489418,0.0343408,-0.61834,0.461559,0.0612291,0.366859,0.558336,0.0385094,0.130124,0.0670964,-0.139853,-0.336501,0.161768,-0.0592606,-0.454119,-0.0481682,0.776932,-0.228739,-0.154941,0.80888,-0.425603,-0.970804,0.258786,0.554791,0.364931,0.331198,0.072804,0.671651,0.063207,-0.361201,-0.390303,-0.750262,-0.637093,0.385987,-0.332892,-0.045252,-0.318855,0.074308,-0.361345,0.202799,0.137203,0.564128,0.561476,0.309181,0.466213,0.626419,0.353808,0.103153,-0.854327,0.722404,0.253653,-0.641649,0.421589,-0.774663,-0.439005,0.0531042,0.0568253,0.00806357,-0.180885,0.0348899,-0.297605,0.0452023,-0.20709,0.655897,0.164059,0.262772,-0.157571,0.198611,-0.133994,0.460923,-0.727092,0.0052832,0.107914,-0.157824,-0.414499,0.209911,0.116961,-0.133599,-0.238649,-0.656132,-0.0162648,0.671098,0.172206,0.175182,0.414977,0.418547,-2.18088 +3426.91,0.992569,0.0848144,5,1.50179,1.04328,-0.494323,0.0988402,0.93086,-0.122824,0.475195,-0.198841,0.161327,0.562723,0.145736,-0.298599,0.329891,0.308775,0.171869,0.998418,-0.153856,-0.0429841,0.129604,-0.0692418,-0.450578,-0.637497,-0.798021,0.197724,-0.479706,0.535344,0.0991674,0.194883,-0.504216,0.198334,0.580273,-0.219838,0.0621939,0.249677,0.22407,-0.213983,-0.056739,0.302044,0.735434,-0.212696,1.00003,0.340104,0.093766,-0.323034,-0.374062,0.22725,-0.241966,-0.409086,0.461556,-0.151765,-0.302176,0.581022,-0.0302579,-0.378775,0.908714,-0.161737,0.1496,-0.269599,0.508553,-0.121846,0.243002,0.926303,-0.410665,-0.697882,0.246519,0.317174,0.424357,0.311223,0.110642,-0.852273,-0.258428,-0.0937471,0.397697,-0.0242969,0.709734,0.473775,0.320056,-0.0728704,-0.670942,0.266441,0.513832,-0.496561,0.211824,-0.385785,-0.202619,0.524706,0.0511523,-0.206079,0.455764,-0.291403,0.0717097,-0.018762,0.0627208,0.125162,-0.392877,-0.829739,0.181694,-0.142076,-0.414478,0.168918,0.334633,-0.544448,0.0187925,-0.107136,0.445178,-0.533424,0.235584,-0.224748,0.322889,0.241781,-0.208095,0.00477147,-0.283496,0.345587,0.0717061,-0.127022,-0.336472,0.218511,0.274552,0.0419267,-0.447676,-0.160768,0.0293781,0.147252,0.104542,0.236817,0.39968,0.116703,0.161773,-0.496944,0.136562,-0.0763303,-0.514032,0.406329,0.119419,0.164968,0.435542,-0.719716,0.461747,-0.140116,-0.28452,-0.455044,0.319103,-0.178193,-0.0156738,-0.0323111,-0.104156,0.500684,-0.163485,-0.693809,0.098895,0.209906,-0.212462,0.451369,0.498314,0.880723,-0.434442,0.258136,-0.299796,-0.224052,-0.118794,-0.00166946,1.17438,-0.612977,0.537494,0.0453863,-0.160599,0.12021,-0.280777,0.0483844,0.163442,0.307523,0.0975847,0.0641802,0.255107,-0.0896761,-0.271775,-0.271274,0.0570183,0.882741,-0.343561,-0.198834,-0.456342,0.376677,0.202567,0.170565,-0.095484,-0.842148,0.612272,-0.190424,-0.509471,-0.445013,-0.109728,-0.285083,0.358464,0.124856,0.111806,-0.00372857,-0.408639,0.0651573,-0.223956,-0.0246834,-0.0346037,-0.109725,0.512692,-0.300335,-0.837525,1.0323,0.442317,0.460317,0.171474,-0.288294,0.153738,0.119201,0.123764,0.440787,-0.311348,0.254138,0.263038,-0.162828,-0.172923,-0.0141906,-0.609184,0.436772,-0.198655,0.38799,-0.189603,0.10321,-0.308932,0.556785,0.115169,0.00910627,0.198672,0.126697,-0.44569,0.442476,0.0966341,-0.0528044,0.518659,-0.073943,0.0240653,-0.115354,-0.264964,-0.357091,0.917136,0.251222,0.112367,0.148635,-0.0516516,-0.293755,-0.15704,-0.599374,0.342952,0.336618,-0.841674,0.207079,-0.181984,-0.00858732,0.0736278,-0.1505,0.285556,-0.17799,0.245315,0.380295,0.304873,-0.180609,0.0686655,0.184652,0.0337674,-0.15184,-0.389034,-0.0511018,0.678891,0.342718,0.0777247,-0.325235,-0.027755,0.426983,0.504223,0.194641,0.147193,-0.620932,-0.666829,-0.899665,0.0823635,0.210537,-0.104075,1.08461,0.10126,-0.0875406,0.110433,0.0875584,0.0893508,0.886009,-0.502618,-1.07268,-0.0547356,-0.361182,0.0821507,0.341855,-0.681418,0.144644,0.219799,0.380321,0.468827,-3.23624 +3435.16,0.980953,0.0848144,4,1.49741,1.04793,-0.509062,0.114275,0.956015,-0.127777,0.46197,-0.260309,0.171341,0.599412,0.203622,-0.29342,0.381934,0.315882,0.104103,0.96697,-0.212358,-0.0395737,0.14753,-0.052223,-0.457132,-0.584395,-0.754254,0.169261,-0.424473,0.359153,0.114999,0.209409,-0.494146,0.123521,0.525271,-0.0967654,0.151298,0.325692,0.30274,-0.217662,-0.095352,0.309296,0.69431,-0.243821,1.02202,0.313041,0.114755,-0.286434,-0.379957,0.222964,-0.260255,-0.336673,0.447086,-0.0608248,-0.251716,0.527264,-0.0554139,-0.37719,0.890315,-0.212326,0.160713,-0.315901,0.506678,-0.104085,0.226043,0.885186,-0.471432,-0.71532,0.222907,0.310726,0.403808,0.411059,0.141085,-0.923947,-0.20646,-0.0886175,0.399526,-0.0617754,0.713313,0.413307,0.350821,-0.0782593,-0.54186,0.239161,0.5191,-0.51979,0.186273,-0.314658,-0.13673,0.515298,-0.0602682,-0.154556,0.421087,-0.235289,0.132283,0.0532127,0.0381998,0.132829,-0.340998,-0.742126,0.142094,-0.0754524,-0.317878,0.159374,0.301225,-0.529431,-0.104496,-0.0984006,0.449061,-0.512545,0.222472,-0.220918,0.326462,0.319414,-0.127576,0.0577277,-0.342349,0.382353,0.0813722,-0.121984,-0.341011,0.221498,0.272222,0.0249114,-0.404116,-0.155079,-0.0232854,0.161813,0.0668967,0.201211,0.475256,0.171047,0.149199,-0.580066,0.144419,-0.0999455,-0.460236,0.396219,0.0631659,0.223048,0.361196,-0.729316,0.481476,-0.220534,-0.27457,-0.432646,0.213409,-0.259651,0.0244186,-0.0329103,-0.0574057,0.534926,-0.172087,-0.667922,0.122882,0.182103,-0.15871,0.388063,0.366727,0.850457,-0.497776,0.216043,-0.247443,-0.246253,-0.175684,-0.0247196,1.22137,-0.51828,0.461241,0.145477,-0.178306,0.0561001,-0.206689,0.116915,0.184201,0.349291,0.055413,0.0085179,0.285143,-0.0874814,-0.223917,-0.297774,0.0708667,0.78795,-0.285855,-0.236017,-0.335371,0.298177,0.28269,0.239221,0.00962546,-0.869772,0.641529,-0.0995149,-0.509802,-0.41529,-0.0628868,-0.258048,0.246641,0.11301,0.0679512,-0.0332237,-0.425048,0.0891924,-0.177705,-0.0607509,-0.0590293,0.00771409,0.48042,-0.354847,-0.940888,1.07766,0.558711,0.457242,0.122351,-0.226592,0.191341,0.0903343,0.121491,0.332411,-0.381065,0.234356,0.278982,-0.167452,-0.161697,-0.0418527,-0.564664,0.354406,-0.217016,0.442092,-0.162928,0.0936174,-0.311845,0.599298,0.144978,0.0317828,0.117349,0.0505532,-0.42569,0.477888,0.128801,-0.0543054,0.486683,-0.0139987,-0.0469355,-0.079747,-0.271027,-0.333278,0.86068,0.23444,0.0797482,0.112516,-0.0456001,-0.288203,-0.130193,-0.648835,0.326758,0.311181,-0.852627,0.203323,-0.194805,0.0171133,0.0995664,-0.159616,0.299943,-0.153335,0.24246,0.379497,0.278648,-0.197418,0.0911279,0.13763,0.0811034,-0.180964,-0.310892,0.0530552,0.745735,0.270388,0.0941135,-0.410139,-0.0441682,0.370746,0.45023,0.230917,0.115684,-0.621939,-0.640589,-0.845968,0.0546912,0.212202,-0.0564269,1.08936,0.0784032,-0.0899962,0.106884,0.0861557,0.0670219,0.818101,-0.51598,-1.22924,-0.00815913,-0.318971,0.040006,0.29131,-0.760331,0.139724,0.231204,0.373797,0.480837,-3.338 +3432.67,0.80809,0.0848144,4,1.51773,1.09234,-0.446219,0.0542744,0.799964,-0.105681,-0.219796,-0.126674,0.159354,0.307879,0.253313,-0.105025,-0.223064,0.175892,-0.19179,0.818895,-0.0596993,-0.356119,0.334492,-0.0461376,-0.415103,-0.531279,-0.956179,-0.0327637,-0.329591,0.327713,-0.097381,0.294872,-0.331429,0.138575,0.37723,-0.202483,0.141568,-0.00933756,0.366028,-0.0394577,-0.117882,0.583628,0.761038,-0.329924,1.13613,0.521164,0.44073,-0.206963,-0.453991,0.192881,-0.19072,0.359173,0.364428,-0.114179,0.0441419,0.391694,-0.304974,-0.455976,0.832474,-0.194573,-0.178887,-0.763524,0.692812,-0.380491,0.179325,1.13707,-0.299963,-1.13272,0.0503693,0.33367,0.0867528,0.0556134,0.280584,-0.639938,-0.433613,0.154503,0.336517,0.200944,0.313461,0.518726,0.431057,-0.319779,-0.210376,0.0677825,-0.00995718,-0.285807,0.0450351,-0.148368,-0.627858,0.431884,0.258195,0.123212,0.0478657,-0.362909,-0.0702979,-0.073343,0.63472,-0.132447,-0.0017845,-0.224796,0.13426,-0.0945325,-0.0599869,0.38624,-0.187666,0.0382552,-0.139282,-0.107742,0.73901,-0.407815,0.171482,-0.189013,0.456796,0.597205,0.070509,0.394718,0.289327,0.335148,-0.0911092,-0.450164,-0.208845,-0.165758,-0.244768,0.0963497,-0.284297,0.0561066,-0.598276,-0.221527,0.59553,0.326185,0.216493,0.112246,-0.0319293,-0.525248,-0.253381,0.0542877,-0.323879,0.786983,0.0514978,0.33801,-0.20072,-0.435849,0.557078,-0.573412,-0.46438,-0.192583,0.790049,-0.182896,0.377392,0.289196,0.157995,0.626876,0.111281,-0.231931,0.307968,0.0126948,-0.300986,0.324523,0.450033,0.0149958,-0.0138257,0.304421,-0.133347,-0.369472,-0.319898,-0.133236,1.45703,-0.545511,-0.0482439,0.274362,0.188663,0.29308,-0.627066,-0.0764162,0.505728,0.7172,0.130497,-0.380801,-0.181648,-0.0701108,-0.252899,0.117502,-0.091331,0.506321,-0.169355,-0.433064,-0.610029,-0.395678,0.43855,-0.16449,-0.104697,-1.29493,0.112879,0.171087,-0.125477,-0.456142,0.0732812,-0.487264,0.298129,0.210323,0.0744569,-0.207952,-0.494419,-0.255654,-0.077262,-0.165917,-0.110568,0.231745,0.38101,0.0423681,-0.800348,1.10385,0.150884,0.848424,0.189659,-0.541435,0.161453,0.024278,-0.0372722,0.831999,-0.301532,-0.037699,0.243714,0.223871,0.0364611,0.154706,-0.365472,0.496297,-0.102462,0.329158,-0.366707,-0.00727128,-0.0725098,0.20687,0.201094,-0.0078686,-0.628875,-0.24569,0.0299546,0.726409,0.427344,-0.286958,0.388217,-0.015822,0.0233671,0.318015,-0.161151,0.0479648,0.830705,0.229578,0.222469,0.327229,0.610275,-0.45475,0.477318,-0.327473,0.458143,0.0454183,-0.408975,-0.169831,-0.70057,0.258518,0.548038,-0.0148077,0.242561,-0.443048,-0.0159731,0.400922,0.161068,-0.342204,0.324268,0.118388,0.190398,-0.0846439,-0.625298,0.0146449,0.351688,0.266118,-0.231606,0.266319,-0.0844273,0.118254,0.420276,0.0850458,-0.0906108,-0.277211,-0.103336,-0.307592,0.179297,0.606347,-0.0324632,0.826573,0.225065,0.234698,0.125871,-0.209814,-0.0372092,0.121397,-0.394214,-1.00828,-0.136568,-0.122003,0.232624,0.433062,-0.31028,0.147447,0.194179,0.383988,0.440657,-2.85978 +3427.79,0.93908,0.0848144,4,1.53268,0.959171,-0.429078,0.0752542,0.567294,-0.110663,0.379794,-0.466164,0.217353,-0.0226688,0.280383,-0.252777,-0.32242,0.228257,-0.24263,0.819342,-0.0337857,-0.0200181,0.333009,0.23524,-0.0883142,-0.593141,-0.425533,0.214643,-0.263111,0.0739521,-0.232982,0.964679,-0.212898,0.207889,0.641137,-0.408116,-0.450461,0.106247,0.350555,-0.102805,0.232255,0.340925,0.120021,-0.19375,0.725562,0.434996,0.306562,-0.451862,-0.290321,-0.0660688,-0.950212,-0.0674507,0.346884,-0.441974,0.088092,0.230185,-0.0216103,-0.416207,0.829076,0.139906,0.321043,-0.313587,0.549691,-0.455817,0.317106,0.909677,-0.536479,-0.314293,-0.467888,0.0974665,0.338476,0.360049,0.0632903,-0.608254,-0.321829,0.445169,0.78469,-0.106388,0.632012,0.270511,0.433593,-0.197658,-0.840212,0.192836,0.000613653,-0.697533,0.0893256,0.411639,-0.545382,0.374876,-0.862326,0.0302863,-0.0290834,-0.0827824,0.368157,0.275377,-0.126268,-0.468692,0.306387,-0.305345,-0.0999344,-0.472325,0.726907,0.355944,-0.315688,0.0630307,-0.135513,0.101888,-0.0141282,-0.0279898,-0.0648983,0.307881,0.696515,0.407394,-0.0983339,0.366178,-0.346019,0.625669,0.225072,-0.131536,-0.582436,0.150505,0.109541,0.0317277,-0.466576,-0.0181516,0.157246,-0.215238,0.197149,0.804491,-0.228896,0.0267461,0.166125,-0.827787,0.451064,-0.218317,0.103371,0.591053,-0.166486,-0.0186021,-0.179718,0.15919,0.165492,-0.441332,-0.0578868,-0.231306,0.313407,-0.577569,0.442211,0.00932253,-0.396462,0.3205,-0.183947,-0.321985,-0.188049,0.523033,0.00950319,0.0637328,0.363529,0.471259,0.210721,-0.114651,0.244563,-0.589607,-0.228294,0.0379605,1.07407,-0.568095,0.249083,0.369951,-0.0694264,0.250924,-0.148453,0.162389,0.56588,0.161174,0.0802511,0.318507,0.00723877,-0.238783,-0.0206031,-0.0376192,0.00522632,0.770006,0.0316269,-0.736928,0.205778,-0.0441074,0.234144,-0.649037,-0.177112,-0.803958,0.237576,-0.656562,-0.00794113,-0.144756,0.103395,-0.164979,0.0937377,0.311528,-0.260595,-0.286498,-0.249681,-0.150715,-0.280614,-0.293657,0.705788,0.0607722,-0.685816,-0.0957445,-0.255197,1.09782,0.0336227,0.764832,0.460244,-0.237937,0.142936,-0.462935,0.0538569,0.648727,-0.630195,0.684729,0.808359,-0.676882,-0.0970238,0.134512,-0.460145,0.748374,0.0503887,0.805849,0.516962,0.471347,0.122568,0.375918,0.3385,0.166005,-0.480521,-0.853899,-0.322369,0.215018,0.403804,-0.080278,0.355222,-0.388088,-0.415411,-0.0772353,0.465016,0.414836,0.720536,0.524164,0.121083,0.308852,-0.232477,-0.0572446,0.335267,-0.166294,0.581826,-0.334813,-0.173109,-0.106684,-0.481961,0.3809,0.566775,0.0978383,0.265705,-0.028942,0.142264,-0.0374582,-0.0969374,0.364676,0.147833,0.486742,0.43365,-0.118774,-0.159153,-0.0566465,-0.888853,0.0551508,0.0929276,0.158682,0.218029,-0.441106,-0.385251,0.0788545,0.192384,-1.12499,-0.0331549,0.221919,-0.021794,0.635298,0.358618,0.405784,-0.0122744,-0.278881,0.249523,0.121406,-0.162771,0.111097,-0.28594,-0.720163,0.0114935,-0.317967,-0.16414,-0.740666,0.173299,0.179151,0.168752,0.423262,0.410795,-1.86464 +3408.82,0.923905,0.0848144,5,1.42349,0.878349,-0.691678,0.241051,0.366516,-0.0839385,-0.126895,0.115411,0.25345,0.372813,0.0815878,0.410607,-0.0176584,0.505742,-0.0683074,0.32391,0.204258,0.16353,0.00407543,-0.0384332,-0.143283,-0.573954,-0.414774,0.294389,-0.128488,-0.121233,0.29709,0.0855162,-0.0330998,0.258928,1.02822,-0.0144824,0.477792,0.611524,-0.109513,-0.0782879,-0.437985,0.180208,0.612675,-0.892337,0.866526,0.509981,0.370942,-0.64059,0.0194735,0.34369,-0.644953,0.0899122,0.564092,-0.0241094,-0.138888,0.317984,0.049857,-0.608862,0.926197,-0.709155,0.030067,-0.741079,0.297754,-0.297339,0.406311,1.25879,-0.562494,-0.679344,0.162664,0.33069,0.00716553,0.248795,0.230642,0.0703157,-0.00367862,0.456643,0.475822,-0.137282,0.767644,0.647996,0.307956,-0.264159,-0.161591,0.053645,0.792117,-0.487491,0.222011,-0.440354,0.357816,-0.145908,0.694064,-0.432581,0.0951226,-0.446597,-0.239466,-0.39685,-0.00730897,0.100293,-0.0991114,-0.053979,0.523003,-0.0569201,0.397081,0.626094,0.334023,-0.231288,0.0378613,-0.473736,-0.0953976,1.01237,0.0685162,-0.381751,0.0591191,1.09142,0.175819,-0.20398,0.936041,0.328486,0.541909,0.284852,0.235422,0.0719233,0.241858,-0.423744,-0.981478,0.0969163,-0.287631,0.388919,-0.292852,0.364988,0.348423,0.00686449,0.120941,-0.146004,0.493813,0.461736,-0.335387,0.91617,-0.0118811,-0.242191,-0.0526898,-0.13067,0.620721,-0.92897,-0.728878,0.0338228,-0.259892,0.40144,0.06806,0.213752,0.356485,0.0416158,0.077228,-0.0222476,-0.182448,-0.033471,-0.0394004,-0.551875,-0.0491561,0.239298,0.387092,0.712291,0.402515,0.550944,0.730304,0.635318,0.808033,-0.430277,-0.199211,0.251603,0.426192,0.450377,0.0291856,-0.507137,-0.126114,-0.0875622,-0.0360509,-0.459642,-0.538934,0.207609,-0.400928,-0.0080999,0.17152,0.662919,-0.186392,-1.03827,0.61249,0.109307,0.660162,-0.0586263,-0.666115,-0.0122871,-0.0197519,0.293259,-0.0923221,0.0562541,0.422712,-0.414444,0.198226,0.0991996,0.235764,-0.202702,-0.880647,-0.0663689,0.142371,-0.171834,-0.366394,-0.0449685,0.168499,-0.246873,-0.777554,0.845825,-0.0280424,0.215354,-0.0929734,-0.154691,0.662767,-0.41879,0.0644373,0.16165,0.111667,0.0591829,-0.0595114,-0.269633,0.0908419,-0.502579,0.227726,0.511082,-0.31666,0.368305,-0.493594,-0.372794,-0.580459,-0.0367347,0.451576,0.11502,-0.586816,-0.344787,-0.489824,0.529427,0.0393067,-0.196858,0.47731,0.363783,-0.967627,0.374163,0.0154663,0.205102,0.19408,-0.0133908,0.422444,-0.176165,0.18479,-0.423959,0.63274,0.0216669,0.465894,-0.591852,-0.121546,0.465967,-0.223816,-0.211383,0.0516692,0.00599518,0.502785,0.416791,-0.186854,0.355503,0.49604,0.122346,-0.244668,-0.367962,-0.263272,0.256231,-0.434322,-0.820715,0.285771,0.236513,-0.370113,0.138827,0.157879,-0.250339,0.199305,0.304331,-0.127138,0.489335,-0.031816,0.0813287,0.134765,0.676895,-0.24089,0.243485,0.883353,0.227933,-0.095909,-0.139268,-0.0225726,0.178807,0.229239,0.342927,-0.50602,-0.00776192,0.566988,-0.362961,0.212767,0.185206,0.20248,0.430356,0.449978,-1.19034 +3416.25,0.960367,0.0848144,5,1.66305,0.951504,-0.445159,0.0671903,-0.295333,-0.0138541,0.368475,0.0503599,0.262105,0.444174,0.0919452,-0.556263,-0.227757,0.371553,-0.0826092,1.13576,0.192335,-0.403979,0.188472,0.100602,-0.551847,-1.19452,-0.849991,0.124695,-0.180657,-0.288077,-0.0945498,0.448794,-0.558578,0.0957563,0.568588,-0.437233,-0.410299,0.0512048,-0.650612,0.162893,-0.228715,0.250922,-0.10866,0.0831645,1.1043,0.298624,-0.183012,-0.506854,-0.00026998,-0.636961,-0.993982,0.304847,0.570411,0.275854,0.398451,0.182877,0.111608,-0.599878,0.974482,0.00737236,-0.213079,-0.379208,0.256136,-0.13471,0.0796106,0.970343,-0.451136,-0.789951,-0.392236,-0.247933,0.188235,-0.214362,0.139933,-0.966648,-0.420467,0.351413,0.773281,0.164014,0.26987,0.381801,0.0141835,0.19975,-0.156005,0.468415,0.32975,-0.0657809,0.20454,-0.533309,-0.428434,0.0419872,-0.465103,0.165597,-0.20538,-0.104485,0.199305,0.0959803,-0.049343,-0.135519,0.181658,-0.377563,0.0824222,-0.0821194,-0.0928599,-0.086683,0.0164484,0.24314,-0.484829,-0.334159,0.203719,-1.02152,0.12451,0.0967919,0.418708,0.209249,-0.281361,-0.294762,-0.19312,-0.0194036,-0.0901125,-0.129553,-0.657529,0.139742,0.094455,0.0364454,-0.454616,-0.564408,-0.221017,-0.382238,0.0328314,-0.611499,0.0213257,0.110119,0.0869321,-0.45457,-0.287551,-0.414979,0.24017,-1.9054e-05,-0.0932921,-0.0529729,-0.200417,0.00896451,0.454449,0.341188,0.536374,-0.0855599,0.606266,-1.20135,0.00490662,-0.0890373,-0.166511,0.452023,-0.251116,-0.137601,-0.219871,0.195899,0.37682,-0.068197,0.229595,0.734566,-0.076085,-0.317773,-0.279987,-0.366502,-0.0422536,-0.513903,0.350435,0.0439809,0.245927,0.124353,-0.688826,-0.740386,-0.0431959,0.331265,0.320686,0.586183,-0.299978,0.707467,0.249177,-0.311011,-0.0347279,-0.144393,0.0757023,0.489371,0.128182,0.675127,-0.178635,-0.0139774,-0.323325,-0.454774,-0.322126,-0.730365,0.122836,-0.725676,0.217747,0.225787,-0.45689,-0.410307,-0.301621,-0.0310541,0.115963,0.0748686,0.288002,0.331135,-0.277041,0.243086,0.599048,-0.0957661,-0.464182,0.120987,-0.293958,1.17261,0.258543,0.139062,0.011859,-0.271636,-0.519946,0.337125,0.00542514,0.436952,-0.344469,0.255811,0.632926,-0.266593,-0.0781966,-0.180434,-0.0236277,0.474865,-0.0497506,0.444418,-0.667346,0.230012,0.426951,0.207776,-0.602282,-0.157131,0.148622,-0.0926044,-0.0377262,0.349076,-0.027195,0.10245,0.507033,-0.978612,0.543533,0.341118,0.247125,-0.138149,0.408693,-0.0238604,0.131089,0.320142,-0.0730438,-0.0123456,-0.226612,-0.804452,0.377841,-0.0103576,-0.374174,-0.0341645,-0.152755,0.18684,-0.190459,0.0793795,-0.344049,-0.158562,0.594425,0.0285564,0.219145,-0.0494594,0.266679,0.0199535,0.127969,-0.242208,0.171898,0.258049,-0.5812,-0.157605,0.250466,-0.162734,-0.0940894,0.501655,0.170421,-0.0663386,-0.190169,-0.913201,-0.20961,-0.328311,-0.0959923,-0.301469,0.138608,0.244295,-0.585486,-0.518228,-0.0350438,0.562286,0.102883,0.151344,-0.222059,-0.907294,0.525097,-0.00219889,-0.84284,0.0254256,-0.199184,0.143951,0.207762,0.379409,0.455809,1.13491 +3429.23,0.9277,0.0848144,4,1.62071,0.92088,-0.625299,0.0544112,-0.175968,-0.194068,0.138335,0.0687834,0.311729,0.0359196,-0.182836,-0.211746,-0.540531,0.465738,-0.0290225,0.921008,0.169043,-0.43554,-0.284617,0.00398595,-0.624301,-1.21254,-0.795071,-0.192755,-0.544283,-0.140536,-0.0378346,0.103932,-0.135032,0.0986023,0.540799,-0.561072,-0.0137341,0.0822923,-0.187869,0.262422,-0.720338,0.101081,-0.0020054,0.0699132,1.12582,0.417427,-0.0104363,-0.365241,0.168725,-0.712947,-0.418597,0.248129,0.806177,-0.0531733,0.00964731,-0.0513493,0.352212,-1.33537,1.21946,-0.742586,-0.391043,-0.58782,0.348929,0.110097,0.292257,0.826024,-0.401988,-0.872451,0.0900857,0.582868,-0.238188,0.364868,0.217604,-0.378784,-0.123841,0.224221,0.365401,0.235666,-0.0399404,0.0299159,0.433459,-0.318662,-0.459967,-0.0278534,0.577818,-0.369162,0.516281,-0.148342,-0.288698,-0.624442,0.190938,0.455644,-0.245602,-0.130992,0.112488,0.134196,0.119407,0.0872441,-0.196351,-0.541852,0.74421,0.270153,0.150895,0.389614,-0.159742,0.00603072,-0.383965,-0.554474,0.345981,-0.959169,-0.017418,-0.406363,-0.129983,0.760072,0.0586423,-0.252196,-0.396457,0.25915,-0.316035,0.737503,-0.791407,0.617105,-0.0298014,0.151126,-0.443479,-0.463389,0.0166905,-0.211257,-0.252956,0.358229,-0.431049,-0.242932,0.0997132,-0.523097,0.163534,-0.344436,0.125498,0.502679,-0.122922,0.302078,0.102766,-0.1502,0.639436,0.18741,-0.26782,0.063282,0.246683,-1.03085,0.0614037,-0.227706,-0.55929,0.177503,-0.118017,-0.291051,-0.434735,0.116403,0.149784,-0.176206,0.178542,0.692296,0.569521,-0.607981,-0.348877,-0.478162,0.446465,-1.04203,0.360236,0.640204,-0.0453402,-0.17482,-0.176621,-0.568699,0.0600642,0.21347,-0.242575,0.031352,-0.340878,-0.000388341,0.393202,-0.113014,-0.149535,-0.238522,0.304347,0.507933,-0.199216,0.152299,0.223281,-0.368558,-0.227934,-0.143272,-0.391958,-0.427063,0.327513,-0.0946076,0.360814,0.052587,-0.0520058,-0.388402,0.525598,0.265561,0.114839,-0.106846,-1.09272,-0.134147,0.139617,0.225696,0.34303,-0.184006,-0.624709,-0.0743983,-0.907272,0.971805,0.705825,-0.280112,-0.353841,-0.34115,-0.123374,-0.21873,-0.0990521,0.603874,-0.521645,0.243738,0.372015,-0.0595167,0.0664176,-0.0628393,0.229445,0.34785,-0.399066,0.284795,-0.527046,-0.145721,0.443795,0.303997,0.166859,-0.212996,-0.183554,-0.0760225,-0.204615,0.476676,0.0371107,-0.285847,0.406618,-0.381966,-0.647387,-0.0504066,0.064885,0.194721,0.634597,0.175856,0.187699,0.330142,0.129818,-0.127963,0.276948,-0.883246,0.365252,0.0932495,-0.547558,0.415072,-0.0351948,-0.633975,-0.334432,0.38258,-0.208455,0.481335,0.195266,-0.0167171,-0.0731813,-0.108835,0.146609,-0.0577847,0.100261,-0.237871,-0.0730039,-0.261378,-0.508189,0.405262,0.3105,0.00516916,-0.180815,0.308596,0.366889,0.221975,-0.390031,-0.80685,-0.597667,-0.347254,0.0833726,0.537178,0.255779,0.376239,-0.115146,0.181716,-0.388719,0.523219,0.248137,0.422425,-0.162479,-0.460823,0.165716,-0.0229139,-0.774061,-0.245433,-0.047677,0.127901,0.247654,0.357632,0.497649,0.902275 +3429.23,0.8774,0.0848144,4,1.61829,0.922717,-0.273409,0.0863257,-0.175031,0.0426826,0.11975,0.267939,0.678646,0.33353,-0.0252815,-0.315852,-0.178521,0.416618,-0.0394969,1.04446,0.385085,-0.37169,-0.317512,-0.0219119,-0.366723,-1.01043,-0.510408,-0.137759,-0.770824,-0.550599,0.0268698,0.843592,-0.142595,0.269845,0.722661,0.251179,0.162571,0.182905,-0.250342,-0.0353676,-0.844975,0.233348,-0.2495,-0.573381,0.703382,0.556233,-0.0263775,-0.653196,-0.105926,-0.521367,-0.441856,0.153207,0.389973,-0.282302,0.203757,-0.429488,-0.102589,-0.90611,0.770149,-0.263585,-0.518832,-0.15541,0.0377623,-0.332186,0.247788,0.92515,-0.309271,-0.555619,0.294695,0.00783788,0.39882,0.0923776,-0.0438064,-0.496817,-0.286479,0.177243,0.930509,-0.0400419,0.198922,0.235142,0.401593,0.0328159,0.0240039,0.561707,0.546766,-0.0686213,0.540117,0.102766,0.445806,-0.0440629,-0.525422,-0.178492,0.0988021,-0.884575,0.0381034,-0.17756,0.150557,-0.145739,-0.610852,-0.474436,0.3852,0.212747,-0.00817014,0.182457,0.4875,-0.0447399,-0.202233,-0.509492,0.00940285,-0.26622,-0.333209,-0.31153,0.195708,0.696153,0.352769,-0.478148,-0.0358734,0.304648,0.0377484,0.431786,-0.551921,-0.00851927,0.261557,-0.660286,-1.13776,0.181748,-0.216155,-0.422766,-0.254077,-0.154679,-0.0244014,0.117606,0.255,-0.846133,0.281855,0.122167,0.520876,-0.0309701,-0.462665,0.0277667,0.00715766,0.0359947,0.525049,0.237562,-0.508076,0.305721,0.667106,-0.108412,0.688182,-0.10918,-0.0476356,-0.241189,0.122779,-0.29178,0.194842,-0.0200357,0.0544552,0.450864,0.959905,0.20868,0.136048,-0.466956,0.265438,-0.0380711,0.138969,-0.0241612,0.150338,0.482892,0.111288,0.230482,-0.147059,-0.121018,-0.19959,-0.172831,0.367737,0.859252,0.0260645,-0.204056,-0.206189,0.00133246,-0.407876,0.141152,0.0737912,0.56892,0.0369611,0.0944923,-0.561893,-0.0314553,0.1167,-0.201809,-0.293983,-0.353919,-0.0331872,0.15822,0.249775,-0.196052,0.00986763,-0.247089,0.514819,0.07741,0.0935451,-0.186184,-0.882294,0.269854,0.455501,-0.458687,0.271786,0.284764,-0.577132,-0.15294,-0.130118,1.05785,-0.204341,0.416644,-0.304415,-0.417824,-0.146462,-0.218236,-0.00331262,0.634773,-0.141366,0.258171,0.158718,-0.22485,0.0945517,-0.315071,0.149324,-0.571573,0.042262,0.402421,0.00582044,-0.0520412,-0.265679,-0.166509,-0.260647,0.0870112,0.513722,0.314609,-0.129496,0.854899,-0.188839,-0.0662384,0.50435,-0.518096,-0.332207,-0.19972,0.630242,-0.318563,0.13661,-0.0930557,0.432791,0.151441,0.245723,-0.416602,0.122903,-0.377939,0.302597,-0.192363,-0.202387,0.290403,-0.158543,0.287678,-0.290445,0.245905,0.155486,-0.112613,-0.150956,-0.337219,-0.600075,-0.158734,0.0010072,-0.0615364,0.0272879,0.121516,-0.287065,-0.148151,0.252954,-0.0513883,-0.291627,0.0219012,0.295206,0.172765,-0.198739,0.0346047,-0.124622,0.334131,-0.0944462,-0.583845,0.0397485,0.458719,-0.0794677,0.326581,0.0825188,-0.593208,0.0126961,-0.355562,0.525212,-0.099605,0.254743,-0.429469,-0.106562,-0.466797,-0.787144,-0.627989,-0.0993618,0.120403,0.221354,0.346992,0.470483,0.619145 +3430.2,0.94226,0.0848144,4,1.55538,0.982855,-0.837983,0.304916,0.325474,-0.0329437,-0.137892,-0.424022,0.420143,-0.0266421,0.0292449,0.125478,-0.249727,0.201238,-0.14237,0.906157,0.0509032,-0.38905,-0.200587,-0.269711,-0.499411,-1.11808,-0.47517,-0.0672811,0.165083,-0.388807,-0.234848,0.209795,0.23306,0.482753,0.481016,-0.411361,0.0807616,0.234699,-0.336599,-0.247557,-0.713373,0.488853,0.332329,-0.456963,0.820145,-0.0513527,0.494262,-0.703585,0.0270315,-0.626969,-0.72546,0.372304,0.304853,-0.0738123,-0.173724,-0.297199,0.227138,-0.8999,0.558599,-0.241696,-0.459033,-0.469544,0.292195,-0.386025,0.450009,0.606549,-1.31984,-0.756767,0.203733,0.0243941,0.571362,-0.242302,0.21671,-0.582351,-0.0419333,0.382506,0.449904,0.271608,0.332048,0.859189,0.939348,0.409788,-0.264672,0.201013,0.532368,-0.589383,0.490106,-0.0309247,0.458875,0.139386,0.453431,-0.297508,0.0364786,-0.370338,-0.675642,0.376412,0.147157,-0.207022,0.773187,-0.255154,0.0878887,-0.774475,0.0193103,0.17852,0.244432,-0.391229,-0.186907,-0.0976058,0.349173,-0.159294,0.00453626,0.010361,0.470337,0.702076,-0.0832956,-0.254691,0.0745639,0.433398,0.310933,-0.0936519,-0.35414,0.113209,0.223887,-0.371172,-0.470808,0.0495669,-0.468142,-0.25798,0.592446,-0.0753535,0.29764,0.353938,0.0925238,-0.586892,-0.0289902,0.152422,0.316257,0.362779,-0.181502,-0.380818,0.128181,0.00933767,0.586189,-0.355726,-0.72549,0.391232,0.265251,-0.0269316,0.281399,-0.14227,-0.497293,0.0961307,0.0311342,0.0665731,-0.61198,0.274087,0.0683,0.091779,0.198255,0.50641,0.657716,-0.0308667,0.0843201,0.337727,0.00229308,-0.175843,0.123059,-0.0739483,0.18043,0.0726356,0.35968,0.0971316,-0.155184,0.083075,0.180655,-0.175205,-0.00681487,-0.0059837,-0.0871006,-0.508183,-0.46471,-0.185571,0.100674,0.863831,0.195642,-0.437691,0.126858,-0.638252,-0.234102,0.164988,-0.262744,-0.174035,0.142248,-0.0846223,0.376047,0.327383,0.289173,-0.19725,0.0478813,0.684702,0.294596,-0.307978,-0.809167,-0.599246,0.0721006,-0.350609,0.78557,0.04431,-0.239539,-0.154845,-0.781262,0.940567,-0.55557,0.337095,-0.133246,-0.0411832,0.108366,-0.258196,-0.209433,0.148742,0.235721,0.19765,0.473025,-0.169869,-0.00881501,0.0109708,0.356496,0.0854351,-0.395094,0.362914,-0.380433,0.135769,0.178786,-0.176461,-0.808273,0.0905117,-0.230863,-0.115597,-0.216778,0.348108,0.19829,0.398135,0.590405,-1.11954,-0.309503,0.0402945,-0.156681,0.507775,-0.033234,-0.348023,0.0960281,0.151336,0.477549,-0.062832,0.167365,-0.974882,0.0361385,-0.260792,-0.0995914,0.25894,-0.188225,0.271258,-0.183803,0.420741,0.0279815,0.601008,0.997598,0.345614,-0.344538,-0.354404,0.0462313,-0.0219206,0.198688,-0.426772,-0.295476,-0.573153,0.0166409,0.289763,0.198671,-0.360999,0.319717,-0.169986,0.517345,-0.424798,-0.507805,0.402411,-0.396054,-0.454492,-0.123506,-0.0430355,-0.432275,0.510233,-0.000255473,-0.462802,-0.19053,-0.0842358,0.170165,-0.0261064,-0.0882389,-0.277797,0.0316464,-0.329317,-0.226869,-0.349237,0.00905044,0.147762,0.23913,0.384398,0.489009,-1.10341 +3420.75,0.984082,0.0848144,4,1.68901,0.957731,-0.701132,0.208151,0.181667,0.018308,0.287545,-0.0984635,0.503079,0.0390085,0.0105259,0.0500061,-0.0993767,0.258032,-0.567461,0.752186,-0.268885,-0.158713,-0.203723,0.0545103,-0.491994,-0.538977,-0.721564,-0.296443,-0.332774,-0.339345,-0.428357,-0.0561519,-0.430751,0.121843,0.42473,-0.411985,-0.374101,0.223075,-0.25247,-0.600039,0.0874318,-0.47863,0.507381,-0.511789,0.929125,0.485938,0.224251,-0.621214,-0.467827,-0.779454,-0.540565,0.153892,0.30134,-0.0806448,0.0406751,-0.0388317,0.00700818,0.371967,0.560865,-0.411626,-0.225012,-1.15173,0.294101,-0.551112,0.123695,0.530149,-0.497358,-0.844364,0.150181,0.167495,0.833451,-0.78299,-0.563879,-0.452642,-0.344729,0.83481,0.544874,0.519242,0.374725,0.656282,0.260664,0.0933496,0.0403566,0.276387,0.539119,-0.739318,0.31082,0.37865,-0.000530445,-0.0440544,0.355523,0.0271365,0.0332072,-0.188984,-0.280772,0.625647,-0.0203215,-0.486609,0.0538489,-0.779581,0.106493,0.0555986,-0.0157978,-0.167424,0.349102,0.0207105,-1.11286,-0.231391,-0.435167,-0.2689,0.289082,-0.529873,0.147846,0.400654,-0.374847,-0.403858,0.0457248,0.288445,0.255838,0.157164,-0.290756,0.135397,0.101571,-0.312512,-0.34129,0.104225,0.0922079,-0.295237,-0.16329,0.732288,0.136632,0.579734,0.118005,-0.53646,0.454528,0.332743,0.281159,0.366612,-0.185592,-0.52594,-0.0307716,-0.285766,0.647667,-0.309176,-0.274396,0.354426,-0.363033,-0.637662,0.16077,-0.186106,-0.312053,-0.0785768,0.0604518,0.0281907,-0.382848,-0.0486294,-0.140537,0.497703,0.433777,0.36528,-0.293051,0.119966,0.00768273,-0.0845498,0.000475474,-0.2848,1.13077,0.198407,0.287215,0.0262576,-0.245523,-0.0551493,0.0035599,-0.416063,-0.0325498,0.157141,0.000583617,-0.19762,0.173027,0.528782,-0.398848,0.245551,-0.00628987,0.913093,0.171643,0.0697399,0.013224,-0.271112,-0.0134167,-0.809539,-0.170857,-0.202662,-0.0253352,-0.316821,-0.167963,-0.457449,0.266306,-0.357816,0.328393,0.335114,-0.0795816,-0.372282,-0.0915744,-0.815504,0.243642,-0.594764,0.202292,-0.0749919,-0.0586776,-0.25758,-0.580871,1.10033,0.0380842,0.615469,-0.728842,-0.0136113,0.415622,0.0772099,-0.581989,-0.0328926,0.367267,-0.0723011,0.172755,-0.441306,0.0495453,-0.40808,0.175972,-0.15013,-0.253323,0.276115,-0.38643,0.0752005,0.47598,-0.0580764,-0.186431,0.0389136,-0.371347,-0.291308,-0.634656,0.464278,-0.0519621,-0.166411,0.837127,-0.542411,0.199587,-0.062647,0.453745,-0.133704,0.417003,-0.0650098,0.0366853,-0.279067,-0.141188,-0.368352,0.110956,-0.180637,0.505042,-0.190356,-0.357194,0.0811921,0.0789377,-0.0180968,0.33063,0.095381,-0.241352,0.2946,0.368463,-0.0662119,0.203126,0.174601,0.225436,0.745335,0.603189,-0.0382772,-0.0922129,-0.546838,-0.657434,0.903666,0.0421029,-0.35763,-0.24348,0.456977,0.399792,-0.265857,-0.34955,-0.483412,-0.154898,-0.152528,-0.202189,0.00427749,-0.173836,1.135,0.469499,-0.815527,0.0200396,0.513393,-0.220112,0.134891,-0.317062,-0.232077,-0.367176,0.0546431,-0.584996,-0.657101,-0.107703,0.13983,0.187951,0.373938,0.433533,-0.440903 +3412.65,0.569756,0.0848144,4,1.70109,0.884265,-0.801931,0.294721,0.62437,-0.0169722,-0.237516,-0.384045,0.685123,-0.360011,0.0512715,0.0774325,-0.433203,0.297106,-0.449264,0.553885,-0.30752,-0.113554,-0.640094,0.119769,-0.647942,-0.944552,-0.544071,0.105983,-0.174666,-0.281602,-0.420931,0.222063,-0.361234,-0.0773091,0.492739,-0.454621,0.00696733,0.351816,-0.322163,-0.702317,-0.126464,-0.408834,0.946246,-0.18334,1.00962,-0.0540583,0.438957,-0.218468,-0.598755,-0.194638,-0.587252,0.172302,0.598969,-0.159581,0.15429,-0.129263,-0.128947,-0.145496,0.558402,-0.547769,-0.305876,-0.674841,0.342733,-0.298403,0.22486,0.42569,-0.287825,-0.837778,0.205886,0.035329,0.7012,-0.395836,-0.514308,-0.307928,-0.487633,0.688698,0.625966,0.20395,0.351247,0.915965,0.515128,0.363498,0.140814,0.0802601,0.334435,-0.48783,0.251555,0.227621,-0.451796,-0.344248,0.653818,0.178474,0.346534,-0.267497,-0.393842,0.333913,0.160352,-0.762047,0.108673,-0.650105,0.0722972,-0.310277,-0.399464,-0.0275143,0.296483,0.237207,-0.580268,0.040297,-0.552211,-0.201803,0.213286,-0.432247,0.203862,0.554874,-0.0896352,-0.23066,0.0133335,0.281558,0.138383,-0.148181,-0.0736557,0.275435,0.0284204,-0.168889,-0.237321,0.293749,-0.0609561,-0.464676,-0.195069,0.922314,-0.128019,0.0712859,0.155908,-0.220406,0.890285,0.274608,0.405652,0.452974,-0.455694,-0.443219,0.357285,-0.368891,0.687445,-0.794604,-0.22414,0.263565,-0.2629,-1.05133,0.485022,-0.141511,-0.506765,0.147469,0.264822,0.0699005,-0.966968,0.232977,-0.254234,0.477733,0.188924,0.69824,0.128001,-0.245076,0.0326528,-0.0770223,0.180064,-0.393325,0.805564,0.0203281,-0.0638115,-0.293972,-0.488346,0.0845976,0.0327283,-0.196076,0.164674,0.12826,-0.013598,-0.223798,0.470396,0.257297,-0.194844,0.113247,-0.118721,0.917814,0.304226,-0.301609,0.0134782,-0.359486,-0.0380096,-0.763304,-0.363024,-0.389924,-0.201319,-0.311522,-0.11174,-0.303951,0.548449,-0.163811,0.360548,0.738269,0.11315,-0.334878,-0.551318,-0.731829,-0.0484402,-0.780719,0.183003,-0.22888,-0.3763,-0.417696,-0.00784218,1.15788,-0.0312914,0.554171,-0.71612,-0.247712,0.366366,0.0324325,-0.612054,-0.164179,0.188794,-0.0306643,0.0681307,-0.774657,0.0560313,-0.408913,0.0439603,-0.00786097,-0.385932,0.409863,-0.252747,0.0267479,0.0812812,0.0191017,0.0439623,0.0247906,-0.208421,-0.0460389,-0.5138,0.756727,0.307509,-0.145174,0.573562,-0.416322,0.212383,-0.217506,0.0834239,-0.140875,0.393618,0.0227238,0.41538,-0.303522,0.0539681,-0.237645,0.0332624,-0.21819,0.790377,-0.147718,-0.247596,-0.140156,-0.391671,-0.134672,0.0423134,0.0195194,0.34229,0.52543,0.289885,-0.0974835,0.118863,0.0868942,-0.0782971,-0.142779,0.0259618,-0.252077,-0.152309,-0.174112,-0.566389,0.655042,-0.0299887,-0.121551,-0.309139,0.328257,0.250155,-0.241952,0.0401706,-0.343581,-0.289584,-0.120779,-0.20456,0.0390545,-0.479503,0.882271,0.395671,-0.561653,0.157859,0.0054741,0.134959,0.108318,0.0423043,0.0826535,-0.179236,-0.0317481,-0.373631,-0.753462,-0.236597,0.178213,0.241566,0.422153,0.491493,-1.78893 +3453.34,0.935742,0.0848144,4,1.6473,0.662249,-1.66258,0.651205,0.100689,0.0575959,0.0458824,-0.269411,-0.541614,0.291369,-0.0597266,-0.371252,-0.215103,0.564087,-0.190805,0.40185,0.308778,-0.434441,-0.129874,-0.136888,-0.0147717,-0.70596,-0.833739,0.479898,-0.764046,-0.0353195,-0.0760964,-0.0206191,-0.380829,0.208315,0.865629,-0.578892,-0.227341,0.1649,-0.397421,0.210479,-0.68898,0.714316,-0.137773,-0.511419,0.512516,0.585484,-0.104137,-0.565124,-0.120638,0.554149,-0.357403,0.10122,0.106491,0.163056,0.0098862,0.469479,0.151849,-0.298273,0.356167,0.236074,-0.392692,-0.491311,0.494071,-0.437178,0.338844,0.531818,-1.009,-0.735008,0.0343825,0.366495,-0.163981,0.0611308,-0.0666959,-0.109924,0.129485,-0.0851588,0.473162,-0.0186722,0.974037,0.118582,0.256863,-0.117414,-0.51979,-0.0345631,0.558253,0.0264378,0.177487,0.316678,-0.314934,0.363607,-0.437662,-0.338538,-0.551818,-0.25524,0.4616,-0.409654,0.0729765,-0.1426,-0.0565247,0.286272,0.122019,-0.110885,0.449419,0.365181,0.129441,-0.448622,-0.143599,-0.108159,0.382327,-0.294839,0.0332364,0.102322,0.216199,0.390212,-0.177696,0.00454755,-0.201945,0.610813,-0.200666,0.464172,-0.344721,-0.0282336,0.453033,-0.0548161,-0.394155,0.0777085,-0.0172404,0.242771,0.0446243,-0.0613612,0.416564,-0.077891,0.554248,-0.641065,-0.614587,-0.265365,-0.185976,0.629933,0.304199,0.488068,-0.350008,0.194702,-0.113744,0.135463,-0.452743,-0.351461,0.46177,-0.0242252,-0.49078,0.0778504,0.391973,0.0682454,-0.263291,0.0153024,0.280058,0.187981,0.132198,-0.343255,0.365656,0.203585,-0.0984659,0.19554,0.108355,-0.187814,0.0693858,-0.207794,0.702405,-0.268077,0.0509315,0.277586,0.542371,-0.220877,-0.193355,-0.0539862,0.243084,-0.148529,-0.0246923,0.0254875,-0.272422,-0.407179,-0.192008,-0.158711,0.318843,0.61831,-0.0201354,0.237341,0.246259,0.137298,0.0394491,0.125037,0.0978339,0.213875,0.319108,-0.589686,0.118374,0.387295,-0.00512606,-0.527557,-0.0288364,0.132859,0.0547081,-0.19216,-0.267648,0.896467,0.0403414,0.32838,0.253182,0.303564,0.261292,0.145826,-0.827818,0.780949,-0.0484557,-0.331621,0.486097,-0.376838,-0.0319367,-0.158664,0.148645,0.358248,-0.314395,0.123798,0.597465,0.334854,-0.385273,-0.665784,0.00332645,0.126518,-0.149625,0.431766,-0.463632,-0.489739,0.208046,0.177878,-0.660709,0.239345,-0.293798,0.00176289,0.0155899,0.180206,-0.161339,-0.101963,0.604292,-0.507185,-0.00316768,-0.00594086,-0.274805,-0.0128865,0.178639,0.454198,0.26364,0.270168,-0.169567,-0.50134,-0.00716407,-0.365429,-0.03234,-0.0537278,0.0982565,0.235754,-0.36794,-0.278083,-0.0403051,-0.0166575,-0.118065,-0.0883787,0.198859,0.20539,0.177999,-0.472319,0.0172124,-0.0934387,-0.341561,-0.156303,-0.571554,-0.20183,0.253836,-0.00899501,-0.234752,0.157458,0.262157,0.0200887,0.160857,0.0377227,-0.178277,-0.148699,-0.185803,0.081566,0.0632882,-0.122762,-0.178291,-0.087517,-0.36311,0.176047,-0.224302,0.0874461,0.0771377,-0.0761452,-0.235681,-0.535536,-0.280841,0.169907,0.165365,0.24561,-0.254256,0.101498,0.173539,0.318587,0.41658,0.383778 +3430.35,0.986891,0.0848144,4,1.63925,0.744105,-1.44614,0.584394,0.34008,0.0284021,-0.202515,0.246512,-0.342003,-0.142107,-0.115426,-0.209567,-0.261874,0.563122,-0.456458,0.512736,0.249774,-0.0942139,-0.425731,0.0465461,0.277281,-0.582611,-0.996471,0.479822,-0.572444,-0.461888,0.0779508,-0.435036,-0.529426,0.224285,0.815288,-0.453694,-0.118575,-0.0311198,-0.147069,0.416273,-0.520517,0.946578,-0.108436,-0.322157,0.686836,0.4172,0.0467239,-0.484784,-0.149088,0.0709201,-0.408448,0.494549,0.190398,0.351383,0.151804,0.680022,-0.0815506,-0.493265,0.275396,-0.408706,-0.540269,-0.572721,0.362006,0.14916,0.763298,0.528346,-0.520158,-1.34007,0.518406,0.470117,0.247073,-0.0845317,-0.217774,-0.222952,0.339355,-0.0669162,0.511699,0.261657,0.770159,0.457344,0.247602,0.153774,0.0941334,-0.182859,0.416508,-0.41345,0.0766946,-0.0846634,-0.279576,0.27243,-0.0950349,-0.315826,-0.231672,-0.386145,0.330886,0.0785922,-0.0128237,-0.173719,-0.450301,0.536602,-0.0297366,-0.0433683,0.116313,0.548933,0.239651,-0.484003,-0.432521,-0.467647,0.429617,-0.688139,0.285997,0.0621953,-0.259612,0.251506,0.161531,-0.159511,-0.469641,0.51719,0.137284,0.316909,-0.467236,-0.205415,0.435223,0.0547501,-0.428104,-0.209345,-0.536867,0.404417,0.160015,-0.153027,0.445404,0.211414,0.270026,-0.799296,-0.146999,-0.181847,-0.0585102,0.380668,-0.254879,0.27021,0.0569,0.0621493,0.0870588,-0.540408,-0.67581,-0.453171,-0.0338137,-0.468181,0.0113555,-0.316125,-0.25738,0.239524,-0.0720195,0.279331,-0.438059,0.175344,0.0749808,-0.399779,0.0291513,-0.0587918,0.223952,0.203159,0.226069,-0.0607993,0.275778,0.409663,0.552182,0.274821,-0.242283,0.538824,0.112221,0.324078,-0.659879,-0.316999,0.0468908,-0.138605,0.104772,-0.400643,-0.557506,-0.309587,-0.386863,0.180932,0.175234,1.13936,0.382995,0.489751,0.213246,-0.156314,0.478517,0.351582,-0.19149,-0.151172,0.549378,-0.497291,-0.0404509,0.386684,-0.17124,-0.383718,0.328717,-0.116834,-0.128044,-0.277828,-0.555242,0.443332,-0.0361805,0.2666,0.00208759,0.249601,0.315103,0.699267,-0.542864,0.943396,0.163586,-0.171528,0.169092,-0.419912,-0.11435,-0.271653,0.082454,0.101522,-0.116243,0.386215,0.797973,0.224781,-0.154059,-0.460618,-0.229987,0.747584,-0.474805,0.498447,-0.286382,-0.740217,-0.291217,-0.1884,-0.365088,0.141574,-0.326317,-0.446408,0.173948,0.0958179,0.266039,-0.185178,0.802501,-0.443315,-0.338531,-0.0962592,-0.217676,-0.504207,0.236287,0.229661,0.45975,0.417222,-0.607719,-0.40965,-0.177106,-0.202938,-0.164938,-0.198795,-0.128015,-0.0688931,-0.346001,-0.172716,-0.184302,-0.0119396,-0.19167,-0.00994695,-0.0485125,-0.394154,-0.157604,-0.208033,0.0402789,0.0166336,0.183311,0.103595,-0.144446,-0.468335,0.40002,-0.170022,0.111247,0.411862,0.325886,0.0741567,0.577591,-0.186233,-0.341646,0.0582252,-0.332069,-0.333969,-0.153595,0.0304135,-0.14687,0.320252,-0.144582,0.0843923,0.0136108,0.145897,0.545704,0.360067,-0.375022,-0.874262,-0.234591,0.48502,0.51138,0.128801,-0.214535,0.115977,0.233842,0.340554,0.483572,-0.60678 +3421.37,0.865078,0.0848144,4,1.55023,0.584471,-1.5636,0.593605,-0.215659,0.033769,0.235923,-0.0540677,0.316335,-0.00764873,0.145564,-0.626454,0.0415782,0.731626,0.188967,0.592649,0.35285,-0.101451,-0.0547377,0.372489,-0.104929,-0.661048,-0.69762,0.483286,-0.54135,0.201405,0.00908182,0.0293999,-0.844911,-0.196713,0.810894,-0.882709,-0.319091,0.105587,-0.547477,0.02127,0.320192,0.188417,0.107275,-0.160289,0.829356,0.286171,0.299025,-0.586642,0.0569932,-0.587813,-1.25586,0.543704,0.563668,0.024131,0.476151,0.190344,0.0438222,-0.296841,0.58276,0.0551525,-0.159882,-0.393861,0.632363,-0.224354,0.0863376,0.501187,-0.74834,-0.842828,0.0384944,0.0485412,-0.445835,0.110347,-0.472647,-0.30866,0.638154,0.366991,0.657592,-0.0362877,0.0120426,0.49099,-0.188549,0.16448,-0.497708,-0.212234,0.359531,-0.00355029,0.444224,0.371777,-0.326358,-0.306983,0.374264,-0.350711,-0.0515093,-0.217832,-0.262113,-0.0513909,0.244458,-0.227954,-0.339437,0.209117,0.269976,-0.181441,-0.0314596,0.532325,0.679117,-0.430319,-1.0026,-0.139829,0.501997,-0.285352,-0.0207439,-0.305461,-0.133381,0.459383,-0.070392,0.133177,0.0158351,0.434239,0.567725,0.000249025,-0.278506,-0.00603075,0.0210175,-0.135627,-0.331431,0.421394,-0.102913,0.701997,-0.322034,-0.690198,-0.518589,0.236829,0.106984,-0.153109,-0.0997498,-0.083957,-0.313221,0.153612,-0.0638489,-0.254986,0.13279,-0.110419,0.361361,-0.292375,-0.396208,0.348908,-0.0869651,-0.629206,-0.230175,0.240933,0.548551,0.357589,0.0460177,-0.0459358,-0.456407,0.602376,0.144373,-0.45139,0.272582,0.514893,0.0487147,-0.302749,0.177959,-0.163315,0.485263,0.133078,0.555691,0.390596,-0.638548,-0.104029,-0.410694,-0.212183,-0.251899,0.313441,0.0649639,-0.217944,0.119956,-0.093698,-0.0714558,-0.474794,-0.332295,-0.484765,0.0580897,1.21304,0.335162,0.492645,0.310784,-0.341707,0.0953763,-0.345724,0.304999,-0.0724251,-0.22888,-0.512674,0.0428417,0.158276,0.173536,-0.0979349,0.124612,-0.520437,0.309728,-0.0235825,-0.676675,0.00673967,-0.169757,0.270433,0.24058,0.116619,0.213199,0.431138,-0.619426,1.13621,0.598894,-0.21314,0.298107,-0.07443,0.115807,0.340845,-0.146648,-0.0513452,-0.184165,0.652878,0.0976171,-0.0257472,0.00412123,-0.882419,-0.85424,0.283428,-0.424645,0.916241,-0.388291,0.0419466,0.155265,0.241865,-0.247497,0.288836,-0.138204,-0.0090245,-0.406881,0.451921,0.302386,-0.122675,0.754508,0.0402196,0.0843825,-0.179712,-0.169288,0.0198698,0.175728,0.174124,0.2615,0.246091,-0.625602,-0.337802,0.0204781,-0.140608,0.432805,-0.755303,0.0363108,-0.290094,-0.344252,0.359116,0.522358,0.245967,0.0429305,-0.101312,0.0787176,0.407685,0.285137,0.108187,0.0749795,0.528148,0.144743,-0.0852421,0.063462,0.0688948,-0.39611,-0.036784,0.085727,-0.0650898,0.182963,-0.0428983,0.164944,-0.580405,-0.279814,-0.223388,-0.235936,-0.13857,-0.0544428,-0.0954402,0.0680045,0.0783992,0.300632,-0.30589,-0.0950823,-0.137514,0.41061,0.605502,-0.323288,-0.431307,-0.341184,0.0935456,-0.216646,0.431977,-0.447154,0.131981,0.188024,0.363292,0.433617,1.483 +3397.77,0.928492,0.0848144,4,1.53326,0.793493,-0.877386,0.284154,-0.202524,-0.0554894,-0.0771289,-0.00254222,-0.0833159,0.0963628,-0.252801,-0.593284,0.144135,0.945591,0.0318682,0.725465,0.498125,0.129226,-0.0212863,0.298632,0.0778914,-0.685961,-0.515803,0.599629,-0.0458181,-0.416328,-0.185505,-0.799158,-1.11529,0.345359,0.979339,-0.539785,-0.23106,0.054104,-0.203706,0.233074,-0.65201,0.726431,0.58434,0.105291,0.856795,0.69283,0.428224,-0.384859,-0.12907,0.0921555,-0.00303807,0.376844,0.721485,0.182741,-0.0700803,-0.00512846,0.0367777,-0.292802,0.480546,-0.378848,0.00552352,-0.625609,0.260723,0.147435,0.745897,0.471538,-0.452245,-0.681452,0.227663,0.269486,-0.12346,-0.372765,0.0375136,0.255816,-0.424624,0.243919,0.540399,0.0745603,0.143096,0.267443,0.651147,-0.0957123,0.0353433,0.243461,0.568849,-0.313047,-0.0714764,-0.288159,-0.430537,0.121902,0.591535,0.00531323,-0.114484,-0.173303,0.154168,-0.534903,0.125064,0.242036,0.205254,-0.744575,0.269696,-0.494415,-0.323953,0.295015,0.564526,-0.0890205,-0.689671,-0.59509,0.266027,-0.529314,0.700806,-0.198761,0.0872182,0.709942,0.234508,-0.0867056,0.270656,0.773538,0.271787,-0.261092,0.289754,-0.211021,0.451337,-0.0799418,-0.210022,-0.0160229,-0.510483,0.410537,-0.201688,-0.401155,1.07994,-0.103095,0.45871,0.0895287,-0.467209,-0.21271,-0.147587,0.581608,-0.294327,0.195622,-0.0333865,-0.242244,0.354745,-0.381383,-0.587407,-0.567043,0.0985434,-1.06512,0.36565,0.610773,0.243072,0.473801,-0.139375,-0.580549,-0.191957,0.160567,0.0770093,-0.419585,-0.0263376,0.272952,0.0299335,-0.526293,0.267133,-0.236579,-0.142622,-0.262564,0.214114,0.0829846,0.72915,-0.296618,0.054561,-0.208213,0.129614,0.0514102,0.580785,0.271823,0.243256,-0.0421732,0.196539,-0.557519,0.0481193,-0.219545,-0.128804,1.04824,0.279308,-0.315785,0.665258,-0.0475053,0.619057,0.212967,-0.445564,-0.321122,1.10663,-0.15146,-0.302312,0.239478,0.0796707,-0.508877,-0.00539961,0.0321439,-0.0686976,-0.408708,-0.354171,0.357881,-0.0777277,-0.1409,0.0640316,0.16859,0.0284099,0.224299,-0.100071,0.829718,0.363641,0.338893,0.280029,-0.133245,0.22187,0.0930147,-0.681214,0.211005,-0.388427,-0.0601844,0.394981,0.183502,0.241427,-1.16839,0.0681753,0.488341,-0.83003,0.0776869,-0.0341725,-0.295551,0.104614,0.111172,-0.6632,0.265447,0.0895932,-0.323457,0.447335,0.397348,-0.488067,-0.234442,0.712731,-0.294381,-0.267732,-0.17579,-0.542587,0.107591,0.00949851,0.334573,0.701355,1.08587,-0.335171,-0.343079,-0.369287,-0.0111599,0.0792847,-0.366951,-0.0307301,-0.0414733,-0.183415,-0.459294,-0.0693218,-0.356677,0.843744,-0.239732,-0.0883651,0.314363,0.461802,0.103418,-0.137339,-0.294285,-0.0295081,-0.438789,0.100837,-0.386708,-0.593415,-0.0447895,-0.167633,-0.426988,0.386469,-0.617373,0.438858,-0.38201,0.424341,0.26201,-0.217272,-0.212399,-0.249667,0.152979,0.30932,0.296398,-0.0682908,0.264704,0.265898,0.509001,-0.0999501,-0.325454,0.115375,-0.197242,-0.215771,0.287511,-0.801924,-0.0814673,-0.354669,0.159599,0.264956,0.399498,0.514739,1.00812 +3407.6,0.85934,0.0848144,5,1.53274,0.740177,-1.43444,0.591548,0.678531,-0.0349834,0.289822,-0.0693851,-0.0249927,-0.0586815,-0.216486,-0.16708,-0.369111,0.452815,-0.421681,0.637072,0.568732,-0.309629,-0.192554,-0.169459,0.0529283,-0.78233,-0.821717,0.310019,-0.728194,0.302882,0.141971,0.412276,-0.0802648,-0.0573449,0.866107,-0.681596,-0.187143,0.388062,-0.070854,-0.150675,-0.119559,0.372426,0.216529,-0.325374,1.09375,0.688895,0.0751201,-1.1854,0.487034,0.230608,-1.64358,0.246902,0.311764,0.00450909,-0.188522,0.989398,0.391092,-0.237686,0.399007,-0.298522,-0.105477,-0.658645,-0.0252694,-0.390073,-0.302605,1.25003,-0.656098,-1.14974,0.241349,-0.0893199,0.0299195,0.438628,0.0206232,-0.432062,0.670237,0.124604,0.555808,-0.0108038,0.566905,-0.0348969,0.300528,-0.0482775,-0.446359,0.0352726,0.414264,-0.148127,0.221013,0.247693,-0.186794,-0.30311,-0.530101,-0.0887882,0.0902399,-0.353432,-0.0309903,0.29449,0.0484403,-0.120594,-0.276846,0.261684,-0.0158517,-0.218876,0.265989,0.141393,-0.218871,0.181605,0.229275,0.0396447,-0.043959,0.754287,-0.23675,-0.272786,0.46263,0.642706,-0.345982,-0.097997,-0.330673,0.363885,0.235405,0.199351,-0.521834,0.602873,-0.0308221,-0.0833021,-0.854933,-0.0642424,0.524153,-0.390957,0.0115787,0.626079,-0.478636,0.327662,0.466203,-0.195367,0.337621,0.12528,-0.083813,0.0651985,-0.629404,-0.0312252,-0.0222219,0.193458,0.544202,-0.462156,-0.182961,0.394046,0.0941417,-0.178864,-0.253177,-0.256518,0.227522,0.00853857,0.016895,0.416477,-0.109834,0.230603,0.175668,0.217488,0.176775,0.310569,-0.0152857,0.391073,-0.154716,-0.0808426,0.216084,0.311058,0.889463,-0.0982489,-0.742421,0.194063,-0.306272,0.0482387,-0.0652929,-0.245276,-0.43106,-0.343319,0.113016,0.0242101,-0.523703,0.500495,-0.244284,-0.0949774,0.614511,0.34687,-0.261283,0.437419,-0.424425,-0.165206,-0.692458,-0.86005,-0.294162,0.43848,-0.438071,-0.411665,0.293567,0.0170742,-0.224669,-0.938978,0.367084,0.0688367,0.134088,0.0558816,-0.514587,-0.0707107,-0.191431,0.285925,-0.311605,-0.345849,0.135119,-0.0833584,-0.816984,0.921229,0.0752124,-0.157066,-0.0639042,-0.283038,0.0250195,0.404832,0.131583,0.411156,-0.0469693,0.275676,-0.0363472,-0.506228,-0.351234,-0.313518,-0.263333,-0.100352,0.291246,0.541747,-0.278227,0.14234,-0.164804,-0.145688,0.446738,0.28593,-0.0795656,-0.0642327,-0.720381,0.682773,0.509635,0.311651,0.311552,-0.0346446,0.23085,0.248343,-0.0692354,-0.10548,0.574805,0.0669029,0.60426,-0.453535,-0.197724,-0.381395,0.576624,-0.947079,-0.0344013,0.164926,-0.449677,0.558824,-0.16148,0.507747,0.0756464,0.321393,-0.599975,0.253794,-0.0547102,0.366907,0.255034,-0.328046,0.205548,0.0132672,-0.215229,0.450728,-0.497885,-0.159682,0.186591,0.364537,0.327183,0.0251135,-0.261792,0.65362,-0.223809,0.504024,-0.616963,-0.453182,-0.365667,0.45323,0.204478,0.0894154,-0.186329,0.00899124,0.000661922,-0.473915,0.0135035,0.25395,0.023761,0.551886,0.0217486,-0.315123,0.0502095,-0.243979,0.492631,0.116098,0.0573307,0.145414,0.323081,0.381331,0.568402,-1.82702 +3406.53,0.690292,0.0848144,4,1.57218,0.710343,-1.5722,0.603065,0.236426,-0.101445,0.28817,-0.294228,-0.329199,-0.263877,-0.22614,-0.0306127,-0.170232,0.379452,-0.0731479,0.565629,0.77575,-0.216935,0.141429,-0.0783213,-0.19423,-1.01702,-0.336037,0.303718,-0.64564,-0.014668,0.0316028,0.505216,-0.0987422,0.08183,0.8994,-0.634753,0.277668,0.397557,-0.391307,0.00416606,-0.297502,0.63019,0.358584,-0.0582587,1.08606,0.253922,0.214401,-1.0334,-0.0998624,0.458989,-1.48491,-0.050814,0.341488,0.0722618,-0.114302,1.27256,0.200379,-0.311038,0.285657,-0.270461,-0.0444613,-0.995154,0.0571378,-0.406344,-0.198425,1.40849,-0.532962,-1.05442,0.00286279,-0.220483,0.0500792,-0.266518,-0.509713,-0.309199,0.148498,0.0714386,0.658692,-0.0695957,0.505052,0.0957891,0.509878,-0.197907,-0.305815,-0.0187737,0.494123,0.337761,-0.0161819,0.539906,0.0525508,-0.19095,-0.616476,0.0391402,0.000130086,-0.537493,0.0317757,-0.302114,0.21748,-0.0256737,0.193949,0.113212,-0.0348271,-0.33306,0.222217,0.255341,-0.179867,0.296706,0.00669147,0.0393738,-0.110281,0.578521,0.0371624,-0.622195,0.267464,0.89649,-0.643754,-0.0539685,-0.418708,0.477677,0.108166,0.14184,-0.399848,0.361623,0.458947,-0.200172,-0.99689,0.319791,0.715819,-0.106573,-0.0661387,0.72425,-0.0625442,0.760193,0.614233,-0.00139717,0.107845,0.0278036,-0.531868,0.181592,-0.563235,0.116953,0.100433,0.0675892,0.37939,-0.921899,-0.294013,0.216297,-0.366731,-0.114446,-0.711286,-0.412655,0.022618,0.161748,0.0563349,0.0504673,-0.361194,-0.0187114,0.387557,0.425113,0.502691,0.282753,0.140204,0.557934,-0.0370218,-0.0350524,-0.0424335,0.491035,0.702012,-0.831036,-0.561819,0.168832,-0.0671452,-0.259784,-0.304476,-0.236639,-0.274873,-0.426619,0.192106,0.0195157,-0.457287,0.0277686,-0.249733,-0.153819,0.529153,0.136284,0.210745,0.423977,-0.479545,-0.301459,-0.234448,-0.425977,-0.0411058,-0.0181162,-0.144452,-0.253728,0.121843,0.520103,-0.102206,-0.913514,0.303552,0.436863,0.13617,-0.208229,-0.550667,0.0205203,-0.174565,-0.0121696,-0.462257,-0.309175,-0.13761,-0.0180257,-0.790655,0.987502,0.291589,0.174943,-0.227893,-0.208204,-0.0672145,0.131289,0.429334,0.440608,0.0148841,-0.0329639,-0.18951,-0.161638,-0.127501,-0.46892,-0.457172,-0.120855,0.621882,0.460827,-0.641397,0.0671147,0.314414,0.126161,0.516675,0.17694,0.567365,-0.116839,-0.33006,0.633632,0.429841,0.380332,0.258947,-0.0713372,0.201958,-0.0667081,-0.279552,-0.00235744,0.266155,-0.00587301,0.90046,0.133493,0.296136,-0.120018,0.132521,-1.11999,0.154864,0.0947864,-0.172073,0.370856,-0.376778,0.461785,0.0663605,0.188038,-0.833077,-0.230613,0.159735,0.227321,-0.0168295,-0.172914,-0.0356337,-0.280976,-0.618938,0.10979,-0.124259,0.274852,-0.0356008,0.0853602,0.567734,-0.0776421,-0.189601,0.766222,-0.141508,0.193519,-0.741817,-0.198969,-0.317528,0.194543,0.27429,-0.0203396,-0.444544,-0.248708,-0.00549785,-0.251906,0.0272353,0.0987421,-0.0873901,0.19275,0.155113,-0.320957,-0.255138,0.119073,0.270798,-0.157539,0.341521,0.13475,0.28863,0.367084,0.537243,-0.189059 +3425.78,0.98734,0.0848144,4,1.56845,0.721393,-1.49275,0.538746,0.481616,-0.143595,0.243974,-0.384459,0.424065,0.0125648,-0.121045,-0.175215,-0.416969,0.204369,-0.0720285,1.00962,0.359047,-0.205833,-0.505526,0.0342015,-0.228092,-0.975897,-0.582965,0.466545,-0.498486,-0.286636,0.119545,0.563088,-0.451526,0.212553,0.835492,-0.594691,-0.283118,0.32388,-0.149333,-0.166919,-0.554161,0.564423,0.25339,-0.282685,1.12309,0.736084,0.512244,-1.04444,-0.170528,0.500752,-1.09919,0.51221,0.249623,0.251848,0.198064,1.25637,0.237103,-0.892025,0.504932,-0.30476,-0.0388836,-0.579944,0.437742,-0.163561,-0.055055,1.04393,-0.799628,-1.05104,0.191519,-0.187878,-0.194219,-0.163632,-0.608107,-0.455061,0.411131,0.0975388,0.65032,0.445343,0.508659,0.0661658,0.610978,0.0180853,0.000355442,0.457527,0.271257,-0.636132,0.106165,-0.174504,0.302533,-0.56569,-0.330513,0.0134243,0.0448892,-0.46572,0.0691653,-0.0178687,-0.0580094,-0.15774,0.27809,-0.389678,0.301745,-0.0549278,-0.251911,0.205591,-0.267534,0.130685,-0.174107,0.171895,0.160933,0.182885,0.506791,-0.36721,0.419302,0.598448,-0.174992,-0.0647219,-0.316766,0.547488,-0.269561,0.0531744,-0.512576,0.413053,0.101374,0.100683,-0.674308,0.090916,0.588192,-0.27269,-0.0719307,0.952948,0.524471,0.551709,0.44745,-0.147696,-0.0834627,0.242274,-0.402363,0.0929896,-0.364941,-0.0452005,0.223607,0.122648,0.350241,-0.421398,-0.326423,0.134734,-0.594959,-0.602591,0.0836482,-0.368213,-0.664552,0.340466,-0.264929,-0.0558014,-0.247016,0.0653101,0.131307,0.0401076,-0.0307732,0.416495,0.272424,0.0399277,-0.285191,0.0759094,-0.307492,0.112535,0.605491,-0.693607,-0.375341,0.0170007,0.190078,-0.492758,-0.0773375,-0.112023,-0.0561614,-0.582237,0.0997469,-0.12831,-0.113523,-0.227522,-0.393415,-0.156254,0.644745,0.244027,0.462482,-0.0736494,-0.299345,-0.14655,-0.123422,-0.224076,-0.527762,-0.00346472,-0.186374,-0.592078,-0.0877024,-0.337875,-0.694913,-0.411193,0.284834,0.453635,0.271442,-0.246111,-0.217031,0.0409928,-0.337906,-0.331457,-0.248184,0.0760291,-0.136573,-0.371648,-0.649718,0.843608,0.480594,0.492692,-0.742075,-0.672047,0.178052,-0.308387,0.218667,0.177493,-0.0955355,0.471265,-0.360978,-0.150356,0.0126477,-0.198511,-0.134549,0.140896,0.211867,0.661898,0.0831923,-0.211605,0.431207,0.330934,0.252184,0.214483,0.109696,-0.464956,0.00770548,0.497411,-0.0836597,0.287206,0.480689,-0.225964,0.485067,-0.189309,-0.0695274,-0.198956,0.217215,0.358632,0.56121,0.0637341,0.487657,-0.0952586,0.145528,-1.33811,0.0468225,0.376258,0.073962,-0.0273212,-0.173355,0.60314,0.0300233,0.223254,0.108901,0.234069,0.0136553,-0.324731,0.127339,0.111846,-0.0442917,-0.811799,-0.320337,-0.0722581,-0.26919,-0.175959,-0.0511416,0.0976538,0.076139,-0.419102,-0.133077,0.305813,-0.113897,0.142737,-0.789163,-0.553662,-0.212174,0.00177371,-0.0155788,0.0967877,0.413616,-0.222793,0.165776,-0.0566997,0.411466,-0.162504,-0.256416,-0.0925851,-0.101341,0.0342962,-0.188011,0.264154,-0.160323,-0.443615,0.269273,0.12421,0.346521,0.352434,0.588661,-0.996514 +3415.29,0.902901,0.0848144,4,1.47735,0.644254,-1.88663,0.920553,0.565706,-0.11152,-0.154874,-0.0875553,0.0978827,0.177364,0.191181,-0.270385,0.153392,0.42669,-0.307073,0.595701,0.613482,0.236023,0.12093,0.0483421,0.0754877,-0.631935,-0.691297,0.494004,0.16571,-0.0340621,-0.147782,0.24918,-0.0891622,-0.0972984,1.35217,-0.659466,0.338131,0.642769,-0.530599,-0.00743761,-0.385314,0.344605,1.02754,-0.111803,1.02754,1.19235,0.823886,-0.790523,0.128581,0.334602,0.121963,0.200405,0.342656,-0.160599,-0.241237,0.163497,-0.40584,-0.541239,-0.105628,0.168541,-0.0266463,-0.336268,0.188663,-0.369441,0.436782,1.28755,-0.546837,-1.21763,0.681277,-0.174894,0.481339,0.22704,0.508281,-0.139824,-0.183263,0.445596,0.867709,-0.320901,0.373814,0.349868,0.132537,0.00598917,-0.418494,-0.059035,0.844121,-0.0702192,0.477287,-0.0827374,-0.234349,0.452786,-0.00337031,0.101456,-0.101437,-0.628122,0.0248164,0.104458,-0.190855,-0.247061,0.0486954,-0.87488,0.413786,-0.361341,0.441584,-0.131511,0.23852,-0.377553,-0.0813957,-0.308275,0.382738,-0.260098,0.113443,-0.658601,0.0829112,0.665076,0.393542,0.34038,0.511297,0.579254,-0.206281,-0.339283,-0.1043,-0.429066,-0.0919422,0.15542,-0.857945,0.211183,-0.714297,-0.306479,-0.180881,0.176844,-0.414623,0.000878526,-0.0338061,-0.305524,0.178949,0.196357,0.0367847,0.340555,-0.320716,-0.418015,-0.0936011,0.121397,0.422046,-0.420446,-0.475075,-0.0486529,0.354807,-0.225412,0.103405,0.367577,0.118443,0.580137,-0.350759,-0.264531,-0.442934,-0.186714,0.0263584,-0.177378,0.522626,0.870255,-0.214899,-0.0098409,-0.14223,-0.512995,-0.00983714,0.0810612,0.133911,0.68813,0.00938246,0.177215,-0.250888,-0.0654881,0.123877,0.374274,0.236028,0.293991,0.141239,0.475038,0.00544697,-0.714211,-0.181145,-0.0340442,0.433817,0.495256,-0.286424,0.0278668,0.42721,-0.0891936,-0.0258662,-0.920672,-0.157099,-0.248252,0.675656,-0.613098,0.265568,0.709544,0.366135,-0.513999,-0.239276,0.213023,-0.454088,-0.0519423,-0.33933,-0.232044,0.311169,0.0447121,0.119282,-0.140341,-0.2862,-0.220315,0.173391,0.5162,0.0257629,-0.323969,0.519479,-0.040473,-0.354844,-0.141377,0.332698,0.138472,-0.587906,-0.51132,0.134354,-0.438459,-0.0140246,-0.0992476,-0.034135,0.472579,-1.03201,0.0847961,-0.17031,-0.21726,-0.212442,0.243397,0.412307,0.200088,-0.430035,-0.614577,-0.608698,0.282547,0.397374,0.411952,0.363158,-0.00324743,-0.21344,-0.0293668,-0.0197361,0.263616,-0.16352,-0.57653,0.399011,-0.22899,-0.161768,0.0565807,-0.164918,-0.129395,0.497082,-0.436605,-0.528169,0.433721,-0.306191,-0.450911,-0.0131254,0.312163,-0.0548535,0.43534,-0.00308867,0.0991366,-0.346649,-0.0418612,-0.341319,-0.0309766,-0.294785,-0.160222,-0.067135,-0.238821,-0.587298,-0.177166,-0.0175439,0.0329175,0.17892,-0.382248,-0.430621,0.207189,-0.1277,0.753599,-0.444821,-0.103327,0.0844004,-0.0299004,-0.746762,-0.0460685,0.369261,-0.343046,-0.07986,0.307824,0.277689,0.348065,-0.0812204,-0.186954,0.373114,-0.173216,-0.679641,0.132821,0.00171445,0.116664,0.254466,0.341561,0.504446,-1.39356 +3427.53,0.811661,0.0848144,4,1.52514,0.742093,-1.69422,0.765449,0.543048,-0.133197,-0.272111,-0.260535,0.319215,0.0855057,0.199516,0.0157117,-0.345246,0.3261,-0.194329,0.523685,0.199687,0.409436,-0.0474412,0.529186,-0.249622,-0.34626,-0.379394,0.0906694,-0.457011,0.500994,0.308805,0.134307,0.0124792,0.23136,0.962438,-0.590965,-0.330055,0.625289,-0.645204,-0.0812861,-0.378918,0.40315,0.936343,-0.272968,1.40611,0.894869,0.602245,-0.84234,-0.445528,-0.0967951,-0.177744,0.660803,0.683676,-0.16554,-0.099005,0.77535,-0.265475,-0.285978,0.0933391,0.211649,-0.157513,-0.325989,0.434974,-0.107376,0.532838,1.02396,-1.0279,-1.16009,-0.165572,-0.299089,0.390931,-0.102126,-0.1698,-0.40958,0.0335405,0.392196,0.876313,0.490778,0.150823,0.151669,-0.0436626,-0.169547,-1.02191,0.231026,0.135038,-0.732097,0.387776,0.160355,-0.132848,-0.375875,-0.01591,-0.400935,0.374572,-0.541353,0.0604369,-0.0184603,-0.351023,-0.246746,0.142555,-0.325529,-0.0461219,-0.517022,0.185716,0.102962,-0.0777761,0.0619629,-0.736367,0.102939,0.314073,-0.271565,0.263774,-0.482717,0.362375,1.01493,0.128921,0.222007,-0.0524878,0.340007,-0.00616199,0.244646,-0.796808,0.0534856,0.0588659,0.227642,-0.988982,0.232816,-0.609354,0.368369,0.0363877,0.639801,-0.56141,0.557028,0.496118,0.139907,0.124461,0.102221,0.185174,0.778682,-0.24313,-0.401834,0.0295541,-0.338998,0.514264,-0.885794,0.395249,0.331108,-0.0943362,-0.616994,-0.0179718,0.353178,-0.430376,0.236093,-0.257098,0.249365,-0.200872,0.0438713,0.485724,0.166588,-0.134685,0.994532,0.157623,-0.0144624,-0.262604,-0.0111902,0.493326,-0.0728163,0.704733,0.200603,-0.0486095,-0.253773,-0.337832,0.0684309,0.00372652,0.407271,0.456858,0.116487,-0.130194,-0.482207,-0.535149,0.0799422,-0.406819,-0.391258,-0.585789,0.406346,0.750227,-0.00768885,0.295695,-0.0146422,0.591723,-0.48688,-0.436744,-0.302088,0.0507324,0.403733,-0.0797068,-0.105743,0.195442,-0.474547,-0.173324,0.10553,-0.0177305,0.0124043,-0.777006,-0.328763,0.126399,0.0743126,-0.533431,-0.583764,-0.0616251,-0.489039,-0.53937,0.834299,0.815135,-0.128293,-0.821833,0.0987052,0.267753,0.0462401,0.0538893,-0.554569,-0.183819,-0.228936,-0.204008,0.129721,0.13199,-0.292314,0.231242,-0.0847872,-0.401795,0.0890446,-0.0763596,-0.0122387,-0.0321922,0.122006,0.238961,0.000773614,-0.357291,-0.12408,-0.279005,0.252347,-0.0840584,-0.0608576,0.365331,-0.218739,-0.43717,0.367887,0.180254,-0.12651,0.676506,0.0926137,0.493176,0.241646,-1.0344,-0.219689,-0.16985,-0.00391082,0.200545,-0.06582,0.0689022,0.11412,0.11963,0.192928,-0.244831,0.126101,-0.209642,-0.140696,0.0949644,0.216388,0.290656,0.339632,-0.10401,-0.180782,0.550968,-0.129553,-0.349254,-0.498774,-0.352746,0.0659169,-0.373551,0.0668563,-0.245452,-0.0653894,0.161059,-0.250315,0.0276983,0.31443,-0.167795,-0.405495,-0.27059,0.48774,-0.17722,0.135378,0.434253,-0.614849,0.313979,-0.329505,0.0916635,-0.124623,0.0796217,-0.285668,-0.0503853,-0.00195806,-0.382211,0.258032,-0.163148,0.144624,0.256531,0.380294,0.506489,-1.3921 +3416.81,0.897509,0.0848144,4,1.50915,0.63996,-1.75215,0.841545,0.696742,-0.119606,0.0471071,-0.25267,0.359613,-0.0491476,0.178392,-0.153577,-0.33203,0.209934,-0.0279117,0.594739,0.491214,0.598108,-0.147976,0.237899,0.0303408,-0.38433,-0.430564,0.400187,-0.506482,0.268772,0.443146,0.341517,-0.236765,0.542515,1.1844,-0.437029,-0.0739942,0.806893,-0.553726,-0.235386,-0.503213,0.626791,0.853981,0.304993,0.997066,0.868491,0.489411,-0.967663,-0.332558,-0.277753,-0.535089,0.452886,0.418642,-0.404626,-0.204985,0.692178,-0.174322,-0.512755,0.130032,0.171524,-0.157719,-0.287856,0.529175,-0.290853,0.619515,1.16226,-1.03266,-1.39405,0.220976,-0.289755,0.242547,-0.311942,0.00599191,-0.530294,-0.108299,0.389579,0.785443,0.421169,0.319183,0.316377,0.346451,-0.48129,-0.981258,0.218469,0.29122,-0.729012,0.633621,-0.0992958,-0.0938821,-0.772987,0.060527,-0.338697,0.277787,-0.63777,0.0975293,-0.0400487,-0.213058,-0.166317,0.242693,-0.312438,-0.504101,-0.723971,0.117182,0.0730177,-0.193891,0.295646,-0.326299,0.100137,0.597967,-0.344969,0.300454,-0.828845,0.713241,0.741292,0.0722258,-0.0947214,-0.0354319,0.46923,0.101314,0.302452,-1.11377,0.0636428,0.369123,0.124379,-0.991641,0.427633,-0.842587,0.489329,0.0717717,0.721335,-0.174163,0.297419,0.656338,0.147028,0.0202474,0.0320365,0.154561,0.712183,-0.274459,-0.697461,0.142983,-0.381727,0.419014,-0.774215,0.653961,0.322529,0.119534,-0.567467,-0.214169,0.269834,-0.546677,0.482414,-0.270547,0.410056,-0.389958,-0.082782,-0.0201815,0.251824,0.0581332,1.00216,-0.0900941,0.167041,-0.205155,0.259325,0.295441,-0.0405352,0.82209,0.191875,-0.074438,0.0521949,-0.260868,-0.00164652,0.105056,-0.00383339,0.399469,-0.130086,-0.0382694,-0.177996,-0.346357,0.540595,-0.396498,-0.40774,-0.369556,0.487683,0.275095,-0.192454,0.143808,0.226233,0.196815,-0.320399,-0.43161,-0.153167,0.218827,0.0109015,0.202879,-0.175144,0.40904,-0.491312,-0.303775,0.00782146,-0.0294943,-0.205104,-0.998185,-0.186467,0.0059985,-0.124132,-0.649644,-0.37274,0.149217,-0.197979,-0.574089,0.660748,0.64198,-0.454009,-0.667016,0.00316741,0.225725,0.0972195,-0.283523,-0.160706,-0.411815,-0.36319,-0.19713,0.268052,0.193303,-0.117527,0.016232,-0.2175,-0.0869071,0.0595074,0.0582126,-0.0712735,-0.0674899,0.0251869,0.249175,0.151402,-0.39216,0.0695916,-0.110575,-0.355548,-0.137657,-0.510216,0.431202,-0.0162459,-0.450346,0.268042,0.248518,-0.0786999,0.202496,0.309868,0.527131,-0.00697051,-1.11577,-0.309225,-0.239821,-0.339658,0.354738,-0.102243,-0.108635,0.0701005,-0.021424,0.119628,-0.162777,0.207405,0.0126819,0.105349,-0.248168,0.254612,0.40165,0.0692569,-0.0694854,-0.26074,0.612508,-0.128765,-0.449124,-0.136287,-0.0521586,0.23846,-0.159439,-0.24188,-0.372694,-0.103843,0.378231,-0.0163988,-0.318592,0.516809,-0.0850971,-0.0902825,-0.427825,0.27625,0.0717798,-0.249325,0.345914,-0.253878,0.0461986,-0.399621,0.157516,-0.0759069,0.250888,-0.28054,-0.0990392,-0.232195,-0.0676469,-0.0535365,-0.0180345,0.138075,0.273997,0.371585,0.523447,-1.78288 +3440.85,0.981563,0.0848144,4,1.48639,0.885436,-0.635244,0.314338,0.123964,-0.163802,0.163996,0.219094,0.324659,0.208574,0.0169848,0.104698,0.424683,0.598859,0.0760155,0.961129,0.260519,0.220202,1.02581,0.122969,0.00169396,-0.520899,-0.974064,0.570522,0.372103,-0.0796528,0.303367,0.227543,0.395965,0.0985454,1.23965,-0.215022,0.258721,0.113861,-0.749447,-0.101617,-0.105596,0.579966,0.5174,-0.612072,1.03946,0.756466,-0.179009,-0.916472,-0.126088,0.270235,-0.100492,-0.0281192,0.285549,0.199588,0.196883,0.71733,0.287957,-0.041768,0.194792,-0.0854157,-0.388297,-1.17609,0.649268,-0.0543566,-0.206479,0.975346,-0.137473,-0.352264,-0.0114502,0.621838,-0.1757,0.224412,0.694185,0.046062,-0.228155,0.230732,0.510488,-0.214361,0.657726,0.744158,-0.0218374,-0.233183,0.227383,-0.05303,0.476397,0.0711725,0.0120595,0.157565,-0.139632,-0.156333,-0.216148,-0.45813,-0.331905,-0.480468,-0.246163,0.124594,0.0641721,0.237378,-0.12818,-0.423233,0.387175,0.111149,-0.225978,0.0598894,-0.0487057,0.105656,-0.189934,-0.254406,-0.45801,-0.242001,0.239155,0.163058,-0.25224,0.321528,-0.210345,-0.163924,0.414018,0.674692,-0.391009,-0.252653,-0.111529,-0.363889,0.00346973,-0.235988,-0.390592,-0.399654,0.751313,-0.257219,-0.0443821,-0.00110204,0.289293,0.108685,-0.00110105,-0.332009,0.112606,0.14934,0.0260151,0.321886,0.134846,-0.238842,-0.582556,-0.0870835,0.262608,-0.336692,-0.997595,-0.14446,-0.0631513,0.137499,0.193546,0.0696141,0.0762391,0.330806,-0.434935,-0.476922,0.111355,0.0429071,0.265807,-0.0941513,0.397962,-0.034373,0.19933,-0.280976,-0.246491,-0.326517,0.673146,0.135288,0.66436,-0.386902,-0.0753729,0.336232,-0.00688311,-0.0195825,-0.238865,0.333838,-0.186074,-0.451499,0.170381,-0.0216354,0.450982,-0.3989,-0.657253,0.0133021,0.72363,0.473204,-0.0294135,0.157626,-0.00264757,0.127611,-0.322671,0.0184503,0.0296402,-0.0493826,0.0876231,-1.02089,0.0259708,-0.076371,0.0586864,-0.197096,-0.0310339,-0.164076,-0.172333,-0.279219,-0.162986,0.596503,0.130563,-0.296339,0.465179,0.297769,0.220429,-0.112598,-0.460773,0.723204,-0.332783,0.400999,0.353628,-0.373538,0.0880633,-0.0746895,-0.150824,-0.00617788,-0.457239,0.168953,-0.0443908,-0.831341,0.214716,-0.258437,0.402851,0.203546,-0.398311,0.562512,-0.219729,-0.261769,-0.0408074,0.0891649,-0.54066,0.340104,-0.0450389,-0.0872508,-0.325575,0.609722,0.00941199,0.731304,0.200086,-0.367564,-0.0658498,0.0957733,-0.429053,0.196625,0.277876,0.240474,0.55765,0.330082,0.382489,-0.00934097,0.184051,-0.567957,0.497808,-0.479097,-0.890075,-0.105474,-0.332637,-0.211119,0.549605,0.231714,0.209957,0.343374,-0.200927,0.192815,-0.399686,0.102377,-0.419689,-0.0341234,-0.196028,0.0988613,0.205297,-0.431556,-0.1376,0.146745,0.0850476,0.226552,0.143652,0.14137,0.333706,0.461311,0.289086,-0.318126,-0.550131,0.124201,0.329211,0.0110825,-0.182408,0.396667,0.015633,-0.0272442,0.328782,0.147028,-0.138591,0.378839,-0.779416,-0.661083,0.412424,-0.16446,-0.252924,0.0615419,-0.0514884,0.105374,0.338529,0.324614,0.581833,-0.413942 +3444.61,0.9043,0.0848144,4,1.46694,0.991061,-0.781021,0.413589,0.338274,-0.154846,0.167455,0.41896,0.725468,0.370543,0.161466,-0.146764,0.162991,0.315282,0.1251,0.902233,0.156354,0.253475,0.421764,0.276372,0.193905,-0.726146,-0.976514,0.402906,0.0906782,0.230336,0.359805,0.767359,0.141076,0.49665,1.26167,0.136571,-0.195187,0.526357,-0.283826,-0.121956,-0.530054,0.550656,0.291685,-0.633735,0.961948,0.453211,0.2027,-0.77002,-0.386892,0.0230921,-0.604566,-0.0452887,0.0800915,-0.205748,0.12005,0.757102,0.184472,0.0137505,-0.189451,-0.288099,-0.324586,-0.689484,0.362848,0.0589446,-0.0219301,1.19465,-0.985195,-0.87835,0.187805,0.0738013,-0.506384,-0.361143,0.319816,-0.190636,-0.693296,-0.00671799,0.867251,-0.424386,0.656763,0.123868,0.38098,-0.269347,-0.255518,-0.309632,0.543249,-0.173451,0.13804,-0.23137,-0.203078,0.296212,0.321295,0.126105,0.17916,-0.556065,-0.0747118,-0.577591,-0.0478146,-0.155011,0.146592,0.110519,0.131968,-0.578479,0.712507,0.391109,0.0186803,-0.0561564,-0.593462,-0.191823,0.871643,0.181751,0.277573,-0.201569,0.517725,0.373607,-0.172986,-0.632269,-0.418738,0.661925,0.274616,0.536387,-0.18088,0.139682,0.0266604,0.481851,-0.981007,-0.0879436,-0.573909,-0.299936,-0.00618169,-0.014679,0.604084,0.0803557,0.331569,-0.213599,-0.271509,0.01154,0.34654,0.789355,0.0464615,0.12676,-0.500574,-0.10168,0.218204,-0.457203,0.472652,-0.211193,-0.266859,-0.414606,0.0254564,-0.153954,-0.200411,0.267872,-0.240858,0.446899,-0.0028003,0.11871,0.0125055,0.250834,-0.0265298,0.265165,-0.0618379,-0.130137,-0.212646,0.214702,0.442579,-0.230054,0.51409,0.303248,-0.00473399,0.286362,0.189797,-0.0798008,-0.167187,-0.166963,-0.250459,0.115013,0.356782,-0.130413,-0.42963,0.165218,-0.079432,-0.480666,0.131801,0.325619,0.379004,-0.298964,-0.191317,-0.134483,0.289717,0.131445,-0.241565,-0.16099,0.458742,-0.221118,0.140948,0.423234,0.19932,-0.699004,0.0381556,-0.48249,0.420138,-0.356688,-0.600003,0.0185367,-0.359682,-0.638148,-0.0667531,-0.205023,0.0694412,-0.555594,-0.0570331,0.454504,0.384644,0.147251,0.19008,0.0112451,0.171059,-0.1722,-0.386869,0.577653,-0.128215,0.0708218,0.198493,-0.0491326,-0.48691,-0.121954,-0.0227645,-0.422133,0.198329,0.857198,-0.378153,-0.0887496,-0.190276,-0.152469,-0.213103,0.359239,-0.416657,0.0468735,-0.171352,-0.0802889,-0.238486,-0.582768,0.485755,0.00882437,-0.0625673,-0.250353,0.430096,0.0182885,0.081486,-0.127267,0.253192,0.432224,-0.38178,0.227894,-0.191608,-0.150876,0.765461,0.138424,-0.378186,0.0800303,-0.50444,0.0358413,0.133476,-0.179021,-0.0283926,0.279088,0.16214,0.0130926,0.170747,0.134752,-0.0821868,-0.303782,0.369433,0.236881,0.0767752,-0.290548,-0.462024,0.172935,-0.182171,0.464029,-0.0105591,0.665399,0.545278,0.360424,-0.0105505,-0.409766,-0.298441,0.278048,0.0154789,0.0592361,0.103793,-0.0448405,0.220355,-0.443222,0.371753,0.64599,0.403307,0.147494,-0.213406,-0.236112,-0.023161,-0.0531064,-0.0237579,0.0535628,0.280673,0.124003,0.225793,0.35214,0.475177,-1.35137 +3438.61,0.383171,0.0848144,4,1.38181,0.923412,-0.432005,0.279377,0.183015,-0.169431,0.451709,0.744263,1.01396,0.397913,0.17917,0.153524,0.0792968,0.566852,0.340703,1.09274,0.435558,0.115686,0.0426195,0.334068,0.169292,-0.725064,-0.846031,0.525957,0.761818,0.275812,0.172882,0.624608,0.00120694,0.350371,1.06965,0.0257939,0.0350697,0.412074,-0.56844,-0.469464,0.0602228,0.521225,0.12756,-0.476588,0.93461,0.165039,0.207689,-0.276573,-0.352336,0.290344,-0.881812,0.254659,0.142212,-0.0263498,0.125357,0.478165,0.125204,-0.511036,0.366783,0.240223,-0.516918,-0.624179,0.265659,-0.0253701,0.163091,1.10888,-0.892614,-0.221173,0.395767,0.120689,-0.0889097,0.0175214,0.59559,-0.0739374,-0.319438,0.321094,0.608518,-0.333363,0.626586,0.318909,-0.0173127,-0.599283,-0.392358,-0.255277,0.577521,-0.477396,0.0943259,-0.179397,-0.0286536,0.285654,0.15504,-0.0231838,0.0549888,-0.0648556,-0.484468,-0.622944,-0.150604,-0.0166259,0.103576,0.0310764,0.240496,-0.0606873,0.176488,0.268316,-0.0410267,-0.665975,-0.643147,0.133833,0.628378,-0.164845,0.164623,0.175958,0.273907,0.550904,-0.0903175,-0.235855,0.12015,0.475993,0.215256,0.2427,-0.388801,-0.161328,0.500101,0.358337,-0.533128,-0.045864,-0.370853,-0.00678511,-0.130263,0.163713,0.11613,0.116257,0.096857,-0.516718,0.0403867,0.168401,0.690011,0.722654,0.0785231,-0.234175,0.115019,0.277638,-0.0821012,-0.291159,0.0869543,-0.133815,-0.213329,-0.323284,0.0394036,-0.135757,-0.701425,0.312354,-0.494141,-0.211403,0.0315102,0.279636,-0.276414,0.43516,-0.149821,0.402655,0.137259,-0.0811742,-0.0127196,0.00811365,0.148089,-0.144725,0.674295,-0.323406,-0.240287,-0.476399,-0.284701,-0.0333349,0.0636262,-0.541219,-0.0299774,0.015922,0.267029,0.322567,0.164138,0.0453084,-0.0906768,-0.201799,0.083344,0.219928,0.472961,-0.236571,0.216289,0.475683,-0.187414,-0.579263,0.270107,-0.155182,0.697742,-0.304679,0.11782,0.0483424,0.064846,-0.567082,0.12543,0.0871022,0.0383308,-0.501098,-0.731953,-0.131982,-0.262344,-0.29722,-0.0785475,-0.746205,0.053722,0.0311936,-0.582774,0.868026,0.545789,-0.00190368,0.000847752,-0.0365434,0.191957,0.2262,-0.0653201,0.320138,0.174773,-0.0404992,0.405954,0.607448,-0.661103,-0.383672,-0.314224,0.159272,-0.22376,0.672364,0.0240522,0.043119,0.199391,0.130425,0.259731,0.392314,-0.637236,0.357899,-0.180708,0.540529,0.159336,0.160942,0.185643,-0.35892,-0.0746557,-0.170902,0.209967,-0.304428,-0.00948318,0.303256,0.288229,0.148197,-0.0223087,0.108582,-0.349397,-0.0273958,0.695892,0.168512,-0.209222,0.290702,-0.37538,0.00601078,-0.0169325,0.284883,-0.174083,0.299535,-0.135637,-0.356988,0.283156,0.0793236,-0.0275339,-0.415569,0.36502,0.110128,-0.340944,-0.247089,-0.201177,-0.0698258,0.210217,0.507466,0.363846,0.512536,0.37206,0.0711073,-0.295695,-0.385759,-0.789847,0.110044,0.141112,0.24476,-0.429518,-0.213667,0.105864,-0.44862,0.25589,-0.213675,0.0499914,-0.0371556,-0.216785,-0.489381,-0.401355,0.146749,-0.213149,-0.211923,-0.621872,0.0983328,0.327697,0.313581,0.572449,-0.853922 +3437.5,0.772669,0.0848144,4,1.52486,0.97284,-0.416152,0.2315,0.0565347,-0.176726,0.221645,0.925765,0.969369,0.0255021,0.111348,0.0193016,0.129631,0.533414,0.140314,0.601667,0.320017,0.224783,0.232151,0.270067,0.1385,-0.827072,-0.155912,0.299742,0.244539,0.233174,-0.116718,0.651109,0.31609,0.275417,0.975741,-0.0861531,0.0750046,0.208888,-0.31499,-0.355697,-0.00698898,0.254597,0.383712,-0.00226682,0.985302,0.513055,-0.426052,-0.266221,-0.393303,0.109766,-0.195905,0.489075,0.135875,-0.141036,-0.0255578,0.561562,0.0296299,-0.663502,0.164603,0.244285,-0.497001,-0.300931,0.300907,-0.113011,-0.414211,0.972685,-0.670557,-0.118154,0.147859,0.0253598,-0.221337,-0.0363467,0.520417,-0.0955381,0.199469,0.240773,0.520855,-0.348518,0.688979,0.31979,0.467764,-0.45404,-0.476611,-0.237924,0.449994,-0.513511,0.0274493,-0.262646,-0.190506,0.42739,-0.262513,0.291633,0.286091,-0.571355,-0.131627,-0.121086,-0.449989,0.0036915,0.38785,0.121921,0.0772465,-0.135274,0.332859,0.183453,0.100895,-0.664125,-0.108299,-0.116637,0.336628,-0.426631,0.252953,0.0175243,-0.189737,0.775754,-0.516693,-0.111057,-0.00338876,0.508235,0.337793,0.214716,-0.327737,0.00305895,0.200834,0.420417,-0.215554,-0.125336,-0.47195,-0.120003,-0.11348,-0.358022,0.191979,0.35581,0.0890803,-0.469788,-0.0278175,0.238992,0.38519,0.542631,-0.317667,-0.272277,-0.465917,-0.0656579,0.222019,-0.131694,0.332018,0.0166189,-0.242081,-0.966625,0.382289,0.113799,-0.377176,0.352194,-0.30382,0.0547221,0.0804416,0.556448,0.139129,0.478424,0.168615,0.485477,-0.0708637,-0.10853,0.0303261,0.312087,0.353857,-0.230343,0.607787,0.00934937,-0.513613,0.157901,-0.316257,-0.129434,-0.425831,-0.128025,-0.318802,-0.392445,0.0331962,0.114986,0.444153,-0.35295,0.0986529,-0.0601813,0.533392,0.479931,-0.126016,-0.300893,0.0116244,0.0511164,-0.0693316,-0.22506,0.210424,-0.268922,0.327612,-0.291652,-0.10002,-0.221402,0.0192626,-0.208975,0.200085,0.594766,0.253308,-0.222545,-0.210419,-0.0353817,-0.361484,-0.111201,-0.0802275,-0.68808,0.154383,0.0827836,-0.760671,0.861875,0.485917,0.448363,0.110116,-0.383387,0.0688032,0.153421,0.270207,0.163367,-0.60649,-0.1884,0.465643,-0.00621012,-0.302461,-0.626164,-0.635076,0.28449,-0.0922878,0.691451,-0.24541,-0.0268803,-0.0460855,0.0219728,0.194956,0.0314141,-0.555197,-0.347463,0.0223429,0.263088,-0.028657,-0.288936,0.386787,-0.246341,-0.368108,0.43233,0.100328,-0.886013,0.142618,0.0631064,0.485227,0.167532,-0.222137,0.0241259,-0.53775,-0.344025,0.549685,0.00857642,-0.549184,0.367592,-0.406252,0.214605,-0.0684401,0.0633273,-0.248134,0.0292726,-0.320257,-0.402628,-0.0641908,0.223996,0.0506512,-0.25916,0.136813,0.130737,-0.0837661,-0.317404,-0.0219757,-0.21337,-0.265355,0.39104,-0.113222,0.287194,-0.255256,-0.201553,-0.289203,0.0563123,-0.284006,0.204513,0.221889,0.0111632,-0.385905,0.135129,0.271896,-0.178165,0.216069,-0.178708,0.0720428,-0.301114,-0.441,-0.651803,-0.248748,-0.217155,-0.0177453,-0.070381,-0.362344,0.112697,0.174126,0.335703,0.417284,-0.339467 +3447.38,0.787663,0.0848144,4,1.52812,1.08773,-0.253414,0.133456,0.152741,-0.157358,0.711194,0.273624,0.262596,0.380376,-0.0755311,-0.271092,0.186676,0.271783,0.361906,1.30094,0.126719,-0.0454897,0.0654616,-0.300649,-0.190692,-0.687605,-0.650979,0.112961,0.162392,0.278463,0.610249,0.611595,-0.0995709,0.0469849,0.977312,-0.214034,0.0467573,0.254959,-0.622729,-0.101216,-0.680901,0.583278,0.0691312,-0.359844,0.832423,0.301687,0.201201,-0.99489,-0.0722056,-0.193726,-0.671631,-0.0607746,0.383173,0.0305335,0.300412,0.431916,0.230018,-0.599671,0.460855,-0.0940185,-0.113755,-0.738167,0.471383,-0.511488,0.45519,0.963688,-0.469452,-0.782847,-0.0323437,0.559144,0.0537926,-0.060325,0.246109,-0.477344,-0.50818,0.443224,0.694147,0.0133063,0.576472,0.406281,0.280312,0.0288589,-3.24645e-05,0.0421243,0.577457,0.0230211,-0.07967,-0.420914,0.0752546,0.409611,0.134894,-0.177657,0.262491,-0.328065,-0.0275354,0.56065,0.176689,0.00642308,0.250917,-0.509949,-0.276528,-0.247181,-0.365128,0.0760819,0.208528,-0.636862,-0.514484,-0.393041,-0.0522961,-0.0820229,0.383422,-0.265974,0.297526,0.410782,0.182627,0.0959948,0.645612,0.235633,-0.235703,0.113632,-0.374021,0.0872623,-0.0771868,0.467266,-0.63649,0.407759,-0.448244,-0.227398,-0.500635,-0.040801,0.0746786,-0.365298,0.157277,0.125404,0.618219,0.116296,-0.0571414,0.849663,-0.324559,-0.525621,-0.022107,0.292711,0.0745435,-0.590951,-0.282951,-0.208832,0.0839651,-0.759293,0.211624,0.408923,-0.407528,0.226088,0.0166208,0.137411,0.108481,-0.192654,0.22335,-0.375868,0.570015,0.276011,0.656575,-0.291926,0.302463,-0.192489,0.288122,-0.322763,0.599307,-0.297723,-0.177214,-0.0983488,-0.221073,-0.0647814,-0.414402,-0.667947,0.0373053,-0.144204,-0.0850072,-0.44728,-0.0066463,0.263291,-0.805255,-0.150843,0.132136,0.479742,-0.381125,-0.205115,-0.0772311,-0.216945,-0.346845,-0.0187358,0.101412,-0.172727,0.193216,-0.598833,0.0670138,0.41755,-0.499833,-0.275248,-0.086601,-0.0935095,0.248349,-0.798222,-0.357334,-0.0163392,0.1024,-0.124809,0.343897,-0.236696,-0.163982,0.0669247,-0.130147,0.757466,-0.32541,0.117275,0.00225641,0.011147,0.0129768,-0.366669,-0.579007,0.100203,0.236857,0.197849,0.0248101,-0.415901,-0.198464,-0.442086,-0.0988859,-0.0717618,0.0314476,0.279895,-0.379677,-0.320494,0.164652,0.00762233,-0.521172,0.020206,-0.52937,-0.00213499,-0.285862,0.251442,0.0530831,-0.0946111,0.235084,-0.252774,-0.325347,0.0249898,0.105651,-0.957898,0.192313,0.577823,0.255485,0.593509,0.0132614,-0.126082,-0.984008,-0.365627,0.559854,0.160883,-0.205855,0.488613,-0.192712,-0.280917,-0.138161,-0.0355199,0.506095,0.113841,0.028501,0.0331012,-0.115188,0.307314,-0.0687893,0.264026,0.108296,0.247292,-0.21274,-0.193498,-0.395043,0.163299,0.306654,-0.238743,0.280531,0.0652654,0.522902,0.402648,0.446698,-0.213211,0.218687,0.280152,0.575475,0.05517,-0.412095,0.0848748,0.150526,-0.546373,-0.0467099,-0.0252545,-0.259678,0.211667,0.0332921,-0.49906,0.0939399,-0.446735,0.0294689,0.534979,0.442027,0.106062,0.19864,0.325671,0.445691,-0.856078 +3423.6,0.97624,0.0848144,4,1.52605,1.15236,0.0144534,-0.0862614,0.223995,-0.176245,-0.415727,0.717909,0.81536,0.439948,0.150346,0.0211533,0.238263,0.492491,-0.30193,0.822654,-0.0181695,0.205092,0.0697953,0.106475,-0.497395,-0.948765,0.22062,-0.0554003,-0.240154,-0.0332438,0.26739,0.187423,-0.100327,-0.197076,0.441145,0.0330779,-0.0283687,0.0600858,-0.212711,-0.316364,-0.0172976,0.0195026,-0.146282,-0.0145609,0.791707,0.440128,0.0587851,-0.194789,-0.222589,0.309295,-0.331307,0.0984894,0.434321,-0.117753,0.211204,0.136418,0.0177591,-0.391429,0.767224,-0.00999947,-0.18075,-0.392066,0.555298,0.258844,-0.260549,0.842944,-0.848726,-1.1332,0.168403,-0.0572343,0.16018,-0.119808,0.534059,-0.701329,-0.627911,0.33064,0.308019,-0.0242186,0.0614263,0.368027,0.353576,-0.375591,-0.396232,-0.0306591,0.126102,-0.875633,-0.00620551,-0.509646,0.0650999,-0.224932,-0.573369,0.0677598,0.747221,-0.101969,0.0330187,0.185899,-0.00383975,-0.0361205,0.363381,-0.837215,0.20982,0.0382273,0.638739,0.0611864,0.0495647,-0.162865,-0.787405,-0.511395,0.784291,0.264613,0.125495,-0.337142,0.285216,0.162547,0.609694,-0.212031,0.325559,0.373133,0.452649,-0.0337356,0.0750369,-0.0878783,-0.243576,-0.15452,-1.10395,-0.01127,-0.505864,-0.696789,-0.180773,0.0784887,-0.168837,0.0131955,-0.274593,-0.194687,-0.309041,-0.0698184,0.462746,0.349544,-0.0308962,-0.223502,0.105303,-0.125681,0.270213,-0.280963,-0.513589,0.0275242,-0.00386354,-0.668167,-0.567622,0.168541,0.194527,0.720675,-0.0831918,-0.346479,0.228321,0.0285417,0.532304,-0.00587681,-0.0106666,0.303925,0.335862,-0.252135,0.185438,0.358407,0.039666,0.261114,0.68995,0.67282,0.0689927,-0.336693,0.10603,0.0216742,-0.0404798,0.279349,-0.141021,0.0670485,-0.0523779,-0.125609,-0.102913,-0.485475,-0.38093,-0.358393,0.457088,0.398855,0.0753247,0.282303,0.120478,0.142406,0.282316,-0.203964,-0.114513,-0.506285,-0.139795,-0.367295,-0.345363,-0.35055,-0.0851912,-0.309766,0.0661495,0.214153,-0.069373,0.0520195,-0.745578,0.187842,-0.102374,-0.266099,-0.00754128,0.331199,0.365381,-0.0662069,-0.603579,1.24365,-0.356505,0.355762,-0.0962573,0.0290146,0.721754,0.335606,0.401704,0.425032,-0.308441,0.360229,0.0429077,0.391011,0.148224,-0.459577,-0.303012,-0.0585892,-0.140344,0.213155,-0.225119,-0.337332,-0.119705,-0.356627,-0.377371,-0.0592415,-0.024622,-0.343725,0.124806,0.0763626,-0.0512413,0.482206,0.672416,-0.163088,0.0280484,-0.198508,0.154912,-0.123922,0.724784,0.3308,0.249822,0.184548,-0.843351,-0.166061,0.140052,-0.539404,0.192605,-0.690117,0.0181495,0.365139,-0.248567,0.112254,-0.764066,0.0653275,0.104715,-0.0213372,-0.348442,0.185009,0.0112966,-0.292796,0.410183,0.157939,-0.572577,-0.122928,-0.347324,0.0696168,0.25998,0.401201,-0.113083,-0.668347,0.232336,-0.274091,0.279341,-0.305502,-0.365135,0.109212,-0.399684,-0.601136,0.0367763,0.210375,0.101431,-0.00875375,0.484505,0.139381,-0.0046412,0.0594245,0.31061,0.179507,0.0861639,-0.295832,-0.255253,0.254614,0.144305,-0.157409,0.183072,0.136739,0.164044,0.369783,0.405023,-1.1366 +3424,0.965591,0.0848144,4,1.62728,1.04224,-0.112378,-0.0837011,0.111427,-0.0698744,-0.514899,0.391104,0.495051,0.132553,-0.0942338,0.260878,0.311163,0.707401,-0.353058,1.35254,0.102781,-0.15718,0.150543,-0.195813,-0.268205,-1.14455,-0.41467,0.0110221,-0.24678,0.0696395,0.458315,0.195831,-0.208211,0.0465059,0.337036,0.224693,0.109691,-0.130858,-0.25195,-0.273381,-0.210188,0.193431,0.00286406,-0.324818,1.00381,0.539233,0.0650365,-0.456063,-0.253709,-0.0040083,-0.333244,0.678915,0.687077,-0.10999,0.201957,-0.0580572,0.0618608,-0.553309,0.980211,0.19754,0.0543588,-0.440191,0.686386,-0.192841,-0.122738,0.645143,-0.492633,-0.999463,-0.114943,0.11667,0.309041,0.002988,0.0552655,-0.700376,-0.311308,0.167522,0.173946,0.107141,0.251315,0.606993,-0.113306,-0.445233,-0.180167,-0.190856,0.425236,-0.985734,0.400737,-0.386653,0.103968,-0.0493396,-0.011617,0.00380152,0.0329699,-0.0619634,-0.308245,0.341941,0.136805,-0.463647,0.573601,-0.774291,-0.200876,-0.491131,0.544565,0.168902,0.0848789,0.0418611,-0.507382,-0.266602,-0.116477,0.134102,0.11815,-0.517487,0.17376,0.244378,0.175803,-0.0253636,0.544244,0.366747,-0.106751,-0.0535086,-0.0618695,0.0398458,-0.296235,-0.60372,-0.662828,0.0408896,-0.193393,0.00591377,0.0643456,0.522616,0.103703,-0.590038,-0.121016,-0.484268,-0.0687954,-0.260232,0.238019,0.74357,-0.0938048,-0.00408968,-0.0464022,-0.251898,0.14785,0.0738566,-0.511157,-0.287448,0.289913,-0.239878,-0.202102,0.435855,0.213124,0.638412,0.123885,-0.0638496,0.326904,0.255882,0.381757,-0.029403,0.286598,0.471967,0.456535,-0.833217,0.334188,0.166787,-0.380573,-0.358881,0.884755,0.67683,-0.0216278,-0.315327,0.0340806,-0.40108,0.0533661,0.22979,-0.221411,0.0641815,-0.166708,0.0568548,-0.0448809,-0.0970403,-0.794291,-0.0936376,0.65132,0.6577,-0.214511,0.152577,0.174524,0.188832,-0.0933125,-0.461401,-0.081125,-0.432906,-0.104408,0.103538,-0.482776,-0.244666,-0.505259,-0.666423,0.336614,0.16094,0.253086,-0.252407,-0.838973,0.406811,0.0912551,-0.0985475,0.335589,-0.371416,0.104831,-0.486922,-0.591608,1.13621,-0.13634,0.309439,0.259508,-0.0612957,0.741796,0.115501,0.247733,0.324903,-0.880153,-0.110777,0.17493,-0.304923,-0.37738,-0.352152,-0.213221,0.316946,-0.16107,0.075491,-0.526842,-0.350791,0.224648,0.0450111,-0.111203,-0.209872,-0.690984,0.0300657,-0.140251,0.149788,0.0401856,0.0635324,0.367539,-0.43128,0.156231,-0.200349,-0.0755276,-0.0227713,1.04001,0.114508,0.465825,0.228394,-0.385668,-0.407541,0.098817,-0.434786,0.564488,-0.781987,-0.00152804,0.40966,-0.148555,0.584058,-0.35219,-0.0472552,0.482425,0.213752,-0.30732,0.557966,0.0729988,0.12231,-0.0794243,0.552663,-0.240473,-0.366595,-0.513595,0.0800523,0.0479425,-0.124791,0.321532,-0.273554,0.288247,-0.0983034,0.293463,-0.218468,-0.351917,0.238429,-0.723283,-0.585716,0.309276,-0.138307,-0.0333184,-0.058971,0.512457,0.121221,-0.0524215,-0.130273,0.372719,0.111022,0.0527638,0.0564251,-0.473963,0.0137527,0.259226,-0.124329,0.282486,0.122263,0.212885,0.349662,0.461395,-0.429382 +3431.76,0.807122,0.0848144,5,1.56996,1.03938,-0.237919,-0.0247882,-0.0141666,-0.0907636,-0.58627,0.340979,0.3449,0.110322,-0.0619714,0.213528,0.264553,0.624828,-0.27798,1.26731,0.018574,-0.0915377,0.212607,-0.271132,-0.202241,-1.1023,-0.331658,-0.0353732,-0.149564,0.120259,0.4406,0.205791,-0.353083,-0.0563176,0.307724,0.111728,0.15297,-0.226382,-0.403521,-0.210138,-0.287061,0.108433,0.0631136,-0.555451,0.930326,0.357899,-0.0288286,-0.189333,-0.288719,-0.0642027,-0.359531,0.589908,0.661264,-0.0885328,0.201791,-0.0638528,0.0830577,-0.227129,0.965109,0.164382,0.00868166,-0.338734,0.694851,-0.170816,-0.124639,0.561412,-0.510531,-0.841023,-0.423853,0.103895,0.429255,0.0602601,-0.0434668,-0.608036,-0.162157,0.163754,0.275088,0.0566714,0.237772,0.603202,-0.00467319,-0.538992,-0.176435,-0.244155,0.506688,-0.867461,0.396819,-0.406882,0.0996833,-0.0289154,0.00489881,-0.0415224,0.0536574,-0.0708439,-0.343539,0.243317,0.0429823,-0.466651,0.601336,-0.626275,0.0672137,-0.53671,0.486266,0.193142,0.181369,-0.0140203,-0.404543,-0.241174,-0.0179063,0.127149,0.154754,-0.436104,0.0763413,0.331817,0.110951,-0.0660435,0.544033,0.313795,-0.248726,-0.179384,0.0133202,-0.0323558,-0.310336,-0.675764,-0.603822,-0.000694507,-0.0936265,0.131378,0.0264669,0.44915,0.305344,-0.567896,-0.0353997,-0.474235,-0.135022,-0.374662,0.376407,0.460242,-0.13864,-0.0251701,0.0772898,-0.278727,0.120258,0.144649,-0.497881,-0.259156,0.201101,-0.518996,-0.318695,0.242697,0.124048,0.635243,0.209667,0.119249,0.160544,0.236013,0.226936,0.101563,0.207864,0.438715,0.508579,-0.905787,0.284483,0.114221,-0.447989,-0.379766,0.926608,0.611939,0.0274215,-0.203621,-0.0402122,-0.419277,-0.011792,0.233756,-0.211969,0.138464,-0.165367,0.158952,-0.117884,-0.0592848,-0.756373,-0.270278,0.620636,0.694594,-0.474686,0.188755,0.266437,0.247929,-0.0409538,-0.546922,-0.159416,-0.483423,-0.192054,-0.0797263,-0.394205,-0.125689,-0.501876,-0.631246,0.338638,0.0342745,0.266927,-0.199648,-0.837277,0.369177,0.0225304,0.0241092,0.210907,-0.413711,0.0193912,-0.507297,-0.445577,1.24227,-0.31793,0.312112,0.325097,-0.122249,0.705299,0.122481,0.0374272,0.403504,-0.696229,-0.0493703,0.322586,-0.222068,-0.213075,-0.434874,-0.18199,0.292293,-0.00604511,0.0955668,-0.488682,-0.417429,0.22217,-0.0470506,-0.0880135,-0.157816,-0.556045,-0.0711847,-0.108358,0.130528,0.106887,0.126721,0.450583,-0.243152,0.151071,-0.12761,-0.210876,0.0440087,1.05813,0.190716,0.541685,0.19412,-0.325575,-0.376513,0.081883,-0.157796,0.656409,-0.661173,-0.305021,0.324939,-0.183528,0.737694,-0.421432,0.0601576,0.276401,0.126965,-0.265566,0.608781,-0.000192439,0.0959708,-0.0430427,0.393103,-0.327079,-0.259192,-0.561939,0.0368536,0.0246657,-0.0864428,0.255444,-0.248939,0.273544,-0.107443,0.314321,-0.102821,-0.260894,0.0701563,-0.803614,-0.650367,0.294303,-0.0374443,0.111443,0.0908092,0.441053,0.187296,-0.145055,-0.164458,0.27007,0.095909,0.163019,0.324421,-0.393734,0.122931,0.117961,-0.313159,0.0568997,0.130606,0.183997,0.361395,0.428948,-0.0493801 +3444.15,0.950528,0.0848144,4,1.50141,1.20985,-0.00608508,-0.16234,-0.0784618,-0.199697,-0.148816,0.549306,0.825548,0.703106,-0.0704511,0.00865479,-0.0984037,0.38256,-0.0141279,0.945589,-0.174415,-0.0991091,0.0941111,0.0177058,-0.487234,-0.881828,-0.499685,-0.114902,-0.487887,0.135159,0.28646,0.674688,-0.00644306,-0.189738,0.590154,-0.200713,-0.0390308,0.442951,0.15392,-0.211068,-0.0595719,0.807965,0.070061,-0.623572,1.14699,0.27544,0.512495,-0.528652,-0.00369996,0.164509,-0.626497,0.238216,0.498361,0.089921,0.303627,0.0634081,0.0382639,-0.384187,0.841603,0.00381098,-0.25498,-0.813972,0.532828,-0.321406,0.260817,1.19181,-0.909705,-0.945064,-0.0361669,0.152231,-0.143898,-0.212644,0.247387,-0.925059,-0.022381,0.732951,0.260564,-0.0980518,0.586982,0.775388,0.202199,0.118995,-0.0814215,0.365296,0.549168,-0.337901,-0.00660552,-0.210646,-0.183406,0.259475,0.27075,-0.454068,0.0515459,-0.189826,0.276787,-0.0680036,0.0336478,-0.342889,0.105943,-0.368025,-0.0174461,0.289014,0.420449,0.0614424,0.16731,0.194932,-0.475053,-0.382825,0.371253,-0.0929583,0.146343,-0.0846501,0.0279767,0.662697,0.0221253,0.0941686,-0.517123,0.237553,0.162341,0.145746,0.338217,0.0681374,-0.053701,0.239146,-0.845143,-0.276872,-0.235917,-0.116436,-0.0995613,0.156336,0.272859,0.441997,0.166615,-0.493857,-0.0904134,-0.158494,0.629493,0.506272,-0.240553,0.020443,0.0775762,0.238728,0.0551851,-0.57829,0.00126211,0.00992569,-0.10123,-0.308953,0.014832,0.447068,0.18735,0.43435,0.216829,-0.182168,0.280464,0.0197877,-0.206303,0.0465789,-0.0908927,0.35889,0.455416,0.232737,0.0076699,-0.344363,0.404695,0.237235,0.412341,0.0348033,0.482269,-0.0730802,-0.0876412,0.0609413,-0.247068,-0.429812,0.210066,-0.214554,-0.055655,0.272462,0.0761477,-0.223633,-0.171177,0.403979,0.0300745,0.644052,0.148066,0.500683,0.030343,0.190616,-0.627888,-0.122251,0.0555322,-0.167566,-0.0290096,-0.42055,-0.000538091,0.414838,0.0280671,-0.311768,0.242365,-0.112236,0.119485,-0.422109,-1.52221,0.190697,-0.174888,0.2695,0.487127,0.280192,-0.100179,-0.117356,0.018667,0.997864,0.43943,-0.0734337,-0.341661,0.00171336,0.426928,-0.0542903,-0.149425,0.327426,-0.0457902,0.045193,0.126323,0.263904,-0.0777735,-0.692479,0.379087,0.209932,-0.339942,0.297056,0.0586969,0.0351524,-0.165292,0.112279,0.250446,0.0468346,-0.705167,-0.128422,0.483812,0.227655,0.000957459,-0.11463,0.211651,-0.0897362,-0.324643,-0.0147805,-0.278136,-0.327537,-0.110565,0.248604,0.158528,0.362284,0.2466,-0.409017,-0.192523,-0.0804826,0.513832,-0.103044,0.0194736,0.220943,-0.281573,-0.256683,-0.09295,0.201374,-0.572018,0.466284,0.0239065,-0.565321,0.677055,0.176211,0.20948,0.0678929,-0.339057,-0.100135,0.50206,0.165289,-0.324111,-0.0865711,-0.135363,0.073786,-0.216014,0.0803174,0.711001,-0.197447,0.442369,-0.234909,-0.474189,0.103282,0.0337357,0.163198,-0.290541,0.2822,0.298217,-0.411329,0.138555,-0.488863,0.054665,0.144328,-0.225216,-0.529993,0.0560993,0.0421727,0.0854176,0.0253905,0.196643,0.0914417,0.231505,0.302393,0.481149,-0.170003 +3394.43,0.814301,0.0848144,4,1.61678,0.911513,-0.894872,0.436585,0.437442,0.0274711,0.566027,0.422498,0.0740382,0.0146588,-0.0686462,-0.0744081,-0.21222,0.55637,-0.598029,0.998202,-0.113811,-0.307179,-0.184131,-0.00271055,-0.2766,-0.503936,-0.469473,0.356875,-0.560647,-0.344612,-0.197933,0.39477,-0.772326,0.00425605,0.621873,-0.341116,0.31292,-0.0829503,-0.471586,-0.269106,-0.488672,0.393954,0.387643,-0.263221,1.23358,0.44753,-0.0180977,-0.47251,-0.0902667,-0.908475,-0.740761,0.406657,0.406488,0.0783151,-0.25923,0.367749,0.181814,-0.27585,0.358634,0.161244,-0.0679919,-0.767505,0.578535,-0.233176,-0.156567,1.1468,-0.675271,-1.08233,0.335785,0.386954,-0.382714,0.44434,-0.186115,0.304483,-0.212662,0.163043,0.300489,0.581814,0.303507,0.211773,0.877853,-0.253042,-0.800094,-0.0285965,0.233958,-0.630321,0.145608,1.10359,-0.675764,-0.105823,-0.022858,0.11463,0.7782,-0.0506076,-0.0120366,-0.329766,0.106514,-0.0626993,0.149609,-0.172249,-0.108737,0.43447,-0.0561454,0.189525,0.254204,-0.0163628,-0.16888,-0.291959,0.376219,-0.131541,-0.123491,-0.538031,-0.0509731,0.447855,-0.497277,-0.203289,0.866611,0.338917,-0.210015,0.371616,-0.569727,-0.306978,0.10292,0.0409098,-0.394573,0.251381,-0.0778575,-0.478549,-0.104798,-0.212968,-0.491771,-0.0448938,0.481303,-0.0486659,0.946974,-0.351089,-0.265181,0.829838,-0.106142,-0.385906,0.117255,-0.661695,0.589686,-0.66163,-0.886881,-0.229977,1.04431,-0.278763,0.538718,-0.114878,0.215677,0.604577,-0.0841405,-0.0241778,-0.0647309,-0.0124039,0.0358873,0.278255,0.496012,0.30748,0.0376467,-0.21031,-0.345875,0.194789,0.452702,-0.340119,0.701361,-0.120555,-0.541448,0.0505402,-0.420962,-0.47378,-0.0708604,0.547969,0.0134357,0.276059,-0.222016,-0.413729,-0.231452,-0.0505961,-0.737245,-0.578342,0.203881,0.209441,0.358435,-0.268489,0.200668,-0.187032,0.283034,0.233504,-0.448496,-0.00439089,0.201847,0.00633636,-0.448596,0.0967689,-0.283061,-0.135902,0.396227,0.792678,-0.0956716,-0.00524186,-0.59718,-0.0890496,-0.0890618,-0.146993,-0.0932811,0.0842795,0.257529,0.725366,-0.908608,1.26709,-0.531103,0.989115,0.585204,0.217973,0.105408,-0.161956,-0.284067,0.244984,0.261112,-0.453688,0.155096,-0.734315,-0.0341289,-0.374524,-0.153102,0.209409,-0.399397,0.207823,-0.0862799,-0.309743,0.174455,0.0856832,-0.379268,-0.172993,-0.362473,-0.264713,-0.120455,0.16099,-0.0807434,0.155664,0.391515,0.27831,-0.203098,0.498649,0.409458,0.0681696,0.648138,0.233581,0.75249,-0.336814,-0.175924,-0.604369,0.0815067,-0.567029,0.420449,-0.239548,0.0754196,0.368679,-0.222922,0.21983,0.289134,-0.269961,1.09565,-0.00821105,-0.0129689,0.304932,0.142221,0.137666,0.103541,0.133432,-0.301816,0.274808,-0.420124,-0.427691,-0.173664,0.131613,0.31654,-0.373826,-0.149403,0.154703,-0.233175,0.0342676,-0.956433,-0.506161,0.0304295,-0.341453,0.0938924,0.290929,0.372529,0.352386,-0.291972,-0.107921,-0.271644,0.287019,-0.0859077,-0.0838064,-0.174868,-0.20508,0.373022,-0.641227,0.180121,-0.280952,-0.0697786,0.150531,0.262456,0.387983,0.512304,-1.39768 +3415.4,1,0.0848144,5,1.67973,1.0278,-0.634351,0.0932131,0.303818,-0.26062,-0.157292,-0.110703,0.871627,0.326459,-0.526812,0.0777127,-0.0281678,0.362462,-0.247776,0.957849,-0.113895,0.143542,-0.408537,0.0780219,-0.322004,-1.5503,-0.808051,-0.124619,-0.691462,-0.0114571,0.246468,0.394506,-0.498871,-0.0913725,0.514733,-0.488637,-0.544446,0.0370116,-0.596387,-0.0435798,-0.433301,0.103896,0.201698,-0.0457164,1.37304,0.387213,0.243478,-1.08326,-0.526332,0.542534,-0.625165,-0.0495799,0.505194,0.049681,0.199283,0.427283,-0.0821453,-0.503591,0.751827,-0.558678,-0.295145,-0.980411,0.0657763,-0.44395,0.669316,1.12623,-0.565116,-1.23412,-0.306936,-0.54016,0.378081,-0.488037,0.286515,-0.482375,-0.0169362,0.36561,0.251362,-0.555315,0.447322,0.436889,-0.131147,0.139244,0.00773655,-0.128485,0.485699,-0.00801253,-0.169307,-0.846498,0.294145,-0.419062,0.0256214,0.29848,-0.523038,-0.352227,0.126434,0.646027,-0.160119,0.0532134,0.152595,-0.135975,0.159578,-0.757067,0.0217762,-0.272195,0.0923149,0.271053,-0.412307,0.00890818,-0.227187,-0.0399352,0.373215,-0.160222,0.273851,0.557798,0.0472066,-0.342515,-0.526478,0.27546,0.123469,-0.257345,0.382867,0.217489,-0.0529118,-0.311705,-0.994223,-0.125399,0.156762,0.336466,-0.22648,0.234379,0.423811,0.311093,0.484617,-1.21271,-0.823261,-0.127086,0.282599,-0.320043,-0.29381,-0.034265,-0.0453323,-0.12381,-0.0560112,-0.161322,0.277569,-0.164562,-0.145615,-0.430195,-0.282406,0.527653,0.0916567,0.133812,0.0704513,-0.160943,-0.363102,0.146496,0.224387,-0.246732,0.176423,0.686442,0.26507,-0.268746,-0.123124,0.096892,0.0846896,0.22402,0.562632,0.260784,0.400112,-0.211789,0.0955096,0.0523184,-0.3167,-0.166464,0.0471764,-0.211555,-0.143891,0.326909,-0.0215375,-0.189976,0.0716189,0.318824,-0.180283,0.578137,-0.560436,0.141774,-0.0441474,-0.098389,-0.41758,-1.12448,0.169503,-0.191305,-0.255805,-0.276665,-0.00755265,0.0721323,-0.169654,-0.872856,-0.331562,-0.0135538,-0.0895685,-0.621684,0.22254,-0.124321,-0.340604,-0.00231836,0.501714,-0.0788223,-0.507674,-0.285894,-0.0386505,0.822586,0.625518,-0.206796,-0.534982,-0.325613,0.101547,-0.159202,0.351705,0.353371,-0.681428,0.0372455,0.388379,-0.393935,-0.14905,-0.0148385,-0.0189873,0.107001,-0.443671,0.318603,-0.42332,-0.296474,-0.323963,-0.151396,0.0160862,-0.0202245,-0.105985,0.0799604,-0.236661,0.478985,0.0739256,-0.357525,0.122105,-0.495132,-0.137473,-0.255236,-0.375654,-0.295281,-0.0151017,0.102972,0.707356,0.33418,-0.193661,-0.396414,0.112836,-0.678634,0.20196,-0.0678036,0.00234708,-0.285219,-0.325959,0.366927,-0.290909,0.120644,-0.483108,0.708237,0.188296,-0.0574371,0.578283,0.302421,0.162287,-0.287012,0.211331,-0.0786543,0.258084,0.0295614,0.227852,0.616026,0.259154,0.0890321,-0.205242,-0.357453,0.8885,0.072016,0.649873,0.163867,-0.211012,0.137457,-0.16753,-0.120035,-0.459696,0.154093,0.18352,0.117101,0.117637,-0.0948825,0.193302,0.548702,-0.0586419,-0.430467,-0.635124,-0.12553,-0.503228,0.596863,0.289814,0.123864,0.355283,0.351943,0.596056,-0.83593 +3407.48,0.911415,0.0848144,4,1.64102,0.95104,-0.97279,0.218349,0.5707,-0.195894,0.0707129,-0.229027,1.0599,-0.0363611,-0.443292,-0.464496,0.0574364,0.144887,-0.458872,1.10958,0.0100286,-0.300339,-0.178211,-0.308802,-0.374439,-1.11822,-1.2832,0.0902901,-0.608384,-0.818815,0.238478,0.274779,-0.798515,0.118315,0.530566,-0.583883,-0.330535,0.111636,-0.386912,0.0983015,-0.488317,0.536484,0.437376,-0.306546,1.13381,0.358382,-0.0945538,-0.822161,-0.387661,-0.202454,-0.839059,-0.43999,0.260533,0.183818,0.331481,0.319042,0.529405,-0.378274,0.91768,-0.559544,-0.0959175,-1.02078,0.366654,-0.38633,0.501659,0.857245,-0.627936,-0.970244,-0.166084,-0.570151,-0.151751,-0.916191,0.205,0.111848,0.0427646,0.55458,0.476473,-0.180099,-0.0374999,0.420567,0.0902253,-0.719756,-0.512578,0.0075827,0.834599,-0.130577,0.126246,-0.647281,-0.021037,-0.196009,-0.112589,0.120393,0.0232452,-0.351141,0.0126065,-0.108628,-0.246342,0.274073,-0.309877,-0.619718,0.495016,-0.146066,0.310422,-0.174078,0.0857809,0.211841,-0.244672,0.0714959,0.272324,-0.532171,0.0602937,-0.230845,0.121498,0.27877,-0.116871,-0.132006,-0.56776,0.192305,0.590425,-0.204784,-0.104479,0.249888,0.022167,0.381643,-0.702925,-0.663196,0.412331,0.0441641,-0.174263,0.35131,-0.527116,0.158745,0.49688,-0.801668,-0.686236,-0.084398,0.0101594,0.0273703,-0.325177,-0.338642,0.0197321,-0.433675,0.156166,-0.431981,0.0130155,-0.371786,0.160394,-0.15151,-0.0745537,0.381831,0.318961,0.216653,-0.352531,0.318892,0.171341,0.225332,0.891881,-0.684773,0.354151,0.404465,0.643978,0.315529,-0.387842,-0.00166241,-0.633718,0.300478,0.712363,-0.0874758,-0.165917,0.686279,0.105591,-0.513583,-0.335196,-0.196128,-0.10919,-0.21507,-0.159733,0.468534,-0.00246551,0.133073,0.171136,0.0310934,0.144758,0.339756,0.390649,-0.0840523,0.606188,-0.726374,-0.058394,-0.810897,-0.0838253,0.119412,0.51231,-0.232925,-0.25439,0.396592,-0.311425,-0.680427,0.423265,-0.124799,0.0613935,-0.225004,-0.0651703,0.185426,0.030899,-0.103094,0.613923,-0.00995473,-0.19504,0.298514,-0.532827,0.831933,-0.0621645,0.156267,0.157045,-0.0911433,-0.0211125,0.158682,0.875292,0.358759,-0.523703,-0.401185,0.772803,-0.609382,0.485642,-0.574411,0.0837859,-0.46948,-0.731779,0.274493,-0.0640971,-0.50926,-0.204685,0.474577,0.116309,-0.290137,-0.339582,-0.077382,-0.30342,0.569614,-0.02482,-0.187135,0.635643,-0.36854,-0.289451,-0.216853,-0.283353,0.0189455,0.440442,-0.105956,0.674604,0.638578,0.00933072,-0.781712,0.529993,-0.571134,0.20304,-0.121583,0.123914,-0.318728,-0.175462,-0.00100362,-0.138775,-0.0295563,0.176074,0.403847,-0.0635816,0.553987,-0.0212097,0.148142,0.171577,-0.0450585,0.147672,0.0786175,0.362062,-0.0924668,-0.0830577,0.298413,0.0204755,0.0824026,-0.176723,-0.137457,0.623545,0.388646,0.241405,0.529481,0.155015,0.612868,0.249755,0.623377,0.160619,0.318576,-0.0687032,0.461473,0.0343573,0.159196,0.0587181,0.384794,0.560535,0.428302,-0.306979,-0.131253,-0.694348,0.0777682,0.342471,0.136727,0.473884,0.369766,0.688392,-1.58195 +3428.04,0.709247,0.0848144,5,1.64927,1.2332,-0.16805,-0.109128,-0.0531904,-0.100413,0.09907,0.171096,-0.0361012,0.489676,-0.747247,-0.0184371,-0.179112,0.426322,-0.346597,0.978159,-0.040914,-0.0974498,-0.201974,-0.0500994,-0.78997,-1.57498,-0.351851,-0.287936,0.0224975,0.0969916,-0.0456832,0.490516,-0.340932,-0.151666,0.247674,-0.273607,0.0535118,-0.394337,-0.254617,-0.204814,-0.502613,0.0977707,0.148247,-0.0887624,0.953563,0.600593,0.611813,-0.736078,0.130194,0.378164,-0.772216,0.275101,0.459321,-0.302037,0.450124,0.201916,-0.0148705,-0.633985,0.852785,0.212548,-0.284721,-0.64285,0.194218,-0.156443,0.298701,0.640517,-0.634622,-1.32647,0.380484,0.494076,0.281701,0.786197,-0.0221401,-0.673029,-0.382756,-0.161917,0.401373,0.387242,0.626641,0.328507,0.139984,0.505437,-0.54319,-0.0825379,0.0653862,-0.431945,-0.00646861,0.34407,-0.0564355,0.0954923,-0.155243,0.00738682,0.157864,-0.169058,-0.0116014,0.112676,0.198447,-0.0544032,0.230493,0.109093,-0.121882,-0.266096,-0.233701,-0.0629516,0.112949,-0.157767,-0.319904,-0.446999,-0.100936,0.21201,0.753113,-0.0818406,0.582527,0.430657,-0.0907744,-0.106956,0.761969,0.0378051,-0.443464,0.389899,-0.116615,0.250495,0.47524,-0.576278,-0.502304,0.353239,-0.694082,-0.0807509,0.019108,0.192933,0.672898,-0.188739,0.170852,0.137867,0.742179,-0.272911,0.120859,0.476458,-0.00580046,-0.185348,-0.0742517,-0.394244,0.304546,-0.434635,-0.573339,-0.0788265,-0.139568,-0.804259,0.0590603,-0.365317,-0.159079,0.509951,0.224517,-0.390464,-0.600689,-0.0583586,-0.360814,0.450422,-0.0714965,0.399946,-0.433339,-0.461813,-0.138434,-0.157645,0.770028,-0.144541,0.533852,-0.114554,0.322779,0.164585,-0.213495,0.381828,-0.163281,0.357342,0.371671,0.022824,-0.203386,-0.791874,-0.0673348,0.174825,-0.318778,-0.0621767,-0.247699,0.712035,-0.44621,-0.313845,-0.0366915,0.437076,0.0198851,0.275337,-0.404552,-0.266061,-0.246975,-0.429024,0.0117924,-0.18105,-0.0545888,-0.294237,-0.608637,0.381109,-0.579095,-0.390899,-0.59621,-0.296649,-0.396153,-0.31129,-0.267514,-0.108776,-0.0526339,-0.257664,-0.2561,1.19452,0.143802,0.12499,-0.151214,0.0350119,0.126239,-0.158301,-0.945471,-0.0166888,0.140667,0.0263626,-0.151653,-0.105287,-0.3332,-0.227975,-0.230524,0.775221,0.286201,0.526126,-0.675569,-0.136537,0.180089,-0.677521,-0.246524,-0.127494,0.134613,-0.220081,-0.154709,0.572969,0.0597572,0.289903,0.169209,-0.478687,0.179538,-0.202903,0.202352,0.033027,-0.0380012,0.309066,0.458682,-0.439583,-0.255091,-0.0392156,-0.263324,-0.754798,0.406201,-0.407804,-0.126734,0.15542,-0.339192,0.304101,0.119388,-0.0990427,0.00131371,0.210192,0.143924,-0.479035,0.676846,0.0150029,-0.0098202,0.0672786,-0.257123,-0.00570999,-0.458598,-0.620042,-0.406861,-0.0298061,-0.00828991,-0.0605807,-0.22179,0.319347,-0.126691,-0.0613727,-0.439904,-0.799667,-0.138475,-0.114217,0.0202362,0.0772504,-0.61965,0.203683,0.147531,-0.3733,-0.160786,-0.0111177,0.157372,0.41134,-0.297533,-0.981534,-0.272813,-0.0375332,0.31687,-0.162363,-0.38281,0.145818,0.291169,0.381861,0.539601,-0.1375 +3411.72,0.846631,0.0848144,4,1.63759,1.30034,-0.399174,-0.0484222,0.0653916,0.02533,-0.083636,0.210072,0.0775839,1.08417,-0.743333,0.0934456,-0.405549,0.240649,0.169082,1.03142,-0.451359,-0.0764051,-0.16145,0.339514,-0.866148,-1.13262,-0.438487,-0.350564,-0.360476,-0.134175,0.206536,1.18276,-0.368048,-0.33929,-0.114959,0.155726,0.126,-0.164656,-0.495425,-0.153201,-0.909309,0.519253,0.466812,0.0439828,1.24815,0.778006,-0.416439,-0.386818,-0.0306521,-0.0857649,-0.982263,0.342547,0.377125,-0.648969,0.283996,0.118079,-0.14859,-0.620917,0.686509,0.284586,-0.47954,-0.947399,0.0217331,-0.221095,0.489261,1.20659,-0.976087,-0.625446,-0.299552,0.311083,-0.227649,0.667659,-0.507588,-0.525122,-0.120269,0.182182,0.513125,-0.392972,0.615579,0.38283,0.351397,0.268415,-0.424425,0.110574,0.329836,0.0938983,0.0758342,-0.0612398,-0.327366,-0.349885,-0.0526082,-0.0627301,0.0238887,0.0242159,-0.274238,0.126966,-0.0550571,-0.105444,-0.0132654,-0.0170893,0.284552,-0.562567,-0.205121,0.121766,0.11347,-0.128334,-0.421971,-0.496046,-0.193943,0.0689742,0.439332,-0.118986,0.773967,0.414882,0.355216,-0.124511,0.646463,0.154562,-0.174858,0.205986,-0.351199,0.190529,0.321185,-0.377067,-1.11762,0.875411,-0.343612,0.0472447,0.447495,0.192922,0.288474,-0.181176,0.525148,-0.432191,0.117617,-0.160425,0.2455,0.465795,-0.00360718,-0.397392,-0.703701,-0.639265,0.240358,-0.33185,-0.143225,-0.238419,-0.206961,-0.333536,-0.0519287,-0.202944,-0.195617,0.495818,0.165752,-0.657235,-0.463754,0.408129,-0.00858656,0.206534,-0.0960105,0.54569,0.445935,-0.933641,0.0196963,0.21171,-0.532771,-0.200723,0.197909,-0.465467,-0.0325459,0.469722,-0.0753837,0.197619,-0.133862,0.0840012,0.0747478,0.13774,-0.210667,-0.271749,0.368858,-0.232111,-0.157131,-0.00778113,0.0203435,0.671388,-0.4697,-0.000202767,0.408726,0.328352,0.0704728,-0.51455,-0.683654,0.0426336,0.124228,-0.461056,-0.341132,0.270785,-0.354975,-0.12894,-0.597468,0.215418,-0.235861,0.00426986,-1.0358,0.0906475,-0.238146,0.0133017,0.312315,0.324724,-0.391985,0.479046,-0.405432,1.15803,0.27652,0.168614,0.0148674,-0.679836,0.125747,-0.116148,-0.683086,0.0484011,-0.317976,0.145625,0.394704,-0.101323,-0.714539,-0.575573,-0.330089,0.752445,-0.283735,0.418269,-0.720254,-0.717728,0.0287469,-0.229155,0.0806654,-0.0743775,-0.772865,-0.378391,-0.337617,0.422637,-0.578536,0.017195,0.32633,-0.305038,-0.080509,0.145806,-0.137537,-0.809251,0.0576244,-0.129206,0.476525,-0.11371,0.0178184,-0.482365,-0.0963789,-0.668604,0.466908,-0.639589,0.0394555,-0.254767,-0.294668,0.425752,0.0729933,-0.11677,-0.167758,0.0729848,0.0799317,-0.314039,0.476266,0.0830982,0.344798,0.300348,-0.470646,-0.0792297,-0.198988,-0.730859,-0.457277,0.482754,0.230027,0.310871,-0.143179,-0.684968,0.21047,-0.0335189,-0.424298,-0.256783,0.0011204,-0.0818457,-0.00577122,0.585811,-0.489224,0.0669397,0.767491,0.184234,-0.514701,-0.64704,-0.0364925,-0.00608263,0.306531,-0.205742,-0.171706,-0.162556,0.0504454,-0.202475,-0.300148,0.145862,0.279504,0.381918,0.528681,-0.6291 +3415.71,0.997363,0.0848144,5,1.65646,1.06316,0.104639,-0.187065,-0.190448,-0.150047,-0.0142115,0.585294,0.311843,0.846267,-0.380184,-0.0605655,0.0488255,0.619575,-0.152474,1.14889,-0.0921945,0.0330703,-0.263178,0.147008,-0.466054,-1.19341,-0.967922,0.0727943,-0.163299,-0.41358,0.179585,0.0420083,-0.277587,-0.0867647,0.471716,-0.0485553,0.14752,0.0944121,0.0739362,-0.104909,-0.631219,0.388089,0.017692,-0.486474,0.655371,0.371978,0.16494,-0.889345,-0.235431,0.160364,-1.00553,0.0104163,0.473834,-0.255812,0.229861,-0.235249,0.0242205,-0.452342,1.18584,-0.114818,-0.35079,-0.508041,0.050396,-0.305187,-0.085882,0.986769,-0.67034,-1.08656,0.171809,0.603468,-0.587951,0.0607987,-0.715021,-0.440079,-0.837557,0.366632,0.140453,-0.548231,0.282331,0.907545,0.0247191,0.407921,-0.401256,-0.479417,0.279416,-0.554723,0.0768682,0.415724,-0.399525,-0.218187,-0.375418,0.345676,0.0330047,-0.0256501,-0.616867,0.0516644,-0.0708073,-0.282024,0.498471,-0.212517,-0.186361,-0.426673,-0.0125827,0.630905,0.228977,0.30093,-0.27051,-0.372343,0.228376,0.20757,0.0248179,-0.0597716,0.640818,0.809544,0.102498,-0.279973,0.0803723,0.117051,-0.11773,0.127548,-0.27754,0.185497,0.375147,-0.196565,-0.791807,0.0455476,0.0871686,-0.203042,0.428105,0.0135378,0.54247,-0.29395,0.00767196,-0.0989927,0.243859,-0.0807022,-0.223381,0.555438,-0.311052,-0.00736803,0.260684,-0.514495,0.537956,-0.161802,-0.492791,0.0277523,0.28019,-0.925407,0.292504,-0.646733,-0.0707555,0.612467,0.254796,-0.227584,-0.218882,-0.508652,-0.17177,-0.189999,0.454371,0.250293,-0.118535,-0.513756,-0.2088,0.106886,0.158067,0.188592,0.65264,0.152288,-0.295811,0.592986,-0.182418,0.0250346,-0.0754597,-0.600745,0.241075,0.357705,-0.298142,0.256168,-0.340407,-0.351485,0.0967696,-0.418032,0.427081,0.338983,0.324515,0.767253,0.105172,0.220594,-0.180514,-0.827282,-0.359872,-0.0144566,-0.227504,-0.51915,0.0668006,-0.0171551,-0.23847,-0.407455,0.221782,0.45436,-0.511688,-0.332005,-1.20041,0.0609209,0.00297979,-0.657058,0.577852,-0.0841283,0.365142,-0.208137,0.00314249,1.16167,-0.563015,-0.0965018,-0.405534,-0.766039,0.165851,0.316693,0.112668,0.464245,-0.727587,0.150276,-0.123422,-0.597354,0.237634,-0.493018,-0.486847,0.553245,-0.61299,0.556402,-0.453453,-0.443436,-0.147048,-0.0735892,0.0756276,-0.336109,-0.0758844,0.285562,0.0388769,0.698526,-0.147201,-0.250202,-0.10732,-0.606129,-0.494163,0.088455,0.252834,0.573882,0.527523,-0.187697,0.391662,-0.58071,0.0712976,-0.62711,0.134661,-0.591959,0.579314,-0.607116,0.273366,-0.129123,-0.0625927,-0.334378,-0.187329,-0.0353868,0.451574,0.340678,-0.282271,0.25,0.203323,0.422734,0.0629792,-0.113651,-0.517205,0.0598027,-0.246932,0.0272969,0.397418,-0.637664,0.0313022,0.0570883,0.0191763,-0.170334,-0.306407,-0.173094,-0.1483,-0.261181,0.236372,0.0752175,-0.411831,0.511413,-0.257647,0.302418,0.114529,0.138799,-0.0324786,-0.114155,0.607977,0.10299,0.205631,0.0158188,0.334672,-0.422227,0.244974,-0.796589,-0.180141,0.160222,0.304596,0.400278,0.551902,0.569027 +3437.81,0.733373,0.0848144,4,1.64635,1.01943,-0.236418,0.0268078,-0.0592365,-0.112588,0.092195,0.0156718,0.725916,0.582539,-0.391843,-0.120105,-0.0596724,0.428064,-0.0750176,0.669601,-0.121659,-0.339149,-0.441305,0.350797,-0.147422,-1.04558,-0.320183,-0.0701815,-0.0775762,-0.390069,0.207336,0.289015,-0.597843,-0.262113,0.527352,-0.319697,-0.316891,0.257194,-0.391936,-0.39059,-1.22177,-0.175339,-0.0832314,-0.0905684,0.869083,0.141615,-0.0594201,-1.03337,-0.449261,-0.157673,-1.07294,0.01382,0.624055,-0.210343,0.0695641,0.466727,0.313163,-1.071,0.574037,-0.461543,-0.372931,-0.61838,0.068658,-0.368604,0.23673,1.14458,-1.21017,-1.44657,0.456271,0.374601,0.274246,-0.128282,0.0664187,-0.128786,-0.0735039,0.298034,0.712615,-0.159061,0.291502,0.213532,0.334858,-0.0721222,-0.625653,0.0258092,0.561302,0.059913,0.244335,-0.300231,-0.0144408,-0.369956,0.21466,-0.220008,-0.237904,-0.0112483,0.210237,0.173525,-0.220469,-0.251641,0.110765,-0.669906,-0.127423,-0.166949,0.0434076,0.104031,0.0180766,0.0722714,0.121548,-0.197641,-0.166501,-0.829535,-0.165801,-0.322848,-0.288853,0.487209,-0.49563,-0.0192254,-0.19654,0.437481,0.386729,-0.0276321,-0.379977,0.523468,0.238596,0.072516,-0.821483,0.229593,-0.118574,-0.150414,-0.186084,0.285012,0.148531,0.0781517,0.394924,-0.510028,-0.0555747,0.0231394,0.28715,0.525808,0.0816881,-0.0344805,-0.430432,-0.184144,0.109834,0.116642,-0.948996,-0.090873,0.102408,-0.412008,0.100032,0.273659,0.573042,0.550627,-0.15329,0.0588224,0.0788136,0.297498,-0.0716128,0.525326,0.239014,-0.00935944,0.258942,0.0747916,0.25362,0.129349,0.778927,0.499768,0.977093,-0.0792055,0.177446,0.260681,-0.554107,-0.386966,-0.17915,-0.0983724,-0.0585735,-0.145906,0.00902551,-0.451762,0.209628,0.316899,-0.0766101,0.0546636,0.189235,0.124493,-0.41429,-0.0879024,-0.462968,-0.275652,-0.508716,-0.583085,-0.479745,-0.21506,0.120507,-0.181471,-0.13964,0.144548,0.213068,-0.25823,-0.0337835,0.871035,0.0155929,-0.281643,-0.466801,0.186834,-0.265664,-0.690537,0.558187,0.260419,-0.248683,0.226269,-0.492662,0.904588,0.134223,0.11214,-0.0711636,-0.375051,0.261947,0.204179,-0.310831,0.0867281,-0.553184,0.19742,0.440771,-0.638485,0.0897859,-0.0295044,0.471887,0.198928,-0.130201,-0.0116554,-0.342191,-0.538842,0.0902161,-0.552938,-0.997314,0.222601,-0.0711501,-0.380858,-0.323248,0.677973,-0.156236,-0.204367,0.423863,-0.0400911,0.0724471,-0.262325,0.263533,-0.224258,0.357142,-0.285848,0.55222,0.476406,-0.0370974,-0.349072,0.348482,-0.298191,0.651368,0.129572,-0.822721,0.0471531,-0.565675,0.352204,-0.059885,-0.288355,0.124965,0.517327,-0.232275,0.444956,0.455954,0.081937,-0.0593689,-0.294135,0.377053,-0.145882,0.090775,-0.470131,-0.0594208,0.240388,0.369068,0.196118,0.278481,0.0240514,-0.16485,0.689564,-0.0829666,0.196205,-0.874756,0.346865,0.255035,0.300186,-0.111643,0.346465,-0.153422,-0.162931,0.0197953,0.323884,-0.11597,-0.0883164,-0.257346,-0.585032,0.0715182,0.0405348,0.305585,0.0584255,-0.0950821,0.0967749,0.272933,0.311087,0.52243,0.167647 +3405.27,0.975072,0.0848144,4,1.70441,1.01917,-0.686445,0.0304551,0.209509,-0.0929681,-0.0679466,-0.1207,-0.00962153,0.172316,-0.330584,-0.40883,-0.119492,0.00710117,-0.487891,0.678929,-0.250464,-0.0631168,-0.00401837,-0.53865,-0.460725,-1.60887,-0.450199,-0.166526,-0.374161,-0.140005,-0.0118899,0.252862,-0.740013,0.0898089,0.564992,-0.914245,0.0563061,-0.346377,0.0714992,-0.276544,-0.916322,0.360246,0.219647,-0.475497,0.935215,0.408383,0.449708,-0.898368,-0.173464,0.505887,-0.247684,-0.312951,0.70127,0.175652,0.729904,0.239699,0.124225,-0.36943,0.8371,-0.368628,0.0815488,-0.449398,0.254834,-0.0417914,0.340019,0.957145,-0.366146,-0.743455,0.286264,0.131081,-0.370922,-0.274881,0.145793,-0.236807,0.0271953,0.288983,0.567941,0.618845,0.384948,0.659281,0.219505,0.411961,0.189835,-0.360399,0.56163,-0.889957,-0.0783959,-0.0778718,-0.128671,-0.404358,-0.0987849,0.332508,0.16357,-0.808658,-0.682192,-0.333063,0.387493,-0.0379791,0.459944,0.216953,0.17439,-0.0341353,-0.0303653,0.609519,0.4515,-0.0453236,-0.257475,-0.110927,0.202877,0.212965,0.697558,-0.191066,0.199873,0.0740368,-0.357564,-0.640221,0.288209,0.442764,-0.464976,0.118251,-0.77608,0.162017,0.09152,-0.429603,-0.557994,0.193202,0.492382,-0.505808,0.323009,-0.188531,-0.176793,0.0796834,0.0962091,-0.356213,0.0682811,0.160825,-0.48216,0.608081,-0.352621,-0.250138,0.162402,-0.258442,0.405735,-0.620862,-0.218434,-0.120783,-0.00907886,-0.643352,-0.241267,0.115461,0.337769,-0.0606646,-0.236378,-0.0636349,-0.811677,0.187817,0.251587,-0.117766,0.547477,1.03817,0.170616,-0.44212,-0.0569917,-0.515293,-0.324181,-0.0962392,0.719333,-0.0156859,0.0845784,0.530304,-0.330841,-0.149266,-0.317737,-0.0272806,0.106586,0.719726,0.0622639,0.0502283,-0.566684,0.237029,0.100447,-0.498034,-0.428276,0.63322,0.377059,-0.409055,-0.0507449,0.163299,0.981948,-0.263559,0.0115744,-0.368114,-0.0720209,-0.43297,0.466548,0.14326,0.329763,-0.522781,-0.166464,-0.205622,-0.219361,-0.523152,-0.576625,-0.623502,-0.228065,-0.246162,-0.0967074,-0.317414,0.238659,0.344727,0.0503274,0.633882,0.338484,0.15508,-0.0843523,-0.0769961,0.669544,-0.0920399,0.301234,0.587251,-0.305937,-0.117839,0.382344,0.219094,0.122282,-0.504738,-0.86214,-0.15649,-0.58381,0.462422,0.0107695,-0.828615,-0.482987,0.270583,-0.236591,0.0307353,0.0653022,0.212591,-0.96559,0.800431,-0.286419,-0.0372225,-0.033457,-0.71993,-0.268244,-0.00131228,-0.305197,0.472205,0.96418,0.0184446,0.395595,-0.126098,0.0299349,-0.266455,-0.612825,-0.27029,0.410126,-0.302728,-0.0654723,0.447794,-0.266459,0.882309,-0.287369,0.0127752,0.203161,-0.129487,-0.393443,-0.568152,0.634151,-0.350333,-0.172335,0.12493,-0.137064,0.0361054,-0.837103,0.053236,-0.188146,0.193347,0.0762634,-0.0816749,-0.0148545,0.549449,0.153539,0.456383,-0.112611,-0.538396,-0.805891,0.221218,-0.34057,0.26671,-0.0716106,-0.222965,0.276411,-0.204273,0.270628,-0.237459,0.249923,-0.00535391,0.282921,-0.0536847,-0.0406706,-0.557838,-0.700368,-0.110343,0.0608247,0.153522,0.320056,0.391818,0.565735,-0.437933 +3421.45,0.971118,0.0848144,4,1.68185,0.934377,-0.895399,0.284152,0.422844,-0.128192,-0.3599,-0.216931,-0.622635,-0.509273,0.105386,-0.427968,-0.326872,0.145252,-0.317218,0.705693,-0.594306,0.330469,-0.482211,-0.136937,-0.121616,-1.40303,-0.706746,0.139553,-0.335798,-0.351486,0.196738,-0.236373,-0.383144,-0.0893508,0.91554,-0.26683,0.239214,-0.14982,-0.399685,-0.59513,-0.504922,0.00158881,0.467698,-0.475333,0.748452,0.463031,0.784402,-0.352716,0.206176,0.0355127,-0.171632,0.453993,0.320776,-0.511994,0.0588486,0.38323,0.269809,-0.871171,0.54094,0.170237,-0.184115,-0.263892,0.457157,-0.772134,-0.0552684,1.45657,-0.619775,-1.14993,-0.315913,0.0357567,-0.0963108,-0.132467,-0.0607829,-0.42621,-0.27626,0.633113,0.667096,0.549748,0.497963,1.02953,-0.0496768,0.265912,0.0488875,-0.0106359,0.691672,-0.188756,-0.0599559,-0.324908,0.146666,-0.143816,0.318926,-0.355483,-0.059343,-0.484376,0.198959,-0.0758898,0.363976,-0.135909,0.184907,-0.19666,-0.36317,-0.641875,-0.120209,0.576885,0.0114458,-0.309903,-0.389429,-0.258872,-0.402127,-0.280746,0.430569,-0.132415,0.811168,0.369043,0.446317,-0.508472,-0.169492,0.380444,-0.0778482,-0.00394402,-0.686074,0.146756,0.435613,-0.336027,-0.602882,0.237879,-0.222757,-0.00329633,0.0898973,0.194731,0.352827,0.285812,-0.44331,-0.351991,0.650887,0.0330698,-0.052936,0.635406,-0.382052,-0.69386,0.333978,0.057769,-0.198634,0.358105,-0.0718423,-0.145439,-0.106742,-0.296346,-0.00847067,-0.147943,-0.150869,-0.159496,-0.503694,0.286031,-1.3101,0.452612,-0.105553,-0.00634637,0.496239,0.659095,0.252995,-0.028294,0.104322,0.000360849,-0.337626,0.187432,0.4427,-0.0254912,-0.226783,-0.0919351,-0.192828,0.153106,-0.141792,0.133737,-0.443452,0.00217727,-0.00910613,-0.103547,-0.0552591,-0.167434,-0.782106,0.144216,0.106264,0.211653,0.0361476,-0.0891606,0.21308,-0.226759,0.392167,-0.163014,-0.112451,-0.437195,0.53092,-0.43463,0.0360402,0.449277,0.0788831,-0.409395,-0.188143,0.270869,0.126885,-0.190521,0.00251099,-0.328316,-0.248427,-0.365868,0.00155424,0.0663762,-0.187892,0.00185669,-0.564053,0.570096,0.569052,0.80457,0.17809,0.00142433,0.814594,0.439101,0.00763583,-0.13851,-0.375322,0.448336,0.402337,-0.450211,-0.28125,-0.617942,-0.145156,0.0743652,-0.996387,0.297758,-0.758447,-0.045422,0.266157,-0.261993,-0.380307,0.10285,-0.0898849,-0.34684,-0.807528,0.320649,0.188938,-0.258357,0.135204,-0.429961,-0.472325,0.371365,-0.00282616,-0.207825,0.110364,0.33887,0.303213,0.516033,-0.238179,-0.350335,-0.0937523,-0.700295,1.03498,-0.573111,-0.00832461,0.0384624,-0.334055,0.197329,0.00458505,0.0320718,0.114017,0.382212,0.0722397,0.328,0.405011,0.334456,-0.133867,-0.0236868,-1.28399,0.48322,-0.173658,-0.113891,-0.200596,0.566886,-0.157526,-0.211626,0.0705915,0.00487946,0.127953,0.00760576,-0.621472,-0.271236,-0.690447,0.156762,-0.137097,0.520903,-0.69411,-0.43361,-0.0751695,0.44781,-0.165308,0.224344,-0.266524,-0.020884,-0.128949,-0.645966,0.457903,-0.281025,0.216324,0.263149,0.137271,0.14438,0.234445,0.379974,0.484195,-1.1408 +3427.57,0.9333,0.0848144,4,1.65201,0.720739,-1.08417,0.407638,0.563404,-0.141435,0.2313,-0.09945,0.443316,0.153705,-0.0870585,-0.559294,-0.552172,0.383107,-0.296627,0.540973,-0.108707,0.166417,-0.434748,-0.0453518,0.0533511,-0.661954,-0.604812,0.426087,0.17517,-0.536619,-0.239068,0.546199,-0.339315,0.594665,0.863598,-1.07629,-0.139642,0.184008,-0.294302,-0.0706082,-0.866096,0.387617,0.736407,0.530431,0.769095,0.179747,0.396418,-0.711281,0.206333,-0.224281,-0.738088,-0.256784,0.393544,0.278635,0.169714,0.143313,0.331587,-0.0366881,0.702609,-0.302642,-0.0842156,-0.941817,0.850404,-0.464669,0.296342,0.995973,-1.39611,-0.832631,0.0606764,0.455406,-0.612237,0.409329,0.187673,-0.392552,0.411344,0.0659301,0.579091,-0.0838396,0.296477,0.368214,-0.00682239,0.402744,-0.151692,-0.000917759,0.61816,-0.313575,0.281609,-0.74712,-0.2227,-0.507471,-0.456453,0.0369346,-0.106648,-0.452553,-0.254703,-0.251455,0.18245,0.0102706,0.25974,-0.276098,-0.21526,-0.38883,-0.376362,0.234069,0.290606,-0.837258,-0.435625,-1.06707,0.159037,-0.0127495,0.382384,-0.531551,-0.136836,0.373858,-0.576727,-0.197692,0.222386,0.388145,0.0840354,0.341705,-0.199654,-0.323904,0.464873,0.116022,-0.959783,0.122451,-0.489955,0.227252,-0.293083,0.598799,0.330604,-0.00131219,0.408875,-0.940832,0.327233,0.0464169,-0.213764,0.417145,-0.136318,-0.360785,0.184808,-0.3854,0.61324,-0.918516,-0.492773,-0.232451,0.0075753,0.22196,0.421329,-0.247087,-0.160107,-0.167223,0.00605887,-0.135831,0.256909,0.0232759,0.212658,-0.166071,0.789644,0.878036,0.120792,-0.497978,-0.0924107,0.107597,0.200858,-0.0786517,0.119882,-0.860337,-0.187665,0.128221,-0.01319,-0.0466123,-0.127231,-0.266615,0.317739,0.26366,-0.0745144,-0.274288,-0.151977,0.0353033,-0.46176,0.0153086,0.218276,0.579841,0.122012,-0.291719,-0.0829772,0.205105,-0.0366631,-0.410142,-0.402041,-0.67738,0.186597,-0.239307,-0.0423774,-0.395426,0.0925118,-0.208764,-0.188622,0.178748,-0.0823876,-0.551968,-0.84546,-0.0145734,-0.0231061,-0.684369,0.330294,-0.092465,0.497256,0.0100717,-0.381112,0.947272,-0.0590047,0.0303587,0.269461,0.142311,0.024768,-0.315305,-0.4097,0.0887683,-0.612604,-0.111202,0.288297,-0.684328,-0.270473,-0.290042,0.0965582,-0.155808,-0.577665,0.457497,-0.107512,-0.358202,0.306234,-0.161739,0.0155098,-0.00762767,-0.195149,-0.324059,0.474746,0.217684,0.348775,0.0496399,0.0069268,-0.18021,-0.187741,0.419262,-0.345178,0.360302,0.152327,0.404844,0.360052,0.414094,0.318395,-0.0938848,0.0303498,-0.762666,0.402308,-0.320579,0.525213,0.300014,-0.104108,0.0472545,0.272302,0.0318778,0.0948355,0.366164,0.169613,0.0663913,-0.519593,-0.397764,-0.392743,-0.0183525,0.252741,-0.313432,0.200712,-0.0172508,-0.92771,0.0203752,-0.263861,0.00155088,0.420253,0.388253,0.00989466,-0.166529,0.145741,0.0203124,-0.0194912,0.208335,-0.0504958,0.282589,0.148177,0.381062,0.00370825,-0.565902,0.368391,-0.677787,0.188715,-0.229517,-0.269974,-0.130735,0.00575991,-0.196501,-0.157702,-0.00414855,0.350915,0.122987,0.297963,0.350695,0.54586,-1.2742 +3427.57,0.653693,0.0848144,4,1.65201,0.720739,-1.08417,0.407638,0.563404,-0.141435,0.2313,-0.09945,0.443316,0.153705,-0.0870585,-0.559294,-0.552172,0.383107,-0.296627,0.540973,-0.108707,0.166417,-0.434748,-0.0453518,0.0533511,-0.661954,-0.604812,0.426087,0.17517,-0.536619,-0.239068,0.546199,-0.339315,0.594665,0.863598,-1.07629,-0.139642,0.184008,-0.294302,-0.0706082,-0.866096,0.387617,0.736407,0.530431,0.769095,0.179747,0.396418,-0.711281,0.206333,-0.224281,-0.738088,-0.256784,0.393544,0.278635,0.169714,0.143313,0.331587,-0.0366881,0.702609,-0.302642,-0.0842156,-0.941817,0.850404,-0.464669,0.296342,0.995973,-1.39611,-0.832631,0.0606764,0.455406,-0.612237,0.409329,0.187673,-0.392552,0.411344,0.0659301,0.579091,-0.0838396,0.296477,0.368214,-0.00682239,0.402744,-0.151692,-0.000917759,0.61816,-0.313575,0.281609,-0.74712,-0.2227,-0.507471,-0.456453,0.0369346,-0.106648,-0.452553,-0.254703,-0.251455,0.18245,0.0102706,0.25974,-0.276098,-0.21526,-0.38883,-0.376362,0.234069,0.290606,-0.837258,-0.435625,-1.06707,0.159037,-0.0127495,0.382384,-0.531551,-0.136836,0.373858,-0.576727,-0.197692,0.222386,0.388145,0.0840354,0.341705,-0.199654,-0.323904,0.464873,0.116022,-0.959783,0.122451,-0.489955,0.227252,-0.293083,0.598799,0.330604,-0.00131219,0.408875,-0.940832,0.327233,0.0464169,-0.213764,0.417145,-0.136318,-0.360785,0.184808,-0.3854,0.61324,-0.918516,-0.492773,-0.232451,0.0075753,0.22196,0.421329,-0.247087,-0.160107,-0.167223,0.00605887,-0.135831,0.256909,0.0232759,0.212658,-0.166071,0.789644,0.878036,0.120792,-0.497978,-0.0924107,0.107597,0.200858,-0.0786517,0.119882,-0.860337,-0.187665,0.128221,-0.01319,-0.0466123,-0.127231,-0.266615,0.317739,0.26366,-0.0745144,-0.274288,-0.151977,0.0353033,-0.46176,0.0153086,0.218276,0.579841,0.122012,-0.291719,-0.0829772,0.205105,-0.0366631,-0.410142,-0.402041,-0.67738,0.186597,-0.239307,-0.0423774,-0.395426,0.0925118,-0.208764,-0.188622,0.178748,-0.0823876,-0.551968,-0.84546,-0.0145734,-0.0231061,-0.684369,0.330294,-0.092465,0.497256,0.0100717,-0.381112,0.947272,-0.0590047,0.0303587,0.269461,0.142311,0.024768,-0.315305,-0.4097,0.0887683,-0.612604,-0.111202,0.288297,-0.684328,-0.270473,-0.290042,0.0965582,-0.155808,-0.577665,0.457497,-0.107512,-0.358202,0.306234,-0.161739,0.0155098,-0.00762767,-0.195149,-0.324059,0.474746,0.217684,0.348775,0.0496399,0.0069268,-0.18021,-0.187741,0.419262,-0.345178,0.360302,0.152327,0.404844,0.360052,0.414094,0.318395,-0.0938848,0.0303498,-0.762666,0.402308,-0.320579,0.525213,0.300014,-0.104108,0.0472545,0.272302,0.0318778,0.0948355,0.366164,0.169613,0.0663913,-0.519593,-0.397764,-0.392743,-0.0183525,0.252741,-0.313432,0.200712,-0.0172508,-0.92771,0.0203752,-0.263861,0.00155088,0.420253,0.388253,0.00989466,-0.166529,0.145741,0.0203124,-0.0194912,0.208335,-0.0504958,0.282589,0.148177,0.381062,0.00370825,-0.565902,0.368391,-0.677787,0.188715,-0.229517,-0.269974,-0.130735,0.00575991,-0.196501,-0.157702,-0.00414855,0.350915,0.122987,0.297963,0.350695,0.54586,-1.2742 +3446.22,0.950909,0.0848144,4,1.63142,0.835274,-0.960553,0.36641,0.417033,-0.0620643,0.18213,0.126605,0.277915,0.145664,-0.0793551,-0.474547,-0.483936,0.221476,0.0235339,0.664422,0.142358,0.0448255,-0.486808,0.152593,-0.371752,-0.675402,-0.591145,0.39076,-0.1536,-0.28391,-0.285926,0.0440706,-0.435582,0.567537,0.890582,-1.05877,0.281497,0.225862,-0.44805,-0.0837819,-0.976298,0.416731,0.526839,0.200226,0.952666,0.288887,0.527009,-0.50329,0.0364714,-0.46324,-0.722125,-0.0577488,0.183014,0.0307366,0.156228,0.484283,0.24363,-0.4334,0.588382,-0.222175,-0.429277,-0.831554,0.503776,-0.261114,0.2827,0.958025,-1.17179,-0.830812,-0.275684,0.310258,-0.072454,-0.141136,-0.00462388,-0.272292,0.340935,0.0151866,0.695271,0.0950086,0.395212,0.320941,0.108433,0.0786372,-0.448233,0.13966,0.19895,-0.120375,-0.013563,-0.530772,-0.326206,0.0440704,0.410092,0.0518101,-0.282632,-0.365436,-0.210595,0.108966,0.335112,-0.171946,0.316081,-0.188651,0.154972,-0.129499,-0.488993,0.189995,0.247152,-0.505221,-0.308593,-0.573858,0.176544,0.240042,0.185832,-0.345626,-0.123569,0.478624,-0.65189,-0.289231,0.0301364,0.485374,-0.173133,-0.0133105,-0.325235,-0.553271,0.426087,-0.112265,-0.697853,-0.127502,0.0326658,0.200155,-0.115939,0.0651123,0.160281,-0.379099,0.182594,-0.860159,0.181272,0.112092,0.0750944,0.301705,0.0836921,0.107905,0.504795,-0.289885,0.626876,-0.975223,-0.532843,-0.243002,0.0484033,-0.173617,0.327686,0.171289,-0.086838,0.129478,0.0104954,-0.0213941,0.192825,-0.0918321,0.313594,-0.352279,0.428603,0.48433,-0.00278102,-0.372992,0.0558061,-0.0413299,0.151424,-0.381407,0.602716,-0.671541,-0.174686,0.00924074,-0.285724,-0.440164,-0.307161,-0.553768,0.19705,0.0413405,-0.252463,0.482172,-0.428238,0.0880863,-0.797308,0.127543,0.246919,0.533327,0.378437,-0.213982,0.178146,0.46072,0.0698331,-0.656069,0.0630567,-0.499387,0.118573,-0.0860481,0.121071,-0.476504,0.231368,-0.790142,0.0787006,0.437701,0.0374666,-0.207112,-0.519512,0.199086,-0.186305,-0.568752,0.550179,-0.295704,0.0752767,0.121355,-0.435768,0.714218,-0.233025,0.206406,0.403086,-0.219414,-0.161391,0.214493,-0.228877,0.435139,-0.330576,-0.068981,0.189243,-0.578195,0.0760869,0.0529871,-0.133238,-0.16095,0.0200608,0.554887,-0.0464759,-0.298108,0.351166,-0.0388821,-0.0940663,0.109882,0.162893,-0.169972,-0.0138637,0.444601,-0.172891,-0.110446,0.110266,-0.106999,-0.230893,0.321926,-0.00200715,-0.110871,0.41453,0.0216101,0.754409,0.240427,0.651531,-0.12263,-0.0150398,-0.820607,0.85635,-0.434324,0.778504,0.327794,-0.438489,0.0729603,-0.0487264,-0.172663,-0.102172,0.055609,-0.314204,0.0299576,0.0624642,-0.497576,-0.344085,-0.222205,0.653913,-0.145141,0.152704,-0.603281,-0.143373,0.641062,0.263488,-0.207859,0.166017,0.0882907,-0.384876,-0.0992901,0.125049,-0.109749,-0.377456,0.067693,-0.0833017,-0.171601,-0.303862,-0.0436735,-0.0215623,-0.194332,0.0457705,-0.372783,-0.192442,-0.322852,-0.183788,0.299842,-0.101517,-0.291834,0.225536,0.166673,-0.0527426,0.132644,0.333456,0.364204,0.577456,-1.05705 +3445.63,0.994261,0.0848144,4,1.65844,0.811383,-0.961416,0.361386,0.551422,-0.0437343,0.160104,0.172287,0.221632,0.0700304,-0.0522367,-0.377735,-0.330414,0.0253049,0.0354977,0.673814,0.0491276,0.0203544,-0.512385,0.19107,-0.314942,-0.8696,-0.6006,0.322329,-0.190533,-0.247718,-0.207659,-0.129372,-0.402156,0.521479,0.826598,-1.03621,0.226035,0.213615,-0.309958,-0.0547591,-0.924202,0.593182,0.339451,0.214238,0.999372,0.238767,0.616555,-0.326549,0.0275669,-0.540446,-0.57262,-0.0667133,0.272944,0.2055,0.112375,0.498403,0.228907,-0.435284,0.612193,-0.0957703,-0.189629,-0.804746,0.606158,-0.304908,0.190031,0.935277,-0.967978,-0.677428,-0.429897,0.126945,-0.0621783,-0.245191,0.0946016,-0.159716,0.31983,-0.152745,0.712094,0.159066,0.359862,0.389867,0.21847,-0.062068,-0.646895,0.00727439,0.0959692,0.0129172,0.0133332,-0.573308,-0.155341,0.262435,0.410571,0.0536657,-0.396865,-0.448547,-0.16204,0.16946,0.211169,-0.23501,0.389382,-0.332324,0.180453,0.0629258,-0.485498,0.125729,0.0470975,-0.351314,-0.292588,-0.473985,0.294944,0.264507,0.0601275,-0.181581,-0.143826,0.541324,-0.827989,-0.314015,-0.0133404,0.480106,-0.0370698,0.0671921,-0.339593,-0.519183,0.32099,0.164158,-0.959827,-0.0825485,-0.174383,0.184691,-0.210903,0.0785998,0.241038,-0.301586,0.0755337,-0.592876,0.266146,0.207826,-0.0824244,0.492516,0.305176,0.101447,0.489071,-0.34655,0.492695,-0.874269,-0.654879,-0.267971,0.178779,-0.301025,0.594634,0.379695,-0.0760536,0.184626,-0.100199,0.114581,0.266989,-0.0562908,0.506949,-0.358853,0.440193,0.509539,0.0412158,-0.422112,-0.0437013,0.12076,-0.0563619,-0.24223,0.627374,-0.561885,0.178464,-0.231986,-0.259499,-0.298371,-0.40757,-0.406596,0.0597737,-0.113275,-0.0763669,0.263592,-0.682898,0.212641,-0.640891,-0.0171372,0.126199,0.501353,0.271457,-0.25746,0.32802,0.336137,0.203302,-0.433308,0.244282,-0.506533,0.201925,-0.0710118,0.161464,-0.713019,0.158289,-0.914964,0.188727,0.631599,0.0669348,-0.166958,-0.589365,0.0911238,-0.0713851,-0.567484,0.671022,-0.429571,0.148028,0.10867,-0.474795,0.719302,-0.0935525,0.189944,0.494247,-0.298262,-0.181692,0.214771,-0.329342,0.169986,-0.340395,-0.276956,0.223405,-0.443287,-0.0700232,0.0242943,-0.111569,0.166031,0.170182,0.442976,-0.200464,-0.258207,0.381029,0.012326,-0.0106759,0.0317985,0.00437673,-0.132007,0.0339294,0.502559,0.10037,0.28211,0.0866716,-0.0654927,-0.0999937,0.264065,-0.0703869,-0.120595,0.384099,0.00416045,0.566051,0.314906,0.602262,-0.109357,0.0479609,-0.917211,0.940076,-0.301202,0.691251,0.134594,-0.435348,0.0115522,-0.0351011,-0.211643,-0.142716,0.0197074,-0.207467,-0.0496812,-0.0387558,-0.663675,-0.304488,-0.327529,0.483748,-0.0649799,0.00891386,-0.879049,-0.195295,0.339495,0.247513,-0.288565,0.111857,0.0542463,-0.344408,-0.162149,0.102121,-0.0895432,-0.276229,0.00297716,-0.00850048,-0.261726,-0.262024,0.0438914,0.0546823,-0.0664097,0.0789988,-0.352576,-0.092273,-0.199476,-0.191939,0.208854,-0.0315317,-0.412504,-0.0283842,0.276027,0.0487128,0.121757,0.328935,0.348937,0.573528,-1.4333 +3422.41,0.920693,0.0848144,4,1.56481,0.995025,-1.01426,0.390772,0.868011,-0.129926,0.0379912,0.157068,0.406352,0.314259,-0.13382,-0.51277,-0.269414,-0.0114548,-0.302041,0.671747,-0.500495,-0.00887767,-0.731975,-0.0257813,-0.294182,-0.771488,-0.449047,0.0595794,-0.018034,-0.0379686,-0.380198,0.623359,-0.25303,0.4094,0.803583,-0.818827,0.481021,0.183884,-0.484042,0.0421702,-0.620136,0.650494,0.160791,0.214336,1.2585,0.542507,0.36312,-0.711129,0.234787,-1.05806,-0.351485,-0.0598116,0.368149,0.515592,-0.0834713,0.552704,0.00831972,-0.406719,0.406545,-0.418127,-0.372234,-0.857363,0.609459,-0.354344,-0.0986009,1.29901,-0.399392,-0.555407,-0.194312,-0.187868,0.541157,0.0915066,0.00615035,-0.0217421,0.214415,-0.128552,0.713764,-0.117897,0.263262,0.703488,0.727769,0.0116359,-0.33941,0.0102441,0.52456,-0.196197,-0.0689449,0.344509,-0.0904813,0.291034,0.392432,0.017131,0.0182306,-0.552919,0.181064,0.362108,-0.029636,0.0221884,0.094856,0.0606213,-0.171045,-0.141299,-0.517511,-0.28757,0.0368418,-0.171027,-0.232167,-0.908501,0.425049,0.09906,0.206963,-0.381417,0.252934,0.791314,-0.787407,0.0197509,-0.0477475,0.432179,-0.0277558,-0.0447558,-0.242205,0.155162,-0.0127535,-0.0223769,-1.11124,0.380831,-0.622072,0.327557,-0.144622,0.369889,0.0780169,-0.302427,0.343853,-0.654129,0.383894,-0.00122971,-0.176202,0.759898,0.135777,0.261518,0.247756,-0.676663,0.413377,-0.952946,-0.269734,0.173658,0.248878,0.136326,-0.047294,0.231979,-0.171163,0.339173,-0.120593,-0.0782334,0.107582,0.370449,0.402415,-0.499905,0.00472218,0.384794,-0.20323,0.0244704,-0.23743,0.311317,-0.0240174,-0.207934,0.0900542,-0.481895,0.0868475,-0.138674,-0.266149,-0.376598,0.0279331,-0.644067,-0.0249343,0.0656401,-0.292723,-0.0410493,-0.212122,0.469328,-0.647087,0.465794,0.150241,0.188527,0.037041,-0.151807,0.144574,0.00447991,0.00935113,-0.591185,-0.475977,-0.151153,0.160413,0.142258,0.345732,-0.168637,0.248053,-0.668537,-0.0157888,0.0835684,0.125536,0.0945022,-0.343829,0.0240938,0.039823,-0.185148,0.400712,-0.443413,-0.172657,-0.392249,-0.174829,0.764197,0.00787941,0.210475,-0.0777111,-0.550454,-0.14322,0.102575,0.0620277,-0.165602,-0.368581,-0.555086,0.00859976,-0.0949661,-0.278857,-0.352527,0.0484488,0.30872,-0.208616,0.242505,-0.192671,-0.507717,-0.366119,0.0364791,-0.828483,-0.018704,-0.0219279,0.306628,-0.168724,0.141761,0.236772,-0.232736,0.25101,-0.0938553,0.151382,0.215572,-0.506391,-0.429506,0.473,-0.295964,0.628092,0.135298,0.392819,-0.219008,-0.157703,-0.674388,0.554199,-0.480006,0.0564873,0.167999,-0.363381,-0.169067,-0.474124,-0.118959,-0.338443,0.139531,-0.00617665,-0.120191,0.0281715,-0.0799601,0.258621,-0.0541362,0.150344,-0.0903633,0.262437,-0.979559,0.178885,0.249517,0.283269,-0.162015,-0.261913,-0.13345,-0.353427,-0.23791,-0.0641128,0.253408,-0.477626,0.0570437,-0.213636,-0.337346,-0.174917,-0.394102,0.602384,-0.126439,0.0652935,-0.434874,-0.164064,0.0697857,-0.247023,-0.334657,-0.124005,-0.551396,-0.487086,0.682594,-0.253718,0.111008,0.225141,0.333178,0.474491,-2.88116 +3437.69,0.940198,0.0848144,4,1.6887,0.939272,-0.986217,0.337669,0.73852,-0.0875357,0.256373,0.00218283,0.134299,0.313714,-0.3649,-0.303889,-0.434074,-0.0873533,-0.162601,0.935912,-0.346508,-0.16784,-0.547815,-0.204882,-0.272849,-0.947068,-0.772012,-0.166601,-0.248573,-0.288077,-0.235867,0.648425,-0.445103,0.0412737,0.578606,-0.57235,-0.13416,0.142078,-0.678133,-0.0492112,-0.0661452,0.736606,0.440379,0.0668638,1.36397,0.513433,0.171678,-0.438621,0.0126761,-0.395063,-0.353796,0.276138,0.632835,0.3951,-0.111603,0.632809,0.112631,0.0415844,0.527758,-0.385286,-0.431648,-0.995061,0.491381,-0.775721,-0.263719,0.988376,-0.487105,-0.633691,-0.23549,-0.102392,0.425921,0.281479,-0.0127709,-0.188259,0.325703,-0.058479,0.633806,-0.0431655,0.568332,0.578587,0.337628,0.343553,-1.08638,-0.101475,0.709316,-0.396879,0.0768851,-0.13217,0.19555,0.0852868,0.100174,0.309816,0.12117,-0.520355,-0.113673,0.466315,0.104957,0.188844,0.141963,0.139665,0.0248012,-0.232966,-0.747881,-0.263173,0.0267866,0.0901327,-0.501794,-0.889021,0.670358,-0.134452,-0.400812,-0.543847,0.343949,0.567802,-0.50977,0.0770352,-0.33947,0.348036,0.457058,0.0982479,-0.00404571,-0.0228357,0.419077,0.0454943,-0.912903,0.573019,-0.649708,0.230379,0.0833075,0.488635,-0.28,-0.396783,0.455008,-0.207048,-0.0632308,0.158676,0.152,0.361199,-0.0599615,-0.136846,0.230801,-0.404778,0.26757,-0.475198,-0.355058,0.26964,0.266688,-0.14592,0.0431795,-0.0110468,0.247677,0.320397,-0.0874504,0.0859707,0.103399,0.458,0.519387,-0.453985,-0.0825817,0.126679,0.0837958,-0.171781,-0.523084,0.286777,0.307011,-0.115388,0.264963,-0.427541,0.00731474,0.0254581,-0.258538,-0.762343,-0.0560134,-0.394741,0.0770813,-0.081646,0.0130453,-0.158104,0.345099,0.326149,-0.478553,0.472921,0.324171,0.408192,-0.194508,-0.331853,0.0802654,0.0433486,0.0399585,-0.218591,-0.320632,-0.0611875,-0.102378,0.0833477,0.0933965,-0.0597125,-0.348694,-0.544572,-0.109934,0.0963226,-0.122687,0.0619619,-0.281902,0.0683709,0.0975431,-0.138129,0.526869,-0.629879,-0.0849094,-0.877595,-0.36252,0.769636,0.125593,0.220446,-0.203248,0.1188,0.070284,0.0138161,-0.0985341,-0.191317,-0.395966,-0.460773,-0.404511,0.0842616,-0.208304,-0.294706,0.540581,0.0903288,-0.40011,0.280851,-0.171408,-0.401218,-0.374726,-0.238261,-0.888159,-0.0318093,0.00255725,0.135816,-0.299278,0.0814737,-0.237293,-0.312814,0.502171,0.312559,-0.435664,0.0591902,-0.0571047,-0.31252,0.576812,-0.397558,0.478676,0.290284,0.39156,-0.0444944,0.0455684,-0.380739,0.716491,-0.113492,0.382137,0.382882,-0.233118,-0.0416431,-0.324875,-0.0917848,-0.468465,0.114016,-0.0963466,0.263972,-0.0594632,-0.134348,0.0927702,0.519383,-0.0399948,0.123598,-0.115431,-0.502924,0.475767,0.25204,0.610899,-0.143669,-0.139407,-0.292111,0.0606638,-0.219657,0.147076,0.465639,-0.355827,0.178682,-0.165637,-0.440733,0.0263365,-0.259926,0.249606,-0.0061696,0.113703,-0.254649,0.145666,0.55197,-0.0303352,-0.226681,-0.155355,-0.338354,-0.421532,0.644377,-0.423566,0.116109,0.290976,0.340748,0.539422,-2.20379 +3423.75,0.989089,0.0848144,4,1.57109,0.958254,-1.56956,0.5322,0.535901,-0.142251,0.170599,-0.161437,0.635808,0.196394,-0.0102533,-0.866635,-0.343283,0.163988,-0.393821,0.600137,0.038409,-0.54717,-0.721961,0.1226,-0.431966,-1.29734,-0.963556,0.046739,0.0766551,-0.138741,-0.0202414,0.3171,-0.653124,0.15584,0.410892,-0.790245,-0.558213,0.0498833,-0.54604,-0.11974,-0.0773624,0.837845,0.395755,0.0594561,1.33023,0.555557,-0.017085,-0.487321,0.169831,-0.386653,-0.940933,0.205796,0.224174,-0.146327,0.00953252,1.11938,-0.0634023,-0.27076,0.268757,0.468038,-0.187644,-0.679079,0.366259,-0.542427,0.66361,1.33841,-0.466291,-0.758216,0.673928,-0.109165,-0.52721,0.166051,0.493761,-0.439823,0.298611,-0.00354821,0.612205,-0.280765,0.508203,0.321727,0.0268111,0.401037,-0.199423,-0.254462,0.703751,0.287744,0.045688,-0.293548,-0.171331,0.014535,-0.664235,-0.0379937,-0.253253,-0.109398,-0.597889,0.567654,-0.0728453,0.139212,0.351581,-0.305909,-0.0693879,0.00606287,-0.377884,-0.158468,-0.0297604,0.340781,-0.198638,0.055089,0.320375,-0.184127,0.256649,-0.263532,0.50704,0.703292,-0.416714,-0.0413125,-0.120921,0.473472,-0.286295,-0.187412,-0.424282,-0.0171542,0.481113,0.379998,-0.653744,-0.0554785,-0.0758547,-0.239986,-0.200436,0.3477,-0.0143862,0.183846,0.0146844,-0.64847,0.314471,0.283289,-0.547929,0.229775,-0.286923,0.428037,0.320701,-0.0818784,0.400365,-0.655263,-0.41036,-0.621622,-0.351703,-0.261477,-0.210118,0.212787,-0.188542,-0.351489,-0.258696,-0.108262,-0.562659,-0.0375093,0.378665,-0.406771,0.455027,-0.23176,0.188915,-0.337866,-0.400729,0.187724,0.275737,-0.278956,0.610598,0.681582,-0.307998,-0.151139,-0.0984346,-0.311869,-0.534295,0.103274,0.678232,-0.0334458,0.0732603,-0.375369,-0.137204,0.138796,-0.34366,-0.42865,-0.0698687,0.683912,-0.513595,-0.247841,0.145498,0.122889,0.506673,-0.173323,-0.338871,-0.45536,0.373526,-0.345253,-0.0166754,0.156703,-0.207726,-0.475534,0.680021,-0.0524981,-0.188506,-0.119479,-0.382584,-0.0178401,-0.252857,-0.553348,-0.119223,0.474347,-0.802115,0.195336,-0.301604,1.17163,0.258156,-0.142163,0.145278,0.0785561,0.0597438,0.0258997,-0.203383,0.387921,-0.309369,0.0335088,0.218393,-0.0881149,-0.247963,-0.544302,-0.71502,0.381423,0.368473,0.281588,0.0410222,-0.168602,-0.0695771,-0.24595,0.0688585,0.147236,-0.225784,0.0778218,-0.399157,0.527983,0.688046,0.384227,0.156343,-0.0665824,-0.217806,0.125525,-0.103851,0.0547635,-0.103306,0.105416,0.332864,0.318204,0.244821,-0.325638,-0.0220513,-0.0247993,0.0989818,-0.176571,0.459488,-0.0771729,-0.719208,-0.177829,0.317244,0.190326,0.411694,0.319081,-0.140643,0.33529,0.0697554,0.307784,0.214053,0.53036,0.514899,-0.154533,0.337067,-0.248294,-0.426054,-0.171286,0.0930656,0.513318,-0.332929,0.265904,0.810544,-0.437744,-0.518706,-0.892138,-0.0423851,0.534719,-0.0840888,-0.0167259,-0.0182281,0.807602,-0.213737,0.127666,-0.118025,0.0020197,0.0271842,0.170059,-0.126036,0.158071,-0.0353694,-0.392978,-0.480589,-0.098084,0.406369,0.123764,0.276501,0.351801,0.525833,-1.54661 +3425.46,0.706733,0.0848144,4,1.5695,0.871648,-1.55925,0.516667,0.162542,-0.0849088,0.241367,-0.153047,0.325118,-0.21732,-0.144814,-0.586937,-0.365255,-0.0232219,-0.160181,0.82628,0.136884,-0.428351,-0.37627,0.00189552,-0.00573988,-1.13305,-0.519237,0.251038,-0.572174,-0.0785127,0.36913,0.273937,-0.432793,0.0708323,0.885494,-0.922843,-0.572835,0.230286,-0.634184,0.171873,-0.259976,1.20686,0.724111,0.11606,1.07738,0.549407,0.494686,-0.900491,0.0335676,-0.711941,-0.177064,0.560925,0.53689,-0.0210419,0.535474,0.655842,-0.16338,-0.0133109,0.39377,0.0824764,-0.207328,-0.450123,0.0226544,-0.319462,0.408367,0.822023,-0.282976,-1.26388,-0.0903693,0.265194,0.0770527,-0.0275227,-0.355314,-0.304209,-0.0616202,1.03629,1.05619,0.0618428,0.714418,0.405933,0.919695,-0.267604,-0.768412,-0.0531371,0.671075,-0.848082,0.0453396,-0.0646457,0.283627,-0.189619,-0.084459,-0.208108,-0.263818,-0.498896,-0.0208281,0.100566,-0.144776,0.17229,-0.393601,0.221351,0.0773387,-0.283126,-0.281006,0.350599,0.0312382,-0.0128319,-0.530099,-0.70726,0.25024,-0.558252,0.27907,-0.112695,0.452013,0.105257,0.266871,-0.0882834,0.0028214,0.282717,-0.12703,0.353476,-0.11032,0.272602,0.904813,-0.0902885,-0.472255,-0.144065,0.0398492,-0.399026,-0.0175421,0.2541,0.357947,-0.455484,0.269773,-0.731962,0.0652121,0.097747,-0.0865275,0.328538,0.0351609,0.156989,0.40025,-0.57976,-0.0803914,-0.447987,-0.268591,0.18318,0.0993251,-0.393379,-0.185987,-0.237078,0.00888784,0.404428,-0.142037,0.0869226,-0.0197442,-0.231943,0.160884,-0.383582,-0.015971,0.381333,0.512782,-0.184336,-0.148994,0.15698,-0.107708,-0.217591,0.243911,-0.131827,0.232153,0.56796,0.0334905,-0.391586,-0.728153,-0.0259521,0.70765,-0.0878844,-0.157306,-0.649928,-0.0086429,-0.00839678,0.00578217,-0.22443,0.181411,0.687527,0.585825,0.0670677,0.636518,-0.816517,0.218791,-0.265167,0.291406,-0.0205312,0.469382,0.0504756,0.65261,-0.283877,0.177694,-0.456634,0.180215,0.702642,-0.286562,-0.177023,-0.557262,0.321549,-0.525439,-0.0397978,-0.0807614,-0.465728,-0.0678885,0.365889,-0.487821,0.64523,0.368381,0.30268,-0.00829877,-0.594073,0.0724429,-0.297944,-0.172262,-0.28261,-0.219953,0.0908608,-0.133787,0.22117,0.223914,-0.417565,0.311561,0.655387,-0.410409,0.515022,-0.0220939,-0.553692,0.00959939,0.123611,-0.0112296,-0.0581597,-0.239591,-0.097797,-0.25398,0.599885,-0.368243,-0.250014,0.749946,-0.24217,0.172718,0.150808,0.154407,0.223481,0.0759802,0.214924,0.00766953,0.322789,-0.0628461,-0.499578,0.812931,-0.887138,0.293781,-0.0594164,0.541044,0.0453352,-0.670767,-0.0399403,-0.0342524,-0.355507,-0.0764183,0.187737,0.225566,0.094431,0.17784,-0.203229,-0.0209662,0.115649,0.557953,-0.0353852,-0.288035,0.0709633,-0.540816,0.137961,-0.0128649,-0.197289,0.15316,0.363014,0.00943139,-0.162879,-0.27864,-0.010947,-0.621193,0.116044,0.17081,0.131018,0.118602,0.259431,0.259121,0.19795,0.149755,-0.39668,0.459127,0.0990582,0.0830377,-0.690107,0.186085,0.284973,0.105793,0.347863,0.0966676,0.110726,0.393197,0.332755,0.627054,-0.160638 +3430.49,0.980045,0.0848144,4,1.53153,0.855349,-1.16935,0.394909,1.0096,-0.0118529,-0.0543991,0.0714459,0.493599,0.314843,0.105536,-0.341267,-0.755856,0.239589,-0.335127,0.819168,-0.188125,-0.271551,-0.000285548,0.261529,-0.283486,-0.755295,-0.846784,0.234036,-0.402334,-0.262974,0.25879,0.698015,-0.209411,-0.00509315,0.8383,-0.309847,0.385062,0.354359,-0.105188,-0.201709,-0.0877464,0.436172,0.584564,0.417264,1.13229,0.907722,-0.0349807,-0.152731,-0.00884618,-0.629919,-1.02283,-0.103676,0.072863,0.063905,0.153729,0.533768,0.131682,0.0538005,0.593854,0.0794357,-0.153898,-0.60436,0.84932,-0.628612,-0.061571,1.35661,-0.249468,-0.699509,0.488093,0.0453941,0.382118,0.0474866,0.145324,-0.340553,0.2018,0.0979503,0.35603,-0.403456,0.210023,0.64067,0.370698,0.186102,-0.290079,-0.0512357,0.312499,0.354608,0.0350433,-0.0301692,-0.253415,-0.152452,-0.227389,-0.391231,0.402733,-0.321791,0.0528012,-0.153845,0.0160547,0.39438,0.514212,-0.136484,-0.131343,-0.927076,-0.392208,0.00329737,0.065102,0.113639,-0.144873,-0.222563,0.517694,0.0758885,0.201562,-0.122459,0.273117,0.649975,0.0709912,-0.373758,-0.105582,0.632773,-0.262774,-0.0908282,-0.716145,0.0047636,0.0618092,0.21906,-0.463367,0.012153,-0.0339829,0.18719,-0.198784,-0.0717912,-0.400774,0.126704,0.117683,-0.129855,0.23923,0.255654,0.333511,0.682977,0.0784876,0.0116006,-0.388285,-0.0368676,0.65269,-0.649368,-0.469083,-0.450297,0.57508,-0.257457,-0.524388,0.145387,-0.205527,0.176909,-0.393902,-0.209425,-0.431286,0.296859,0.0682219,-0.00810916,0.131202,0.385029,-0.13489,-0.6192,0.213906,-0.0997946,-0.116699,-0.221679,1.06828,0.483385,-0.436707,-0.152135,0.162517,0.253023,0.00376466,0.35722,0.153631,-0.29841,0.165358,0.523141,0.17926,-0.230883,-0.368548,0.178545,0.534237,0.552406,-0.668363,-0.132105,-0.00279088,0.469784,-0.533019,-0.0594574,-0.534804,-0.276422,0.480027,0.46271,-0.20113,-0.130858,-0.345369,-0.0162278,0.00241141,-0.0721218,-0.133844,-0.394519,-0.124835,-0.174779,0.12064,0.213639,-0.120191,-0.0888825,-0.296612,-0.548826,-0.546563,0.837528,-0.111429,-0.0169005,-0.104821,0.0416258,0.258836,0.0906933,-0.220533,0.985497,-0.207727,-0.00576014,0.333481,-0.216451,-0.0642806,-0.671754,0.0533109,0.0424344,0.126762,0.159149,-0.467182,-0.120659,0.222747,0.263339,-0.144564,0.229803,-0.0165201,0.0547182,0.114433,0.462833,0.88987,0.724402,0.324515,-0.381594,-0.644346,0.00163575,0.0460719,0.166873,0.464369,0.168028,0.434562,0.359345,-0.19276,-0.391107,-1.00024,-0.283981,0.33442,0.0579762,-0.761827,-0.0422463,0.192306,0.257128,0.0714522,-0.161705,0.269976,0.535971,-0.0744144,-0.00122592,-0.122552,0.593467,-0.47511,0.323788,-0.272314,-0.0303982,0.0123481,-0.44321,0.162397,-0.187513,-0.263767,-0.28392,-0.0460365,-0.138891,0.0753864,-0.0404026,0.230312,-0.187843,0.078373,-0.000588049,0.139498,0.419653,-0.593764,0.231377,-0.0410096,-0.482165,-0.144561,0.0615753,-0.39016,0.0371587,-0.297883,-0.0113506,0.269929,-0.30141,-0.559866,-0.360648,0.173735,0.112807,0.191696,0.335868,0.437831,-3.08949 +3429.93,0.700472,0.0848144,5,1.47544,0.944072,-0.941116,0.338707,0.678966,0.00314495,0.294698,-0.150908,0.517245,0.372014,0.226987,-0.288499,-0.93966,0.204054,-0.284964,0.927389,-0.25765,-0.377587,0.0928146,0.267491,-0.120309,-0.819803,-0.403228,0.322828,-0.514199,-0.118587,0.169582,0.762183,0.0491765,-0.0217201,0.757853,-0.221006,0.619859,0.149592,-0.248867,-0.253812,-0.493226,0.585412,0.58876,0.301354,1.03593,0.525188,0.0317388,-0.45437,0.0617441,-0.415917,-0.843177,0.140448,0.374118,0.072641,-0.124149,0.233866,0.283943,0.0845633,0.56141,-0.0863736,-0.152834,-0.392176,0.595123,-0.293617,0.149266,1.29543,-0.522902,-0.589114,0.0430511,0.105164,0.484553,0.0890954,-0.151573,-0.317233,-0.0162286,0.207883,0.56274,-0.0562557,0.441629,0.573654,0.562819,-0.105678,-0.263713,-0.367118,0.405357,0.26482,0.0711792,-0.363098,-0.225543,-0.0398709,-0.158392,-0.350589,0.331474,-0.44134,0.0656448,0.0589123,-0.0954335,0.454201,0.346981,0.0563326,0.206658,-0.262299,-0.0798148,-0.0253768,-0.130063,0.253558,0.0489457,-0.286782,0.291432,0.399417,0.527253,-0.14599,0.287677,0.435259,0.151725,-0.237383,-0.637227,0.409512,0.190827,-0.138636,-0.688686,0.0230217,0.233661,0.205237,-0.454184,-0.425429,0.0373675,0.114895,-0.121686,-0.254516,0.106592,0.193023,0.104911,-0.480523,0.166117,0.182364,0.29051,0.263468,-0.0253278,-0.192416,-0.298866,-0.148915,0.575238,-0.866713,-0.651079,-0.339233,0.445012,-0.625131,-0.242297,0.673353,-0.0982408,0.0526639,-0.320075,-0.470933,-0.19724,0.230347,0.264894,0.105083,-0.257361,0.495256,-0.0350466,-0.371514,-0.105777,-0.096558,-0.186158,-0.155579,0.915747,0.79724,0.0517634,0.00591815,0.139802,0.162411,0.0654836,0.605841,0.0924589,-0.143174,0.060072,0.0909143,0.0559448,-0.336416,-0.373177,-0.163928,0.362477,0.377669,-0.786937,0.177612,-0.0310576,0.425701,-0.332027,0.00909634,-0.410967,-0.551403,0.29631,0.188844,-0.414078,0.088567,-0.163606,-0.337114,0.362521,0.0628024,-0.241895,-0.178534,-0.444917,0.300627,0.160468,0.00666289,-0.116606,0.205398,-0.129137,-0.507061,-0.404039,0.971166,-0.173722,0.272402,-0.158217,-0.0865352,0.158019,0.458183,-0.307493,0.953921,-0.444417,0.142844,0.453659,0.0295954,-0.420191,-0.831802,0.326642,0.00830752,-0.388741,0.349988,-0.281043,-0.231178,0.239994,0.540195,-0.0763231,0.280477,0.544272,-0.234112,-0.0591838,0.111129,0.343894,0.299725,0.344669,-0.177927,-0.237026,0.00402074,0.0179498,0.291241,0.400663,0.00808664,0.482562,0.19192,-0.362257,0.0864301,-0.579777,-0.626648,0.569105,0.607798,-0.497893,-0.194073,-0.174281,0.455287,0.0548273,-0.0800346,0.555873,0.75677,-0.0964456,0.145033,0.272516,0.574077,-0.0639045,0.247818,-0.0201919,-0.0783234,-0.383487,-0.545011,0.236814,-0.541853,0.120332,-0.292013,0.0481771,-0.0846751,0.691233,-0.151942,-0.0382416,0.151376,0.159695,0.0859149,0.0761787,0.22709,-0.705449,0.0386159,0.369791,-0.360425,-0.0715029,0.306459,-0.526554,-0.163577,-0.0517171,0.420719,0.0775187,-0.646661,-0.12383,-0.415502,0.190689,0.106241,0.187025,0.325947,0.432464,-2.27518 +3440.72,0.943709,0.0848144,4,1.49179,0.995367,-0.790224,0.229184,0.830861,-0.0405261,0.339705,0.109113,0.472601,0.357783,0.106971,-0.0875872,-0.512842,0.43797,-0.400686,0.81953,0.0565733,-0.225935,0.06178,-0.0176811,-0.196315,-0.955925,-0.58969,0.0361789,-0.468825,-0.0733037,-0.120351,0.660396,0.188607,-0.0941194,0.652263,-0.441316,0.0637861,0.254016,-0.0244523,-0.0396294,-0.295487,0.847848,0.642,-0.205249,1.09901,0.569898,0.471875,-0.0997899,-0.0097658,-0.0573425,-0.859679,0.0848221,0.202604,0.222281,-0.0708972,-0.184363,-0.255338,-0.346082,0.735164,-0.111777,0.249902,-0.214458,0.553031,-0.358398,-0.133311,1.43557,-0.071517,-0.616553,0.511692,-0.313512,0.106518,-0.524621,0.327131,-0.160453,-0.0307309,0.339536,0.459813,-0.0936763,0.627423,0.530937,0.578635,-0.105781,-0.188337,-0.0445408,0.709505,0.240882,-0.102342,-0.603306,0.267439,0.258145,-0.240166,-0.163003,0.347991,-0.489987,0.0282862,0.29374,-0.472877,0.103901,0.0145378,0.0341471,-0.0381149,-0.293098,-0.0165579,0.127004,-0.145309,0.20234,0.0220921,0.0116083,0.3152,0.243208,0.778611,-0.468317,-0.0170847,0.748907,0.26214,-0.202217,-0.217707,0.554191,0.146876,0.0899854,-0.732775,0.346104,0.598704,-0.143132,-0.75684,-0.182518,-0.0639282,-0.0376051,-0.0302785,-0.366443,-0.111897,-0.0220841,-0.0419884,-0.332994,-0.035347,0.118814,0.493973,0.520077,-0.521075,0.149945,-0.486069,-0.0977253,0.432078,-0.360362,-0.779811,-0.0814415,0.784442,-0.36765,-0.619991,0.48937,0.0849626,0.466486,-0.280027,-0.260789,0.0444289,0.231335,0.307718,-0.116502,-0.32298,0.216885,-0.10684,0.114067,-0.285295,0.0329184,-0.327856,0.0197073,0.719102,0.5014,0.148895,0.49918,0.158793,0.167613,0.237352,0.76554,0.533884,-0.516264,-0.0638873,-0.14949,0.137952,-0.543088,-0.286104,-0.282468,0.252307,0.473001,-0.321304,-0.0238609,-0.210182,0.294983,-0.360266,0.446171,-0.638391,-0.437764,0.301311,0.491943,-0.241748,0.354967,-0.0193145,-0.47311,0.195655,0.318346,-0.11914,-0.153306,-0.598316,0.190109,-0.12735,0.0473592,-0.123653,0.222224,-0.128622,-0.399986,-0.0178608,1.0772,-0.373215,-0.180632,0.475935,0.191437,0.268293,0.639258,-0.498142,0.628876,-0.0187247,0.296796,0.222055,-0.343919,-0.106148,-0.408772,-0.216783,0.359247,-0.0364503,0.485998,-0.396901,0.116115,0.37848,0.136402,-0.0118623,0.0969284,0.0323417,-0.0310427,-0.0673225,0.500483,0.015631,0.00608241,0.273049,-0.320376,-0.185907,-0.459752,-0.298575,0.140028,0.429373,0.343857,0.324039,0.0158852,-0.469279,-0.30961,-0.248028,-0.512506,0.712128,-0.283632,-0.233878,0.155722,-0.448323,0.514711,0.191833,-0.00935059,0.183332,0.696585,0.0816497,0.424865,0.068578,0.421353,0.0161795,-0.088809,-0.55847,-0.181276,-0.130165,-0.44001,0.0473911,-0.474065,0.084574,-0.385525,0.117314,-0.0231611,0.345307,-0.1601,0.133413,0.0500772,-0.248358,-0.150637,0.00374803,0.284336,-0.389846,0.112615,0.516067,-0.117779,-0.149681,-0.162917,-0.431623,-0.0637638,0.145029,0.477742,0.33731,-0.440932,-0.0266696,-0.33307,-0.569305,0.134762,0.165222,0.367099,0.406475,-2.81827 +3441.69,0.904669,0.0848144,5,1.61365,0.716466,-0.869995,0.218334,0.269408,-0.0914549,-0.0443159,0.452494,0.20805,0.43718,0.255529,-0.264421,-0.50104,0.314437,-0.481562,0.616337,0.0346568,0.196843,-0.311425,0.128997,-0.0488042,-0.902201,-1.08404,0.784382,-0.248131,0.0551193,-0.348746,0.0785717,-0.571006,0.0027031,1.05601,-0.265846,-0.288728,0.460092,0.157673,0.0119074,-0.621855,0.696262,0.380357,0.110138,1.04443,0.561189,0.567223,-0.548586,-0.0139391,-0.223394,-0.720138,0.0476057,1.00388,0.279184,0.0940577,-0.300561,0.133157,-0.976016,1.11112,-0.338314,0.0480858,-0.76541,0.584249,-0.711549,-0.120902,0.808612,-0.399834,-1.3557,0.22378,-0.236961,0.0548645,-0.555905,-0.544465,-0.190641,-0.526525,0.903413,0.447723,-0.212619,0.0662408,0.305619,-0.0294962,0.0888006,-0.256921,0.0878351,0.636258,0.0452834,-0.188295,-0.123126,-0.00781932,0.0833513,0.331335,0.21011,-0.0614317,-0.357186,-0.0041338,-0.324233,-0.111551,-0.143147,0.351024,-0.360774,-0.284095,0.176053,-0.0864381,0.435076,0.163334,-0.095859,-0.531916,-0.362388,0.079812,-0.0404573,-0.0934634,-0.761059,0.362039,0.509299,-0.166578,0.0632531,-0.257183,0.332866,0.00246454,-0.111882,0.131739,0.242763,0.284509,0.287634,-0.585259,0.16505,-0.413502,-0.0573149,0.0614314,0.332299,0.509717,-0.099817,-0.14358,-0.308612,0.592942,0.176253,0.499431,0.719555,-0.114772,-0.0163826,0.0357764,-0.417395,0.280468,-0.459213,-0.406914,-0.345901,0.217515,-0.471897,-0.25594,0.0776541,-0.0490448,0.294412,-0.27249,0.375762,0.0303967,0.161931,0.158524,-0.054578,0.107121,0.0573551,0.247551,-0.28034,0.215135,-0.248065,0.0702923,0.031426,0.826147,0.153557,0.547007,0.308454,-0.11459,-0.334076,-0.13582,-0.0304541,0.532874,0.159038,0.177622,0.370093,0.00322325,-0.355788,-0.101329,0.570144,0.450102,0.786278,0.600444,-0.209886,0.402166,-0.323407,-0.377357,-0.457365,0.408619,-0.0696143,0.429122,0.150326,-0.0899886,0.383181,-0.235019,-0.876639,0.11957,0.368478,0.11138,-0.361032,-0.519855,0.224973,-0.383999,-0.185651,0.196704,-0.382715,-0.297352,-0.065404,-0.0784545,0.609023,-0.439848,0.0938595,-0.209505,-0.291453,-0.198831,0.0698014,-0.0772176,0.0313458,-0.573728,0.0837143,0.509148,-0.339012,0.132733,0.0127415,0.27155,0.0700809,-0.295588,0.271437,-0.295477,0.187378,0.366915,0.148963,-0.643354,0.0261018,0.121823,-0.56491,-0.270958,0.411136,0.00051502,0.616715,0.52669,-0.53389,-0.164784,0.435058,0.352916,-0.279781,0.428693,-0.316493,0.273853,0.216955,0.824777,0.124189,0.746901,-0.716336,0.317511,-0.480332,-0.116616,0.0214316,-0.196258,-0.0264433,0.113477,-0.425555,-0.113867,-0.55432,-0.492896,0.0176776,-0.298551,0.131323,-0.0837043,-0.130743,-0.0676192,0.0185852,-0.345744,-0.114351,0.261783,0.151459,-0.206057,-0.166574,-0.0220454,-0.0112323,-0.214466,0.355345,0.162037,-0.215393,0.305217,0.580016,0.0615176,-0.0104224,0.327445,-0.201947,0.335233,0.163759,0.137668,0.226648,-0.0772234,0.342814,0.146997,-0.195126,0.395899,-0.51468,-0.685912,-0.0648032,-0.311514,0.0947037,0.414038,0.30774,0.643458,-0.27449 +3454.52,0.708235,0.0848144,4,1.48356,0.789101,-0.568845,0.125189,0.345087,-0.0589266,0.406778,0.201948,-0.0867917,0.647067,0.293304,-0.317111,-0.506773,0.585659,-0.396458,1.02494,0.579652,-0.0744413,-0.495299,0.0704214,0.0875108,-0.666253,-0.480733,0.884374,-0.460203,-0.106022,-0.415695,-0.252649,-0.41139,0.0490115,1.02989,-0.672501,-0.0320684,0.19648,0.407189,0.0858925,-0.7445,0.587438,0.438089,-0.556397,0.951889,0.558574,0.216764,-0.687215,0.154797,-0.208078,-0.716276,-0.504269,0.632201,0.40694,0.122611,0.0561077,0.355547,-1.12501,1.23444,-0.456836,0.110553,-0.834464,0.477377,-0.166874,0.117387,0.887484,-0.390665,-0.699495,-0.0325523,0.114866,-0.202248,0.072294,0.027318,-0.0905835,-0.550353,0.66562,0.629472,-0.375699,0.217892,0.455394,-0.190595,0.479259,-0.0337063,0.0723715,0.440891,-0.275909,-0.349726,-0.0977469,-0.267436,0.155546,-0.0365642,0.170495,0.0550478,-0.434217,-0.162045,-0.192861,-0.164028,-0.325792,0.0396095,-0.0649834,0.030036,0.0292784,0.178426,0.281696,0.448591,-0.0263713,-0.0402434,0.0112878,-0.480797,0.269827,-0.321182,-0.321145,0.367625,0.564655,-0.00720649,-0.118779,-0.00032551,0.525172,0.207225,-0.102822,-0.154794,0.278429,0.180742,0.119162,-0.249974,0.193709,-0.100478,-0.50857,0.0935427,-0.0912183,0.234286,0.230015,0.023742,-0.213734,0.460152,0.129496,-0.119903,0.39949,-0.346457,0.304596,0.638295,-0.301924,0.479274,-0.48673,-0.582323,-0.174459,0.000642022,-0.405042,-0.240236,0.0798021,0.0842046,0.192779,-0.311038,-0.327949,-0.482893,-0.147871,-0.0989639,0.0354776,0.522099,0.203504,0.34462,0.203902,0.201145,-0.309087,0.192377,0.309703,0.790307,-0.0856877,0.299687,0.50115,-0.189385,-0.140167,0.0306318,-0.52461,0.38379,0.45898,-0.127153,0.128294,-0.200728,-0.395004,-0.196809,0.172136,0.552534,0.706459,0.173309,-0.212549,0.680325,-0.131623,0.238646,-0.361212,0.0762881,-0.0370923,0.138468,0.186235,0.160701,0.28637,-0.306974,-0.808368,-0.139154,0.335167,-0.263342,-0.199606,-0.334828,0.0509359,-0.514236,0.187029,0.0699267,-0.465981,0.00100289,-0.0957039,-0.532186,0.863319,0.0330249,0.0727624,-0.292702,-0.0844092,-0.293762,-0.347528,0.146763,-0.065451,-0.455663,0.0678519,0.219021,-0.0341614,0.268651,-0.432903,0.288149,0.12498,0.204118,0.279197,-0.112505,0.109257,0.0780728,0.17226,-0.138017,0.0299894,0.303651,-0.290897,-0.410349,0.541609,0.0441,0.123977,0.767479,-0.340459,-0.357125,0.234325,0.0454118,0.0550477,0.374196,-0.144524,0.0427202,0.345952,0.592415,-0.460834,0.447504,-0.712178,0.452706,-0.139228,-0.0805442,-0.0759686,-0.199254,0.208,-0.121379,-0.591985,-0.150305,0.0488538,-0.00194627,0.0624903,0.0252135,0.0904911,-0.0109326,-0.344581,-0.152205,-0.0833742,-0.297564,0.0235741,0.265889,0.14904,-0.750493,0.161466,-0.00509331,-0.196082,0.0730301,0.142308,0.14175,-0.3549,-0.111598,0.0865359,0.0427857,0.0203293,0.314257,-0.572542,-0.0838945,0.339551,0.0983354,-0.0524345,0.137236,0.463961,0.0475521,-0.288071,0.362134,0.144064,-0.460921,-0.267373,-0.0683046,0.113469,0.386057,0.336852,0.621335,-0.862259 +3452.95,0.478024,0.0848144,4,1.61794,0.646963,-1.03596,0.278623,-0.0155335,-0.095666,-0.301646,0.0742595,-0.135491,-0.0845666,-0.224892,-0.220202,-0.573937,0.303964,-0.165613,0.547706,-0.00286589,-0.0900689,-0.412796,0.485837,-0.198674,-0.902931,-0.908141,0.838952,-0.764761,-0.0567651,-0.320668,-0.205946,-0.435877,0.0951038,1.00181,-0.991006,-0.184783,0.399586,-0.179069,-0.00481572,-0.572314,0.201019,0.205648,-0.462758,1.1721,1.11712,0.398826,-0.441016,-0.125977,-0.263312,-0.6346,0.213504,1.10927,0.00546485,0.259937,0.23759,0.352384,-0.330005,1.20807,-0.39368,0.195157,-1.07756,0.328924,-0.347674,0.523652,0.573072,0.0244832,-0.590705,-0.437439,-0.00560023,-0.416821,-0.030824,-0.227671,-0.245141,0.0478035,0.13664,0.633252,0.483155,0.272022,0.138648,0.123131,0.114829,-0.260353,-0.0798346,1.03948,-0.236461,-0.181768,-0.0125519,-0.312328,-0.305807,0.212516,-0.0594962,0.306619,-0.352544,-0.201396,0.277359,-0.00319391,-0.085184,-0.0106296,-0.142891,-0.0068279,-0.21671,0.46221,0.428761,-0.350607,0.168992,0.167494,0.154783,0.0756269,-0.230571,-0.0284461,-0.0781282,-0.0126595,0.72402,0.193931,-0.44422,-0.03135,0.260053,0.442302,-0.0810792,-0.304726,0.499081,0.607253,-0.565429,0.036912,-0.282119,-0.484339,0.0300585,-0.180575,0.274069,-0.0831173,-0.152288,0.439733,-0.506045,0.290795,-0.10709,0.104639,0.481417,-0.15008,0.152136,0.241722,-0.243332,0.351001,-0.519164,-0.585815,-0.404386,0.144444,-0.653106,0.11443,0.0877498,-0.0726599,0.404419,-0.372131,0.00436787,-0.169985,0.135997,0.173566,0.38702,0.102409,0.0844558,0.478757,-0.135001,-0.196523,-0.150186,-0.430775,-0.219226,0.410592,0.121567,0.0853555,0.169033,-0.433011,-0.0653868,-0.150022,-0.179183,0.0162936,0.270775,0.0105074,0.344898,0.0405678,0.674129,0.14535,-0.0438851,-0.127751,0.824248,-0.14107,-0.402791,0.427954,0.0738082,-0.0859292,-0.421069,-0.0628941,-0.169067,-0.104998,-0.538769,-0.0341447,0.130328,-0.197529,-0.0918208,0.102313,-0.180394,0.0702861,-0.503833,-0.439787,0.022321,-0.483386,0.113003,0.069968,-0.0684407,-0.220883,0.21548,0.0290189,0.712824,0.288613,0.169873,0.278862,0.052628,0.377788,-0.218609,0.105365,0.444812,0.408015,0.0925619,-0.6187,-0.241917,0.549477,-0.272921,-0.215111,-0.00235353,-0.654849,0.0151069,-0.174824,-0.357262,0.488253,0.311305,-0.405411,0.0672307,-0.20159,-0.122293,0.00178268,0.744073,-0.0932153,-0.160126,0.450442,-0.857912,-0.27805,0.085891,0.291089,0.455105,0.244294,0.157131,0.533989,0.191589,0.425507,-0.0525531,0.0312079,-0.528501,0.279396,-0.172628,0.075579,-0.178171,-0.284838,-0.228992,0.307463,-0.195205,0.247538,0.211125,-0.375228,0.0192718,-0.072833,0.221985,-0.0052848,0.0823546,-0.049418,0.124624,-0.0526243,-0.0648445,-0.213049,0.579192,0.0796734,-0.0424304,0.284017,-0.581508,-0.100895,0.161478,-0.0379359,-0.509432,-0.195768,-0.0814017,-0.256517,-0.0541231,0.191931,-0.368527,0.023483,0.40217,-0.104952,0.522293,0.124331,0.214558,0.0544876,-0.120205,-0.323189,-0.0756766,0.093594,-0.279165,-0.0368405,0.0818892,0.191226,0.286163,0.437293,0.829699 +3443.1,0.711381,0.0848144,4,1.58844,0.899291,-0.78325,0.18144,-0.2061,-0.173917,0.122301,-0.0416156,0.596115,0.881789,-0.440936,-0.104665,-0.336202,0.261255,-0.331048,1.01106,0.582633,-0.0587523,-0.256886,-0.291536,-0.350088,-1.03139,-1.13478,0.495319,-0.26298,-0.204818,-0.0694759,0.737718,-0.380605,-0.0539017,0.867764,0.0982789,-0.126196,-0.175542,-0.0927082,-0.0250591,-0.580588,0.42459,0.11932,0.220836,1.21289,0.727088,-0.295326,-0.731596,-0.308467,-0.175184,0.0267924,0.283505,0.593038,0.300947,0.37457,-0.178045,0.294368,-0.925464,0.868259,0.269316,-0.313068,-0.473538,0.174652,0.135602,0.435161,1.11009,-0.518192,-0.744331,0.504789,-0.155191,0.0991774,-0.243457,-0.171623,0.0296061,-0.567411,0.670411,0.490464,-0.101896,0.27608,0.130172,0.339407,0.166296,-0.497674,0.0379534,-0.0344444,0.259632,-0.146347,0.119782,-0.262804,0.49645,-0.0534175,-0.568036,-0.402216,-0.674907,-0.126167,-0.038429,-0.0681852,0.0433089,0.0346396,0.274366,0.153515,0.385427,-0.526414,-0.0138758,0.13126,-0.287917,-0.508965,0.163575,0.361689,-0.177099,0.544782,-0.539744,0.14967,0.255315,-0.0264423,0.0485058,0.0178036,0.318664,-0.229318,0.0498207,-0.317488,0.0241719,-0.0987015,0.179661,-0.773558,-0.368339,0.0385104,0.116296,-0.035283,0.13205,0.231785,-0.290391,0.259063,0.184961,-0.0190283,0.243864,0.108285,0.168296,-0.381242,-0.28367,-0.10945,-0.0369065,0.396101,-0.615154,-0.453513,-0.386555,0.156326,-0.317328,0.220683,-0.257153,0.0186414,-0.150211,0.0978971,-0.0476998,-0.570079,0.139968,0.142156,-0.17234,0.185839,0.438083,-0.341484,-0.431822,-0.479374,-0.133249,-0.193683,0.0880775,0.574169,0.117386,-0.378975,0.170123,0.108502,-0.344852,-0.206549,-0.502526,0.21725,-0.104925,-0.281907,-0.36753,0.151159,0.0617755,0.110993,-0.27542,-0.256744,0.351087,-0.0553774,-0.17789,0.306358,0.077301,-0.215992,-0.110692,-0.195285,0.383807,-0.521525,-0.105638,0.203443,-0.0380029,-0.0878132,-1.25508,-0.0643441,0.724733,-0.35273,-0.148907,-0.0428327,0.36543,-0.193013,0.151568,-0.0092869,-0.195509,-0.217747,-0.0813241,-0.615369,0.815884,0.472602,0.133817,0.0314844,-0.297482,0.293111,0.347819,-0.228861,0.233551,-0.812595,0.00541021,0.0490776,-0.344999,-0.0937876,-0.0165003,-0.00727185,-0.269238,-0.262092,0.24036,-0.446953,-0.162567,-0.220897,-0.42924,0.46508,-0.122096,-0.463195,-0.0364503,-0.205307,0.590839,0.102641,-0.0436955,0.54307,-0.200651,0.217897,-0.0179274,0.00971464,-0.548955,0.0602863,-0.610743,0.554763,0.148007,0.251253,-0.228239,-0.221656,-0.102856,0.387733,-0.34202,0.00575131,0.289719,-0.204622,0.232501,-0.258855,-0.328273,0.0479796,0.268172,0.0670699,-0.494567,-0.0651286,-0.0164694,-0.156134,-0.328417,0.161108,-0.225761,-0.101816,-0.450838,-0.00782009,-0.123738,0.319076,-0.404336,-0.0393079,0.0772607,0.612293,0.183532,0.603119,0.120149,-0.332922,-0.0719125,-0.059502,0.106231,-0.243928,0.920208,-0.289489,-0.470156,0.0334776,0.00778406,-0.164125,0.323288,0.195731,-0.727812,-0.121809,0.0817623,-0.411839,-0.303979,0.427901,0.0961504,0.373886,0.310081,0.611462,0.965684 +3438.84,0.813035,0.0848144,4,1.53449,1.03324,-0.75631,0.199507,-0.253245,-0.0932699,-0.0544375,-0.0182467,0.603465,0.398838,-0.548618,0.130901,-0.525121,0.673964,0.269275,0.645201,0.0314203,-0.145468,-0.0390149,0.44647,-0.462234,-0.956619,-0.306141,0.20113,0.0193697,-0.134518,-0.0236115,-0.149994,-0.317153,0.176449,0.726054,-0.610884,-0.273445,-0.150527,-0.476805,-0.0321495,-0.697774,0.599701,0.200436,0.15201,1.24809,0.865352,0.425801,-0.728897,-0.393013,0.101097,-0.152527,0.479291,0.607562,-0.0137652,0.6424,0.482998,0.334743,-0.677097,0.899468,0.42369,-0.0598402,0.00972023,0.12148,-0.244409,0.112287,0.726295,-1.94774,-0.903633,0.456853,-0.338559,-0.222601,-0.550653,-0.24421,0.038724,-0.239356,0.0865162,0.142141,-0.0119842,0.768676,0.0696804,0.0315308,0.0612024,-0.103891,-0.00851826,0.737898,-0.349746,-0.0978999,0.0652184,-0.0941763,-0.0746095,-0.0580491,0.124384,0.489329,-0.495988,0.313936,-0.29144,0.613596,0.141873,0.0977588,0.575112,0.101956,-0.422586,0.0155417,0.15889,0.187714,-0.305772,-0.673033,0.265679,0.278365,-0.493845,0.404055,-0.79044,0.0884565,-0.109556,0.411999,-0.250665,0.218945,0.0348436,-0.184921,0.379737,-0.155048,0.467076,-0.20459,0.179314,-0.450766,-0.325549,-0.675736,0.115969,0.533608,0.0765223,-0.128389,-0.329318,0.542115,-0.966881,0.30773,-0.0824245,-0.0679266,0.253298,0.0413775,-0.365683,-0.29138,-0.182224,0.160977,-0.117506,-0.332977,-0.151358,0.282859,-0.695198,-0.236525,-0.0304174,0.204923,0.379786,-0.0991231,0.271336,-0.195666,0.412694,0.0460717,-0.297894,0.269455,0.392439,0.378475,-0.239498,-0.294213,0.150224,0.558806,0.0241361,0.681616,-0.516121,-0.41604,-0.299413,0.1325,-0.449429,-0.472637,0.2728,0.123456,0.308781,-0.343643,-0.0288618,0.189487,-0.0549472,0.274375,0.0476934,0.339145,0.923862,0.25884,0.338356,-0.270248,0.241041,-0.00260805,-0.390205,-0.255415,0.124772,-0.424297,-0.132582,-0.0867359,0.384618,0.0162558,-0.75761,-0.0903425,0.243359,0.191,-0.372225,-0.352533,0.187529,-0.279471,-0.0253262,0.153587,-0.0350089,0.0130302,0.175621,-0.00476743,0.870805,-0.0300783,0.341037,0.145534,-0.459678,0.117111,-0.0602031,-0.14936,-0.00840388,-0.0348968,0.0183759,-0.220716,-0.0661885,0.230052,-0.338161,0.216536,-0.255183,-0.265422,0.516853,-0.543692,-0.525234,0.259863,-0.0300732,-0.207789,-0.181992,-0.409846,-0.389974,-0.639058,0.550792,-0.175568,0.0405215,0.384971,0.171516,-0.208312,-0.321243,-0.263739,0.354127,-0.0306876,-0.100583,0.0502514,0.428749,-0.206849,-0.252257,0.149584,-0.462125,0.269673,0.051229,-0.313647,0.0699724,0.239842,-0.0993827,0.142158,-0.175639,0.217901,0.0788561,0.180479,0.183297,0.471253,0.156976,0.0760057,0.0092447,0.190078,0.264024,-0.135068,-0.0321331,-0.410885,0.102515,-0.000622773,0.126216,0.0844486,-0.206235,0.730734,0.177664,0.117455,-0.625666,-0.185627,-0.085684,-0.0703784,-0.190703,0.0256399,0.40345,-0.112486,-0.268946,-0.392309,0.0620379,0.00487296,0.224872,-0.0641074,-0.205883,0.0803964,-0.123975,0.198954,-0.214653,-0.144821,0.103872,0.252967,0.322292,0.502959,0.779989 +3416.16,0.993119,0.0848144,4,1.45874,0.818387,-0.587813,0.158208,-0.551179,-0.276128,0.40113,0.271338,0.498184,0.309087,-0.152489,-0.0402396,0.370541,1.29859,0.211228,0.897713,0.393767,-0.380476,0.272157,0.310083,0.00260205,-1.056,-0.8503,0.5337,-0.319064,-0.26445,0.184065,0.424789,-0.118155,-0.795518,0.959351,-0.00451616,-0.254682,0.046641,-0.46106,0.46621,-0.427329,0.460128,-0.0678029,-0.270728,1.21163,0.702427,-0.0559238,-0.892357,-0.0342501,-0.608654,-0.561295,0.0837069,0.618279,0.439804,0.583159,-0.365874,0.210383,-0.0206155,0.900339,0.0703748,-0.0657137,-1.32062,0.439241,-0.274682,0.477256,1.06208,-0.890662,-0.710336,0.487093,0.380667,0.0993659,0.420964,0.54541,-0.354518,-0.135595,0.286754,0.449881,-0.585907,0.236128,0.513785,0.686952,-0.377475,-0.61399,0.125985,0.16689,-0.520005,0.233274,-0.0445121,-0.770967,0.186258,-0.241169,-0.26552,-0.0241654,-0.174415,-0.0498702,0.163254,-0.23686,0.100489,0.0494897,-0.666118,0.0424412,0.358285,-0.210361,0.183974,-0.258672,-0.288875,-0.389135,-0.510998,0.0134846,-0.24324,0.359732,0.491492,-0.198008,0.681484,-0.522695,-0.208015,-0.285909,0.410456,-0.395767,-0.343031,0.0355335,0.067135,1.07034,-0.528221,-0.83966,-0.017134,0.803369,-0.389659,-0.523745,0.602266,0.266368,0.194275,0.177282,-0.143734,0.111576,-0.178938,-0.301385,0.550893,-0.354506,0.250295,-0.461869,0.004046,0.430079,-0.113774,-0.351832,-0.0130242,0.207073,-0.702444,0.37197,0.350941,-0.126365,0.711469,0.131454,-0.321848,-0.317399,-0.0201826,0.373382,0.138546,-0.136013,0.0651955,-0.00840132,-0.435148,0.107718,0.0853952,-0.00832424,0.368653,0.64756,0.534866,-0.348197,0.803198,-0.209467,-0.114576,-0.211364,-0.141432,0.0929815,-0.238627,-0.0888937,-0.398236,-0.437813,-0.30214,-0.42795,-0.0762886,0.193414,0.314345,0.633556,-0.17814,0.409079,-0.269496,-0.310403,-0.285537,-0.0818479,-0.219875,0.271192,-0.115909,-0.217754,-0.334566,-0.118986,-0.229283,0.599803,-0.236022,-0.325249,-0.311648,-0.339618,-0.261283,-0.0295417,-0.179138,-0.112286,-0.175266,-0.0228349,-0.444233,-0.179546,1.05916,-0.131765,0.295429,0.191096,-0.137635,-0.110117,0.367156,-0.0227256,0.628005,-0.76351,-0.0252424,0.531982,-0.0977272,-0.0551575,-0.158474,-0.46734,0.570187,0.201884,0.294946,-0.969592,-0.559766,-0.00426385,-0.0357674,-0.174909,-0.0677896,-0.265337,-0.162617,0.0591144,0.539869,-0.0461808,-0.00464015,0.663972,-0.277104,0.00927235,0.0765607,0.390691,0.0384332,0.176507,0.368438,1.05196,-0.246643,-0.704404,-0.601863,-0.195647,-0.327063,0.374309,-0.142291,-0.181773,-0.0492347,-0.796258,0.18857,-0.473124,0.287878,-0.115421,0.69806,0.167802,0.373825,0.17676,0.538323,0.135007,0.164504,-0.699296,0.483924,-0.0466686,-0.554096,0.264551,0.0817737,-0.340672,-0.55377,0.0546751,0.186088,0.10793,0.149616,-0.237903,0.28136,-0.00979111,0.168207,0.436122,0.273153,-0.291713,-0.000746765,-0.00882973,-0.105894,0.235537,0.342214,0.249913,0.35653,0.179963,0.25812,0.0655653,0.00727154,-0.154201,-0.0378923,-0.351727,0.146272,0.431958,0.382455,0.657235,2.06951 +3413.02,0.975948,0.0848144,4,1.51159,0.758839,-0.661568,0.172759,-0.112376,-0.090899,0.202849,-0.281634,0.120561,0.320051,-0.0556194,-0.271368,0.130916,0.966686,0.456283,0.574365,0.406352,-0.171532,0.0128997,0.641985,0.052819,-0.589863,-0.430402,0.338577,-0.158071,-0.0962015,0.268349,0.372882,-0.0975597,-0.209375,0.803716,-0.431883,-0.491638,0.0543494,-0.166812,0.196486,-0.514492,0.277658,0.415922,0.557331,1.2621,0.30506,0.242072,-0.649725,0.223484,0.227495,-0.920636,-0.229351,0.556744,0.179579,0.850683,-0.102007,0.20367,0.0294067,1.10135,0.145624,0.114247,-0.779034,0.531181,-0.545365,0.150082,1.09689,-0.851707,-0.410737,0.310202,0.0483921,0.359818,0.139003,0.271057,-0.0387543,0.474951,0.0531568,-0.0934347,-0.743223,0.449984,0.596607,0.850466,-0.251939,-0.533384,0.0178424,0.420724,0.164921,0.36275,0.000636602,-0.55647,-0.242613,-0.405062,-0.263923,0.447059,-0.453019,0.130264,0.142814,0.215623,0.274969,-0.0207346,-0.475928,-0.125545,-0.426052,-0.292416,0.322547,0.288713,-0.275815,-0.233034,-0.068854,0.0419806,-0.0334211,0.227924,-0.174076,0.23432,0.262383,0.243537,-0.518139,-0.628264,0.22309,0.21382,-0.174449,-0.223429,0.16291,0.299708,-0.617491,-0.155719,0.298721,0.458661,0.376827,-0.773195,0.532048,-0.066949,-0.280025,0.174316,-0.544978,-0.283595,-0.23661,0.218696,0.798967,-0.00236805,-0.171367,0.446554,0.00418962,0.353499,-0.31456,-0.122201,-0.108815,0.0921108,-0.903223,0.11863,-0.222316,0.162499,0.796327,-0.057379,-0.221563,-0.789974,0.355441,0.018286,0.0990708,0.0121129,0.852798,0.223984,-0.128508,0.170259,-0.516335,-0.699578,-0.135684,0.268514,0.516222,0.211538,0.679688,0.208838,-0.150081,-0.554008,0.0682616,0.590864,-0.243859,0.0395428,-0.29834,-0.491126,-0.0470072,0.0810939,-0.626075,-0.00815204,0.656052,0.350524,-0.470667,0.146629,0.221804,-0.245824,-0.571366,-0.278421,-0.262186,0.588064,-0.385654,-0.185803,0.0822316,0.207115,-0.450095,0.640592,-0.293445,0.161079,-0.292674,-0.432832,-0.216596,0.131206,-0.0937533,-0.0243443,-0.0742023,-0.313519,-0.128847,-0.152778,0.975721,0.617185,-0.53104,0.365732,0.100415,0.163932,-0.120658,-1.0524,0.275029,-0.706379,-0.225881,0.380007,-0.0561156,-0.0628154,0.0993263,-0.481833,-0.139015,-0.170257,0.371299,-0.541124,-0.246822,0.58792,-0.229166,0.140294,0.0971285,0.366324,0.269566,-0.594154,0.294967,-0.520924,-0.0132808,0.15982,-0.422587,-0.0544999,0.409606,-0.0257975,-0.0720991,0.618282,0.251268,0.348363,0.499173,-0.24014,-0.307881,-0.0806404,-0.334425,0.407718,-0.461591,-0.238398,0.203314,-0.295371,0.432769,0.0240035,-0.0362518,0.473828,0.121809,0.127823,-0.239823,0.333227,0.554112,0.137359,0.0303022,-0.00807529,0.589873,0.131686,-0.642005,-0.142028,0.0361193,0.00522262,-0.666358,0.0448329,0.290245,0.0215647,0.145635,0.29015,-0.104125,-0.659718,0.431696,0.66915,0.0593316,-0.655518,0.399394,0.0823947,-0.122716,0.0547645,0.0549527,-0.104067,0.27227,0.11228,-0.163973,0.224553,-0.280159,0.303513,-0.772543,-0.447034,0.125293,0.279692,0.353967,0.528859,0.749548 +3422.41,0.975555,0.0848144,4,1.467,0.700284,-0.901792,0.276949,0.167729,-0.189174,-0.135491,0.0525404,0.347279,-0.00804329,0.356185,-0.200653,0.170805,1.01897,0.0878355,0.672427,0.319143,-0.288449,-0.0502552,0.349456,0.222202,-0.916881,-0.455522,0.454665,-0.516948,0.159638,-0.120934,0.29392,-0.651509,-0.34069,0.776759,-0.877536,-0.320952,-0.0646628,0.0400791,-0.137686,-0.516261,0.522722,0.197002,0.351333,1.17028,0.389028,0.667601,-0.140726,0.0185638,0.364412,-0.200352,0.110988,0.452848,0.169857,0.500677,-0.22824,0.201186,-0.428833,1.15986,-0.17541,0.154126,-0.0827248,0.506799,-0.132415,0.339995,0.892114,-0.877754,-1.04308,0.386274,0.214492,-0.0393203,0.289206,-0.144159,-0.421547,0.0955754,0.366817,0.402632,-0.185399,0.36764,0.382171,0.392306,0.0745222,-0.0387022,-0.162984,1.0197,-0.00847176,0.527868,0.0504982,-0.323967,-0.00780748,-0.112623,-0.259847,0.631814,-0.0798981,0.229364,0.186884,0.152394,0.112107,0.087891,-0.40871,0.0390836,-0.0683296,-0.329884,0.273409,0.511931,0.328634,-0.0838073,-0.37783,0.230311,-0.175634,0.422506,-0.185247,0.113275,-0.00239625,0.404206,-0.27142,-0.304193,0.478684,-0.0961002,-0.171691,-0.79827,0.214234,0.481516,-0.116388,-0.531398,-0.0474971,0.240628,0.0996187,-0.0624963,-0.261734,0.231061,-0.345297,-0.000922386,-0.216287,0.140926,-0.333679,-0.206617,0.40791,0.0565317,-0.16985,-0.00371375,-0.967324,0.252468,-0.875357,-0.574765,0.0510304,-0.185862,-0.174474,0.170424,0.294076,-0.127444,0.433961,0.24627,0.139951,-0.308228,0.524331,0.125178,-0.0233609,0.10286,0.363529,0.257641,-0.316202,-0.407389,-0.678492,-0.181646,0.0222511,0.389778,0.171544,0.019519,0.479591,-0.0942709,0.0690946,-0.772766,0.508741,0.333506,-0.392201,-0.0665862,-0.337103,0.0412068,0.263852,-0.0478613,-0.311043,-0.371131,0.819645,0.0303738,0.205952,0.118288,0.259463,-0.0210902,-0.639047,0.0305123,0.00867836,0.438002,-0.237372,-0.261381,-0.254227,0.186418,-0.58048,0.638161,0.295943,-0.769947,-0.454892,-0.355093,0.0250823,0.188584,-0.335045,-0.0162872,0.172884,0.295729,0.0555195,-0.38233,1.33955,0.373236,0.0255941,0.0931703,-0.0283701,0.532019,-0.0403442,-0.572608,0.168057,-0.38179,-0.0130259,0.751717,-0.0843411,0.274697,-0.357,-0.567863,0.0237183,0.443897,0.715003,-0.379789,-0.265964,-0.00966524,-0.00937109,0.272703,-0.115421,-0.00132418,0.149512,-0.607289,0.335778,-0.521711,0.36127,0.15842,-0.419239,-0.184656,0.072617,-0.307927,0.141807,0.460849,-0.234977,0.438134,0.0336464,-0.748607,-0.74076,-0.143786,-0.491733,0.135053,-0.555841,-0.119463,0.00239457,-0.170288,-0.0929301,0.643065,0.113095,0.404386,-0.439342,-0.275296,-0.107294,0.420918,0.226678,-0.0937339,0.238877,-0.107843,0.591381,-0.120967,-0.43497,-0.525418,0.0591896,-0.640992,-0.292401,0.368093,0.496279,0.0780992,-0.0452686,0.205186,-0.495163,-0.306369,-0.133238,0.218103,0.287166,-0.645276,0.283861,0.0774237,-0.263016,0.201558,-0.349563,-0.115035,-0.110318,0.284544,0.0163763,0.160161,-0.605016,0.743769,-0.270614,-0.291502,0.136478,0.220509,0.369429,0.469584,-0.0694335 +3437.15,0.900391,0.0848144,4,1.49068,0.721056,-0.873346,0.298557,0.273988,-0.200432,-0.0203188,0.107256,0.36771,0.328065,0.216121,-0.116166,0.236241,0.903418,0.0714735,0.60207,0.565263,-0.266288,-0.154548,0.637505,0.198118,-0.778948,-0.682253,0.286191,-0.578698,0.146574,-0.0741658,0.227711,-0.412836,-0.357872,0.756905,-0.751025,-0.541192,0.0653801,-0.00368731,-0.170156,-0.206684,0.316116,0.321983,0.111047,1.10757,0.336903,0.38214,-0.0682278,0.161431,0.438953,-0.351861,-0.011187,0.55954,0.197206,0.490079,-0.200281,0.046569,-0.403604,0.925432,-0.255616,-0.0353509,-0.234685,0.391201,-0.163024,0.423414,0.989845,-0.718582,-1.09602,0.498496,0.296636,0.0748618,-0.0635976,-0.0822423,-0.43163,0.0348184,0.28063,0.42161,-0.165468,0.360898,0.409586,0.323265,-0.0956753,-0.260453,-0.3017,0.989503,-0.481615,0.418128,0.03648,-0.324615,0.0103623,-0.230432,-0.347531,0.516801,-0.285811,0.294456,0.168066,0.119008,0.134893,0.107547,-0.410129,0.0277902,-0.1894,-0.197533,0.168939,0.195648,0.140182,-0.221279,-0.282469,0.1054,-0.123084,0.722778,-0.300747,0.382791,0.0636692,0.542094,-0.260415,-0.350898,0.463922,-0.166473,-0.474229,-0.79451,0.449378,0.368198,0.227309,-0.453351,0.0760767,0.177601,-0.113858,-0.20344,-0.302207,0.297859,-0.176681,-0.0527681,-0.240872,0.0824698,-0.220032,-0.239515,0.575909,-0.0421521,-0.108173,-0.0851285,-0.798494,0.222353,-1.05239,-0.541422,-0.0825683,-0.075327,-0.19931,0.468422,0.246412,0.111857,0.336288,0.287499,0.104468,-0.278909,0.574877,0.130892,-0.310618,-0.00975096,0.276131,0.283854,-0.27503,-0.219257,-0.674746,-0.0884875,0.0218331,0.48415,-0.122728,0.162987,0.419949,-0.069887,-0.0516805,-0.829963,0.524629,0.333228,-0.311705,-0.0348075,-0.292726,0.00226128,0.229418,-0.19836,0.0280307,-0.231703,0.826739,0.281027,-0.0128714,0.116181,0.243194,-0.188665,-0.850853,0.0165184,0.0410708,0.534252,-0.0647332,-0.237464,-0.307089,0.155075,-0.606047,0.60974,0.313726,-0.759071,-0.322591,-0.378192,-0.11374,0.181054,-0.396613,0.0852501,0.147921,0.19837,-0.114617,-0.353864,1.27583,0.404748,0.0690014,0.273542,-0.236763,0.255495,-0.127599,-0.523293,0.231493,-0.414124,0.0870036,0.666988,-0.044337,0.0753418,-0.400261,-0.391984,-0.0138312,0.515496,0.44878,-0.401035,-0.0993509,-0.0287899,-0.239336,0.0798668,-0.000994757,0.0068728,0.301917,-0.545409,0.464047,-0.587406,0.331577,0.188132,-0.376719,-0.257056,0.0111197,-0.179109,-0.233068,0.442806,-0.278724,0.541726,0.05111,-0.663025,-0.553877,-0.179097,-0.414009,0.423068,-0.453563,-0.36557,-0.080161,-0.0765135,0.0539904,0.543404,0.039827,0.384534,-0.281635,-0.40191,0.239738,0.353712,0.287451,0.048991,0.0105593,-0.0914494,0.350609,0.0906946,-0.481922,-0.387351,0.073072,-0.565303,-0.15954,0.31023,0.607226,0.0926016,-0.0402651,0.1709,-0.706732,-0.194069,-0.0403667,0.181106,0.199945,-0.794937,0.260083,0.243493,-0.534933,0.160224,-0.328899,-0.0575846,-0.122226,0.332523,-0.264013,0.136601,-0.72539,0.796906,0.0491394,-0.40602,0.127327,0.186509,0.356829,0.431867,-0.467857 +3411.74,0.687448,0.0848144,4,1.46543,0.683149,-1.20053,0.430531,-0.072437,-0.214441,0.197684,0.235543,0.464365,0.531675,-0.121841,-0.298491,-0.0301484,0.890003,0.37678,0.510054,0.189131,0.0286149,0.269707,0.636853,0.0852042,-0.701547,-0.992105,0.551931,-0.328988,-0.197843,-0.00885074,-0.000608861,-0.392426,0.0937779,0.783393,-0.284525,0.453623,-0.0152342,-0.421495,0.420229,-0.271337,0.471655,0.0829801,0.148901,1.22844,0.644335,0.30706,-0.81385,-0.186256,0.0516895,-0.49747,0.0274012,0.699383,-0.470056,0.637919,-0.0442829,0.377413,-0.344349,0.833407,0.14236,-0.24996,-0.155209,0.281555,0.0265874,0.151105,1.10497,-0.719364,-0.679753,-0.156159,-0.0104442,0.280105,-0.828117,-0.39331,-0.412089,0.251341,-0.0187399,0.260928,-0.112444,0.538506,0.579602,0.41798,-0.0885444,-0.594786,-0.01071,0.39982,-0.360187,0.0541599,0.463764,-0.649551,-0.116714,0.258363,-0.501003,0.736779,0.0224215,0.0606161,0.19844,0.211216,-0.0238944,-0.0795755,0.0461084,-0.118942,-0.194845,-0.609843,0.149351,0.532116,0.519061,-0.241864,-0.372371,-0.430449,-0.315309,0.660903,-0.211055,0.729934,0.528848,0.392921,-0.0791565,0.105402,0.382409,0.0340575,0.0686325,-0.245725,-0.0225889,0.698365,-0.152667,-0.58779,-0.744374,-0.230016,-0.0663129,-0.400838,-0.408156,-0.12871,-0.23517,0.595418,-0.301561,0.148184,-0.252798,0.125612,0.493966,-0.205293,0.302825,0.072808,-0.260271,0.128956,-0.171799,-0.233139,0.147093,-0.347494,-0.658444,-0.538984,-0.338622,0.634158,-0.288975,-0.0162959,0.0715958,-0.0189714,0.483196,0.50693,0.0204789,0.357228,0.449825,0.296421,-0.432058,0.240417,0.361019,-0.237167,-0.294846,0.875988,-0.379162,0.0650342,0.207017,0.0739634,0.420665,0.035395,-0.225456,0.318085,-0.304826,-0.0360787,-0.119003,0.0192239,0.172938,0.202436,-0.16815,0.207274,0.498382,-0.229017,-0.461924,0.538179,-0.346388,0.0877389,-0.903113,-0.606924,-0.139042,0.350231,-0.619334,0.225775,-0.240305,-0.31575,-0.298378,0.0653906,-0.0975538,-0.293256,-0.116956,-0.406675,0.240149,-0.0884393,0.0125014,0.497615,-0.0826865,0.417456,-0.0262365,-0.128894,0.950255,0.915086,0.0509409,0.197305,-0.479044,0.341067,-0.163443,-0.115499,1.03226,-0.0379909,-0.0630671,0.195309,-1.0837,-0.0595537,-0.730187,-0.268293,0.782006,0.232585,0.220617,0.0984171,-0.326933,0.129444,0.367425,0.102731,0.0409831,-0.452416,0.0464706,-0.0734613,0.717478,0.180431,0.0477457,0.537447,0.359204,0.331143,0.425205,0.26579,-0.251574,-0.157052,-0.0413579,0.725299,0.612726,0.180646,-0.557407,-0.146314,-0.247592,0.442694,-0.262366,-0.582135,-0.023426,-0.427237,0.0614771,0.482779,0.473558,-0.197889,0.245048,0.577147,0.0783596,0.518633,0.537744,0.432274,0.0926451,-0.568123,0.349834,0.212819,-0.556324,-0.340556,0.987288,0.702819,-0.442596,0.0508068,0.0400724,0.0288472,0.227478,-0.0468507,-0.158096,-0.831197,0.208446,0.401166,0.403136,-0.374106,0.789445,0.202477,-0.717801,0.321497,0.473022,0.153149,-0.474786,0.0586196,0.140007,-0.357676,-0.163264,-0.113273,-0.488333,0.347204,0.175951,0.237036,0.419466,0.486863,0.774217 +3401.36,0.823193,0.0848144,5,1.56755,0.836917,-0.743769,0.299177,0.142292,-0.00804357,0.352518,0.22036,0.0587734,0.00339859,-0.353143,-0.336493,-0.0152615,0.51876,-0.0189079,0.83961,-0.10134,-0.363047,-0.152524,0.0245644,0.224357,-1.05219,-0.17918,0.0470275,0.33769,-0.0330951,0.0113631,0.48433,0.144827,-0.378904,0.668541,-0.427954,-0.512764,0.502301,-0.168418,-0.565808,-0.260304,0.0554702,-0.0263646,-0.066322,0.961683,0.374471,0.0638621,-0.515746,-0.398051,0.232223,-0.563353,0.0319505,0.393437,0.222519,0.123341,0.382305,0.0154907,-0.304864,0.784736,-0.343746,-0.166482,-0.683352,0.321805,-0.25201,0.434936,0.841536,-0.633748,-0.726147,0.503116,0.457682,-0.380159,0.507287,0.566748,-0.0820868,0.363693,0.805991,0.661316,-0.0420595,0.67527,0.607682,0.310016,-0.245279,-0.0197702,-0.173595,1.10803,-0.826595,0.731724,-0.721512,-0.189396,0.373138,-0.675781,-0.12097,-0.531374,-0.445254,-0.109604,-0.287299,0.0111494,-0.453743,0.756988,-0.428046,-0.148848,0.122938,0.0665294,0.12748,-0.27029,-0.0175864,-0.4512,0.187395,0.334869,-0.104158,0.484633,0.0122558,-0.180485,0.683795,-0.0587698,0.0684016,-0.253475,0.17705,0.293768,0.476844,0.0898978,0.414532,-0.0938287,-0.0342188,-1.05414,0.968343,0.281201,-0.723549,-0.822813,0.000738647,0.160114,0.0591048,0.218791,-0.426316,0.0338256,0.0260995,-0.243973,0.695091,0.314353,-0.360148,-0.0387299,-0.380974,0.213946,-0.873638,0.306707,0.227462,-0.0784038,-0.721702,0.47105,-0.191871,-0.937796,1.04259,0.0765497,0.0619604,-0.571499,-0.137515,-0.0660583,0.311982,0.0101775,0.823571,0.33693,-0.531514,-0.185686,0.184514,0.877871,-0.163446,1.25531,0.23188,-0.0668524,0.490491,0.0108581,-0.575214,-0.318161,0.118987,-0.208197,0.135229,-0.110192,0.330698,-0.0798343,-0.311467,-0.336121,-0.0358545,0.567825,0.60967,0.28885,-0.302068,0.273748,0.344955,-0.516571,0.510044,0.153884,0.214386,0.555259,-0.214406,-0.408431,0.322133,0.0367174,-0.370876,0.717882,-0.0843317,0.0888295,-0.636804,-0.768732,-0.590251,0.262162,-0.15816,0.180549,0.418485,-0.00778743,0.0791938,-0.437527,1.10016,-0.827444,0.106763,0.133813,0.0674487,-0.130129,-0.40193,-0.0284134,-0.191188,-0.674238,0.349784,0.48861,0.128695,0.107066,-0.191167,0.203235,0.0499073,-0.394152,0.761923,-0.39221,-0.242676,0.248168,-0.459793,-0.266634,-0.0348689,0.170587,-0.235547,-0.528176,0.435167,-0.0552359,-0.495934,0.241248,-0.300662,-0.0813424,-0.329501,-0.887116,0.288981,0.814815,0.486075,0.558215,0.0641047,-0.449941,-0.288496,-0.277704,-0.580224,0.666911,0.175805,-0.0272417,0.411969,-0.544392,0.345654,-0.189178,0.148798,0.292185,0.338526,-0.479314,0.121607,-0.337327,0.0317307,-0.0805146,-0.648328,0.204496,-0.0872291,-0.497161,0.26172,-0.0709275,-0.13399,-0.323499,-0.0596763,-0.0363298,-0.235288,0.281056,-0.331523,0.0799536,-0.0294348,-0.49068,0.464336,0.308494,0.355196,0.00288233,0.022076,-0.0647944,0.728038,-0.411367,-0.468365,-0.0965217,0.609632,0.0430879,-0.579078,0.298122,0.111451,-0.168354,0.233997,-0.231716,0.20325,0.172956,0.450832,0.41588,-0.275388 +3409.23,0.982074,0.0848144,5,1.62871,1.20621,-0.521877,0.00657377,0.516434,-0.120935,0.476172,0.0704744,0.225139,0.495861,-0.203869,-0.374136,-0.412949,0.0700711,-0.332867,0.820426,-0.383398,0.179664,0.331206,-0.194365,-0.410021,-0.935807,-0.700395,-0.490163,-0.0334954,-0.371742,0.00310314,0.485407,-0.0435651,0.452625,0.464544,0.273214,0.554746,0.139352,-0.386475,-0.0869077,-0.527128,0.939655,0.696689,-0.00316579,0.871608,0.15658,-0.197359,-0.639129,-0.294577,-0.208235,-0.722553,-0.307863,0.44369,-0.0332788,0.343623,-0.37339,0.0412566,-0.306336,0.858436,-0.204051,-0.141588,-0.770073,0.114965,-0.209283,-0.310836,0.630533,-0.977024,-0.803249,0.163817,-0.138045,0.423501,-0.176699,-0.361955,-0.783113,-0.147507,0.443939,0.188064,0.238922,0.810483,0.720819,0.363792,-0.0429343,-0.350193,-0.365074,0.162759,-0.288548,0.0456326,-0.683417,0.0887201,-0.154996,0.142132,-0.233215,0.473918,-0.411085,-0.0295862,0.348211,-0.430773,0.4985,0.0849564,-0.422262,-0.217836,-0.34237,-0.852767,0.403916,1.02253,0.58384,-0.0497144,-0.147588,0.0807288,0.125591,0.700822,-0.16615,0.540296,0.404689,-0.485545,-0.365737,0.300529,0.253033,-0.00316897,-0.195007,-0.518437,0.0736934,0.208475,-0.281972,-0.506962,-0.166867,-0.695039,-0.628686,0.301319,-0.215762,0.212821,0.37231,0.16848,-0.505169,-0.135593,-0.180157,0.338607,0.423697,-0.180951,-0.0533586,-0.717497,0.0213889,-0.0450976,-0.403057,-1.00226,0.184139,-0.234041,-0.528821,-0.225409,0.11093,-0.206421,-0.481298,-0.376292,-0.174889,-0.452899,-0.169825,0.36073,0.240683,0.387319,-0.112329,-0.060513,-0.00926326,0.118297,0.109239,-0.350353,0.103658,0.706358,-0.179683,0.518084,-0.03572,0.187426,-0.268711,-0.059241,0.146875,0.661531,0.200985,-0.190642,-0.282883,-0.111501,-0.209624,0.00361527,-0.404716,0.595656,1.05849,-0.183402,0.104838,-0.204947,-0.826079,0.333417,-0.0892801,-0.400572,-0.551881,-0.0162557,-0.20815,-0.166645,-0.000414297,-0.0708259,0.0456939,-0.745616,0.172978,0.259961,-0.407858,-0.604422,0.139272,0.0952341,-0.682203,0.411015,0.00786053,-0.0566343,-0.253196,-0.492861,0.640938,0.356054,0.154106,-0.561207,0.0023905,0.198418,0.55638,-1.13179,0.153559,-0.804046,0.025991,0.0902945,-0.00378227,-0.415921,-0.409496,-0.536548,0.390451,0.123407,0.280913,-0.45708,-0.149915,-0.203355,0.0935314,-0.766769,-0.0959226,-0.399243,0.0471085,-0.156379,0.823342,0.245007,-0.824612,0.576719,-0.494587,-0.359882,-0.0771103,-0.588382,-0.0580364,0.52963,-0.127878,0.3429,0.649465,0.790478,-0.734883,-0.0975653,-0.866902,0.321019,-0.408966,-0.21165,-0.168425,-0.69862,0.0474493,0.0657491,0.0259997,-0.486105,0.4862,-0.0967339,-0.0784022,-0.299962,-0.414145,-0.185541,-0.407173,-0.591376,-0.24318,-0.119299,-0.275862,0.233188,0.205361,0.4288,0.114531,0.165505,0.486316,0.721123,-0.157371,-0.157716,-0.486827,0.00606512,0.0745233,0.0808116,-0.0609358,-0.240527,0.105917,0.327436,-0.903885,0.0278307,0.426499,-0.228135,0.276167,0.239747,-0.348291,0.00949958,-0.167739,0.365579,-0.140787,-0.122667,0.169173,0.215745,0.411306,0.464483,-1.92005 +3404.09,0.987374,0.0848144,4,1.6725,1.17288,-0.136139,-0.0863048,0.410506,-0.159511,-0.0278721,0.0021716,0.0236063,0.550664,-0.166166,-0.441126,-0.146319,0.436851,-0.430829,0.916491,-0.339426,0.22182,0.457583,-0.196824,-0.438241,-1.08141,-0.507046,-0.297343,-0.0276866,-0.603695,0.0999943,0.183008,0.00351559,0.0934338,0.628437,0.139546,0.519914,0.388837,-0.675979,-0.164865,-0.53896,0.476962,0.526756,-0.00788537,0.904353,0.152435,-0.228331,-0.361007,-0.136203,0.271835,-0.956644,-0.0836856,0.501707,-0.681131,0.244942,-0.352123,0.232118,-0.159773,0.888204,-0.0122205,-0.31037,-0.727441,-0.0865622,-0.470447,0.179237,0.243824,-1.064,-0.801171,-0.137819,-0.190368,0.259495,-0.152847,-0.297766,-0.813815,0.103698,0.0659044,0.245489,0.155791,0.557897,0.630363,0.0888617,-0.363191,-0.203162,-0.195156,0.514588,-0.258198,0.174476,-0.716061,-0.0351131,-0.0542376,0.050281,-0.607219,0.203855,-0.402797,0.542555,0.282606,-0.579406,0.517834,-0.077811,-0.521612,-0.291364,-0.2134,-0.901248,0.768892,0.205633,0.433963,-0.294181,-0.466865,0.235798,0.0146899,0.350628,-0.211167,0.0868106,0.289836,-0.177642,-0.071677,0.26887,0.211708,-0.387392,-0.119346,-0.759547,0.142799,0.0331568,-0.0558084,-0.504502,-0.611296,-0.398302,-0.839751,0.207726,-0.195971,0.302446,0.340693,0.256519,-0.048418,-0.14035,-0.221965,0.494551,0.460952,0.0090668,-0.00213969,-0.621341,-0.179578,0.0366957,-0.3393,-0.619247,-0.0652945,-0.0696905,-0.416688,-0.0632985,0.0920283,-0.0235043,-0.124837,-0.546216,-0.51955,-0.278108,0.267513,0.378891,0.47312,0.395225,0.0505866,-0.0971548,-0.302757,0.100341,-0.188833,-0.427425,0.446223,0.472813,-0.177235,0.488338,0.266318,0.0603707,0.278779,-0.0435325,-0.176878,0.56826,0.266336,-0.182834,-0.141228,-0.594752,-0.295363,0.0807463,-0.369591,0.706634,1.20889,-0.102168,-0.22561,-0.348042,-0.437392,0.428366,-0.109931,-0.354255,-0.690416,0.132024,-0.268912,-0.465755,0.166983,0.0982424,-0.11658,-0.730651,0.455153,0.148171,-0.192959,-0.365913,-0.152086,0.197132,-0.575644,0.336045,0.286215,-0.139175,-0.25172,-0.403254,0.715936,0.232551,0.442249,-0.526159,0.170395,0.202194,-0.109558,-0.759361,0.188004,-0.804311,-0.105588,0.435514,0.0804793,-0.260131,-0.517469,-0.494755,0.287326,-0.370825,0.483609,-0.403149,-0.231794,-0.0665791,0.102024,-0.466894,-0.0969933,0.152463,0.100868,0.0271035,0.98531,0.0653179,-0.590696,0.825638,-0.522776,-0.232315,0.00209998,-0.612479,-0.219345,0.0429267,-0.306314,0.288337,0.378834,0.562626,-0.900584,0.12183,-0.985961,0.492592,-0.612162,0.181432,-0.220105,-0.716252,0.208917,0.193155,0.0783815,0.0494825,0.496399,0.126374,-0.0729489,0.0113639,-0.315251,-0.0740712,-0.741759,-0.912934,-0.255987,0.0655681,-0.338313,0.0884762,0.0912627,0.146251,0.016918,0.218963,0.0854419,0.662469,-0.00762851,-0.1353,-0.198153,-0.110709,-0.401004,-0.0502861,-0.043515,-0.55047,0.0760985,0.17301,-0.356326,-0.0762132,0.420671,-0.507583,0.617204,0.199899,-0.109882,0.107304,-0.251106,-0.203688,-0.634902,-0.1029,0.162475,0.216033,0.403082,0.464794,-1.57063 +3391.94,0.945418,0.0848144,5,1.64789,1.17707,-0.270875,0.0303683,0.517864,-0.145026,0.334542,0.055437,0.161418,0.609684,-0.140774,-0.384536,0.0543027,0.516322,-0.343821,1.07069,-0.215883,0.217645,0.491972,-0.228519,-0.286594,-1.09205,-0.617845,-0.42364,-0.13344,-0.565639,0.313688,0.2348,0.169042,-0.153286,0.580437,0.0574342,0.332839,0.493247,-0.597335,-0.0958984,-0.511148,0.290675,0.509061,0.0462344,0.60597,0.18955,0.231384,-0.365498,-0.17506,0.214725,-1.02431,-0.13634,0.317828,-0.691759,0.112753,-0.155825,0.183669,-0.723539,0.571889,-0.271958,-0.234508,-0.667239,-0.117583,-0.142799,0.461838,0.162466,-1.0474,-0.77523,0.0193655,-0.168632,0.141649,-0.343739,-0.289022,-0.955372,-0.0501667,-0.0400134,0.147331,-0.269768,0.638876,0.716802,0.13285,-0.485605,-0.356652,-0.19865,0.287867,-0.021281,0.294401,-0.738179,0.228679,-0.0123625,0.094388,-0.683167,0.17854,-0.316287,0.182963,0.242798,-0.659696,0.468752,0.00595097,-0.304174,-0.599786,-0.0621431,-1.27518,0.760353,0.165363,0.379478,-0.472344,-0.537201,-0.00740195,0.170376,0.476029,-0.309783,0.221414,0.294965,-0.352139,-0.11235,0.0388229,0.208363,-0.188148,0.0174827,-0.613366,0.0999772,-0.248662,-0.241877,-0.480306,-0.553789,-0.363298,-0.688431,0.408061,0.0361344,0.346202,0.306069,0.435917,-0.00306097,-0.0343484,-0.405091,0.449805,0.482802,0.0967178,-0.0487757,-0.878099,-0.37967,0.214992,-0.467075,-0.649188,0.0349799,-0.0628401,-0.279749,-0.124969,0.483184,-0.265011,-0.179469,-0.698946,-0.875684,-0.187177,0.299039,0.533539,0.173001,0.503816,0.019184,0.00325876,-0.219316,0.0857733,0.154228,-0.528975,0.286543,0.520226,-0.214063,0.523305,0.250764,-0.0511404,0.345172,-0.31188,-0.311217,0.259469,0.189058,-0.16151,0.0750995,-0.950921,-0.370381,0.00994327,-0.15088,0.553032,1.18207,0.0690095,-0.109654,-0.50958,-0.5923,0.277696,-0.278588,-0.123002,-0.874711,0.0836947,-0.0542014,-0.25275,0.231855,-0.147781,-0.0699375,-0.452123,0.185285,-0.033619,-0.166043,-0.370071,-0.0687327,0.261607,-0.463188,0.34291,0.11607,-0.188328,-0.0313271,-0.429223,0.779258,0.137727,0.162873,-0.666971,0.225571,0.492182,-0.0280031,-0.420622,0.0705428,-0.852141,-0.0615917,0.420485,-0.19613,-0.0843597,-0.375209,-0.340809,0.383609,-0.44647,0.215035,-0.142044,-0.183752,0.151278,-0.0417226,-0.426127,-0.0559195,0.10524,0.0558923,0.136818,0.979925,0.104824,-0.295192,0.744886,-0.345505,-0.294117,-0.0124879,-0.565974,-0.304414,-0.139193,-0.425464,0.11727,0.559484,0.381119,-0.742002,-0.285658,-0.668198,0.490778,-0.712703,0.20736,-0.27385,-0.575979,0.265949,0.181325,-0.0696552,0.0912626,0.30815,0.104846,0.148798,0.257854,-0.477523,0.0757489,-0.747927,-0.498942,-0.113703,0.156259,-0.311407,0.101405,-0.0776642,0.077039,0.334444,0.227137,-0.423202,0.277066,0.565094,-0.0478928,0.385103,0.0148763,-0.356904,0.136737,0.109275,-0.298957,0.243649,0.197013,-0.247576,-0.173359,0.216075,-0.715062,0.463622,0.235152,-0.0347403,-0.215169,-0.0198735,-0.209689,-0.571451,-0.230131,0.16222,0.224892,0.402766,0.474228,-2.00254 +3409.6,0.622801,0.0848144,4,1.62043,1.04171,-0.463144,0.0794864,0.342207,-0.0313219,0.249611,0.696499,0.719779,0.155818,0.291981,-0.508046,0.239015,0.208154,-0.275112,0.741397,-0.196183,-0.0285854,-0.423226,0.44899,-0.155337,-1.15219,-1.20139,-0.103498,0.225056,-0.171628,0.100657,0.461771,0.0303842,0.264572,0.822655,-0.168461,0.0509606,0.119564,-0.582252,-0.258916,-0.368123,0.317085,0.506534,-0.318378,0.696167,0.540234,-0.423137,-0.921608,-0.1649,0.1123,-0.616157,-0.189689,0.787835,0.347801,-0.133033,0.196675,-0.263385,-0.0800009,0.859943,-0.338074,0.226798,-0.569177,0.340957,-0.354357,0.0462759,0.848751,-0.676169,-0.636807,0.398506,0.52445,-0.222934,-0.182563,0.316585,-0.767953,-0.249899,-0.121223,0.678383,-0.100503,0.410676,0.416463,-0.279272,-0.298452,-0.372948,-0.504516,0.592069,-0.645268,0.206886,-0.632987,-0.0227158,-0.109305,0.331772,-0.679622,-0.0940374,-0.580772,0.163501,0.565942,-0.0890621,0.317798,0.257986,-0.23489,0.274809,-0.497812,0.67279,0.628204,-0.413712,0.587234,-0.250955,-0.335999,-0.286496,-0.160003,0.280586,-0.812742,0.33672,0.869773,0.0632056,0.0136635,0.075517,0.159873,-0.0871122,-0.0513842,-0.665295,0.467521,-0.377994,0.0739479,-0.168934,-0.53508,-0.268479,0.272645,-0.505031,-0.00302517,0.377982,-0.201352,-0.232799,-0.357835,-0.219015,0.0920665,-0.447987,0.789191,-0.051688,-0.143761,-0.0520636,-0.575559,0.17422,-0.127717,-0.210426,0.114407,-0.153109,0.105432,0.127394,0.0591964,-0.994684,0.185927,-0.0257292,-1.01134,-0.0769716,-0.0436378,0.0528136,-0.323597,0.19657,0.798418,0.0708175,0.170309,-0.221867,-0.023859,0.00904997,-0.013778,1.08499,0.0346239,0.733262,0.197546,-0.145773,-0.248868,-0.251086,-0.125285,0.0498678,-0.228772,-0.357283,0.393021,-0.346892,-0.0701912,-0.109147,0.332955,-0.343933,0.782604,0.13959,0.0521549,0.243726,0.220581,0.198302,0.0981846,-0.502225,-0.744609,0.428341,-0.757902,0.0265889,0.431051,-0.770263,-0.486404,0.00416492,0.724167,-0.152499,-0.706581,-0.284775,0.359238,0.0404671,-0.374984,0.39329,0.0577523,-0.351477,-0.420876,-0.722201,0.689926,-0.248678,0.279326,-0.181055,0.463201,-0.00303715,-0.0800807,0.142948,-0.106014,-0.0843048,0.452572,0.737391,-0.871476,-0.456611,-0.542673,0.224164,0.0430328,-0.124491,0.285515,-0.213255,-0.162113,0.159144,0.162773,-0.0742851,-0.188935,-0.402339,-0.289356,-0.282666,0.381813,-0.111982,0.205446,0.80587,-0.269904,0.0558705,0.231016,0.514222,-0.392774,0.828929,-0.239849,0.233075,0.774307,-0.303667,-0.172804,0.169275,-1.2196,0.666346,-0.00116079,-0.838673,-0.0914996,-0.496959,0.241325,0.117381,0.105637,-0.286409,0.516608,0.126064,0.228084,0.0751246,0.525997,-0.203998,-0.226587,-0.896121,-0.366551,-0.0756692,-0.204955,-0.390867,0.342765,-0.234292,-0.4231,0.311338,-0.267776,1.01423,-0.217451,-0.257956,-0.124596,0.410665,0.452278,-0.321914,-0.06402,0.508588,0.4338,0.476466,-0.244476,-0.163497,0.223214,-0.309966,0.0246236,-0.158655,-0.682802,-0.183188,-0.0291069,-0.0592431,-0.771955,-0.226261,0.169189,0.217771,0.411326,0.46666,-1.18152 +3402.84,0.994951,0.0848144,4,1.62785,1.03529,-0.43528,0.12262,0.288846,-0.0256338,0.319265,0.80867,0.622496,0.133993,0.269265,-0.458278,0.233749,0.340394,-0.1838,0.856174,-0.120891,0.0345015,-0.492883,0.486702,-0.176051,-1.21641,-1.0975,-0.0669707,0.134956,-0.179036,0.202919,0.439798,0.172547,0.251741,0.892275,-0.351914,-0.0155638,0.0804189,-0.513706,-0.256382,-0.170475,0.374562,0.570989,-0.318133,0.74532,0.543364,-0.461513,-0.783181,-0.174504,0.179345,-0.519942,-0.251127,0.75981,0.26299,-0.154009,0.275955,-0.182691,0.0111072,0.786926,-0.441151,0.302846,-0.637425,0.318265,-0.42096,-0.0627101,0.772592,-0.649126,-0.534157,0.362471,0.575596,-0.181643,-0.125586,0.300949,-0.718827,-0.159314,-0.155592,0.640418,-0.210688,0.39407,0.451689,-0.221075,-0.389292,-0.307663,-0.545608,0.670374,-0.66308,0.141751,-0.529032,0.0189382,-0.076055,0.301876,-0.753108,-0.0696713,-0.552463,0.123602,0.692525,-0.0854367,0.277367,0.214002,-0.211638,0.406332,-0.487016,0.744556,0.65751,-0.386782,0.582136,-0.293895,-0.320961,-0.248331,-0.129809,0.177607,-0.774244,0.422079,0.882339,0.0791479,-0.137089,0.0669589,0.137468,-0.0187892,-0.101143,-0.749291,0.416855,-0.390856,0.0645669,-0.172929,-0.624285,-0.386539,0.265285,-0.584776,-0.0795017,0.27816,-0.195294,-0.179642,-0.292563,-0.215655,0.115603,-0.410875,0.762401,-0.0373236,-0.293633,-0.0266128,-0.519042,0.148805,0.0147203,-0.031278,0.0917723,-0.15359,0.118995,0.322868,0.0697984,-0.924902,0.206704,-0.0370743,-0.973368,-0.0386589,-0.00517133,-0.00416578,-0.424422,0.115223,0.701314,0.068174,0.214108,-0.236832,-0.0202237,0.072482,-0.0321399,1.05372,0.138656,0.805815,0.190252,-0.165787,-0.289073,-0.210091,-0.0122184,0.118632,-0.337722,-0.39757,0.324914,-0.297883,-0.0937585,-0.0471683,0.35131,-0.379718,0.839897,0.163011,0.221846,0.0575838,0.17101,0.257931,0.131026,-0.362531,-0.757242,0.441782,-0.621422,0.0171707,0.50329,-0.718738,-0.393262,0.0615226,0.608185,-0.126174,-0.666719,-0.386423,0.368829,0.0715064,-0.214029,0.355889,0.122966,-0.311318,-0.439211,-0.614074,0.676801,-0.23487,0.199252,-0.160849,0.454089,0.105119,-0.120066,0.0567319,-0.0449234,-0.317796,0.494892,0.801981,-0.852054,-0.430813,-0.447711,0.146017,0.0512713,-0.0866789,0.392637,-0.115023,-0.0411467,0.25199,0.148223,-0.0453891,-0.13266,-0.423243,-0.333933,-0.25622,0.511836,-0.146927,0.11534,0.850422,-0.266493,-0.0551501,0.314685,0.473818,-0.352946,0.813813,-0.159355,0.181252,0.83156,-0.290064,-0.0765073,0.201849,-1.26162,0.655533,-0.0774865,-0.834111,-0.0863138,-0.556306,0.347699,0.179188,0.0436158,-0.170117,0.455677,-0.0263863,0.326064,0.0857099,0.478566,-0.256884,-0.276151,-0.901694,-0.446893,-0.0819043,-0.138571,-0.38224,0.382233,-0.215934,-0.466772,0.254414,-0.252496,1.00737,-0.120443,-0.236181,0.0101067,0.481362,0.273637,-0.150068,-0.212028,0.507588,0.320563,0.495015,-0.331315,-0.104022,0.17017,-0.265883,-0.0224413,-0.186322,-0.546166,-0.232075,-0.02583,0.0735107,-0.831016,-0.0917764,0.175407,0.249971,0.418816,0.499971,-1.04257 +3405.02,0.975563,0.0848144,5,1.59344,1.00919,-0.514297,0.140772,0.329131,-0.00301311,0.381228,0.760121,0.6169,0.133532,0.310291,-0.436578,0.17284,0.268399,-0.203381,0.842244,-0.140302,0.065827,-0.549428,0.390674,-0.164331,-1.16477,-1.02492,-0.128482,0.173329,-0.240555,0.283746,0.375197,0.137232,0.295107,0.967375,-0.308504,0.0965942,0.144018,-0.550721,-0.279609,-0.109184,0.421636,0.494719,-0.352405,0.733032,0.564646,-0.464678,-0.797017,-0.169896,0.144102,-0.535369,-0.258906,0.743737,0.264162,-0.0508265,0.242482,-0.189827,0.0835225,0.810087,-0.414501,0.304872,-0.666017,0.31539,-0.31378,-0.0809764,0.647468,-0.602207,-0.561789,0.347052,0.595512,-0.144896,-0.194447,0.36435,-0.680944,-0.116889,-0.206979,0.607439,-0.277339,0.448531,0.427467,-0.231943,-0.407878,-0.374768,-0.490548,0.713849,-0.790921,0.177915,-0.555155,-0.00619505,-0.10602,0.24273,-0.73876,-0.106524,-0.565674,0.152828,0.648072,-0.0309671,0.309614,0.152411,-0.280682,0.385118,-0.43702,0.745849,0.621941,-0.395816,0.589678,-0.234731,-0.274525,-0.26977,-0.215034,0.204494,-0.778944,0.321421,0.829869,0.023376,-0.177015,-0.0209701,0.0817155,-0.0689929,-0.0179031,-0.634959,0.454708,-0.347573,0.0338338,-0.204778,-0.557813,-0.445911,0.23903,-0.567939,-0.0700085,0.350632,-0.0618872,-0.124352,-0.349854,-0.20995,0.0968279,-0.4092,0.759432,-0.124839,-0.392034,-0.0221429,-0.453288,0.131574,0.0776328,-0.0611308,0.150501,-0.232554,0.0794278,0.288979,0.0688626,-0.96008,0.174743,-0.0858809,-1.05646,-0.0430852,-0.00463526,-0.00665907,-0.404005,0.170416,0.717798,0.103177,0.195473,-0.223602,-0.0209183,0.0523257,0.0437508,1.07766,0.0959439,0.776377,0.180324,-0.219849,-0.271749,-0.176151,0.122013,0.151116,-0.33459,-0.450359,0.27496,-0.207547,-0.104153,-0.15581,0.433852,-0.417478,0.876434,0.205775,0.172898,0.058661,0.26721,0.357506,0.181595,-0.339319,-0.706083,0.388687,-0.611949,0.0623476,0.492499,-0.775303,-0.403707,0.104008,0.590694,-0.144186,-0.562533,-0.428875,0.416949,0.155215,-0.24166,0.41778,0.153363,-0.392665,-0.353909,-0.623309,0.6712,-0.1872,0.209022,-0.17204,0.444463,0.0872968,-0.201389,-0.0372704,-0.102995,-0.295586,0.514014,0.822537,-0.854466,-0.431455,-0.34431,0.180344,0.0585693,-0.110225,0.393479,-0.1612,-0.060429,0.21622,0.102805,-0.098798,-0.151118,-0.400125,-0.400238,-0.26122,0.529971,-0.0763509,0.214829,0.757226,-0.243974,-0.0154036,0.237018,0.496102,-0.309198,0.783081,-0.222592,0.169288,0.824272,-0.267637,-0.0647239,0.216041,-1.17498,0.715665,-0.0886942,-0.831636,-0.167504,-0.532726,0.324316,0.129263,0.00938984,-0.182402,0.547123,-0.0544583,0.323872,0.118975,0.429867,-0.31995,-0.206493,-0.944224,-0.364809,-0.145244,-0.0974616,-0.267008,0.438939,-0.234256,-0.423113,0.226909,-0.278134,0.977181,-0.106947,-0.194554,-0.0443949,0.461344,0.322441,-0.202546,-0.200965,0.465087,0.337538,0.526396,-0.301378,-0.10589,0.220697,-0.256861,0.066392,-0.186906,-0.626664,-0.196771,-0.114338,0.0674737,-0.811794,-0.1848,0.17778,0.253035,0.42164,0.503025,-1.14594 +3400.17,0.941466,0.0848144,4,1.56716,1.04122,-0.394258,0.0914256,0.0511148,-0.0282491,0.4011,0.667172,0.726674,0.219141,0.153302,-0.492711,-0.0482992,0.217954,-0.207794,0.876745,0.0799238,0.0230625,-0.455121,0.432687,-0.0357095,-1.19304,-1.01159,-0.0724674,0.0891405,-0.461414,0.249155,0.307685,0.270657,0.146563,0.847823,-0.61851,0.563684,0.229078,-0.557619,-0.365593,-0.108296,-0.0142523,0.509066,-0.0146231,0.727669,0.428221,-0.181696,-0.757264,-0.255916,-0.110526,-0.535028,0.179895,0.392942,0.182202,-0.0683175,0.140885,-0.0171314,0.089943,0.972556,-0.12738,0.347227,-0.713627,0.261688,-0.199524,0.0066388,0.698342,-0.784063,-0.902533,0.0625473,0.580993,-0.28707,-0.0250312,0.203262,-0.849096,-0.00226372,-0.253778,0.633802,-0.18426,0.628247,0.211796,-0.39116,-0.487565,-0.395641,-0.373767,0.722908,-1.07738,0.293603,-0.415495,0.0430521,-0.136335,0.152891,-0.484116,-0.174644,-0.542437,-0.0851718,0.579319,-0.173936,0.364328,0.209198,-0.174661,0.258229,-0.276796,0.639646,0.30995,-0.358061,0.414496,-0.297187,-0.229413,-0.00783683,-0.0852083,0.56186,-0.599101,0.544189,0.727885,-0.265667,-0.0408329,-0.385687,0.236027,-0.127904,0.197309,-0.755413,0.309317,-0.424049,-0.0447804,-0.274417,-0.334556,-0.261267,0.0964674,-0.256442,-0.0195774,0.48845,-0.0296937,-0.0801543,-0.20787,-0.165373,0.195029,-0.0468921,0.554732,0.007201,-0.370771,-0.0289836,-0.345915,0.0800396,0.0620352,-0.374311,0.185,-0.464058,-0.142999,0.27727,-0.279144,-1.0188,0.399985,-0.162818,-0.825586,-0.20697,-0.0570394,-0.114323,-0.272281,-0.124256,0.822524,0.0857244,0.151334,-0.0438715,-0.218491,0.124101,0.156097,0.874793,0.192036,0.847236,0.220305,-0.137173,-0.177162,-0.143875,0.190511,0.495181,-0.516655,-0.514332,0.390128,-0.102744,-0.355908,-0.386176,0.292128,-0.0702886,0.799078,0.0655431,0.335064,0.299819,0.307174,0.354978,0.00226629,-0.0423327,-0.802512,0.22054,-0.533816,-0.0721105,0.45402,-0.648116,-0.465507,0.0478345,0.699659,-0.30072,-0.716999,-0.415491,0.473194,0.0773162,-0.606871,0.214457,-0.267022,-0.710259,-0.426292,-0.766266,0.865245,0.00759265,0.277488,-0.348919,0.289846,-0.0660367,-0.0573795,-0.0661138,-0.166091,-0.275983,0.40931,0.814447,-0.575458,-0.180091,-0.132017,-0.17849,0.159244,-0.165515,0.341953,-0.0639062,0.239266,0.194194,0.130777,-0.434915,-0.242338,-0.456593,-0.104033,-0.152182,0.499142,0.00366196,0.399578,0.59524,0.187928,-0.031393,0.20568,0.562893,-0.261913,0.884031,-0.328725,0.266233,0.708625,-0.207755,0.145959,0.178156,-1.2916,0.555409,-0.100627,-0.729665,0.029853,-0.481577,0.207877,0.3452,0.0693996,-0.349116,0.848832,-0.123296,0.155976,-0.0387243,0.137118,-0.378816,-0.304125,-1.01632,0.0499334,-0.0332449,-0.296869,-0.0577018,0.308683,-0.0254255,-0.606973,0.381298,-0.436341,1.10486,-0.471858,-0.144083,0.111221,0.20332,0.199077,-0.0946179,-0.337285,0.604991,0.644574,0.501255,-0.213512,-0.208569,0.0282006,-0.258383,0.0587392,-0.269563,-0.841046,-0.271857,0.0540506,0.0676153,-0.746381,-0.208351,0.164796,0.267612,0.405951,0.517312,-0.315843 +3399.04,0.96003,0.0848144,4,1.51205,1.14808,-0.670779,0.0729843,0.192238,-0.178077,0.0707903,0.421088,0.497833,0.34945,-0.149515,-0.286292,0.374364,0.218063,-0.349895,0.985042,0.0352533,0.15944,0.160509,-0.0419286,-0.407944,-0.915056,-0.37784,-0.241954,0.478866,-0.316069,0.101917,0.520395,0.116812,0.153337,0.662581,-0.39519,0.00845229,0.0879988,-0.438721,0.386965,-0.339118,0.439192,0.746796,-0.0220474,1.01178,0.356865,-0.216392,-0.0990726,-0.647059,-0.349738,-0.565179,0.105863,0.689987,-0.050243,-0.094753,-0.301098,-0.178909,-0.257468,1.10981,0.144863,-0.44662,-0.31642,0.501068,0.0432321,0.377195,0.713269,-0.540378,-0.811675,0.305206,0.10862,-0.186546,-0.139047,0.304409,-0.820734,-0.3519,0.375038,0.404616,-0.087207,0.295204,0.466673,0.153487,0.0858197,-0.702469,-0.0750037,0.650012,-0.390923,0.398493,-0.23792,0.544872,-0.202754,0.156405,-0.264273,-0.237054,-0.374874,-0.136455,-0.018928,-0.0645945,0.0685532,-0.171904,-0.135253,0.749519,-0.612912,-0.974171,0.195202,0.0174489,0.550171,-0.432169,0.0444869,0.340045,0.193088,0.314895,-0.0136883,0.37534,0.897178,0.673051,0.0209149,1.08623,-0.0436365,0.148673,0.0667502,-0.796652,0.0670419,0.085081,-0.0484867,-1.20918,-0.0491634,-0.530241,-0.0794695,0.275705,0.137047,0.375313,-0.316351,0.341562,-0.117198,-0.0775169,-0.119863,0.31768,0.622508,-0.324253,-0.133461,0.0167774,-0.42329,0.252829,-0.0974696,-0.410217,-0.131893,-0.482462,-0.126276,0.153081,-0.180401,-0.440264,0.296496,-0.414006,0.0289265,0.263689,-0.0592438,0.168,0.071079,0.559914,-0.226726,-0.271473,0.0619983,0.210874,0.134846,0.476284,0.170537,1.40866,0.145261,-0.490587,0.25533,-0.0328526,-0.649784,-0.0887761,0.134721,0.579719,-0.489913,-0.14277,-0.288942,0.0149035,-0.201292,-0.258374,0.0220222,-0.0219656,1.14889,-0.0904639,0.253992,0.04468,0.126407,-0.189387,0.0598483,-0.125156,-0.771495,0.420141,-0.360224,0.0956157,-0.131927,-0.0157014,-0.677043,-0.152299,-0.136302,-0.156092,-0.664787,-1.06789,0.553615,0.0964576,-0.44764,0.0579,-0.603656,0.373788,-0.23582,-0.811043,0.72512,0.00720236,-0.0909976,-0.0187774,0.650797,0.287119,0.460334,-0.670894,-0.00130008,-0.28046,0.233064,0.590923,-0.0318265,0.250138,-0.644384,1.04067,0.645181,-0.65037,0.378448,-0.213091,0.0844138,-0.0795329,0.384003,-0.75449,-0.242087,-1.12458,-0.31836,-0.468583,0.670522,-0.30124,0.565203,0.598975,-0.170576,-0.365371,-0.433086,-0.208952,-0.532095,0.0605407,-0.394264,0.231097,-0.0260416,0.0836152,-0.318801,0.691953,-0.887202,0.270517,-0.3603,-0.283636,0.0479935,-0.529952,-0.304711,-0.483134,0.115224,0.387184,0.422812,0.365471,0.471946,-0.21109,-0.627916,0.210608,-0.297992,-0.105582,0.178905,0.189211,-0.374656,-0.661374,1.00284,0.0462419,-0.604085,0.0446544,0.113959,0.494747,-0.671147,-0.0117152,0.137856,0.236833,0.71952,0.167083,0.291963,0.0917982,-0.0992565,0.284642,-0.0453888,-0.313369,0.274561,-0.383241,0.148971,-0.373339,-0.145302,0.533916,0.304985,-0.125229,-0.0959817,-0.729549,0.174456,0.164078,0.41768,0.405065,-0.828148 +3405.01,0.545138,0.0848144,4,1.61032,1.12026,-0.211766,0.0323891,0.490552,-0.233929,-0.0914888,0.27155,0.556177,0.451262,-0.00636893,-0.509703,0.133561,0.144439,-0.300495,0.873758,0.248344,-0.0270377,-0.136576,0.284695,-0.151957,-1.23567,-0.4535,-0.370995,-0.150291,-0.624259,0.244413,0.208389,0.0965747,0.364374,0.631417,-0.358151,0.234449,0.264538,-0.327029,-0.0117493,-0.144869,0.153897,0.508502,-0.346944,0.757411,0.272122,0.126783,-0.329542,-0.361704,-0.718624,-0.50591,0.334805,0.318129,-0.563391,-0.262223,0.0859091,-0.0240459,-0.161248,0.965709,-0.318894,-0.365096,-0.215501,0.368449,-0.379543,0.127007,0.694169,-0.69242,-0.715827,-0.0299347,-0.0758817,-0.209952,-0.510425,0.111291,-0.792904,-0.295356,0.779992,0.39691,-0.0125476,0.511284,-0.20177,0.0555687,0.303537,-0.687892,0.0521072,0.716486,-0.229495,0.42042,-0.396809,0.368824,-0.445214,-0.08883,-0.239262,-0.123471,-0.209833,-0.378061,0.252814,-0.0104847,-0.0751015,-0.433148,-0.183276,0.624629,-0.46693,-0.812537,0.333993,0.265259,0.516502,-0.950222,-0.362666,0.40359,0.289974,0.391755,-0.793001,0.288442,1.0776,0.507567,0.210258,0.359525,0.0682885,0.235085,0.340311,-0.611868,-0.286462,0.00218146,0.0644374,-1.04885,-0.0406447,-0.258356,-0.1837,0.378762,0.647291,0.401907,-0.252095,-0.168499,0.152786,-0.451679,0.373626,0.309589,0.71178,-0.148937,-0.102811,-0.145806,-0.31148,-0.00532276,-0.0743793,-0.850462,0.118689,-0.302326,-0.232432,-0.0263466,-0.234254,0.00515998,0.147965,-0.455504,-0.405473,0.123264,-0.0797825,0.310406,0.167328,0.503387,0.0288898,-0.0926777,-0.723055,0.169605,0.150822,0.153364,0.286198,1.26507,0.332745,-0.0608892,0.180273,0.0354163,-0.055557,-0.0417497,-0.0350693,0.238164,-0.895577,-0.476806,0.0838494,0.11003,-0.0346965,-0.214833,-0.313088,0.125188,0.949936,-0.151534,0.0643168,0.0306698,0.0587337,-0.122898,0.350423,-0.0222064,-0.455844,0.311421,-0.622463,0.234793,-0.131859,-0.0166723,-0.846132,0.0659632,-0.081084,-0.291885,-0.67925,-1.1937,-0.307356,0.259803,-0.01313,0.433485,-0.35158,0.462006,0.000660132,-0.683279,0.879613,-0.0542119,0.310848,0.125704,0.271902,-0.0533082,0.421868,-0.394632,0.454268,-0.334489,0.417398,0.461154,-0.659671,-0.100921,-0.81571,0.688284,0.592954,-0.710597,0.22987,-0.256703,0.320579,-0.250001,-0.037977,-0.684261,-0.136457,-0.696314,-0.185047,-0.364046,0.526543,-0.0627825,0.209469,0.814744,-0.723937,-0.273225,-0.575878,-0.978678,-0.626039,0.445733,0.280807,0.45505,-0.314362,-0.219476,-0.113868,0.137096,-0.60523,0.427159,-0.100269,-0.186474,0.0465121,-0.538893,-0.685173,-0.501645,0.252246,0.327437,0.592368,0.323173,0.186379,-0.379336,-0.651175,-0.0201004,-0.370699,0.0526974,-0.143732,0.123532,-0.596415,-0.679448,0.863908,-0.465426,0.094566,0.0914304,-0.165135,0.213183,-0.322953,-0.04617,0.492204,0.0946186,0.187278,0.222061,0.595552,0.542737,0.416003,0.366536,0.375427,0.0703117,0.468929,0.146534,0.0310925,-0.0316799,-0.214832,0.0889601,-0.0344634,-0.16064,-0.307857,-0.624119,0.182377,0.171793,0.427056,0.414479,-1.85973 +3408.42,0.968797,0.0848144,5,1.6373,0.859851,-1.01805,0.35701,0.361255,-0.00564662,0.588571,-0.141405,-0.00939483,0.116024,-0.0671612,-0.236872,-0.414088,0.0834279,-0.0822325,0.873376,-0.0395059,-0.220143,-0.146884,-0.154024,0.0627127,-0.432138,-0.404615,-0.124773,-0.218325,0.307167,-0.260511,-0.055217,-0.312276,0.185609,1.10992,-0.664401,-0.856756,-0.0556963,-0.304305,0.378655,-0.800451,0.551449,0.35949,-0.338647,0.519644,0.435903,0.0625094,-0.852494,-0.311678,-0.294151,-1.0065,-0.250602,0.227171,-0.0267357,-0.120281,0.32303,-0.0361998,-0.808664,0.657598,-0.100821,-0.13583,-0.950067,0.149401,-0.240764,-0.0353239,0.308112,-0.312802,-0.865979,0.589183,-0.0876236,0.442639,0.255318,0.180077,-0.196554,0.115206,-0.0724254,0.978974,-0.0628465,0.21935,0.634264,0.313759,-0.0662992,0.0451279,-0.107857,0.22658,-0.51254,0.403722,-0.390866,-0.480908,0.513952,0.878813,-0.0882842,-0.473127,-0.809701,0.104378,0.564654,-0.166726,-0.0554087,-0.080578,0.155559,-0.178565,-0.238104,0.684875,0.563474,0.0705608,0.000780974,-0.00257834,-0.00413454,0.341739,-0.381246,0.180291,0.117006,0.652995,0.550393,-0.166305,-0.582709,0.0539494,0.291192,-0.217833,-0.0135413,-0.296052,0.478265,0.210775,-0.142287,-0.0264549,-0.14937,0.105797,-0.89894,-0.320483,-0.0353944,0.453052,0.0617161,0.0729825,-0.110347,0.527126,-0.2489,-0.306678,0.172712,-0.0152785,-0.466137,-0.057451,-0.115368,0.14216,-0.564099,-0.217977,0.0618044,0.349773,-0.872445,-0.320883,0.0393089,-0.301996,0.0159194,-0.239686,-0.441586,-0.138281,0.241668,0.00717587,-0.646253,0.164574,-0.0387695,-0.00524991,0.618989,0.279279,-0.589386,0.239852,-0.188699,0.557238,0.648078,-0.0363362,-0.213566,-0.0478324,0.078914,0.659242,0.0814061,0.487509,0.530789,-0.0477236,-0.246439,-0.554506,0.0743114,0.282287,0.275,0.223683,1.15606,-0.0927784,0.212593,0.016359,-0.247362,0.220734,-0.898526,-1.31492,-0.143757,0.457377,-0.484361,-0.110538,0.208812,-0.387664,-0.332973,0.404811,0.305187,-0.122021,-0.636516,-0.0952283,0.130118,0.144088,0.173732,-0.235529,0.402036,-0.0147009,-0.576609,-0.617601,0.529653,0.00439399,0.0154735,-0.255801,-0.452608,-0.136466,0.0991079,-0.272839,-0.470786,-0.436718,-0.268953,0.597394,-0.0749195,-0.0517907,-0.396245,-0.0515346,-0.585097,-0.751291,0.718837,-0.168268,-0.461542,0.399447,0.103333,-0.170275,-0.214593,0.155672,0.123345,-0.441167,0.421527,-0.12495,0.116548,0.855243,-0.339196,-0.21669,0.387059,-0.432072,0.343708,0.406428,0.328222,0.266842,0.401459,-0.113147,0.0767333,0.00806533,-0.980135,0.336075,-0.190497,-0.510111,0.226164,-0.185834,-0.263102,0.230395,0.431513,-0.637843,-0.0930278,0.305968,-0.289191,0.483687,0.194093,-0.516933,-0.0778454,0.222004,0.241816,-0.536823,-0.659869,0.115748,-0.199983,0.404216,0.211147,0.627464,-0.0421174,0.197877,0.250392,-0.520755,-0.143977,0.156919,0.06576,0.226864,0.408303,-0.218545,0.38145,-0.0900556,-0.70064,-0.437164,-0.308029,0.2361,0.248707,0.0122567,-0.235542,0.281941,0.120687,-0.456719,0.200718,-0.0369204,0.149585,0.247353,0.386762,0.497346,-0.884427 +3412.69,0.983721,0.0848144,4,1.68237,0.746074,-1.2153,0.475851,0.306576,0.0350378,0.257925,-0.0831723,-0.0432945,0.264577,0.169653,-0.242728,-0.642768,0.2432,-0.100633,0.621146,0.0457255,-0.307048,-0.01457,-0.124555,-0.224177,-0.56966,-0.572865,0.00693797,-0.0103974,0.359817,-0.172817,-0.0709524,-0.18904,-0.174591,1.15567,-0.456327,-0.409997,0.195157,-0.259164,0.366467,-0.952712,0.69083,0.427748,-0.744482,0.840524,0.833985,0.184478,-0.646833,-0.357446,-0.0968272,-1.04178,0.0155147,0.0207899,-0.178563,-0.325241,0.682037,-0.0760191,-0.654216,0.67909,-0.131519,-0.197778,-0.896,0.00272493,-0.470298,0.181147,0.500103,-0.735117,-0.776548,0.759987,0.0282881,0.407517,-0.0785278,0.490176,-0.219175,-0.0405413,-0.0591236,0.920036,-0.321011,0.158122,0.551385,0.197107,-0.0339299,-0.236129,-0.00784045,0.0638858,-0.275195,0.51483,-0.594921,-0.62634,0.449537,0.648474,0.158738,-0.344394,-0.452373,0.0249572,0.460335,-0.237737,-0.227013,-0.431448,-0.240932,-0.330567,-0.443721,0.401728,0.635001,0.281942,-0.122794,-0.137049,-0.00479194,0.329933,-0.0697924,0.616569,-0.0103185,0.0758922,0.568259,0.236646,-0.427367,-0.137187,0.282358,0.0164168,0.273631,0.153837,0.471857,-0.0657824,-0.0882943,-0.25781,-0.064481,0.0792546,-0.413659,-0.425073,0.197018,0.376744,-0.731978,-0.0345359,0.0317111,0.69268,-0.325837,-0.362117,0.466493,0.174031,-0.439806,-0.272253,-0.0981977,0.373875,-0.655194,-0.522814,0.106029,-0.511577,-0.830889,-0.326373,0.130747,-0.155185,0.140242,-0.64338,-0.57509,0.132798,0.176693,0.082534,-0.391859,0.271044,-0.212472,-0.196016,0.429332,0.51603,-0.41456,0.184313,-0.1099,0.803869,0.416247,-0.00742401,-0.129285,0.0450468,-0.167654,0.151911,-0.195511,0.386538,0.336676,-0.342438,-0.247208,-0.271154,0.215595,0.0916595,0.0435968,0.367437,1.40623,-0.02626,-0.0174926,0.0535455,0.0856078,0.525321,-0.272499,-0.845241,-0.0423225,0.395984,-0.468896,-0.00579705,-0.00934919,-0.0137138,-0.410474,0.0903081,0.136862,-0.232287,-0.345723,-0.287589,-0.381764,0.541862,0.0818192,-0.332263,0.244607,0.198419,-0.652197,-0.462392,0.49568,-0.0232789,0.117504,-0.354846,-0.368076,-0.0944403,0.393451,-0.47473,-0.112804,-0.72465,-0.0368599,0.108957,-0.0467894,-0.261587,0.0356596,-0.107719,-0.396463,-0.15215,0.516724,-0.483138,-0.691031,0.776912,0.324046,-0.530914,-0.0132341,0.150491,-0.343701,-0.376962,0.660524,-0.568332,0.405461,1.07675,-0.31339,-0.341136,-0.063657,-0.551112,0.208496,0.432714,0.219981,0.514243,0.187469,0.047313,-0.121567,-0.162049,-1.16303,0.478511,0.23641,-0.926499,0.457284,-0.688267,-0.59331,0.676653,0.231,-0.209594,-0.594084,0.33654,0.152418,0.407764,0.108039,-0.479067,-0.000475641,0.228254,0.147124,-0.409344,-0.249508,0.0760111,-0.409269,0.718436,0.045494,0.307189,0.084158,0.24072,-0.129923,-0.321153,-0.118055,-0.160502,-0.0360046,0.261523,0.448234,0.0260773,0.381548,-0.264871,-0.153156,-0.336556,-0.298649,0.0360233,0.151478,0.304728,-0.192183,0.489092,0.28782,0.0377025,-0.141863,-0.201905,0.143625,0.225456,0.378979,0.474822,-0.475917 +3405.41,0.857012,0.0848144,4,1.66733,0.864115,-0.874254,0.409657,0.563577,-0.0971058,-0.231968,0.442233,-0.428021,0.272933,-0.348703,-0.413385,0.325634,0.446401,-0.123777,1.34539,0.00245787,0.228998,0.401591,0.0389255,-0.0598326,-0.994256,-0.904942,0.230599,-0.240382,0.0535009,0.0395233,0.201464,-0.40477,0.587176,0.90617,-0.323499,0.0213024,0.78523,-0.247751,-0.249746,-0.54634,1.12821,0.233212,-0.249655,0.525131,0.698219,0.220201,-0.912585,-0.189545,0.450209,0.0884584,0.0189811,0.0489738,0.261164,0.179638,0.107312,-0.300466,-0.401223,0.565181,-0.132236,-0.334705,-1.24585,0.0970812,-0.369151,-0.425722,0.220439,-0.450548,-1.12158,-0.480411,0.152362,-0.0892446,0.299119,-0.294128,-0.30636,-0.111737,-0.453885,0.220192,0.0891908,0.17345,0.673865,0.217336,0.00406194,0.141325,0.149465,0.891526,-0.161618,0.0399581,0.130322,-0.36307,-0.168134,-0.0633597,-0.578193,-0.146215,-0.638468,0.184856,0.154652,-0.168197,-0.195317,-0.0284471,-0.01385,0.0942377,-0.195156,0.333802,0.319635,-0.133386,-0.461892,-0.453813,-0.331639,-0.233954,-0.377898,0.412565,0.0373258,0.00737389,0.471621,0.0298304,0.223548,-0.181477,0.0730605,0.0485535,0.101722,0.143595,0.135124,0.219068,0.0455698,-0.359265,-0.699222,0.236699,-0.386109,0.0286348,-0.0798337,0.595784,-0.823147,0.641513,-0.771027,0.0527283,0.0513732,0.037059,0.0894609,0.000706204,0.0903371,0.0232248,-0.495292,-0.0544316,-0.152806,0.0299133,0.340225,-0.00922297,-1.01103,0.0461524,0.237174,0.230594,-0.0048658,0.0406565,-0.165032,0.25334,-0.545434,-0.133877,-0.185723,0.341406,0.0947323,0.234388,-0.103484,-0.135679,-0.0812602,0.24292,0.0941628,0.619431,-0.283467,-0.577706,0.188056,0.269908,-0.420034,-0.31631,-0.112222,0.146691,-0.210661,-0.115947,-0.279793,-0.0970959,-0.00547557,-0.277744,0.141046,0.801214,0.717762,-0.119869,-0.0454104,0.552027,0.0686397,-0.987344,-0.817322,-0.302006,0.0637537,0.416581,-0.302622,0.152441,0.202258,-0.197446,-0.3179,0.0336463,-0.326126,0.22846,-0.00522387,-0.355845,0.055951,-0.232456,-0.700863,0.578667,-0.575951,0.482428,0.0889941,-0.0533337,0.763242,-0.287474,0.00642001,0.173354,-0.50463,-0.562364,0.221939,-0.662336,0.475085,-0.0933174,0.391611,-0.427358,-0.771724,0.216959,-0.446494,0.187799,0.329268,-0.765536,0.751605,-0.332912,-0.14036,0.222363,0.459067,0.196228,-0.2521,-0.153075,0.37172,-0.657444,0.459798,0.196532,0.0591509,1.14332,-0.768816,-0.0514888,-0.207563,-0.323935,-0.683883,0.114989,0.297033,0.732817,0.0618662,0.00217022,-0.347837,0.373789,-0.299474,0.475927,-0.21083,-0.451878,0.173118,-0.795096,0.139259,0.168454,0.358961,0.504671,0.427704,0.0250759,0.168237,-0.0253397,-0.0334427,-0.459784,-0.438585,-0.135608,-0.308932,-0.312064,-0.369275,-0.585642,-0.100769,-0.253209,-0.31563,0.0453123,-0.890781,0.444076,0.077517,-0.302337,-0.830929,-0.434321,-0.479817,0.232894,-0.154109,-0.101278,-0.345133,-0.0209551,-0.14243,-0.0856835,-0.4298,-0.67034,0.633792,-0.243738,-0.752858,-0.483118,0.104306,0.266177,-0.78635,-0.217041,0.144623,0.281886,0.380293,0.53093,-1.63622 +3404.58,0.951838,0.0848144,4,1.6318,0.7658,-1.26996,0.647893,0.803298,0.0353391,0.307166,8.40381e-05,0.600763,0.454754,-0.128826,0.223295,0.0443511,0.567022,-0.156186,0.633022,-0.0484285,-0.129245,-0.125185,0.193246,0.0849856,-1.03919,-1.08246,0.0390124,-0.433715,-0.113694,0.108491,0.303126,-0.132738,0.0434031,0.975841,-0.600524,0.0208121,0.676949,-0.423357,-0.312224,-0.15171,0.0230413,0.346274,-0.208757,0.732422,0.788794,-0.14361,-0.974992,-0.356049,0.412909,-0.580502,-0.0649704,-0.379345,0.121393,-0.236581,0.914258,-0.119235,0.171764,0.288205,-0.653436,-0.296319,-0.865779,0.310586,-0.383168,-0.286311,0.559883,-0.491833,-1.20621,-0.403004,-0.0848822,-0.00802747,0.314536,0.0308344,-0.125622,-0.505848,-0.120393,0.488026,-0.484345,0.290613,0.813081,0.233981,0.0359731,-0.693488,0.0562082,1.11327,-0.114845,0.335413,-0.271947,0.0926129,-0.248678,-0.198339,-0.652031,-0.285891,-0.399568,-0.12475,-0.283763,-0.658032,-0.149073,-0.198744,0.189605,0.194905,-0.663944,0.134956,0.23041,-0.375722,-0.564298,-0.355078,-0.773833,-0.0378441,-0.525175,0.237618,-0.29323,0.0818291,0.768216,0.359055,0.151058,-0.223603,0.468562,0.0826484,0.270965,-0.116127,0.14684,-0.392589,0.617416,-0.386846,-0.678223,0.294063,0.51788,-0.272087,0.632775,0.134676,-0.293196,0.383832,-0.622553,0.564087,-0.287903,-0.214661,0.478501,-0.0636655,-0.573502,0.426558,-0.156245,0.370583,-0.455517,0.198515,0.249168,0.114042,-0.883334,0.139537,0.00127502,0.408079,0.184348,-0.069196,-0.332836,-0.00797412,-0.480657,-0.208816,-0.0296351,0.227825,0.42408,-0.525151,0.017762,0.11239,0.240737,0.211227,-0.228301,0.686918,-0.154302,-0.505642,0.576149,-0.073622,-0.277732,-0.70077,0.000791174,-0.134658,0.371418,-0.280762,-0.558557,-0.424191,-0.262561,-0.0844533,-0.139261,0.174164,0.519691,0.204491,-0.0455845,0.126591,-0.0770709,-0.35814,-0.51487,-0.432523,0.48747,-0.0177957,-0.329816,-0.0279205,0.207283,-0.110822,-0.518977,-0.0179082,-0.287054,-0.258822,-0.530384,-0.230925,-0.0787004,0.34566,-0.133408,0.0783635,-0.314662,0.324163,0.404272,0.158332,0.766836,-0.169581,0.430698,-0.11892,-0.188928,-0.429642,0.134137,-0.437368,0.590728,-0.433834,0.298062,0.361288,-0.0402498,-0.00892602,-0.52289,-0.0427845,-0.214501,-0.482619,0.740151,-0.284454,-0.746333,0.145889,0.0269237,-0.118154,0.0467077,-0.633211,0.553194,-0.13245,-0.108108,0.179061,0.230779,1.02853,-0.736031,-0.161485,-0.640733,-0.0576271,-0.427627,-0.149523,0.00694033,0.731804,0.1289,-0.146386,-0.459789,-0.358002,-0.610899,0.421263,-0.17826,-0.759614,0.197645,-0.455475,-0.128356,0.0528405,0.24617,-0.183566,0.243451,-0.003109,0.564607,-0.0791106,-0.353628,-0.0822252,-0.441113,-0.100862,-0.427094,-0.374299,-0.734975,-0.12024,-0.252259,0.162954,-0.821236,0.527555,-0.507059,0.838632,0.280841,-0.177509,-0.422205,-0.329857,-0.432015,0.410761,-0.0452213,-0.458876,0.353427,-0.0756548,-0.563442,-0.248082,0.303282,-0.457735,-0.133531,-0.0260933,-0.503095,-0.290442,0.332502,0.229873,-0.623204,-0.290756,0.154505,0.22574,0.393071,0.475121,-2.34489 +3373.02,0.902233,0.0848144,4,1.56589,0.897218,-1.15056,0.455036,1.07444,-0.0508736,-0.0157539,-0.572606,0.227184,-0.636864,-0.27204,-0.0374439,-0.454093,0.553502,-0.207225,0.813778,0.103397,-0.00791217,0.270383,-0.228029,-0.0671272,-0.336448,-0.516244,-0.280233,0.333809,0.456989,-0.00187817,0.44763,-0.989513,0.342754,0.97762,-0.166051,-0.435239,0.480814,-0.0780208,-0.0622347,-0.73943,0.930246,0.638124,0.0691101,0.742115,0.426769,0.217909,-0.477226,0.157769,0.472521,0.112147,0.131409,-0.230881,0.373218,-0.0683574,-0.0750509,0.138203,-0.266296,0.782297,0.28988,-0.669247,-0.526033,0.433222,-0.496009,0.399725,1.06742,-0.661878,-0.244602,-0.0642998,-0.023038,0.407005,-0.308517,0.345875,-0.0382943,-0.963043,0.272549,0.290011,-0.00421667,0.565022,0.094527,0.35526,-0.210294,0.249495,-0.38022,-0.126009,-0.191176,0.717638,-0.746369,-0.273805,-0.02459,-0.159516,0.18056,0.469821,-0.520906,-0.339853,1.1771,-0.145976,-0.166719,-0.264176,-0.533602,0.0569273,-0.000259112,0.104549,0.275158,0.147847,1.01231,-0.36282,-0.0290132,0.531669,-1.06708,0.485049,0.396636,0.0579475,0.0851401,-0.132255,-0.0806592,-0.128765,0.115551,-0.297662,0.283169,-0.672199,0.235516,0.486389,-0.744735,-1.2978,0.322919,-0.495313,-0.878628,-0.220511,0.876383,-0.144596,0.548041,0.864068,-0.594962,-2.0181e-05,-0.271243,-0.500483,0.586024,-0.244199,0.4559,-0.661681,0.0451849,0.0151569,-1.2796,-0.358481,0.424075,-0.235339,-0.52207,0.0546689,-0.140208,0.425451,0.228232,-0.576788,-0.0505241,0.0800029,0.0681772,-0.0911412,-0.0739266,0.634844,0.45884,0.930675,-0.371037,0.366271,-0.521299,0.0997956,0.127128,0.590091,-0.980612,-0.0361121,-0.181586,0.485625,-0.622983,0.0765185,0.31423,0.136446,-0.301713,-0.164346,0.238223,0.573232,-0.166804,-0.467943,-0.068691,0.654695,1.04387,0.531075,-0.947734,1.35916,-0.273751,-0.129427,-0.51173,-0.172415,-0.262506,-0.309897,-0.233213,-0.360781,0.0175373,0.133488,-0.824702,0.144686,0.78164,0.162457,-0.410223,-0.645924,0.0689851,0.286777,-0.556799,-0.101041,-0.202514,0.0278041,-0.236944,-0.981548,0.829744,-0.358576,-0.345372,-0.658389,-0.551273,0.222544,0.211215,-0.174591,0.310481,-0.561536,0.125492,0.0116235,-0.300663,-0.431076,-0.28628,-0.667921,-0.361881,-1.11833,0.537234,-0.797901,0.167186,-0.019069,-0.156614,-0.608811,-0.183354,-0.266624,-0.432843,-0.467024,1.05989,-0.0770868,-0.408062,0.148811,-0.767797,-0.17944,0.502793,-0.0157879,0.230103,0.579963,0.486832,0.775949,-0.0709926,0.0466268,-0.776239,0.168988,-0.68984,0.0921162,-0.793552,-0.333611,0.0738474,-0.433435,0.016925,-0.114115,0.361072,-0.0959527,-0.083098,0.164983,-0.193344,0.31616,0.254336,-0.403651,-0.181321,0.30215,-0.350279,-0.387439,-0.0253597,-0.320252,0.445541,-0.27858,-0.337992,-0.670782,-0.187996,0.443765,-0.29444,-0.0113916,-0.535145,-0.584355,0.439746,-0.0642708,0.172177,-0.46185,0.612775,-0.0756295,-0.153902,-0.171392,-0.261305,0.305225,-0.0993762,-0.0226552,-0.744546,0.431486,-0.268977,-0.172231,0.371376,-0.0625391,0.228546,0.23776,0.478065,0.487606,-3.40156 +3396.8,0.997971,0.0848144,4,1.49394,1.07502,-0.984466,0.377564,1.20589,-0.0474761,0.198528,-0.0354424,0.250461,-0.566503,-0.160138,0.159221,-0.0480246,0.33367,-0.288472,0.786399,0.106688,0.150582,0.397286,-0.410549,0.0616865,-0.799056,-0.460674,-0.431012,0.33065,0.198706,0.339921,0.929627,-1.11158,0.127589,0.916503,0.101462,-0.116767,0.605423,0.175054,-0.160085,-0.696322,0.539503,0.745731,-0.171608,0.997612,0.723969,0.694112,-0.333203,0.0672115,0.303083,0.045812,-0.216351,-0.0651628,0.416067,-0.0160977,0.26077,0.34494,0.185298,0.702193,0.158907,-0.552319,-0.541964,0.307934,-0.669465,0.189174,0.928014,-0.438626,-0.673418,-0.237628,0.125661,0.271851,-0.0931332,0.481976,0.171172,-0.534428,0.566664,-0.110116,-0.0560615,0.364979,0.214641,0.262877,-0.00334411,-0.0899971,-0.353691,0.0269845,-0.522316,0.481985,-0.80248,-0.407693,-0.534385,-0.0155847,0.337353,0.106043,-0.635391,-0.283772,0.81358,0.103704,-0.00748144,-0.209848,-0.552539,-0.0588577,-0.342868,-0.0913748,0.227785,0.489775,0.662152,-0.420073,0.276259,0.0800213,-1.47955,0.187566,0.12526,0.276841,0.268835,-0.349458,0.242853,0.345252,0.173934,0.249406,0.22266,-0.569464,0.37895,0.252985,-0.663136,-1.34999,0.241838,-0.12651,-0.817722,-0.13844,1.00456,-0.654031,0.492502,0.607683,-0.738385,0.436279,-0.270314,-0.237663,0.664936,-0.146094,-0.151289,-0.279665,-0.136762,0.311632,-0.901418,-0.663428,0.349256,0.0437952,-0.499057,-0.223886,-0.297594,0.53454,0.22963,-0.442383,-0.178892,0.0412408,0.0495688,-0.184215,0.0610681,0.96915,0.770331,0.72122,-0.575135,0.362441,-0.477571,-0.041066,0.105092,0.717339,-0.135643,-0.126968,0.325143,0.205842,-0.487419,-0.0391222,0.235482,-0.30408,-0.657602,-0.18955,0.237282,0.424943,-0.129333,-0.274999,0.0941555,0.707415,0.503568,0.462048,-0.742513,0.918476,-0.226284,0.28507,-0.238395,0.121134,-0.253099,0.0820985,-0.398166,-0.383166,-0.141491,0.0745124,-0.650984,0.101094,0.456153,0.0698059,-0.214064,-1.21732,-0.294594,0.15976,-0.617953,0.0294727,0.110355,0.446561,0.033924,-0.892553,0.608478,0.0696531,-0.0794325,-0.368853,-0.356006,0.148404,0.343833,-0.0476212,0.432922,-0.392872,0.289223,-0.121101,-0.350607,-0.354596,-0.407242,-0.383736,-0.067383,-1.1741,0.615351,-0.816729,0.0908254,-0.282237,-0.174775,-0.0914552,-0.289274,-0.371403,-0.232748,-0.448775,0.663064,-0.0236204,-0.718632,0.099726,-1.08161,-0.410287,0.453266,-0.0304112,0.374116,0.611874,0.568929,0.511871,0.106108,0.168603,-0.575598,0.170362,-0.458107,0.268087,-0.680013,0.0461217,0.136026,-0.318612,-0.0439703,-0.149031,0.281017,0.268507,-0.0434962,0.332059,0.30301,0.657515,0.295565,-0.312698,-0.29393,0.449458,-0.316729,-0.401308,-0.122588,0.0445317,0.764601,-0.132137,-0.454252,-0.560754,-0.287418,0.422408,0.0879888,-0.154302,-0.0404795,-0.529134,0.0417521,-0.168294,-0.0679295,-0.299696,0.819928,-0.42405,-0.209911,-0.379489,-0.326157,0.28932,-0.149756,-0.0543685,-0.661783,0.242919,-0.277087,0.121563,0.285264,0.0351764,0.180566,0.192198,0.424931,0.438403,-4.2389 +3381.48,0.974229,0.0848144,4,1.50971,1.01203,-1.30755,0.487361,1.04123,-0.0554982,0.319287,0.131,-0.255271,0.159191,-0.072216,0.303699,-0.206107,0.713656,-0.456069,0.763506,0.105202,0.295823,0.182665,-0.280526,-0.301349,0.0193596,-1.19448,-0.334091,0.047808,0.0571402,0.145233,0.698307,-1.08036,0.0614058,0.761754,-0.598357,-0.0353949,0.343963,-0.418154,-0.392759,0.204859,0.110565,0.285456,-0.19646,0.905522,0.456858,0.114004,-0.635903,-0.273322,0.741524,0.212292,0.462841,0.0998056,0.394073,-0.410047,0.252893,-0.00662416,0.186522,0.456993,-0.0412171,0.0287465,-0.660951,0.508324,-0.384059,0.187054,1.59589,-0.429595,-0.159785,-0.320648,0.366953,0.272627,-0.156916,1.05296,-0.388923,-0.108472,0.633096,0.132099,-0.0882498,0.861674,0.115543,0.353721,0.559768,-0.187781,-0.535465,0.261073,-0.110667,0.644618,-0.488871,-0.299202,0.145631,-0.0748062,0.585292,0.257099,-0.500627,-0.359927,0.351727,-0.299758,0.120494,0.306694,-0.153776,-0.0788765,-0.329182,0.186965,0.0320765,0.798953,0.561008,-0.61044,-0.282381,0.637221,-0.880646,0.199785,-0.0164698,-0.334932,1.05516,-0.164195,0.110654,-0.117697,0.229416,0.125159,0.465135,-0.246883,0.0310957,0.599432,-0.262386,-0.975596,-0.0138727,-0.169027,-1.02196,-0.0235958,0.851622,-0.456079,0.707267,0.292772,-0.799292,0.389001,-0.944086,0.102433,0.544081,-0.886666,-0.285737,-0.225062,0.122195,0.18991,-0.552823,-0.64864,0.348631,-0.413763,-0.675688,0.310643,-0.0590447,0.152869,0.603196,-0.32063,-0.0752717,0.160469,0.142034,0.156855,0.3536,1.08194,0.713583,0.923113,0.0783527,-0.1732,-0.429708,0.0134232,0.0312427,0.579346,-0.0750368,0.275816,0.356859,0.106815,-0.308083,-0.31017,0.451885,0.158319,-0.787511,-0.143519,0.177962,0.535382,-0.217163,-0.302385,-0.407529,0.501331,0.830297,0.145426,-0.580979,0.832306,-0.33736,0.129878,-0.735534,-0.197453,-0.172392,-0.751064,-0.670306,-0.656277,-0.222494,-0.158077,-0.574418,0.228949,0.0101132,-0.259145,-0.533233,-1.19041,0.315682,0.275253,-0.756304,0.199668,-0.299774,0.0991272,-0.14488,-0.493755,0.802948,-0.27314,-0.187778,-0.0830519,0.0172247,-0.0426931,0.453366,-0.138203,0.445243,-0.260624,0.415644,-0.0222442,-0.51365,-0.0223699,-0.395985,0.322832,-0.311174,-0.0727203,0.588223,-0.796877,0.0479797,-0.367672,0.287439,-0.0916276,-0.012535,0.354866,-0.159462,-0.0891865,0.346489,0.00845443,0.24286,0.203928,-0.896418,-0.568448,0.302664,-0.108701,0.517212,0.657028,0.304148,0.630066,-0.35527,0.119708,-1.03309,0.0200594,-0.436308,-0.0677473,-0.541009,0.311193,0.142824,-0.443563,-0.149086,-0.276606,0.382788,0.0648962,0.354956,0.487746,-0.0623454,0.216066,0.619091,-0.230587,-0.462007,0.189999,-0.499633,-0.237528,-0.219965,-0.0102636,0.621657,-0.498903,-0.57868,-0.328839,-0.238447,0.819676,-0.0432254,0.234172,-0.42528,-0.136745,0.0316194,0.229673,0.0161577,0.124572,0.689838,-0.0428013,-0.544183,-0.122106,-0.114611,-0.216518,-0.0474635,-0.0998199,-0.325783,0.309108,-0.47595,-0.162614,-0.647541,0.520309,0.206263,0.251465,0.454162,0.501463,-3.4975 +3376.05,0.642725,0.0848144,5,1.53605,0.903087,-1.10661,0.45733,0.718503,-0.0782459,-0.0864953,0.24001,-0.101744,-0.246983,-0.0894509,0.606124,-0.0292352,0.901805,-0.388404,0.373038,0.600616,0.352142,-0.461053,0.0588988,0.132238,-1.11472,-1.18784,-0.121135,-0.0835628,-0.212765,-0.372203,0.841437,-0.829555,-0.131777,0.721362,-0.405062,0.0938941,0.401343,-0.309008,-0.295488,-0.379911,0.342286,0.372923,-0.283613,1.31411,0.499448,-0.0676852,-0.645525,-0.186648,0.428886,0.00511529,0.150162,0.135728,0.409457,0.00640866,0.130858,-0.0498375,0.283565,0.396928,-0.522556,-0.0824603,-0.494771,0.535793,-0.252882,0.0586634,1.18417,-0.515879,-0.215015,-0.329481,0.138011,-0.0716238,0.182924,0.590128,-0.0141302,-0.138132,0.65769,-0.119594,-0.234312,1.0861,0.015075,0.38945,0.937763,-0.57758,-0.0820009,0.0554154,-0.00195483,0.130054,0.248837,-0.747353,0.375402,0.170046,0.0612665,0.186516,-0.465479,-0.531868,-0.0510888,-0.507132,-0.150437,0.438985,0.107227,-0.236208,0.0547796,0.526658,0.185147,0.553265,0.693488,-0.492802,-0.0857257,0.172023,-1.20999,0.108391,-0.202257,-0.156685,0.691824,-0.00388396,-0.186999,0.633255,0.242093,0.920072,-0.605112,-0.149839,0.0798963,0.232479,-0.815506,-0.848875,0.234593,-0.412537,-0.637047,-0.688901,0.650484,-0.514931,0.263441,0.446035,-0.639813,0.386603,-0.800243,0.154076,0.515779,-0.767617,-0.5496,-0.388284,-0.126653,0.351982,-0.486748,-0.088245,0.291861,-0.208872,-0.489472,0.379332,0.109763,0.403172,0.701878,-0.172205,0.310704,0.184217,0.495716,0.351376,0.234233,0.935803,0.955678,1.14769,-0.322673,-0.266475,-0.208517,0.186829,0.638822,0.509987,-0.446832,0.134133,0.343637,-0.0766057,-0.313843,-0.398326,0.520491,0.231634,-0.704358,-0.116832,0.520347,-0.241947,0.222461,-0.384215,-0.0308396,0.206635,0.257509,0.17413,-0.874738,0.0874952,-0.364575,-0.308886,-0.19421,-0.289692,-0.383043,-0.303494,-0.957051,-0.632154,-0.192873,-0.288145,-1.05784,-0.547955,0.297952,-0.0307062,-0.54319,-1.05913,0.477858,0.272871,-0.337546,0.287068,0.0151551,-0.149123,0.131661,-0.731664,1.11587,-0.105678,-0.0166038,-0.082597,0.0135373,0.265233,0.539844,-0.242622,0.333587,0.00445307,0.082346,-0.280937,0.27326,-0.0870756,-0.465011,-0.153631,-0.248383,-0.0683592,0.728941,-0.249557,-0.151399,-0.401389,0.0111446,-0.453279,0.0578593,0.0978313,-0.746653,-0.355414,0.400475,-0.0188188,0.412718,0.187321,-0.389767,-0.346858,0.458197,-0.203278,0.283086,0.576981,0.308543,0.550593,-0.11498,0.0986135,-1.1584,0.0749399,-0.533459,0.320349,-0.706315,-0.538143,0.376029,-0.242415,0.25745,0.0415525,0.502412,-0.136852,0.525881,0.00414751,0.444129,0.184819,0.591121,-0.19264,-0.679115,0.447741,-0.241752,0.316881,-0.434914,0.157457,0.336044,-0.442682,-0.484309,-0.287965,-0.380014,0.490222,-0.107363,0.314629,0.28271,-0.141882,-0.48796,-0.0245407,0.138692,0.0674852,0.529034,-0.205502,-0.435982,0.00234869,0.62071,-0.443206,-0.314806,-0.319819,-0.591137,-0.429791,-0.355417,-0.172955,-1.03044,0.646204,0.192214,0.21977,0.438422,0.468797,-2.27856 +3379.41,0.988641,0.0848144,4,1.53293,0.910468,-1.14731,0.470628,0.741736,-0.0847969,-0.0128711,0.288459,-0.126838,-0.294681,-0.052607,0.518231,-0.0398652,0.90208,-0.348505,0.3856,0.657365,0.333657,-0.485725,0.0559538,0.187646,-1.07739,-1.12246,-0.0971865,-0.0382737,-0.131429,-0.338655,0.81764,-0.85427,-0.202562,0.682583,-0.477635,0.15357,0.348594,-0.388221,-0.320748,-0.283658,0.34225,0.371249,-0.287725,1.28473,0.490157,-0.169502,-0.726024,-0.10249,0.424203,0.0296758,0.140019,0.0305554,0.450658,-0.00749284,0.166744,-0.079129,0.250071,0.436767,-0.50989,-0.0523326,-0.532868,0.525236,-0.238541,0.0172607,1.16611,-0.522827,-0.124128,-0.277909,0.0819761,-0.122938,0.165275,0.643036,0.0331671,-0.191584,0.639284,-0.170811,-0.272219,1.05548,-0.0350822,0.34596,0.89262,-0.528774,-0.0941768,0.0107922,0.00421321,0.164739,0.21518,-0.627331,0.394885,0.202202,0.0928729,0.150434,-0.475388,-0.418889,-0.0814146,-0.462323,-0.136977,0.489375,0.0252729,-0.291013,0.0634688,0.460208,0.104729,0.515413,0.67514,-0.480546,-0.177046,0.117637,-1.18243,0.0696081,-0.239032,-0.138708,0.716584,0.0308033,-0.244242,0.599933,0.257749,0.919879,-0.548282,-0.184863,0.112189,0.241469,-0.742509,-0.821499,0.259527,-0.4208,-0.654577,-0.616827,0.6551,-0.504628,0.185412,0.357503,-0.615687,0.447088,-0.84957,0.152319,0.58215,-0.794717,-0.539863,-0.33126,-0.157901,0.340027,-0.341996,-0.177597,0.273248,-0.143975,-0.481747,0.429381,0.105196,0.437946,0.693767,-0.177804,0.225397,0.195205,0.491199,0.350311,0.272977,0.905555,0.919857,1.15503,-0.312362,-0.274184,-0.170588,0.158133,0.708961,0.509293,-0.478179,0.173281,0.304818,-0.0185307,-0.310769,-0.49717,0.6048,0.236981,-0.767514,-0.0556013,0.62822,-0.156732,0.213429,-0.330181,0.00367265,0.252345,0.294996,0.245835,-0.922977,0.0534641,-0.332592,-0.275098,-0.152627,-0.225516,-0.383485,-0.177953,-0.975409,-0.674719,-0.160777,-0.360163,-1.13913,-0.469906,0.401386,-0.0552062,-0.555833,-1.11059,0.553043,0.304164,-0.278778,0.216781,-0.0267937,-0.194644,0.0717821,-0.661219,1.089,-0.108061,0.0329161,-0.0916328,-0.0934106,0.275074,0.524131,-0.318272,0.341698,0.0384734,0.0699018,-0.226348,0.298417,-0.134643,-0.476751,-0.236123,-0.20554,-0.0572084,0.665503,-0.233151,-0.184954,-0.351497,-0.0435845,-0.496717,0.0970287,0.083957,-0.659844,-0.399132,0.389496,0.0272871,0.492983,0.169401,-0.310164,-0.354415,0.381968,-0.182594,0.269985,0.496652,0.238237,0.545112,-0.131775,0.0738239,-1.23234,0.061037,-0.491616,0.329859,-0.699298,-0.4979,0.323796,-0.223337,0.240987,0.0405664,0.440975,-0.125028,0.567961,-0.0442486,0.438014,0.177652,0.659089,-0.18618,-0.69613,0.483895,-0.266889,0.345734,-0.50118,0.0926565,0.260371,-0.520996,-0.561718,-0.291358,-0.378172,0.516097,-0.133109,0.187515,0.21228,-0.244511,-0.536295,-0.0500851,0.125429,0.0622827,0.607212,-0.0903069,-0.527254,-0.0166431,0.624326,-0.331779,-0.302554,-0.291781,-0.647864,-0.465744,-0.36631,-0.2667,-1.023,0.637065,0.194018,0.230715,0.440475,0.480328,-2.36145 +3391.46,0.717341,0.0848144,4,1.66633,0.793572,-1.15306,0.407975,0.911635,-0.0977913,-0.443457,-0.0329599,-0.336226,-0.0455208,0.245914,-0.0857185,-0.058269,0.646647,-0.372447,0.582284,0.117419,-0.10745,-0.330114,-0.183102,-0.353002,-0.738143,-1.3985,0.0395089,-0.212186,-0.344616,-0.213069,-0.311952,-0.734926,0.10356,0.598981,-0.486447,-0.184751,0.556592,-0.229288,-0.290891,-0.438149,0.460183,0.142861,-0.265743,0.795888,0.45479,-0.0509723,-0.429811,0.0598127,0.477184,-0.563223,0.197503,0.145224,-0.222814,-0.266467,0.262788,0.343732,-0.416082,0.529241,-1.07929,0.435138,-0.860256,0.471802,-0.154666,0.278743,1.39289,-0.808552,-1.50375,-0.414824,0.346043,-0.292633,0.033943,0.658994,-0.0554425,-0.463432,0.573503,-0.117779,-0.445537,0.568761,0.164756,0.490975,0.475333,-0.528813,0.0515576,0.812353,0.0439597,0.495608,0.0210543,-0.331987,-0.0451612,0.0700748,0.101309,0.196914,-0.399446,-0.302085,-0.190825,-0.525185,0.144734,-0.34279,-0.1739,-0.510833,0.15791,0.145014,0.101006,0.749007,0.67756,-0.753959,-0.455914,0.504271,-0.966953,0.251303,-0.162904,0.380809,0.667998,-0.132676,-0.0307986,0.202337,0.530498,0.362239,-0.0743131,-0.602232,0.00799228,-0.319628,-0.433091,-1.53367,-0.162286,-0.170291,-0.864011,-0.113333,-0.123232,-0.255873,-0.0286435,-0.040679,-0.50073,-0.434424,-0.428426,0.385127,0.760128,-0.662821,-0.646606,0.0811094,-0.250383,0.373791,-0.452334,-0.0871809,0.259017,-0.438941,0.0401527,0.715369,0.416452,0.33031,0.350186,-0.0338147,-0.346369,0.298352,0.0633306,0.0769159,0.513194,0.486642,0.415317,0.755798,-0.206602,-0.102845,-0.254334,0.213285,0.152096,1.05735,-0.393491,0.362576,0.421499,0.120931,0.0773268,-0.667518,-0.159874,0.544678,-0.226451,0.377546,0.688148,-0.149951,-0.275481,-0.363993,-0.456177,0.381242,0.401281,0.360328,-0.552112,0.0258056,0.301612,-0.22043,-0.262613,-0.194136,-0.157208,-0.396273,-0.568155,-0.267309,0.0686766,0.100698,-1.14593,-0.0113854,0.191965,0.0929277,-0.644933,-1.18758,0.19211,0.212126,-0.744529,0.65789,0.204045,-0.160553,0.462871,-1.29157,0.929668,-0.202126,0.222261,0.0101888,-0.166439,0.312156,0.559827,-0.330082,0.0900797,-0.295097,-0.194372,-0.354216,-0.00515228,0.214363,-0.64016,-0.572148,-0.469417,-0.0654713,0.837099,-0.0452464,-0.537612,0.0620732,-0.290423,0.1889,0.256256,0.328136,-0.233811,-0.0735682,0.547262,-0.475734,0.28418,0.115803,0.221515,-0.286182,-0.10521,-0.0456352,0.0694304,0.746273,0.366209,0.150248,0.0936398,0.0832672,-0.486532,0.0417278,-0.649241,-0.142305,-0.295813,-0.643298,0.532728,-0.304225,0.0613064,-0.159093,0.30634,-0.0839145,0.569147,-0.112642,-0.0307654,1.05476,0.375899,-0.0638639,-0.995165,0.429003,0.0863352,-0.346379,0.151315,0.498628,0.407619,0.0157185,-0.260987,-0.000450142,-0.132762,0.682199,0.117056,-0.0190929,-0.0959414,-0.260548,-0.212394,-0.261727,0.292128,0.120377,0.503989,-0.054064,-0.475053,0.150336,0.329254,0.140687,-0.154776,-0.0442245,-0.495519,-0.352655,-0.28414,-0.0289915,-0.870064,-0.160894,0.215649,0.220249,0.46438,0.469307,-2.51973 +3396.48,0.993047,0.0848144,4,1.63113,0.746342,-1.14704,0.432626,0.920169,-0.0825697,-0.399706,0.0381629,-0.118911,-0.0867718,0.251641,-0.307915,1.77056e-05,0.583559,-0.460768,0.492854,0.382676,0.011633,-0.216305,-0.200469,-0.311804,-0.729705,-1.16663,-0.0789555,-0.198727,-0.491751,-0.386547,-0.137314,-0.606509,0.208708,0.67353,-0.378334,-0.232918,0.587556,-0.203887,-0.417078,-0.572829,0.604838,0.2822,-0.300535,0.685382,0.498647,-0.0611933,-0.597859,0.18978,0.397667,-0.550087,0.132949,0.181929,-0.0830015,-0.341812,0.184614,0.177312,-0.213609,0.546996,-1.13952,0.256357,-0.865239,0.725844,0.00931166,0.342019,1.23167,-1.11711,-1.37665,-0.278825,0.0240567,-0.339951,-0.193535,0.734799,-0.128877,-0.387862,0.410235,-0.0475245,-0.505804,0.642281,0.062719,0.547718,0.0936776,-0.670958,-0.0302878,0.889248,0.105236,0.465649,0.344684,-0.313134,-0.145975,-0.0761642,0.0654404,0.387082,-0.428005,0.131279,-0.163295,-0.724836,0.320091,-0.223226,-0.0552678,-0.478346,0.0067726,0.0303499,0.258249,0.445874,0.561471,-0.724555,-0.61025,0.544026,-0.944073,0.140083,-0.104266,0.290417,0.679863,-0.132159,0.117665,0.323354,0.560107,0.49953,-0.0413093,-0.340339,0.231026,-0.422151,-0.604343,-1.1681,-0.0170847,-0.241862,-0.616403,-0.223176,0.218119,-0.24324,-0.0457923,-0.0431178,-0.588511,-0.156897,-0.538102,0.131261,0.649796,-0.895271,-0.733436,0.0674654,-0.386095,0.327307,-0.79468,-0.328106,0.395832,-0.488013,0.0269685,0.804826,0.419726,0.255775,0.577126,0.134866,-0.344766,0.381008,0.0932135,0.13555,0.389424,0.459191,0.541288,0.543735,-0.0924972,0.0318321,-0.323117,0.0540915,0.248695,1.0534,-0.586939,0.561,0.525178,0.205278,-0.0215093,-0.679116,-0.39779,0.641687,-0.186751,0.164622,0.564698,-0.105818,-0.21129,-0.387188,-0.507864,0.0522605,0.265963,0.111331,-0.665123,-0.0811658,0.420845,-0.166513,-0.131845,-0.0454871,-0.206196,-0.411395,-0.168216,-0.400444,0.0941565,-0.0069298,-0.693152,0.00861856,0.0313174,0.0680385,-0.514645,-1.08907,0.351114,0.192819,-0.821282,1.00109,0.439886,-0.122891,0.243454,-1.09852,1.087,-0.113384,0.123378,-0.152408,-0.255291,0.24343,0.815808,-0.101785,0.230088,-0.272806,0.0823744,-0.170957,-0.0564116,0.1363,-0.777312,-0.578708,-0.422268,-0.0726015,0.931586,-0.0381673,-0.533133,0.260277,-0.19814,0.0404624,0.34418,0.22631,-0.230116,-0.0842511,0.510636,-0.465716,0.447285,0.0157607,-0.0199442,-0.295744,0.107016,-0.197741,-0.119366,0.66677,0.306746,0.108313,0.134777,-0.0358959,-0.684739,0.453049,-0.462778,0.103343,-0.188137,-0.499623,0.52082,-0.357303,0.0613015,-0.300221,0.31616,0.0258565,0.740665,-0.132507,0.412706,0.842506,0.375465,-0.0662545,-0.942495,0.174125,0.090129,-0.417175,-0.00846257,0.464927,0.121042,0.185112,-0.469257,-0.120574,-0.0327731,0.538025,0.0188856,-0.236157,0.0921015,-0.548964,-0.041951,-0.363873,0.297056,0.0590806,0.405139,0.11237,-0.27133,0.101589,0.667002,-0.108432,-0.23318,-0.0140829,-0.619737,-0.435997,-0.463073,-0.182322,-0.695908,-0.00917682,0.188574,0.222355,0.434251,0.471545,-2.5301 +3374.92,0.917314,0.0848144,4,1.59786,0.714661,-1.14048,0.361401,0.974416,-0.12208,-0.218482,0.158938,-0.389266,-0.360914,0.22465,-0.0255928,-0.585851,0.510939,-0.471847,0.280883,0.396952,0.0795968,0.453724,0.0821761,0.00260727,-0.70863,-0.641178,0.298016,-0.259773,-0.28206,-0.430413,-0.218494,-0.392262,-0.151759,0.513132,-0.379247,-0.677698,0.563942,0.0450307,-0.328991,-0.105703,0.334457,-0.079669,-0.428058,1.1818,0.625969,-0.0430947,-0.201262,0.0667374,0.305558,-0.157904,-0.430554,0.151268,0.0204382,0.41887,0.750623,-0.0582154,-0.145807,0.681374,-0.638173,0.138931,-0.701274,0.684997,-0.125166,0.145274,1.41038,-0.688581,-0.978862,-0.498351,0.211183,-0.461099,0.0600478,0.222169,-0.494035,-0.50398,-0.0273833,0.41714,-0.459647,0.920006,0.0608087,0.700964,0.162332,-0.743069,0.236173,0.671399,0.417078,0.0206061,0.0571955,0.0630494,-0.113713,0.201577,-0.182655,0.513574,-0.418657,-0.758797,-0.290995,-0.44968,0.503564,0.125676,0.102099,-0.39821,0.0304575,0.361578,0.39122,0.509109,0.901584,-0.512905,-0.537658,0.411214,-0.895002,0.538148,-0.305488,0.704698,0.402931,-0.401185,0.190906,0.237494,0.745691,0.245888,-0.464489,-0.542553,-0.120453,-0.61363,0.348889,-1.3335,0.447164,0.0771747,-0.948245,-0.248797,0.365915,-0.239135,-0.230941,0.200136,-0.00776269,0.119455,-0.456682,-0.245601,0.965291,-1.0598,-1.34966,-0.350283,-0.427649,0.539054,-1.05736,-0.491955,0.194215,-0.101588,-0.144216,0.201759,-0.0517324,0.0862189,0.488474,0.0897333,-0.22884,0.110931,-0.109491,0.120525,-0.0734536,0.226536,0.723051,0.725029,0.559723,-0.154477,-0.202075,0.360385,0.538597,0.896665,-0.663369,0.405444,0.444402,-0.0629877,0.304323,-0.753631,-0.292567,0.806066,-0.40481,0.0974864,0.0550951,-0.357134,-0.318704,-0.156775,-0.592826,-0.136889,0.704622,-0.220347,-0.509998,0.307196,0.343006,0.0594451,-0.654696,-0.307542,-0.587084,-0.234151,0.193635,-0.334465,0.59942,0.286212,-0.774802,-0.203495,0.213752,0.167118,-0.191455,-1.01105,0.160996,-0.01006,-0.858364,0.854488,0.215202,-0.537179,0.504379,-0.522648,1.19797,-0.713121,0.298601,-0.0620143,-0.167694,0.531642,0.728704,0.404596,0.85824,-0.180045,0.51091,-0.14582,-0.165133,0.408199,-0.79159,-0.183564,-0.210539,-0.176196,0.704384,-0.451078,-0.210027,-0.0805809,-0.0491363,0.179855,0.354613,0.706768,-0.564641,0.0274646,0.0746609,-0.332609,0.348657,-0.0860613,0.048561,-0.371195,0.493681,0.127582,-0.146763,0.100757,0.19119,0.650329,0.188468,-0.338578,-0.628253,0.306644,-0.392066,0.0608855,-0.623612,-0.407647,-0.0339968,-0.00569174,-0.0487124,-0.230039,0.230781,0.00363299,0.397948,0.37962,0.0961441,0.635957,-0.00511218,0.195588,-0.101658,-0.0365936,-0.0217145,-0.180227,-0.0250518,0.324714,-0.240846,0.0925126,-0.403352,0.362874,-0.133338,0.685399,-0.216334,-0.450346,0.132721,0.164131,0.0361936,-0.0249852,0.468897,-0.498471,0.410946,-0.0585789,-0.472434,0.517309,0.683523,-0.0587959,-0.109701,0.137322,-0.816152,-0.156524,-0.774888,0.535792,-0.45534,-0.10664,0.205389,0.229762,0.453199,0.479334,-2.61347 +3394.94,0.672947,0.0848144,5,1.52188,1.01017,-1.08,0.4048,0.275801,-0.0352191,0.308595,-0.126476,0.410552,0.0313644,-0.168538,-0.323417,-0.311056,0.123457,0.117446,1.25381,0.0141234,-0.496442,-0.327364,0.157727,-0.317621,-1.28473,-0.652284,0.477177,-0.427295,0.439011,0.225122,0.681198,-1.15426,-0.196523,0.63834,-0.218132,-0.0120562,0.0134251,-0.468472,0.432626,-0.476425,0.976,0.778068,0.118074,1.34427,0.630809,0.671116,-0.72402,0.0219127,0.139316,-0.602892,0.146515,0.0237193,0.284201,0.0252995,-0.11063,0.537289,-0.699395,0.302012,-0.142948,-0.348238,-0.695043,0.4438,-0.936726,0.19521,0.689308,-0.308578,-0.564819,0.513297,0.260763,0.498469,-0.282203,-0.059011,-0.205881,0.0692492,0.733773,0.676134,0.327848,0.374473,0.295696,-0.248577,-0.139464,-0.239467,0.0604507,0.0410251,-1.23499,-0.314164,-0.394913,-0.458669,-0.0765073,-0.467139,0.161501,-0.141995,-0.594507,0.660813,0.313863,0.419513,-0.504901,-0.376866,-0.253411,0.507866,-0.422666,-0.387839,0.345559,-0.670759,-0.495939,-0.133942,-0.225756,-0.286245,0.271087,-0.256132,0.185382,0.162187,0.665953,0.367157,-0.618897,0.0297385,0.501862,0.218524,0.470414,-0.509844,0.203321,0.935639,-0.414472,-0.0287326,-0.108229,-0.533534,0.583544,0.183326,0.0402587,0.17417,0.26962,0.441286,-1.00118,0.227485,0.233972,0.30401,0.243219,0.378842,0.844117,0.37294,-0.245735,0.317854,-0.123658,-0.291534,-0.461634,0.239461,-0.616566,-0.169504,-0.117268,0.258856,0.539071,-0.0497044,-0.17894,-0.278393,0.276451,0.388814,-0.211331,0.609296,0.107867,-0.24607,-0.843684,0.0283029,-0.0407366,0.538742,-0.419286,0.286348,0.505011,-0.247823,-0.335653,0.185685,-0.288082,0.375345,0.416328,-0.533805,0.426447,-0.117036,0.315229,0.103122,0.0987609,-0.41338,0.223443,0.589919,0.931211,0.40986,0.375298,-0.0526109,-0.139638,-0.129996,-0.114963,-0.26388,0.151626,0.308416,-0.82747,0.0601474,-0.495308,-0.191267,-0.510013,0.145079,-0.00805943,-0.259548,-0.1426,-0.153733,-0.221281,-0.492578,0.39566,-0.287271,-0.407859,0.0510238,-0.264524,-0.156139,1.26631,0.533872,0.0258609,-0.174451,-0.0130947,-0.571295,-0.116841,-0.792865,-0.260476,-0.550056,-0.115812,0.483589,-0.187099,-0.285603,-0.363998,-0.0103147,0.712966,-0.739541,0.402217,-0.0579984,-0.248944,0.569625,-0.203815,-0.496042,0.089018,-0.748111,0.0427988,-0.662108,0.393926,0.232175,-0.189849,0.832399,-0.37965,-0.0127589,-0.0841814,0.0729937,0.138197,0.3888,0.0943853,0.118786,-0.0668512,0.30349,-0.163569,-0.233682,-0.589056,0.3709,0.115049,0.136545,0.0208372,-0.28922,0.0693821,0.243466,-0.350964,0.28266,0.427456,-0.225181,-0.129326,0.117512,0.445701,-0.0830123,-0.271988,0.0205489,-0.0776406,-0.223568,-0.629901,-0.590206,0.325512,-0.0475076,0.141013,-0.0401379,-0.105068,0.209925,0.342057,-0.220058,-0.515638,-0.43648,-0.0715627,0.270876,0.145309,0.320954,0.456019,-0.0755701,0.194956,0.0945969,-0.188565,-0.158812,0.383312,-0.378049,-0.0617334,0.158673,0.69932,-0.592146,0.15222,0.116328,0.141934,0.390266,0.376741,0.624713,-0.987291 +3416.56,0.982958,0.0848144,4,1.55582,1.02722,-1.05095,0.359301,0.305025,-0.0393955,0.274283,-0.176225,0.639503,0.223559,-0.454635,-0.380339,-0.552496,0.115294,-0.103566,0.844235,-0.0618975,-0.576024,-0.39133,0.00637431,-0.354252,-1.05901,-0.993972,0.341837,-0.503532,0.515078,-0.134897,0.868931,-0.852939,-0.158133,0.651581,-0.249016,-0.124737,-0.166975,-0.409257,0.0745036,-0.907233,0.960783,0.55206,-0.0259245,1.09832,0.750695,0.488335,-0.686443,-0.00433084,0.0803313,-0.681316,0.174153,0.160535,0.107653,0.00236636,0.311156,0.421046,-0.40397,0.324406,0.0791972,-0.322438,-0.509703,0.35725,-0.782118,-0.107015,0.465613,-0.620126,-0.499844,0.712948,0.354533,0.424884,0.0437725,-0.147029,0.115203,-0.0548249,0.384986,0.683511,0.139503,0.516939,0.250212,0.0878791,-0.477634,-0.355508,-0.000459171,0.0906803,-0.784252,-0.136181,-0.325649,-0.310462,-0.198493,-0.129844,0.250762,0.10701,-0.679069,0.235473,0.31993,0.566966,-0.158303,-0.118586,0.249659,0.0688428,-0.0909405,-0.111813,-0.0183549,-0.637049,-0.699375,-0.527802,0.0488614,0.033508,0.427096,0.1099,0.052938,-0.002814,0.557407,0.24077,-0.352948,-0.160296,0.455226,0.246717,0.68132,-0.638653,-0.128795,0.743189,-0.31365,-0.23681,-0.247396,-0.418491,-0.063844,0.404576,0.349059,0.106782,0.394716,0.557412,-0.432244,0.351586,0.244833,0.332601,0.229823,0.418777,0.418919,0.586969,-0.138599,0.586327,-0.159639,-0.311118,-0.61914,0.125472,-0.526613,-0.124488,-0.138926,0.182898,0.553029,-0.278538,-0.236757,-0.473211,0.357854,0.364091,-0.257459,0.457812,0.138202,-0.209087,-0.451854,0.0136708,-0.22687,0.413957,-0.292529,0.417466,0.525661,0.107126,-0.290335,0.342838,-0.18696,0.270623,0.260815,-0.32411,0.347816,0.0358768,0.521652,0.00812261,0.208044,-0.261169,0.00777579,0.457462,0.727371,0.0183444,0.0807449,0.029759,0.0450482,0.15876,-0.0493006,-0.255264,0.0557146,0.084802,-0.557332,0.118853,-0.557972,-0.347313,-0.758149,0.0245235,0.0694488,0.0603542,-0.0699292,-0.0777774,-0.512075,-0.336977,0.310108,-0.27378,-0.249759,-0.180641,-0.167617,-0.284039,0.853525,-0.0988945,0.324576,-0.233844,-0.239371,-0.404546,-0.456535,-0.662174,-0.059262,-0.645743,-0.160568,0.592735,0.0331389,-0.167115,-0.797051,-0.00241317,0.505913,-0.822939,0.644953,0.0575413,-0.228591,0.48593,-0.50564,-0.772628,0.316814,-0.752283,-0.399893,-0.538614,0.685524,0.177628,0.00690132,0.730752,-0.327042,0.307911,-0.00811152,-0.120522,0.0270456,0.467709,0.101593,0.0724194,0.0194723,0.321012,-0.116932,-0.447169,-0.430864,0.613026,-0.169002,-0.190705,0.117255,0.112489,0.0356762,0.490656,-0.210105,0.361384,0.0490547,0.194451,-0.373075,0.0295467,0.21439,-0.144242,0.16458,0.355925,-0.0767585,-0.368674,-0.626422,-0.697361,0.371781,0.0730072,-0.150218,0.0906683,0.0977139,0.264599,0.36744,-0.429858,-0.328424,-0.48461,0.146275,0.520224,0.0622432,0.0218175,0.0805665,-0.296265,0.083942,0.15071,-0.344495,0.0377374,0.151447,-0.380192,0.0864003,0.0403739,0.530083,-0.599622,0.268538,0.0620319,0.149886,0.285733,0.387151,0.53454,-1.05159 +3424.32,0.883889,0.0848144,4,1.5573,1.01416,-1.60161,0.585697,0.784932,-0.169991,-0.0545689,-0.348638,-0.255053,0.289328,-0.158832,-0.333811,-0.245,0.232161,-0.028333,0.650034,-0.12193,-0.134937,-0.0426288,-0.088731,-0.475548,-0.682943,-0.933689,0.320335,-0.714308,-0.211223,0.0927263,0.0439657,-0.258178,0.0590074,0.695853,-0.522988,-0.0975341,0.0699687,-0.318946,0.30526,-0.113599,0.752577,0.554454,0.374069,1.18967,0.303167,0.379634,-1.09598,0.188644,-1.0378,-0.863198,0.385955,-0.232018,-0.121987,-0.223496,0.659813,0.0804749,-0.197804,-0.0710953,0.270103,-0.183247,-0.513566,0.45714,-0.913837,0.479626,1.05059,-0.539968,-0.706045,0.197024,0.094054,0.185311,0.498589,-0.323296,-0.765559,0.240061,0.704019,0.341601,-0.189124,0.494023,0.418101,0.65254,0.124308,-0.465059,-0.232634,0.26683,-0.362897,-0.296196,0.16372,-0.598623,-0.274007,0.450406,-0.0137449,-0.0974164,-0.312229,-0.0602009,-0.00890004,-0.0700314,-0.122691,-0.0908307,0.239107,0.434937,-0.0892553,-0.41275,-0.0237104,0.408497,-0.248028,-0.157516,-0.747112,0.537533,0.7103,0.201826,0.031097,0.0495769,0.474054,0.0980435,-0.477813,0.107271,0.598149,-0.435337,-0.108896,-0.122036,-0.234882,0.0917178,-0.212361,-0.367058,-0.148947,0.0705388,-0.258969,-0.19581,0.392582,0.910629,-0.603614,0.111571,0.0126251,0.463911,-0.0388133,-0.275646,0.418902,-0.245983,-0.314857,-0.136612,-0.733909,0.40008,-1.0256,0.217073,-0.353199,0.111508,-0.236466,0.612902,0.0182213,0.413315,0.198414,-0.194928,0.0765492,-0.286448,0.167223,0.0372505,-0.497179,-0.0203959,0.423702,0.268318,-0.0504022,-0.357083,0.553104,0.271211,0.256956,0.323881,-0.048286,-0.0697233,0.167916,0.0627334,-0.194401,-0.571322,-0.0389388,0.546377,0.0677563,0.179701,-0.424063,-0.117483,-0.341021,-0.136512,0.136317,0.211591,0.791565,0.30707,0.109449,0.192841,-0.0871413,0.433007,-0.0269917,0.34457,-0.0448173,0.361754,-0.239085,-0.0586329,-0.200432,0.635476,-0.35449,0.458092,0.292759,-0.0807112,-0.298247,-0.099363,-0.0561326,-0.442943,0.000840692,-0.0653908,-0.00117136,-0.300555,0.273801,-0.0261742,0.650728,-0.172823,0.20918,-0.0379786,-0.492679,-0.464503,0.468324,-0.215246,0.348295,-0.257009,-0.180886,0.330542,0.00163553,0.315336,-0.246776,0.192159,0.481229,-0.419668,0.52156,-0.0343183,0.384692,-0.205348,0.220461,0.511168,0.0992268,-0.0620605,-0.728602,-0.212836,-0.0712542,0.617145,0.12441,0.56201,0.339965,-0.889992,-0.458537,0.0258729,-0.00937526,-0.189526,-0.0372027,0.529281,0.303771,-0.283784,-0.501045,-0.0553195,-0.396438,0.148525,0.112672,0.292354,0.225793,-0.344676,-0.0428735,0.115476,-0.348289,-0.0571168,0.140447,-0.427888,0.0974327,0.365092,-0.368894,-0.0854546,-0.00978229,0.250363,0.652848,-0.087491,-0.530456,0.529033,-0.317148,0.289108,-0.498003,-0.183033,0.151109,0.174177,0.290614,-0.209894,0.0649859,-0.0549585,0.558777,0.307472,0.356223,-0.0805369,0.454392,-0.0693574,-0.391432,0.250387,-0.0254741,0.168083,-0.882636,-0.0112437,-0.083161,0.248491,0.0397196,-0.309401,-0.81345,-0.513741,0.121196,0.254172,0.348133,0.504154,-2.51293 +3417.56,0.913077,0.0848144,4,1.55832,1.00552,-1.28318,0.467884,0.771428,-0.193288,-0.0411475,-0.30357,-0.207733,0.243269,-0.00583539,-0.436472,-0.176499,0.259933,-0.176693,0.748572,-0.164781,-0.145209,-0.0713055,-0.123855,-0.275637,-0.561029,-0.989592,0.264334,-0.762827,-0.193587,-0.0719421,0.0974983,-0.497291,0.00532779,0.67793,-0.43763,-0.288293,0.106649,-0.263904,0.221835,-0.0721325,0.597268,0.617307,0.474107,1.07702,0.288359,0.591217,-0.98263,0.243952,-1.04747,-0.989288,0.602142,0.006507,-0.0727629,-0.00512908,0.736869,0.169741,-0.163366,0.0683044,0.13825,-0.131407,-0.597363,0.515185,-0.908816,0.439398,1.05892,-0.749351,-0.668922,0.599547,0.0911703,0.193261,0.733881,-0.542841,-0.780366,0.267062,0.702412,0.412634,-0.151023,0.512628,0.376365,0.518728,-0.1034,-0.273394,-0.157365,0.23568,-0.48558,-0.318583,0.169264,-0.570246,-0.268599,0.517248,-0.167343,0.00355947,-0.386986,-0.132664,-0.0293375,0.0843568,-0.0579703,-0.201039,0.310203,0.243745,-0.0796314,-0.454501,-0.153429,0.309591,-0.228394,-0.319603,-0.611765,0.510421,0.637707,0.332071,0.0953901,-0.00272294,0.347764,0.0859979,-0.31727,0.0427625,0.629973,-0.0597455,-0.202285,-0.190378,-0.170181,0.243743,-0.256213,-0.316225,-0.18065,0.161819,-0.131082,-0.19711,0.446757,1.06862,-0.724741,0.00264523,-0.0280884,0.433886,-0.026822,-0.220395,0.607459,-0.223597,-0.314823,-0.332645,-0.636958,0.48713,-1.10812,0.127538,-0.426421,0.236749,-0.436106,0.378979,0.0385134,0.507783,0.286256,-0.226408,-0.0155696,-0.101205,0.126828,0.0635029,-0.680707,0.0632244,0.47223,0.213295,-0.0235492,-0.235634,0.504506,0.430766,0.102369,0.151942,-0.154807,-0.146208,0.117959,-0.0258467,-0.231399,-0.299722,-0.181759,0.351065,0.0794477,0.226011,-0.381814,0.0499186,-0.173943,-0.0713279,0.167065,0.288759,0.873067,0.16824,0.08566,0.281183,-0.221006,0.47665,-0.203041,0.410295,-0.248903,0.183609,-0.248052,-0.254391,-0.0328628,0.696047,-0.33424,0.400391,0.268405,-0.105221,-0.25064,-0.303313,0.275128,-0.351988,0.0209564,0.0868416,0.039667,-0.00156751,0.395035,0.0638333,0.659513,0.026398,0.273457,0.184866,-0.497383,-0.334536,0.534017,-0.327852,0.391101,-0.259383,-0.182926,0.174912,-0.0978663,0.484762,-0.182211,0.251068,0.503418,-0.674234,0.647697,-0.0416717,0.146882,-0.196641,0.179278,0.55462,0.175587,-0.123058,-0.852166,-0.0503597,-0.00180731,0.559736,-0.00312068,0.371216,0.286756,-0.929246,-0.330138,-0.148064,0.170982,-0.210394,0.021169,0.499853,0.214225,-0.222995,-0.439599,-0.0408689,-0.220075,0.110104,0.00426783,0.350338,0.0758074,-0.204079,-0.0226683,-0.0722337,-0.282984,0.27139,0.0682849,-0.413681,0.174161,0.33997,-0.350141,-0.192937,-0.185417,0.146291,0.652561,-0.042844,-0.727994,0.352601,-0.145908,0.393173,-0.459208,-0.526386,0.0762426,0.107565,0.153491,-0.238675,0.259079,0.111023,0.471436,0.272159,0.220664,-0.0814839,0.460177,-0.0438438,-0.717179,0.198304,-0.0351292,0.241754,-1.03154,0.0470837,-0.158379,0.21795,0.0814987,-0.305287,-0.901819,-0.597533,0.122749,0.211562,0.350356,0.459958,-2.50157 +3399.13,0.497822,0.0848144,5,1.64569,0.715562,-1.17171,0.426529,0.426083,-0.259216,-0.312665,-0.0625346,0.7406,-0.0983426,-0.38438,-0.069379,-0.423606,0.160681,-0.529099,0.832788,0.241316,0.0815009,-0.252292,-0.451683,-0.266096,-1.17833,-0.571385,0.298014,-0.313372,-0.0919231,-0.531971,-0.533849,-0.482212,0.0652126,0.678421,-0.937288,0.365365,0.248654,-0.18035,-0.576615,-0.488635,0.625358,0.541872,-0.939381,0.540881,0.329951,0.0252541,-0.558759,-0.00460209,1.14753,0.0221898,-0.272003,0.540483,-0.346382,0.349396,0.173818,-0.0423326,-0.338036,0.819172,-0.165257,-0.296755,-0.584579,0.322348,-0.0923397,0.0675602,1.14021,-0.366426,-1.06257,-0.637825,0.157037,-0.356667,-0.845765,0.5227,0.0400958,-0.383714,-0.337991,0.861641,-0.00713744,0.510797,0.618442,0.311948,0.119768,-0.248035,0.119578,0.889981,-0.120158,0.134317,-0.220452,-0.22874,0.135465,-0.446333,-0.0703934,-0.179639,-0.0206243,0.170269,0.152391,0.0537116,-0.183595,0.165237,-1.09716,-0.182913,-0.127507,0.456727,0.406063,-0.0676015,0.0729805,-0.279378,-0.254489,-0.353961,-1.1452,0.29765,-0.599825,0.352148,0.401957,-0.198589,0.241961,0.10137,0.268497,-0.0950361,0.166033,-0.416707,0.402908,0.309421,0.290988,-1.07151,0.0447909,-0.333832,-0.00029207,-0.105458,-0.270457,-0.798439,0.664139,0.605677,-0.602861,-0.379426,-0.189808,0.20461,0.382448,-0.12136,0.230993,0.445845,0.534231,0.287554,0.261961,-0.740865,-0.114296,0.0584483,-0.867304,-0.332085,0.430539,-0.663907,0.24893,-0.0265334,-0.293558,-0.12213,0.405419,0.128065,0.516817,0.278247,0.390257,0.312751,-0.299474,0.105826,-0.452024,-0.0657821,-0.0262293,0.621288,0.0674497,-0.00126823,0.34901,-0.0802196,0.0165584,-0.188843,0.0766154,0.0735924,-0.173787,-0.0466313,0.0388837,-0.507569,-0.0662403,-0.503793,-0.204127,0.284228,0.531465,-0.0374137,-0.263724,0.331849,-0.0345502,-0.778396,-0.576566,-1.05911,-0.0646123,0.15392,-0.513818,0.18857,-0.0348503,-0.88708,-0.670481,-0.182777,0.149161,0.267184,-0.276187,-0.603499,-0.164602,0.0157167,-0.27063,-0.348131,-0.163595,0.115529,-0.501421,-1.03484,1.03512,-0.0447545,0.0613497,0.236685,0.042447,0.369821,-0.523391,0.125208,0.384835,-0.367466,0.181016,0.534199,-0.409292,-0.50138,-1.1751,-0.292106,-0.243307,0.201909,0.172338,-0.533174,-0.776574,0.413275,0.0237276,-0.932141,-0.141524,-0.439179,0.253761,-0.643857,0.517882,-0.400105,0.296429,0.359007,-0.772516,0.754198,0.763808,0.152231,-0.183409,0.765288,0.151699,0.66978,0.240942,0.0892331,0.0107064,0.0183284,-0.751237,0.513847,-0.231831,-0.594346,0.632371,-0.270819,0.335958,0.199927,0.150091,0.177169,0.0280455,0.672736,0.324838,0.178694,0.555915,0.177772,0.0143191,-0.10863,-0.250081,-0.444514,0.263694,-0.919536,0.456804,-0.0528833,0.436801,0.419355,0.240894,0.451787,0.069725,-0.213503,-0.527169,-0.637813,-0.278647,0.00799761,0.218652,-0.251402,0.0250072,0.475683,0.476322,-0.0171471,0.0168711,-0.394092,1.23658,-0.187496,-0.604646,-0.175865,-0.261857,0.0720491,0.841979,0.842304,0.190499,0.241281,0.436462,0.491204,-0.757962 +3382.84,0.951551,0.0848144,5,1.52006,0.97919,-1.05276,0.400548,0.504021,-0.146508,0.523925,0.0399515,-0.504944,-0.0566338,-0.245822,-0.124198,0.225651,-0.0756129,-0.140524,0.854496,0.356556,0.50346,-0.0229868,-0.435855,-0.635707,-0.611607,-0.94386,0.477716,-0.398081,-0.606057,0.0277789,0.66005,-0.0330787,0.0449062,0.619681,-0.212904,-0.334147,0.541817,-0.152411,0.268221,-0.436327,0.0589167,-0.0253453,0.00137336,0.665256,-0.0351706,0.00218638,-0.331089,-0.63821,-0.816209,-0.555831,0.0963272,0.190873,0.304054,0.0201521,0.0989441,-0.14067,-0.293692,0.229474,-0.0973405,-0.251142,-0.704598,0.412349,-0.752145,0.0799051,1.02454,-0.571112,-0.811255,0.281912,0.0485798,-0.107875,0.815698,0.126323,-0.521696,-0.117883,0.31681,1.06137,-0.0938314,0.380388,0.37024,-0.137339,-0.316315,0.0329482,0.281091,0.450145,-0.398468,-0.102341,-0.0949149,-0.243144,-0.239848,0.290501,-0.782515,0.268613,-0.511338,-0.295378,-0.158736,-0.230164,0.00154247,-0.284497,-0.471615,0.534853,-0.190562,0.252378,0.359357,0.886284,0.110743,-0.701162,0.0331339,0.0783981,-0.236586,0.679523,0.0940426,0.561013,0.559731,0.356528,-0.232637,0.196,0.646696,0.247234,-0.280002,-0.326318,-0.265696,0.430513,-0.0782839,-0.574658,-0.071472,-0.660603,-0.504132,-0.258581,0.530979,0.809035,-0.345564,0.229945,-0.564501,0.115919,0.810903,0.328874,0.495544,-0.243169,-0.909461,-0.429996,-0.414388,0.85759,-1.05989,0.0489922,-0.224492,0.510122,0.0661785,0.360211,0.0683342,0.261702,0.443499,-0.0358581,-0.185987,-0.496371,-0.277011,-0.0805461,-0.653376,0.826469,0.733144,0.345105,0.455177,0.21708,0.636024,0.725447,-0.0723964,1.06406,-0.715112,-0.306848,0.24031,-0.0718055,-0.477738,-0.208232,-0.0878023,0.658424,-0.0201587,0.0194292,-0.311943,0.0743532,-0.330624,0.0392317,0.0613371,0.0797832,0.76281,-0.182371,-0.556597,0.412366,-0.493306,-0.0240796,-0.194713,-0.0518773,-0.0186069,-0.127521,-0.823903,0.500606,0.140495,0.662486,-0.546201,-0.259115,0.055654,0.182273,0.06432,-0.571219,0.170319,-0.500106,0.185724,0.794382,0.517822,0.317688,0.0241071,-0.280884,0.980239,-0.06023,0.21262,-0.321794,-0.544383,-0.211815,1.08827,-0.981063,0.45875,-0.252209,0.313948,0.37388,-0.446646,0.195318,-0.178229,0.333184,-0.218338,-0.627999,0.64356,0.27902,-0.0584835,0.435215,0.293956,0.426058,0.0808347,-0.0842111,-0.859262,-0.1079,0.672727,0.675017,-0.0971554,0.476655,-0.870859,-0.699522,-0.408849,-0.860874,0.0951702,0.0023057,0.813375,0.721555,0.398304,-0.778716,0.0899454,0.0784964,-0.956179,0.39116,-0.689581,0.363594,0.386278,0.0950576,-0.40026,0.368702,-0.222586,-0.145543,0.752543,0.0363953,-0.294426,-0.135704,-0.286726,0.0621092,-0.252492,-0.00733029,0.25249,-0.145742,-0.894886,0.140052,-0.00557761,0.0897055,-0.276468,0.0838053,0.690641,0.648893,-0.0233813,0.338283,-0.27142,-0.299613,0.885374,0.18612,0.689978,0.113156,0.497033,0.153197,-1.11893,0.215573,0.147303,0.325893,-0.8579,0.224252,0.111232,0.856307,-0.100621,-0.367702,-0.553899,-0.502086,0.228648,0.154311,0.478172,0.392824,-1.67445 +3388.18,0.677229,0.0848144,5,1.55695,0.926481,-0.478251,0.0751228,0.543761,0.0939024,-0.242229,-0.375902,0.314444,0.122703,0.128665,-0.155916,-0.599461,-0.0199872,-0.767464,0.822836,0.0831879,0.0304648,-0.59139,-0.298733,-0.104123,-0.707955,-0.365925,0.0624884,-0.370057,0.00257576,0.0093274,0.0434536,-0.301721,0.380888,0.865811,-0.682118,0.0839133,0.0305182,0.183687,-0.352293,-0.358723,0.765854,0.115692,-0.727904,0.509422,0.713107,-0.0611978,-0.229082,-0.0606448,0.7623,-0.457451,-0.0725268,0.238506,0.156471,0.250613,0.690474,0.00257598,-0.503315,1.1514,-0.156032,0.100516,-0.845526,0.49335,-0.168227,0.324704,0.943976,-0.467868,-0.356852,-0.608419,0.382154,0.199184,-0.431065,0.238776,-0.502958,0.184398,0.421895,1.04675,0.37044,0.995715,0.576489,0.259388,0.0284318,-0.499659,0.201473,0.439799,0.00994,0.24816,-0.282489,0.154425,0.221719,-0.186524,0.035909,-0.439779,-0.347689,-0.118677,0.27167,0.333033,-0.278587,0.314911,0.093593,-0.267971,-0.0142152,-0.154294,0.780426,-0.575211,-0.125022,0.0177073,-0.495947,-0.230443,-0.444347,-0.0709633,-0.115055,0.195413,0.569612,-0.906945,0.336561,0.264444,0.444506,-0.217903,0.129739,-0.358849,0.751796,-0.0367687,0.14055,-1.14998,-0.371934,-0.332775,0.225384,-0.156234,0.399633,0.0979627,0.470004,-0.156863,-0.0949231,0.158521,0.141621,-0.0381806,0.814787,-0.142933,0.110748,0.352103,0.231685,0.142208,-0.451357,-0.714066,-0.155159,-0.26503,-0.755204,-0.23875,0.184062,-0.333617,-0.0795294,-0.484663,-0.320225,-0.0358449,0.592388,0.190175,0.552464,0.179072,0.367364,0.374736,-0.396712,0.283855,-0.22093,0.234028,0.311464,0.272797,0.448006,-0.193116,0.238739,0.401445,0.226408,-0.171031,0.0619848,0.137677,-0.291764,-0.167897,0.0865955,-0.537678,0.278846,-0.232284,-0.374054,0.254851,0.785552,0.638783,-0.442842,-0.426439,0.427392,0.560678,-0.377523,-0.311873,-0.718631,0.318301,-0.051091,0.378434,0.12705,-0.510167,-0.585878,-0.219987,0.244472,-0.00698607,-0.277455,-0.687252,0.349862,0.174977,-0.560928,-0.303452,-0.775107,-0.244533,0.0930107,-0.936118,1.07357,-0.160825,0.430893,0.253767,0.00421596,0.504596,-0.889379,-0.162832,0.359772,-0.403867,0.50104,0.754998,-0.538212,-0.158445,-0.523716,-0.566231,0.50681,-0.438967,0.742516,-0.871805,-0.475891,-0.357026,0.210764,-0.713818,-0.0194593,-0.400406,0.177964,-0.422549,0.712501,-0.757036,0.343038,0.502472,-0.113459,0.213302,0.722427,0.351252,0.237996,0.948095,-0.544165,-0.105678,-0.172634,0.163076,-0.0039889,-0.157843,-0.476565,0.223632,-0.418119,-0.948632,0.0739909,-0.406911,0.284031,-0.0987272,-0.113919,0.379128,-0.0716986,0.383281,0.40201,0.648968,0.107863,-0.273261,-0.683736,0.0598584,-0.314158,-0.419984,0.047685,-1.01273,0.525191,0.114369,0.278678,0.482747,-0.273967,0.434783,0.100956,-0.605424,-0.216467,-0.383212,-0.702883,0.299483,-0.240024,-0.458719,-0.381918,0.388198,0.834304,-0.21992,-0.0235704,-0.573088,0.990256,-0.104373,-1.06799,-0.932468,-0.139625,-0.245828,-0.265545,0.51262,0.21437,0.177194,0.463002,0.420945,-1.72964 +3427.84,0.995582,0.0848144,4,1.59591,0.988533,-0.850055,0.288446,0.391528,-0.0375792,0.325112,-0.0507995,0.624206,0.243581,-0.357378,-0.294124,0.165437,-0.00018093,0.264224,0.336058,-0.0166645,-0.068744,0.0300322,-0.16093,-0.26561,-0.797651,-0.831862,-0.183867,0.139069,-0.200173,0.102806,0.334923,-0.425429,-0.200956,1.02281,0.271377,-0.120971,0.257579,-0.56759,-0.186779,-0.0844955,-0.204217,0.267698,-0.0965234,0.928388,0.240377,0.410051,-0.926622,0.154859,-0.832626,-0.681898,-0.0508038,0.319535,0.302601,0.162435,0.259565,-0.215327,-0.388783,0.458367,0.0937706,0.112458,-0.540216,0.311127,-0.369441,-0.28133,0.360218,-0.598719,-1.08391,0.504982,-0.137472,0.196615,-0.393457,0.37013,-0.532256,-0.117783,0.153863,0.812321,-0.11032,0.608648,0.282082,0.327288,0.307415,0.177253,-0.0492802,0.27879,-0.403296,0.372836,-0.170776,-0.539172,-0.133163,0.300726,-0.221538,0.16024,-0.618577,-0.0988461,-0.0426864,-0.0742234,0.3435,-0.00293004,-0.700354,0.602818,-0.358398,0.442262,0.146471,0.107995,-0.595878,-0.60436,-0.411588,-0.256632,-0.0022335,0.692698,-0.0700188,0.12808,0.376247,0.0609338,-0.0646249,0.23298,0.351439,0.203161,-0.239653,-0.0375867,-0.0156907,0.390579,-0.0926166,0.170586,0.30546,-0.179918,-0.2054,0.0365441,-0.0841595,0.235443,-0.435395,0.0803171,-0.732581,0.118523,0.522643,0.245175,0.488232,-0.298889,-0.0578935,0.399515,-0.0669807,0.409267,-0.384053,-0.216565,0.343635,-0.0723072,0.11245,0.105285,0.176291,0.291457,0.730121,-0.105604,0.00849582,0.340614,-0.245728,0.143004,-0.00081282,0.303946,0.133554,0.11089,0.549572,0.0425619,0.303426,-0.019101,-0.236673,0.627329,-0.310046,0.110937,0.608715,-0.0644897,-0.64982,0.0125616,-0.328093,0.443883,-0.18096,0.0247147,-0.330205,0.177905,-0.483117,-0.223223,-0.219469,0.324571,1.00918,-0.430129,-0.124222,0.408543,-0.20679,-0.327339,-0.568229,0.0692298,-0.181313,0.186602,-0.776351,0.379629,-0.136108,-0.00618992,-0.268167,0.0704962,0.255941,-0.273536,-0.19143,-0.807634,-0.222684,-0.0295257,-0.350969,0.535687,0.440246,0.00166416,-0.572496,0.0767379,0.512212,-0.52765,-0.250372,-0.124511,-0.227846,0.287953,0.488702,-0.128098,0.399888,-0.00967776,0.106998,-0.240758,0.286073,0.173799,-0.643105,0.417726,0.252619,-0.199662,0.40663,-0.585695,-0.206069,0.198718,0.201095,-0.401459,0.00173756,-0.361242,-0.794335,-0.0305199,0.751053,0.649571,0.129366,0.963352,-0.656774,-0.513826,-0.605105,-0.395163,0.511108,-0.519043,0.252466,0.0722348,0.415358,0.095628,-0.302366,0.0957165,-0.829112,0.253318,-0.598519,0.167706,0.253375,-0.299776,-0.28871,-0.0821098,0.200307,-0.152779,0.0430958,-0.204663,-0.0574095,0.0337422,-0.0217312,-0.354815,0.117374,-0.514912,0.243973,0.0205001,-0.359882,0.12312,-0.329352,0.221422,-0.0123928,-0.213984,-0.20608,0.0757062,-0.0899866,-0.525612,-0.191891,-0.113796,0.552051,-0.115058,0.0434947,0.0100671,0.256668,0.0714756,-1.04788,-0.0680326,-0.184038,0.301004,-0.441064,0.286004,0.0733655,-0.403072,0.218882,-0.203365,-0.227999,-0.159137,0.132706,0.18842,0.364288,0.434073,-1.26908 +3448.93,0.996536,0.0848144,4,1.66083,1.06702,-0.633519,0.201631,0.671326,-0.0282422,0.165151,-0.185045,0.547565,0.289194,-0.178388,-0.031023,-0.35236,-0.0198296,-0.936282,0.786082,0.105412,-0.148618,-0.470428,0.162275,-0.344768,-0.928299,-0.564812,-0.0605469,-0.458687,0.00353269,0.122038,0.241615,-0.415124,0.101906,0.648427,-1.05143,0.363234,-0.20096,-0.391356,-0.0754275,-0.471443,0.955419,0.73168,-0.422303,0.977261,0.681616,0.185144,-0.467418,-0.320516,-0.209135,-0.354198,0.0301501,0.250337,-0.0973864,-0.207723,0.349094,0.128758,0.031984,0.478754,-0.45266,-0.0148785,-0.762031,0.210854,-0.423726,0.352265,0.581341,-0.5892,-0.555358,-0.201346,0.145557,-0.200282,0.237966,-0.34846,-0.176291,-0.273462,0.285054,0.769657,-0.076504,0.669413,0.25055,0.0791443,-0.16948,-0.765471,0.102574,0.51625,-0.1082,0.148379,-0.225254,-0.17151,-0.348965,-0.195968,0.437286,-0.080071,-0.319957,-0.102204,0.158351,0.336799,-0.108202,-0.328782,0.335447,-0.493485,-0.399055,-0.314712,0.00701827,-0.0245098,-0.191345,-0.304522,-0.0978678,0.617427,-0.593312,-0.0078832,-0.25742,-0.0543474,0.725126,-0.230404,-0.148041,0.0554911,0.403883,0.0419386,0.0525415,-0.237494,0.494815,0.176158,0.115856,-0.719016,-0.0609104,-0.220401,-0.332087,-0.385312,0.451642,-0.240101,0.48452,0.200659,-0.0796317,-0.215193,-0.0783424,0.342716,0.934398,-0.396101,-0.195144,0.0279201,-0.374581,0.283,-0.537533,-0.274703,-0.157802,0.244685,-0.745308,0.0583389,0.0657668,0.270358,0.0691745,-0.415042,-0.0149627,-0.360668,0.602473,0.125303,-0.301704,-0.537033,0.68689,-0.00963032,-0.613749,-0.113341,0.0865685,0.269514,0.271158,0.49195,0.398952,0.143301,0.00681031,-0.0913088,-0.171979,-0.190963,-0.323823,0.0835774,-0.138844,-0.182385,0.10416,-0.805916,0.128797,-0.17126,-0.163609,0.10012,0.910387,0.251213,0.183896,-0.34783,0.0121629,0.632522,-0.197645,-0.42954,-0.172796,-0.0966588,-0.0920981,0.224277,0.179771,0.129895,-0.569255,0.0798225,-0.198846,-0.0288455,-0.6348,-0.214765,0.247867,0.0351784,-0.392682,-0.0457106,-0.3988,-0.277735,0.115102,-0.526216,0.985655,0.0407853,0.136676,-0.0527648,0.117275,-0.0623121,-0.213441,-0.249523,-0.209312,-0.61704,-0.152646,0.0028816,-0.549231,0.00781611,-0.747872,0.0351091,0.0298972,-0.445626,0.368794,0.0784124,-0.207842,0.131957,0.0840308,-0.229866,0.12731,-0.0217191,-0.0283195,-0.165814,0.433162,-0.512743,0.206967,0.675454,0.565825,-0.182622,0.655043,-0.0792605,-0.15483,0.477252,-0.38285,0.221728,-0.185337,0.132883,0.0972676,-0.247575,-0.466674,0.199459,0.00481231,-0.619943,-0.327138,-0.336312,0.0870371,0.173005,0.0100977,0.222305,0.182491,-0.0393117,0.32422,-0.166257,-0.0247527,-0.0991114,-0.219235,-0.0700778,-0.39129,-0.160366,-0.0965362,-0.366878,0.390636,-0.317875,-0.537669,-0.205682,0.182082,0.0332481,0.272717,-0.0274752,0.432731,-0.629035,-0.395793,0.346279,-0.308938,-0.164621,0.141432,0.111528,0.50652,-0.0823671,0.261476,-0.741364,0.356111,-0.0711317,-0.752401,0.159519,0.270366,-0.402098,-0.276495,0.16984,0.114311,0.229546,0.338099,0.479109,-2.30557 +3461.06,0.986357,0.0848144,4,1.65846,1.06283,-0.692595,0.149313,0.490245,-0.0383494,0.0425732,-0.359608,0.392575,0.385636,-0.256496,-0.186727,0.275055,0.0233693,-0.333309,0.833808,0.0960608,0.0583903,-0.325128,0.0231563,-0.3747,-0.918005,-0.836964,-0.123991,-0.322936,0.334964,0.172334,0.298341,0.00331407,0.500434,0.478056,-1.02019,0.324212,-0.147719,-0.1605,0.0432078,-0.375738,0.471425,0.437002,-0.233243,1.02257,0.751832,0.423188,-0.450723,-0.0798163,-0.144943,-0.310198,0.458979,0.128089,0.10996,0.311455,0.375892,0.0672322,-0.603978,0.656418,-0.350741,0.0341132,-0.220138,0.318375,-0.443849,-0.0723168,0.658264,-0.583792,-0.747727,-0.236501,0.601497,0.0943013,0.240274,0.299922,-0.209652,-0.522359,0.391049,0.436066,0.095247,0.547449,0.167439,0.160828,-0.0430481,-0.553365,0.163454,0.285568,-0.514715,0.162023,-0.47348,-0.00886781,-0.397853,-0.15693,0.293876,-0.251884,-0.558775,-0.231846,0.0938043,0.240431,-0.121544,-0.333847,0.187051,-0.148831,0.158544,-0.18334,-0.131595,0.0505991,-0.0589505,-0.545387,0.0889836,0.24902,-0.929438,-0.092821,-0.0359767,-0.140992,0.261898,-0.000497215,-0.28636,-0.153893,0.346527,-0.265568,0.302737,0.211815,0.0556542,0.256714,-0.264113,-0.653532,0.37656,-0.14537,-0.164145,0.0675448,0.369537,-0.304133,0.433498,0.248725,-0.046795,0.182254,0.0641342,0.00758222,0.292737,-0.385332,-0.340634,-0.113672,-0.433786,-0.193616,-0.113378,0.154039,-0.0890346,0.318462,-0.820511,-0.142037,-0.0455174,-0.105437,-0.0550411,-0.104238,-0.147926,-0.362809,0.45398,0.139453,-0.0857606,-0.128577,0.425511,0.105081,-0.188282,-0.104264,0.194482,0.0140443,-0.41297,0.663139,0.0743463,-0.320474,-0.141244,-0.265743,0.430829,-0.629249,0.100539,0.190278,-0.056162,-0.0380309,-0.117729,-0.302407,-0.214224,0.0972068,-0.3,0.45674,0.661309,0.505285,-0.0776408,-0.466489,0.316746,-0.0832204,-0.149115,-0.579242,0.143448,-0.101993,-0.0293035,0.134654,0.30336,0.12964,-0.656784,-0.0409363,0.642711,-0.311356,-0.439378,-0.452061,0.315684,-0.0770855,0.0638844,-0.281674,-0.222353,-0.185077,0.149214,-0.751207,0.960077,-0.0462576,0.00374045,-0.0984171,-0.0874094,-0.0142994,0.497557,-0.152662,-0.248725,-0.146519,-0.186037,0.0987181,-0.0263605,-0.20739,-0.440661,-0.346379,-0.00405969,-0.289833,0.607423,0.0271231,-0.239556,0.253527,0.0621629,0.0755919,0.0998353,-0.0750776,0.0867332,-0.501294,0.618686,-0.759587,0.474433,0.469099,0.0166741,0.228111,0.472353,-0.191896,-0.265709,0.312597,-0.0120209,0.351921,0.0575398,0.3423,0.010477,0.172397,-0.170812,0.144622,0.036811,-0.0753097,-0.057732,-0.511825,-0.202093,0.238324,-0.175244,-0.219194,0.00723466,0.0178898,0.182764,-0.545847,-0.30409,-0.283927,-0.00985906,0.185717,-0.15076,0.100323,0.061915,-0.433181,-0.425623,-0.124249,-0.0468432,-0.0216718,-0.274575,0.441077,-0.318792,0.243268,-0.025246,-0.486154,-0.264783,0.299711,0.245532,-0.359913,-0.0155535,0.271641,0.275663,-0.155141,0.236134,-0.254009,-0.0786726,-0.503135,-0.634426,0.043637,-0.377524,0.25139,-0.196148,-0.422861,0.102059,0.158585,0.319467,0.398227,-1.61618 +3459.67,0.882382,0.0848144,4,1.65532,1.05594,-0.658477,0.154735,0.493548,-0.036731,0.0567262,-0.326215,0.365142,0.310189,-0.274114,-0.158298,0.319522,0.00754081,-0.312521,0.83926,0.065966,0.0808637,-0.353648,0.0403456,-0.375262,-0.885943,-0.810034,-0.104676,-0.331707,0.361329,0.127392,0.312455,-0.0397198,0.514524,0.49786,-1.02807,0.346222,-0.144642,-0.156642,0.0413818,-0.417958,0.515062,0.41213,-0.23062,1.03729,0.743177,0.430789,-0.466274,-0.0925108,-0.172181,-0.281601,0.446018,0.12521,0.057922,0.293323,0.343445,0.0893689,-0.561513,0.596292,-0.391093,0.0259856,-0.208493,0.337545,-0.413679,-0.0717425,0.649415,-0.540464,-0.795231,-0.24905,0.604777,0.0714849,0.234921,0.302987,-0.252587,-0.530041,0.414168,0.427712,0.0839737,0.567045,0.16424,0.18419,-0.0473013,-0.570096,0.208543,0.254333,-0.496571,0.164226,-0.471248,0.0100876,-0.399198,-0.142574,0.291998,-0.23325,-0.569643,-0.23008,0.124115,0.28926,-0.113021,-0.329588,0.240356,-0.166724,0.193151,-0.212762,-0.127458,0.0464856,-0.0927737,-0.557621,0.0954274,0.299511,-0.944786,-0.112679,-0.0212704,-0.0963008,0.243991,-0.0251559,-0.291003,-0.212996,0.371375,-0.233034,0.296514,0.239796,0.0608615,0.277798,-0.261071,-0.63734,0.35577,-0.167064,-0.128834,0.036516,0.364987,-0.313535,0.415013,0.216154,-0.069309,0.19383,0.120266,0.00664089,0.318704,-0.414314,-0.304065,-0.151827,-0.404505,-0.213003,-0.0828369,0.0960167,-0.0752842,0.339044,-0.850363,-0.12786,-0.05458,-0.128973,-0.0125109,-0.132947,-0.0942723,-0.388466,0.420193,0.116064,-0.104307,-0.113844,0.425125,0.0488127,-0.194877,-0.100806,0.163549,0.0614494,-0.404557,0.685592,0.0806851,-0.319695,-0.107803,-0.276248,0.431378,-0.574641,0.0844924,0.16606,-0.042194,-0.043532,-0.131531,-0.310244,-0.23826,0.0915291,-0.338729,0.45188,0.64099,0.556264,-0.118317,-0.467831,0.275371,-0.0740924,-0.149903,-0.550626,0.161606,-0.0584591,-0.0267634,0.135098,0.337337,0.13819,-0.64818,-0.035873,0.648644,-0.344094,-0.430937,-0.445329,0.280022,-0.0659424,0.0673711,-0.301131,-0.208881,-0.178055,0.178333,-0.741258,0.919339,-0.0269465,0.000317529,-0.0899526,-0.108892,0.00179322,0.490033,-0.0925802,-0.230208,-0.0972153,-0.203677,0.0783032,-0.0367547,-0.211321,-0.453675,-0.390699,0.00196667,-0.306923,0.622305,-0.00577306,-0.259587,0.238754,0.0822335,0.0995408,0.0957459,-0.0160304,0.116822,-0.487843,0.625783,-0.723404,0.48504,0.501953,0.0292754,0.211275,0.484557,-0.217583,-0.276003,0.316633,-0.00152377,0.327955,0.0217746,0.346259,0.00653418,0.157906,-0.151714,0.122969,0.0219487,-0.086514,-0.0477494,-0.507,-0.162785,0.262661,-0.186711,-0.264659,0.0553119,0.0036253,0.145319,-0.556202,-0.313201,-0.292288,-0.0334995,0.211808,-0.15716,0.0819122,0.0713634,-0.424129,-0.442233,-0.0820921,-0.071567,0.0084405,-0.293791,0.464599,-0.369711,0.230447,-0.0194311,-0.507512,-0.246809,0.287113,0.208167,-0.361885,0.0682949,0.269224,0.228303,-0.166844,0.278447,-0.229697,-0.0576541,-0.507884,-0.610666,0.0379191,-0.407235,0.200516,-0.159731,-0.397457,0.103968,0.163509,0.32244,0.404362,-1.64159 +3437.66,0.957954,0.0848144,4,1.61867,0.922787,-0.599383,0.169119,0.379306,-0.189827,0.0104088,0.588752,0.30827,-0.286396,-0.026298,-0.433484,-0.483202,0.27003,-0.431434,0.640196,0.214203,-0.076495,-0.233331,-0.118238,-0.388668,-0.642795,-0.268873,0.286909,-0.372141,-0.241701,0.381926,0.439701,-0.459948,0.195181,0.916104,-0.111337,0.145613,0.239115,-0.279531,-0.178839,-0.417035,0.36663,-0.123651,-0.0722071,1.23873,0.647405,0.0172545,-0.159426,-0.16169,0.0601502,-0.225784,-0.196413,0.430556,-0.353352,0.155975,-0.413622,-0.141962,-0.302002,0.678648,-0.194309,-0.366602,-0.982798,0.630841,-0.201597,-0.272559,1.07538,-0.616818,-0.296838,-0.064022,0.0560402,-0.244534,0.255272,0.0170521,-0.615069,0.133584,0.393396,0.586521,0.15367,0.150588,0.222545,-0.0446662,-0.290996,-0.288886,0.251109,-0.186889,-1.01029,0.109294,-0.37562,-0.147367,-0.164948,-0.156989,0.26891,0.0163029,-0.247625,0.363967,-0.471462,0.110939,-0.239624,-0.0570472,-0.284432,-0.830054,-0.15965,0.43,-0.0265499,-0.442455,0.160772,-0.267658,-0.123816,0.192238,-0.494138,0.279041,-0.182038,0.184043,0.16437,-0.262792,0.109706,-0.0183955,0.380276,0.210664,0.0466583,-0.26884,0.153794,0.468982,0.0246113,-0.609707,-0.0972141,0.0236304,-0.167593,-0.0425665,0.269904,-0.0530659,0.297027,0.0398157,0.0524514,-0.35318,-0.176843,-0.0568785,0.734516,-0.775542,-0.0574577,0.432824,0.0256936,0.727455,-0.288593,-0.182742,-0.303033,0.206742,-0.072233,-0.283414,0.483493,-0.100453,-0.450215,-0.609855,-0.173635,-0.261218,0.0321545,0.400515,0.278654,0.39506,0.420101,-0.119393,0.416449,-0.417079,-0.503279,0.364514,-0.133852,0.368757,0.208102,-0.362543,0.191294,-0.139528,0.307702,-0.086448,-0.227937,0.405761,0.444344,0.0770661,-0.638321,0.0453305,0.344364,-0.579452,-0.364877,0.309788,0.50853,-0.19479,-0.0592386,-0.226951,-0.0927742,-0.73093,-0.411689,-0.571664,-0.337306,-0.129971,-0.53522,-0.0010951,-0.0736534,0.318631,-0.616475,-0.0980921,-0.240227,0.0572573,-0.692656,-0.349739,0.48822,-0.435035,0.354955,0.264027,0.167463,-0.338032,-0.203731,-0.443884,0.460413,-0.365755,-0.145808,0.114767,-0.420392,-0.196882,0.22064,-0.302644,0.410288,-0.204101,-0.181441,-0.17385,-0.0918511,-0.3337,-0.493248,-0.297743,0.159412,-0.0967843,0.163732,-0.433447,-0.0332175,0.421589,0.0324777,0.10016,0.026253,-0.408949,0.0484402,-0.106573,-0.0339263,0.422656,0.15461,0.519741,-0.0928036,-0.512668,0.134875,-0.15032,-0.10135,0.159425,0.355913,0.529501,0.299441,-0.148348,-0.357089,0.393256,-0.389382,0.14762,-0.0823072,0.1488,0.171617,-0.0245171,-0.306675,-0.0732846,0.192703,0.0226785,0.0169504,-0.279819,0.170594,0.279682,-0.418857,-0.0274874,0.102753,0.112567,-0.0509118,-0.216017,-0.569375,0.152179,0.495833,0.21097,-0.117468,-0.0943098,-0.00598202,0.131899,0.0737904,0.140538,-0.817425,0.0581597,-0.489227,0.201871,0.370852,-0.198976,-0.0839621,0.174035,-0.712572,0.25684,0.885211,-0.559952,0.41179,-0.365037,-0.0696653,-0.200114,0.128487,0.0983379,-0.534253,0.0623306,0.0967027,0.164807,0.310971,0.405965,-1.06999 +3442.27,0.904165,0.0848144,4,1.57794,0.951798,-0.0986431,0.0565202,0.453486,-0.141633,0.235018,-0.177975,0.318098,0.495558,0.0487486,-0.260469,0.888058,0.437018,0.108255,0.807844,0.214897,0.233486,-0.00376477,0.0674935,-0.185004,-0.855708,-0.724411,0.177447,-0.0978352,-0.299779,-0.309067,0.254948,0.312414,0.187894,0.725021,-0.505303,0.418389,0.522636,-0.19737,-0.0909553,-0.675795,-0.279316,0.674378,-0.358006,0.984004,0.0650022,0.186761,-0.963051,-0.204739,-0.686524,-0.57551,0.0287473,0.112279,0.431729,-0.00981044,0.402619,0.20656,-0.5895,1.04829,-0.100054,0.0735502,-0.526876,-0.0764215,-0.940337,0.310765,0.720228,-0.539008,-1.54661,-0.0171266,0.0112974,-0.377805,-0.168589,0.08936,-0.0180414,0.220978,-0.307564,0.381621,-0.0609352,0.751939,0.314869,0.380186,0.235402,-0.136718,0.138458,0.809399,0.32002,0.192682,0.431034,0.267184,0.303365,0.328022,-0.587971,-0.213062,-0.464051,-0.294908,0.249459,-0.230914,0.145175,0.194107,-0.0741016,0.479526,0.0819925,-0.520246,0.0776629,0.466423,-0.128975,-0.0634952,0.0334013,-0.0456529,-0.107474,-0.0681541,-0.258339,0.141032,0.757185,0.0731374,-0.273771,-0.0780359,0.224631,-0.35844,0.0579199,-0.0880283,-0.00953511,0.145978,-0.261815,-0.69804,0.251664,-0.147301,-0.151376,0.082589,-0.160679,0.0275139,0.0859346,0.267341,-0.407521,-0.133553,-5.78581e-05,-0.294282,0.48239,0.199898,-0.359485,-0.178081,-0.24628,0.124065,-0.649199,-0.495878,0.200097,-0.258482,-0.25323,0.362997,-0.294922,-0.337848,0.694035,0.119727,-0.0827053,-0.281711,-0.19861,-0.122668,-0.262302,0.270207,0.795565,0.195564,-0.412953,0.0794659,0.388906,-0.117677,0.164701,0.854767,-0.357479,0.0214106,-0.000495423,-0.0568097,-0.572983,0.0162861,-0.185255,-0.204019,-0.204807,-0.241634,0.00441763,-0.223681,-0.141271,-0.0751847,0.215631,0.105636,0.647488,0.0868698,0.252117,0.535583,-0.136586,0.566889,-0.0762114,0.11941,0.124127,0.559956,-0.491658,0.0157188,0.163235,-0.114772,-0.268572,-0.0131279,0.378417,-0.0144804,0.130585,-0.853096,-0.506841,0.280121,-0.697637,0.520007,-0.150285,-0.0332101,-0.257423,-0.41704,1.07882,0.0607068,0.145386,-0.188412,0.208766,0.371722,0.361971,-0.468702,-0.0386487,-0.491973,-0.122129,0.186794,-0.403405,0.203054,-0.212289,0.428449,0.036472,-0.542585,0.424532,-0.220963,-0.599901,0.0476979,0.344868,-0.455512,-0.00299387,-0.126092,-0.281898,-0.561198,0.830446,-0.20182,-0.16013,0.174546,-0.246581,0.379578,-0.367897,0.184358,0.173803,0.588327,0.14105,0.402306,0.0799812,-0.436892,-0.0602328,-0.215605,-0.378024,0.467879,-0.0265031,0.0844158,0.407307,-0.0362982,0.134016,0.105039,0.00706314,0.317934,0.7043,0.0880682,-0.109652,-0.275343,0.855365,0.0168211,-0.307749,-0.396313,0.1218,0.086117,0.217808,-0.493627,-0.0324233,-0.207369,-0.130968,0.125059,0.25726,0.247303,0.0313771,-0.0259428,0.565944,-0.597815,0.62291,-0.0327178,-0.0769589,0.229593,0.565464,-0.203363,0.22361,-0.0654386,-0.596749,0.406527,-0.0970352,0.0883544,-0.272032,0.358999,-0.0281473,-0.252295,0.38304,-0.169989,0.0982727,0.230307,0.313485,0.479903,-1.57664 +3421.86,0.851629,0.0848144,4,1.49926,1.02519,-0.676724,0.162472,0.516066,-0.182853,0.354721,-0.212637,0.381857,0.755274,-0.107637,-0.0791226,0.487242,0.164194,-0.0390953,0.92106,-0.0795798,-0.0957739,-0.285886,0.0575586,-0.391417,-1.11378,-0.379057,0.143036,-0.0636446,-0.446527,-0.208239,0.647339,-0.138414,0.0894115,0.75554,-0.79276,0.25794,0.515904,-0.171025,-0.124056,-0.667211,0.227034,-0.017626,-0.349725,1.00208,-0.0768538,0.284422,-0.533351,-0.215705,-0.682009,-0.56598,0.353902,0.349174,0.528352,0.339407,0.521972,0.253791,-0.637141,1.01921,-0.0306996,0.0551282,-0.687038,0.356536,-1.01961,0.187302,0.894834,-0.32806,-1.77771,0.133219,0.525597,0.274634,-0.131109,0.0841402,-0.335975,0.283255,-0.637486,0.971777,-0.209233,0.713002,0.459834,0.298111,0.0864282,-0.249865,0.261984,0.858052,0.0990855,-0.173474,0.44385,0.200224,0.473818,0.194582,-0.192163,-0.0582593,-0.388576,-0.1136,0.00810431,-0.211634,-0.106613,0.458835,-0.0668508,0.108877,0.403917,-0.266472,0.0415754,0.283477,-0.422675,0.2015,-0.0916237,-0.519224,-0.692435,0.0962745,0.159824,-0.0809733,0.426904,-0.0115886,-0.695706,0.227614,0.175925,-0.547289,-0.0663617,-0.489256,0.326909,0.604423,-0.0731002,-0.521083,0.0519369,-0.550831,-0.408345,0.0884418,-0.0208463,0.186933,-0.620486,0.382166,-0.648523,0.132538,-0.108916,-0.560025,0.964366,0.17746,-0.350551,0.0141572,-0.404304,0.161549,-0.514923,0.0812261,-0.149059,0.221964,-0.486651,0.679034,-0.16879,-0.630422,0.416485,-0.01035,-0.61811,-0.218245,-0.247421,0.147387,0.0461813,0.0321065,0.471304,0.432734,0.0264073,-0.052273,0.328907,0.00920129,-0.263793,0.819271,0.0742443,-0.0845433,-0.209215,0.233924,-0.273414,-0.406485,0.198312,0.0162767,-0.0401442,-0.397566,-0.411842,-0.0694907,-0.202389,0.264486,-0.268498,0.191931,0.897051,0.196912,-0.194942,0.254643,-0.210006,0.320287,0.210206,-0.269114,0.0457576,0.682348,-0.262319,-0.127394,0.241218,0.317761,-0.0477483,0.0512563,0.256303,0.154132,-0.0457757,-0.737186,-0.683109,0.0673793,0.197007,0.90003,0.412569,-0.0622545,-0.446297,-0.111645,0.841163,0.0634274,-0.11902,-0.352573,-0.32059,-0.127373,0.403911,-0.313525,0.20907,-0.370236,0.248195,0.24648,0.0549844,0.598458,0.115061,0.488105,0.594756,-0.292648,0.765646,-0.414132,-0.511402,-0.255981,0.462009,-0.547144,-0.223172,-0.115633,-0.39218,-0.0166724,0.883216,0.0266639,-0.129773,0.37809,-0.376894,0.46193,-0.288212,0.0731062,0.344074,0.726763,0.288961,0.178111,0.0830515,-0.152321,0.123941,-0.311141,-0.0720229,0.514078,-0.186565,-0.18016,0.198399,-0.2001,-0.0778907,0.189961,-0.0965372,0.251447,0.471846,0.044312,-0.0136533,-0.115582,0.498425,0.0676818,0.297771,-0.198581,-0.00827629,0.0670083,0.129235,-0.850278,0.101055,-0.330119,0.217663,0.173977,-0.131471,0.570051,0.489722,0.128672,0.175853,-0.755932,0.243534,-0.0621195,-0.10774,0.236525,0.320298,-0.184284,-0.434249,-0.247128,-0.4643,0.116161,0.170204,0.0484456,-0.219191,0.211675,0.12226,0.253846,0.240769,0.0292051,0.144822,0.24649,0.380554,0.496477,-1.77925 +3411.45,0.732015,0.0848144,4,1.55909,0.945248,-0.614735,0.0945166,0.749835,-0.212959,-0.101175,-0.702441,0.411286,0.528341,-0.107874,-0.26472,0.375545,0.0094946,-0.0617363,0.639909,-0.187809,0.112804,-0.062321,-0.00954241,-0.26217,-0.829156,-0.634009,0.253239,-0.350828,-0.472497,-0.0898228,0.639439,0.0202942,-0.192005,0.825568,-0.480117,0.466361,0.568733,-0.235534,-0.476963,-0.292418,0.1813,-0.350964,0.0357953,0.94384,0.00473929,0.584864,-0.620319,-0.345048,0.0198246,-0.849461,0.255807,0.179696,0.321591,0.492543,0.539729,0.232012,-0.341979,1.26829,-0.213533,0.34482,-0.741527,0.251474,-0.360786,0.250528,0.773979,-0.755313,-1.40585,0.198997,0.147282,0.246836,-0.309398,-0.280156,-0.689329,0.448169,-0.0761258,0.598097,-0.352862,0.453484,0.523416,-0.00538022,0.485452,-0.604625,0.474649,0.241193,-0.327046,-0.138348,0.283146,0.0937257,0.814748,0.222202,-0.180646,-0.109068,-0.210993,-0.0691218,0.122226,-0.608504,0.0178355,0.444173,0.03079,-0.414378,0.339725,0.301078,0.0365153,0.7248,-0.444932,-0.0670115,0.00591833,-0.452172,-0.368074,0.138611,0.132388,0.0245595,0.344706,0.447987,-0.236192,-0.117844,0.143992,-0.594076,0.332154,-0.702914,0.483601,0.471081,-0.487494,-0.235646,0.00982763,0.0772178,-0.374281,0.0758783,0.0665609,0.209885,-0.550445,0.51225,-0.506302,-0.266261,-0.299734,-0.652811,0.926611,0.099259,-0.235477,0.0888277,-0.667442,0.201315,-0.321557,0.121892,-0.128417,0.01227,-0.457336,0.778896,-0.160893,-0.234504,0.506963,-0.311449,-0.493438,-0.435585,-0.10278,0.377144,0.249919,0.473121,0.279174,0.439332,-0.05026,0.197058,0.349372,-0.0688995,-0.225254,0.928665,-0.296113,0.071584,-0.285978,0.242907,-0.228612,-0.645273,0.269547,0.299149,0.257337,-0.157193,-0.112593,0.131958,0.0505933,-0.0829521,-0.354226,0.0939313,0.748449,-0.242139,-0.491669,0.187581,-0.105971,0.551993,0.00386632,-0.0886557,0.115137,0.194015,-0.358617,0.166516,-0.044418,-0.0660474,-0.0145963,0.117369,0.0619367,0.138382,-0.292494,-0.766961,-0.431991,0.0103802,0.0900598,0.534586,-0.0177984,-0.313706,-0.246536,-0.153177,0.737566,-0.08511,-0.332775,0.0121342,-0.189038,-0.234924,0.11619,-0.298323,0.397472,-0.184351,0.448543,0.58626,-0.432214,0.126474,-0.383272,0.78626,0.365303,-0.717166,0.513592,-0.821247,-0.460665,-0.273236,0.231856,-0.331362,-0.102334,0.0978322,-0.889501,0.37634,0.972269,0.282278,0.0538744,0.447208,-0.0210596,0.318961,-0.511087,0.465846,0.598299,0.604609,0.531936,0.476197,0.198092,-0.453579,-0.132351,-0.0256308,-0.910437,0.360284,-0.573301,-0.325334,0.161312,-0.393868,0.468465,0.486351,0.109986,0.207309,0.199403,0.240581,0.168485,0.212088,0.306855,0.0722422,0.163073,-0.451725,-0.215964,-0.00179439,0.321095,-0.942156,0.0419399,-0.077315,0.162304,0.62814,0.0365145,0.65015,0.373834,0.334534,0.161897,-0.700258,0.246598,0.332537,0.152122,-0.0186528,0.0623771,0.0812433,0.0647486,-0.178206,-0.0524097,-0.245761,0.0782215,-0.142855,0.0459255,0.183365,-0.28836,0.0119529,0.38499,-0.609415,0.123197,0.285786,0.350994,0.53459,-2.31476 +3381.23,0.919996,0.0848144,4,1.40306,0.961639,-0.941825,0.413483,1.0453,0.0223519,0.339641,0.30831,0.0228793,0.0329958,0.112846,0.19681,-0.169705,0.235401,0.237613,0.604273,0.150669,0.295762,0.408118,0.0798477,-0.293932,-0.756219,-0.733312,0.554539,-0.139626,0.720596,-0.24052,0.38995,-0.452964,0.252207,1.08263,-0.301581,0.322169,0.259604,-0.565068,-0.277372,0.0268848,0.936301,0.86522,-0.198451,1.06515,0.782584,0.294076,-0.261434,-0.146143,-0.319547,-0.450729,0.149022,0.492241,0.05369,0.301659,0.439238,0.139263,-0.0295833,0.707982,-0.0823329,-0.113076,-0.525782,0.504933,-0.355136,0.249484,0.899082,-0.562183,-0.85806,0.715986,0.246372,0.0310795,0.708087,0.645488,0.0534065,-0.598033,0.404751,0.46045,-0.0175319,0.95967,0.514274,0.687629,-0.510748,-0.20372,-0.544893,0.731258,-0.359358,0.248766,-0.409027,-0.141733,-0.0264813,0.317066,-0.6444,0.650149,-0.779183,0.293816,-0.489744,0.433311,0.491999,0.193367,-0.85371,0.650788,-0.245328,-0.358696,0.553788,-0.235702,0.0108766,-0.190595,0.171972,0.495405,-0.733292,0.275898,-0.344851,0.500562,0.307011,-0.335183,0.0411224,0.0787684,0.407022,0.0553324,-0.00474311,-0.126001,0.18756,-0.637972,-0.0985799,-0.630335,0.396952,0.890406,-1.18495,-0.346826,0.643739,0.239271,0.575592,-0.068648,-0.536112,0.241429,0.204819,0.245467,0.580987,0.0807026,-0.199876,0.0825054,-0.0174293,0.575851,-0.831374,-0.185227,-0.331683,0.376938,-0.548387,-0.0914267,0.337827,0.107102,-0.0833202,-0.284469,0.112958,0.38335,0.213938,0.0904897,0.224131,-0.146537,0.43428,0.306613,0.0730051,0.16216,-1.02749,-0.187768,-0.461214,1.06274,0.617782,-0.266363,-0.0473285,0.0975796,-0.00792971,-0.292536,-0.611314,0.0217404,-0.0519968,-0.272301,-0.228893,-0.463373,-0.555473,0.147788,-0.355622,0.254541,0.830809,0.809634,0.669286,-0.791591,0.193698,-0.375559,-0.0635924,-0.883113,-0.442422,-0.0676359,-0.0441994,-0.133058,-0.252247,0.214731,-0.520563,-0.0553411,-0.536012,0.0995351,0.240788,-0.32246,0.43472,-0.457256,-0.0314157,-0.531663,-0.286349,-0.184751,0.607923,-0.0362407,0.782775,0.184579,0.251537,0.0151644,0.489869,0.943322,0.0019087,-0.597807,0.938227,-0.564814,-0.417131,0.354507,-0.238152,0.0804142,-0.693684,-1.06877,0.114482,-0.202049,0.465795,-0.108085,-0.312388,0.336791,-0.149341,-0.491076,-0.0981535,0.138264,-0.108397,-0.628948,0.500408,0.277455,-0.337749,0.879213,-0.463479,-0.0225559,0.264446,-0.477334,0.502556,0.885243,-0.295112,0.651053,0.169137,-0.385314,-0.656767,-0.608471,-0.308838,0.540577,-0.538902,-0.0148135,0.33112,-0.303322,0.0434662,0.17391,-0.229859,-0.0612038,0.288873,-0.161824,-0.313662,0.0308353,0.281569,-0.403425,0.0547849,0.181413,0.34635,-0.139182,-0.0963289,0.520291,0.040113,0.239889,-0.0608558,-0.518222,0.153967,0.083696,-0.245,-0.106132,-0.244212,-0.0674612,-0.137923,0.125413,0.238692,-0.402245,0.168703,0.179436,-0.59554,-0.0964956,0.309241,-0.498317,0.435535,0.165767,-0.600018,-0.0455622,0.103822,-0.256825,-0.773301,0.131159,0.180215,0.188269,0.424517,0.4339,-3.67012 +3385.53,0.97189,0.0848144,4,1.3826,1.00539,-1.11096,0.27186,0.666067,-0.157243,0.13184,-0.184992,0.553003,0.280968,0.209337,0.210304,0.491812,0.411996,-0.062071,0.633156,-0.133446,-0.0444544,0.0421149,-0.27411,-0.345934,-0.593045,-0.706964,0.240463,-0.189455,-0.0552559,0.419166,0.366964,-0.0474907,-0.39826,0.679209,-0.420451,-0.246118,0.315174,-0.421247,-0.297641,-0.442606,0.126812,-0.277433,0.209774,1.38859,0.966076,0.244216,-0.108497,0.634039,0.263511,0.0222406,0.60882,0.310753,0.263446,-0.0598979,0.10375,-0.0427127,0.0805317,0.713802,-0.292288,0.48553,-0.131673,0.908222,0.0704041,0.470523,1.12701,-0.507637,-0.891546,0.308247,-0.236779,0.10372,-0.47611,-0.097004,-0.582783,-0.568461,-0.278078,0.314688,-0.307722,0.748997,0.529807,0.0862854,0.0573219,-0.0359287,0.381036,0.482869,-0.580606,-0.162675,-0.319295,-0.605993,0.202668,-0.132491,-0.272325,-0.122324,-0.0679362,-0.0385974,0.235892,0.147496,-0.00722998,0.0544546,-0.446194,-0.0433942,0.860039,0.0735251,-0.136709,0.409327,0.78048,-0.576723,-0.704885,0.783449,-0.157157,0.397916,0.112825,0.160328,1.12148,0.341619,-0.0750793,0.310858,0.39083,0.489379,-0.041137,-1.04913,-0.230192,0.320414,0.137118,-0.24926,0.3522,-0.702118,-0.698934,0.339339,0.319878,0.0717744,-0.355976,0.332174,-0.373635,-0.424695,-0.398995,-0.279653,0.670778,-0.226708,0.171896,-0.229361,-0.565651,0.247168,-0.795776,0.18375,-0.0717001,-0.0784988,-0.790487,-0.251966,0.648366,0.104678,1.17729,-0.0413315,-0.769199,0.299311,0.0764023,0.72749,0.478972,1.01862,0.469623,0.626103,0.36666,-0.324593,0.0541566,0.30339,-0.346516,0.188506,0.427608,0.115402,0.212803,0.213474,-0.108481,-0.0861745,0.591098,1.11422,0.0276841,0.160022,0.103247,-0.267843,0.00523862,-0.216784,0.0177868,0.384707,0.738363,0.129389,0.305311,0.181101,-0.0796897,0.164845,-0.118689,-0.0202806,-0.504365,0.0724825,-0.650796,0.0224499,-0.108501,-0.415639,-0.172122,-0.164475,0.603044,-0.0678593,-0.5713,-1.33948,0.0812464,-0.142796,0.0237678,-0.132017,0.623144,0.338736,-0.436159,-0.0922261,0.895317,-0.070518,0.368814,0.278783,0.107259,0.325743,0.971665,0.279239,0.35037,-0.272829,0.373318,-0.815675,0.412542,-0.787973,-0.67821,0.324016,0.119113,-1.07267,0.87153,-0.460617,-0.250824,0.586298,0.477051,-0.0442244,0.178354,-0.51274,-0.154329,-0.24567,0.461927,0.0250048,0.134952,0.526802,0.214415,-0.42479,0.234309,0.427449,-0.218903,0.539866,1.09554,0.312037,-0.56007,-0.433872,-0.325123,-0.187111,-0.985043,0.315582,-0.134787,-0.763078,0.60712,-0.131012,-0.0509044,0.543413,0.109028,0.211821,-0.0362309,0.336561,0.147777,0.549234,0.298707,-0.0181026,0.26338,0.571571,-0.0898748,0.10144,0.0174736,-0.217257,0.702919,0.0786207,0.0899922,0.169637,-0.51898,0.945085,-0.0518574,-0.445652,-0.398637,-0.0284996,-0.357988,0.0642801,0.465702,0.167516,1.11359,0.125917,-0.335298,0.0893128,0.589371,0.165381,-0.19024,-0.100307,-0.355501,-0.0150469,-0.0564172,-0.0112595,-0.336688,-0.892486,0.186571,0.245375,0.431939,0.495354,-2.24087 +3385.87,0.930573,0.0848144,4,1.33964,0.955627,-1.25971,0.279575,0.685729,-0.239153,0.116873,-0.141452,0.637025,0.199616,0.105606,0.19049,0.57477,0.331866,-0.173613,0.618846,0.0677854,-0.155779,0.00424118,-0.331833,-0.204908,-0.67738,-0.696096,0.156351,-0.216285,-0.00977099,0.367178,0.298239,-0.0528765,-0.338219,0.721084,-0.460568,-0.0282446,0.291165,-0.0743109,-0.119397,-0.321141,0.0732918,0.0199306,-0.205056,1.40695,0.923188,0.0954879,0.00308915,0.524163,-0.00478005,0.00659771,0.78172,0.493429,0.297443,0.186448,0.333514,-0.054759,0.108335,1.07226,0.0181929,0.558923,-0.261449,0.8685,0.0523291,0.367425,1.08031,-0.467439,-0.94093,0.407527,0.0515056,0.172678,-0.720115,-0.329361,-0.723401,-0.718616,-0.183436,0.137014,-0.281459,0.588883,0.613974,0.273353,0.0997144,-0.141021,0.239289,0.36333,-0.339827,-0.0464902,-0.398094,-0.341974,0.198073,0.035014,-0.382066,0.0309363,-0.436057,0.17901,-0.0715751,-0.00152659,0.0401823,0.167555,-0.726557,-0.191394,0.858617,-0.14168,-0.015893,0.36106,0.721706,-0.65534,-0.765381,0.503183,-0.412051,0.343554,0.242552,0.170476,1.17665,0.0863373,-0.0500312,0.361645,0.353586,0.393908,-0.11734,-1.29746,-0.185131,0.291962,0.139983,-0.228547,0.170642,-0.527164,-0.807368,0.295162,-0.0949328,0.196165,-0.10603,0.0387163,-0.389767,-0.695883,-0.285621,-0.350717,0.7224,-0.132307,0.118373,-0.499301,-0.476372,0.219391,-0.806157,0.0502979,-0.170158,-0.0170655,-0.801468,-0.40735,0.363999,0.194387,1.07286,-0.0755678,-0.711543,0.435681,0.131535,0.707408,0.428053,0.518818,0.474026,0.595356,0.152841,-0.357253,0.0291197,0.497812,-0.212542,0.310223,0.433723,0.0544348,0.205187,0.498636,0.292332,-0.218515,0.440689,1.15286,-0.1725,-0.119169,-0.0715177,0.00210595,0.184196,-0.344595,0.0164643,0.354786,0.623945,0.0179344,0.209536,0.253692,-0.159574,0.0952497,-0.246654,-0.600822,-0.600947,0.0958319,-0.456298,-0.102906,-0.517667,-0.697323,-0.104151,-0.128153,0.359286,-0.112757,-0.343841,-1.29405,0.27374,-0.13163,0.0791404,0.335552,0.285396,0.429076,-0.42104,-0.239084,0.674822,0.346078,0.319888,-0.0970718,0.0187247,0.286899,0.932261,0.49545,0.437163,-0.640275,0.362691,-0.38898,0.276292,-0.717162,-0.728691,0.0018307,0.246947,-1.1188,0.82381,-0.18133,-0.320584,0.406808,0.598355,0.0711645,0.15766,-0.323545,-0.085762,-0.451764,0.551828,0.11805,-0.224145,0.624537,-0.0553476,0.0187026,0.0992483,0.496741,-0.267618,0.517014,1.31387,0.509158,-0.77361,-0.262582,-0.564066,-0.208545,-0.643483,0.219034,-0.0616741,-0.830845,0.583737,-0.279329,0.112981,0.299261,0.0622281,-0.146836,0.156831,0.483655,0.109729,0.293801,0.399212,-0.144723,0.161272,0.694482,-0.108975,-0.0106374,0.129676,-0.260378,0.80375,0.191509,0.330399,0.326451,-0.398901,0.829495,0.294998,-0.583695,-0.26248,-0.377174,-0.396783,-0.0508734,0.448207,0.460068,0.948908,0.481054,-0.242841,0.240837,0.566881,-0.0509826,-0.255288,-0.118892,-0.517959,-0.0810277,0.0705367,-0.100513,0.0645292,-0.732358,0.167739,0.246,0.40956,0.495984,-2.16981 +3403.55,0.520819,0.0848144,5,1.65325,0.742271,-1.13716,0.633443,0.0602354,-0.288022,0.181734,0.397148,0.0132856,0.327804,0.292829,-0.345052,-0.61358,0.911392,-0.382388,0.461889,0.184229,-0.670783,0.231347,0.0568793,0.0940371,-0.346627,-0.543247,0.359586,0.243356,-0.0655289,0.25233,0.593127,-0.215282,0.138155,0.87523,-0.0958976,0.0284614,0.595515,-0.602651,-0.322676,-0.322318,0.566175,0.320934,-0.662104,0.486067,0.204706,0.138787,-1.04811,-0.878311,-0.13869,-0.734472,0.139687,0.371942,-0.00574012,0.278202,-0.290539,0.245977,-0.919364,0.0203952,-0.0181954,-0.561001,-0.601228,-0.0879738,-0.294598,-0.138236,0.507942,-0.492308,-0.899636,-0.336889,0.563078,0.120633,0.40356,0.838399,-0.43852,0.311089,0.796179,0.342822,0.0732325,0.510582,0.592403,0.427891,-0.165664,-0.444853,-0.324593,0.35536,-0.310738,0.353907,-0.0841149,-0.0245375,-0.397719,-0.047674,-0.236493,0.272246,-0.341552,-0.554892,0.180363,-0.170706,-0.0877733,0.170523,-0.0655046,0.553067,-1.42603,0.321253,0.319803,-0.178408,-0.506171,-0.425667,0.0900514,0.242524,-3.42162e-06,0.0230693,-0.629388,0.364365,0.119711,-0.102379,-0.304818,0.149399,0.447172,-0.303819,0.344636,0.0859454,0.215665,0.0991357,-0.196966,-1.18503,-0.57973,0.512706,0.277241,-0.0104941,0.240388,-0.0782136,0.77972,0.28883,-0.584639,0.814077,-0.37218,0.287029,0.341812,-0.335222,0.0891058,0.270686,0.1026,0.388158,-0.625843,-0.668178,0.101776,-0.000305353,-0.258608,0.381965,-0.307889,-0.558368,-0.0792125,0.0588149,0.47692,-0.673943,-0.256381,-0.394747,-0.268472,0.0380213,0.671826,-0.29637,-0.136704,0.363477,-0.0218964,0.422446,-0.130101,0.800107,-0.591908,-0.227574,-0.232619,-0.548028,-0.505825,-0.0981588,0.00921329,-0.755114,0.292303,-0.0269024,-0.190467,-0.147126,-0.680741,-0.165309,-0.205611,0.115922,0.892078,0.270235,0.0103694,-0.00890652,0.346112,0.0996447,-0.474734,0.0743193,-0.443362,-0.090565,-0.378686,-0.540286,0.408021,0.606626,-0.944879,0.740235,-0.0642823,0.0767415,-0.379353,-0.217466,-0.205267,-0.113288,-0.871806,0.121639,-0.415601,-0.670276,-0.0626215,-0.514799,0.995937,-0.0509576,0.22932,-0.364521,-0.302971,0.242281,-0.666077,-0.351762,-0.28611,0.101264,-0.0506254,0.94587,-0.455898,0.268815,-0.352446,0.399549,0.117048,0.0908009,0.104422,-0.411106,-0.162232,0.212147,-0.592082,-0.4123,0.219679,-0.0980769,-0.235029,-0.51432,0.529761,-0.0626486,0.324121,0.715094,-0.424994,-0.0554561,-0.0862422,-0.268284,0.258421,0.167813,-0.191997,0.130902,1.00183,0.140897,-0.338563,0.245204,-0.456553,0.654354,0.178733,0.355813,0.0235069,-0.121169,-0.119292,0.084199,0.061036,0.353405,0.718658,-0.394302,0.340272,0.0413797,0.258644,0.241644,-0.0582514,-0.573302,0.112084,-0.0771893,-0.239257,-0.142953,-0.0160927,-0.0859808,-0.0617153,0.121514,0.693059,0.204574,-0.368718,0.377185,0.0539153,-0.0872502,0.462913,0.393233,0.0564732,-0.537623,0.0660835,-0.0558244,-0.0849007,0.24647,-0.438123,0.405563,0.33464,0.127471,-0.268786,0.182168,0.0702759,0.0848038,-0.271789,0.520898,0.166852,0.179976,0.408475,0.424236,0.209728 +3390.46,0.814381,0.0848144,4,1.62909,0.833319,-0.904085,0.309007,0.128828,-0.17905,0.119831,0.107016,0.203175,-0.430152,0.0755154,-0.166907,0.110754,0.583128,-0.219489,1.19179,0.156258,0.0477278,-0.467109,0.384446,-0.262383,-0.71311,-0.483898,0.266596,-0.976315,-0.191063,-0.20157,0.144662,-0.202385,0.369102,1.03292,-0.730468,0.0254047,-0.00742492,-0.331291,-0.144126,-0.619508,0.00767592,0.598599,-0.884742,0.594715,-0.00624723,0.433523,-0.41438,-0.545103,-0.257527,-0.614763,-0.0839036,0.272548,0.1,0.167199,0.617949,0.0520347,-0.104932,0.600949,-0.207793,-0.201332,-0.759392,-0.165231,-0.385398,0.256662,0.833164,-0.730484,-0.662476,0.70236,-0.0984839,-0.707049,-0.617004,-0.225303,-0.381375,-0.000307619,0.211715,0.279791,0.145527,0.423641,0.655974,0.434753,0.222167,-0.78672,0.0229237,0.118928,-0.354799,0.0429909,0.396623,-0.273801,0.107582,-0.282561,-0.150481,-0.196668,-0.354062,-0.351123,0.0594599,0.153065,-0.10489,-0.423674,-0.557529,-0.222002,0.0954839,0.41766,0.4009,0.541885,-0.336462,-0.988444,-0.663658,-0.41879,-0.0688094,0.309647,0.114822,-0.329229,0.389127,-0.192392,-0.3684,0.109455,0.397574,0.173183,-0.31308,-1.06611,0.388716,0.33184,0.155529,-0.0733644,-0.190172,-0.189198,-0.657667,-0.105135,0.00695471,0.658834,-0.156574,0.0258886,-0.0119795,-0.0267095,-0.110071,0.342468,0.462693,0.146343,0.158394,-0.373476,-0.213115,0.289571,-1.09703,0.0338684,-0.00159311,0.633493,-0.916825,-0.453052,0.0180211,0.131386,0.237345,-0.71803,-0.144315,-0.167065,0.488082,0.146837,0.253257,0.239633,0.288282,0.0059053,-0.307342,0.414445,-0.148547,0.0306238,-0.0757415,1.39179,-0.00605995,-0.18321,0.335796,0.103308,-0.556149,-0.38548,-0.137338,0.321921,-0.0355097,0.0406406,0.292007,-0.442865,0.4165,-0.29164,0.0264304,0.347505,0.678568,-0.228826,-0.521278,-0.281443,-0.492083,-0.472177,-0.29197,-0.836757,-0.715849,0.519298,-1.12696,0.132125,0.025309,-0.646232,-0.299065,-0.173141,0.132637,0.0292195,0.0339017,-0.955323,0.0888483,0.0820568,0.474372,0.0328408,-0.0787117,0.322075,-0.140272,-1.33902,0.883644,-0.0890193,-0.049191,0.566729,-0.310094,0.149374,0.463642,0.192576,-0.0710638,-0.0360496,0.781703,0.722537,-0.22136,-0.979136,-0.183302,0.0698166,0.711245,-0.230462,0.566732,-0.620951,-1.12114,0.46677,0.157981,0.52614,-0.0380093,-0.728291,-0.726399,-0.468028,0.843627,-0.555943,-0.168096,0.417791,-0.466927,-0.175367,0.258133,-0.0285397,-0.488998,1.01515,0.0874206,0.562838,-0.591126,-0.248563,-0.375761,0.0600249,-0.550779,0.704117,0.412843,-0.328582,0.0503695,-0.0911404,0.266962,0.00442817,0.240931,-0.0196492,-0.0202129,0.744746,-0.218778,0.385725,-0.46171,0.0103071,0.636314,0.467396,0.0200875,-0.225393,-0.0778374,-0.678808,0.251716,-0.277003,0.40829,0.57372,0.00389817,0.0510545,0.0523334,0.180485,-0.374925,-0.606845,0.310081,0.13045,-0.314569,-0.0393185,-0.311276,0.161629,0.272159,0.0763411,0.424181,0.110939,0.282122,0.315327,0.0258217,-0.412608,0.418783,-0.283289,-0.924779,-0.484199,0.218814,0.216912,0.467776,0.465738,-0.0451226 +3380.65,0.93864,0.0848144,4,1.5935,0.811746,-1.5348,0.688685,0.0505759,-0.114074,0.0898442,0.357131,-0.284726,0.948426,0.017877,-0.352447,-0.0577609,0.544513,-0.335205,0.739277,-0.0883343,0.00287066,-0.239781,0.297166,-0.0616831,-0.443298,-0.769548,0.153941,-0.288448,-0.0971614,-0.0698427,0.12787,-0.0751145,0.443819,1.14699,-0.228434,0.152205,0.135255,-0.524757,-0.344316,0.00221883,0.959331,0.393916,-0.199417,0.134472,0.716145,0.267728,-0.477486,-0.750556,-0.308257,-0.747236,0.216808,0.282292,0.0776652,0.604067,0.326165,-0.0379965,-0.298874,0.129345,-0.107516,-0.116723,-0.497696,0.19419,0.377013,0.0229852,0.540869,-0.683092,-0.826603,0.590472,-0.396532,-0.555666,0.271606,-0.150538,-0.468551,-0.0399205,0.0109663,0.544292,0.0535113,-0.212608,0.53773,0.252406,0.106499,-0.813867,0.0586077,0.190799,-0.0825388,0.255732,0.19533,-0.213371,0.285749,0.260967,-0.380329,-0.397012,-0.487551,-0.407108,0.0153873,-0.117564,-0.472961,-0.337864,-1.03933,0.202939,-0.339314,-0.0135586,0.832235,0.189883,0.017499,-1.31198,-0.70186,-0.562821,-0.715943,-0.103455,-0.536856,0.142705,0.236607,-0.316055,-0.358199,-0.507642,0.260167,-0.151382,-0.697257,-0.859275,0.17909,0.0562285,-0.750726,-0.414915,0.227929,-0.455653,-0.443604,0.723324,0.340194,0.407473,0.040801,0.116328,-0.220581,-0.202341,0.171632,0.673927,0.179481,-0.427339,0.141409,0.584235,-0.423854,0.221171,-1.36783,-0.573384,0.0771097,-0.302248,-0.53569,-0.35782,0.219185,-0.548428,0.115886,-0.313843,-0.838598,-0.275532,-0.108788,-0.293971,0.506891,0.536758,0.0275476,0.0879175,-0.216534,0.650852,-0.331829,0.329038,-0.152888,1.12955,-0.168311,-0.383614,-0.0524668,-0.103243,-0.430585,-0.649752,-0.108655,0.408414,0.706908,-0.156862,0.451426,0.111115,-0.475701,-0.424237,-0.145475,0.47024,0.941236,-0.149925,-0.0605212,-0.089301,0.128403,0.0970719,-0.203144,-0.343088,-0.805036,0.0366722,-0.999997,-0.30225,-0.323707,-0.514392,-0.0115963,0.0769801,-0.194897,-0.179746,-0.199675,-1.03036,0.127706,0.227071,0.493032,0.406788,-0.0302151,-0.304232,0.382182,-0.646856,0.468882,0.155995,0.582739,-0.0756369,-0.364228,-0.121528,0.3759,0.297075,-0.219108,-0.0566602,1.05112,0.622803,-0.00494288,-0.643501,-0.10118,-0.309803,0.5007,-0.239535,0.29402,-0.911608,-0.873104,0.306438,0.175796,0.608586,-0.131502,-0.109109,-0.259329,0.0921566,0.391788,-0.114003,0.093977,0.555416,-0.70388,0.15528,0.0849783,-0.11317,-0.622885,0.558006,0.286128,0.480463,-0.459759,-0.501958,-0.244486,0.130285,-0.64036,0.514098,-0.290466,-0.184806,-0.267537,-0.398428,0.0832716,0.156356,0.254157,0.215683,0.0177711,0.483506,0.051533,-0.103818,-0.274226,-0.501084,0.30044,-0.581426,-0.028888,0.229462,-0.439138,-1.1851,0.244772,-0.717281,0.541307,0.337098,0.659162,0.528743,0.0913319,-0.320568,-0.33871,-0.813394,0.250586,0.218442,0.0295231,-0.462653,-0.00408766,-0.322969,-0.376928,-0.05334,0.173307,-0.456345,0.604781,0.0204062,-0.481904,0.41697,0.0169547,-0.252657,-0.509771,-0.380997,0.168361,0.204872,0.410318,0.452628,0.172269 +3382.84,0.998831,0.0848144,4,1.62735,0.838006,-1.63566,0.70563,0.116328,-0.117022,0.276901,0.249789,-0.355957,0.899996,-0.0355117,-0.503435,0.14258,0.26198,-0.15827,0.873168,0.113782,-0.0880101,-0.27141,0.286713,-0.0206134,-0.542381,-0.796552,0.0311577,-0.311169,-0.419588,0.0378575,0.216092,-0.142233,0.271843,1.14093,0.0272716,0.220634,0.243596,-0.602911,-0.22848,0.102565,0.988793,0.0823168,-0.128667,0.135652,0.533349,0.214458,-0.403922,-0.774058,-0.188241,-0.756471,0.189709,0.360064,-0.0242372,0.538328,0.391426,-0.0392613,-0.0832544,0.0121711,-0.267788,-0.412941,-0.588009,-0.0921918,0.32094,0.047835,0.623879,-0.788201,-0.891066,0.453255,-0.0402818,-0.464088,0.395171,-0.0910028,-0.537918,-0.0369225,-0.160019,0.584491,-0.012803,0.0809825,0.515923,0.20619,-0.126986,-0.499308,0.109333,0.321744,-0.008298,0.352051,0.381515,0.114705,0.0961986,0.461656,-0.195664,-0.386396,-0.658185,-0.340704,-0.142284,-0.385416,-0.523012,-0.0354679,-1.10206,0.107211,-0.406224,0.164664,0.730163,0.193083,-0.0817265,-1.45512,-0.635978,-0.438377,-0.412022,-0.162063,-0.654109,0.294831,0.232108,-0.0613192,-0.199933,-0.508821,0.178103,-0.0770878,-0.392394,-0.952575,0.169353,0.0989237,-0.598918,-0.244173,0.109951,-0.648598,-0.22251,0.4912,0.354412,0.564884,-0.217349,0.0878979,0.077225,-0.395597,0.204122,0.502503,0.0873142,-0.312688,0.157312,0.538292,-0.260395,0.110695,-1.4212,-0.954803,0.067661,-0.290819,0.00209212,-0.321434,0.210792,-0.718548,0.0494638,-0.342274,-0.73949,-0.19359,0.035114,-0.497351,0.735356,0.855104,0.258202,0.127532,-0.153589,0.762343,-0.692489,0.334175,-0.496433,0.784968,-0.169426,-0.463022,-0.185149,0.163232,-0.488912,-0.501136,-0.0284875,0.385688,0.49946,-0.156815,0.306915,-0.102212,-0.535006,-0.466684,0.00193131,0.479279,1.00401,0.175825,0.00973384,0.0247346,-0.0514239,0.311588,-0.20565,-0.315736,-0.861382,0.610916,-0.824685,-0.437906,-0.161735,-0.543514,-0.102486,0.411965,0.120944,-0.476671,-0.121599,-1.04184,0.250065,0.253307,0.462497,0.224828,0.0882766,-0.0701848,0.0855583,-0.531844,0.589001,0.301264,0.543861,0.0299071,-0.159698,-0.260191,0.294785,-0.248139,-0.148287,-0.30259,0.963566,0.761858,0.0509739,-0.654457,-0.174982,-0.262614,0.384835,-0.494684,0.195414,-0.529085,-0.949859,0.115834,0.265135,0.814679,-0.105195,-0.0195392,-0.149262,0.0689686,0.398546,0.04243,0.118216,0.698613,-0.610455,0.387462,-0.158111,-0.227996,-0.279789,0.629473,0.119818,0.321737,-0.221475,-0.360522,-0.155182,0.0971511,-0.598687,0.253011,-0.21843,-0.0452386,-0.252175,-0.0111648,-0.0129736,0.313072,0.34671,0.311388,-0.129244,0.192491,0.210048,-0.357468,-0.0792749,-0.457342,0.303736,-0.746973,-0.0458893,-0.00216614,-0.319761,-1.22838,-0.149751,-0.543205,0.0865302,0.406258,0.536147,0.318078,-0.265707,-0.171218,-0.320702,-0.781039,-0.0661287,0.19094,0.275334,-0.661643,-0.0948091,-0.452891,-0.191711,-0.0771748,0.00111955,-0.439298,0.297907,-0.0653498,-0.57929,0.558605,0.00918096,-0.440236,-0.269668,-0.211772,0.178145,0.199281,0.422072,0.446409,-0.0209298 +3390.19,0.976896,0.0848144,4,1.53142,0.888983,-1.56036,0.710135,-0.18971,-0.153098,0.310923,0.174002,0.00745539,0.699683,-0.092247,-0.333751,0.851039,0.527732,0.00268437,1.22249,0.26207,-0.323885,-0.433152,0.377462,-0.258374,-0.411975,-0.776246,0.210651,-0.494413,-0.437691,-0.0573664,0.446144,0.240015,0.436585,1.07729,-0.0440932,0.310969,0.346777,-0.601842,-0.071717,-0.0186536,0.606046,0.209381,-0.443241,0.4638,0.925052,0.276981,-0.625984,-0.341247,0.249847,-0.740086,0.293141,0.287098,-0.204411,0.68016,0.801316,-0.0225242,-0.15825,0.0289637,-0.072423,-0.279344,-0.537141,0.0367714,-0.40946,0.380375,0.73493,-0.509601,-1.36872,0.209523,-0.181093,-0.480622,0.0521595,0.00670992,-0.556614,0.425808,-0.596391,0.756573,-0.138704,-0.0681316,0.473659,0.383684,0.0743548,-0.425376,0.0506085,0.0188932,-0.686771,0.248917,0.449527,-0.143732,-0.533114,-0.266458,0.0448422,-0.321499,-1.10413,0.0824363,-0.433964,-0.190022,-0.443261,-0.125571,-0.848841,0.370938,-0.376285,0.0273295,0.714128,-0.151899,-0.166211,-1.18781,-0.721803,-0.111822,-0.270458,0.0374928,-0.726793,0.318633,0.200012,-0.377104,-0.216904,-0.536353,0.0515025,-0.0346147,-0.239985,-0.657019,-0.0134932,0.10017,-0.486544,-0.730783,-0.162884,-0.84068,0.117805,0.807079,0.127075,0.218984,-0.561322,0.155402,-0.29634,-0.469878,0.325538,0.162111,-0.0321656,-0.168155,0.0451251,0.265439,-0.269807,-0.0840333,-1.34258,-0.526126,0.0763246,-0.545702,-0.0383117,0.0898055,0.223831,-0.548373,0.155607,-0.285724,-0.808862,0.181098,0.161464,-0.0852939,0.348361,0.254665,0.474827,0.202888,0.034502,0.649352,-0.405026,0.722096,-0.569103,0.835474,-0.351975,-0.535676,-0.312088,0.133154,-0.232447,-0.382073,-0.0023578,0.365869,0.424947,-0.216821,0.596607,0.248834,-0.249881,-0.114382,0.288383,0.266386,0.950404,-0.126358,-0.0368292,0.264447,0.209257,-0.193712,0.177193,-0.225815,-0.802789,0.947933,-0.867905,0.00500471,0.0546456,-0.264267,-0.41958,0.06907,0.0545813,-0.341444,-0.407039,-1.26524,0.0728834,-0.0238903,0.238498,0.298699,0.139959,-0.32491,-0.121359,-0.693039,0.740794,0.0245239,0.746721,-0.325066,0.155814,-0.200872,0.013335,-0.640157,0.297607,-0.619118,0.636107,0.355621,-0.166385,-0.774948,-0.583117,-0.0382906,0.603259,-0.129673,0.212426,-0.598047,-0.890619,-0.00947412,0.0879558,0.88429,-0.230301,-0.412535,-0.319018,0.0966177,0.313637,0.0395003,0.257189,0.690688,-0.0141661,0.134502,0.0874609,-0.371882,-0.01666,0.756473,0.527753,0.347276,-0.175086,0.108122,-0.3736,0.19746,-0.619321,0.735058,-0.429968,0.0916591,0.297244,-0.0902003,-0.598167,0.264635,0.304317,0.296382,0.349986,-0.0719619,0.0945152,-0.49984,-0.259569,-0.477345,-0.309914,-0.383982,-0.213295,-0.219803,-0.811999,-0.79615,-0.236859,-0.481793,0.26718,0.60138,0.426264,0.0423587,-0.241857,-0.181546,0.221385,-0.784698,0.359586,0.311817,0.473008,-0.610447,0.803495,-0.304322,-0.584015,-0.0152483,-0.0610172,-0.23022,0.253485,0.269886,-0.871872,0.414227,0.130041,0.256452,0.404226,-0.757509,0.208009,0.215605,0.45608,0.464332,0.774184 +3422.73,0.999292,0.0848144,5,1.58477,0.83482,-1.4769,0.583427,-0.313736,-0.0578167,-0.228195,-0.135365,0.612845,-0.209337,-0.529358,-0.15101,-0.555294,0.625743,-0.495585,0.630156,-0.263891,0.122886,0.275527,0.159269,-0.732879,-0.796636,-0.972449,0.605866,0.139817,-0.291589,-0.105615,-0.0831234,-0.27455,-0.116501,0.850866,-0.54885,-0.686155,0.407197,-0.722485,-0.431469,-1.06309,0.68658,0.331917,-0.350864,0.754873,0.684632,0.450666,-1.0126,-0.227211,0.073806,-0.589422,0.849876,0.190848,-0.06817,0.11552,0.286093,-0.0187658,-0.539193,0.122021,-0.219757,0.0610775,-0.291814,-0.30665,0.251916,0.566892,0.903004,-1.24787,-0.232152,0.799604,0.657641,0.280409,-0.239529,0.194754,-0.305394,-0.250053,0.593008,0.436924,0.320212,0.755457,1.01714,0.0994128,-0.258356,-0.261579,0.000116138,0.587779,0.142527,-0.127097,-0.282413,-0.277501,0.597442,0.171328,-0.295114,0.145652,0.114649,0.0431622,0.382676,-0.203824,0.121532,0.270682,0.333047,0.241338,-0.17264,0.3267,0.470536,-0.0670748,-0.462256,0.0266915,0.00407268,0.306808,-0.104943,0.283603,0.249692,0.0697266,0.742093,0.160547,-0.0829187,0.455712,0.46555,0.0917246,0.298899,-0.632289,0.484153,0.208283,0.0631522,-0.29931,0.515565,0.78273,-0.416261,-0.65758,-0.0557966,0.0260695,0.74203,0.148139,-0.144275,0.185224,-0.296158,-0.0383284,0.604957,0.490307,-0.252895,-0.228985,-0.148837,0.818695,0.00618309,0.156997,-0.233554,0.310033,-0.445521,0.176574,0.064891,-0.0145071,0.23928,-0.236323,0.625597,-0.345371,-0.35512,0.183547,-0.434896,0.263164,0.460136,-0.164124,0.271333,0.115827,0.081126,0.112071,0.113177,0.374503,0.456385,0.345318,0.345143,-0.0970208,0.0407153,-0.0433543,-0.418706,-0.240062,-0.114819,-0.14606,-0.297009,-0.34797,0.0609886,-0.0782124,-0.363716,-0.0619856,0.578359,0.254739,-0.263345,-0.237438,-0.219161,0.304113,-0.731885,-0.23985,0.144472,-0.48221,0.121909,0.0787338,0.310421,-0.166101,-0.0156667,-0.132503,0.109737,0.116688,-0.123514,-0.192744,0.248384,-0.23576,-0.227434,0.0709931,0.15931,0.153641,-0.137157,-0.436126,0.817896,0.338725,-0.508781,-0.100544,-0.641743,0.0890205,0.571249,0.259062,0.0160211,-0.0191814,0.2562,0.00158616,-0.299801,0.21762,-0.595586,0.306365,0.136493,-0.641669,0.623293,0.0420176,0.183199,-0.258749,-0.240579,-0.902269,0.188987,0.237052,-0.183869,-0.813076,0.793423,-0.0641277,-0.236315,0.532238,-0.698775,-0.271432,-0.0240446,0.420025,0.543137,-0.0385674,-0.169203,0.329298,0.405749,-0.456111,-0.375568,0.302808,-0.900276,0.6523,-0.216851,-0.658856,0.0338056,-0.496788,0.00722592,0.143834,-0.310605,0.0437708,0.367108,0.296634,0.111704,0.313627,0.207152,0.154676,-0.146935,0.142888,-0.147154,-0.168081,0.377757,-0.0783476,0.483955,0.164094,-0.272697,0.265179,-0.279637,0.238288,0.00485601,-0.114653,-0.335135,-0.122032,-0.389499,-0.038086,-0.27786,0.433704,-0.0146072,0.0816108,0.324987,0.110731,0.305334,0.295168,0.00584115,-0.0515879,0.0603634,-0.413512,0.00783722,-0.653151,-0.553218,0.457698,0.120983,0.282989,0.347826,0.531967,1.38752 +3433.28,0.992752,0.0848144,5,1.59933,0.822644,-1.27441,0.501957,-0.349587,-0.103584,-0.370669,-0.14351,0.433962,-0.074582,-0.23579,0.0169282,-0.365023,0.832029,-0.243752,0.882271,-0.371002,0.119147,0.238603,0.442264,-0.291289,-0.756652,-0.994079,0.517417,0.114074,-0.222215,0.124529,-0.118102,-0.261942,0.236662,0.785091,-0.682354,-0.831042,0.410962,-0.300892,-0.175277,-0.963217,0.811957,0.440679,-0.490488,0.839227,0.734515,0.561621,-1.07695,-0.391323,0.143624,-0.832141,0.769999,0.391266,-0.147401,0.025665,0.214571,0.208407,-0.722452,0.196741,0.00606005,-0.182755,0.0940364,-0.0632809,0.037544,0.826353,1.17479,-1.02629,-0.458337,0.844182,0.261316,0.169253,-0.305015,-0.0701007,0.00832009,-0.157428,0.224011,0.602924,0.140887,0.289755,0.99247,0.22978,-0.214707,-0.385987,-0.0814427,0.447986,0.0778401,-0.307059,-0.514982,-0.167457,0.449258,0.20723,-0.111665,-0.23461,0.0120733,0.0588548,0.400285,0.0384932,-0.00713532,0.186183,-0.148966,-0.158684,-0.0950672,0.28101,0.466936,-0.130201,-0.772617,-0.221909,-0.0631853,0.322285,-0.337783,0.288305,-0.0728349,0.158888,0.500361,0.202389,-0.0672633,0.3991,0.400543,-0.244045,0.123465,-0.25389,0.459501,0.0779979,-0.098103,0.0324968,0.305339,0.504935,-0.433116,-0.186681,-0.180083,0.238115,0.905446,0.126268,-0.147612,0.296575,-0.139688,-0.0704831,0.41563,0.262794,0.0348552,-0.19127,-0.475261,0.546455,-0.124,0.274493,-0.449817,0.368394,-0.432119,0.26985,-0.269682,-0.09887,-0.0147521,-0.226656,0.306744,-0.182217,-0.24008,-0.0533904,-0.062094,0.329782,0.223466,-0.0594697,0.0232399,-0.0671334,0.202185,0.181544,0.0442642,0.556115,0.214969,0.337589,0.0216954,-0.0882067,-0.203231,-0.150737,-0.76606,-0.00531028,-0.120119,-0.0945187,-0.609979,-0.40443,-0.330162,-0.0610052,-0.365366,0.00672123,0.246457,0.0657136,0.0281564,-0.087615,-0.428259,0.353314,-0.565632,-0.153573,-0.110928,-0.10487,-0.12757,0.207341,0.213593,0.123722,0.192913,-0.746159,-0.0406283,-0.194557,-0.00220488,-0.415593,0.294184,0.0973623,-0.509087,0.348305,-0.0851899,0.347242,-0.197809,-0.461944,0.84352,0.300122,-0.205975,-0.460277,-0.482647,0.428061,0.365103,-0.120328,-0.0646838,-0.144384,0.104014,-0.0197013,-0.233875,0.150962,-0.371587,-0.00666835,0.0756954,-0.770106,0.825845,0.270291,-0.295661,-0.177824,0.165448,-0.925221,0.24427,-0.218375,-0.137393,-0.41423,0.684127,-0.286324,-0.465767,0.426801,-0.565246,-0.0469486,-0.0269226,0.0156123,0.300529,-0.19112,0.137739,0.325691,-0.0665046,-0.0452175,-0.63821,0.494956,-0.969456,0.642504,-0.415963,-0.462425,0.0325033,-0.283668,-0.165845,0.192093,-0.478386,-0.0327812,0.242384,0.211559,-0.114768,0.397814,-0.113663,0.162004,0.271559,-0.23297,-0.228397,-0.13108,0.193856,-0.196082,0.851422,-0.0949414,-0.058433,0.187629,0.0292037,0.233981,0.0404488,0.0771289,-0.391591,-0.333409,0.351144,0.033985,-0.460129,0.286071,0.373531,-0.0844507,0.111684,0.0109065,0.0426604,0.137876,-0.0620957,0.165715,0.0144432,-0.597819,-0.288795,-0.693042,-0.219874,0.589143,0.10339,0.319329,0.321543,0.565092,1.52495 +3451.24,0.999054,0.0848144,5,1.57963,0.793787,-0.982001,0.305614,-0.302787,-0.0223858,0.0427683,-0.0741357,-0.0227492,0.296114,-0.0762004,-0.183024,-0.00556079,0.798856,0.220354,0.719331,0.436434,-0.283701,-0.356345,0.346867,-0.13987,-0.73538,-0.609518,-0.00227825,-0.743239,-0.609715,-0.0858099,0.214653,-0.256695,0.339795,0.906534,-0.742424,-0.101363,0.130497,-0.658536,0.0840303,-0.206227,0.221565,0.0960936,-0.269363,0.92717,0.806451,0.209523,-0.65119,-0.0568837,0.000828697,-0.347285,0.194354,0.70131,-0.40443,0.737177,0.377135,0.524743,-0.506366,0.992334,0.0356085,0.0440956,-0.975443,0.253917,-0.557707,-0.0761271,0.934478,-0.684552,-1.27518,-0.34519,0.00347567,-0.00999986,0.255681,0.338406,-0.704058,-0.126839,0.148647,0.438691,-0.108979,0.535874,0.0723306,0.0292123,0.0328103,-0.294372,0.230636,0.351887,-0.500992,0.564228,0.511178,0.0613265,-0.561819,-0.211894,-0.113686,0.00944191,-0.60521,-0.0629733,-0.233407,-0.205778,0.0437746,0.0176971,-0.0327475,0.198818,-0.23322,-0.149465,0.146635,0.156734,0.639448,-0.25125,-0.307649,-0.158607,-0.272668,0.00319938,-0.0870142,0.26438,0.261443,-0.280306,-0.282955,-0.111921,0.131228,0.0678005,-0.0285293,-0.201083,0.0248318,0.263642,-0.133526,-1.12607,-0.36735,-0.930906,0.235206,0.198072,0.500726,-0.0159302,-0.671658,0.0183197,-0.537553,-0.218332,0.110879,0.202556,0.311239,-0.264428,-0.40404,-0.0302525,-0.103434,0.236493,-0.555789,-0.705921,0.320801,-0.0872841,-0.0756251,-0.172757,0.425662,-0.0283109,0.199667,0.0671996,-0.226148,0.0556686,0.140734,0.465171,0.131585,-0.0439364,0.431836,0.305104,-0.0461582,0.25848,-0.30397,-0.0221941,0.0554365,0.587488,-0.261087,-0.361647,-0.0666346,0.184244,0.0174083,-0.205228,0.590355,0.149223,0.245648,-0.128053,0.324383,0.236446,0.12675,-0.0868071,0.238384,-0.0634031,0.864478,0.186026,-0.20541,0.485079,0.460936,-0.303623,0.132905,-0.0902638,-0.350548,0.200555,-0.422026,-0.125623,-0.141193,-0.157946,-0.775452,0.636476,0.0908175,-0.0331172,-0.319817,-0.326829,-0.247855,-0.271436,0.337319,0.121057,0.0713278,-0.337968,0.133322,-0.461541,0.803318,0.120618,0.413103,0.193576,0.334302,-0.234782,-0.175686,-0.0644312,0.449541,-0.199541,0.236751,0.1722,-0.251856,-0.0411241,-0.251259,-0.000299487,0.235105,0.262121,0.128726,-0.696458,-0.183653,0.300668,-0.409302,0.743896,-0.174675,-0.270699,-0.167136,-0.127151,0.592139,0.365722,0.32886,0.429736,0.329206,-0.142748,0.197212,0.0184943,-0.24299,0.626431,0.0186102,0.256118,0.0265688,-0.140615,-0.00809146,-0.488679,0.0832232,0.267331,-0.147098,-0.0383755,-0.157127,-0.177805,0.178322,-0.148265,0.501942,0.303449,0.323529,-0.155482,0.265754,-0.219975,-0.078164,-0.167224,-0.232706,0.136806,-0.0749627,-0.0764905,-0.539657,-0.108413,-0.799622,0.0770801,0.0513352,-0.0256074,-0.171835,-0.0190109,0.074526,-0.337588,0.183646,-0.0406052,-0.377245,0.14965,0.678545,-0.58909,-0.0777298,0.0230435,-0.321264,-0.28117,-0.202349,-0.186088,0.233424,-0.0407919,-0.597945,0.386521,0.0771155,0.400346,0.0286229,-0.65072,0.114249,0.189038,0.338007,0.434785,1.41317 +3429.8,0.812038,0.0848144,4,1.54264,0.82486,-0.767423,0.154337,-0.164104,-0.101111,-0.109426,-0.118442,0.156411,0.227353,-0.263551,-0.24051,-0.0240658,0.647072,0.0535833,0.701415,0.408129,-0.0473076,-0.114076,0.388888,-0.064515,-0.708195,-0.4783,0.085733,0.0102259,-0.186428,-0.0775299,-0.254629,-0.424155,-0.139567,0.534335,-0.419169,-1.00645,0.112583,0.0191873,-0.124423,-0.795112,0.400012,0.00899868,-0.282358,0.892383,0.944655,-0.452666,-0.747363,-0.0251331,0.165487,-0.634838,1.04421,0.671462,0.00219533,0.381377,-0.158542,0.0555754,-0.827801,1.41385,-0.264308,-0.048718,-0.47243,0.427211,-0.283632,0.4975,0.803359,-0.355277,-0.524874,-0.244318,-0.0494454,0.378036,-0.174429,-0.318318,-0.200542,-0.614599,0.179205,0.521697,-0.0301106,0.389406,0.54812,0.561468,0.375232,-0.689426,-0.100151,0.0162102,-0.0269372,0.33462,-0.129032,0.0714549,0.537601,-0.24109,-0.322195,-0.263448,0.299371,-0.376402,-0.0680855,0.217413,0.103006,0.743248,-0.631655,0.124114,-0.131677,0.0996471,0.30796,-0.252167,0.403038,0.195024,-0.292001,0.140069,-0.254341,0.174614,0.0134118,0.424347,0.354011,0.100081,-0.228559,0.651578,0.0906722,-0.379284,-0.0406253,-0.201674,0.0932235,0.655008,0.31844,-0.751937,0.281519,-0.379487,0.373124,0.552269,0.38829,-0.157482,0.462458,0.395588,-0.298442,0.105018,-0.180877,-0.275664,0.509003,-0.26798,-0.255986,0.0870467,-0.66279,0.016963,-0.370233,-0.662478,0.211754,0.225228,-0.434016,0.28992,-0.333729,-0.033412,0.202065,-0.458235,0.16232,-0.362344,0.138689,0.0420887,0.157371,0.136063,0.250208,0.187422,0.102562,0.272724,-0.281353,0.402899,-0.0465772,0.588333,-0.021912,-0.235855,-0.230145,-0.362932,0.195192,-0.378009,-0.22443,0.0827648,-0.688592,-0.433712,-0.224154,-0.447655,0.370738,0.128476,0.514137,0.40912,0.436364,-0.113563,0.0217111,0.37073,0.169886,0.22785,0.0192568,-0.329646,-0.356468,0.406583,-0.155816,-0.0603557,-0.118789,-0.36885,-0.782493,-0.199408,0.00560046,-0.122779,-0.215576,-0.448752,0.0169781,0.533705,0.0294735,0.606989,0.43945,0.185293,-0.00759401,-0.145715,1.04608,-0.0105359,0.805299,-0.288298,-0.470674,0.392484,-0.555531,0.164051,0.309934,-0.203372,0.527918,-0.0124383,0.521516,0.42068,-0.359286,0.430052,-0.22306,-0.53861,0.496855,-0.387034,-0.0669251,0.136433,0.350753,-0.560864,-0.235087,-0.542059,-0.0545774,-0.378107,0.401514,0.204727,-0.0303122,0.866846,-0.482957,-0.0606743,-0.488799,-0.404266,0.185508,0.387421,0.121702,0.520468,0.315414,0.301585,-0.379297,-0.237322,-0.56354,-0.00324758,-0.126864,-0.489613,0.201366,-0.581941,-0.621829,0.0955115,0.272507,0.122802,-0.231244,-0.276536,-0.0243912,0.270805,0.219947,0.0498711,-0.236736,-0.254692,-0.0876921,-0.471635,-0.18596,-0.179632,0.142889,-0.0770168,0.520137,0.281018,0.0807743,-0.00463036,0.026796,-0.0818271,-0.459067,0.11805,0.173873,-0.137165,0.247451,-0.283394,0.203187,0.0452682,-0.0791079,-0.25263,-0.0228685,0.392103,0.339709,0.147159,-0.283733,-0.252969,-0.424684,-0.372459,-0.142087,0.16494,0.139479,0.397147,0.373468,0.630196,0.911245 +3459.94,0.98587,0.0848144,4,1.54872,0.836529,-0.523459,0.139567,-0.339136,-0.0340702,0.161853,-0.0852741,0.280929,0.198575,-0.0723366,-0.150998,-0.135198,0.78031,-0.0867781,0.792486,0.096598,0.0706281,-0.529803,0.377321,-0.161942,-0.549872,-1.08921,0.122186,-0.578041,-0.227485,-0.148492,0.537133,-0.313049,-0.237873,1.22344,-0.574024,-0.0831529,0.206801,-0.433317,0.0435361,-0.651468,0.1968,-0.299414,0.0728291,0.844739,0.90903,-0.437777,-0.471041,-0.292656,-0.146974,-0.498802,0.0957424,0.609839,0.108396,0.533385,0.580659,0.118029,-1.0232,1.05759,0.17678,-0.357149,-0.680148,0.362565,-0.117022,-0.127053,1.00914,-0.57475,-0.983541,0.441535,0.0573765,-0.0145638,-0.113499,0.115713,-0.369301,0.363264,0.288185,0.52963,-0.0252222,0.824421,0.303868,-0.219829,0.297793,-0.3869,0.039955,0.27204,-0.432572,0.316919,0.00166532,-0.250449,-0.0385557,0.152605,0.00950057,0.0334227,-0.535729,-0.340331,-0.0152374,-0.137391,0.179468,-0.268633,-0.260424,0.0910979,-0.262321,0.058845,0.486142,-0.00235975,0.367357,-0.636964,-0.123487,-0.157764,-0.650714,0.274231,0.103866,-0.070738,0.605987,-0.171484,-0.065528,-0.0311794,0.166071,-0.573618,0.214854,-0.265842,0.182224,0.267571,0.0238186,-0.714371,-0.319238,-0.17129,-0.582801,-0.0855358,0.481711,0.2991,0.162535,0.120983,-0.45604,0.0391851,0.124099,0.0470622,0.14363,0.0869542,0.212176,0.00996005,-0.398809,0.19863,-0.959868,-0.218435,0.0735383,-0.0628123,-0.482325,0.0608279,0.165274,-0.34599,0.78403,-0.203033,-0.306117,-0.30213,-0.10108,0.153331,-0.18099,0.244313,0.0147754,0.0658269,-0.087012,0.322334,-0.344122,0.0130801,0.289491,0.920089,0.495154,-0.0421399,-0.00670001,-0.035189,-0.0401294,-0.479842,0.235196,0.24613,-0.129234,-0.188477,0.402854,-0.00377635,0.416186,-0.195626,-0.103585,0.227237,0.642532,0.000941073,0.46388,0.112899,-0.0346569,0.0296087,-0.033919,-0.667055,-0.270175,-0.583247,0.0443736,-0.0896715,0.472348,-0.0159339,0.0272088,-0.408719,0.324525,0.0226159,-0.111225,-0.00932492,-0.0539257,0.0972809,-0.214068,0.00639602,0.243833,-0.314301,0.476294,-0.354312,0.720365,0.0924598,0.468545,0.0245535,-0.0220071,-0.00530997,-0.0814796,-0.396516,0.265589,-0.575141,0.339833,0.0525038,-0.0739897,0.0301817,-0.27508,-0.428956,-0.271308,-0.257513,0.445189,-0.785289,-0.267062,0.00196899,0.11163,-0.576739,-0.0871106,-0.464061,-0.115082,0.353365,0.342634,0.217498,0.187315,0.216499,-0.380459,-0.47374,0.207556,-0.0654812,-0.284423,-0.233262,-0.144609,0.423089,-0.591593,0.0286743,-0.373971,-0.230423,-0.181352,0.572578,-0.214913,0.348951,-0.209031,-0.227072,0.0540151,-0.060347,0.349777,0.524181,0.469196,0.155446,0.0270695,0.515857,0.325574,-0.486376,-0.204503,-0.171485,0.109573,0.020839,-0.110354,-0.253684,0.0878303,0.332984,-0.269789,0.0674487,-0.725933,-0.298258,-0.780418,0.272999,0.0141178,-0.445497,-0.136726,0.108928,0.0379426,0.16705,0.707663,0.493702,0.00439686,-0.19582,-0.0192331,0.0642419,0.332149,-0.211086,-0.109392,0.113683,0.161436,0.153684,0.215629,-0.157697,0.0963016,0.217425,0.310325,0.466288,1.34683 +3441.69,0.856884,0.0848144,5,1.43705,1.02271,-0.712076,0.260285,0.138122,-0.0652316,-0.212313,0.414363,0.0819249,0.257963,-0.494427,-0.183397,0.155376,0.620007,0.262676,0.791993,0.236423,0.0948859,0.00546022,-0.0886978,0.0932371,-0.944187,-0.154662,-0.129373,0.0651822,-0.00913926,0.165141,0.196931,-0.430565,0.220528,1.16545,0.414106,0.0138647,0.422035,0.075921,0.0767199,-0.301166,0.731068,0.535872,-0.282079,0.946411,0.631943,0.313171,-0.498064,0.0457927,-0.100315,-0.583371,0.751322,0.246708,0.38299,0.124924,0.216009,-0.0339177,-0.579123,0.326501,-0.318557,0.165898,-0.554167,0.159035,0.00228024,0.502993,0.776877,-0.824131,-0.815008,0.158763,0.52062,-0.185035,-0.173767,0.13004,-0.256307,-0.244718,-0.0986887,0.637091,-0.127328,0.330906,0.753953,0.405929,-0.0783464,-0.0706002,-0.211857,0.597015,0.057868,0.436474,0.440078,-0.190952,0.47721,-0.339069,0.161939,0.0866382,-0.576353,-0.100147,-0.22865,-0.0539708,0.00492347,0.307775,0.14053,-0.0951221,0.192139,-0.0565672,0.206886,0.174874,0.619238,-0.0598947,-0.0991334,0.78185,-0.0636687,-0.0296762,-0.227059,0.116927,0.326799,-0.378333,0.0248962,-0.179806,0.608875,0.0191914,-0.0142814,-0.0223896,0.240599,0.00233481,0.0994445,-0.228208,0.426234,-0.445898,-0.188569,0.0741536,0.160807,0.271476,0.183552,0.335445,-0.115238,0.290028,-0.112773,-0.336567,0.723057,-0.351755,-0.368666,0.194347,-0.215493,0.151995,-0.333215,0.00501699,0.223796,0.131813,-0.068129,0.0913386,-0.389513,0.389571,0.137323,-0.367664,-0.170843,-0.277816,-0.0979489,-0.0759912,0.26258,0.515935,0.771026,0.393643,-0.297535,0.0947146,-0.0823751,0.30009,-0.521917,0.37033,-0.384323,-0.291548,0.382104,-0.0768283,-0.144773,-0.15025,-0.44198,0.423091,0.267156,0.11558,-0.358251,-0.107708,-0.679175,0.118334,-0.129379,0.510494,0.358921,-0.127096,-0.704579,-0.192184,0.397711,-0.205416,0.20771,0.335378,-0.0808676,0.887065,-0.100011,0.0491341,-0.402541,-0.23399,-0.370359,0.199168,-0.0316696,0.233708,-0.679992,-0.886607,-0.371187,0.201914,0.10694,0.368199,0.225848,0.0773894,-0.0504978,0.025671,0.656305,-0.091524,-0.26259,0.0322678,-0.11745,0.0701321,0.382115,-0.395087,0.203221,-0.249764,0.241667,0.360697,-0.310586,0.121714,-0.664416,0.0628037,0.209975,-0.630111,0.465233,-0.822742,-0.271952,0.221952,0.261352,0.321679,0.183634,0.476186,-0.197186,-0.815298,0.693307,-0.197424,0.0423473,0.746056,-0.179953,-0.1619,-0.181475,-0.231297,0.138936,0.497753,0.222154,0.416064,0.9235,-0.333711,-0.561044,0.10023,-0.742241,0.0756947,-0.222809,-0.492444,0.447738,-0.34261,-0.245384,0.0958727,0.119317,-0.0388451,-0.0793605,-0.133396,0.037272,0.256476,-0.431738,-0.0845193,0.29202,0.0741907,-0.0866377,-0.362008,-0.266924,-0.162428,0.0623437,0.24121,-0.0616953,0.00840963,0.171621,0.425157,0.00445109,-0.112245,-0.259882,0.281571,-0.312336,0.0453765,-0.18856,-0.505943,-0.0842788,-0.375938,-0.236077,0.139693,0.0840787,0.161229,0.320799,0.0320168,-0.597279,-0.357077,-0.199193,-0.244891,-0.83383,0.213324,0.112339,0.305374,0.335171,0.552606,-0.685998 +3435.23,0.872077,0.0848144,4,1.60352,0.919947,-1.04157,0.306371,0.443323,0.0531857,-0.121589,0.266019,0.0206919,0.143957,0.0768011,-0.886721,0.151396,0.128086,-0.0825425,1.03473,0.0632206,-0.0435308,0.0688549,-0.370088,-0.0861682,-0.775779,-0.710457,-0.327645,-0.694037,-0.23812,-0.0233035,0.155565,-0.488706,0.291061,0.690518,-0.309318,0.271862,0.266213,-0.484188,-0.303487,-0.409658,0.488588,0.602629,0.130855,1.08021,-0.00126769,-0.0490215,-0.9696,0.0989646,-0.536082,-0.48417,0.342242,0.647476,0.340404,0.300167,0.327053,0.247705,-0.281896,0.534526,-0.0577869,-0.286158,-0.114588,0.347822,-0.209355,0.0134892,0.976106,-0.415693,-0.723182,-0.0700985,0.882972,-0.229433,-0.0607466,0.517598,-0.1543,-0.19936,0.195016,0.551005,-0.213441,0.690388,0.0863921,0.487278,-0.133215,-0.0624918,-0.48983,0.0991719,-0.141287,0.667273,-0.0504574,-0.30146,0.236357,-0.341146,0.0445373,0.0896705,-0.0427901,-0.076672,-0.445556,-0.0818519,-0.639308,0.449484,-0.0776071,-0.663478,-0.334407,0.179544,0.244002,0.460773,-0.21459,-0.465025,-0.460787,-0.339681,-0.433037,0.218608,-0.196521,0.117888,0.252651,-0.534655,-0.288261,0.208377,0.565706,-0.00963898,0.452068,-0.300731,0.135819,0.808036,-0.0905411,-0.56585,0.601075,0.0180627,0.241286,0.457387,0.364012,0.251123,0.413765,0.215954,-0.292614,0.198716,-0.113058,0.175527,0.352508,-0.239827,0.280517,0.198599,0.10591,0.202052,0.293739,-0.27137,0.279192,0.0691984,-0.487858,0.128846,0.0385852,0.0102842,0.542951,-0.151084,-0.36265,-0.526478,0.153934,0.0434152,0.0081491,0.216312,0.361117,0.336618,-0.33204,-0.0933654,0.198569,0.483739,-0.628322,0.571334,0.111327,0.0353735,-0.000455568,-0.149341,-0.209572,0.194257,-0.0539634,0.0823185,-0.492213,0.133974,0.108765,0.165409,-0.105399,0.0830514,-0.263599,0.304455,0.826664,0.417488,0.195825,0.0552587,-0.167691,-0.0303801,0.266996,-0.286733,0.0854678,0.225418,-0.654498,0.0915775,-0.0370219,0.113434,-0.848823,-0.185745,0.045843,-0.0851482,-0.667229,-0.625428,-0.1131,0.169971,0.37694,0.228572,0.335586,0.068157,0.532372,-0.355484,0.735139,-0.309217,0.504096,-0.270607,0.0446679,-0.222785,-0.44448,-0.2853,-0.54178,-0.172816,0.251413,-0.0264317,0.198769,0.160795,-0.384237,-0.131595,0.481151,-0.672711,0.445985,-0.515834,-0.250317,0.244258,0.325015,0.0818454,0.191758,0.438235,-0.0283259,-0.463721,0.466816,0.0388782,0.151108,0.422975,0.00151731,-0.105718,-0.135683,0.461914,0.143916,0.177971,0.0739753,0.472076,0.577211,-0.35538,-0.521334,-0.351877,-0.364274,0.56935,-0.374181,-0.372895,0.28826,-0.406519,-0.0994074,0.464094,0.463133,0.292499,0.425773,-0.137285,0.296045,0.200408,0.150645,-0.22237,0.295111,0.0941824,-0.0672144,-0.152119,-0.309846,-0.589871,0.392263,-0.0414481,-0.0471769,-0.0330334,0.622714,0.217839,-0.0712891,-0.142539,0.22133,-0.116763,-0.121775,-0.441758,-0.163363,0.0614085,-0.00198041,0.271711,-0.46621,-0.0127605,-0.109017,-0.150327,-0.0242462,-0.285462,-0.231626,-0.233055,-0.114027,0.292335,-0.0874018,-0.36486,0.114569,0.285675,0.338481,0.534485,-1.25123 +3433.1,0.778398,0.0848144,4,1.47192,0.929845,-0.964176,0.346796,0.132189,-0.0824843,-0.233522,0.0685832,0.61995,0.0408131,-0.194961,-0.478068,0.427618,0.636603,-0.0781709,0.703325,0.237766,0.0563979,-0.0907417,-0.156457,0.203756,-0.990567,-0.833843,-0.124239,-0.217184,-0.0714831,0.234813,0.0445673,-0.477685,-0.32475,0.724944,-0.144318,-0.289033,0.617897,-0.337912,-0.0451055,-0.337793,1.00881,0.707618,-0.576796,1.07884,0.336589,-0.0813677,-0.467758,0.151956,-0.601603,-0.414123,0.239549,0.617372,0.0095222,-0.0653914,0.615904,0.168168,0.117685,0.450515,-0.0646666,-0.384152,-0.163779,0.149329,-0.341046,-0.0290796,0.942299,-0.65436,-0.99201,0.616651,0.58512,-0.229601,0.0195597,0.091384,-0.292928,-0.166319,0.0660528,0.586931,-0.0205241,0.464935,0.375335,0.0482902,-0.121528,0.125463,-0.586725,0.109475,-0.886934,0.699697,-0.152322,0.0390479,-0.05297,0.286303,0.0817916,0.364914,-0.380727,-0.0197832,0.0437633,-0.325427,-0.452816,-0.0417294,0.0923623,-0.303666,0.0796937,0.419916,0.234943,-0.0565687,-0.34188,-0.0278878,-0.415408,-0.326705,-0.333175,0.310988,-0.268805,0.203769,0.303329,-0.223763,0.0250257,0.0232171,0.221927,0.304077,-0.348839,0.0536722,0.496859,0.157266,-0.101452,-0.551047,0.0235587,-0.3154,0.0746389,0.142103,0.0465257,0.191024,-0.109643,0.481122,-0.370921,-0.00668727,0.0205298,0.226114,0.342576,0.101114,0.0394499,0.235184,0.590059,0.0227881,-0.309941,-0.179904,0.0323452,-0.210998,-0.619074,-0.116753,0.123779,-0.141358,0.345313,-0.107019,-0.205641,-0.513025,-0.185905,0.173672,0.240263,0.122636,0.311521,-0.18959,0.19153,-0.321659,0.205044,0.10236,-0.126982,0.658527,0.720731,0.322677,0.0471635,-0.0491959,0.0651842,-0.223953,0.447913,0.130485,-0.0970853,0.182339,-0.288155,0.0623517,-0.394669,-0.110922,0.0780482,0.227931,0.328086,0.219504,0.238883,0.483746,-0.0437903,-0.306377,-0.191491,0.384596,-0.21012,0.726158,-0.344928,-0.0305679,-0.587902,0.0399512,-0.753449,-0.216523,0.154706,0.203701,-0.175227,-0.366886,-0.54559,0.107066,0.164079,0.294314,0.0179019,0.0401909,0.332186,-0.283542,1.09686,-0.310023,0.48875,-0.0640141,0.0983884,-0.00541418,-0.196355,0.0581896,0.110497,0.172335,0.180246,0.167525,-0.127696,0.0421197,-0.689784,0.665135,-0.158741,-0.355569,0.058182,-0.420782,0.0142094,0.624363,-0.132351,-0.185078,0.0179119,0.282846,-0.351809,-0.359912,0.697791,-0.120444,0.436839,0.600955,-0.156166,0.00740919,-0.0883153,0.495155,0.243987,0.636148,0.228026,-0.345923,0.626347,-0.357316,-0.111257,-0.452729,-0.591012,0.483256,-0.504909,0.0143835,0.288423,-0.291429,-0.201203,0.367908,0.258732,0.456675,0.366361,-0.393454,-0.0508349,-0.258362,0.405797,0.277413,0.016059,0.432774,-0.155155,-0.258962,-0.536334,0.0596401,0.0576166,-0.517311,-0.353241,0.0614628,0.569535,0.224828,-0.180061,-0.139085,0.609423,-0.161522,0.281579,-0.367687,-0.399536,-0.269314,-0.012532,0.209183,-0.956848,-0.0206871,0.00180203,0.260132,-0.43014,-0.285116,-0.380928,0.218016,-0.320171,0.000197264,-0.062104,-0.181167,0.0978835,0.222508,0.312863,0.471707,-0.412515 +3428.86,0.460389,0.0848144,4,1.52583,0.971016,-0.809329,0.170304,0.157089,-0.0986026,-0.129416,-0.0852171,0.277078,0.0184612,-0.0433566,-0.191264,-0.184912,0.176844,-0.221772,0.726886,-0.030473,-0.115142,-0.20442,0.0572368,-0.493337,-0.670288,-0.444374,-0.196985,-0.193989,-0.151498,0.230605,0.19696,-0.365161,0.197968,0.584722,-0.522224,-0.279845,0.137868,-0.0556702,0.0150796,-0.197683,-0.232304,0.092121,0.0253438,0.749053,0.428248,0.144452,-0.54202,0.106132,0.416634,-0.407944,-0.383341,0.408893,0.0397411,0.0393771,-0.0961548,-0.196759,-0.206065,0.965151,-0.615667,0.370979,-0.763559,0.655585,-0.13787,0.105741,0.642761,-0.549646,-0.545984,-0.105406,0.479331,0.129467,-0.157528,0.23892,-0.227803,-0.419577,0.050278,0.779164,0.229498,0.414836,0.468049,0.187067,-0.123134,-0.530205,0.396519,0.513057,-0.0181895,-0.0941654,0.0194096,-0.215395,-0.622922,0.0402199,0.108321,-0.418682,0.0231912,0.224747,0.0514252,-0.280457,-0.122203,-0.0591962,-0.333099,0.455766,-0.132922,-0.36101,0.30227,0.456343,0.777859,-0.673118,-0.73178,-0.106915,-0.5642,0.670802,-0.247495,0.490273,0.944968,0.0615502,-0.223861,-0.0602169,0.386458,-0.220411,0.403405,-0.0494469,-0.0883376,0.406155,0.217136,-0.763525,0.09405,-0.641101,-0.3461,-0.2346,-0.0203172,-0.210259,0.521506,-0.141373,-0.255455,-0.340536,0.29219,0.130495,0.514136,-0.316625,-0.0249746,0.0653629,-0.505538,0.584851,-0.308527,-0.0705826,0.284267,0.270514,-0.104617,0.00598152,0.083454,-0.0500429,0.506732,0.0436461,0.0265447,0.508528,0.125129,-0.15117,-0.256161,0.100534,0.465679,0.387082,-0.0853804,0.488528,0.0365949,0.688554,-0.253873,0.3498,-0.420929,-0.0125613,0.758231,-0.273405,-0.440101,-0.0457231,-0.173673,0.355215,-0.474072,-0.415258,0.398656,-0.586426,0.113498,-0.0322684,0.0682122,0.272626,0.901212,-0.130888,-0.610175,-0.137649,0.0156987,0.14343,-0.0173897,-0.658969,-0.104893,-0.212666,-0.309791,0.428787,0.373956,-0.0176143,-0.673464,0.0399771,0.116096,-0.130869,-0.44039,-0.417929,0.68952,0.150406,-0.413517,-0.226644,0.148315,0.134385,0.0451193,-0.404485,0.96036,0.541984,0.108612,-0.226604,-0.515004,0.239906,-0.141408,-0.0793357,0.0529211,-0.17058,0.240242,0.202542,-0.411604,-0.0861717,-0.65653,-0.519886,0.402229,0.214997,0.10325,-0.475932,-0.203512,-0.531606,0.557695,-0.596377,-0.0327148,-0.214357,-0.302533,-0.637467,0.369945,-0.48976,-0.0240297,0.362888,-0.155548,0.199783,0.10694,-0.0627618,0.192286,-0.477076,0.691161,0.659576,0.191909,-0.182407,-0.381102,0.40485,-0.232172,0.239256,0.138814,-0.277585,0.0694328,-0.215703,-0.00303444,-0.404991,0.170045,0.0451744,-0.0835019,0.0918235,0.0429153,-0.287703,-0.205619,-0.0144928,-0.266004,0.119747,-0.0408802,-0.394879,0.224634,-0.338692,-0.320714,0.336485,0.488534,-0.0416515,0.324203,-0.175093,-0.281092,-0.566522,-0.101122,-0.138201,0.158858,0.019184,0.33258,0.286554,0.272587,0.280366,0.336583,-0.0659102,0.0582469,-0.366411,0.591326,0.32335,-0.291823,0.62136,0.56733,-0.0138929,0.238107,-0.073907,0.123061,0.149339,0.350801,0.386444,-0.424001 +3451.55,0.965994,0.0848144,4,1.60782,0.783487,-1.0049,0.425377,0.148708,-0.203837,0.324507,0.0411726,0.320316,0.0290922,-0.0986412,0.0416907,0.153989,0.267795,-0.218595,0.560437,0.00273277,-0.324207,-0.0199987,0.443405,-0.0146796,-0.805992,-0.574047,0.225916,0.0241479,0.172651,-0.332745,0.00425526,-0.00980086,0.363937,0.734352,-0.0187592,-0.59443,0.494556,0.080688,-0.054503,0.0397445,0.0494424,0.500555,-0.333706,0.746692,0.276562,0.35684,-0.405128,0.0647704,0.270851,-0.861274,-0.170762,0.742012,-0.077364,-0.420377,0.0804017,-0.00476641,-0.0665035,0.544064,0.146765,0.0795985,-0.719982,0.252361,-0.588627,0.368941,0.725881,-0.788673,-0.726205,0.381524,-0.297896,-0.251478,0.0385258,0.014444,-0.318202,-0.186591,0.633704,0.434457,0.431423,0.178959,0.749144,0.103035,-0.104189,-0.227016,-0.40266,0.43504,0.249484,0.519334,-0.205289,-0.482325,-0.20617,-0.0893396,-0.0478949,0.0362379,-0.163918,0.137563,-0.0884873,0.0887052,-0.318344,-0.0961099,-0.468661,0.776708,-0.281354,-0.3503,0.577273,0.536117,0.583549,-0.393957,-0.351087,-0.0519587,-0.746879,0.220353,-0.437286,0.227666,0.946505,0.126452,-0.261115,0.145277,0.0827267,0.171862,-0.585011,-0.0297261,-0.623326,0.42342,-0.321904,-0.930855,0.281605,-0.0911943,-0.251046,-0.119038,0.0746248,-0.443354,0.180629,0.28028,-0.257107,0.117762,0.289543,0.0255157,0.869347,0.0262675,0.416863,-0.141232,-0.635795,0.358317,-0.5535,-0.299765,0.0301992,-0.2539,-0.0673579,0.0384005,0.058041,-0.0792493,0.0920043,-0.296161,0.424295,0.311377,-0.105884,-0.0227514,0.0843969,0.174731,0.989509,0.278562,-0.0959616,0.262949,0.104404,0.0309546,0.0987832,0.40382,0.0758242,0.140252,0.296591,-0.284199,-0.255107,-0.500746,-0.355516,0.3435,-0.20843,0.0444686,0.129316,-0.673776,-0.0884509,-0.328688,0.304929,0.19179,0.846196,0.0624009,-0.283311,0.177211,0.0327637,-0.296993,-0.113253,-0.453633,-0.24606,0.0109349,-0.628107,0.187237,-0.232314,0.490471,0.17193,0.121263,0.167507,-0.282502,-0.442715,-0.339136,-0.0905126,0.319511,-0.51125,-0.0755891,-0.203703,-0.000435008,0.0123435,-0.889383,1.0679,-0.0525858,0.12638,-0.158617,-0.616879,0.210396,-0.0847159,-0.304949,0.26509,-0.195146,0.143265,0.460025,-0.0945322,-0.393913,-0.578771,0.013238,0.127852,0.0575045,0.222543,-0.171597,-0.216043,0.077104,-0.139527,-0.026019,-0.0191117,-0.332886,-0.452627,-0.258343,0.239277,0.482608,-0.122027,0.61746,-0.0204655,0.106777,-0.0411253,0.14508,0.279497,0.133332,0.127067,0.304929,0.222241,-0.16364,-0.399869,-0.159856,-0.21061,0.650095,0.199731,-0.6984,0.0583573,-0.172271,-0.00227337,-0.199717,0.411992,-0.0316564,0.0619967,0.477579,0.0598849,0.327326,0.0592916,-0.0279689,0.200841,0.262056,0.00355756,-0.633843,-0.464973,-0.0458065,-0.0674831,0.246225,0.0516699,0.331839,-0.0796571,0.1686,-0.0816709,0.0476076,-0.25124,0.229697,-0.11427,-0.0582469,0.453123,-0.254865,0.243656,0.430098,-0.0176173,0.164699,0.0848768,0.00668565,0.531881,-0.175576,-0.509663,0.219168,0.322295,-0.0146436,0.108542,-0.1844,0.127821,0.152071,0.357521,0.389963,-0.095491 +3428.59,0.98594,0.0848144,4,1.57265,0.626004,-1.48196,0.621726,0.280043,-0.161075,-0.144209,0.264435,0.0789205,-0.254291,0.311337,-0.204053,-0.543976,0.218952,-0.218561,0.377481,0.50887,-0.00368183,-0.339309,0.326543,0.422059,-0.992922,-0.451317,0.354676,-0.0590706,-0.268021,0.173896,0.419971,-0.654965,-0.153596,1.1489,-0.933789,-0.0169605,0.264791,-0.20184,-0.152154,-0.322298,0.466337,0.307792,-0.16202,0.834351,0.386322,-0.532218,-0.763722,-0.198678,0.569767,-0.466428,0.605468,0.603351,0.0523069,0.346859,0.218439,-0.0330383,-1.12016,0.533371,-0.328407,-0.206343,-0.705443,0.35971,-0.305238,0.350307,0.490078,-0.985617,-0.697528,0.420827,0.0721023,-0.102147,-0.325573,-0.249925,0.155583,-0.160965,-0.385598,1.01062,-0.30564,0.584771,0.274386,0.814749,-0.301202,-0.515268,-0.0716458,1.02223,-0.767571,0.302039,0.273048,-0.557814,-0.521122,-0.176122,0.0235855,-0.0475597,-0.471934,0.121729,-0.195827,0.0470342,-0.0408981,0.383389,-0.484018,0.0393541,0.113709,-0.0978784,0.0787412,-0.447215,-0.0514231,-0.654295,-0.196606,0.0897081,-0.568453,0.250902,-0.568908,-0.281892,0.487287,0.505153,0.303058,0.21764,0.56201,0.0239949,0.12816,-0.211038,0.311681,0.712097,-0.252047,0.0897458,-0.2505,-0.267098,0.177292,-0.505535,-0.206022,0.376488,0.200825,0.152695,-0.291771,0.0142022,-0.0102853,0.275099,0.0560446,-0.18279,-0.297231,0.424826,-0.679994,0.0679419,-0.77315,-0.0527444,0.280611,-0.283341,-0.0790598,-0.383135,-0.206264,-0.159399,0.59948,-0.272495,-0.238491,-0.12465,0.0336032,-0.394307,-0.19431,0.427291,0.217845,-0.292654,-0.166026,0.185894,0.0182329,-0.20952,-0.559908,0.865919,-0.135744,-0.0825693,0.0892221,-0.182822,-0.141718,-0.171602,-0.229481,0.198059,-0.203965,-0.207964,-0.503133,0.203061,0.0286076,0.00771784,-0.113614,-0.106388,1.09937,0.247136,-0.0209639,-0.150772,-0.0028646,-0.0453098,-0.625645,0.171422,-0.416685,0.167497,-0.157083,-0.0811346,-0.430408,0.180976,-0.844257,0.309152,0.228663,-0.0981136,-0.592797,-0.220039,-0.378039,0.416179,-0.400724,-0.109429,-0.0551858,-0.152675,-0.00866685,-0.322187,0.510504,0.0835772,0.392394,0.265602,-0.16326,-0.215725,-0.0217409,0.118591,0.195053,-0.0625042,0.125222,0.11666,-0.344256,0.41397,-0.641974,-0.416113,0.656127,-0.140034,-0.0123194,-0.424082,0.434055,0.191701,0.123267,-0.212008,0.0847124,0.236021,-0.146265,-0.53815,0.700901,0.0016099,-0.0262589,0.65845,-0.366668,0.113544,-0.198139,0.131139,0.125244,0.625525,0.475404,0.66153,0.0159337,0.360144,0.225485,0.523063,-0.239248,0.35904,-0.228575,-0.145812,-0.191173,-0.333747,-0.0291677,0.0568464,0.440749,0.0190637,-0.165503,0.0576279,0.242417,0.002544,0.370794,-0.0461111,-0.348256,-0.43411,-0.29757,0.0778751,-0.170318,-0.26666,0.0982102,0.0399137,0.518862,0.619017,-0.140323,0.536817,0.327844,-0.180762,-0.275183,-0.790756,0.367487,-0.205746,0.00610912,-0.191081,0.0111293,0.471189,0.398536,-0.0278474,0.191183,0.209119,0.0989906,0.234983,-0.455864,-0.171912,-0.0493494,-0.0912982,-0.0560136,-0.393968,0.118005,0.295952,0.343519,0.544015,-0.234484 +3431.36,0.996914,0.0848144,4,1.61713,0.751659,-1.29284,0.456953,-0.154565,-0.170273,0.131748,-0.488035,-0.130697,-0.137047,-0.231796,-0.348197,-0.648046,0.58728,-0.148535,0.497726,0.0916304,-0.3186,-0.135453,0.498528,-0.112053,-1.34453,-0.777889,0.356221,-0.507858,-0.113006,0.136161,0.121826,-0.366503,-0.00911655,1.04622,-0.346141,-0.22595,0.357491,-0.0542273,0.261669,-0.213005,0.236209,0.687334,-0.300008,0.862169,0.825895,0.362912,-1.11585,-0.195634,-0.224552,-0.696371,-0.11618,0.90127,0.245292,-0.298757,-0.139115,-0.324378,0.265883,0.565044,-0.64065,-0.148106,-0.601732,0.160244,-0.29954,0.299168,0.859938,-0.150936,-0.577668,0.521315,0.0794821,0.107803,0.148016,0.0938011,-0.40937,0.21537,0.622304,0.243522,-0.0900865,0.600233,0.514,0.290355,-0.0821705,-0.482648,-0.00862956,0.765602,-0.532839,0.326668,-0.209042,-0.304505,-0.00484115,-0.654646,0.414582,0.0989768,-0.620662,-0.106044,-0.0897252,-0.422777,-0.30304,-0.481153,0.260134,0.231823,-0.745615,-0.223558,0.363006,0.330047,0.448996,-0.0342967,-0.0657257,0.238112,0.2507,-0.0440373,-0.374007,0.279974,0.89098,0.159606,0.45888,0.378018,0.123212,0.400239,0.145084,-0.311337,0.0316314,0.107174,-0.0934826,-0.442933,0.20053,-0.427647,-0.00720165,-0.137856,-0.272247,-0.225112,0.145063,0.160656,-0.238061,-0.0310742,-0.141715,-0.0203291,0.458568,-0.0534156,-0.00554461,0.0424989,-0.175886,0.308603,-0.52043,-0.574217,0.127871,0.189429,-0.158033,0.0433066,-0.234814,0.162208,0.329764,-0.288947,0.480242,-0.269073,0.0420618,-0.221066,0.049507,-0.311871,0.611377,0.735935,-0.49111,0.155066,-0.26288,-0.0787684,0.387053,0.710465,0.189603,-0.220652,0.2528,-0.664281,-0.330585,-0.589913,0.143782,0.209196,-0.0323268,0.0421794,0.429523,-0.321283,-0.14477,-0.0982726,-0.433073,-0.0470968,0.750846,0.120365,0.199756,-0.513323,-0.30106,0.0192527,0.232796,0.153369,-0.23865,-0.227825,-0.113835,0.286815,0.342293,0.28571,-0.114742,-0.143994,0.239713,-0.161476,-0.434208,-0.230112,0.219591,-0.187548,-0.208169,0.20305,-0.116665,-0.000502123,0.348806,-0.361429,0.68226,-0.313375,-0.120565,-0.0668327,-0.260518,0.180103,-0.12825,-0.45898,-0.0880173,-0.288711,0.20062,0.76001,0.240831,0.609673,-0.354194,0.668287,0.185693,-0.670928,-0.073554,-0.556563,-0.0895914,0.0615659,0.454018,-0.336016,-0.0092794,-0.236715,-0.414978,-0.125312,0.222539,0.439908,0.160376,0.672423,-0.435089,-0.17614,-0.406169,-0.328043,0.528814,-0.0524372,-0.365387,0.218782,0.560082,0.0373991,-0.290061,0.00348558,-0.0418838,0.418973,-0.47757,-0.187826,-0.200126,0.0293092,0.651767,0.0502422,0.389296,0.05519,0.431374,-0.0438743,-0.325189,0.167716,0.156157,-0.535949,0.240309,-0.22873,0.236349,-0.464746,-0.121112,-0.260918,0.628091,-0.329642,-0.236829,0.0414814,0.155574,0.611495,0.217237,-0.00776637,-0.782479,-0.0266012,-0.296042,0.034617,-0.242311,0.0979952,0.251046,0.134468,-0.313022,0.112852,0.488972,0.0835036,0.0515522,0.0493288,-0.182467,0.126157,-0.172401,0.0340169,0.652563,-0.19227,0.0964692,0.203048,0.310595,0.450609,1.08985 +3412.79,0.640984,0.0848144,5,1.56263,0.722555,-1.21994,0.502143,0.517341,0.0296316,-0.193497,0.173141,0.115264,0.0183222,0.129136,-0.182841,-0.0160652,0.145952,-0.208412,0.732273,0.531058,0.034614,-0.192376,-0.258709,-0.371305,-0.189057,-0.483038,0.591549,-0.421784,-0.102104,-0.548961,0.413379,-0.199903,0.230489,1.1545,-0.576295,0.170027,0.294672,-0.283735,-0.373884,-0.752574,0.527068,0.587412,-0.287468,1.16079,0.223519,-0.0740982,-0.435294,-0.218213,0.435416,-0.476632,0.451908,0.207556,0.193628,0.316461,0.382383,-0.0173949,-0.668989,0.510181,0.33285,-0.259399,-0.421667,0.70964,-0.378362,0.0777097,0.984819,-1.02157,-0.838435,0.0743749,0.335911,-0.167164,0.110442,0.412723,-0.28754,0.00480595,-0.0397528,0.918138,-0.0727873,0.416025,0.214861,0.4335,-0.166253,0.0403965,0.659708,0.117943,-0.148004,0.112112,0.411292,-0.51541,-0.0773996,0.321607,-0.642937,-0.257637,-0.384592,-0.0924153,-0.391147,0.561262,0.287128,0.61232,-0.428172,0.0165356,0.0979633,0.42092,0.249856,-0.043804,0.0760808,-0.0728648,-0.327342,-0.142168,-0.237652,0.257527,-0.325233,-0.364426,0.382424,0.311261,-0.00586018,-0.663378,0.646523,-0.411689,0.287434,-0.232697,-0.138159,0.349666,-0.256263,-0.0347912,-0.216749,0.207647,0.00848647,0.163352,0.805086,0.431216,0.124063,0.17846,-0.384056,0.613737,0.216057,0.0826108,0.313681,-0.213651,-0.100505,0.216027,-0.6296,0.93893,-0.020253,-0.264963,-0.127828,-0.172623,-0.296972,0.654073,0.194913,-0.29314,-0.0325939,-0.590543,-0.528466,-0.108342,0.134056,0.199704,-0.48797,0.920796,-0.00212699,-0.959772,-0.617549,-0.053879,-0.227816,0.416128,0.0648029,0.746273,-0.611989,0.128347,-0.0198316,0.0667372,-0.0495242,0.100772,-0.0380497,0.51516,0.0217979,-0.0176353,-0.3603,0.394204,-0.154019,-0.821602,0.463814,0.659091,0.566532,-0.368704,-0.472866,0.0435443,0.169017,0.0418812,-0.259072,-0.255789,-0.115333,0.670429,-0.540197,-0.0641017,-0.082834,-0.136079,-0.749856,0.245665,0.047392,0.0838544,0.386538,-0.818035,0.0118663,0.150368,0.3613,0.00968628,-0.102296,0.0122585,-0.433829,-0.337462,0.502969,0.0108832,0.251468,0.261204,0.058608,0.196123,0.410635,0.380846,0.131829,-0.298311,0.0905626,-0.374166,-0.548886,-0.716282,0.215975,-0.370077,0.364888,0.302669,0.294257,-0.106311,-0.149644,0.570745,0.131924,0.0221135,0.237548,0.0199224,0.100288,-0.143451,0.218048,-0.324333,0.0823876,0.311052,0.100577,-0.0378414,0.252613,0.0463655,-0.546599,0.499283,0.181298,0.428711,-0.277393,-0.156829,-0.407216,-0.0505513,-0.456186,-0.0947072,0.261541,-0.0780592,0.421322,-0.0850507,-0.640999,0.15284,-0.226744,0.485159,-0.0526495,0.103308,0.136961,-0.108939,-0.0233844,0.0215477,-0.180852,0.297898,-0.288918,0.155173,-0.454267,0.045177,-0.195357,-0.163444,0.50203,-0.154081,0.0101952,-0.345635,0.188914,0.186704,0.512088,-0.326012,0.34348,-0.363419,0.130172,0.120445,0.102161,0.296551,0.184257,-0.0938123,-0.290659,0.054814,0.0661192,-0.537035,-0.277752,-0.200743,0.201831,-0.150253,-0.964285,0.0519166,0.117824,0.27262,0.343255,0.52213,-1.27492 +3415.42,0.926844,0.0848144,4,1.50222,0.841195,-1.17604,0.474422,0.948138,0.0709998,-0.173601,0.584749,-0.113934,0.191319,0.0559489,-0.291367,-0.627679,0.228423,0.261328,0.834001,0.352911,-0.0842632,0.101016,-0.182254,-0.69065,-0.625175,-0.64874,0.112721,-0.154764,0.157967,-0.217568,0.258413,-0.254856,0.251902,1.28326,-0.508138,-0.596201,0.548171,-0.146468,-0.159569,-0.687638,0.73708,0.553191,-0.425163,1.03859,0.636677,-0.208556,-0.591266,-0.0887878,0.249825,-0.452348,0.228237,0.650746,0.309146,-0.295077,0.622799,-0.139461,-0.265302,0.415461,0.300904,-0.274102,-0.18173,0.910594,-0.81141,-0.041026,1.17063,-0.940271,-0.689675,-0.0363486,0.197023,-0.44637,0.659277,0.192513,-0.644146,0.0836619,0.273132,0.914313,-0.358046,0.366931,0.170497,0.0857962,-5.73813e-05,-0.0546028,0.417604,0.130502,-0.225428,0.21865,0.0995041,-0.262793,0.293477,0.69296,-0.349818,-0.466618,-0.884121,0.245976,0.206307,0.353163,-0.0206671,-0.0908003,-0.336479,0.0498985,0.119531,-0.0364247,0.421253,-0.0214513,0.269522,-0.0211257,-0.782545,0.171254,-0.273888,-0.0419629,-0.447732,-0.278587,0.380115,0.200341,-0.245233,0.300405,0.541986,-0.0951828,0.218306,0.0989472,-0.449541,0.28636,-0.431146,-0.270882,-0.276778,-0.0478316,-0.744633,0.507179,0.345164,-0.13403,0.0400168,0.355503,-0.579755,0.87174,0.0368477,-0.457463,0.322068,-0.218661,-0.090524,-0.214955,-0.401994,0.889472,-0.245438,-0.0190765,0.0386762,0.0918242,-0.27678,0.648536,-0.192604,-0.524522,0.106784,-0.718256,0.0796855,-0.412996,0.11528,0.230694,-0.129363,0.717104,0.0881989,-0.525092,-0.676591,-0.114899,-0.346963,0.589723,0.298374,0.82539,-0.244202,0.396693,-0.0428094,0.0615126,-0.605461,0.0750296,0.0808337,0.474214,-0.100261,0.26913,-0.15263,0.01452,0.0236627,-0.634946,-0.155126,0.631594,0.578123,-0.385474,-0.779757,-0.388424,0.20133,-0.249056,-0.0372538,-0.559682,-0.101121,0.256347,-0.679227,0.103589,0.190454,0.38779,-0.548881,0.252269,-0.453394,0.142826,0.5106,-0.49876,-0.198917,0.235565,0.396707,0.114811,0.0873308,-0.268895,-0.559844,-0.165512,0.711705,-0.106616,0.280073,0.0862337,0.0667093,0.023936,0.285666,-0.181946,-0.108064,-0.323369,0.137202,-0.0174423,-0.120778,-0.32162,-0.00188278,-0.691492,0.37556,-0.36052,0.281399,-0.101406,-0.0564139,0.432323,0.344507,0.157611,0.337266,-0.262916,-0.124629,-0.0431486,0.230462,-0.0118602,0.133913,0.289008,-0.134021,0.329406,-0.0128814,0.0683744,-0.269381,0.543183,0.184533,0.500862,-0.551077,-0.123061,-0.180327,-0.367923,-0.780842,0.119953,0.153431,-0.0538887,0.470925,0.0113668,-0.504343,0.0793514,-0.138652,-0.167019,0.610817,0.352362,0.0513976,-0.091606,-0.0804502,-0.574808,-0.370107,0.613856,-0.234113,-0.130459,-0.459107,-0.256344,-0.344199,-0.183896,0.555959,-0.280627,-0.343368,0.152674,-0.231566,-0.196249,0.0695484,0.219128,-0.384935,-0.221094,0.301245,-0.0542064,0.0146218,0.448231,0.169388,0.00413671,-0.244702,0.120292,0.0705098,-0.227545,-0.0300054,-0.295603,0.111941,-0.56145,-0.151419,-0.466406,0.129296,0.220653,0.359578,0.469737,-2.98235 +3429.79,0.97178,0.0848144,4,1.63462,0.852087,-0.942564,0.361753,0.224508,-0.0942997,-0.326251,-0.0251689,-0.0125651,0.518377,-0.0421976,0.133658,0.427916,0.177233,0.00164961,0.904087,0.236737,-0.137746,-0.152687,-0.189396,-0.250973,-0.528308,-0.822684,0.266664,-0.227232,0.125811,-0.201065,0.113573,-0.00858419,0.0130247,1.07062,-0.868981,0.110859,0.320115,-0.494883,0.118759,-0.572923,0.836826,0.495293,-0.485853,1.18158,0.747639,-0.0647675,-0.632663,0.0982916,0.564163,-0.761146,0.300769,0.181068,0.181987,0.0003459,0.375109,-0.193146,-0.265862,0.393701,-0.0860683,-0.579126,-0.949154,0.54013,-0.569355,0.493777,0.657266,-0.404402,-0.814105,0.579339,1.1351,-0.143569,0.276774,0.180281,-0.422152,-0.178068,0.363963,0.723259,-0.503087,0.145962,0.483626,0.412963,0.159965,0.0889711,0.616133,0.343955,-0.674977,0.163981,-0.389296,-0.314461,-0.926012,0.248622,-0.553389,-0.392927,-0.573664,-0.0765493,0.500813,-0.368408,0.350853,-0.0715008,-0.445798,-0.0578549,-0.487807,1.19834,-0.0277914,-0.236469,-0.300407,-0.122126,0.0143035,-0.0012354,-0.368852,0.203806,-0.466728,0.186931,0.599382,0.0725188,-0.399228,0.199098,0.541852,0.382237,0.404178,-0.564149,-0.00298589,0.724492,-0.122729,-0.463928,0.158776,0.376571,-0.34101,0.192842,-0.00819374,0.514695,0.14351,0.257038,-0.433777,0.20695,-0.169955,0.0650259,0.0860552,0.176634,0.257632,-0.368301,-0.099707,0.480714,-0.4289,-0.119676,-0.247631,-0.0263908,-0.984705,0.674337,0.000829689,0.413247,0.311009,-0.387259,0.277609,-0.0427865,-0.167662,0.126254,-0.0553025,0.535803,0.151661,-0.121075,0.719651,-0.33879,-0.118917,0.118005,0.134762,0.358063,0.0761636,-0.732182,0.223029,-0.181204,-0.236134,0.211212,0.0227422,0.14327,-0.0700969,0.0411225,0.385308,-0.109341,0.0337742,-0.401855,-0.117971,0.210949,0.75742,0.296808,-0.298492,0.0981351,0.0766576,0.137735,-0.0870867,-0.416648,-0.308969,0.415586,-0.273322,0.426258,-0.117566,0.152999,-0.765319,-0.38888,-0.225089,0.20493,-0.296495,-0.299697,-0.0404426,-0.0629641,-0.383807,-0.179582,0.133085,-0.282337,0.0711159,-0.0987488,0.563812,-0.682676,0.268225,-0.270552,-0.448041,0.00640516,-0.131663,-0.526351,0.141614,-0.197521,-0.0413233,-0.257601,-0.0197534,-0.427396,-0.392818,-0.0825844,-0.339804,-0.183047,0.288194,-0.368485,0.0231341,0.148573,0.0500664,0.118273,0.113221,-0.256665,0.138149,-0.0877361,-0.31121,0.0916295,0.453095,0.498307,-0.0795999,-0.0946034,0.433351,0.0781486,-0.903861,0.17547,-0.40614,0.512174,-0.36279,-0.313072,0.0185699,-0.379413,-0.893362,-0.142675,-0.25223,-0.177122,0.221307,-0.149206,-0.13165,-0.253138,-0.0856822,0.306942,0.087372,0.340507,-0.0670941,0.22547,0.165099,-0.335891,-0.533215,0.313632,-0.217732,-0.215701,0.0759032,-0.282287,-0.164396,-0.260223,0.00815043,-0.276335,-0.0222047,-0.0135147,-0.18739,-0.327574,-0.585839,-0.552851,0.0732359,0.288123,-0.0106384,0.395194,0.220481,0.279097,-0.162478,0.154655,-0.191221,0.105482,0.319163,-0.308734,-0.472983,-0.144209,-0.0385108,0.164876,0.0866723,-0.305014,0.113304,0.311045,0.336606,0.557714,-0.441407 +3422.22,0.912219,0.0848144,4,1.46236,0.871786,-1.1233,0.434281,0.253013,-0.052843,-0.0112288,0.402415,0.393769,0.056534,-0.154345,-0.201995,-0.350382,0.338177,0.416227,0.902695,0.232986,-0.111164,0.247608,0.131258,-0.565481,-0.949819,-1.00541,0.473879,-0.12453,-0.102825,-0.158416,0.625007,-0.359634,0.407319,1.20918,-1.04616,0.131847,0.652643,-0.184978,-0.294712,-0.455275,0.757344,0.308856,-0.142308,1.3061,0.68597,0.225249,-0.820143,-0.0984273,0.0823724,-0.426206,0.348004,0.517891,0.254075,0.101923,0.562156,0.136802,-0.20341,0.579343,-0.223577,-0.208294,-0.536682,0.457029,-0.463877,0.328307,1.01053,-0.898907,-1.25862,0.280617,0.114534,0.0683905,0.339048,-0.0120079,0.0108418,-0.460485,0.324458,0.663423,-0.477619,0.314644,0.525077,0.0121657,-0.109898,-0.161116,0.523624,0.231022,0.0464367,0.160499,-0.10942,-0.389825,-0.17837,0.170076,0.0215845,0.206744,-0.647662,0.0670094,0.233818,-0.324179,0.0763533,0.16483,-0.454236,-0.38312,-0.209197,-0.138948,0.0807495,0.472255,-0.636427,-0.0401159,-0.275399,-0.647725,0.0670632,-0.0377195,-0.145124,-0.233054,0.44687,-0.242259,-0.367627,0.000435056,0.299108,-0.456167,0.516865,-0.480536,0.0651343,0.255722,-0.845262,-0.726289,-0.00560036,0.220643,0.0121774,0.132614,0.232489,0.329369,-0.0833913,0.364468,-0.905289,-0.297902,0.253677,-0.127942,0.647329,-0.393872,0.42042,-0.244909,0.114962,0.450423,-0.0739853,0.341555,-0.156393,0.267008,-0.0894207,0.0574899,0.0197945,0.630174,-0.18378,-0.332104,-0.032016,-0.310983,0.307438,0.138593,-0.22868,0.445069,0.288125,0.556459,-0.340532,-0.267896,0.00641398,0.579352,-0.202877,0.267723,-0.0979742,-0.36277,0.558215,-0.212785,-0.375522,-0.185397,-0.385647,0.236958,0.580953,-0.0432808,-0.0400639,-0.395437,0.188715,-0.479751,-0.130256,-0.138534,0.810677,0.268906,-0.183346,0.213572,-0.158411,0.388692,-0.189698,-0.0885798,-0.43685,0.283095,-0.464629,0.278548,-0.122328,-0.572121,-0.474949,0.26577,0.051472,0.0576023,-0.127988,-0.357388,-0.46063,-0.403877,-0.102451,-0.0595356,-0.288601,-0.241157,0.134259,-0.664884,0.658666,0.468668,-0.36131,-0.250818,-0.160489,-0.187798,0.426706,-0.104707,0.175559,-0.819192,-0.182768,-0.0766197,0.0235881,0.177944,-0.286265,-0.0223527,-0.203236,-0.592284,0.767752,-0.829916,-0.239243,-0.269657,-0.198907,-0.731303,0.155949,-0.434684,0.0147543,0.432167,0.541611,0.684361,0.0771609,0.572366,-0.00688771,-0.163192,0.27288,-0.0905147,-1.02158,0.827218,0.0856452,0.521775,0.272326,0.084667,-0.411283,0.0344819,-0.32736,0.497082,-0.214378,-0.25784,0.192117,-0.126094,0.153723,0.0644158,-0.326075,0.195225,0.817744,0.108733,0.482599,-0.338158,0.428648,-0.239952,-0.427895,-0.190961,-0.217865,-0.248572,-0.346813,-0.183255,0.0904314,-0.0732556,0.555745,-0.0983387,0.400825,0.868604,0.0636049,-0.525404,-0.565642,-0.887274,0.160995,0.00819052,0.273817,-0.357072,-0.334013,0.627545,-0.8042,-0.0328497,0.693735,0.218254,0.151998,0.0864637,-0.168689,-0.459513,0.317253,-0.01103,-0.0452861,0.167419,0.143085,0.216649,0.378266,0.465455,-0.72731 +3413.64,0.986288,0.0848144,4,1.57998,0.732001,-1.24074,0.493715,0.352539,-0.254179,-0.44907,0.173408,-0.37205,0.537709,0.176603,-0.187182,0.029077,0.233686,-0.149092,0.742008,0.223164,-0.20207,0.152547,0.0504167,-0.0435178,-0.629296,-0.893936,0.497176,-0.43875,-0.0543111,-0.234485,0.147281,-0.210089,0.228378,1.10445,-0.13577,0.0665313,0.345805,-0.301539,-0.117706,-0.243242,0.657965,0.295844,-0.224662,1.13918,0.451735,0.397473,-0.537803,-0.222922,-0.0950785,-0.659769,0.315402,0.123106,-0.199847,0.244208,0.732514,0.184334,0.00131094,0.717737,-0.173875,-0.305499,-1.13943,0.355486,-0.372774,0.4263,0.463288,-0.440906,-1.0674,-0.108917,0.434203,-0.275373,-0.305675,0.630764,-0.125871,0.0106089,0.739542,0.727755,-0.333494,0.744904,0.390451,0.591828,-0.263527,-0.0162663,0.468225,0.589688,0.337652,0.261395,0.0132388,-0.781559,0.119464,0.2743,-0.307414,0.142535,-0.785407,-0.50467,-0.242626,-0.273828,-0.375498,-0.118133,-0.384673,-0.0169296,0.580114,-0.0612185,0.0016264,0.382051,-0.268853,-0.3434,-0.30828,-0.630168,0.163917,-0.279204,-0.0161396,0.57616,0.494671,0.204866,-0.497479,-0.0742778,0.438639,-0.509947,0.446415,0.280947,-0.0793085,-0.0868103,-0.575122,-0.691451,-0.165848,0.339201,-0.0429587,0.603215,0.0363367,0.114998,-0.430279,0.225175,-0.617048,-0.232366,0.396651,-0.220115,0.584482,-0.290597,0.132206,-0.211153,0.0664386,0.402932,-0.333713,-0.330208,-0.390467,0.195792,-0.769377,0.451356,0.414536,-0.100066,-0.191143,-0.408078,-0.576497,-0.67851,0.000730878,0.0427867,-0.135009,0.0814366,0.397207,0.361732,-0.231892,-0.233775,-0.0802918,0.823458,-0.130797,0.766105,0.211363,-0.00931715,0.599153,-0.0894704,-0.22918,-0.467275,0.421719,0.19359,0.456918,-0.0728643,-0.312881,-0.148308,-0.0494829,-0.251997,-0.0640901,-0.408541,0.636503,-0.150541,0.361519,0.50888,-0.587791,-0.402659,0.198291,-0.423543,-0.290748,-0.0980213,-0.523855,0.338987,-0.116068,-0.226416,-0.174873,-0.00280481,0.053258,-0.173294,-0.4827,-0.641156,-0.836499,-0.180673,-0.370434,0.00552514,-0.591458,-0.0648811,0.0191179,-0.280949,0.599066,0.541627,-0.284309,-0.39694,0.0702727,-0.376,0.250443,0.388421,0.362721,-0.444346,-0.0618544,-0.0888967,-0.180285,0.0523241,-0.126396,-0.221548,-0.166009,-0.295308,0.424917,-0.405205,0.329436,-0.0063923,-0.123397,-0.463631,-0.0657448,0.652072,0.160409,-0.131854,0.153731,0.344519,-0.245185,0.7823,-0.193422,0.0668235,-0.182879,-0.354267,-0.846904,1.08021,0.291768,0.58781,0.480533,-0.988549,0.194605,-0.160149,-0.45346,0.416711,-0.331196,-0.303817,0.226111,0.00436918,0.199664,0.0133524,-0.217383,0.0533132,0.16546,-0.143974,0.0570503,0.375077,0.408006,-0.0645119,-0.431287,0.474629,-0.219732,-0.117029,-0.0621087,-0.0635027,0.305591,0.123688,0.255583,0.274207,0.732453,0.363678,0.27275,-0.471466,-0.160117,-0.396725,0.253153,0.382827,0.0874128,-0.0415732,-0.296505,0.546049,-1.02341,-0.068022,0.232235,0.319799,0.0299406,0.0618598,-0.640361,-0.130357,0.278417,0.0942031,0.208287,0.19787,0.145634,0.294189,0.38162,0.542392,-0.637291 +3409,0.992349,0.0848144,4,1.59394,0.761503,-1.15954,0.449468,0.466824,-0.211571,-0.220882,0.196324,-0.186553,0.452067,0.0614089,-0.525748,-0.0143126,0.0473713,-0.045733,0.620654,0.117917,-0.405862,0.055308,0.0503406,-0.404374,-0.759323,-0.872502,0.524436,-0.275963,-0.218964,-0.204062,0.0818486,-0.275368,0.214766,1.1447,-0.394858,0.0882459,0.37474,-0.223951,-0.199259,-0.259543,0.633754,0.438252,-0.395077,1.05672,0.588473,0.341557,-0.489159,-0.192756,-0.152148,-0.612561,0.212783,0.160374,-0.243558,-0.0124919,1.05312,0.0245758,0.00266634,0.612873,-0.130936,-0.399389,-1.31121,0.491413,-0.183856,0.493879,0.775483,-0.536105,-1.23334,-0.165109,0.164437,-0.423965,0.00671609,0.254966,-0.0739561,-0.000458395,0.350055,0.9433,-0.46644,0.819686,0.384298,0.488213,-0.388596,0.147559,0.268964,0.328733,0.255453,0.344293,0.0934901,-1.0635,-0.0235177,0.0746114,-0.17525,0.222724,-0.72136,-0.569031,-0.521916,-0.137135,-0.319854,-0.0308244,-0.0829352,-0.508642,0.407781,0.168956,-0.0951276,-0.0431712,-0.336986,-0.457062,-0.21783,-0.652152,-0.228508,-0.183959,0.204692,0.429791,0.52443,0.357434,-0.385124,0.0468072,0.193758,-0.266056,0.0839583,0.397703,0.00793194,-0.162712,-0.562761,-0.527899,-0.0293225,0.653018,-0.134302,0.659437,-0.0326386,0.094563,-0.457743,0.283848,-0.610628,-0.517165,0.276538,0.00966174,0.742028,-0.445138,0.385626,-0.292467,0.0378464,0.331432,-0.0269485,-0.270441,-0.395009,0.129744,-0.598403,0.306468,0.40781,0.0804325,-0.224222,-0.458935,-0.235256,-0.459615,0.189985,0.191009,-0.0803039,-0.0258177,0.781906,0.122943,0.139327,-0.0953405,0.0385588,0.538748,0.00218548,0.729359,0.0273951,-0.127907,0.555995,-0.0204188,0.0768108,-0.414712,0.0691543,0.139814,0.545488,0.153225,-0.0202999,-0.147116,0.0509876,-0.18617,0.492672,-0.201939,0.694806,-0.248159,0.0387891,0.145889,-0.76206,-0.382294,0.0694513,-0.154484,-0.283078,-0.507039,-0.501006,0.102077,-0.126061,-0.0752195,-0.06922,-0.140186,0.0414836,-0.189655,-0.538349,-0.366742,-0.978218,-0.0934425,-0.275217,0.120731,-0.494097,-0.0350233,0.0350022,-0.328789,0.742557,0.466882,-0.450356,-0.0540874,0.157086,-0.232425,0.663813,0.300007,0.266872,-0.361632,-0.150716,-0.116295,-0.138776,0.0590325,-0.165863,-0.797932,-0.00992499,-0.338879,0.617994,-0.316809,0.248839,0.20768,-0.0593657,-0.667803,-0.0175129,0.325734,0.0708331,-0.0679806,0.430972,0.228498,-0.082143,0.686924,-0.430875,-0.17539,-0.167416,-0.230412,-0.826755,0.621899,-0.0842573,0.540974,0.691856,-0.938595,0.263184,0.0418607,-0.435111,0.345066,-0.193953,-0.24554,0.260474,-0.276391,0.406605,-0.0986378,-0.22076,-0.00800553,-0.0861842,-0.166899,0.130566,0.57939,0.0286725,0.0148195,-0.517127,0.472326,-0.279925,-0.0109071,0.200916,-0.174436,0.256265,0.0924038,0.512149,0.444112,0.599523,0.0491383,0.187537,-0.738002,0.106042,-0.0786997,0.266462,0.524975,0.0971509,-0.047739,-0.138186,0.36252,-0.639137,-0.0110751,0.0795416,0.538375,0.0764871,0.102911,-0.45668,-0.0805269,0.166799,-0.213739,-0.0906533,0.470343,0.159787,0.19491,0.399733,0.441486,-1.06624 +3435.17,0.952587,0.0848144,4,1.60486,0.922891,-0.945451,0.499262,0.62009,-0.0286526,0.30526,-0.071132,0.111652,0.318811,-0.114296,0.00868582,0.202992,0.262235,-0.24697,0.608472,0.359614,-0.0131862,0.131858,-0.283394,-0.162154,-0.8812,-0.181979,0.319173,0.0361051,-0.0447846,0.365469,0.497578,-0.491452,0.309721,1.18986,-0.722702,0.0950941,0.330084,-0.39668,-0.165052,-0.215332,-0.17916,0.330052,-0.0218217,0.775937,0.374432,0.206144,-0.883629,0.102765,-0.021033,-0.883815,0.133936,-0.0869537,0.0100038,-0.169665,0.228319,0.295526,-0.166731,0.11796,-0.35161,-0.3402,-0.800841,0.0551195,-0.677272,0.297887,0.859551,-0.976112,-1.07535,0.378016,-0.29526,0.0734897,0.334838,0.0654459,0.0962989,-0.111058,0.631044,0.584565,-0.561766,0.599224,0.261274,0.592265,0.440016,0.144302,0.0387343,0.702111,-0.913462,-0.173119,-0.12947,-0.41329,0.120495,-0.379039,0.25557,-0.0329956,-0.654393,-0.296732,0.028012,0.155983,-0.198876,0.537277,-0.609073,0.412351,-0.411225,-0.121009,0.638201,0.0552067,-0.101719,-0.66073,-0.201826,0.287166,0.208727,0.42188,-0.0371351,-0.082069,0.488707,0.0524985,-0.308835,0.0827179,0.448683,0.322174,0.123445,0.0301434,0.154744,0.468378,-0.456431,-0.765866,0.313895,0.302464,-0.413174,-0.247312,-0.282094,0.556314,-0.247984,0.245189,-0.291583,-0.489929,0.128592,0.458595,0.498937,-0.372485,0.182474,-0.199454,-0.0860503,0.583553,-0.559566,-0.317897,0.15961,-0.241605,-0.533114,-0.218448,-0.142354,0.382455,0.4791,-0.533335,0.0285547,-0.156001,-0.177746,0.0046467,-0.166435,0.36881,0.534297,-0.0866136,-0.154798,0.0527252,0.506053,0.306892,-0.593696,0.52534,-0.126524,0.241501,-0.0988846,0.553784,0.392028,-0.12424,-0.173312,-0.254612,-0.260013,-0.348909,-0.197168,0.0303154,0.593031,-0.222581,-0.271677,-0.262436,0.72036,0.266597,-0.124754,0.325896,0.245331,-0.287752,-0.679505,-0.438799,-0.295398,0.37981,-0.5007,0.0500222,0.34031,0.0651584,-1.05683,0.297968,-0.0520314,0.134772,0.263642,-0.648825,-0.250928,-0.365018,-0.0699616,0.411003,-0.313573,0.443002,-0.410766,-0.834246,0.658016,0.390204,0.142537,0.211844,-0.199476,-0.374025,-0.148377,-0.137412,0.201966,-0.309617,0.00552566,-0.175697,0.214433,0.301462,-0.806439,0.108358,0.657151,-0.483813,0.402877,-0.109005,-0.141983,0.341929,-0.564604,-0.337428,0.00841801,-0.353428,-0.729046,0.0453513,0.407197,0.121357,0.219683,0.399278,-0.00948164,-0.0759928,-0.0256793,0.000726142,0.188499,0.476415,-0.0211864,0.473167,-0.0397606,-1.00503,-0.24997,0.155509,-0.084302,0.154006,-0.0686546,-0.125859,0.144846,-0.377505,-0.252113,0.152674,-0.0477428,0.425083,1.23419,0.212499,0.357787,0.00736107,-0.16475,-0.423678,-0.0965606,-0.0957716,0.155358,-0.306797,-0.469475,-0.613858,0.354,-0.114803,-0.315346,-0.128751,-0.0246053,-0.0008866,0.048395,-0.689684,-0.337244,-0.240735,-0.117046,0.0758883,-0.0698773,0.197859,0.0534252,0.146407,-0.158347,-0.107879,0.478597,0.297397,-0.309731,0.0340831,-0.540383,-0.245939,0.213177,0.432302,0.134955,-0.577143,0.135869,0.301147,0.368604,0.548769,-2.0549 +3418.08,0.831713,0.0848144,4,1.51926,0.924661,-0.832495,0.426934,0.607549,-0.114898,0.463285,0.206994,0.354499,0.16304,-0.0339754,-0.156086,0.593965,0.300749,0.0879915,0.750565,0.47899,-0.342067,0.100214,-0.070115,-0.208214,-0.463368,0.247631,0.380218,0.133741,0.0805449,0.0879462,0.412203,-0.411461,0.250542,1.15858,-0.556145,-0.257133,0.325775,-0.32754,-0.301959,0.0896381,-0.367249,0.583739,-0.125286,0.775245,0.622688,-0.148542,-0.668785,-0.113181,0.344798,-0.734956,-0.0831158,-0.083625,-0.115269,-0.196712,0.232693,0.322279,-0.559053,0.491182,-0.108071,-0.380036,-1.00938,0.142409,-0.343476,0.565059,0.895627,-1.0809,-0.513774,0.155422,-0.420294,0.172998,-0.0929023,-0.266901,-0.0927634,-0.138223,0.555218,0.54564,-0.310285,0.480422,0.546755,0.630038,0.211597,0.0722985,-0.251627,0.326197,-0.527482,-0.105063,-0.235528,-0.076837,-0.128244,-0.27163,-0.149128,0.422526,-0.832569,-0.65969,0.182868,0.0201009,-0.183058,0.0285224,-0.326039,-0.0125247,-0.369918,-0.51767,0.429551,-0.157189,-0.599028,-0.713006,-0.213248,0.58725,0.0864833,0.775077,0.0168522,-0.000781472,0.0857396,0.511174,-0.317935,-0.313808,0.212489,0.244924,-0.20311,0.25127,0.141679,-0.0417205,-0.348205,-0.845191,0.350887,0.256613,-0.360561,-0.0188891,0.298453,0.619582,-0.041344,0.256725,-0.260936,-0.416793,0.160533,0.551405,0.335206,-0.404531,-0.0515979,-0.434599,-0.147243,0.393616,-0.695107,-0.897163,-0.243406,-0.252375,-0.43429,-0.079681,0.442139,0.730658,0.49838,-0.800107,-0.130207,0.418713,0.139176,0.0649048,0.0807861,0.162779,0.843045,-0.0621132,0.31541,-0.0397088,0.214922,-0.0883279,-0.0358602,0.343972,-0.00595208,-0.139427,-0.0248799,0.532666,0.416215,0.0613657,-0.377255,-0.383194,-0.402001,-0.078017,-0.0286361,0.224726,0.284651,-0.0160353,0.104309,0.120727,0.726526,0.169808,-0.218915,-0.159337,0.207745,-0.130316,-0.765956,-0.15498,-0.282103,-0.0492189,-0.447418,0.137724,0.417431,0.0877347,-0.747152,-0.0401101,0.133774,0.344226,0.00371265,-0.408295,-0.123099,-0.38423,-0.284431,0.296097,-0.469352,0.162786,-0.0944495,-0.3104,0.643149,0.593252,0.488824,0.0472577,0.180001,-0.430565,-0.370642,-0.0163885,0.0790678,0.146724,-0.163237,-0.100773,0.155411,0.157087,-0.834428,0.365472,0.468514,-0.28037,0.313672,-0.00648596,-0.19716,0.0921531,-0.587797,-0.116496,-0.0533178,-0.346776,-0.523235,-0.351915,0.440196,0.433393,-0.120033,0.275577,-0.213701,0.0948342,0.012233,-0.169584,0.614685,0.170154,-0.299048,0.575929,-0.132243,-0.526573,0.0410796,0.146845,-0.394888,-0.149392,0.190959,-0.152232,0.248241,-0.31503,-0.115187,-0.215526,0.10064,0.743561,0.927688,0.191414,0.711542,0.248819,-0.321087,-0.492503,-0.191412,-0.0921815,0.0508143,-0.188931,0.187131,-0.476681,0.309347,0.356869,0.0464246,-0.252981,0.0430525,-0.0940513,0.0923378,-0.366681,-0.0690387,-0.51654,0.326299,0.250836,-0.0828415,0.0829832,0.211064,0.0783322,0.0711716,-0.00305048,0.392814,-0.323975,0.0419571,0.309604,-0.737636,-0.00112689,0.34748,0.281721,0.127978,-0.557681,0.118699,0.251175,0.344527,0.501173,-2.07119 +3415.12,0.989258,0.0848144,4,1.55096,0.827496,-0.943682,0.420441,0.492059,-0.233388,0.390831,0.155296,-0.104808,0.367606,-0.0418408,0.052173,0.41714,0.283659,-0.20316,0.894225,0.273449,-0.132436,-0.334815,-0.160362,0.0966297,-0.562902,-0.308263,0.526518,-0.241909,-0.125758,0.411989,0.279203,-0.48803,0.245855,1.2384,-0.852501,-0.190923,0.401848,-0.220901,-0.0911264,0.40435,0.529387,0.161728,-0.97361,1.27404,0.127341,0.250835,-0.803284,0.0245473,0.188995,-0.736591,0.0304317,0.234897,0.108682,0.0567428,0.633038,0.574916,-0.789769,0.531527,-0.655477,0.041471,-0.664079,0.242929,-0.39419,0.148333,0.859607,-0.33977,-0.759308,-0.125885,-0.432533,0.0599808,0.564563,0.0303335,-0.449113,-0.313468,0.252556,0.807586,0.0583318,0.986266,0.319831,0.756028,-0.135288,-0.240698,-0.328841,0.626715,-0.810307,0.115993,-0.0975274,0.0182886,-0.426628,0.23748,0.294972,0.00612504,-0.158759,0.13243,0.191492,-0.0765858,0.100488,0.37163,-0.445397,0.149046,-0.0966693,0.234062,-0.0933321,-0.209967,-0.316998,0.0971299,0.0561791,0.360623,0.268803,0.447743,-0.115689,-0.121151,0.687359,-0.0522586,-0.692861,0.334507,0.371691,-0.0420896,0.0245627,0.175803,-0.0902773,0.322404,-0.640713,-0.840413,-0.154798,0.390981,-0.117618,0.315305,-0.84815,0.283566,0.227116,0.713536,-0.195199,-0.516492,-0.139658,0.359493,0.110998,-0.46232,0.434836,-0.173637,-0.21148,0.357301,-0.807686,-0.704102,-0.250236,0.196891,-0.180839,-0.406578,0.519067,0.0964305,0.154786,-0.158044,-0.379963,-0.147018,0.0951402,0.148235,-0.192855,-0.230368,0.688907,-0.0860809,0.569891,-0.355487,0.126908,-0.00913991,0.381162,0.743777,-0.168561,-0.898074,0.192221,0.310581,-0.051015,-0.508751,0.235465,0.142414,-0.486829,-0.0788147,-0.104246,-0.0442108,0.0646773,-0.338358,0.140943,0.377165,0.190272,0.228984,0.0422985,-0.138343,-0.0751669,-0.0396456,-0.146124,-0.554717,-0.131514,0.233563,-0.00872554,0.128998,0.0138648,0.0595949,-0.730465,0.404731,0.582532,0.328229,-0.00262639,-0.611695,-0.0120243,0.146368,-0.320698,0.179413,-0.389814,-0.397611,0.179018,-0.199149,0.594044,0.385893,0.0612868,0.401863,-0.303605,0.0968342,0.0274,-0.0327092,0.012501,-0.170796,-0.0421244,0.340115,-0.0968586,0.351245,-0.11086,0.272216,0.282106,0.0662682,0.458797,-0.686896,-0.218798,0.536088,-0.103331,-0.0389053,-0.0846852,-0.362499,-0.607314,-0.613322,0.679665,-0.376854,-0.0587463,0.496989,-0.872817,-0.0636623,-0.366125,-0.316421,0.679766,0.325294,-0.503445,1.08609,-0.109931,-0.39308,-0.151659,-0.274529,-0.338377,0.265136,-0.664792,-0.236824,0.52054,-0.29499,-0.0894203,0.154414,0.0603697,0.0951549,0.573951,0.141046,0.58225,0.543419,0.125401,-0.204577,-0.182481,-0.106635,0.466466,-0.371218,-0.180906,0.356241,0.707411,0.678863,-0.0427332,0.249382,0.204303,0.514569,0.286998,-0.717979,-0.0343198,-0.695704,0.412094,0.120309,0.0551503,0.0581094,0.371471,0.0916438,-0.00314792,0.0325566,0.183684,-0.120808,-0.100444,0.319241,0.142821,-0.190592,0.24829,0.458432,-0.0860419,-0.295196,0.143698,0.256974,0.379075,0.506926,-1.3901 +3437.74,1,0.0848144,4,1.53156,0.712309,-1.31806,0.616655,0.607624,-0.1555,0.164326,0.449423,0.229653,0.260833,-0.0707447,-0.22039,-0.120551,0.453359,-0.37612,0.438456,0.457881,-0.0124148,-0.130654,-0.0164221,-0.0520374,-0.546557,-0.36043,0.490613,-0.123555,-0.292725,0.237658,-0.0547182,-0.28861,0.156465,1.07944,-0.295556,-0.311472,0.198077,-0.222495,-0.30678,-0.0673028,0.612756,-0.0362484,-0.770774,0.694287,0.40986,0.464405,-0.645736,-0.256561,-0.76528,-0.822784,-0.302843,0.0135022,0.196184,-0.297078,0.553634,0.225906,0.194983,0.374662,-0.0970595,-0.226267,-0.76531,0.652856,-0.271012,0.291501,1.05723,-0.732966,-1.50577,-0.0663266,0.0346882,0.045503,-0.252692,-0.245073,-0.774918,0.2735,0.133785,0.513194,0.426816,0.409624,0.1505,0.323889,0.56505,0.0611069,0.0399164,0.093557,-0.294233,-0.00650492,0.124474,0.105392,0.102976,-0.356774,-0.120995,0.241329,-0.414925,-0.457019,0.333717,-0.178805,-0.0655049,0.0434729,-0.515874,0.30395,-0.117306,0.37899,0.32072,-0.228013,-0.238347,-0.483487,-0.0746945,-0.41419,0.0969236,0.257534,0.175324,0.113985,0.810846,-0.030529,-0.422495,0.65132,0.396358,0.489284,-0.12511,-0.492884,-0.378749,0.0412097,-0.100504,-0.417904,-0.127118,0.0310953,-0.0516709,-0.688659,-0.374665,-0.304507,0.188421,0.700659,-0.217421,-0.228339,-0.102604,0.247589,0.458544,-0.0591665,0.103158,0.131364,-0.250209,0.687985,-0.0655155,-0.391247,0.00592825,0.010039,-0.0519982,-0.118642,0.168686,0.0837199,0.199448,-0.577466,0.571323,-0.247084,-0.0193167,0.183047,0.412601,-0.095955,0.83624,-0.18739,0.375626,0.113274,-0.364077,0.112927,0.0401989,0.821258,-0.27855,-0.384934,0.0176367,0.317087,-0.00432818,-0.0456244,0.200604,-0.100705,-0.00397332,0.0502398,-0.259707,0.190353,-0.0790666,-0.421126,-0.149267,0.00781911,0.699422,0.336634,0.130822,0.149994,0.0718083,-0.110843,0.23148,-0.087982,0.0081556,0.29782,-0.500603,0.0748545,-0.261802,-0.116029,-0.515797,0.330765,0.137675,0.0982398,-0.153212,-0.632316,-0.116394,-0.0353982,-0.0404258,0.442952,0.107671,-0.0862387,0.147854,0.0956818,0.6447,0.180479,-0.193606,0.430686,-0.431574,-0.0719252,0.292287,-0.8685,0.58131,0.36611,0.24347,0.445948,-0.361529,-0.278165,-0.050229,0.717544,0.131493,-0.245145,0.583262,-1.00476,-0.1131,0.0238962,-0.282546,-0.198697,0.143115,-0.617094,-0.283492,-0.545585,0.291691,-0.283737,0.11661,0.779984,-0.291482,0.077542,0.133407,-0.155773,0.070719,-0.180326,0.0159387,0.713192,0.529252,-0.23354,0.0365415,-0.0807557,-0.141766,0.448316,-0.589514,-0.26285,0.39047,-0.306199,-0.0982072,0.0462281,0.27263,0.800091,0.599608,-0.121755,0.177418,0.915755,0.495258,0.145824,0.495523,-0.137732,0.368077,-0.327864,-0.619738,-0.0393692,-0.072334,0.773041,0.228446,0.0396411,0.379897,0.303535,0.233845,-0.707299,-0.30569,0.226101,0.353482,0.260734,-0.275907,0.184914,0.556137,-0.109459,0.31101,0.13877,-0.169128,0.221272,-0.164348,-0.170079,0.290108,0.212213,-0.251983,0.118109,0.314776,-0.00413029,0.112769,0.209327,0.335811,0.457523,-1.59836 +3441.54,0.947663,0.0848144,4,1.51788,0.803963,-1.31895,0.6429,0.708084,-0.182261,0.214651,0.0222063,0.401698,-0.546305,0.213166,-0.106075,0.219232,0.278555,-0.252475,1.00544,0.0913167,-0.0012649,-0.185594,0.0681788,0.169579,-0.85136,-0.220286,0.268883,-0.108903,0.163005,0.264981,0.374536,0.182565,0.121457,1.17337,-0.765524,0.359794,0.550786,-0.657241,-0.301454,0.123423,0.682176,0.401778,-0.00617406,0.763828,0.718055,-0.289568,-0.79604,-0.307057,0.275737,0.0911572,0.357641,0.0413258,-0.00328385,-0.240504,0.596622,0.203068,-0.504653,0.361077,-0.463342,-0.239011,-0.397819,0.424605,-0.445864,-0.0118498,0.583518,-0.564839,-0.199467,0.230707,-0.256618,-0.216541,0.308286,0.087749,-0.085435,0.0663669,0.334314,0.6329,-0.229344,0.521032,0.402699,0.584382,0.284554,-0.264339,0.139822,0.455556,-0.728894,0.387804,-0.197324,-0.0667635,-0.199096,0.381904,-0.342892,-0.247226,-0.459003,-0.519578,0.17586,0.182461,0.214718,0.35048,-0.917168,-0.251954,0.153611,0.0130623,0.411915,0.710815,-0.507647,-0.535224,0.0871564,0.430086,-0.0997052,-0.115655,-0.316977,0.33958,0.407286,-0.450826,-0.359179,-0.127739,0.207601,0.054026,-0.360078,-0.267554,-0.497341,0.192333,0.320889,-1.0556,0.230121,0.538992,0.0768822,0.167895,0.190935,0.626149,0.110068,0.164868,0.0640883,0.239408,0.0839415,0.284911,0.690873,-0.0414357,0.0601017,-0.0384179,-0.39897,0.122444,-0.298444,-0.455004,0.113845,0.268274,-0.205279,0.0967366,-0.0403056,-0.338515,0.327757,-0.310211,0.11729,-0.624888,0.416122,0.100136,-0.402177,0.430275,0.184265,0.970032,-0.361926,0.374029,-0.398073,0.725278,-0.372318,0.583259,0.124462,0.102961,-0.0449113,-0.0173531,-0.286411,0.249494,-0.283554,0.118221,0.112989,-0.215016,0.173897,-0.099465,-0.360612,-0.462974,0.150605,0.0651045,1.00498,0.0331621,-0.0440059,0.00065841,-0.133226,0.00010472,-0.403304,-0.305843,-0.100246,-0.033766,-0.252825,0.118062,-0.138514,0.0138708,-0.170341,0.223936,0.289092,0.326671,-0.334905,-0.575491,0.0568943,-0.0198006,-0.0469104,-0.079116,-0.204875,0.162776,-0.371044,-0.583916,0.703834,0.412394,0.438975,-0.421118,-0.250599,0.339136,0.0703462,-0.00284559,0.409738,-0.383384,0.132656,-0.0792364,0.152883,0.195894,0.0402998,-0.0206484,0.0999863,0.0804452,0.541649,-0.0594642,0.407384,-0.420366,0.225754,0.281387,-0.217626,0.11712,0.106745,-0.353726,-0.0077827,0.049471,0.458884,0.230148,-0.328629,0.00912218,-0.179175,0.188534,-0.0366583,0.328705,0.588286,0.837087,0.126385,-0.111266,-0.147478,-0.0405769,-0.754781,0.473686,0.0342292,-0.44787,0.338918,-0.49547,0.919765,-0.191707,-0.00210583,-0.631783,0.197116,0.0734878,0.355989,-0.473894,-0.0675569,-0.406578,0.172793,0.178281,0.0556963,-0.4724,0.187524,-0.37682,0.102392,0.272115,-0.321787,0.37482,-0.500953,-0.469707,0.279559,0.0855113,-0.227976,-0.17599,0.221565,-0.102122,0.0567533,0.0667522,0.43746,0.0357044,-0.416461,-0.0814451,0.33726,0.237902,0.340015,-0.0543694,-0.502293,-0.00153024,0.526975,0.222111,0.0790595,-0.246137,0.130485,0.165746,0.361228,0.407119,-2.12531 +3420.02,0.916687,0.0848144,4,1.38832,0.852142,-1.60011,0.691939,0.63967,-0.0504529,0.164752,-0.298242,0.201994,0.206954,0.0422106,0.20692,0.117066,0.303651,0.00513287,0.807305,0.207178,-0.25205,-0.310752,0.00137722,0.269692,-1.14877,-0.143413,0.205208,-0.099622,-0.253815,0.329366,0.578535,-0.0140049,0.335584,0.829327,-0.171256,0.48305,0.558712,-0.399816,-0.0823981,0.0357468,0.869252,0.486216,-0.277882,0.77231,0.70048,-0.448149,-0.606947,-0.340712,0.51849,-0.366014,0.508155,0.381107,0.112893,-0.277814,0.784732,0.309081,0.279193,0.362926,-0.623058,-0.28558,-0.409823,0.698532,-0.281248,0.0960147,1.05052,-0.525499,-0.899916,-0.0535334,-0.369641,0.0234133,0.346379,-0.245996,-0.343019,-0.0102333,0.351304,0.928161,0.309021,0.640978,0.562409,0.688964,-0.192123,-0.387275,-0.204346,0.757702,-0.413277,0.532702,-0.376791,0.268655,0.486427,-0.107179,-0.373975,-0.137038,-0.633217,-0.469061,-0.102602,0.285191,0.264898,-0.15698,-0.446678,-0.0535055,0.880926,0.0951634,-0.0825955,0.00711587,-0.0354509,-0.066929,-0.0122696,0.841998,-0.475865,0.137606,-0.495241,0.452867,0.980875,0.646018,-0.602541,-0.0456036,0.168212,0.0695667,-0.0679304,-0.619293,-0.259793,0.217941,0.276651,-0.438199,-0.0152464,0.285797,0.115291,0.455859,0.587878,0.217301,0.120588,-0.058867,-0.277384,-0.0944173,0.024972,0.145898,0.136026,0.219299,0.37909,-0.167436,0.0347555,0.140548,-0.77159,-0.384139,0.15384,0.171466,0.0168311,0.358796,0.167583,-0.0905689,0.268787,-0.27927,-0.244123,-0.42578,0.207435,0.0591326,-0.182288,-0.0305942,0.368186,0.646609,-0.201468,0.301698,-0.212163,0.567131,-0.188067,0.74334,0.089349,-0.40486,-0.210329,0.292037,-0.0589398,0.187947,-0.658185,0.489659,0.180833,-0.0439249,0.000391279,0.16017,-0.559055,-0.266566,0.0822171,0.551874,0.942422,-0.287121,-0.211312,0.376632,-0.0519591,0.0989906,-0.241805,0.416132,-0.0142801,-0.33113,-0.594358,-0.195688,-0.0375573,0.383244,-0.347767,0.313136,0.693359,-0.601038,-0.263481,-0.191643,-0.153234,0.174683,-0.0760314,0.173614,0.0964367,-0.207938,-0.0703692,-0.24801,1.15969,0.154273,0.440286,0.123164,0.130475,0.0176041,0.195052,-0.22614,0.403423,-0.17299,0.162319,0.15828,0.141334,-0.16614,-0.427493,-0.324668,0.205874,-0.500976,0.517195,-0.274928,0.0586705,-0.187595,-0.0419558,-0.242322,-0.151884,0.183193,0.0439765,-0.462668,0.0889788,-0.720781,0.406846,0.583621,-0.48898,0.103198,-0.383798,0.361263,0.584897,0.42144,0.60774,0.465767,0.256949,0.0505416,0.00591147,0.492536,-0.873615,0.423472,0.243728,-0.562969,0.273726,-0.123087,0.539413,-0.30431,0.0230309,-0.2371,0.134863,0.730257,0.0479498,0.282428,0.0644798,-0.0377631,-0.205821,-0.115136,-0.0523654,-0.20051,-0.39673,-0.0035711,-0.108979,0.0282347,0.0564016,0.313185,-0.542625,-0.243158,0.169525,0.171736,0.177244,-0.788112,-0.0425986,-0.386937,0.0999089,-0.208835,0.611566,0.154648,0.377925,-0.0173113,0.378608,0.0648103,-0.0206319,-0.177361,-0.417305,-0.0994817,0.296264,-0.152491,0.563553,-0.711065,0.121824,0.200453,0.349033,0.44772,-2.04467 +3439.44,0.935551,0.0848144,4,1.50674,0.860357,-1.28619,0.588044,0.67483,0.0228665,0.0380049,-0.436654,0.336885,0.334142,0.277965,0.133886,-0.154922,0.379502,-0.297428,0.736169,0.222361,-0.0800347,-0.300098,0.25635,0.0247924,-0.697042,-0.346945,0.192441,-0.0330897,-0.470745,0.0267214,0.842766,-0.343042,0.314987,0.808489,-0.287598,0.425844,0.414108,-0.6219,0.0386202,-0.229344,0.757408,0.395005,-0.13109,0.887371,0.81694,0.115103,-0.848016,-0.113937,0.600405,-0.327381,0.416355,0.309838,-0.169185,-0.289795,0.870575,0.161037,-0.0509332,0.492572,-0.359699,-0.215404,-0.375168,0.499109,-0.0837518,0.222056,0.927268,-0.559587,-0.619482,0.212262,0.0606262,-0.0793431,-0.329766,-0.0693281,-0.419516,-0.208738,0.563153,0.579848,0.610846,0.88175,0.171576,0.568038,0.152386,-0.214144,0.179463,1.02767,-0.264629,0.628876,-0.129565,0.408443,0.551144,-0.0704327,-0.0902834,-0.0782111,-0.598257,-0.0870612,0.720872,-0.262441,0.4122,-0.398022,-0.15487,-0.0385806,0.0241473,0.100884,0.45022,-0.310347,0.0116992,0.128058,-0.276737,0.274374,-0.300892,-0.16281,-0.314627,0.628861,0.799675,0.181037,-0.354762,0.0839382,0.33055,0.496575,-0.273814,-0.493608,-0.1658,0.346297,0.351267,-0.181167,0.157159,0.449509,0.222264,0.0745761,0.304578,0.285283,-0.111519,0.496217,-0.572758,-0.170056,-0.139822,-0.477771,0.18242,-0.248327,0.541469,0.493203,-0.227323,0.173923,-0.456248,0.193691,0.0147431,0.300699,-0.711206,0.030667,0.368219,0.0580383,0.333438,-0.0247755,0.125277,-0.405327,-0.129982,-0.0498671,-0.23556,0.352556,0.207936,0.260958,-0.00710383,0.345569,0.127427,0.200117,0.112705,0.846367,0.122565,-0.765988,-0.183219,-0.0262226,-0.358743,0.345848,0.107629,0.427048,-0.417067,-0.360951,0.225962,-0.184385,-0.0790718,-0.202123,0.188388,0.613276,0.722463,-0.285149,-0.0469695,0.0921228,-0.013561,0.293304,-0.252355,0.120036,0.165609,-0.450119,-0.488756,-0.0667942,-0.110714,0.193234,-0.819429,0.280894,0.74627,-0.172337,-0.28991,-0.642702,-0.368207,-0.0339975,0.158346,0.448795,-0.294319,-0.00693605,0.0894268,-0.383331,1.09272,0.00485776,0.453123,-0.121391,0.0902405,0.126394,0.333826,0.115347,0.204716,-0.314679,0.231932,-0.034012,-0.0164003,-0.050304,-0.198414,0.643385,0.398879,-0.234414,0.377576,0.159772,-0.177756,0.190795,-0.405978,0.351776,-0.069616,0.0309619,0.103667,-0.273571,0.102367,-0.483786,-0.149816,0.550019,-0.858026,0.337924,-0.356478,-0.119305,0.590098,0.641727,0.037201,0.104805,-0.0216294,-0.157218,-0.0556393,0.471075,-0.922351,0.404212,0.0443032,-0.60957,0.132155,-0.575671,0.438955,-0.441034,-0.11869,-0.0892841,0.532011,0.741604,0.276251,0.449312,0.0937184,0.163191,-0.21833,0.0975576,-0.0186434,0.132634,-0.632125,0.169887,-0.174154,-0.0265073,0.0895975,0.224349,-0.192344,-0.147864,0.312685,0.0514662,-0.0170889,-0.377149,0.096068,-0.384432,0.0660004,0.442498,0.349182,-0.0070896,0.318696,-0.237483,0.400222,-0.060474,0.435481,-0.368234,-0.109543,-0.162719,0.149147,-0.180445,0.185847,-0.236791,0.139822,0.195934,0.373928,0.442644,-2.14223 +3444.07,0.917255,0.0848144,4,1.48014,0.970647,-1.44629,0.562706,0.60083,-0.183352,0.200771,-0.469975,0.516397,0.386707,-0.0190956,0.290392,-0.000721624,0.14283,-0.623617,0.784497,0.477291,-0.262248,-0.298929,-0.286651,-0.136464,-1.09569,-0.318289,0.0721631,-0.249327,0.0555716,-0.252113,0.230554,-0.218151,0.277887,0.807987,-0.504943,0.00196432,0.462366,-0.417623,0.0224988,-0.110756,0.751149,0.708704,-0.170203,1.03736,0.647776,0.29199,-0.803831,-0.283916,0.382328,-0.25839,0.507275,0.611876,0.214787,-0.124919,0.332759,-0.0456182,-0.721421,0.381331,-0.520538,0.19249,-0.785055,0.355455,-0.69566,0.295193,0.873173,-0.044691,-1.17673,0.327361,0.360375,0.181178,-0.170987,0.240385,-0.725084,-0.48614,0.621983,0.409158,0.304365,0.755835,-0.0491032,0.560428,-0.342265,-0.307963,-0.0530356,0.494782,-0.327783,0.173738,-0.0703684,0.0523455,-0.196967,-0.600961,0.354926,-0.552291,-0.431862,0.153319,0.0684815,0.0183896,0.109461,-0.0729784,-0.106416,0.101461,0.0791155,-0.125604,0.0516649,-0.668548,0.137679,-0.430643,0.0250855,-0.0715447,-0.102213,-0.153116,-0.406073,0.348686,0.999325,0.214672,-0.327275,0.340471,0.213574,0.200785,-0.0632699,-0.294321,0.08186,0.969085,0.0925519,-0.101263,-0.233375,-0.0083081,-0.129899,-0.17368,0.537898,0.36174,0.0865156,-0.119265,-0.401437,-0.0437687,0.203224,0.00844871,0.390911,-0.436927,-0.209153,0.16905,-0.222647,0.0776163,-0.326122,-0.760661,-0.172892,0.482829,-0.602602,0.232365,0.094994,-0.269957,0.311321,-0.0693616,0.74717,-0.12065,0.287759,-0.188436,-0.343777,0.00976296,0.252852,0.160349,-0.171031,0.144293,0.0272486,0.305535,-0.176068,0.64642,-0.456566,-0.0746227,0.360245,-0.0958121,0.0253589,0.0116625,-0.0804897,0.00498815,0.211603,-0.173365,0.313313,-0.325708,-0.350301,-0.195223,0.182159,0.27374,0.725189,-0.671997,-0.20118,0.174662,-0.114098,-0.0390024,-0.458422,-0.0484673,-0.271818,-0.310819,-0.206398,0.126795,0.114579,0.0656674,-0.613012,-0.0379305,0.298055,0.489382,-0.257041,-0.246191,-0.114193,0.0595182,-0.238172,0.230119,0.433242,0.0552389,0.241959,-0.805117,0.876574,0.19954,0.148101,-0.0762641,-0.192254,-0.0890051,0.305796,-0.491271,0.545754,0.13271,-0.16462,0.258328,-0.795666,0.242963,-0.658519,-0.434415,0.498014,-0.978948,-0.0218146,0.202023,-0.425282,0.593891,-0.146445,0.0358276,-0.219623,-0.0944153,0.159723,-0.561812,0.385576,-0.0427539,0.164137,0.695223,-0.435179,-0.297456,-0.0270416,-0.601452,0.856116,0.507714,-0.0611765,0.30542,-0.101815,0.407104,-0.53054,-0.361988,-0.248447,0.181747,0.00477172,0.0917234,0.024393,-0.144931,0.033308,-0.559335,0.148449,0.0958908,0.299424,-0.326043,-0.200288,0.415365,-0.0891147,0.144988,0.678997,-0.0759606,-0.0467444,0.162345,-0.198641,0.387125,-0.187944,0.152018,0.215333,-0.298378,0.241384,0.166289,0.347857,0.221117,-0.28647,-0.0534385,0.124168,-0.00386767,-0.29573,-0.139587,0.539368,0.0607937,0.513528,-0.0282198,-0.0342708,-0.519994,0.494092,0.0258482,-0.734645,-0.0632657,0.238962,0.156553,-0.126113,0.0839197,0.125441,0.216193,0.354176,0.464966,-1.95845 +3447.23,0.890229,0.0848144,4,1.51922,0.873111,-1.39247,0.603465,0.938021,-0.138301,0.183885,-0.293666,0.219918,-0.082994,0.321542,-0.165326,-0.49346,0.235131,0.53519,0.587911,-0.100838,0.160128,0.0433205,0.120897,-0.435178,-0.309767,-0.63819,0.202619,-0.52696,0.187027,0.327199,0.634236,-0.790827,0.228543,0.732989,-0.436282,0.43351,0.492756,-0.524089,-0.379791,-0.110897,0.721846,0.689292,-0.164622,0.879997,0.783018,0.550623,-0.56719,0.0558849,0.939842,-0.505731,0.0436966,0.207014,0.000615432,-0.181841,0.699221,0.26346,0.382731,0.373389,0.119155,-0.27449,-0.670778,0.301235,-0.412887,0.417715,0.980476,-0.321344,-0.575314,0.226855,0.0530816,0.200714,-0.0862764,-0.320187,-0.444316,-0.0818441,0.0394203,0.44785,-0.847831,0.39733,0.361128,-0.0490897,0.623378,-0.228188,0.154098,0.0674934,-0.578938,-0.00210925,-0.15454,-0.288993,-0.0186104,0.563672,-0.170031,0.302993,-0.144466,-0.224404,-0.179405,-0.351546,0.176357,0.0740205,-0.155018,0.135448,-0.297616,0.217432,0.158404,0.55392,0.00865945,0.00517419,-0.276649,-0.0500625,-1.01216,0.0540666,-0.198319,-0.194239,0.222461,0.012444,0.0214839,-0.333761,0.296873,0.0741811,0.0400204,-0.293156,0.217012,-0.726282,-0.0574565,-0.75366,0.029326,-0.173443,-0.254067,-0.187851,0.259975,0.236699,-0.00948379,0.191899,-0.720526,0.234027,-0.377584,-0.386174,0.30322,-0.151878,0.253759,0.000294304,-0.374779,0.742087,-0.252171,-0.0535281,0.121941,-0.0244113,-0.498903,-0.1937,-0.161659,0.411101,-0.0427969,-0.135582,-0.829691,0.0562155,-0.282676,0.32882,-0.000189059,0.430348,0.0301171,-0.0424297,-0.117077,-0.26159,0.00407251,0.0731383,0.0707267,0.578033,0.0701997,0.154451,0.117984,-0.0998386,0.0264745,0.0384292,0.219221,0.128935,-0.0387136,-0.200537,-0.138355,-0.0351847,0.109786,-0.0996721,-0.110502,0.131808,0.757033,0.240283,0.100813,0.168654,-0.343286,0.153222,-0.180509,-0.614232,-0.636363,0.318038,-0.658118,-0.528228,-0.629223,-0.0865986,-0.456232,0.0815538,0.101386,-0.523399,0.131258,-1.0532,0.0358712,-0.155468,0.0495234,-0.185327,-0.0936601,-0.32116,-0.203002,-0.132924,1.03108,-0.122451,-0.406205,-0.205186,0.239424,0.394723,-0.385865,0.10297,-0.21056,-0.207471,0.216782,0.103129,0.156411,-0.255554,-0.0558406,0.0488663,0.240803,0.267698,0.351481,-0.455223,-0.0928027,-0.159261,0.0861862,-0.581169,0.0731346,0.0291408,-0.509138,0.283039,0.457188,0.40216,-0.191871,0.458731,-0.0897325,0.229199,0.225744,0.331293,-0.204662,0.164377,0.370752,0.434274,0.069189,-0.0499906,0.0767457,0.309999,-0.461291,0.213906,-0.262509,-0.159473,0.090539,-0.170694,-0.139086,0.754997,0.0700702,0.339588,0.120171,0.0164693,0.576742,0.35981,0.2535,0.153753,-0.550343,0.285319,-0.149717,-0.167503,-0.382495,-0.752656,0.160469,0.119533,0.176867,0.170323,-0.264988,0.225832,-0.407685,-0.112669,0.247871,-0.258306,0.142137,-0.305843,0.219829,0.393963,0.197387,0.0355701,-0.131965,0.0143324,-0.0445,0.203658,0.0111988,0.0780822,0.400639,-0.101745,-0.293921,-0.585745,0.30148,0.0485291,0.109628,0.246866,0.331101,0.496856,-2.94453 +3454.93,0.99474,0.0848144,4,1.52594,0.867291,-1.45864,0.615772,1.09974,-0.149715,0.21967,-0.102172,0.0693169,-0.156241,0.33754,-0.215616,-0.368373,0.415019,0.512288,0.647749,-0.012194,0.0562901,0.0937914,0.0493891,-0.310999,-0.295834,-0.414765,0.0797597,-0.453248,0.410334,0.362478,0.726949,-0.564916,0.266926,0.781535,-0.400373,0.400194,0.584808,-0.498404,-0.529759,-0.136434,0.721183,0.781903,-0.0723189,0.821149,0.690898,0.499607,-0.603618,-0.0262498,0.908934,-0.551691,-0.217164,0.274998,0.179031,-0.147663,0.879159,0.22864,0.467985,0.476518,0.096344,-0.16614,-0.836314,0.364653,-0.543773,0.334721,0.921332,-0.127947,-0.584386,0.245546,0.0704911,0.293904,-0.223275,-0.226423,-0.548474,-0.213752,0.195807,0.538474,-0.718653,0.355936,0.558279,-0.0318606,0.577775,-0.13586,0.172695,0.0761782,-0.386874,0.0125582,0.0818403,-0.323049,0.0478139,0.548448,-0.107659,0.309012,-0.236331,-0.00873082,-0.424053,-0.345357,0.149591,0.0974467,-0.00736307,0.0436119,-0.167155,0.284305,0.204968,0.432025,0.0695105,-0.0478208,-0.410636,0.00779733,-0.837477,0.123302,-0.231718,-0.251727,0.218819,0.116169,-0.0598106,-0.121841,0.263401,0.163343,-0.0572449,-0.347827,0.3309,-0.706225,-0.0385651,-0.952117,0.421655,-0.355223,-0.299562,-0.355454,0.238458,0.263053,0.0158164,0.165342,-0.469842,0.282069,-0.229379,-0.226512,0.270143,-0.188826,0.22694,-0.0609052,-0.353234,0.802479,-0.350171,-0.227525,0.0651576,-0.225912,-0.551208,-0.0362659,-0.176552,0.564499,0.108358,-0.214072,-0.828877,-0.140115,-0.131325,0.497298,0.184436,0.340242,0.216423,-0.0947855,-0.0441309,-0.143443,0.0405213,0.088686,-0.00200684,0.494704,0.273287,0.0686942,0.101717,-0.171536,-0.0510639,-0.126804,0.279565,0.15066,-0.196413,-0.0918093,-0.0415522,-0.09301,0.157713,-0.0985687,-0.261618,0.242797,0.816511,0.1786,0.163321,0.0483843,-0.238205,0.0939151,-0.127251,-0.460444,-0.68913,0.289249,-0.626002,-0.467113,-0.599485,0.177879,-0.394468,-0.0794252,0.0532022,-0.705934,0.0430696,-1.01754,0.190168,-0.00750514,0.0337938,-0.222007,-0.0317083,-0.229757,-0.100551,0.0868783,0.900371,-0.160062,-0.26331,-0.195715,0.289467,0.205921,-0.365707,0.0278678,-0.0883796,-0.171704,0.262745,-0.0153799,0.321304,-0.215221,-0.0148376,0.122155,-0.0232954,0.0710976,0.437457,-0.427937,-0.0130154,-0.27515,0.0996193,-0.404433,0.0221511,0.0134566,-0.381288,-0.0840826,0.538984,0.162144,-0.201726,0.317812,-0.0327108,0.0512818,0.546882,0.0992762,-0.162801,0.163679,0.542297,0.352304,-0.0762966,-0.295089,-0.069982,0.0547731,-0.412775,0.346285,-0.187135,0.110492,0.0641162,-0.0963008,0.0159968,0.497757,0.138668,0.217809,0.117837,0.13949,0.439236,0.677936,0.313884,0.112342,-0.478726,0.0509199,-0.461979,-0.121867,-0.040395,-0.627957,0.140608,0.22581,0.074636,0.168864,-0.326918,0.102331,-0.318868,-0.135833,0.199685,-0.397982,0.0597384,-0.180735,0.0382501,0.357112,0.156554,-0.163048,-0.20582,0.12454,-0.0709758,0.157612,-0.185766,-0.0591605,0.484268,0.0705697,-0.157471,-0.473556,0.315549,0.113358,0.1027,0.268551,0.320469,0.518219,-3.43844 +3445.59,0.995028,0.0848144,4,1.53163,0.752454,-1.57253,0.706437,1.14549,-0.0985853,0.165757,-0.0967143,0.0666773,-0.0278904,0.556861,-0.20447,-0.464084,0.22572,-0.199,0.36748,0.0035213,-0.154372,0.219833,0.361432,-0.085161,-0.471881,-0.881246,0.544146,0.0572445,0.418032,0.0867591,0.640071,-0.179748,0.00666682,0.86867,-0.11477,0.349175,0.852843,-0.342501,-0.738185,-0.412553,0.625156,0.67504,-0.0665251,0.696517,0.573869,0.30466,-0.822421,-0.0437458,0.501401,-0.503254,-0.137711,0.104556,-0.0372082,-0.149953,0.994356,0.0527564,0.213359,0.333753,-0.403927,-0.038451,-1.14971,0.280905,-0.566978,0.248165,1.09678,-0.554691,-0.69095,-0.237968,0.0766948,0.120908,0.00733073,0.178201,-0.383746,-0.460493,0.286213,0.363064,-0.411887,0.361737,0.479749,-0.180021,0.507616,-0.187596,0.322524,0.169069,-0.390421,0.149083,0.353139,-0.231616,0.249521,-0.10724,0.218628,0.138463,-0.40025,0.0689306,-0.215206,-0.220136,0.146413,0.403215,0.541317,0.304407,-0.187289,0.57101,0.245799,0.232402,0.405746,0.0716501,0.237554,0.343859,-0.414645,0.523047,0.0278928,0.0798514,0.559379,0.579842,0.0668396,0.0513358,0.366587,0.336451,0.348802,-0.0144209,0.0707253,-0.0997797,-0.117356,-0.544996,0.244149,-0.725177,-0.317944,-0.444264,0.218051,0.219098,-0.109495,0.310556,-0.143198,0.366635,-0.430674,-0.416365,0.369695,-0.106085,0.408534,-0.132058,-0.805734,0.510705,-0.278582,-0.306176,0.109919,-0.161042,-0.400613,-0.022116,0.028634,0.568087,0.622839,0.0676269,-0.308153,-0.00955739,0.0963048,0.191216,0.306819,0.138897,0.187122,0.0957946,-0.223818,0.014516,-0.383135,0.0577316,0.0812984,0.637147,-0.121498,0.28015,0.272121,-0.0395804,-0.200928,-0.154747,-0.221877,0.236051,-0.577738,0.0746584,-0.218414,0.25232,0.345273,-0.0458321,-0.473207,0.067144,0.590741,-0.320265,-0.0335819,-0.0650923,-0.205105,0.387737,-0.212597,-0.615998,-0.207733,0.592791,-0.522698,-0.1717,-0.0932518,0.103081,-0.388441,0.458798,0.0198405,-0.127152,-0.109655,-0.462245,0.157392,-0.212743,-0.26356,-0.319678,-0.004293,-0.376989,-0.0623797,-0.0556577,0.955148,-0.167226,-0.265715,-0.110364,0.30355,0.374842,0.110085,-0.073154,0.261062,-0.506346,0.37909,-0.0221546,0.31123,-0.20405,-0.105851,0.377104,0.308236,0.158275,0.686899,-0.328642,0.0490423,-0.76206,0.0309748,-0.380365,0.119316,-0.388303,-0.440661,-0.156704,0.666772,0.402527,-0.566459,0.362362,-0.0152947,0.118008,0.65127,-0.0486828,-0.422998,-0.113843,0.103131,0.120376,-0.142147,-0.268335,-0.146416,-0.225098,-0.269551,0.2784,-0.152518,0.0101029,0.136529,-0.143568,0.104352,-0.0269819,0.0387738,-0.0269537,0.0737264,0.103987,0.291942,0.418015,0.422979,-0.123125,-1.03077,0.132782,-0.292474,0.0351194,-0.0076158,-0.277503,-0.454845,0.345991,0.13048,0.447808,-0.0995125,0.473125,-0.162465,0.0524322,0.129366,-0.247358,0.137844,-0.255648,0.314708,0.338839,0.0358457,0.00111052,-0.528077,0.0078559,0.552659,0.00319396,0.00946441,0.187761,-0.0632598,-0.372819,-0.0922477,-0.500136,0.903999,0.394212,0.105596,0.190377,0.324955,0.436322,-3.42052 +3429.41,0.884976,0.0848144,4,1.52869,0.630703,-1.80768,0.848351,0.704096,-0.117446,0.326985,-0.154856,0.601831,-0.0131734,0.234574,0.047404,-0.541249,0.568497,-0.0937611,1.02196,0.406598,0.00707844,-0.156831,0.0725768,0.273324,-0.616869,-0.513577,0.771228,-0.298657,-0.150315,-0.408616,0.58262,-0.654436,0.269992,0.865168,-0.321966,-0.104088,0.591974,-0.174494,-0.165871,-0.628786,0.681303,0.336957,-0.702063,1.2437,0.363744,-0.253303,-0.323258,-0.334507,0.122364,-0.338963,-0.068983,0.179035,0.417556,-0.117937,-0.0132746,0.134169,-0.179095,0.38055,-0.168961,-0.160593,-0.8563,0.49013,0.0388753,0.18425,0.941558,-0.474367,-0.782704,0.46682,-0.0707636,-0.219041,-0.14417,-0.00306767,-0.463592,-0.0307103,0.0787935,0.399235,0.357799,0.738552,0.293117,0.61448,-0.272895,-0.492971,0.292835,0.366695,0.150786,0.0571281,-0.390366,0.651409,0.422306,-0.299439,0.0636935,0.514603,-0.184814,-0.120342,0.273167,-0.315012,-0.262398,-0.100155,0.353878,-0.0974314,0.178395,0.254427,-0.0287877,0.209076,0.242971,-0.601235,-0.617987,-0.0875972,0.100038,-0.0186647,-0.133221,0.411512,0.258697,-0.445409,-0.604649,0.603316,0.298442,0.225352,-0.24716,-0.559806,-0.159415,-0.466234,0.589819,-0.451743,0.0846913,-0.477486,-0.27354,0.168089,-0.00617454,0.11925,-0.372955,0.296428,-0.571643,0.314737,0.197146,0.146361,0.357888,-0.0725946,0.318505,-0.270998,-0.631178,0.2401,-0.51103,0.0775262,-0.18907,0.298414,-0.093297,0.155197,-0.276368,-0.0677845,0.193894,0.047091,-0.70288,-0.447751,0.206756,0.0776072,0.212298,0.535887,0.126898,0.027728,0.295696,-0.43528,-0.120581,0.0325792,-0.258198,0.955371,0.064434,0.251531,0.525231,0.0123766,-0.161975,-0.319184,0.514138,0.167469,-0.167333,-0.244906,0.0734108,-0.0736664,0.0762997,-0.263754,-0.212051,0.100755,0.622189,0.404711,-0.360598,-0.0214447,-0.0478495,0.0757988,-0.254873,-0.235269,0.0860471,0.0391683,0.178056,-0.0890763,0.27071,-0.0614871,-0.235287,0.264737,0.447712,0.182969,-0.291025,-0.552221,-0.159549,0.021426,-0.716169,-0.265805,-0.0651514,0.141056,-0.402592,-0.498434,0.955964,-0.745841,-0.382298,0.226026,-0.158218,-0.0746213,-0.289149,-0.755183,1.03694,0.097399,-0.136783,0.413551,0.175325,-0.0188425,-0.216276,-0.0473249,0.244498,-0.294112,0.412292,-0.372566,-0.135368,0.635637,0.239798,0.0391046,-0.112327,0.129426,-0.263752,0.201956,0.288119,-0.129405,0.160959,0.745046,0.204353,-0.638758,0.0266435,-0.203718,-0.206302,0.243561,0.62976,0.595879,0.35551,0.660096,-0.492513,0.147859,-0.535552,0.0662259,-0.0981181,-0.249643,-0.0170559,-0.390084,0.27875,0.0607357,-0.0107709,-0.0373048,0.519936,0.321304,-0.160941,0.211889,-0.180865,0.229156,0.46614,-0.118836,-0.174678,-0.310061,0.260703,0.218233,0.365629,0.26429,0.697401,-0.435748,0.753371,0.488533,0.243382,0.163543,-0.100748,-0.112909,0.841709,0.382083,0.00572016,-0.137455,0.915112,0.290669,0.178617,0.00125723,-0.0413576,-0.162981,-0.115426,-0.450779,-0.849935,0.0799346,-0.206303,-0.385599,-0.979972,-0.440118,0.107537,0.27929,0.327928,0.528479,-1.74921 +3437.03,0.956318,0.0848144,4,1.53417,0.71833,-1.37791,0.612618,1.07272,-0.0654627,0.0960617,-0.181701,0.166236,-0.1026,0.360174,-0.130193,-0.313328,0.141289,-0.263864,0.404163,0.350525,-0.260136,0.0145712,-0.0703362,0.149509,-0.440621,-0.467168,0.590158,-0.202454,-0.130343,-0.225135,0.573791,0.0221919,0.108541,0.791482,-0.123048,0.100643,0.434766,-0.308337,-0.0538554,-0.51406,0.819329,0.158006,-0.350435,1.20998,0.229096,-0.273969,-0.579849,-0.585963,0.0625256,-0.505245,-0.254859,-0.0461252,-0.122036,0.081823,0.266414,-0.0620341,0.00474313,0.701584,-0.153426,-0.0883902,-0.775777,0.886428,0.306968,-0.0771823,0.924328,-0.355803,-0.645572,0.344734,0.19473,0.0562564,-0.329684,0.446529,-0.205709,0.0150052,0.46448,0.580822,-0.0963262,0.686426,0.354157,0.600336,-0.0226663,-0.0084626,0.0109633,0.585802,0.0389911,0.170581,-0.358866,0.14966,0.0838257,-0.378573,-0.254231,0.00110959,-0.2607,0.0236292,-0.0887313,-0.246121,-0.00351707,-0.229435,-0.196362,0.108922,0.0510813,0.0521882,0.197595,-0.0599657,-0.0761681,-0.318242,-0.703944,-0.0483627,-0.00576356,0.318954,-0.0727227,0.257246,0.502311,-0.329424,-0.0622773,0.317707,0.321292,0.175357,-0.0340045,-0.421287,-0.225061,-0.0549962,0.265514,-0.763354,-0.0345647,-0.0406019,0.140666,0.177003,0.142577,-0.325726,-0.26331,0.382171,-0.43031,0.0876083,0.172737,0.0926582,0.557729,-0.192592,0.28566,-0.228551,-0.360321,0.160618,-0.26924,-0.781944,-0.111138,0.293524,0.199499,0.437855,0.00731308,0.278047,0.343008,0.202725,-0.614248,-0.427354,0.466268,0.273513,-0.215246,0.756722,0.268124,-0.335378,0.358176,-0.324549,0.0588309,-0.0737746,-0.320312,1.04587,0.25097,0.459706,0.572408,-0.0191462,-0.42619,-0.0600596,0.364974,-0.098873,-0.390948,-0.147224,-0.327532,0.269619,-0.109381,-0.341083,-0.586248,0.385289,0.906111,0.404945,-0.0247815,-0.417267,-0.0566913,0.176119,-0.0750548,0.00835203,-0.0415025,-0.132998,0.226917,-0.0976403,0.21918,-0.00914947,-0.257276,0.276479,0.690591,0.00573866,-0.0604265,-0.516711,0.270966,-0.254912,-0.771871,-0.257835,0.463122,-0.380282,-0.498837,-0.633879,1.19517,-0.604077,-0.430173,0.111581,-0.265572,0.291094,0.0477749,-0.494698,0.291621,0.170007,-0.000924418,0.621337,0.203077,0.342254,-0.282478,0.127473,0.329831,-0.130502,0.292771,-0.219621,-0.00805686,0.384683,0.128379,-0.0625152,-0.00181727,0.45104,-0.294598,0.150066,0.37165,-0.0106011,0.0937283,0.315402,-0.286056,-0.379108,0.567446,-0.11565,0.0462523,0.66618,0.618716,0.505347,0.0908219,0.626358,-0.305461,-0.105391,-0.668822,0.184061,-0.0761989,-0.408518,0.203119,-0.414459,0.226764,0.201751,-0.0812586,-0.224803,0.524758,0.401168,-0.398345,-0.0705932,-0.149753,-0.123342,0.090356,0.0519523,-0.0655613,-0.451275,0.115396,0.134763,0.292705,0.185583,0.315514,-0.53325,0.222144,0.384212,0.120338,-0.0348669,-0.770504,0.180072,0.592696,0.0808281,-0.215444,-0.311631,0.983656,0.255434,0.0193651,-0.0207621,-0.0328973,0.141285,-0.284869,-0.613776,-1.03422,0.22643,-0.290359,-0.128301,-0.393161,-0.619545,0.133372,0.179431,0.365202,0.423592,-3.13764 +3438.37,0.956887,0.0848144,4,1.53828,0.817693,-1.30457,0.55813,0.649998,-0.0493611,0.359364,-0.314195,-0.0032612,0.105882,0.0671604,-0.0996993,-0.301509,0.491833,-0.169005,0.77135,0.0283726,-0.307775,-0.207533,0.194259,-0.0468978,-0.597011,-0.398021,0.397618,-0.193095,0.0498649,-0.300777,0.583169,-0.191605,0.21798,0.696233,-0.209346,0.427978,0.553392,-0.236504,-0.251343,-0.0925624,0.553007,0.201006,-0.215702,1.23518,0.362271,-0.0572191,-0.511743,-0.298151,0.167235,-0.4922,-0.0517804,0.0232805,0.0791397,-0.10608,-0.149694,-0.0576574,0.21524,0.527217,-0.556282,-0.052646,-0.384455,0.723482,0.237194,0.480539,0.977423,-0.477512,-0.453409,0.0783915,0.0906235,-0.113278,0.00476096,0.459643,-0.102427,0.105405,0.266189,0.615078,-0.229296,0.339314,0.247576,0.329361,0.0907211,0.153384,-0.0734744,0.394911,-0.185897,0.150401,-0.308922,-0.00412296,0.396604,0.0347602,-0.0656068,-0.309816,-0.533363,0.163084,-0.0792125,-0.21327,-0.0163186,-0.107297,-0.315034,-0.0469589,0.136275,-0.137998,0.158482,0.284053,-0.18481,-0.037608,-0.867973,0.111485,-0.14127,0.554445,-0.0501428,0.386952,0.595591,-0.201033,-0.257584,0.331658,0.170374,0.0745912,-0.017462,-0.5949,-0.229379,-0.108854,0.212448,-0.663916,0.0385353,0.206193,-0.15386,0.0457084,0.291157,-0.708383,-0.131431,0.611023,-0.724919,0.282444,0.10166,0.38668,0.37618,-0.162955,0.276437,0.265453,-0.432933,0.224015,-0.389351,-0.683977,0.0670707,0.119404,-0.326878,0.661311,-0.0703673,0.0917624,0.235963,0.057578,-0.812532,-0.345174,0.391046,0.208455,0.139746,0.846952,0.32286,-0.372585,0.273662,-0.434572,-0.00648198,-0.0609234,-0.216602,1.10205,-0.0452309,0.490061,0.526961,0.0435393,-0.441172,-0.149066,0.130026,0.223904,-0.457181,-0.101451,-0.237533,0.0848918,0.274589,-0.652716,-0.674855,0.32048,0.854323,0.273325,-0.256302,0.0828567,-0.295524,0.0788144,0.00389966,-0.432818,-0.257405,-0.477381,0.279637,0.373681,0.235976,-0.0308432,-0.26684,0.34724,0.882903,-0.214843,-0.100978,-0.268043,0.317842,-0.0549635,-0.742189,0.0792719,0.192962,-0.518053,-0.514509,-0.689112,1.10645,-0.46215,-0.381842,0.00610595,-0.212282,0.312226,0.0365843,-0.271737,0.449497,0.263458,-0.209382,0.647894,0.152589,0.118504,0.103876,0.119992,0.15407,0.0572084,0.385151,-0.3978,-0.541172,0.66694,0.0951185,0.115565,-0.00200736,0.338882,-0.500497,-0.350549,-0.0150689,-0.222851,0.210014,0.520741,-0.60283,-0.219616,0.182049,-0.144029,-0.100786,0.244796,0.60098,0.686703,0.0711806,0.0530501,-0.486358,0.00726468,-0.715706,0.163736,-0.0821295,-0.505983,0.0742579,-0.72138,0.379809,0.193702,-0.0707463,-0.298084,0.682813,0.17322,-0.360486,0.132721,0.0799058,-0.126377,0.161538,0.111956,0.0804234,-0.288168,-0.27078,0.158178,0.331718,0.210756,0.206658,-0.215486,0.00459881,0.581904,0.0481626,0.136708,-0.366421,0.275303,0.160387,0.123535,-0.323295,-0.182103,0.558709,-0.115803,-0.284148,0.081912,-0.0753069,0.00132273,-0.0317238,-0.619096,-0.770806,-0.154315,-0.278044,-0.339322,-0.602152,-0.669207,0.100029,0.170378,0.316273,0.412769,-1.89674 +3424.86,0.979713,0.0848144,4,1.54817,0.760261,-1.46224,0.594809,0.735343,-0.11279,0.328536,-0.396308,0.897787,0.329682,-0.210784,-0.0848741,-0.393164,0.240403,-0.188116,0.791317,0.249668,-0.289522,-0.243009,-0.00891198,0.197648,-0.667278,-0.573809,0.379925,-0.0913069,-0.0192652,-0.414539,0.146481,0.00267114,0.376744,0.726756,-0.369722,0.41224,0.29518,-0.295891,-0.0935934,-0.352152,0.45658,-0.0564175,-0.28078,1.21405,0.307912,0.0219074,-0.101057,-0.333511,0.22187,-0.774654,-0.0448678,0.168597,0.00953406,0.121273,0.456238,-0.016397,0.300501,0.555915,-0.198489,-0.0343242,-0.447914,0.871056,-0.0682676,0.495956,0.991538,-1.0561,-0.612727,0.0672642,0.11161,0.110361,0.0921017,0.214272,-0.129587,0.250261,-0.102484,0.4341,0.101437,0.467363,0.252187,0.118897,0.655359,0.212316,-0.145371,0.685557,0.459789,0.128764,-0.102738,-0.0120761,-0.332077,0.0560257,-0.188281,0.198694,-0.482402,-0.478455,-0.403396,0.00560757,-0.308584,0.188056,-0.19232,0.259107,0.213568,0.0842882,0.234194,0.154574,0.0774321,0.00740594,-0.858231,0.387968,0.354623,0.481847,-0.302368,0.172696,0.280515,-0.192943,-0.227819,0.495405,0.394718,-0.327068,0.148685,-0.391215,-0.178773,0.030928,0.134078,-1.07115,0.129183,0.14674,0.223995,0.0349581,0.715104,-0.770186,-0.197498,0.406316,-0.649173,0.0846363,-0.000176504,0.354397,0.268027,0.0105375,0.35756,0.405188,-0.487157,0.289893,-0.374988,-0.654866,0.162514,0.0803946,-0.221874,0.286009,0.109908,0.0706844,0.385615,0.0268557,-0.728118,-0.378207,0.3687,0.189151,-0.0343323,0.629303,0.304316,-0.188193,0.49767,-0.463892,-0.18936,-0.0781214,-0.0477191,0.917545,-0.177841,0.362559,0.37852,0.159312,0.021155,0.0462568,0.204832,0.0479404,-0.766138,-0.0930033,-0.180969,0.332966,0.131996,-0.542582,-0.341998,0.140497,0.588307,0.286608,-0.543149,-0.0989631,-0.268053,0.133397,0.12832,-0.430745,-0.360353,-0.127561,0.37708,0.246791,0.00533478,-0.304786,-0.49107,0.101351,0.403741,-0.131355,-0.160315,-0.119005,0.568936,-0.205701,-0.513741,0.245589,-0.126293,-0.66067,-0.408555,-0.866766,1.08469,-0.0932103,-0.206647,0.306681,-0.132615,0.0976746,-0.165823,0.192088,0.146328,-0.406438,-0.0702693,0.409452,-0.0437076,-0.0112435,0.0685972,-0.230505,0.0946135,-0.0753639,0.544651,-0.518424,-0.308096,0.272926,0.247993,0.470161,-0.00715198,0.343914,-0.758455,-0.266253,0.236969,-0.230503,0.204862,0.698734,-0.447292,-0.545867,0.0889425,-0.14958,-0.244224,0.230285,0.373282,0.511834,0.248064,0.288276,-0.269928,-0.0785615,-0.615362,0.282075,0.0626975,-0.480357,-0.0289693,-0.863411,0.2864,0.202333,0.145227,-0.0907106,0.302306,-0.0506207,0.088643,0.25166,0.0350634,-0.0537769,0.0587773,0.259608,-0.0312882,-0.143211,-0.535049,0.18884,0.294874,0.229944,0.334696,-0.218992,-0.11529,0.432261,-0.0389197,0.238487,-0.212224,0.505063,0.567042,0.121014,-0.171558,0.0430741,1.18909,0.130805,-0.621755,-0.036659,0.420294,-0.0741094,0.0213766,-0.549301,-0.178032,0.110983,-0.535495,-0.363695,-0.392645,-0.366007,0.14966,0.159177,0.386859,0.39897,-2.00473 +3420.93,0.589855,0.0848144,4,1.54527,0.785867,-1.38159,0.533841,0.69182,-0.118621,0.169465,-0.376376,0.933476,0.36254,-0.0608292,-0.334793,-0.551035,0.285037,-0.118002,0.819638,0.351748,-0.25574,-0.216541,0.0301455,0.116455,-0.811633,-0.613937,0.231401,-0.338308,-0.053853,-0.411561,0.151429,0.00809499,0.388529,0.553861,-0.499599,0.303457,0.256944,-0.317858,-0.100053,-0.295838,0.347775,0.0321461,-0.348527,1.16334,0.441402,0.0891653,-0.328063,-0.360616,0.358959,-0.947712,0.00109489,0.257808,0.112941,0.0369062,0.32788,-0.0802953,0.0901013,0.512167,-0.219891,0.0503908,-0.410544,0.853325,-0.167705,0.516493,1.00915,-1.07356,-0.657623,0.267774,0.232715,0.125453,0.00566688,0.233688,-0.131083,0.106695,-0.0834769,0.43692,0.209027,0.469849,0.250143,0.176743,0.673627,0.234814,-0.23257,0.563937,0.484178,0.124968,-0.19738,-0.0697732,-0.289495,-0.0604601,-0.16724,0.255817,-0.473428,-0.367025,-0.280604,0.03979,-0.407792,0.0534082,-0.18499,0.336515,0.230548,-0.056211,0.327425,0.12075,-0.00230516,-0.155987,-0.792833,0.144479,0.264676,0.414664,-0.360829,0.221275,0.291444,-0.248382,-0.109401,0.492433,0.50463,-0.352714,0.101631,-0.260812,-0.212143,0.195572,0.0829507,-0.924614,0.196362,0.220652,0.314486,-0.24782,0.661941,-0.672356,-0.163906,0.342073,-0.410393,-0.0748853,0.0783428,0.278259,0.0884526,0.066843,0.320557,0.543909,-0.45154,0.370727,-0.539844,-0.702998,0.0740634,-0.00749391,-0.298278,0.276179,0.0152942,0.190515,0.412171,-0.0675786,-0.618406,-0.389931,0.388183,0.214556,-0.106985,0.461669,0.209715,-0.144937,0.414546,-0.573052,-0.222478,-0.135635,-0.0879826,0.966088,-0.200914,0.22618,0.40496,0.10973,0.0826476,0.0505626,0.345414,0.0888847,-0.741343,-0.000943638,-0.152735,0.560573,0.0608331,-0.554871,-0.393559,0.1041,0.595569,0.399656,-0.414114,-0.0918197,-0.196393,0.301005,0.175525,-0.516985,-0.463957,-0.238754,0.55128,0.121181,0.0464789,-0.199165,-0.344648,0.0715863,0.450699,0.147028,-0.201522,-0.206543,0.508086,-0.144717,-0.363842,0.260527,-0.138206,-0.823808,-0.373454,-0.690373,1.13293,-0.184078,0.0126003,0.470795,-0.0731501,0.0709374,-0.0557302,0.253779,0.16599,-0.368935,-0.0922404,0.398815,-0.24394,0.00338995,0.106544,-0.28927,0.19469,0.0342769,0.477622,-0.435971,-0.391287,0.33921,0.211126,0.285599,0.0157488,0.473902,-0.760694,-0.280156,0.325069,-0.258888,0.263477,0.825577,-0.362109,-0.685226,0.0400859,-0.142569,-0.160589,0.223419,0.344349,0.555125,0.307808,0.346253,-0.294431,-0.202532,-0.866623,0.285441,0.0585901,-0.367039,-0.0631461,-1.00853,0.302777,0.263728,0.149204,-0.130914,0.316733,-0.0491544,0.159077,0.239127,0.0632991,0.00142868,-0.0563857,-0.00692708,-0.119326,-0.185021,-0.534211,0.281234,0.202684,0.175059,0.426073,-0.137036,-0.244475,0.327902,0.0500459,0.170894,0.0337844,0.500228,0.665041,0.2138,-0.247714,0.147195,1.14183,0.0572757,-0.714484,-0.0600586,0.38048,-0.122914,0.014489,-0.548009,-0.13717,0.114515,-0.45832,-0.410965,-0.397583,-0.346456,0.139287,0.162863,0.373212,0.403562,-1.89151 +3405.81,0.922553,0.0848144,4,1.54179,0.854793,-0.737149,0.33603,0.30527,0.118055,0.491983,0.112639,0.0924214,0.247829,-0.0317315,0.146931,-0.115606,0.46909,-0.204456,1.20702,0.0996728,0.308036,-0.567547,-0.043203,0.243253,-1.02323,-0.363171,0.315205,-0.504955,-0.0295431,0.112075,0.552427,-0.0178109,0.257464,0.800216,-0.869337,0.0152001,0.123487,0.0901135,0.145715,-0.421087,-0.0965391,0.331987,-0.523343,0.968401,0.81167,-0.0468409,-1.09985,-0.215727,-0.0926219,-0.126702,-0.114794,0.327615,0.0187313,-0.147856,0.32492,-0.222564,-0.0462531,0.801259,-0.469357,-0.193981,-0.385825,0.543545,-0.333021,0.160028,0.88675,-1.02583,-0.794891,0.453417,-0.0928116,-0.661043,0.202124,0.125919,-0.287291,-0.127712,0.652782,0.952824,0.00616033,0.249545,0.547437,0.20503,0.102516,0.0559034,-0.322685,0.308214,-0.0271222,0.323623,0.339277,0.13187,0.0884028,-0.13267,-0.101205,0.137742,-0.174795,-0.124104,0.252079,0.0419083,-0.112812,0.476853,-0.451515,-0.0530945,-0.0340413,-0.0185199,0.152499,-0.00209093,0.0584211,-0.213569,0.221726,0.174999,-0.0383993,0.0817927,-0.0449587,0.145309,0.669494,-0.161948,-0.422226,0.212425,0.165887,-0.630586,-0.263343,-0.593855,-0.132946,0.332572,0.172957,-0.309389,0.063343,0.0325942,0.417548,0.23622,0.385592,-0.524362,-0.0627171,0.678559,-0.315835,0.312744,0.0973812,-0.00123041,-0.061892,-0.578021,0.12901,0.779956,-0.0134144,0.00899815,-0.802966,-0.238732,0.218136,0.454222,-0.737277,-0.067105,0.293767,-0.594219,-0.269743,0.444433,-0.0524019,-0.786387,0.567827,-0.0615576,-0.157377,0.562427,0.514423,-0.0352062,0.0319031,-0.223487,-0.0562637,0.0214525,-0.052593,0.772539,-0.6901,-0.429554,-0.113269,0.304729,-0.265647,-0.000503826,0.666585,0.679802,-0.620328,-0.115225,0.0021675,-0.0765408,-0.328859,-0.93033,0.251615,0.192367,0.684832,0.651884,-0.00900034,0.381603,0.0144614,0.235462,-0.421709,-0.996439,-0.259013,0.174544,-0.609888,0.177249,0.402913,0.137636,-0.0422252,0.413614,0.495992,0.10996,-0.315294,-0.228233,-0.723456,-0.131057,-0.157385,0.287395,0.0109388,0.149393,-0.0820115,-0.257059,0.992018,-0.102872,0.191924,-0.0415447,-0.297345,-0.221227,-0.389893,-0.279292,0.244161,-0.735777,0.119878,-0.59904,-0.491264,0.56587,0.294202,-0.168406,-0.0831295,0.0582681,0.154416,-0.118177,-0.495911,0.262828,-0.0375343,0.11337,0.104066,-0.454985,-0.433067,-0.847777,0.177135,-0.137083,0.0387126,0.365932,0.026487,-0.142864,-0.151995,-0.421727,-0.236658,0.174007,0.174907,0.652468,0.0180828,0.0440414,-0.38886,-0.276271,-0.819952,0.232737,-0.715133,-0.638077,0.130164,-0.298133,0.853146,0.05951,0.133177,-0.0574544,0.260584,0.0414792,-0.137921,0.18411,0.135023,-0.0403825,-0.345696,0.208055,0.530595,-0.631708,-0.960765,0.182858,0.16538,0.682331,-0.742788,0.0198685,0.123929,0.689387,-0.0742017,0.157729,-0.198425,-0.397178,-0.225975,-0.136603,0.0762205,0.242282,0.000159837,0.235022,-0.266406,-0.245239,0.33381,-0.186151,0.424985,-0.40022,-0.363821,-0.0432876,-0.273147,-0.545946,-0.303204,-0.382693,0.147206,0.398064,0.383675,0.630923,-0.943753 +3417.52,0.679348,0.0848144,4,1.53761,0.772971,-0.752795,0.320612,0.49779,0.0694985,0.449684,0.17482,-0.115799,0.311388,-0.0570707,0.355319,-0.417422,0.584413,-0.200536,1.11433,0.207338,0.217745,-0.672192,0.113626,0.217742,-1.08068,-0.295955,0.311001,-0.41017,0.0848078,-0.0450605,0.506674,-0.185291,0.33739,0.803527,-0.791872,0.0402596,0.0493006,0.0224034,0.193307,-0.535761,0.00847294,0.36694,-0.393679,0.931664,0.799296,-0.16664,-1.08815,-0.413091,-0.217139,-0.0802801,-0.0307191,0.552122,-0.0929534,-0.239313,0.416811,-0.0707454,-0.0480929,0.87572,-0.460244,-0.196743,-0.462906,0.556793,-0.18068,0.187594,0.846147,-0.997658,-0.457955,0.39686,-0.260512,-0.587389,0.382974,0.169152,-0.385101,-0.213602,0.783903,0.821298,0.0918125,0.172283,0.604204,0.319854,0.124738,0.118401,-0.243785,0.275063,0.0100401,0.323604,0.438691,0.141286,0.120203,-0.27723,0.00243378,0.268628,-0.293434,-0.243626,0.0258869,0.221445,-0.235845,0.377493,-0.453051,-0.194921,-0.0478856,0.140807,0.333366,0.0443475,0.218225,-0.426578,0.212951,0.126814,-0.156429,0.0612331,-0.207247,0.0695753,0.631663,-0.159755,-0.412394,0.197427,0.181813,-0.617011,-0.228093,-0.635874,0.0688679,0.155707,0.121966,-0.449778,0.327983,0.0647651,0.163794,-0.0211421,0.526834,-0.221863,-0.198872,0.679093,-0.366116,0.395052,0.0459758,0.186974,-0.0458928,-0.453349,-0.00884835,0.608139,0.0983566,0.0664906,-1.07945,-0.377691,0.284892,0.234743,-0.543142,-0.235736,0.311025,-0.684962,-0.101385,0.221621,-0.228779,-0.599939,0.675892,0.0801638,-0.129032,0.420611,0.570144,-0.233017,-0.17855,-0.237271,-0.103203,0.16725,-0.0298332,0.797643,-0.721366,-0.248962,-0.196391,0.288171,-0.320638,0.0309306,0.471227,0.439146,-0.583246,-0.150741,-0.0378957,-0.101605,-0.282831,-0.73854,0.208995,0.134914,0.646849,0.651794,-0.0762363,0.167626,-0.0689421,0.500295,-0.382669,-0.857553,-0.277997,-0.0508509,-0.669258,0.14773,0.204543,0.0513177,-0.127129,0.133219,0.502617,-0.0492445,-0.165121,-0.206732,-0.667478,-0.150885,-0.21013,0.249834,0.0686509,-0.0724167,-0.110196,-0.390608,1.04967,-0.223774,0.253288,-0.103203,-0.178574,-0.351042,-0.175684,-0.121664,0.382624,-0.630886,-0.00999089,-0.462541,-0.48991,0.482048,0.378897,-0.0467485,-0.193095,-0.144738,0.453011,-0.171556,-0.273178,0.162352,0.000971707,0.306874,0.187625,-0.511149,-0.273627,-0.858063,0.361781,-0.142776,0.0307345,0.342809,0.0253668,0.000926536,-0.0338624,-0.225889,-0.0774175,0.152524,-0.0379677,0.655251,-0.128428,0.165658,-0.514168,-0.537916,-0.747461,0.181651,-0.654002,-0.51702,0.138755,-0.325704,0.608709,-0.32285,0.215312,-0.198488,0.092276,-0.0555298,-0.0944156,0.193497,0.127967,-0.107135,-0.373741,0.147005,0.531483,-0.481644,-1.0926,0.144772,-0.129289,0.483383,-0.62963,0.00896483,0.0534049,0.679558,-0.25534,0.0603151,-0.198681,-0.242307,-0.124571,-0.117349,0.0195357,0.256442,0.0322362,0.36578,-0.0522279,-0.194062,0.281251,-0.310862,0.358147,-0.367076,-0.657144,-0.0664957,-0.171047,-0.687865,-0.33124,-0.457484,0.142095,0.407845,0.376955,0.638627,-1.40743 +3412.71,0.965051,0.0848144,5,1.56747,0.744701,-0.958349,0.451699,0.335437,0.0957399,0.375026,0.295825,-0.0696749,0.511268,0.142406,0.294833,-0.190474,0.266083,-0.353602,1.02356,0.25674,0.280176,-0.55651,-0.229277,0.0639095,-1.06015,-0.423107,0.432126,-0.624802,-0.102163,0.0198612,0.712576,-0.327628,0.21495,0.847093,-0.68397,0.425366,0.0486202,-0.0301886,0.266021,-0.531313,-0.0345072,0.540071,-0.181158,0.925934,0.759769,-0.0830117,-0.738395,-0.288666,-0.484599,-0.632016,0.0543241,0.319085,-0.0241686,-0.205513,0.430934,-0.358657,0.020653,0.617367,-0.35718,0.049888,-0.550699,0.553577,-0.0992321,-0.0160779,0.871084,-1.31571,-0.791344,0.126145,0.0420134,-0.551635,0.324487,0.219479,-0.261052,-0.204168,0.513992,0.804679,0.119517,0.417812,0.772004,0.396394,0.00436504,0.103117,0.0380352,0.485667,0.103006,0.2524,0.378295,0.290268,0.21411,-0.249135,0.0721777,0.174466,-0.429626,-0.168262,0.0418752,0.347337,-0.217792,0.44755,-0.346535,0.0631405,-0.181064,-0.213267,0.288384,-0.179875,0.382555,-0.266184,0.202888,-0.332917,-0.75227,0.44614,-0.363353,0.345813,0.772168,-0.396836,-0.243987,0.189781,0.28039,-0.41166,-0.341159,-0.389877,-0.110476,0.307871,-0.349726,-0.616234,0.200956,-0.207124,-0.00259459,-0.0849166,-0.072279,-0.164813,-0.645725,0.593717,0.0151607,0.162848,0.0203932,0.379879,0.340591,-0.390952,0.113592,0.207069,0.275053,-0.249205,-1.30231,-0.026782,0.162619,-0.140698,-0.502824,-0.429685,-0.0640066,-0.551532,0.409065,0.356394,-0.210767,-0.422156,0.721526,0.148446,-0.0178958,0.270428,0.875771,-0.249381,-0.450727,0.290943,0.0148159,0.308301,0.314066,0.863473,-0.664263,-0.25984,-0.187991,0.208761,-0.483084,-0.33435,0.468678,0.44885,-0.605737,-0.148255,0.161151,-0.0454553,-0.394919,-0.363266,-0.107648,0.131371,0.740295,0.407515,-0.108039,0.032557,-0.187055,0.15492,-0.411891,-0.6075,-0.285242,0.127368,-0.624993,0.234832,0.381381,0.160036,-0.166554,-0.179847,0.437467,0.316689,-0.109029,-0.159086,-0.753146,0.343362,-0.348203,0.254906,-0.186407,0.520907,-0.172917,-0.321043,1.24089,-0.121995,0.0735761,0.130039,-0.310674,-0.357935,-0.28678,-0.0334929,0.298672,-0.509039,-0.072473,-0.250323,-0.393665,0.465734,0.404708,-0.0766806,-0.328987,-0.318194,0.309113,-0.221125,0.171801,-0.272406,0.19786,0.0117493,-0.0810868,-0.30976,-0.332843,-1.00701,0.121834,-0.160109,0.730648,0.351566,0.262586,0.238408,0.0359873,-0.659488,0.02714,0.743829,0.0805379,0.360161,-0.0764198,-0.0810444,-0.350997,-0.530754,-0.759381,0.269793,-0.405024,-0.0567072,0.448527,-0.258149,0.735019,-0.111537,0.0222407,0.213726,0.0725686,-0.149379,-0.326868,0.327984,0.112375,-0.04051,-0.260993,0.115358,0.18628,-0.627238,-0.979271,0.319346,-0.294759,0.478383,-0.441815,-0.174682,0.225329,0.924138,-0.013033,-0.0200909,-0.170654,0.12877,0.495052,-0.194077,-0.046001,0.134845,-0.635836,0.0166543,-0.465114,-0.296881,0.515635,-0.215322,0.414383,-0.296138,-0.499811,-0.210479,-0.371575,-0.463887,0.113567,-0.253823,0.150381,0.223315,0.38779,0.472562,-0.811485 +3407.74,0.881275,0.0848144,4,1.57424,0.724286,-0.839377,0.355649,0.374225,0.0795709,0.473925,0.348752,0.0786989,0.465461,-0.0417225,0.173457,-0.106771,0.566975,-0.369626,1.08291,0.325228,0.104635,-0.518757,-0.0980913,0.0748835,-0.845337,-0.458017,0.146854,-0.246493,-0.256478,-0.0951202,0.485154,-0.217194,0.00766353,0.677455,-0.840425,0.0625397,0.0553906,0.039593,0.350908,-0.310642,0.0505008,0.377098,0.111892,0.916604,0.967515,-0.317812,-0.873885,-0.489062,-0.643815,-0.642602,0.276026,0.427424,-0.0628453,-0.275246,0.538908,-0.249418,0.032191,0.90131,-0.296464,0.159388,-0.48323,0.365885,-0.212413,0.135752,0.927893,-1.28644,-1.15602,0.0484222,-0.174026,-0.566998,-0.180145,0.0996337,-0.272662,-0.579743,0.603761,1.00902,0.15763,0.0643259,0.474423,0.772842,0.139023,0.563082,-0.00659248,0.624376,-0.159403,0.457779,0.718572,0.327261,0.407584,-0.367242,-0.115265,0.348048,-0.248452,-0.0700191,-0.0558035,0.51049,0.0819068,0.269381,-0.316726,0.406857,-0.468519,-0.256263,0.228764,-0.342132,0.408552,-0.246655,0.186898,0.0323246,-0.842458,0.122355,-0.299787,0.442555,0.928713,-0.556423,0.022954,-0.121156,0.430767,-0.734061,0.0920964,-0.10359,0.0140544,0.392623,-0.108853,-0.856928,-0.0769545,0.0455987,-0.303917,-0.0542471,0.0612196,-0.0815486,-0.542695,0.760461,-0.268384,0.380915,0.0779638,0.245609,0.186486,-0.262996,-0.191821,0.194409,0.361163,-0.110125,-1.13286,-0.134481,0.261544,0.108524,-0.177868,-0.239098,0.000136383,-0.299318,0.622412,0.338066,-0.0540377,-0.618402,0.752557,-0.0245455,-0.633075,0.504575,0.895525,0.0443896,-0.482924,0.303192,0.049212,0.567535,0.195518,1.00316,-0.289331,-0.0341399,-0.325202,-0.0951593,-0.693162,-0.324929,0.306261,0.562231,-0.633618,-0.0263843,0.267326,-0.128306,-0.239116,-0.0827651,-0.0915697,-0.0890225,0.69553,0.105081,0.0359994,-0.16327,-0.280136,-0.236873,-0.355097,-0.717389,-0.0756537,-0.151745,-0.487617,0.088374,0.711878,-0.0445246,-0.413916,-0.0210955,-0.123694,-0.153108,-0.144527,-0.0200045,-0.410556,0.2685,-0.320386,0.514177,-0.0895308,0.151898,-0.511534,-0.793999,1.15601,-0.382812,-0.247478,-0.128094,-0.304151,-0.10279,-0.113112,0.176383,0.0611055,-0.53773,-0.228954,-0.425822,-0.287951,0.572625,0.175275,-0.151195,0.0975338,-0.708016,0.627067,-0.386421,0.25752,-0.165252,0.301713,0.477091,-0.124926,0.157454,-0.29861,-0.593848,0.396255,-0.215599,0.776831,0.443946,-0.15521,-0.441654,-0.255078,-0.508106,0.164501,0.430421,-0.16707,0.485889,-0.200652,-0.28342,-0.526256,-0.598477,-0.585573,0.192969,-0.411216,-0.255352,0.355737,0.102041,0.676759,-0.0252856,0.108832,0.349834,0.35528,-0.451513,-0.481541,0.405802,0.478816,0.00162831,-0.486386,0.308578,-0.234089,-0.430809,-0.634726,-0.0699707,0.207003,0.308572,-0.438861,0.0181601,-0.208937,0.957263,-0.239339,0.0545791,-0.281798,0.0447791,0.224989,-0.396618,0.122865,0.0821428,-0.376517,0.094709,-0.941227,-0.345199,0.558376,-0.0307303,0.103254,-0.379523,-0.63736,-0.179998,-0.237296,-0.53165,-0.0719968,-0.278691,0.158618,0.253027,0.398269,0.503018,-0.864767 +3402.47,0.960485,0.0848144,4,1.58923,0.713543,-0.919561,0.396023,0.185898,0.132699,0.427064,0.512795,-0.0367129,0.521674,-0.116817,0.215856,-0.0680178,0.564906,-0.396592,1.15593,0.409824,0.0892576,-0.430468,-0.116723,0.17508,-0.74602,-0.567023,0.298701,-0.317873,-0.271952,0.108492,0.363252,-0.0995065,0.11601,0.720697,-0.726174,0.101991,0.0946529,-0.0864281,0.23861,-0.249393,0.142589,0.365013,-0.0286983,0.880609,0.985672,-0.475494,-0.708894,-0.415883,-0.521388,-0.601299,-0.00056476,0.614505,-0.0585458,-0.377272,0.706714,-0.274035,0.252794,0.877329,-0.177594,0.165972,-0.290847,0.353525,-0.227247,0.0999931,0.938385,-1.26434,-1.03635,0.135184,-0.143598,-0.411572,-0.246592,0.12105,-0.503312,-0.48567,0.678168,1.00417,0.0962726,0.190604,0.505578,0.644521,0.164003,0.614798,0.0877956,0.511485,-0.0967073,0.422763,0.650202,0.247387,0.424885,-0.28036,-0.154261,0.448346,-0.251279,-0.14235,-0.257885,0.533859,0.00158674,0.120907,-0.307792,0.577727,-0.351935,-0.259046,0.201837,-0.251818,0.427151,-0.182694,0.099752,0.272372,-0.646231,0.17767,-0.242631,0.337944,0.86992,-0.557948,0.166616,0.0544844,0.374828,-0.766796,-0.0685299,-0.0569978,0.0459343,0.473605,-0.232751,-0.916766,-0.283553,-0.0510207,-0.205218,-0.206408,-0.0678617,0.0450907,-0.432083,0.742293,-0.200811,0.465637,0.0735314,0.190776,0.336206,-0.204589,-0.183737,0.377065,0.541553,-0.0483462,-1.06507,0.0135134,0.339463,-0.0302996,-0.348112,-0.368688,-0.0258569,-0.35708,0.62709,0.368361,-0.175775,-0.670283,0.903817,0.0311833,-0.758495,0.543709,0.831187,0.140861,-0.502163,0.420835,0.0859265,0.384211,0.259209,1.01866,-0.396773,0.0241676,-0.194341,0.0218769,-0.866647,-0.434456,0.300396,0.569705,-0.821215,-0.0803638,0.236924,0.0106673,-0.223528,-0.114613,-0.0506607,-0.104136,0.743397,0.302614,-0.203445,-0.224198,-0.0930421,-0.189638,-0.142174,-0.7035,-0.0306999,0.0277165,-0.35307,0.0648382,0.789904,-0.0207237,-0.363264,0.0611712,-0.160151,-0.144999,-0.186812,0.0808858,-0.230543,0.238476,-0.40883,0.566647,-0.0221947,0.254779,-0.643555,-0.753973,1.18036,-0.37158,-0.285788,0.00703845,-0.234547,-0.138808,-0.271514,-0.0231285,0.137702,-0.557893,-0.0994271,-0.519025,-0.132449,0.562187,-0.00884523,-0.213101,0.239905,-0.653278,0.593082,-0.307923,0.226198,-0.256021,0.290366,0.315397,-0.146757,0.21217,-0.258862,-0.42136,0.423429,-0.232354,0.762877,0.575207,-0.121654,-0.380459,-0.34397,-0.592547,0.126383,0.468301,-0.0915443,0.285801,-0.377009,-0.249808,-0.492684,-0.524922,-0.569178,0.143804,-0.376439,-0.198173,0.409054,0.155372,0.569537,0.0833866,0.0967497,0.378928,0.381934,-0.420183,-0.644034,0.279438,0.511644,0.0441533,-0.732051,0.21888,-0.131949,-0.389345,-0.676477,-0.202639,0.127471,0.302714,-0.309516,-0.0989287,-0.178596,0.782305,-0.245025,0.0939498,-0.206606,0.0477312,0.255849,-0.487714,0.0595094,0.0186863,-0.341293,0.0155806,-0.921108,-0.355766,0.535682,-0.0441661,0.107587,-0.319039,-0.475907,-0.250999,-0.14106,-0.457622,-0.130392,-0.339864,0.157179,0.263756,0.396458,0.513572,-0.215017 +3419.86,0.827446,0.0848144,4,1.49817,1.04429,-0.562386,0.156969,0.651946,0.0345321,0.0291054,0.446547,0.53163,0.623879,-0.0638834,-0.0389893,-0.362241,0.144404,-0.00654119,0.973351,0.375,0.00722039,-0.248183,-0.238647,-0.557753,-1.13224,-0.864393,-0.126548,-0.399322,-0.130264,0.207223,0.0728857,0.152367,-0.0310939,0.53149,-0.488394,0.90413,-0.00232737,-0.146496,0.211792,-0.0936539,0.722596,0.201624,-0.244458,0.838256,0.539241,0.0999065,-0.79162,-0.0136196,-0.106121,-1.05461,0.493934,0.466262,0.233481,0.237361,-0.389756,-0.171412,-0.378906,0.931719,-0.71055,0.0182925,-0.110889,0.63133,-0.135956,0.102728,1.0052,-0.414035,-0.963471,-0.287907,-0.0247032,-0.306463,-0.474853,-0.415687,-0.386645,-0.528361,0.280025,0.569756,0.105527,0.417697,0.339592,0.134873,0.135693,-0.427487,0.735698,0.980975,0.445171,0.598817,-0.842201,0.193787,0.252521,0.356442,-0.465671,0.257586,-0.145121,0.414095,-0.0526051,0.27867,0.361632,-0.20679,-0.0842583,-0.0792966,-0.399861,-0.150224,0.45619,-0.152605,-0.0331624,-0.21249,-0.0679435,0.156534,-0.120379,0.102635,-0.269093,0.227181,0.816528,0.255387,0.342146,-0.0622941,0.174292,-0.234962,-0.242457,-1.14813,0.121365,0.278744,0.0518251,-0.782754,-0.0931862,0.559215,-0.15021,0.0107168,-0.371282,0.503302,0.00841014,0.29349,-0.0517642,0.191593,0.255222,0.492979,0.106204,-0.442221,-0.0394275,0.372562,0.00630419,0.595374,-0.535791,0.201699,-0.0574775,0.493071,-0.536302,0.0154249,0.421436,-0.0916383,0.349431,-0.174391,0.332939,-0.2475,0.0983354,0.379675,-0.430383,0.355707,0.116006,0.862434,0.0794615,0.290845,-0.125143,-0.0227758,0.45083,0.744723,-0.0818618,0.244923,0.298207,-0.414177,0.161196,0.126872,0.0313425,0.42197,-1.10365,-0.2028,0.398032,-0.420716,-0.439398,-0.105871,-0.452156,-0.315493,0.441559,0.269296,0.00524072,1.01214,0.0416924,-0.104525,0.211446,-0.383095,0.255448,0.101432,-0.0954967,-0.0335589,-0.505583,-0.061792,-0.81795,0.0750383,0.427268,0.457557,-0.283899,-0.451392,0.0470125,0.148349,-0.0100613,0.112528,-0.35663,-0.00648779,0.234043,-0.291505,1.1121,-0.91161,-0.166729,0.60642,-0.382151,0.106742,-0.0839774,-0.38888,0.35694,-0.369611,0.191635,0.364951,-0.699376,-0.025333,-0.379866,-0.298312,0.414789,-0.204795,0.0927212,-0.00370199,-0.386589,0.102688,0.1909,-0.358548,0.131472,0.0621719,-0.347937,-0.454425,0.699506,0.0475067,0.0526511,0.444538,-0.214996,0.286322,0.326713,0.33738,-0.209914,0.46674,-0.244191,0.62076,-0.0540673,-0.0195727,-0.102179,-0.0358599,-0.938937,0.0143765,-0.0206173,-0.123241,0.314613,-0.525688,0.318238,0.389511,0.136524,0.198288,-0.000195947,0.0874876,0.185108,-0.203197,-0.374636,0.177242,-0.758324,-0.185365,0.225097,-0.625907,-0.412937,-0.213938,0.179197,0.108243,0.236888,0.19358,-0.576142,0.316821,-0.286174,-0.36336,-0.0982451,0.110253,-0.370535,0.214622,-0.102412,-0.357103,0.421874,0.65062,0.26614,-0.183251,0.745165,-0.582396,-0.514368,-0.489434,-0.243045,-0.244666,-0.37659,-0.823547,0.284345,-0.056098,0.156818,0.225837,0.396002,0.475223,-2.37442 +3424.37,0.995587,0.0848144,4,1.54236,0.961665,-0.416203,0.160578,0.408479,0.0759842,0.292759,0.37398,0.46157,0.555201,0.0443587,0.146951,-0.286266,0.281881,0.176585,1.05422,0.129542,-0.0187061,-0.121379,-0.0842866,-0.28007,-1.40049,-1.31048,0.0357274,0.0190507,-0.270262,0.589871,0.340876,0.13244,0.250864,0.929323,-0.119042,0.611262,0.184027,-0.0455668,0.116507,-0.374782,0.893769,0.595811,-0.168199,0.723832,0.522155,0.344811,-0.395757,0.0225599,-0.391179,-0.815958,0.0235296,0.44394,-0.26046,-0.259012,-0.0790554,-0.256608,0.0261381,0.986154,-0.878863,0.200999,-0.536285,0.158189,-0.223005,0.311862,1.10969,-0.408406,-0.772016,-0.554813,-0.101672,-0.373225,0.228343,-0.37148,-0.384707,-0.403168,0.192011,0.854558,0.346102,0.799488,0.237048,0.548532,0.087108,-0.330465,0.321216,0.95284,0.390083,0.322255,-0.879943,0.375259,-0.434691,0.402849,-0.283373,0.288767,-0.422385,0.141026,0.076605,0.110484,0.175842,-0.411703,-0.262384,-0.476765,-0.136545,-0.221436,0.493912,-0.499068,0.123323,-0.33287,-0.304023,-0.252506,-0.0823083,0.249637,-0.771877,0.324913,0.97444,-0.00586622,0.3766,0.122316,0.338409,-0.21139,0.0283595,-0.67442,0.326349,0.0642103,-0.35862,-0.800198,-0.428913,0.674183,-0.140631,0.0386864,-0.0434709,0.456618,0.0374183,-0.16569,-0.171782,0.387696,0.0471437,0.0834623,0.249538,-0.232989,-0.123469,-0.117097,0.213793,0.286343,-0.453136,-0.672228,0.273551,0.324898,-0.532055,0.355371,0.506665,-0.150229,0.248998,-0.146848,-0.221611,-0.583242,0.29265,-0.167192,0.103796,0.199843,0.0880479,0.389284,-0.484775,0.316589,0.346895,0.0511446,-0.0111617,0.803601,-0.442719,0.0699613,0.414174,-0.171176,-0.193494,-0.194205,0.0410297,0.432062,-0.0880703,-0.338586,0.256492,-0.01836,-0.642045,-0.0355909,-0.646981,0.0867662,0.952362,-0.217225,-0.163207,0.311822,0.0577202,0.131386,0.480648,-0.0295204,-0.106053,0.0891974,-0.0482594,0.191237,-0.388042,-0.0454095,-0.698116,0.278688,0.676851,0.137293,-0.103885,-0.493796,0.214702,-0.13803,-0.29733,0.460712,-0.508247,0.127913,0.0347796,-0.412602,0.903165,-0.302909,0.243186,0.18804,-0.0248668,-0.0712232,0.528503,-0.514159,-0.118285,-0.441136,0.428556,0.0999913,0.126728,0.159661,-0.641507,-0.266025,0.843827,-0.330686,0.391427,0.051366,-0.40117,0.200062,0.0609862,-0.467434,-0.124068,0.15341,-0.361723,-0.258012,0.607847,-0.00934946,0.144704,0.366052,0.141278,-0.327092,-0.311381,0.0877162,-0.308357,0.448361,-0.0184988,0.457664,-0.223153,-0.193519,-0.139839,0.280706,-1.05364,0.314747,-0.203768,-0.205056,0.311097,-0.815773,0.328408,0.422863,-0.0312087,-0.270984,0.183627,-0.0738015,0.613574,0.0512588,-0.153448,-0.261547,-0.617065,-0.0236007,0.0863152,-0.316595,-0.319854,0.558086,-0.0676921,-0.237457,0.289404,0.449269,-0.302178,0.840216,-0.151,0.0128752,0.566254,0.0972753,-0.467865,0.19547,0.211407,-0.373365,0.372082,0.573769,0.18777,-0.611189,0.330486,-0.300206,-0.246457,-0.476348,-0.472944,-0.144326,-0.515098,0.172738,0.405024,0.497213,0.138239,0.241573,0.371804,0.491501,-1.46649 +3397.75,0.902637,0.0848144,4,1.43215,1.05199,-0.775066,0.26894,0.88632,-0.0123503,0.527271,0.443694,0.285426,0.670297,0.300636,-0.264272,-0.340122,-0.0203411,-0.504896,1.06127,0.0258413,-0.142284,0.135341,0.00658374,-0.140711,-1.63339,-0.481131,0.0650374,0.213767,0.165604,0.473573,0.281107,-0.331425,-0.0314987,0.738528,0.0887924,0.826146,0.0750513,-0.242036,0.0941626,-0.436462,0.638622,0.575693,-0.326427,0.392239,0.628708,0.187569,-0.399855,0.152346,-0.192585,-0.73345,0.177857,0.355677,-0.00297806,-0.207583,-0.0139232,-0.0242675,-0.538716,1.06933,-0.718313,0.233465,-0.174766,0.478852,-0.515769,-0.0511222,0.856824,-0.95533,-1.37633,0.00588396,-0.418349,-0.196366,0.261655,-0.171313,-0.762101,-0.0989253,0.569893,0.623623,0.528911,0.633403,0.623479,0.598818,0.300434,-0.402321,0.298556,1.07844,-0.12572,-0.00739858,-0.432195,0.391991,-0.0445962,-0.356813,0.0447167,0.426816,-0.365521,0.238063,-0.412184,0.00178111,0.404124,-0.316951,-0.830764,-0.608466,-0.0519244,0.234507,0.749306,0.0810626,0.0216626,-0.773541,-0.307539,-0.204084,-0.490352,0.63036,0.0651559,0.580153,0.745599,-0.116866,0.159293,-0.111341,0.0698244,0.172414,0.213651,-0.889638,0.561558,0.396863,0.399169,-1.27922,-0.142558,0.452565,-0.3861,-0.0295783,0.0830715,0.151463,0.302576,0.222635,0.104305,0.36558,0.0584118,-0.272877,0.19591,-0.375447,-0.0833562,0.0684857,0.198987,0.401032,-0.17165,-0.765369,-0.152185,0.395158,-0.0329774,-0.153971,0.232742,0.774229,0.208373,-0.152693,-0.0840458,-0.471662,0.29004,0.082029,0.373405,0.00367982,-0.0796504,0.683882,-0.302829,0.536118,0.00695256,0.321833,-0.0499168,0.807883,-0.161214,0.523759,0.569026,-0.661794,-0.0216403,-0.397595,0.313897,0.371476,-0.289701,-0.395362,0.308293,-0.280275,-0.495894,-0.0726695,-0.783438,0.198111,1.02706,0.143547,-0.463581,0.154673,-0.609626,0.130114,0.148911,-0.586559,-0.780546,0.113546,-0.216013,-0.148254,-0.593415,0.14575,-0.392096,0.242241,0.878975,-0.110615,-0.102724,-0.444408,-0.432145,0.182402,-0.312134,0.361436,-0.487581,-0.265296,-0.191383,-0.0858487,0.950614,0.177041,0.441332,0.551953,-0.140904,0.161063,0.660304,-0.658518,0.414721,-0.138667,0.482707,0.0635816,-0.451104,0.112643,-0.713081,-0.560638,0.69609,0.132428,0.144691,0.0715185,-0.0384964,0.137397,0.193945,-0.161917,-0.280625,0.0111125,-0.281959,-0.129584,0.918939,-0.175927,-0.197995,0.474656,0.291285,-0.0792124,-0.053792,0.292553,0.127525,0.218141,0.410958,0.374799,-0.0388525,-0.0479722,-0.315812,0.65921,-1.22018,0.492832,0.198845,-0.234119,0.195377,-0.533243,-0.0203553,0.161579,-0.156675,-0.0831405,0.197391,-0.176464,0.356606,-0.129704,-0.251334,-0.134083,-0.169639,0.161802,0.0819026,-0.150159,-0.721704,-0.0329951,0.453277,-0.338108,0.212891,0.156883,0.0191588,0.845237,-0.521633,0.410798,-0.258596,-0.590547,0.0256037,-0.0200333,0.1014,0.0258846,0.270699,0.402867,-0.0469673,-0.407662,0.693108,-0.348456,0.216207,-0.516179,-0.405382,-0.182614,-0.204005,0.601903,0.191646,0.128428,0.181652,0.243819,0.426206,0.493781,-3.21484 +3387.58,0.831147,0.0848144,4,1.49996,1.02867,-0.658106,0.315731,1.17052,0.0192892,0.752114,0.331201,0.527646,0.417446,0.431942,0.0352092,-0.410289,0.124321,-0.582732,1.00041,-0.220058,-0.04785,0.04121,0.0804127,-0.31727,-1.29953,-0.837931,0.114702,0.133226,0.222684,0.0305167,0.429434,-0.268464,-0.165488,0.725409,0.0441317,0.926791,0.389168,-0.0829823,0.0405353,-0.0381518,0.596136,0.611693,-0.316072,0.597636,0.787744,0.236946,-0.354911,-0.203172,-0.423977,-1.13897,-0.264562,0.502812,-0.0758079,-0.139929,-0.188853,0.130234,-0.266895,0.783715,-0.79034,-0.169506,-0.170444,0.284111,-0.173447,-0.0893557,0.989221,-0.860387,-1.46026,0.243903,-0.640096,0.0320265,0.508683,-0.465208,-0.538412,-0.0571911,0.250032,0.499533,0.390021,0.675175,0.6084,0.551023,0.206535,-0.145136,0.255308,0.955317,-0.207743,0.17751,-0.605937,0.322108,0.0148992,-0.45195,0.157633,0.270111,-0.362849,0.441059,-0.171439,0.122332,0.56481,-0.386845,-0.689025,-0.577025,-0.35065,-0.276921,0.853237,0.102177,-0.489806,-0.759805,-0.341584,-0.131711,-0.582586,0.451998,-0.130239,0.57206,0.473382,0.540809,0.0785448,-0.11161,0.222893,0.18174,0.694434,-0.769676,0.608553,0.497866,0.46329,-1.21997,0.24639,0.436389,-0.401288,0.0195038,-0.00295888,0.355241,0.496851,0.0532784,-0.271598,0.0310297,0.211626,-0.033657,0.0459149,-0.181908,-0.0739114,0.256628,-0.0319283,0.581155,-0.691388,-0.502063,-0.267109,0.313815,0.135242,0.163782,0.351046,0.796524,0.449033,-0.200646,-0.0366468,-0.732886,0.187463,-0.0330144,0.464552,-0.147288,-0.0875301,0.545991,-0.18298,0.285467,-0.0257053,0.10541,-0.126744,1.00097,0.00478949,0.306387,0.493462,-0.578861,0.0807563,-0.0484259,0.446749,0.3434,-0.162321,-0.368897,0.0369872,-0.0905073,-0.182897,-0.116667,-0.798563,-0.161612,0.96277,0.438218,0.28952,0.170405,-0.737597,-0.0337443,-0.277944,-0.540551,-0.65793,0.395075,-0.532361,-0.0345934,-0.72511,0.476606,-0.112354,0.531521,0.744489,0.0941303,-0.0819251,-0.756788,-0.259856,0.0457822,-0.274406,0.649817,0.200485,-0.0614919,0.00347146,-0.117479,1.05301,-0.246305,0.773821,0.432182,-0.218044,0.0538183,0.00934189,-0.880838,0.301914,0.0953707,0.4811,0.266549,-0.105021,0.215743,-0.527536,-0.533241,0.685329,-0.0911336,0.127054,-0.105255,-0.0476672,0.0272034,0.305123,0.193536,-0.249189,0.0116037,-0.699411,-0.392138,0.390979,-0.29572,0.162836,0.506234,0.740928,0.0102482,-0.00187502,0.210681,0.515256,0.142587,0.611968,0.329485,0.0808585,-0.190582,-0.393837,0.306785,-1.28004,0.580148,-0.0725134,-0.152434,0.0582395,-0.362982,0.0889229,0.145259,-0.172195,-0.314317,0.276244,0.0632905,0.537823,-0.225956,0.190708,0.116584,-0.202687,0.14499,0.184626,-0.0226349,-0.862635,-0.0846148,0.299139,-0.340718,0.378601,-0.291913,-0.0719766,0.430518,-0.455021,0.353206,-0.0160446,-0.243745,-0.01184,0.152004,-0.169568,0.0380161,0.128594,0.421998,-0.124371,-0.473783,0.391299,-0.354331,0.0659899,-0.459443,-0.483851,-0.213069,-0.0674021,0.758938,0.169883,-0.231304,0.200506,0.244909,0.447779,0.494883,-4.16304 +3399.35,0.680988,0.0848144,5,1.55411,0.937597,-1.06241,0.439905,0.966458,-0.00647815,0.244199,-0.00534742,0.336649,0.600393,0.333415,-0.3348,-0.381138,0.0901216,-0.337394,0.838482,-0.18765,-0.23177,0.0518935,-0.111767,-0.108405,-1.39064,-0.760672,0.0416192,0.0547406,-0.300528,0.143036,0.352148,-0.305335,0.0411513,0.663703,-0.199163,0.391705,0.196831,-0.49647,-0.171589,-0.0378496,0.475886,0.854593,-0.457162,0.591624,0.842589,0.428158,-0.205324,-0.209938,-0.364458,-1.08385,-0.151279,0.0287335,0.205252,-0.247622,-0.45656,-0.286889,-0.113077,0.813227,-0.654331,-0.170022,-0.696724,0.23807,-0.167116,0.219435,0.929351,-1.342,-1.21903,-0.0711508,-0.320573,-0.0568101,0.160075,-0.385771,-0.403901,0.0400525,0.664163,0.377962,0.225621,0.491518,0.615921,0.602827,0.0355408,0.0253622,0.258564,0.989502,-0.0739481,0.163973,-0.833993,-0.0277898,0.0887287,-0.132121,0.0508054,0.494968,-0.593206,0.510413,-0.163669,0.0812524,0.455841,-0.646985,-0.755009,-0.519073,-0.471294,-0.158854,0.645115,0.0348373,-0.406456,-0.697413,-0.627275,-0.0888274,-0.644417,0.118602,-0.017891,0.633945,0.534115,0.291126,0.257283,-0.195091,0.0322113,0.127314,0.242783,-0.970889,0.572721,0.622258,0.488077,-1.17875,0.554098,0.748515,-0.588597,0.0647273,-0.0754122,0.302876,0.462405,0.301462,0.0934605,0.145756,-0.0552438,0.148286,0.336056,-0.239447,-5.80543e-05,0.337186,0.0876026,0.48906,-0.76603,-0.165518,-0.0507744,0.00531415,0.294854,0.216537,0.359905,0.302376,0.365117,-0.286036,-0.421183,-0.693255,0.217881,0.0426969,0.00845592,-0.0130831,0.242672,0.366753,-0.070219,0.141703,0.257506,0.0843069,-0.257597,0.957748,0.0644185,0.546918,0.553724,-0.147452,-0.102475,-0.103885,0.538421,0.355329,-0.319545,-0.379577,-0.120028,0.0282128,-0.43944,0.167219,-0.789403,-0.484827,0.973198,0.674914,-0.146422,0.389646,-0.87134,-0.2542,-0.41184,-0.41536,-0.416514,0.593891,-0.735935,-0.127868,-0.469298,0.370517,-0.145355,0.159199,0.143673,0.0518005,-0.115325,-0.93171,-0.0111026,0.0136843,-0.421449,0.833683,-0.0121062,-0.0774285,-0.177167,-0.166352,0.860059,-0.244948,0.538802,0.343929,-0.0115841,-0.144175,0.184337,-0.7795,0.317594,0.15451,0.29084,0.147818,-0.343411,0.0754662,-0.279259,-0.224244,0.911182,-0.462741,0.310147,-0.348552,-0.707719,0.149481,0.208717,0.295285,-0.188108,0.664473,-0.395701,-0.117363,0.738482,-0.308332,0.0122593,0.282857,0.593656,0.217861,-0.333135,0.219789,0.394587,0.165876,0.296754,0.38145,0.350454,-0.219262,-0.283435,0.162712,-0.951004,0.415241,-0.22924,-0.132674,0.266355,-0.360144,-0.0581132,0.346677,0.258476,-0.289667,-0.189521,0.102544,0.498628,-0.36463,-0.0909929,-0.0681471,-0.350656,0.0285663,0.0455136,0.0263524,-0.558712,0.0875049,0.36669,0.133827,0.52463,-0.421579,-0.017587,0.53801,-0.692594,-0.385261,-0.327982,-0.0500381,-0.119113,0.221063,-0.0697278,0.180506,-0.0681934,0.424911,-0.0351572,-0.408765,0.380108,-0.189125,0.144386,-0.766802,-0.890563,-0.390679,-0.0632572,0.982209,0.247816,-0.455414,0.152042,0.270808,0.389925,0.520393,-3.16931 +3365.15,0.727721,0.0848144,4,1.54046,0.981826,-1.15263,0.491867,0.804518,-0.0140921,0.482673,0.2269,0.431995,0.148607,-0.126615,-0.502525,0.311439,0.243417,-0.501819,0.753881,-0.0383288,0.407409,-0.102133,-0.236744,-0.442147,-0.883858,-0.466978,-0.00121972,-0.113066,0.118437,0.431839,0.313057,-0.434226,0.12292,0.734401,-0.179717,0.237425,0.759294,-0.173738,-0.240972,-0.0447265,1.01766,0.891383,-0.908631,0.81129,0.25872,0.26895,-0.693516,-0.438918,0.214116,-1.17535,0.368538,0.265828,-0.0494675,-0.0705342,0.653719,-0.0909643,0.545048,0.696066,-0.508941,-0.0442327,-0.692205,0.0918639,-0.648199,0.242005,0.931165,-1.09923,-1.499,0.254294,-0.389871,-0.071603,0.210117,-0.685109,-0.879994,0.510232,0.238129,0.563352,0.245419,0.841365,0.305535,0.550484,-0.198068,-0.2626,0.38084,0.284038,-0.804779,0.463109,-0.433427,-0.112672,-0.581458,-0.0240941,-0.136999,0.649076,-0.345745,0.155184,0.214278,-0.0171034,0.372869,-0.369576,-0.437009,-0.754753,-0.612245,-0.348486,0.502629,0.176223,-0.301804,-0.590483,-0.677235,0.568648,-0.841975,0.675165,-0.401448,0.627254,0.626505,0.264226,0.278063,-0.231745,-0.107757,0.649539,0.1251,-0.583642,0.46173,0.608603,0.14245,-0.878574,0.391177,0.222249,0.179712,0.126257,0.016715,-0.0358497,0.020661,0.407687,0.0233722,-0.620627,-0.0711852,0.0737593,0.849725,0.0664405,-0.349097,0.663256,-0.162762,0.366447,-0.133779,-0.937297,0.142753,0.30961,-0.224502,-0.55933,-0.199883,0.0828008,-0.17378,-0.224309,-0.619218,0.144163,-0.236156,0.11643,0.164483,0.00865258,0.296199,0.38534,0.591519,0.304688,0.0064235,0.427805,-0.437229,1.39285,-0.395882,0.321477,0.378649,0.0412174,0.171274,0.0207255,0.598968,0.756714,-0.936035,-0.464359,-0.1542,-0.296181,-0.539122,-0.307183,-0.773245,-0.235248,0.800698,0.36912,0.583662,0.435029,-0.325261,-0.244868,-0.352716,-0.359883,-0.955484,-0.00455296,-1.12371,-0.254698,-0.125133,0.147463,-0.524862,-0.0951388,-0.0144984,0.0417571,-0.744655,-1.31758,-0.0755809,-0.134727,-0.28454,0.823404,-0.264905,-0.175984,-0.126827,0.387004,1.1899,0.231774,-0.12655,0.177561,-0.593341,0.0780501,-0.124115,-0.476585,-0.433281,0.0605114,0.338445,0.859655,0.310745,-0.0181447,0.1871,-0.464022,0.89314,-0.682363,0.364763,-0.747584,-0.568099,0.487184,0.404698,0.15535,-0.267944,0.431681,-0.0684468,0.0172692,0.861144,-0.145952,-0.0567164,0.380394,0.239048,-0.0109916,-0.150571,0.164185,-0.120895,-0.12919,-0.252419,0.746811,0.165182,-0.811456,-0.412446,-0.361795,-1.04298,0.27137,-0.320935,0.302321,0.337239,-0.645019,0.37976,0.399255,-0.100464,-0.412137,-0.192091,0.2497,0.145285,-0.100485,0.228693,-0.0972892,-0.0157401,0.0192362,-0.588732,0.219552,-0.440728,-0.47156,0.148817,0.0210867,-0.227903,-0.378459,-0.346316,0.256145,-0.577308,-0.537553,-0.133624,-0.093284,0.364235,0.10086,0.111071,0.0528006,0.531362,0.457459,0.359778,-0.288761,0.587558,-0.276703,-0.202914,-0.294692,-0.639197,0.0284926,0.266694,0.462192,-0.492687,0.130969,0.239681,0.457017,0.489572,0.676031,-2.72352 +3359.59,0.985334,0.0848144,5,1.53247,0.876874,-1.20434,0.349659,0.492922,0.0290787,0.0702688,0.00273924,0.749881,-0.334555,0.587962,-0.448443,0.33081,0.219214,-0.281259,0.53704,0.0136081,-0.0429567,-0.107562,0.0648603,-0.052861,-1.27036,-0.697057,-0.136161,0.0414186,-0.505364,0.344965,0.232962,0.0205526,-0.103874,0.53569,-0.150801,0.229939,0.169933,-0.119317,0.102519,-0.117314,1.51103,0.822686,-1.11271,0.757617,0.872446,0.266446,0.0479508,0.104198,-0.0707642,-0.451794,0.193877,0.338761,0.472275,-0.166115,0.29923,0.142203,-0.567876,1.02253,-0.200888,-0.235978,-0.659936,0.878822,-0.287973,0.352704,1.00435,-0.643358,-1.58676,0.554832,-0.111473,-0.541834,-0.300564,-0.396798,-0.853272,-0.488192,-0.118985,0.628776,0.636951,0.942134,0.103817,0.0988969,0.464516,-0.522985,0.236187,1.49216,-0.670708,0.090341,-0.756087,-0.237091,-0.565145,0.308127,-0.426854,-0.18938,-0.108624,-0.0823648,0.327794,-0.0751972,-0.0152734,-0.00249264,-0.866002,-0.777269,-0.508246,0.762193,0.298367,-0.123864,0.325572,-0.630614,-0.390374,0.157304,-0.90001,-0.00121282,-0.0102955,0.210234,0.94486,0.0731713,0.411382,0.278997,0.258505,0.270548,0.639803,-0.570159,0.107256,0.506448,0.425545,-0.804232,0.129142,-0.245718,-0.282838,-0.154704,0.101808,0.183722,0.273295,-0.028294,0.280641,-0.351939,-0.157293,-0.28618,0.578105,-0.112117,-0.564873,0.655279,-0.193763,0.378203,-0.259362,-0.892867,0.0300038,0.032273,-0.0953715,-0.512721,0.373604,0.604732,0.445707,0.232773,-0.446333,-0.151657,0.166003,0.172806,0.233281,0.948834,-0.416432,-0.0609667,0.740504,0.227019,-0.107492,0.4646,-0.114173,0.744378,-0.471972,1.09462,-0.0549988,0.147301,-0.341868,0.160851,0.056876,0.0194257,-1.11828,-0.357707,0.212812,-0.556217,-0.197321,-0.00792075,-0.510727,-0.0555762,0.812815,0.798926,-0.0355792,-0.240096,-0.691564,0.361847,-0.524653,-0.86286,-0.592476,0.340353,-0.941279,-0.0414974,0.261561,0.234894,0.0752193,-0.572568,-0.108025,0.261014,-0.48576,-0.928081,-0.627023,0.085794,-0.693983,0.77218,0.203856,-0.163018,-0.419889,0.148049,0.908674,-0.237792,0.159898,-0.015109,-0.273949,0.0447895,-0.19406,-0.400807,0.484359,0.0620065,0.999907,0.100084,0.368083,-0.259076,-0.170335,-0.428384,0.48077,-0.604454,0.50572,-0.310916,-0.0127999,0.425148,-0.0846142,-0.619453,-0.208566,-0.0892685,0.3726,-0.165014,0.402199,0.903795,0.396772,0.781575,0.0849953,0.530709,0.43373,-0.482075,-0.111844,0.157588,0.423875,-0.169509,0.130253,-1.15006,-0.587591,-0.3192,-0.666145,0.360857,-0.340558,-0.33266,-0.146799,-0.390044,0.131744,0.557979,0.316968,-0.344654,0.296038,0.236268,0.191902,-0.14788,-0.171798,-0.0992856,0.187536,-0.040512,-0.296465,-0.127481,-0.0227266,-0.484083,-0.00544586,-0.148359,1.30411,0.307003,-0.94589,0.702931,0.195841,0.380272,0.174835,-0.318326,-0.655279,0.0785484,0.078322,0.159681,0.543543,-0.235055,0.24749,-0.495677,0.23435,-0.338845,0.332325,-0.280072,-1.10849,0.478202,0.417689,0.241626,-0.163505,-0.158283,0.194853,0.24619,0.441422,0.496175,-1.36029 +3365.36,0.999149,0.0848144,5,1.41001,0.80614,-1.46489,0.395049,0.489163,-0.0257557,-0.223819,-0.598317,-0.0535722,0.135231,0.182586,-0.132562,0.25151,0.247937,-0.588721,0.597463,-0.174895,0.267038,-0.396583,-0.0590741,-0.279073,-1.41446,-0.0918325,-0.00679833,0.0851436,-0.603895,-0.343181,0.00182691,-0.319978,-0.0397543,0.470544,-0.745155,-0.79422,0.42989,0.313329,0.17763,-0.587488,0.923171,1.34104,-0.610019,1.37621,0.882829,0.47624,-0.194232,0.392218,1.14305,-0.232048,1.0311,1.04979,0.328274,0.264455,0.167014,0.741566,0.217142,1.31875,0.129238,-0.0667374,-0.603744,0.80988,-0.412202,0.0385194,0.881328,-0.599681,-1.51103,0.0637523,0.192197,-0.0175795,0.0811516,-0.688666,-0.405131,-0.133889,0.433377,0.735081,0.494508,0.390854,0.741663,0.651836,0.50234,-0.391714,-0.0969443,0.760546,-0.843861,0.556898,-0.388686,0.38867,-0.193582,0.460447,-0.371394,-0.0576863,-0.0191036,-0.436141,0.663801,0.236236,-0.0173238,-0.406484,-0.509306,-0.618055,-0.905076,0.667126,0.0443811,0.242462,0.122835,-0.54772,-0.510298,0.259206,-0.810303,0.531474,-0.335448,0.72012,0.808489,0.0474098,-0.112475,0.282493,0.026914,0.581973,0.00948129,-0.367034,-0.034337,0.80238,0.0715514,-0.633215,0.579582,0.425097,-0.264306,0.190229,0.578007,0.823303,0.438037,-0.1012,-0.553709,-0.717694,0.117521,0.0608499,0.659923,0.296466,-0.305948,0.0458893,-0.080798,0.437678,0.57631,-0.809194,0.134741,-0.192677,0.236352,-0.483573,0.329293,-0.0689347,0.585931,0.213108,-0.356405,0.561879,-0.377586,0.520249,-0.027941,1.09597,-0.0157143,-0.438606,0.805684,-0.0987155,-0.0715114,0.645625,-0.323773,0.846498,-0.457479,0.48312,0.37982,-0.0500297,0.070461,-0.0953695,-0.0253795,0.121908,-0.193483,-0.194414,-0.414169,0.107706,0.156791,0.102381,-0.276452,-0.92758,0.704554,-0.156747,0.748659,0.0770638,0.189286,-0.0767685,-1.20128,0.0507452,-0.380215,0.0895071,-1.23083,0.182608,0.295794,0.106223,-0.832923,-0.121316,0.480963,-0.12199,-0.0617617,-0.303911,-0.683629,0.345574,-0.935216,0.651351,-0.268815,-0.590245,-0.201346,-0.399064,1.50251,0.147511,1.09899,0.37344,0.181405,0.488727,0.269121,-0.475631,0.213239,0.115335,0.134132,0.548364,-0.46224,0.300331,-0.53443,0.225105,0.93017,-0.800197,0.159885,-0.220626,-0.361994,0.496928,0.0244463,-1.19871,-0.396337,0.257382,0.0885477,-0.0912012,0.299104,0.448342,0.182215,1.15967,-0.117446,-0.0983056,0.333433,-0.372314,0.276359,0.100339,0.396565,0.119207,0.427844,-0.918682,-0.266075,-0.069347,-0.936978,0.547332,-0.339338,-0.0980572,0.0390267,-0.261514,0.0590807,0.271188,0.196032,-0.354484,0.985786,0.484038,0.325957,-0.16407,0.262461,0.0134624,0.0611639,0.204099,-0.395791,-0.408064,-0.503988,-0.322888,-0.371231,0.146945,0.560528,0.198237,-0.361124,0.323589,-0.201227,-0.498376,-0.818297,-0.771733,0.00475315,-0.62393,0.359093,0.15993,0.190949,-0.716692,-0.684977,-0.082441,0.00101636,-0.0269092,0.70008,-0.103911,-0.0377059,0.188844,0.158596,0.101974,-0.387644,-0.503952,0.261554,0.417308,0.511424,0.645994,-1.23766 +3373,0.995921,0.0848144,4,1.40725,0.690994,-1.41512,0.427022,1.07646,-0.0452644,0.505411,-0.776476,0.271506,-0.469074,0.566583,-0.148917,-0.146596,0.0668097,-0.57141,0.589755,0.0344453,-0.133232,-0.596173,0.366119,-0.0909288,-1.43568,-0.587918,0.159964,-0.00220962,-0.536539,-0.0683608,-0.00151118,-0.484937,0.0343013,0.675272,-0.977898,-0.144115,0.568757,0.224972,0.190607,-0.458706,1.05957,0.971386,-0.194188,1.31309,0.988408,0.0549408,0.111779,0.16845,0.672965,-0.115623,0.17416,1.12282,-0.0981349,0.475654,0.81919,0.435505,0.12716,1.32199,-0.148345,0.398947,-0.769914,0.756468,-0.460228,0.207625,1.26811,-0.0936704,-0.893676,0.150241,-0.0222825,0.293547,0.0472435,-0.344784,-0.954348,-0.465721,-0.322781,0.709897,0.423746,0.581271,0.61664,0.457933,0.0486946,-0.611679,-0.114231,0.970471,-0.345186,0.586118,-0.212712,0.0918559,-0.144249,0.792272,0.0233725,-0.0732845,-0.325893,-0.6669,0.892844,0.0170141,-0.44682,-0.0697562,-0.223724,-0.078291,-0.830296,0.616299,0.181584,0.0546126,-0.216048,-0.471287,0.0600842,0.138154,-0.643484,-0.302652,-0.69517,0.703682,0.579257,0.204704,-0.0278736,0.127923,0.460303,0.382527,0.0873546,-0.455514,0.370666,0.30355,0.0473117,-0.547716,0.0583588,0.19838,0.276903,-0.367179,0.462133,0.371365,-0.043059,-0.183521,0.0281302,-0.209434,-0.026653,0.338877,0.908774,-0.169252,0.065108,0.569543,-0.710936,0.769504,0.0625219,-0.660855,0.241239,0.269338,0.261387,-0.474872,0.641764,0.196311,0.440824,0.0469657,-0.123942,0.405976,-0.174524,0.17526,-0.231192,0.75037,-0.111798,0.201029,0.29504,0.0754894,0.0530445,1.18828,-0.283271,0.86758,-1.05302,0.229949,0.218542,-0.0606398,0.889687,-0.375442,-0.456451,0.180179,-0.485923,-0.263642,-0.692303,0.332639,-0.188536,0.285919,0.349947,-0.542665,0.877098,0.366036,-0.265159,0.166146,0.0151202,0.317334,-0.707297,-0.105505,-0.498161,0.440433,-0.903326,0.208032,0.839766,-0.0839333,-0.15076,0.320713,0.402938,-0.152329,0.0138897,0.0899124,-0.448699,0.13647,-0.525174,0.786258,0.127959,-0.254132,-0.0851967,-0.423165,1.1053,-0.285918,0.365643,-0.132255,-0.0283145,0.428725,0.147623,-0.374736,0.403292,0.18927,0.128607,0.0818646,0.173258,0.18923,-0.475179,0.390736,0.1113,-0.261707,-0.491062,-0.126381,-0.465375,0.702797,0.0359825,-0.676593,0.00323461,0.521896,-0.145619,-0.436381,0.557867,0.226088,-0.345735,0.620181,0.0854333,-0.0849472,0.00896417,0.0638719,0.616074,-0.0506974,0.629256,0.589104,0.179301,-0.666903,-0.524244,0.481339,-0.866043,0.334689,-1.18394,0.240009,0.0858166,0.209307,0.421108,0.404854,0.306466,-0.0558625,0.720905,0.957116,-0.0258317,-0.0134387,-0.392162,0.379611,-0.367309,0.273099,-0.121122,-0.129994,-0.492429,-0.648061,-0.2199,-0.062314,0.505796,0.0268855,-0.195698,0.824136,0.354301,0.397727,-1.28478,-0.686755,-0.65339,-0.526974,0.0595233,0.053882,0.169342,-0.599841,-0.494044,-0.111291,0.234304,0.409039,-0.156622,0.0742066,0.18074,0.341556,-0.106431,-0.0309125,-0.622445,-0.477665,0.18108,0.41456,0.425535,0.643863,-3.03812 +3387.83,0.585551,0.0848144,4,1.44021,0.710652,-1.29075,0.365403,0.167953,-0.0687719,-0.223036,-0.427027,0.37546,-0.218192,0.25061,-0.165217,0.101662,0.579982,-0.156617,0.911917,0.283226,0.227355,-0.351917,0.299911,-0.161637,-0.892466,-0.97432,0.177859,-0.268668,-0.220311,-0.37321,-0.27944,0.0895889,0.227858,1.02076,-0.347852,-0.433037,0.33125,0.221914,0.145824,-0.30061,0.590221,0.686968,-0.425701,1.51047,0.932513,0.0428825,-0.79113,0.404884,-0.126327,-0.30242,0.613283,1.23213,0.361063,0.326275,0.521054,0.742558,0.0894562,1.19155,-0.102259,-0.190318,0.0100958,0.307331,0.0595703,0.725102,0.902902,-0.970375,-1.02242,0.325638,-0.383479,0.257895,-0.700781,0.332531,-0.347617,-0.123307,0.424723,0.340627,-0.0552035,0.339541,0.652623,0.231525,-0.0557974,-0.560849,0.253288,1.05808,-0.459194,0.38891,-0.397091,-0.454998,-0.0726455,0.134565,-0.250811,0.367283,-0.100499,-0.782374,0.299686,-0.129927,-0.356629,-0.0635056,-0.32926,-0.150143,-0.723581,-0.0712933,0.164116,-0.430277,-0.367405,-0.235939,-0.374258,0.670279,-0.383064,0.25291,-0.569667,0.416742,0.672485,0.0289739,-0.346907,-0.32957,0.180435,0.438497,0.425813,-0.373196,0.26601,0.283321,-0.979476,-0.585784,0.813569,0.00586334,0.260361,-0.52427,-0.161372,-0.0213031,-0.199657,-0.240792,-0.674755,0.104473,-0.268605,-0.352188,-0.330884,0.19863,-0.239537,0.0684309,-0.512693,0.297241,-0.37288,-0.830672,0.491052,-0.12452,-1.06247,0.839935,0.00532327,-0.837042,0.415153,-0.380294,-0.488778,-0.137316,0.484383,0.13706,0.285079,0.570987,-0.206537,0.46047,0.155546,-0.345992,-0.482473,0.46928,0.326821,0.389686,0.0693383,0.135289,-0.0824699,-0.672796,-0.21099,-0.227146,0.227608,0.146694,-0.500866,0.00941543,-0.218056,-0.425484,0.210559,-0.0536845,-0.356034,-0.100419,0.995405,0.577654,0.0718735,0.891018,-0.226922,0.751906,-1.08151,-0.0223326,-0.133379,-0.0935174,0.0804802,0.0133722,-0.933222,-0.0884949,-0.172014,0.0839589,0.348078,0.0720893,-0.514006,-0.17159,-0.285297,0.505812,-0.69044,0.406723,0.145668,-0.718497,-0.486664,-0.631257,0.970081,0.159747,0.000780135,0.134564,-0.216641,0.275697,0.160022,-0.350582,0.183736,-0.0211657,0.0812939,0.299948,0.0358331,-0.0255809,-0.301353,0.269586,0.0223575,0.319326,0.310076,-0.531365,0.161212,0.129023,0.0234344,0.618481,-0.058653,0.00859083,-0.684488,-0.596906,0.714454,0.0750933,0.200225,0.762914,-0.69935,-0.00832429,0.332304,-0.357305,-0.0314874,0.806867,0.948818,0.148876,0.354708,0.0803955,-0.317377,0.272686,-0.838867,0.546561,-0.462702,-0.0370529,-0.377206,-0.1848,-0.122502,0.502307,0.305368,0.119578,-0.0780721,0.021804,0.653328,0.413241,-0.0809412,-0.24239,0.36934,0.10425,0.0701398,-0.477311,-0.409134,0.931774,-0.307959,0.201123,0.262632,-0.229133,-0.53399,0.440028,0.15239,-0.483845,-0.116652,0.297493,0.436184,-0.310617,0.175233,-0.139011,0.540568,-0.448905,-0.517119,-0.0783698,-0.412507,0.104449,-0.112645,-0.110394,-0.706174,0.230655,0.256005,0.43795,-0.362219,-0.252711,0.169034,0.310276,0.411137,0.557024,-0.0249141 +3392.86,0.477292,0.0848144,4,1.42002,0.709192,-1.03175,0.292436,0.268897,-0.0855354,-0.229149,-0.577668,0.534764,-0.507466,0.346906,-0.0288804,-0.0299052,0.711408,-0.0247043,1.10199,0.244618,0.229628,-0.388094,0.240715,-0.134172,-0.827468,-0.951195,0.18787,-0.290175,-0.458233,-0.450241,0.0198247,0.149676,0.300007,1.04842,-0.815073,-0.151812,-0.0177727,0.311364,0.230947,-0.492262,0.779277,0.740021,-0.653025,1.47026,1.09809,0.185127,-0.591077,0.4562,-0.230881,-0.217023,0.330419,0.930606,0.3991,0.215125,0.29895,0.711056,0.00465418,1.13349,-0.102711,0.0258929,0.00678671,0.591486,-0.0563007,0.524391,0.863922,-1.07319,-1.09656,0.0384975,-0.329853,0.522065,-0.448152,0.414253,-0.2911,-0.163912,0.0701645,0.391455,-0.28059,0.365778,0.722705,0.0845066,-0.427392,-0.652428,0.264578,0.889804,-0.42546,0.320729,-0.509254,-0.404166,0.0938921,0.10282,-0.357342,0.256029,-0.193418,-0.791788,0.205259,0.0173602,-0.19043,-0.104595,0.087289,-0.223974,-0.745095,0.0158071,0.412094,-0.273841,-0.51159,0.191975,-0.487434,0.485362,-0.167313,0.388402,-0.26789,0.206579,0.758896,-0.0785686,-0.284142,-0.39774,0.312382,0.583533,0.331588,-0.367715,0.418351,0.236174,-0.722706,-0.338504,0.707481,-0.256691,0.116166,-0.404193,-0.123818,-0.0731075,-0.417285,0.0463084,-0.770734,0.129486,-0.116449,-0.417407,-0.415691,0.185618,-0.191358,0.0921954,-0.506073,0.204551,-0.453642,-0.702111,0.409526,-0.128269,-0.998468,0.742338,0.232791,-0.792087,0.350686,-0.5271,-0.167955,-0.14813,0.449153,0.225914,0.256675,0.564962,-0.0744442,0.488728,0.0337804,-0.427782,-0.22314,0.388553,0.40609,0.252266,-0.126422,0.0765405,-0.0854934,-0.409115,-0.212278,-0.286489,0.365241,-0.0478942,-0.54912,-0.010502,-0.176931,-0.302938,-0.0295368,-0.047884,-0.22192,-0.15641,1.01103,0.514251,0.261462,0.763245,0.0402407,0.890715,-0.75874,0.0403621,-0.366866,-0.169571,0.0484046,-0.0547202,-0.725913,-0.0985537,-0.392473,0.0322071,0.406188,-0.111128,-0.277976,-0.188303,-0.408556,0.454715,-0.66068,0.332603,0.230229,-0.80432,-0.293618,-0.8745,0.642088,0.0464747,0.184991,0.285435,-0.311826,0.259075,0.433546,-0.542396,0.296096,0.194019,-0.0896237,0.420415,-0.240279,0.0815595,-0.420373,0.370812,0.137925,0.0853692,0.17963,-0.421558,-0.0340974,0.0314887,-0.105875,0.33504,-0.0899643,0.143161,-0.443188,-0.484891,0.850997,-0.0771024,0.138762,0.410874,-0.904381,-0.218482,0.280926,-0.200095,0.366755,0.37769,0.90739,0.0501324,0.399975,0.480481,-0.492756,0.0694945,-0.886837,0.312579,-0.494652,0.0305716,-0.000985666,-0.193281,-0.113493,0.344758,0.27624,0.312092,-0.116892,0.516383,0.936449,0.285506,-0.00115654,-0.326054,0.233687,0.557662,0.12403,-0.3755,-0.549313,1.08958,0.0320638,0.0849781,0.26163,-0.254836,-0.427119,0.472168,0.0133164,-0.453132,0.0998587,0.440802,0.294396,-0.39877,0.228766,0.120583,0.741149,-0.425525,-0.49493,-0.216576,-0.172816,0.24936,-0.157144,0.159237,-0.489915,0.00774024,0.134869,0.450411,-0.120828,-0.224385,0.190079,0.340085,0.435981,0.583168,-0.440326 +3384.14,0.982122,0.0848144,4,1.40988,0.691547,-1.41204,0.465578,0.32216,-0.12556,0.0165988,-0.231662,0.360233,0.183618,0.27444,0.246385,0.000656936,0.739115,-0.137581,1.10896,0.0545649,0.132622,0.0345988,0.540851,0.0571358,-1.2367,-0.74341,0.0310126,-0.149715,-0.173772,-0.220086,0.341393,0.0597038,0.0275503,1.12391,-0.522272,0.00563304,0.120703,0.332227,0.0460227,-0.37276,0.765578,0.541119,-0.21315,1.39152,1.15767,0.622843,-0.723711,0.584321,-0.480259,-0.349861,0.110729,1.02328,-0.0005856,0.471009,0.401903,0.531773,0.794298,1.01129,0.22945,0.143018,0.282951,0.180781,-0.162247,0.41425,0.898623,-1.04783,-1.23249,0.446042,0.119546,0.491194,0.0198895,0.624908,-0.594607,-0.762035,-0.0392078,0.422819,-0.0242663,0.513481,0.222208,0.13651,-0.581068,-0.663428,0.152429,0.593014,-0.541881,0.564894,-0.287762,-0.165327,-0.0855468,-0.148017,-0.695482,0.286648,-0.587326,-0.734068,0.197205,0.0312471,-0.657133,-0.103199,0.0169236,-0.139339,-0.841096,0.691013,0.147465,-0.398566,-0.723208,0.162135,-0.476924,0.457135,0.0837108,0.390799,-0.160536,-0.161541,0.796122,0.239584,-0.535556,-0.358067,0.267351,0.264568,0.360373,-0.215453,0.543609,0.218957,-0.361028,-0.188896,0.241773,-0.347332,-0.00796014,-0.804801,0.214788,-0.00968702,0.222764,-0.046363,-0.791579,-0.0478177,-0.282855,-0.199997,-0.42769,-0.0893035,-0.14322,0.642338,-0.15335,0.0761152,0.229598,-0.264354,0.309017,-0.578586,-1.01991,0.707427,0.00752915,-0.522829,0.394384,-0.337603,-0.179502,-0.0564368,0.273496,0.00457244,0.259017,0.413603,-0.033139,0.511216,0.557414,-0.0851028,-0.206427,-0.076987,0.281241,0.311761,-0.273505,-0.112899,0.204518,-0.735546,-0.0552851,0.0791965,-0.102433,0.750975,-0.465685,-0.0804498,-0.418732,-0.399794,-0.0720923,-0.114626,-0.216714,-0.17826,1.22958,0.408468,-0.00814617,0.677386,-0.0644498,0.620449,-0.931294,0.409248,-0.348978,-0.25399,-0.102407,-0.1042,-0.691201,-0.54806,-0.485098,0.088872,0.644527,-0.353501,-0.153449,-0.26846,-0.445719,0.205594,-0.920677,0.308326,0.049503,-0.621362,-0.398454,-1.0569,0.754366,0.318991,0.574815,-0.0199636,0.131444,0.531756,0.233913,-0.401787,0.487923,-0.364309,-0.0273383,0.405011,-0.320726,0.233148,-0.322005,0.293317,-0.0722716,-0.497513,0.207439,-0.410617,-0.462616,0.194075,0.190794,-0.323728,-0.110093,0.144758,-0.267373,-0.719937,1.01395,0.179988,-0.188043,0.686859,-0.511321,-0.0535945,0.229875,-0.190541,0.821264,0.433671,0.672087,0.00959796,-0.0782506,0.463077,-0.585863,0.128212,-1.13827,0.601066,-0.237661,-0.470011,-0.124016,-0.19705,0.0117671,0.639133,0.214275,0.182482,0.0671798,0.270559,0.867599,0.293702,0.106512,-0.102994,-0.00750828,-0.209398,0.0881597,-0.271364,-0.459061,0.339043,-0.355679,-0.0395931,0.29454,-0.17988,-0.408484,0.449891,0.0156357,-0.472658,0.158647,-0.0922158,0.0571278,0.157791,0.335949,0.110753,0.851641,0.10576,-0.692777,0.151992,0.0888256,0.243648,-0.43871,0.133203,-0.655772,-0.0811271,0.0269721,0.448884,-0.370924,0.133017,0.153904,0.257377,0.392307,0.507323,-0.550481 +3398.14,0.997935,0.0848144,4,1.42386,0.720661,-1.21199,0.35918,0.148716,-0.20241,0.325978,-0.41914,0.391728,-0.12945,0.311953,0.38635,0.140939,0.76345,0.189587,1.22859,0.256958,0.0711203,-0.165026,0.492039,0.128455,-0.742541,-0.766577,0.211793,0.0491354,-0.273803,-0.0496986,-0.00236948,-0.143037,0.0838182,1.06473,-0.604206,-0.0457928,0.379184,0.170812,0.173439,-0.383581,0.912861,0.65431,-0.164529,1.35429,1.21053,0.567937,-0.711039,0.449446,-0.393632,-0.320013,0.383527,0.796846,-0.14229,0.194658,0.464749,0.338632,0.228829,1.03611,-0.0964217,0.163412,0.192452,0.215231,-0.224656,0.576891,0.873197,-1.17098,-0.969558,0.376204,0.0305629,0.317589,0.0532799,0.481451,-0.791983,-0.751048,-0.0314388,0.465343,-0.164862,0.446122,0.214351,0.176025,-0.608456,-0.663001,0.0800358,0.905609,-0.518678,0.566492,-0.192717,-0.117936,-0.419546,-0.11375,-0.57652,0.138458,-0.655355,-0.817144,0.075478,0.186063,-0.520349,-0.0522957,-0.0847635,-0.136771,-1.02986,0.361693,0.235307,-0.394972,-0.605513,0.17012,-0.130752,0.498143,0.121443,0.382814,-0.215108,-0.328816,0.736574,0.237397,-0.661423,-0.368147,0.258317,0.173202,0.571781,-0.0422286,0.608877,0.156025,-0.150369,-0.649851,0.0828888,-0.230721,0.0146704,-0.907357,0.292487,-0.181761,0.203007,0.220216,-0.877762,0.188999,-0.337601,-0.219056,-0.509674,-0.022327,-0.388152,0.48843,-0.277041,0.0757144,0.154383,-0.060846,0.275766,-0.760875,-0.757658,0.606946,-0.107697,-0.487694,0.440498,-0.412746,-0.164491,-0.196371,0.10778,0.0270615,0.0788522,0.91602,-0.15671,0.751545,0.481721,-0.114584,-0.196948,-0.306188,0.116221,0.174,-0.228879,0.047277,0.0498441,-0.626743,-0.310103,-0.102245,0.0430077,0.446091,-0.561555,-0.0123917,-0.26362,-0.547595,-0.168358,-0.086693,-0.116377,-0.230513,1.14424,0.103195,-0.016966,0.772663,-0.19029,0.785157,-0.65754,0.276938,-0.415727,-0.0570186,-0.161069,-0.0647734,-0.837945,-0.273388,-0.274182,-0.1147,0.206714,-0.409095,-0.0653874,-0.00237942,-0.182715,0.179081,-1.00084,0.0625722,-0.0474593,-0.708343,-0.415103,-1.12165,0.787619,0.503095,0.553891,-0.222152,0.163096,0.307773,0.197897,-0.227652,0.429581,-0.408086,-0.107576,0.317167,-0.230335,0.413645,-0.179018,0.185029,-0.165606,-0.556158,0.609081,-0.240254,-0.367572,0.154941,0.273886,0.0845514,0.116418,0.356215,-0.0381271,-0.863437,0.952922,0.282423,0.0889929,0.816473,-0.371899,-0.0585458,-0.0131377,-0.287082,0.560931,0.341847,0.740407,0.0722571,0.0491786,0.344353,-0.473474,0.112054,-1.01112,0.35465,-0.529023,-0.452018,-0.139886,-0.246522,-0.0208602,0.47443,0.28563,0.145746,-0.0415629,0.336207,0.737277,0.197301,0.320959,-0.157506,-0.137163,-0.388427,0.104864,-0.0914221,-0.145037,0.359992,-0.51587,0.0712183,-0.0628783,-0.1582,-0.495555,0.183305,0.248108,-0.375785,0.18151,-0.361358,-0.124226,0.184076,0.340743,0.0743006,0.973719,0.0896256,-0.477708,0.0629363,0.244173,0.0621345,-0.306426,0.324116,-0.548149,0.0141445,0.296765,0.509002,-0.403684,0.116281,0.152491,0.270963,0.390501,0.520541,0.00283293 +3417.08,0.959192,0.0848144,4,1.58114,0.706541,-1.50679,0.624647,0.926696,-0.151313,0.295771,-0.680044,0.141832,-0.158303,0.376283,0.0036332,-0.47333,0.265638,-0.163695,0.693618,0.231266,0.138246,-0.154885,-0.00233846,0.0114026,-1.09904,-0.874671,0.111396,-0.094584,-0.0954692,-0.190297,0.439893,-0.235891,0.0639784,1.03794,-0.598742,0.197113,0.376823,0.286278,-0.30051,0.107803,0.45962,0.636403,-0.22067,0.910977,0.532921,0.141031,-0.793097,0.0862807,0.470949,-0.57875,0.209294,0.473113,0.375739,0.0349386,-0.0530007,0.507137,-0.397855,0.630092,-0.127289,-0.176301,-0.771016,0.369077,-0.29361,0.253589,0.732882,-0.123564,-0.680173,0.00120862,-0.673275,0.341307,-0.473307,0.110887,-0.413081,-0.438917,0.338682,0.690356,-0.821137,-0.144117,0.555735,0.289251,-0.134249,-0.307518,-0.211929,0.612455,-0.0761864,0.361994,-0.230904,0.141503,0.261284,0.18346,0.0184868,0.11387,-0.443689,0.745164,0.0170763,-0.172768,-0.326482,0.156705,-0.405705,0.412753,0.144759,0.282204,0.164559,0.1302,0.347141,-0.400833,-0.729884,-0.418833,-0.0429208,0.155321,-0.647306,0.8884,0.576406,0.220729,-0.199957,-0.480775,0.44534,-0.0668434,-0.235409,-0.4536,0.159963,0.422382,-0.168873,-1.03258,-0.0131302,-0.0607789,-0.124156,0.103225,0.194977,0.564051,-0.831473,-0.126504,-0.30309,0.0639455,0.268256,-0.135812,0.599636,-0.607402,-0.235176,-0.0922773,-0.406575,0.532782,-1.0321,-0.253056,0.15221,0.316888,-0.699264,-0.207122,-0.055127,0.297757,0.227735,-0.284016,-0.425367,-0.400987,0.208984,-0.295347,0.0092485,-0.196678,0.642822,-0.246991,-0.0424515,0.070812,-0.359286,0.184914,0.439476,0.816842,0.509821,0.382003,-0.261607,0.000595495,-0.317062,0.0579415,0.615694,-0.139713,0.661932,-0.132561,-0.156707,0.416799,-0.530578,-0.246304,-0.178838,0.34788,0.877498,-0.380498,0.604625,-0.216119,-0.470092,0.0259537,0.0619038,-0.575219,-0.332183,-0.230405,-0.569809,0.0732683,0.399242,-0.115807,-0.748599,0.117674,0.544303,-0.0251796,-0.271679,-1.11942,0.284629,0.305628,-0.503842,0.481537,-0.128652,-0.348278,-0.279891,-0.170187,0.581858,-0.399138,-0.342186,0.387201,-0.919212,0.114976,-0.400419,-0.247317,-0.0553038,-0.52023,0.0834759,0.0420332,-0.0178943,0.451263,-0.20872,0.115967,0.425446,-0.030688,-0.058437,-0.19647,0.00157146,0.023503,-0.889516,-0.562693,-0.113888,-0.399871,-0.241014,-0.550324,0.369732,0.210017,0.00709909,0.852399,0.320783,-0.213607,-0.734679,-0.109359,0.487852,-0.199345,0.27591,0.547305,-0.207563,-0.685941,-0.378413,-0.0288754,-0.25902,0.359038,-0.00731371,0.097481,0.174308,-0.323496,0.589871,0.00131785,0.614162,-0.272047,0.899519,-0.118908,-0.14852,-0.0687454,0.216727,-0.190425,0.392353,-0.0902137,0.137923,-0.570364,0.0907012,-1.01362,0.577655,-0.177957,0.0296936,0.129141,-0.243113,0.867,0.358375,-0.328388,0.155019,-0.0201906,0.280344,0.0181055,-0.00282157,0.115669,-0.295806,0.144,-0.0292476,0.0136399,0.358472,0.118945,0.244443,0.0514843,-0.968833,-0.0895893,-0.11777,0.228367,0.396109,-0.0144973,0.150015,0.24117,0.387318,0.491091,-2.50729 +3393.6,0.941736,0.0848144,5,1.38898,0.897829,-0.593117,0.124034,0.269885,-0.0899964,0.141526,-0.0475864,0.817703,0.766348,0.383996,-0.00952784,0.160098,0.426052,0.0373836,1.13038,0.337614,-0.204191,0.068066,0.515533,-0.333568,-1.04617,-0.863685,-0.238001,-0.432209,-0.677786,-0.0323771,0.352724,-0.0914201,-0.054719,0.781672,-0.79666,0.575058,0.370795,0.0289277,0.211671,-0.41507,0.0913291,0.63974,0.389199,1.0775,0.732746,0.241076,-0.422651,-0.395765,-0.219164,-0.525125,0.660062,1.05564,0.0258929,0.472157,0.140197,0.456349,-0.499894,0.823814,0.487991,0.23322,-0.639235,0.611402,-0.26141,1.00257,0.950804,-1.10685,-1.69151,0.717281,0.518925,1.068,-0.29683,-0.114377,-0.622027,0.229741,0.635594,0.667251,0.318268,0.473518,0.284453,0.459215,0.309654,-0.299929,0.230388,1.18891,-0.418314,0.793544,-0.299148,0.233205,-0.214972,-0.336562,-0.466144,0.456793,-0.443562,-0.552215,-0.761618,0.396759,-0.0152582,-0.21248,-0.0436254,-0.246228,-0.479145,-0.439302,0.435364,-0.984084,-0.184619,-0.317756,0.315911,0.406351,-0.775967,-0.380065,-0.604393,-0.597746,0.413069,-0.166591,-0.556654,0.22057,0.601788,-0.248075,-0.152678,-0.441669,0.00777481,0.24223,-0.41962,-0.63111,-0.581099,-0.364304,-0.0777962,-0.508929,0.256529,-0.279423,0.547393,0.0200477,-0.571608,-0.189361,-0.118826,-0.161444,-0.0151776,0.338567,0.148384,-0.102897,-0.421922,0.532372,0.0618104,-0.235568,0.589424,0.471198,0.0730919,0.558748,0.235609,-0.18934,0.681859,-0.162494,0.0670807,-0.60494,0.0470715,-0.245162,-0.0261312,0.751708,0.380195,0.331764,-0.780556,0.145688,0.162798,0.47155,0.0108242,1.22455,0.182997,-0.246688,0.502978,-0.415552,-0.522332,-0.510057,-0.555597,0.236045,0.266548,0.261961,-0.713405,-0.400289,0.27006,-0.507078,-0.0734211,-0.658478,0.78247,0.251256,-0.375993,-0.162591,0.412575,0.260548,-0.596757,-0.506215,-0.348516,-0.0902046,0.129148,0.171628,-0.284246,0.0288791,-0.295221,0.340597,0.0557311,0.375485,-0.00159854,-0.146364,0.718985,0.398588,0.328503,0.670349,0.0518428,-0.00613348,-0.0630646,-0.602526,0.934453,0.181696,-0.0282136,-0.0507155,-0.018253,0.174603,0.624158,-0.0260131,0.253968,0.0966366,0.234493,0.632981,-0.756433,0.168863,-0.466961,-0.360101,0.293313,-1.04703,0.325813,-0.269877,-0.429697,0.143713,-0.219085,-0.203257,0.384586,-0.493217,0.0390626,0.232947,0.873103,-0.260502,-0.565784,0.584454,-0.643026,-0.491344,-0.0850657,-0.33082,0.110061,0.260096,-0.223815,0.184925,0.404764,-0.0587063,-0.29863,-0.502823,-0.336707,0.382156,0.105815,-0.367696,-0.0791887,0.320922,0.210104,0.0806656,0.477545,0.216091,0.286134,0.134173,0.410781,0.182614,0.432761,-0.0179124,-0.563223,-0.435411,0.151732,-0.315682,0.0699765,-0.620383,-0.40882,0.157136,-0.329652,0.100355,0.232803,-0.0131682,-0.00756927,-0.000198139,-0.449043,-0.301873,-1.1259,-0.262734,0.648321,-0.493777,0.546571,0.00424173,-0.535199,0.360015,-0.152616,0.0870832,0.0322062,0.242455,-0.394441,-0.573348,0.186862,-0.0241111,-0.810575,-0.0477468,0.173285,0.402144,0.416275,0.634149,-0.877794 +3375.41,0.906549,0.0848144,4,1.49395,0.868919,-0.466023,0.0739357,0.00931077,-0.0493971,0.313957,-0.306906,0.664187,0.520224,0.263699,-0.0210305,0.0454911,0.621716,-0.312364,1.2353,0.287882,-0.0118574,0.194454,0.317744,-0.0575423,-0.908303,-1.30184,-0.321256,-0.247263,-0.789364,0.593122,-0.134284,0.332613,-0.368856,0.850193,-0.463938,0.15627,-0.0247585,0.186581,0.183065,-0.304489,0.476289,0.4218,-0.0177533,1.03329,0.606177,-0.138348,-0.482658,-0.579303,-0.213223,-0.421905,0.133358,0.859663,0.363916,0.632316,-0.00664184,0.356469,-0.439185,1.03075,0.0746941,0.084603,-0.736876,0.586453,-0.0233925,0.733807,0.939932,-0.453861,-0.575497,0.283133,0.104117,0.0789351,-0.189048,0.0935772,-0.263759,-0.1287,-0.163207,0.468732,0.642998,0.434351,0.306123,0.855356,0.225025,-0.616327,0.0996139,0.573429,-0.200805,0.537022,-0.184228,0.893755,0.178781,0.748506,-0.401083,0.761806,0.0601749,-0.0903034,0.165664,0.323791,-0.0610204,0.137654,-1.19898,0.0801124,-0.119548,-0.239029,0.646591,-0.109896,0.159103,-0.505186,0.360602,-0.0449733,-1.02497,-0.0144417,-0.308874,0.253574,0.408447,-0.142231,0.252086,0.541144,0.528934,-0.0316609,-0.126364,0.155711,-0.0431758,-0.0968981,-0.726617,-0.896091,-0.462505,-0.000916229,-0.437319,-0.136377,0.975172,0.173407,-0.205318,-0.0460517,-0.398546,0.46447,0.233773,0.107177,0.211338,0.0244706,-0.206508,0.130841,-0.400025,0.249284,-1.31636,-0.0823949,0.763863,0.462613,0.713688,-0.103928,-0.231975,0.301543,0.357129,-0.00286852,0.225305,0.141508,0.263322,0.19783,0.0428198,-0.0635217,0.754227,0.123087,-0.251765,-0.13485,0.240522,1.16275,0.331094,1.34763,0.755056,-0.309021,-0.105933,-0.719847,-0.133505,-0.363507,-0.200625,0.048243,-0.103757,0.164404,-0.401248,-0.554935,0.342114,0.0605612,-0.386327,-0.124058,0.880716,0.0807752,-0.119345,0.48075,0.317004,0.548295,-0.344956,-0.465363,-0.381701,0.354447,-0.15103,0.0792581,0.182501,-0.115014,-0.542584,-0.410735,-0.142939,-0.605037,-0.346014,-0.216814,1.14099,0.733846,-0.219199,-0.174898,-0.42319,0.669845,-0.482219,-0.623753,0.93475,-0.111696,0.383526,0.548146,-0.470413,-0.426295,-0.0133523,0.412671,0.0461822,-0.831329,0.15436,-0.0371627,-0.681733,-0.203863,-0.860001,-0.595625,0.616735,0.261158,0.178684,-0.32009,-0.388652,-0.0256278,-0.0936966,-0.0487499,0.161861,-0.702816,-0.174714,0.110835,0.228816,0.277144,-0.604693,0.48594,-0.136861,-0.801745,-0.654197,-0.738778,-0.867229,0.0991355,-0.167152,0.128288,0.0803405,0.468316,-0.0233492,0.27158,-0.538119,0.340275,-0.077225,-0.154236,0.0308948,-0.194984,0.0617595,0.325485,0.661395,0.712357,0.385395,0.527381,0.563392,0.151865,0.0248828,-0.170494,0.56375,-0.613943,0.148225,-0.112553,-0.482772,0.330055,0.154717,0.341285,-0.320426,-0.0775777,0.466639,0.122021,0.719809,0.547291,-0.610694,-0.135116,0.0044864,-0.502496,0.510514,-0.142941,0.326153,-0.152183,-0.377209,-0.00665395,-0.0414776,-0.378206,-0.234185,-0.143907,-0.389349,-0.56255,-0.319998,-0.641604,-0.747567,0.00598863,0.183241,0.280454,0.428066,0.529579,0.113924 +3385.01,0.751055,0.0848144,5,1.42798,1.07434,-0.287929,-0.0423353,0.628292,-0.0800231,0.203851,-0.186956,1.31211,-0.224335,0.103114,-0.0775756,-0.166895,0.0395588,-0.215559,0.745501,0.227186,-0.0991911,-0.0263662,0.529007,-0.271764,-0.182742,-1.04677,-0.637349,-0.108491,-0.698442,0.304672,0.107365,-0.870992,0.00814326,0.317572,-0.135966,0.3162,0.320135,-0.188905,0.23843,0.193316,0.365948,0.39802,-0.0508103,1.25392,0.512125,-0.146792,-0.623619,-0.267623,-0.110002,-0.550147,0.188512,1.02738,0.201601,0.231083,0.218645,0.282336,-0.539998,1.02827,-0.115671,0.199108,-0.480753,0.873358,-0.168905,0.446096,1.15035,-0.102311,-1.40793,-0.040826,0.629282,0.276272,-0.349996,0.0214122,-0.641822,-0.0493232,0.3968,0.854223,0.052174,0.455552,0.279997,0.571468,-0.0251901,-0.586308,0.149624,0.174362,-1.02862,0.786936,-0.0718788,0.541312,-0.0601268,0.153397,-0.543713,0.375617,-0.448757,0.320125,0.0293591,0.00757373,-0.0443952,-0.29137,-1.36526,0.211352,-0.18839,-0.0372285,0.131451,0.134336,-0.146742,-0.335746,0.290711,0.178411,-0.844851,0.385897,-0.338168,0.218833,0.694402,-0.281063,0.206462,0.494228,0.494043,-0.0674783,0.468088,-0.0865157,0.209285,-0.388623,-0.0372643,-1.13025,-0.39351,-0.0781469,-0.145685,-0.50245,1.11814,0.372475,0.293775,0.505062,-0.260815,0.441359,-0.0445025,0.0255921,0.175316,-0.0639687,-0.597458,0.0563729,-0.357496,0.260684,-0.803301,0.107605,0.595999,0.241956,-0.207054,-0.374854,0.280788,-0.0374199,0.610028,0.387154,-0.0787144,-0.446328,0.181381,0.70819,0.105533,0.504203,0.719873,0.0799523,-0.321812,-0.266056,0.126289,1.0558,0.431821,0.948657,0.432249,-0.298004,-0.00539359,-0.0815319,-0.186394,-0.589604,-0.126212,0.148908,-0.256648,0.099244,0.0260061,0.0197776,0.341051,-0.291745,-0.0435749,-0.390536,0.403034,0.439557,0.0481816,0.470566,-0.345016,0.332371,-0.0187784,-0.0669885,-0.523951,0.00865041,-0.52201,0.0498118,0.113241,-0.103053,-0.829439,-0.323717,0.0440719,-0.0166263,-0.339611,-0.328407,1.23783,0.812218,-0.111431,0.143744,0.032837,0.770733,-0.374756,-0.720971,1.26381,-0.261264,0.598606,-0.0692088,-0.113129,0.10745,0.0727653,-0.202545,0.295603,-0.455881,0.110984,0.218727,-0.540885,0.595963,-0.615168,-0.381694,0.0178425,0.238378,-0.016315,-0.316177,-0.32547,-0.353184,0.549237,-0.622166,0.24481,-0.71224,-0.140766,0.000904469,0.391873,0.374903,-0.306645,0.415039,-0.427039,-0.780911,-0.294059,0.298733,-0.490897,0.0914947,0.0776083,-0.15874,-0.0977374,0.0815371,-0.223626,0.0582743,-1.06595,0.0341058,-0.584689,-0.245231,-0.455901,-0.330458,-0.479929,0.480284,0.604397,0.736372,1.47959,0.200973,0.501093,-0.0718169,0.348565,0.121605,-0.483413,0.505159,0.21473,-0.570546,-0.219426,-0.297432,-0.185518,0.366543,-0.00132426,-0.0858398,0.273172,0.55407,0.0632148,-0.0766779,-0.452845,0.231706,0.0361901,-0.564896,0.050002,-0.187211,-0.252592,0.0908962,-0.469367,0.168389,-0.264284,-0.599876,0.0190626,-0.241621,-0.200657,-0.846886,0.272564,0.158383,-0.670177,-0.244352,0.211635,0.316305,0.460038,0.56241,-2.34576 +3406.15,0.565268,0.0848144,5,1.48656,0.94216,-0.514385,0.115367,0.856623,-0.0730997,-0.48627,0.235243,-0.301812,0.276466,-0.0593116,-0.281868,-0.263067,0.384799,-0.423218,0.92437,0.0929328,0.240883,0.50409,-0.465907,-0.156486,-0.961571,-0.481335,-0.00160195,-0.361232,0.321019,0.0439255,0.442499,0.0319276,0.244132,0.576075,-0.164546,0.275503,0.45547,0.0906619,-0.13883,-0.718847,0.503306,0.721911,-0.0515973,1.11216,0.656663,0.134192,-0.450028,0.208572,0.0709774,-0.465313,-0.0497507,0.650827,0.340828,-0.200783,0.0102925,0.0985711,0.133028,0.844145,-0.0285576,-0.130201,-0.790427,0.498473,-0.742571,0.359823,0.803835,-1.07776,-0.193458,-0.0430066,0.205916,-0.965595,0.048215,0.163726,-0.462812,0.322233,0.876854,0.32848,0.0220228,0.137027,0.460503,-0.278868,-0.481478,-0.154992,0.0261386,0.0376595,0.271167,0.338916,-0.125187,-0.10826,-0.294711,0.403197,-0.20416,-0.0938214,0.271837,-0.608278,-0.674235,0.0178697,0.340292,-0.3187,-0.298933,-0.358206,0.0315142,0.210702,0.130073,-0.0491951,0.534828,-0.0833169,-0.18638,0.1269,0.298347,0.157359,-0.644119,0.304001,0.615382,0.753039,-0.350391,-0.613446,0.725186,0.00782394,-0.22981,-0.64353,0.0706571,0.661954,-0.237897,-0.710755,0.286025,-0.224908,-0.159215,0.637163,-0.143937,-0.00362152,-0.00928636,-0.226228,-0.149399,-0.0158726,0.0447292,-0.0653877,0.420708,-0.435936,-0.0633889,-0.184791,-0.114111,0.54478,-1.00113,-0.818794,0.102933,-0.0566826,-0.391844,-0.112344,-0.155783,0.317696,-0.0216258,-0.172308,-0.589112,0.144152,0.0163454,-0.180356,-0.134381,0.528527,0.332526,0.321767,-0.400535,0.0916379,-0.247628,0.0581689,0.369435,0.789878,-0.433079,0.588394,-0.239178,-0.24124,0.106954,0.30873,0.860756,0.275931,-0.174859,0.280832,0.199109,-0.0808109,-0.17203,-0.0364128,0.292058,0.103163,0.968363,0.380619,-0.180598,0.12576,0.383536,0.00733862,-0.635501,-0.0440189,-0.00788862,0.135275,-0.370662,0.0152884,0.0088814,-0.107531,-0.586965,0.152134,-0.0180552,-0.0869312,-0.154747,-0.845727,-1.04418,-0.165635,0.192783,0.070522,-0.101014,-0.282164,0.782805,-0.349657,1.08663,-0.590274,-0.280945,0.0957758,0.0190075,0.134534,0.0541265,-0.242768,0.254368,-0.608524,-0.179693,0.266298,-0.215269,0.0828239,-0.557552,0.496331,0.715214,-0.580857,0.504701,-0.611504,-0.0551987,0.334612,-0.169488,0.261943,0.282563,-0.226818,-0.326854,-0.42462,0.671202,0.268825,0.313281,0.629702,-0.399345,-0.39164,0.660512,0.428803,-0.312515,0.485469,0.502834,0.770626,0.289168,-0.374849,-0.570793,-0.478434,-0.720002,0.473307,-0.140568,-0.561474,0.75754,-0.149978,0.411474,0.281984,0.154051,-0.683497,-0.369922,0.241767,0.0960227,0.111155,-0.197931,0.25269,0.138583,-0.442769,-0.133524,0.0248865,-0.336784,-0.309742,0.220665,-0.19069,-0.241977,-0.127269,-0.62147,0.348533,0.509809,-0.00371017,0.375766,-0.612033,-0.112414,0.190728,0.144728,0.0719151,0.752621,0.331936,-0.326978,0.0702772,0.37014,0.796891,0.273028,0.108268,-0.214651,-0.347966,-0.548643,-0.0916179,0.191152,0.27828,0.17515,0.216726,0.418509,0.465539,-2.8438 +3390.54,0.808128,0.0848144,5,1.60703,0.848528,-0.772308,0.21212,0.687163,0.0214921,-0.707496,0.477957,-0.181954,0.389138,-0.104577,-0.416896,-0.646495,0.206059,-0.171418,1.13682,0.153641,0.0444996,0.0641202,-0.342546,-0.339306,-0.971207,-0.190171,0.0376452,-0.138362,0.330017,-0.121095,0.251439,-0.705135,0.254179,0.473839,-0.146365,0.469682,0.386597,0.0956213,-0.0819217,-0.401113,0.107498,0.638967,-0.287495,1.18212,0.624099,0.0425862,-0.499275,-0.0208558,0.0226248,-0.625721,0.0225726,0.406099,0.237694,-0.0706915,0.0821711,0.314159,0.381787,0.771736,-0.245118,-0.0568428,-0.853313,0.629215,-0.673731,0.138906,0.835916,-1.15612,-0.501463,0.0187677,0.30011,-0.561786,-0.245815,0.271575,-0.590434,0.454054,0.913758,0.661386,0.121099,0.127878,0.0832862,-0.0278475,-0.560395,-0.12184,0.0301691,0.408611,0.0115069,0.143397,0.201982,-0.378436,-0.442395,0.893926,-0.0149688,0.21821,0.235354,-0.2262,-0.728211,-0.28388,0.00884461,-0.435716,-0.227262,-0.192426,0.0384898,0.261843,0.146829,-0.128836,0.436812,-0.0293828,-0.0270475,-0.0236754,0.390517,0.388214,-0.656351,0.146127,0.678744,0.456199,-0.318357,-0.527494,0.574055,-0.0415444,0.00245,-1.04472,0.174104,0.697118,0.115738,-0.827538,-0.0361065,-0.0707341,-0.144882,0.29209,-0.235928,0.0975554,-0.0947142,0.0160065,0.135384,0.168497,-0.0678251,-0.283882,0.542748,-0.427769,-0.244247,-0.272971,-0.0189799,0.618134,-0.826436,-1.03372,0.0886251,-0.045802,-0.516398,-0.173515,0.264711,0.0823991,-0.138613,-0.010558,-0.421259,-0.0880928,-0.172471,-0.0908434,0.166625,0.542239,0.434044,0.233507,-0.112938,0.0316263,-0.149892,0.210094,0.618385,0.7069,0.0358428,0.450371,-0.543917,-0.222523,0.0616008,-0.00928641,1.02606,0.0149541,-0.302872,0.241196,0.163344,-0.304867,-0.115385,-0.140271,0.235976,0.0416467,0.804823,0.405263,0.10894,0.092323,0.0101777,-0.19403,-0.737101,0.00750945,-0.0313955,0.24806,-0.243783,-0.172446,-0.103805,-0.130679,-0.515698,-0.17347,0.12194,0.0274385,-0.139169,-0.272232,-1.2066,-0.195503,0.107723,-0.162508,-0.532655,-0.255116,0.729652,-0.0195086,0.90258,-0.423447,0.143414,0.208242,-0.606344,0.0829008,0.136219,-0.252988,-0.212956,-0.332362,-0.140378,0.105577,0.0208546,0.297174,-0.474187,0.390006,0.674765,-0.652245,0.512773,-0.56613,0.117134,0.880223,-0.367886,0.39358,0.440539,-0.00167275,-0.315589,-0.164677,0.71873,-0.0624687,0.126058,0.687399,-0.278526,-0.216887,0.31047,0.444497,-0.453803,0.519425,0.304533,0.667838,0.388719,-0.285619,-0.204002,-0.344814,-0.566591,0.326559,-0.399488,-0.25301,0.7188,-0.502785,0.375501,0.386005,0.225744,-0.717988,-0.609876,0.275651,0.195231,0.456888,-0.170718,0.252623,0.133315,-1.04752,0.0110384,0.0505469,-0.265078,0.128644,0.300038,-0.240495,-0.204954,-0.216529,-0.752152,0.651332,0.336314,0.218341,0.451263,-0.927112,0.123141,0.561393,0.0867843,0.191674,0.562048,0.640972,-0.294711,0.0053902,0.45326,0.752896,0.697389,0.19222,-0.629501,-0.187695,-0.397178,0.0859321,0.18695,0.349124,0.171038,0.203784,0.413567,0.451424,-1.97512 +3420.97,0.920337,0.0848144,4,1.47261,0.823962,-1.01991,0.3271,0.894394,-0.103917,-0.377884,0.188751,-0.446804,-0.261292,0.145221,-0.363464,-0.4532,0.148544,-0.239476,0.911278,0.240695,-0.280006,-0.50658,-0.0715094,-0.219016,-0.97954,-0.742204,0.245844,0.104515,0.318495,-0.0956975,0.187661,-0.72486,0.184782,0.680356,-0.610733,0.739171,0.557796,-0.141775,0.127706,-0.199245,0.521822,0.70392,-0.346916,0.983545,0.47421,0.161096,-0.683931,0.0497918,0.665571,-0.620129,-0.0712352,0.568491,0.596247,-0.0943392,0.222903,0.105614,-0.108405,0.602916,-0.129531,0.128138,-0.703874,0.229043,-0.508956,0.274297,1.08867,-0.90313,-0.822035,0.0669728,0.288754,-0.562182,-0.2302,0.215534,-0.191031,0.633141,1.01349,0.814927,0.0513925,0.511137,0.0662305,0.473436,-0.245388,-0.588373,0.299398,0.580602,-0.0434711,0.11079,0.669721,-0.238488,-0.559232,-0.0848896,-0.133582,0.204208,-0.161787,0.352347,-0.878932,-0.172313,-0.0202342,-0.119161,-0.0152301,-0.393629,-0.595899,-0.069267,0.324472,0.0421616,0.363189,0.156853,0.125713,0.144301,0.369353,0.699129,-0.323232,0.0845373,0.646891,0.356559,-0.44378,-0.335174,0.730514,-0.121676,0.0394932,-0.996188,0.410214,0.0828525,-0.101696,-0.68034,-0.240702,0.0920856,-0.177751,0.893832,-0.335376,-0.131051,0.139455,0.244917,-0.424924,0.199943,-0.0321627,-0.238085,0.392723,-0.579963,-0.0587992,-0.157832,-0.0452431,0.634401,-0.688243,-0.743949,-0.104856,0.202505,-0.723415,0.00270376,-0.189711,0.0311472,0.300074,0.103747,-0.25886,-0.252365,-0.111684,0.217695,0.111764,-0.0361224,-0.0403514,0.38847,0.112538,0.18905,-0.222696,0.397204,0.559162,0.728032,-0.143638,0.155717,-0.207692,-0.109828,-0.105752,0.431283,0.169056,0.320921,-0.467225,0.236707,-0.0780639,-0.355623,-0.0648026,-0.0921418,0.0852339,0.000868324,0.813155,0.322996,-0.0822573,0.29625,0.355094,-0.294474,-0.721872,0.138215,-0.404853,0.274838,-0.0360865,-0.159559,-0.123864,-0.173938,-0.245171,0.208464,0.15237,-0.200208,-0.485238,-0.506781,-0.937305,-0.0497203,-0.0613187,-0.335627,-0.0703143,0.13955,0.367299,-0.543913,1.0894,-0.188463,-0.446545,0.13049,-0.414891,0.257567,0.348531,-0.413062,0.496009,-0.167502,0.134237,0.131219,-0.0921583,0.187845,-0.341859,0.0936176,0.709079,-0.477721,0.53636,-0.666968,-0.123968,0.235663,-0.319357,0.201555,0.395438,0.113705,-0.183592,0.256075,0.889492,-0.194038,0.00497233,0.767086,-0.325171,-0.404102,0.307602,0.266924,-0.727365,0.21148,0.173479,0.728184,0.172073,0.178405,-0.47959,-0.117181,-0.602632,0.210086,-0.577056,0.0069229,0.572095,-0.34361,0.539128,0.380162,0.256214,-0.451307,-0.359631,0.501056,0.271249,0.376083,-0.0567533,0.133561,0.115954,-0.758116,-0.11541,0.196109,-0.225471,-0.0927354,0.279127,-0.0349043,0.241136,-0.448251,-0.482179,0.935087,0.384855,0.177101,0.245281,-0.442142,-0.0618149,-0.0710459,-0.0624149,-0.13901,0.768906,0.632918,-0.41588,0.249399,-0.293736,0.218363,0.0253526,0.174238,-1.00781,0.174526,-0.205407,0.231592,-0.0998958,-0.288115,0.162657,0.229415,0.403307,0.478973,-2.70165 +3383.13,0.940405,0.0848144,4,1.62892,0.72332,-1.00148,0.301844,0.978764,-0.0834315,-0.165848,0.750716,-0.148887,-0.0802871,-0.252149,-0.436582,-0.593465,0.250854,-0.463262,0.499357,0.459309,0.109887,-0.276956,-0.219097,-0.129483,-1.32067,-0.488798,0.12979,-0.579382,0.676922,-0.312327,0.723643,-0.537405,0.265511,0.617665,-0.963992,0.247965,0.334268,0.0336447,-0.168581,0.0729669,1.11563,0.474444,-0.00773577,0.970634,0.762074,-0.414778,-0.38981,0.243518,-0.108099,-0.297844,-0.738606,0.370136,0.635724,0.000371205,-0.00782345,0.0813217,-0.231171,0.916806,-0.592572,-0.0493766,-0.597462,0.482196,0.0700475,0.338336,0.739275,-1.05189,-1.38842,-0.0610896,0.544593,-0.132207,0.613772,0.0399525,0.0833245,0.536982,0.78749,0.444296,-0.109549,0.794073,0.206239,-0.0144843,0.0309968,-0.149346,0.151854,0.99278,-0.33441,0.534697,0.00750084,-0.618378,-0.980133,0.249319,-0.378559,0.111432,0.0252137,0.472756,-0.646273,-0.125468,0.210373,0.0545811,0.0106783,-0.838009,0.048733,0.0862659,0.0229845,-0.495209,0.434198,-0.293251,-0.188673,0.244794,0.545026,0.838448,-0.286498,-0.584689,0.518945,0.00858587,-0.28089,-0.351221,0.654088,-0.286287,-0.18111,-0.435079,0.0534005,0.0397719,-0.0119044,-0.469519,0.12423,0.240059,-0.605736,-0.385901,-0.614071,-0.164752,0.226714,0.197286,-0.163883,0.132749,0.10555,0.408797,0.131216,-0.41953,-0.133952,-0.241427,-0.219345,0.320059,-0.913516,-0.2108,-0.0149922,-1.04643,-0.687067,0.018169,-0.0312585,-0.223437,-0.143544,-0.449393,0.0378769,-0.17328,0.139,0.451778,0.0622049,0.361997,-0.264937,0.0933951,-0.171959,0.0811408,0.0698347,0.610377,0.457004,0.372113,-0.453564,0.0847408,0.0890303,-0.00902155,-0.100115,0.161445,0.196869,0.529026,-0.802802,0.292199,-0.130071,-0.0166633,0.202971,-0.231832,-0.379419,-0.254736,0.432788,0.153909,-0.296599,-0.113672,-0.0218925,0.0279826,-0.426931,-0.154803,0.0387068,0.0516285,-0.236144,-0.3501,0.162799,-0.329201,-1.00105,0.278813,0.212335,0.191668,-0.611819,-0.211817,-0.805477,0.00319894,0.103607,0.258451,0.216939,-0.366452,-0.247218,-0.699584,0.909454,0.450617,0.045444,-0.103895,0.100232,0.109554,0.90222,-0.639981,0.061338,-0.49406,0.471699,0.126713,-0.0898432,0.0615607,-0.343595,0.597686,0.0765382,-0.118973,0.337126,-0.659532,-0.137837,0.206497,0.204954,0.0157149,0.405027,-0.198925,-0.108988,-0.101129,0.471315,-0.548822,0.424148,0.591369,0.231307,-0.125676,0.911806,0.5626,-0.796868,0.288136,0.247505,0.574295,-0.197068,-0.148976,-0.320933,-0.597176,-0.422019,-0.182015,-0.444924,0.418777,0.493315,-0.273861,0.533681,0.0723684,0.203801,-0.36443,-0.506637,0.0145567,0.145698,-0.160718,0.154314,-0.022128,-0.0396105,-0.791882,-0.129242,-0.0092836,0.0440009,-0.466235,-0.528357,0.283718,-0.0906242,0.20202,-0.366445,0.955297,-0.0391037,-0.305141,0.2521,-0.256771,-0.530005,-0.0806819,-0.287555,0.114477,0.836694,0.341751,-0.739304,0.397252,0.119385,-0.0941675,-0.0589831,0.740026,-0.722344,-0.140287,-0.293374,-0.623851,-0.163149,-0.431389,0.157291,0.292072,0.396599,0.540437,-2.63836 +3401.86,0.8232,0.0848144,5,1.54705,0.917967,-0.668059,0.16268,-0.155656,-0.0406555,0.032666,-0.40271,0.32184,-0.194616,0.0510406,-0.257405,-0.0682605,0.848124,0.0818941,0.625747,0.117917,-0.0114044,-0.248423,0.238871,-0.256548,-0.880852,-1.35808,0.0683912,-0.460575,-0.86662,-0.089747,0.508661,-0.00384418,-0.285322,0.888202,0.165825,-0.255523,0.142355,-0.13621,-0.189235,-0.468292,0.362566,0.558154,-0.272298,1.09382,0.509687,0.460847,-0.404698,-0.481736,-0.00874244,-0.830655,0.451483,0.436706,-0.269129,0.621623,0.467196,0.434474,-0.670067,0.668077,0.0625655,-0.192652,-0.837258,0.131708,-0.370052,0.0793185,0.98114,-0.398772,-0.599665,-0.25649,0.00257948,-0.288009,-0.589557,0.291487,-0.669499,-0.865138,-0.0636728,0.409384,0.00201662,0.230554,0.429723,0.343954,0.00201361,-0.420558,-0.127301,0.164599,-0.35185,0.340556,-0.194285,0.48672,0.582902,-0.122113,-0.0926047,0.124026,-0.717182,-0.263428,0.544108,-0.0013362,0.0986394,0.260358,-0.666487,0.675111,-0.661821,0.103538,0.533526,0.736133,-0.318921,-0.266261,-0.0571224,-0.0201306,-0.838783,-0.0226925,-0.193701,0.911774,0.323413,-0.0852375,-0.220167,0.399208,0.555129,0.259429,0.0489331,0.0795473,0.185652,0.331991,-0.195779,-1.04761,-0.517445,-0.551529,0.158642,0.49583,0.842943,0.625725,-0.072661,0.227705,-0.620841,0.137181,-0.421718,-0.314639,0.630439,-0.167381,-0.114486,0.228281,-0.0662446,0.0821163,-0.0868098,-0.43818,-0.19954,0.995109,-0.277371,-0.239754,0.25759,-0.0496004,0.595046,-0.126414,-0.0635924,-0.390044,-0.161705,0.200336,0.0186376,0.166642,0.796832,0.0122857,0.108521,-0.0526076,-0.174691,-0.0589536,-0.320623,1.15476,0.408572,-0.0120965,0.493997,-0.162964,-0.385656,-0.449478,-0.135862,-0.192318,0.580867,0.194622,0.0453088,-0.00953378,-0.265905,-0.121342,0.164514,0.610341,0.537883,-0.446432,0.0695881,0.358558,0.0997508,-0.32468,-0.0740121,-0.243493,-0.354815,0.00436204,-0.410847,0.110893,-0.000178728,0.0384667,-0.385,-0.223801,0.166017,-0.0557327,-0.328917,-0.70874,0.974166,-0.252779,-0.508452,0.0362373,-0.761774,0.439317,-0.0333131,-0.164717,0.960886,-0.151043,0.0902716,-0.0769474,-0.102902,0.41069,-0.801233,0.0410018,0.359881,-0.0126322,-0.322164,0.507408,-0.375608,0.100857,-0.347583,-0.760189,0.687615,-0.367112,0.420461,-0.143639,-0.321642,-0.0536408,-0.322774,-0.548148,0.3307,-0.107586,-0.197915,-0.321384,0.581364,0.540501,-0.385556,0.361235,-1.05211,-0.123728,-1.1287,-0.398024,0.708333,0.463715,0.135004,0.433697,0.298856,0.0944815,-0.455826,0.504582,-0.743041,0.569415,0.00922344,-0.760702,0.041238,-0.244809,-0.42583,0.092369,0.32803,0.554378,0.958442,-0.151238,0.274056,0.354369,0.150147,0.02246,-0.0294999,0.54198,0.108489,0.0500489,-0.362153,0.0488756,0.554419,-0.366863,0.100323,0.115933,0.526983,-0.397577,0.28293,0.120956,-0.690529,-0.0313968,0.772246,-0.194259,0.412939,-0.455234,-0.355616,-0.277681,0.326622,0.0574337,0.0817398,0.256597,0.560462,-0.657216,-0.0594422,0.186903,0.234343,0.110049,-0.0601216,0.213813,0.175271,0.246712,0.418653,0.496702,0.647762 +3425.87,0.947276,0.0848144,5,1.59896,1.16386,-0.70042,0.181296,0.365424,-0.180295,0.103047,-0.0165842,0.397093,0.392179,-0.243259,0.121149,-0.213032,0.232617,-0.151448,0.559424,-0.339946,-0.371173,0.182915,-0.0479485,-0.117505,-0.491666,-0.514535,-0.0433951,-0.342442,-0.18963,0.192639,-0.189582,-0.297794,0.211333,0.635992,-0.157181,0.504502,0.271395,-0.58622,-0.479046,-0.399832,0.497055,0.45623,-0.328921,0.788793,0.368135,0.25205,-1.11326,-0.106404,0.273864,-0.375328,-0.0949915,0.438853,-0.425964,0.116634,0.575426,0.290398,-0.975351,0.396296,-0.326754,-0.180038,-0.480378,0.390093,-0.540452,0.503631,0.787287,-0.954445,-0.883825,0.123594,0.570922,0.00153801,-0.300368,0.569469,-0.190249,0.0250517,0.835193,0.51772,-0.574717,1.22964,0.484593,0.562743,-0.21485,-0.178707,-0.400723,0.349979,-0.706736,-0.131922,0.137872,-0.0985562,-0.146731,0.0969883,-0.410878,-0.0365379,-0.143792,-0.339241,0.0319088,-0.305145,-0.149742,0.457108,-0.0975069,0.0805038,-0.286271,0.0623529,0.404274,-0.669584,0.0415567,-0.0527842,-0.0187417,0.456523,-0.159031,0.209725,-0.371546,0.000712687,0.434938,-0.560099,-0.316455,0.855108,0.433827,-0.429733,0.17334,-0.13825,0.102232,0.0938607,-0.433586,-0.683176,0.310582,-0.043812,-0.248503,0.0320614,0.482631,-0.000418634,0.523535,-0.0739606,-0.552465,0.381073,0.282872,0.161666,0.78709,0.225775,0.0783089,-0.187692,-0.182582,0.190871,-1.40327,0.269064,-0.214914,0.222168,-0.156712,-0.0433837,0.496943,-0.354803,0.2816,-0.243811,-0.825566,-0.25208,0.157763,0.00475358,0.49072,0.117357,0.132246,0.148467,0.396692,0.407103,0.0153762,0.425901,0.252726,0.364265,-0.224141,0.343948,0.118153,0.00440812,0.883792,-0.439189,-0.37562,-0.124901,0.901627,-0.0727955,-0.0592022,-0.0913478,-0.0194524,-0.213307,0.258322,0.107136,0.777252,0.323277,-0.395573,0.358675,-0.169715,0.60046,-0.505748,-0.332466,-0.450674,0.316851,-0.0216938,-0.28503,-0.119866,0.0612573,-0.281622,-0.334234,0.398097,-0.281927,-0.676764,-0.546846,0.0243119,-0.113101,0.051906,0.38844,-0.528587,-0.0877484,0.262926,-0.526884,0.750264,0.222369,-0.149599,-0.208384,-0.54853,0.438292,-0.478956,0.130725,0.0491785,-0.364485,0.275526,0.299795,-0.436615,-0.419847,-0.0709125,0.075082,0.152434,-0.635111,0.23564,-0.427424,-0.762498,-0.343552,-0.431317,-0.395287,-0.0193175,-0.181902,-0.0913971,-0.227581,0.234859,0.144675,-0.310332,0.681248,-0.124783,-0.245079,0.445827,-0.522353,-0.341324,0.537085,0.241508,0.116679,-0.0739213,0.268603,-0.402583,0.0185041,0.0424323,0.224853,-0.173912,-0.221243,0.171524,-0.284862,-0.0867544,0.620586,-0.310943,0.338796,0.769852,0.357104,-0.223147,0.196988,-0.0966287,-0.330985,-1.01512,-0.238559,-0.227458,-0.455982,-0.0899975,-0.165015,-0.210267,-0.712402,-0.28917,0.116979,0.665512,0.723387,0.135904,-0.0922799,-0.848656,-0.262945,0.0748379,-0.108268,0.388689,-0.237611,0.30718,0.0960103,-0.206576,0.17233,-0.224885,-0.160904,0.41749,-0.0102126,-0.157704,0.10371,0.173561,0.432187,-0.105047,0.418975,0.133231,0.206861,0.365008,0.45482,-1.43066 +3401.91,0.926384,0.0848144,4,1.57433,0.934816,-0.422045,0.181754,0.337958,-0.00235752,0.303695,-0.0185967,0.832309,-0.361009,0.206314,-0.257627,0.280566,0.184175,-0.11328,0.846488,0.348846,-0.0902023,-0.116775,0.142486,-0.0170827,-0.591573,-1.19234,0.756947,0.211418,-0.325924,0.48775,0.645744,0.38497,0.231207,1.10556,0.274962,-0.0347837,0.220853,-0.334617,-0.282889,-0.169674,-0.00172413,0.22644,-0.174843,0.521687,0.480967,-0.428769,-0.809493,-0.0775552,-0.135199,-0.953091,0.0791277,0.380129,0.022448,0.152686,0.656205,-0.0265182,-0.342331,0.646063,0.386889,-0.0511457,-0.921716,0.199068,-0.214733,-0.00716087,0.492625,-1.02524,-1.6424,0.34645,0.22375,0.106868,0.432293,0.0070331,-0.204535,0.362868,0.107131,0.857923,-0.154983,0.767852,0.626603,0.644738,0.372262,-0.43642,-0.0893724,0.0862632,-0.35564,-0.404995,-0.0302386,-0.0139536,-0.427287,-0.387699,-0.195083,0.318635,-0.556342,-0.0675798,0.307561,0.323904,0.146013,-0.403197,0.0445262,0.155888,-0.19588,0.432454,0.596446,-0.139137,0.29719,0.0969141,-0.622621,-0.0523795,0.148104,0.492331,-0.149274,0.441005,0.38028,-0.548728,-0.274031,0.436399,0.495783,0.239412,-0.339958,0.224434,0.425651,0.148747,0.181047,-0.928843,0.459155,0.0393124,-0.218243,0.266631,-0.324043,0.0240198,0.90097,0.141518,-0.57718,0.0253351,-0.242731,0.177302,0.40721,-0.165726,-0.11856,0.476596,-0.106422,-0.193146,-0.144029,0.204792,-0.403021,-0.209684,-0.179578,0.316756,0.312219,-0.0194205,0.113368,-0.275262,0.146782,-0.377113,0.179476,0.362459,0.340234,0.55871,0.672996,0.0122024,-0.320938,0.24118,-0.346795,0.31822,0.515964,0.730208,0.125762,-0.436988,0.298963,0.0439033,-0.521362,0.301972,-0.196898,0.214065,0.204697,0.0814019,-0.664723,-0.642053,0.00389994,-0.694211,-0.289998,-0.0355699,1.01795,-0.419164,-0.847237,-0.344621,0.0799216,0.432787,-0.400269,-0.172828,-0.210694,-0.357863,-0.319364,0.250357,0.160468,-0.251771,-0.0220655,0.333338,-0.263759,0.356854,-0.59322,-0.882641,0.502164,-0.555966,-0.37201,0.599075,-0.165076,0.367669,-0.452141,-0.660248,0.829876,-0.320972,0.136587,-0.0179182,0.256664,0.296193,-0.00848543,0.0595008,0.404045,0.0356314,0.143826,0.153632,-0.617843,0.127733,-0.766423,0.00958215,0.0829517,-1.23068,0.294512,-0.341732,-0.269681,0.0416928,0.0881845,-0.329021,0.286153,-0.29888,-0.14089,-0.392139,0.390046,0.378743,0.340231,0.752708,0.129698,0.395696,0.0110161,-0.0683755,0.845027,0.150938,0.324359,0.365828,-0.274214,-0.14757,0.254622,0.552996,-0.283109,0.213963,-0.404708,0.229761,-0.0114511,-0.536741,-0.56051,0.0155164,-0.349448,-0.194612,0.567446,0.0192245,0.409024,-0.27596,-0.227521,0.0848183,0.20053,-0.0123247,-0.244227,0.321239,-0.568467,-0.894242,0.098465,0.805501,-0.1865,0.42652,0.227264,0.209103,-0.0945931,-0.369081,-0.330544,-0.415457,-0.00347076,-0.420055,0.521512,-0.183848,-0.163751,0.347146,0.320491,0.0657473,-0.678475,0.32633,0.252315,0.0781868,-1.03513,0.198215,0.152719,-0.465517,-0.26855,-0.724277,0.164871,0.244935,0.406043,0.494909,-1.15036 +3404.75,0.591713,0.0848144,5,1.60331,1.08879,-0.203251,-0.0259921,0.704443,-0.0691464,0.1877,0.177238,0.117286,0.603651,0.0288767,-0.254589,-0.10415,-0.464466,0.101801,1.25757,0.0329117,-0.176818,0.19971,-0.12643,-0.584024,-0.444066,-0.291723,-0.113755,-0.112369,-0.0197954,-0.242055,0.612863,0.0132493,0.464479,0.499332,-0.616555,0.360739,0.099813,-0.542909,0.301642,-0.538053,0.178702,0.441217,-0.680282,0.689455,0.396937,0.433903,-0.43799,-0.0747626,0.138637,-0.00275662,-0.0499961,-0.0291092,-0.279176,0.086933,0.343081,0.14438,-0.572259,0.703967,-0.658244,-0.180372,-0.375969,0.639794,-0.307375,-0.20911,0.671678,-0.356178,-0.954619,-0.311744,-0.0106462,0.133413,-0.02876,-0.167,-0.857892,-0.254987,-0.0328719,0.87388,-0.610042,0.347981,0.116646,0.499495,0.0178752,-0.339835,-0.117191,0.0917661,0.325565,0.176373,-0.493549,-0.0197657,0.533001,-0.236226,-0.489513,-0.30725,-0.273003,-0.0700504,0.198972,-0.00105086,0.202061,-0.00733222,-0.350866,-0.210745,-0.333101,0.381747,0.341503,-0.118035,-0.570172,-0.19855,-0.4152,0.344382,0.00111894,0.219366,-0.0030853,0.415794,0.48489,-0.541247,-0.328463,-0.204629,0.530379,-0.36805,0.243676,-0.55192,-0.189383,-0.0285105,-0.0771134,0.154038,0.0268011,-0.00454209,-0.287271,-0.440029,0.779747,0.625714,-0.118988,0.250937,-0.422478,0.455269,0.614662,-0.125414,0.511319,-0.0848266,0.407561,-0.397945,-0.0155948,0.399625,-0.96157,-0.419606,-0.218571,-0.131136,-0.926282,-0.0596348,-0.763372,-0.577065,0.349627,0.108423,0.0115232,0.272139,0.18944,0.573497,-0.511805,0.600782,0.805677,0.492995,-0.331814,0.279389,-0.144055,-0.0937147,-0.440588,0.7215,-0.40906,-0.36685,-0.0583042,0.0972358,-0.139349,-0.559677,-0.122408,-0.125627,-0.211909,0.121185,0.169569,0.154371,-0.126879,-0.0221377,-0.136532,0.142517,1.06304,0.530664,0.921682,0.355892,-0.0259153,0.117841,-0.576621,0.0576284,-0.549753,0.560026,-0.517987,0.488176,-0.840257,0.0954211,-0.812652,0.0967102,0.206033,-0.17417,-0.710961,-0.493074,0.224712,-0.133986,-0.101375,0.580366,-0.0313582,-0.530511,-0.472016,-0.560283,1.09662,0.259382,0.358956,0.133339,-0.136156,-0.387625,0.070783,0.00794271,-0.107637,-0.0283108,-0.114917,0.188326,-0.299542,0.067138,-0.329474,-0.0202296,0.0832763,-0.00954049,0.896623,0.397705,-0.162572,0.00995591,0.258413,0.08578,0.0558597,-0.39788,-0.00335163,-0.293665,0.519259,-0.498083,-0.260862,0.499534,-0.0181956,-0.220066,0.424551,-0.216483,-0.468672,0.677027,0.567351,0.239649,1.07317,0.0651801,-0.378498,-0.271759,-0.892789,0.474781,-0.375344,-0.754062,-0.185421,-0.689178,0.182353,0.0417658,-0.220724,0.0922373,0.336094,0.16588,0.0183483,-0.0853114,-0.589243,-0.251143,-0.834757,-0.049525,0.11963,-0.126755,-0.147046,-1.01898,0.13546,-0.412758,0.389752,0.00416067,0.00194197,0.618214,0.349235,-0.151021,-0.0431919,0.165086,-0.0278348,-0.173892,0.151728,-0.283759,0.0740685,0.131139,-1.31426,0.0869776,0.939718,-0.220989,-0.117084,-0.10739,-0.629194,0.199645,0.164647,0.253052,0.165585,0.120103,0.167687,0.214679,0.409495,0.463335,-2.51149 +3384.5,0.735199,0.0848144,4,1.58204,1.06395,-0.231927,-0.0226941,0.735227,-0.0975126,0.124319,0.193026,0.336305,0.206838,-0.137192,-0.247388,-0.122152,-0.0443506,0.173885,0.921494,-0.0358052,-0.336985,0.459074,-0.299315,-0.341428,-1.04603,-0.587474,0.019102,-0.748348,0.000862837,-0.5975,0.614283,-0.0535287,0.551774,0.418412,-0.395145,0.656905,0.272651,0.0174313,-0.0949557,-0.956231,0.445035,0.322786,-0.660483,1.06934,0.380299,0.78104,-0.379095,-0.335296,-0.339224,-0.0532511,-0.20435,0.166978,-0.0637848,0.0236275,0.0764569,0.293253,-0.288251,0.954301,-0.500904,-0.11089,-0.28346,0.679235,-0.239778,0.540715,0.30936,-0.45904,-1.76851,-0.120189,0.230401,-0.0158708,-0.400182,-0.199033,-0.897073,-0.304269,-0.0365182,0.958757,-0.0576338,0.516535,0.244216,0.635713,-0.298599,-0.0944981,0.14673,0.456652,0.533761,0.206643,-0.267371,0.21249,0.161025,0.266268,-0.923452,-0.809507,-0.317721,-0.0983698,-0.131476,-0.388236,0.470635,0.0192486,0.402309,-0.102299,-0.340986,0.235481,0.236726,-0.00354607,-0.694269,-0.13963,-0.411911,0.442579,-0.766582,0.17235,0.0878594,0.298652,0.905501,-0.355631,-0.551013,-0.00531592,0.270461,-0.0302122,0.106672,-0.399016,-0.297639,-0.0719407,-0.165495,-0.376443,-0.197358,0.792634,-0.0475674,-0.348167,0.109346,0.618405,-0.557763,0.191611,-0.605038,0.633241,0.431831,0.0550587,0.668284,-0.329569,-0.319146,-0.457251,-0.208635,0.588917,-0.754457,-0.482036,-0.278413,-0.10038,-0.928901,0.20445,-0.630688,-0.562418,0.194492,-0.0704664,-0.108737,0.360958,0.0935648,0.446501,-0.694096,1.001,0.661205,0.187068,-0.0654982,0.3186,-0.123915,-0.389536,0.17721,0.922826,-0.339827,-0.0493736,-0.0922183,0.0612861,-0.700197,-0.405097,-0.985881,-0.100982,0.0594062,-0.0328735,0.147409,-0.276537,0.0236536,-0.261272,-0.230791,-0.349612,1.24609,0.0842872,1.08194,0.202092,-0.0273643,-0.00876497,-0.28801,-0.376536,-0.264433,0.39919,-0.220396,0.293968,-0.527804,-0.416586,-0.609951,-0.260936,0.05506,0.225833,-0.287119,-0.285096,-0.336919,-0.392019,-0.0908175,0.366434,-0.136077,-0.171172,-0.499528,-0.514065,1.02671,0.462594,0.41035,0.498632,-0.343856,-0.473142,0.346613,0.0906927,-0.036389,-0.207718,0.219181,0.321192,-0.646165,0.0244734,-0.668264,-0.124261,0.0998426,-0.678437,0.985298,0.503395,-0.459706,-0.302407,0.314671,0.297885,0.0778474,-0.626329,-0.0331263,-0.214323,0.232503,-0.660124,0.072295,0.709108,0.0146423,-0.835957,0.250568,-0.14063,-0.492743,0.122192,0.174629,0.492729,0.0640896,0.0254904,-0.364359,-0.442971,-1.03161,0.16558,-0.243378,-1.01772,0.153905,0.213379,0.283859,0.136021,-0.0225258,0.259327,0.0365292,0.507019,-0.530801,-0.229033,-0.286644,-0.155055,-0.205746,-0.582692,-0.155094,-0.254404,-0.115675,-0.259001,0.343723,-0.263477,0.415946,0.466607,-0.00404592,0.421327,-0.460022,-0.0260207,0.467394,0.0171141,-0.169827,0.52181,0.27459,-0.451336,0.0242518,0.203073,-0.828928,0.0827018,0.625966,0.0807754,-0.171786,0.0835765,-0.187791,0.324825,0.216147,0.141471,0.107022,0.475669,0.193701,0.242745,0.440114,0.492692,-2.57201 +3379.43,0.698242,0.0848144,5,1.75316,0.64611,-1.40302,0.525027,1.18163,-0.170716,-0.3251,-0.476201,0.0753474,0.0442358,0.225269,-0.168844,-0.558121,0.096941,-0.481301,0.729627,-0.513166,0.299728,-0.421774,-0.311398,0.210452,-0.54447,-1.02477,0.0575294,-0.205395,-0.0689362,-0.320834,0.00630625,-0.240476,-0.334159,0.82147,-0.708537,-0.834033,0.386803,-0.04576,-0.31971,-0.140454,-0.000206621,1.09981,-0.0248379,0.706164,0.507017,-0.016815,-0.426935,0.118932,0.179596,-0.758741,0.465315,0.116924,0.106152,0.00664163,0.453168,-0.0344251,-0.553261,0.452831,-0.521434,-0.21741,-0.898391,0.269101,-0.864716,-0.312446,0.383727,-0.633219,-0.377569,-0.189865,-0.150554,-0.443688,0.441982,-0.202635,-0.288344,-0.275961,0.381332,0.600839,-0.295058,-0.154508,0.707728,-0.112549,0.240897,-0.52119,-0.00760561,0.192178,-0.776319,0.0558554,0.0763874,-0.641803,0.0433002,0.183553,-0.073131,0.452843,-0.674985,-0.133727,0.207312,0.281778,-0.468712,-0.348853,-0.272359,-0.203866,-0.184606,0.0580041,0.526251,0.0321262,0.330141,-0.433575,-0.243081,-0.522028,-0.00023234,-0.539892,-0.18007,0.462494,-0.0901367,0.213428,0.13374,0.268223,0.697019,0.410448,0.16018,-0.636297,0.265461,0.355043,-0.205236,-0.744265,-0.0859208,-0.544324,-0.496522,0.0786745,0.443779,-0.321416,0.214445,0.00852805,-0.280145,-0.187481,-0.0692582,-0.419839,-0.221651,0.0471673,-0.0874218,0.333012,-0.0822039,0.341481,-0.565866,-0.516698,-0.0325784,0.279033,-0.511717,0.0802044,-0.235309,-0.196134,-0.118262,-0.515301,-0.495366,-0.86024,0.0688121,0.122489,0.113666,-0.162904,0.235313,-0.485189,0.231094,0.0147816,-0.348905,-0.0488534,-0.48366,0.254084,0.503883,-0.0830263,-0.173757,-0.309419,0.187533,-0.0700449,0.691335,0.333974,-0.269171,0.11297,0.178487,0.305163,-0.634228,-0.514874,-0.177606,-0.202427,0.543515,0.37034,-0.904748,0.404222,-0.451481,-0.0019316,-0.402357,-0.41987,-0.386517,-0.419175,-0.381701,0.0987906,0.0594485,-0.05239,-0.412608,0.244745,0.0845116,-0.354307,-0.066562,-1.01248,0.104861,0.0796326,-0.391528,0.0101946,0.12826,0.124853,-0.0572125,-1.48842,0.585283,-0.454279,0.0982484,-0.49251,0.373874,0.521189,0.493057,0.224636,0.236904,-0.229187,0.0657139,-0.10751,-0.544066,0.494465,-0.518196,0.207804,0.178529,-0.548151,0.0171131,-1.12958,-0.303893,0.0305436,-0.482358,-0.267416,0.0971967,0.0990847,-0.136839,-0.696528,0.439991,0.530557,0.0324625,0.742615,-0.624532,0.0998195,0.0917452,0.101299,0.399136,0.320816,-0.404004,0.206653,0.00269319,-0.590522,0.066174,-0.192814,-0.391758,0.797636,-0.319196,-0.218488,0.298243,-0.500822,-0.535558,0.29482,0.0264957,0.0328847,0.611714,0.549133,0.756297,0.0178003,0.180571,-0.113212,-0.379469,0.872187,0.313967,0.192958,-0.659851,0.226705,-0.351427,0.235161,-0.558367,-0.22247,-0.404359,-0.0959678,0.790007,-0.303154,-0.664957,-0.820714,-0.112162,-0.0184671,0.164624,-0.110717,0.354142,-0.225389,0.472094,0.283814,-0.222731,0.146076,0.0811804,-0.210115,-0.534356,-0.172087,0.265225,-0.390095,-0.503608,-1.07829,0.17072,0.235726,0.413182,0.485516,-3.02995 +3404.92,0.943793,0.0848144,4,1.71153,0.651947,-1.82046,0.757066,1.23017,-0.0439967,-0.230328,-0.539032,0.090506,-0.616414,0.577598,-0.235559,-0.387921,-0.430021,-0.339607,0.635606,-0.0647302,-0.476535,-0.297178,-0.135015,-0.0915948,-0.700867,-0.970176,0.277979,-0.772583,-0.121254,-0.711481,0.265906,-0.506611,0.212705,0.787502,-1.1609,0.189296,0.0449543,-0.209462,-0.635226,-0.297388,0.337046,0.825215,-0.564499,0.91469,0.524546,0.497227,-1.01997,-0.3788,-0.559439,-0.774106,-0.0978574,0.1246,0.0949504,-0.178345,0.314579,-0.156429,-0.550017,0.0723316,-0.632024,-0.381781,-1.13165,0.638317,-0.728905,0.176967,0.881308,-0.0944115,-1.5141,-0.438557,0.138533,-0.385742,-0.104207,0.232186,-0.821137,-0.00690461,0.100256,0.86118,-0.440805,0.620838,0.44934,0.723484,-0.14269,-0.543729,-0.251925,0.491752,-0.583886,0.290642,-0.345401,-0.887461,-0.212993,0.0945339,-0.834438,0.0404538,-0.620823,0.233201,-0.03095,0.34707,0.531606,0.470019,-0.453523,0.353514,-0.96922,0.361958,-0.169293,-0.229559,-0.223038,-0.568563,-0.183352,0.411287,-0.555546,0.133249,-0.351425,0.520374,0.436568,-0.124543,-0.176025,0.062442,0.566147,0.179114,0.353967,-0.148464,-0.140145,0.240941,-0.265372,-0.630733,-0.392564,-0.258369,0.357878,0.0952034,0.0760296,-0.259154,-0.129051,0.190251,-1.20443,0.0374566,-0.0435892,-0.0962669,0.23943,0.156431,-0.298182,0.32126,-0.0159885,0.202636,-0.802983,-0.92529,-0.223617,0.167789,0.00495121,0.0486901,-0.235407,-0.276364,0.665675,-0.165836,-0.176322,0.0873943,0.669446,0.0796172,-0.204944,0.15435,0.993958,0.204404,0.501443,-0.45581,-0.231221,0.313004,0.138795,1.24582,0.121308,0.324484,-0.149268,-0.559117,-0.0431749,-0.600677,0.138469,0.479149,0.376408,0.251065,0.0800348,-0.377034,-0.134389,0.329142,0.0795481,0.0374329,0.965687,0.0817099,-0.175262,0.237461,0.19418,-0.444849,-0.0352531,-0.467697,-0.371146,0.122391,-0.517567,0.464396,-0.130852,-0.436827,-0.469503,0.479459,-0.326058,0.0897555,-0.41548,0.0792292,0.210326,-0.131571,-0.394524,0.079314,-0.368901,0.284665,-0.255848,-0.737625,0.736582,-0.649533,0.0889271,0.237642,-0.375725,0.111197,0.3601,0.514105,-0.658457,-0.733602,0.199995,0.00802508,-0.229464,0.16406,-0.0591048,0.350327,0.0530063,-0.797937,0.520646,-0.993922,-0.19916,-0.210274,0.0741563,0.53075,0.468861,0.0251672,-0.390138,-0.00435831,0.398752,-0.351398,0.0783297,0.621976,-0.912959,0.197811,0.0012971,-0.0429811,0.123199,0.319293,0.0781546,0.278043,0.512143,0.00543765,-0.0234841,-0.677673,-0.704966,0.412699,-0.490578,-0.00405823,0.0746265,-0.245562,0.175117,0.631197,-0.0212891,0.158775,0.356615,0.0926191,-0.0423379,-0.0505478,0.139246,-0.435215,-0.352971,0.133157,0.151155,-0.532131,0.0711811,-0.0706641,-0.185555,-0.260624,-0.0396164,-0.514458,-0.0125849,0.292607,-0.130817,-0.327249,-0.341385,-0.390692,-0.0247395,0.0321389,-0.405046,-0.52134,0.49018,-0.224874,-0.25978,0.343267,-0.224684,0.307626,-0.132714,-0.313468,-0.319765,-0.678534,-0.00447856,0.202475,0.283065,0.322519,0.131741,0.286176,0.362961,0.534954,-3.27545 +3412.8,0.958565,0.0848144,4,1.69918,0.753658,-1.32973,0.552824,1.02767,-0.130005,-0.540684,0.131228,0.230262,-0.282319,0.178431,-0.306099,-0.40476,0.153341,-0.246688,0.551519,0.492072,0.0568967,0.474339,-0.160156,-0.259001,-1.47129,-1.03469,0.375181,-0.371962,-0.327798,0.0351234,0.0710223,-0.305642,-0.274458,1.04216,-0.740646,-0.158986,-0.0402387,-0.428038,-0.44499,-0.218133,0.0442681,0.8294,-0.326611,0.921496,0.253174,-0.480386,-0.679148,-0.237403,0.0624965,-0.397978,-0.131698,0.23688,-0.161463,-0.107783,0.66806,0.20533,-0.0511949,0.700538,-0.0924461,-0.0718425,-0.479258,0.729012,-0.759455,0.275217,0.665966,-0.742598,-0.911705,0.0153617,-0.129022,-0.140898,-0.51337,0.204114,-0.16163,-0.49217,0.151921,0.478424,-0.0030442,0.266445,0.321471,0.375066,0.044458,-0.289666,0.186465,0.654812,-0.249681,-0.00984298,0.0406735,-0.109816,-0.385394,-0.135529,-0.00224987,0.193166,-0.53837,-0.196361,-0.0338111,0.18047,-0.446649,0.000675714,-0.0496112,-0.313428,-0.192644,-0.088887,0.129492,0.141858,0.642758,-0.0650452,-0.144084,-0.259659,-0.794311,0.247167,-0.478631,0.25334,0.3328,0.377835,0.00372841,0.222883,0.26591,-0.183573,-0.23309,-0.661369,0.174251,0.342105,-0.349832,-0.45358,0.143477,-0.296788,-0.626271,0.146961,0.0142007,0.374522,0.669028,0.139283,0.194033,0.217571,0.145189,-0.166132,0.566449,-0.749216,0.0530084,-0.593094,-0.240153,0.534219,0.26546,0.600998,-0.00436483,-0.287,-0.0383534,0.144965,0.486374,-0.193327,0.0468876,-0.601184,0.0204823,-0.601898,0.207508,0.453712,0.302789,0.285897,-0.354077,-0.0176432,-0.581304,0.00335391,-0.103403,0.390366,0.216393,0.0437681,0.179303,-0.378024,0.0724823,0.146661,-0.536038,-0.164096,-0.290933,-0.442048,0.0627334,-0.24234,0.123068,-0.114918,-0.0025929,-1.05798,-0.168817,0.0541202,0.429996,-0.0305105,-0.024961,0.516298,0.121766,0.534222,-0.560649,0.253202,-0.076591,0.146479,-0.291171,-0.166643,-0.408204,0.064684,-0.770537,0.382631,-0.0978085,-0.204071,-0.017489,-0.444267,0.301526,-0.0628235,0.584535,0.322722,0.531675,-0.222075,0.18426,-0.520561,0.469304,0.0807958,0.355728,0.307722,0.313293,0.407594,-0.1532,0.210446,0.518834,0.388517,-0.402489,0.386682,-0.356758,0.149722,-0.408954,-0.014732,0.288263,-0.0180843,0.0684814,0.0994791,-0.470537,0.0480173,-0.407074,-1.06706,-0.290428,-0.304011,-0.0435365,-0.879583,0.231551,0.336543,-0.259757,0.553757,-0.614939,-0.387774,0.219776,0.0703461,-0.0890799,0.257652,0.0440842,0.594519,0.0302587,-0.365255,-0.240421,0.503508,-0.480745,0.289429,-0.0377819,-0.778576,0.253344,-0.235123,0.870567,-0.121763,0.180171,0.213758,0.571436,0.268118,0.013606,0.00476558,0.433735,-0.139409,0.542469,-0.0706821,0.373654,0.312303,-0.243298,-0.0695631,0.873211,0.17385,0.0857894,0.1882,0.238606,0.786372,0.0591428,0.121943,-0.0698008,0.110147,0.489597,0.00483646,0.800721,-0.118461,-0.0975859,-0.187075,-0.11031,-0.0824873,0.0350369,-0.344423,-0.235062,0.0106714,-0.405184,0.19796,0.137768,-0.303919,-0.489947,-0.220569,0.102274,0.333991,0.319803,0.577919,-2.83801 +3444.65,0.984153,0.0848144,5,1.59913,0.75429,-1.24089,0.446308,0.462019,-0.152461,-0.373191,-0.399806,0.255752,-0.339541,0.147803,-0.404313,-0.308338,0.482407,-0.601138,0.775366,0.059058,-0.413055,0.206947,-0.0317927,-0.351215,-0.959382,-1.76609,0.422696,-0.316856,-0.42195,0.0538293,0.31572,-0.665677,0.22117,1.06224,-1.22719,0.0238456,0.237769,-0.554523,-0.36746,-0.907109,0.443476,0.0571759,-0.225338,0.925362,0.449455,0.140905,-1.11179,0.145271,-0.43914,-0.88475,-0.259974,0.453109,-0.0448068,-0.0213515,0.0705105,0.252504,-0.178401,0.796512,-0.517039,-0.327997,-0.542298,0.287827,-0.748215,0.394626,1.39051,-0.333114,-1.13092,-0.0684895,-0.0303629,0.241431,-0.396512,0.619182,-0.449468,0.117175,0.335115,0.473469,0.425005,0.170521,0.0611139,0.541523,0.213881,-0.150547,0.331001,0.520293,0.0822809,0.211806,0.241325,-0.38891,0.102386,-0.560269,-0.0964955,-0.0969815,-0.668391,0.145944,0.118389,0.00648427,-0.143862,0.438077,0.0219303,-0.344741,-0.010295,-0.248658,0.325439,0.0764732,0.327707,0.46325,0.273305,0.381897,-0.107238,0.189785,-0.400096,0.202345,0.82999,-0.142936,-0.0435147,-0.132211,0.175835,-0.221399,0.514012,-0.278624,-0.00808238,0.303458,0.149493,-0.73479,0.0244537,-0.59157,-0.30353,-0.00801514,0.376752,0.368234,0.582267,0.23623,-0.57128,0.244735,-0.203589,0.0788839,0.443112,-0.424444,-0.110364,-0.561256,-0.177116,0.408329,-0.490434,-0.309849,0.05854,0.124639,0.0129142,0.232531,0.491211,-0.192607,0.458623,-0.493627,-0.209578,0.0790057,0.295918,0.501381,0.21496,0.448481,0.35687,0.0295818,-0.127299,0.064056,0.0260899,0.305755,-0.231444,0.589388,0.110923,0.199737,-0.149704,-0.207166,-0.26666,0.0455473,0.214011,0.252771,-0.446156,-0.131449,0.179762,-0.13588,-0.237344,0.00239914,0.172046,-0.112879,0.562572,0.0880833,0.277702,0.198989,-0.0704864,-0.27615,-0.0714304,-0.217578,-0.350393,0.254689,-0.475601,0.124299,-0.50224,-0.227581,-0.625409,-0.36011,-0.315115,0.237248,0.348224,-0.550151,-0.0507477,-0.225063,-0.031866,0.242356,-0.40026,0.0986119,-0.182172,-0.437322,0.502887,-0.135495,0.798207,0.291988,0.222087,0.146238,-0.229136,0.419642,0.531376,-0.0634949,0.282837,0.485302,-0.36546,0.399606,-0.354553,0.283409,0.218451,-0.594891,0.503209,-0.176777,-0.0469341,0.144155,0.44917,0.292133,0.0299029,0.193799,-0.0471945,-0.521272,0.413195,0.0459865,-0.0413827,0.227751,-0.650656,0.0943301,0.193612,0.130246,-0.371928,0.327881,-0.153187,0.177247,-0.0587481,-0.0251524,-0.147434,0.142061,-0.326555,0.203153,-0.272602,-0.194283,0.379193,0.15039,0.130925,0.154168,0.0811629,-0.0928604,0.49904,0.0678995,0.438543,-0.00249001,0.167981,-0.336242,-0.87485,-0.248885,0.402972,0.187769,-0.194525,0.661611,-0.0987442,0.248482,0.100154,-0.0101962,-0.169099,0.166133,0.452852,-0.136563,0.275669,-0.468888,0.133991,-0.00495393,0.420305,-0.06843,0.314343,0.134928,-0.0604997,-0.176097,0.213233,-0.22399,-0.27966,-0.106575,-0.189026,0.326295,-0.42941,-0.378118,0.123805,-0.663196,0.133567,0.329684,0.365468,0.574181,-1.00139 +3441.01,1,0.0848144,4,1.4717,0.763378,-1.09178,0.364684,0.299536,-0.262812,0.227007,0.298961,-0.0646897,-0.0212612,0.183792,-0.208419,-0.402088,0.510957,-0.288335,0.769667,0.270862,0.386731,-0.502138,-0.0147408,0.10094,-0.856323,-0.264749,0.359211,-0.392079,0.155417,-0.0609536,0.127793,-0.237435,0.0705408,0.66971,-0.144328,-0.133386,0.573019,0.029289,0.215373,-0.362341,0.517345,0.862369,0.0815544,0.834731,0.785554,0.80291,-0.204326,-0.171261,0.344737,-0.556761,0.67591,0.488559,0.18596,0.209977,0.0597644,0.0706949,-0.547081,1.23951,0.248367,-0.0551454,-0.195176,0.625739,0.0239585,-0.167932,1.25121,-0.80697,-0.644366,0.313005,0.310183,-0.397259,0.0908706,-0.0431115,-0.478769,-0.0312508,0.426501,0.814471,0.0602795,0.473701,0.0890844,0.0880581,-0.136038,-0.0906249,0.0698197,0.462386,-0.306011,0.263932,-0.717178,-0.0537805,-0.230579,0.242342,-0.199493,0.211968,-0.0994792,-0.0571904,-0.028787,0.0872862,0.243663,-0.0926086,0.0203313,0.606,-0.300732,0.120913,0.299297,0.0726468,-0.36817,-0.550143,-0.59496,-0.278094,-0.13584,0.0851146,0.00908715,0.337165,0.573627,0.0999758,-0.243462,0.306257,0.056092,0.241167,0.00905852,-0.587387,0.0395659,0.29469,0.131503,-1.52969,0.204259,0.311006,-0.0994972,-0.223661,0.0976302,0.0339027,0.0361116,-0.0936497,-0.0904299,0.155957,0.0242762,0.167484,0.106059,-0.428276,-0.271907,0.574087,0.12034,0.485735,-0.656119,-0.0775909,-0.00096962,0.0961867,-1.11336,-0.416177,-0.408808,-0.0869584,0.0600181,0.103561,0.0485209,-0.443891,0.110745,0.0129819,0.0631424,0.75722,0.41925,0.205058,0.0387136,0.223609,-0.355866,-0.69262,0.298624,0.828824,-0.205633,-0.155113,0.277949,0.0526684,-0.375694,-0.138899,0.360295,0.200619,0.0487718,-0.354481,0.199722,0.211368,-0.138833,-0.62813,-0.035414,0.559517,0.533163,0.127926,-0.502779,0.4189,-0.391007,0.0061679,-0.485512,-0.30567,-0.268516,0.168669,-0.264747,0.0881257,0.768375,0.202939,-0.807215,0.200026,0.611488,0.15382,-0.689371,-0.23634,0.070909,0.214369,-0.14721,0.11754,0.237632,-0.112153,-0.197443,-0.625472,1.10777,0.093374,-0.818889,-0.159015,-0.00940259,0.220132,0.296711,-0.478582,-0.129559,-0.363365,0.169911,-0.0788251,-0.361048,-0.0393594,-0.00839506,-0.0270335,0.577459,-0.374566,0.187752,-0.304594,-0.162397,0.0884726,-0.222536,-0.513186,-0.298654,-0.75015,0.00457255,-0.195802,0.160612,0.0194476,0.224145,0.496708,0.0786595,-0.0168129,-0.309657,-0.0885263,-0.330569,0.353477,0.266147,0.418417,0.515397,-0.194109,-0.0647114,0.137723,-0.866276,-0.0672496,-0.0603946,-0.46063,0.253996,-0.360999,0.398837,0.343982,0.229224,0.403584,0.0288222,-0.307878,-0.262883,0.417317,0.0515688,0.235147,0.762763,-0.0353527,-0.441761,-0.0549565,-0.0367366,-0.679948,0.0761873,0.0182993,-0.149514,0.490446,0.186913,0.286308,0.0301691,0.14723,-0.429591,0.288532,0.139173,0.263383,0.207206,0.322618,0.611165,0.317508,-0.0660223,-0.31026,-0.179865,0.664406,0.32568,-0.164065,-0.245996,0.0887106,0.380057,0.310678,-0.39944,0.499104,0.162744,0.211417,0.403416,0.459801,-0.578829 +3423.01,0.370687,0.0848144,4,1.39476,0.768179,-1.27023,0.396731,0.544456,-0.175691,-0.156146,0.394407,-0.0562036,0.207941,0.421066,-0.362202,-0.105083,0.231041,-0.102133,1.05985,0.642924,-0.0795601,-0.432949,-0.0832805,-0.0173446,-0.445614,-0.825608,0.255578,-0.0348995,-0.261013,0.168404,0.459488,-0.477961,0.125064,0.762585,-0.325708,0.00260198,0.56103,-0.106134,-0.0798076,-0.598516,0.644033,0.857881,-0.0021895,1.20429,0.565526,0.604408,-0.107952,-0.257094,-0.145796,-0.390903,0.304916,0.727684,0.142677,0.313071,0.481365,0.518194,-1.00564,1.29943,0.336307,-0.0157998,-0.682839,0.969447,-0.282285,0.205815,1.17515,0.0176928,-0.091913,0.463861,-0.130808,0.0157098,0.712648,0.0566102,-0.348768,-0.136802,0.369062,0.456878,-0.113516,0.206892,0.154919,0.221077,-0.342793,-0.303852,0.0106382,0.283155,-0.0326733,0.218132,-0.0830332,-0.235325,0.407299,-0.402644,-0.282312,0.0992793,-0.134453,-0.199546,-0.195296,-0.190384,-0.245251,-0.206275,-0.343651,0.0504308,-0.240007,0.331056,0.575493,-0.0539936,0.22035,0.141577,-0.335532,0.133586,-0.183442,-0.137173,-0.143825,0.354118,0.755458,0.385482,0.104274,0.686645,0.0683598,0.139189,0.114872,-0.447256,0.0170681,0.374782,-0.103461,-1.05019,0.503822,0.0602404,0.28917,-0.320834,-0.0462973,-0.236574,-0.0679784,0.124274,0.124037,-0.159046,-0.0665204,0.10594,0.0486956,-0.402308,-0.114032,0.284351,0.294276,0.0673891,-1.12157,-0.123402,0.175169,0.12595,-0.387893,0.182667,0.086321,-0.141951,0.210121,0.101499,0.0936229,-0.775514,0.111196,0.211863,-0.290641,0.943204,0.353118,0.278455,-0.457029,-0.115129,-0.206505,0.103371,-0.542099,0.918331,1.06745,-0.229669,0.105345,0.0936357,0.344912,-0.298967,0.340183,0.412324,0.605984,-0.316736,-0.547469,-0.10646,0.290095,-0.0560006,-0.15979,0.0359185,0.677809,-0.0822607,0.0295862,0.0825909,-0.281522,0.0359715,-0.254731,-0.346559,-0.49548,0.0686827,-0.365399,0.178242,0.109905,0.200944,-0.554409,0.11013,0.492584,0.266748,-0.358396,0.0488946,-0.671642,0.00420359,-0.376266,0.110973,-0.33347,0.370419,0.2968,-0.449792,1.03784,0.421516,-0.338976,-0.492754,-0.00292845,0.206632,0.571005,-0.617618,-0.17609,-0.941968,0.0444052,-0.219498,-0.226355,-0.0277185,0.458496,-0.189731,-0.134899,-0.463657,0.290302,-0.134272,0.0503687,0.0691172,0.0433265,0.0505605,-0.218881,-0.595595,-0.15046,0.295101,0.326248,0.0184988,0.177128,0.110383,-0.45757,-0.281193,0.130182,-0.239495,-0.870754,0.373998,0.156803,0.346642,0.624452,-0.342674,-0.177705,0.0639313,-0.569792,0.526985,0.311134,-0.643727,0.329481,-0.0623833,-0.236705,0.319649,-0.0436654,-0.170682,0.0902798,-0.185385,-0.190297,0.359184,0.347469,0.0976125,0.076777,-0.171573,-0.110139,0.494267,0.39004,0.0845414,0.385603,0.259598,0.0676784,0.280975,0.316631,0.151684,-0.338002,0.439635,0.711338,0.233455,-0.190585,0.183987,0.608717,0.0281066,0.609683,0.380724,0.192308,-0.0365841,0.0427803,-0.00249349,-0.129152,0.0356717,-0.238558,0.370156,-0.0255989,0.0825671,-0.259542,0.21325,0.0992513,0.276378,0.315042,0.525716,-1.43574 +3443.63,0.573855,0.0848144,4,1.49812,0.778844,-1.23398,0.37239,0.217473,-0.310603,0.0841603,0.141002,0.324926,0.413808,-0.00135125,-0.256522,-0.31113,0.378104,-0.195253,0.462289,-0.165,-0.328361,-0.166334,-0.135614,-0.0966586,-0.687817,-0.923341,0.341347,-0.0210071,-0.202528,-0.0254475,0.374355,-0.424671,0.0540299,0.901992,-0.463314,-0.146523,0.39193,0.0122797,0.254994,-0.15447,0.245806,0.491575,-0.360371,1.15229,0.657606,0.818539,-0.182335,0.109691,-0.509512,-0.617572,0.157439,0.687902,0.0983551,0.166174,0.157506,0.392875,-0.976592,1.18078,0.309373,0.212191,-0.686855,0.753761,0.221985,0.746368,1.54708,0.0668754,-0.629551,0.634749,0.49061,-0.255426,-0.354132,-0.285023,-0.679241,-0.0795465,0.60774,0.609345,-0.0707449,0.527557,0.282107,0.391004,-0.208674,0.303306,0.0572632,0.63923,-0.3503,0.347085,-0.292336,0.114873,-0.238888,-0.334115,-0.162882,-0.190825,-0.117703,0.137155,0.130735,-0.0457104,-0.155689,0.314244,-0.463242,0.0580503,-0.0229623,-0.0419114,0.19779,-0.0238372,0.285508,-0.534137,-0.218118,0.209556,0.0815877,0.183734,-0.0848425,0.140225,0.62777,-0.180628,-0.167611,0.544355,0.291899,-0.076816,0.280059,-0.738251,-0.23345,-0.0459529,-0.434825,-0.5022,0.286725,-0.00588837,-0.0267859,0.295687,0.0600501,-0.110507,0.0915825,0.0208217,-0.493709,-0.124635,0.291185,0.186624,-0.00553075,-0.0133751,0.127236,0.173918,-0.127982,0.472281,-0.538168,-0.0682475,-0.189546,-0.0336087,-0.142709,-0.256796,-0.254127,-0.199145,0.200672,-0.102858,-0.0731055,-0.693916,-0.0381976,0.371069,-0.20212,0.208694,0.037764,-0.287757,0.228283,-0.346911,-0.346816,0.234642,-0.395475,0.794906,0.357776,-0.279276,0.64318,-0.0709642,0.182353,-0.166886,0.475913,-0.0381591,0.53158,-0.239452,-0.00819288,-0.321692,0.389862,-0.536508,-0.298891,-0.0873864,0.553031,-0.200309,-0.445139,-0.112259,0.0280498,-0.459379,-1.00671,-0.376936,-0.332801,0.161794,-0.516775,0.0800741,-0.106934,0.205004,-0.704121,-0.307134,0.151782,-0.174994,-0.377113,-0.731545,-0.0381237,-0.134175,-0.556413,0.274687,0.31921,-0.340846,-0.174444,-0.591154,0.597223,-0.186531,-0.385628,0.0282329,-0.45048,0.0985082,-0.283434,-0.108107,0.0390062,-0.126231,0.451855,0.106347,-0.307013,0.130853,-0.375078,0.426238,-0.136545,-0.544895,-0.0511455,-0.0221982,0.067381,0.107514,-0.231474,0.309006,-0.234799,-0.339189,0.0479038,0.573452,0.0224158,-0.0147247,0.285965,-0.197423,-0.43049,-0.508158,-0.614594,-0.231159,0.391319,0.194804,0.0793069,0.369988,0.35386,-0.170316,0.357867,0.251318,-0.510923,0.431034,-0.174771,-0.147321,0.538048,-0.439528,-0.0339016,-0.00160512,0.123034,-0.0399807,0.292259,0.12109,0.113816,-0.10265,-0.0809203,-0.125474,-0.0557344,-0.0995203,0.0466129,-0.0318862,-0.000534643,0.0306464,0.267016,0.327785,0.154697,0.0692038,0.115468,0.218527,-0.116371,0.68359,-0.121054,0.152842,-0.115012,0.356306,0.224454,0.0126733,-0.116483,0.163542,0.167156,-0.16116,0.178126,0.507166,0.199963,-0.0994409,-0.327997,0.0705427,0.0537537,0.30625,0.195233,0.31745,0.122921,0.267748,0.3506,0.517444,-0.227963 +3453.1,0.708099,0.0848144,4,1.5065,0.781123,-1.11966,0.260263,0.469193,-0.165108,-0.256726,0.0614053,0.391622,0.0701963,0.0385898,-0.417715,-0.741274,0.0160113,0.00363455,0.859481,0.45606,-0.0497525,-0.0550011,-0.0411295,-0.0994312,-0.720977,-0.966734,0.314632,-0.389697,0.0696143,-0.178261,0.161528,-0.710438,0.0817032,0.815948,-0.340168,-0.0891171,0.250057,-0.0539228,0.0998211,0.0849678,0.436709,0.490744,-0.133417,1.09156,0.559098,0.341392,-0.116462,0.199106,-0.15228,-0.774257,0.367946,0.488856,0.0714047,0.349318,0.289552,0.51942,-0.40289,1.19486,0.408559,0.0801803,-0.840841,0.996328,-0.0645516,0.598613,1.23081,-0.48529,-0.996289,0.395782,0.123799,-0.193798,-0.15287,-0.0832857,-0.0337909,0.209615,0.501957,0.620151,0.140037,0.786466,0.362519,0.686608,-0.0268812,-0.196135,0.0282657,0.305117,-0.458535,0.0812647,-0.036118,-0.203045,-0.344325,-0.402677,-0.325792,0.0579646,-0.151201,0.381135,0.329588,-0.0136504,0.271169,0.391306,-0.37813,-0.359956,0.513315,0.00272091,0.329578,-0.135331,0.214852,-0.463909,-0.0762537,0.390078,0.00286741,0.0679453,-0.04225,0.11969,0.838111,-0.647217,-0.0424592,0.074543,0.291365,-0.122877,-0.086236,-0.804481,-0.223937,-0.351942,-0.158778,-1.02616,0.142123,-0.298252,0.00664515,0.0234551,0.256236,-0.105842,-0.445371,0.287777,-0.585594,0.456133,0.15195,0.217085,0.240085,-0.00622971,0.213936,-0.0956542,-0.120895,0.418162,-0.678367,-0.166975,-0.0310716,0.298034,0.233401,-0.288406,0.344029,-0.588896,0.494487,-0.0812393,-0.0805849,-0.204177,0.000271646,0.361365,-0.786398,0.334658,-0.00884322,0.0894572,-0.0227507,-0.050707,0.133909,-0.241122,-0.375093,0.729955,0.114841,-0.214704,0.621782,-0.131284,-0.0429813,-0.000427094,0.279985,-0.360982,0.242872,-0.227255,-0.120309,-0.545968,-0.0733591,-0.0202314,0.0207776,-0.232552,0.403159,0.0506437,-0.364391,0.139413,0.111776,-0.2278,-0.48997,-0.298119,-0.248623,0.0172777,-0.0561026,0.168077,-0.116682,0.08614,-0.634475,-0.148839,-0.246551,-0.164484,-0.309866,-0.250646,-0.0566488,-0.0295829,-0.509379,-0.093342,0.662108,-0.349515,0.0150286,-0.203596,0.841322,-0.183426,-0.174722,0.156128,-0.465795,0.146927,0.0553573,-0.0410908,-0.0339881,0.0195457,0.490713,0.473264,-0.530932,0.173906,-0.330765,0.404949,-0.0128474,-0.632719,0.412199,-0.149663,0.278921,0.277705,0.306425,0.126346,-0.0811961,-0.465222,-0.0688406,0.23613,0.0950407,-0.278894,0.0376608,0.111447,-0.239709,-0.162931,-0.409587,0.154416,0.0381624,0.102131,0.286593,0.332767,0.193219,0.324868,0.246271,-0.0557294,-0.885663,0.498065,-0.129627,-0.151282,0.569414,-0.496648,-0.0745164,0.0763117,0.0348532,-0.145606,0.243627,-0.0406293,0.329969,0.36502,-0.154341,-0.00327472,-0.233214,0.563287,-0.0339256,-0.130385,0.115728,-0.00829996,0.570524,0.613469,0.38363,0.209609,-0.0110312,0.511623,-0.255027,0.204739,0.0478037,-0.442042,-0.350661,0.370582,0.170465,0.284255,-0.171753,0.0739766,0.0350414,-0.0290931,-0.0706032,0.108559,0.205942,-0.113191,-0.525018,0.0163709,0.0280016,0.202904,0.0677943,-0.303341,0.0888533,0.264914,0.298083,0.514698,-1.04936 +3451.49,0.973428,0.0848144,4,1.40118,0.89396,-0.516432,0.00681368,0.521535,-0.116265,-0.254175,0.0150598,0.460568,0.38666,-0.0671341,-0.307736,-0.398271,0.348967,0.184392,0.68832,0.00819416,-0.244,0.225335,-0.15999,0.129079,-0.532293,-1.13016,0.307129,-0.17336,-0.135713,0.158506,0.579831,0.0192907,0.177674,0.871629,-0.442737,-0.175399,0.525716,0.0485414,0.0908071,0.341779,0.366834,0.710622,-0.265276,1.18265,0.686908,0.423565,0.528493,-0.163722,-0.288963,-0.164261,0.0911442,0.589764,0.366899,0.101867,0.218467,0.306445,-0.600574,1.40804,-0.229096,0.375965,-0.433596,1.0815,0.129095,0.819232,1.53326,-0.0692133,0.200054,-0.268,0.254853,-0.373719,-0.0173614,0.346963,-0.461734,0.175433,0.765458,0.631729,-0.359726,0.439957,0.129345,0.352906,0.103137,-0.13506,-0.0423722,0.309308,0.0265715,0.106476,0.0268248,-0.532283,-0.212636,-0.0402405,-0.417444,-0.0327834,-0.491505,-0.155602,-0.116173,-0.108416,0.126411,0.180933,0.0894971,-0.34784,-0.26044,-0.209602,0.263009,0.219441,0.0211445,-0.442808,-0.257581,0.29373,-0.254121,0.266153,0.294706,0.140294,0.634657,-0.201219,-0.130602,0.0515613,0.282309,0.285141,0.127042,-0.580896,-0.034502,-0.483249,-0.425917,-0.435139,0.59771,-0.227133,0.0168678,0.167657,0.253776,0.120895,0.06235,0.449574,-0.47727,0.0169055,0.306827,-0.0906044,0.516781,-0.0998257,0.096746,0.694287,-0.526997,0.0530303,-0.466975,0.145723,-0.0674918,-0.182305,-0.0104676,-0.150517,0.0171891,-0.220554,0.344665,-0.125862,-0.129392,-0.369624,-0.0259737,0.497726,0.0750315,0.13377,0.206586,-0.066232,-0.0526408,-0.155807,0.695514,0.341923,-0.0343708,0.542587,-0.472541,-0.245386,0.139248,-0.0249886,0.221,-0.020556,-0.0908458,0.0273699,-0.0658634,-0.0961803,-0.418909,-0.320393,0.120812,-0.390103,-0.0616446,-0.593043,0.255807,0.310384,-0.448797,-0.165438,0.264345,-0.526246,-0.355066,-0.33354,0.00878792,0.293476,-0.131799,0.250317,0.0901839,0.0304876,-0.603366,0.478682,-0.0747272,0.0640083,-0.635146,-0.391385,0.5253,-0.0138154,0.104608,-0.117499,-0.447436,-0.192548,0.22183,-0.394477,0.891212,-0.0673331,0.298869,0.160576,-0.0349509,0.430437,-0.343313,0.306528,0.415885,-1.10148,0.0313751,0.228585,-0.340856,-0.208028,-0.534001,-0.158288,0.201551,-0.583059,0.338373,-0.269274,0.129175,0.20142,0.178178,0.0260932,-0.00748802,-0.330215,0.0519056,-0.0731507,0.0443362,0.112288,-0.254467,0.123162,-0.179205,-0.20277,0.166354,-0.0720051,-0.18942,0.365436,0.356663,0.455478,0.329829,0.203999,0.0771896,0.173634,-0.177807,0.176918,-0.0765615,0.0471272,0.489875,-0.239952,0.181917,0.0631814,0.106417,0.20693,0.0320444,0.628953,0.268942,0.516066,0.291711,0.122724,-0.294784,0.451529,-0.250298,0.102253,-0.075286,-0.427709,0.0484825,0.372144,-0.0900779,0.248867,-0.00725348,0.254418,-0.134453,-0.104236,-0.285308,-0.0584979,0.190447,0.0283723,0.472354,0.150353,-0.0423595,-0.225665,-0.262555,-0.0956487,-0.0796904,-0.0400286,0.227695,-0.419806,-0.460202,0.133955,-0.0974792,0.173128,-0.120131,-0.0684221,0.104963,0.278778,0.32398,0.527995,-1.61673 +3453.02,0.985331,0.0848144,4,1.43758,0.813942,-0.720297,0.16289,1.05339,-0.144239,-0.00127213,0.322493,0.452589,-0.160263,0.279606,-0.00682327,-0.37683,-0.197216,-0.525595,0.995886,0.560932,0.39799,-0.141398,0.117716,-0.0711799,-1.11806,-1.1544,0.394517,-0.116547,-0.255411,-0.00767948,0.334102,0.117682,0.0756849,1.06575,-0.637937,0.186297,0.406696,0.273658,0.198149,-0.157851,0.533462,0.737658,-0.221811,1.32412,0.0540839,0.423623,-0.231499,0.419814,-0.544395,-0.226058,0.384151,0.554518,0.260061,0.417502,0.306332,0.538966,-0.488069,1.6555,0.00782704,0.016863,-0.706046,1.30165,-0.549703,0.661088,1.14035,-0.491522,-0.554725,0.40675,0.217257,-0.106169,-0.25613,-0.129414,-0.321937,-0.109834,0.264247,0.845929,0.23596,0.364071,0.156308,0.296185,-0.489869,-0.370332,0.153229,0.588251,0.0148907,0.184502,-0.21986,-0.289811,0.0403204,0.106961,-0.47922,-0.379244,-0.535716,-0.033309,0.228641,0.0985648,0.148068,-0.130854,0.00273346,0.15098,-0.150084,0.0505419,0.0761943,-0.0484374,-0.429697,-0.175623,0.103101,-0.239873,-0.819064,0.110106,0.0302468,0.295332,0.466228,0.0408202,-0.17928,0.524358,0.23441,-0.513773,-0.261741,-0.37437,-0.35913,0.41343,-0.366068,-0.675523,0.186228,-0.431981,0.275125,0.211276,0.348172,0.0192648,-0.122526,0.207995,-0.557773,0.272929,-0.021303,0.315497,0.588159,-0.327814,-0.33665,-0.174521,-0.284568,0.0364256,-0.107292,-0.146984,-0.0722031,0.318795,0.327948,0.0613551,-0.514447,-0.0620368,0.853485,-0.487391,-0.062458,-0.439859,0.145429,0.387598,0.0790443,0.0629379,0.310306,0.128885,0.192212,-0.16623,0.335105,-0.266271,-0.665234,0.788566,-0.602141,-0.233116,0.0423605,0.0233248,-0.00324107,-0.0422678,0.374438,0.0351224,-0.0478041,-0.216191,-0.298112,0.0787284,0.144627,-0.513612,0.181295,-0.0385099,0.155787,-0.0737213,-0.369835,0.0248513,0.227893,-0.391707,-0.00103895,-0.085509,-0.278417,0.101294,-0.409005,0.244984,0.0262764,-0.399528,-0.839429,0.0763017,0.224571,-0.101733,-0.0264075,-0.109993,0.595193,-0.125318,-0.405502,-0.128347,0.228659,-0.0312653,-0.473633,-0.190887,0.662104,-0.0836229,-0.0965635,0.0344692,-0.141844,-0.0614102,-0.414077,-0.487275,0.443769,-0.243282,0.187105,0.262967,0.297953,0.170015,-0.387785,0.36535,0.532699,-0.480751,0.17122,0.128135,-0.36008,-0.107965,0.773771,-0.165842,-0.00554342,-0.159737,0.115791,-0.0422069,0.351863,-0.0414225,0.0777392,0.456657,-0.226334,-0.168515,0.0422421,0.107869,0.380469,0.138437,0.156324,0.373206,-0.572215,0.112711,0.240157,-0.038448,-0.697224,0.4021,-0.146781,-0.114071,0.212665,-0.119631,0.077671,0.36972,-0.230136,0.51517,0.474012,0.0189636,0.193096,-0.298698,0.22051,-0.383379,0.0142427,-0.436192,0.0897971,0.338561,-0.278909,-0.275933,-0.238588,-0.219753,0.164937,-0.0327865,0.165981,0.543972,0.00606357,-0.14274,-0.246444,-0.56666,-0.16358,0.466551,0.207178,-0.0020774,0.249671,0.0739462,-0.168888,-0.0928925,0.267905,0.285739,0.0788268,-0.298131,0.00461632,-0.216349,0.0499858,0.142103,0.161349,-0.495295,0.0874013,0.406954,0.295637,0.63793,-3.23842 +3436.34,0.956902,0.0848144,4,1.43052,0.94623,-0.497737,0.121093,0.809722,-0.16847,-0.25585,-0.370367,0.562603,0.49477,0.0426899,-0.116669,-0.062376,0.249149,0.277522,1.18062,-0.00405265,-0.45191,0.0490769,-0.0178965,-0.271388,-0.524905,-0.637871,0.279805,-0.240397,0.121329,0.259731,0.46595,-0.22558,0.056839,1.27555,-0.027627,0.485035,0.45949,0.213695,0.21418,-0.2516,0.809418,0.710001,-0.22636,1.40523,0.392397,0.392059,-0.407772,-0.0851672,-0.737805,0.0540377,-0.0506513,0.933368,0.735384,0.557246,0.368467,-0.110097,-0.120801,1.39321,-0.457468,0.425468,-0.864386,0.527983,-0.149942,0.061129,1.00754,-0.0291163,-1.30218,-0.778218,0.023856,-0.280814,0.00166707,0.119839,-0.292426,0.165963,-0.227474,0.395794,-0.44144,0.282275,0.819636,0.420356,0.306993,-0.172791,0.251264,0.30542,-0.204897,-0.136933,0.207441,0.358796,-0.330129,-0.0948895,-0.409821,0.599496,-0.759313,-0.107397,-0.385101,0.00330947,0.0492201,0.174162,-0.424148,-0.347804,-0.280607,0.111857,-0.184669,0.14761,-0.386415,-0.0866332,-0.283641,0.50005,0.0642994,-0.0235535,-0.526877,-0.238885,0.116226,-0.0618414,0.246251,-0.197357,0.162928,0.721988,0.174158,0.165907,0.330029,-0.276615,0.0204423,-0.411103,-0.415116,0.101243,-0.549914,0.126273,-0.11529,0.18037,0.235062,0.159527,-0.159338,0.142184,0.157935,-0.30798,-0.148758,0.0649659,0.246873,0.299169,-0.209519,0.726373,-0.552876,-0.0955587,-0.238613,-0.311231,-0.809543,-0.134516,0.406625,-0.124387,-0.158016,-0.512482,-0.426544,0.305051,0.02975,0.0849718,-0.339382,0.392908,-0.103981,0.217259,-0.0110185,-0.197698,0.0423712,0.448497,0.792717,0.683418,0.56637,-0.285062,-0.0871875,-0.263064,-0.246454,-0.380009,-0.200296,0.413283,-0.242399,-0.1869,0.120987,-0.203137,-0.138458,0.082501,-0.350432,0.220629,1.09718,0.16649,-0.06298,0.668571,-0.175439,0.385504,-0.446454,-0.281901,-0.0200779,0.122695,0.106686,0.0139326,-0.117848,0.173852,-0.16615,-0.028086,0.390787,0.0168626,-0.144365,-0.556316,-0.649008,-0.267836,-0.330993,0.514552,-0.437984,0.328789,-0.216303,-0.353979,0.346144,-0.188931,0.123599,0.0898275,-0.0580297,-0.161631,0.540922,-0.0813776,-0.354825,0.250705,-0.442256,0.35248,-0.924278,-0.115901,-0.109518,-0.287529,-0.308291,-0.0714216,0.324497,-0.779063,-0.107201,0.232049,-0.308413,-0.149871,-0.238603,-0.136905,-0.422737,-0.491079,0.34796,0.108508,-0.320978,0.513066,-0.218889,0.180829,0.27435,-0.042505,-0.0941644,0.217598,-0.222461,0.447362,0.447246,0.0169745,-0.506312,-0.342791,-0.50139,0.44704,0.212045,-0.129221,0.136766,-0.0930543,0.204858,0.312438,0.168301,-0.439591,0.143621,0.309458,0.0280067,0.434657,0.104561,-0.266839,-0.319267,0.224017,0.0177834,-0.544473,-0.23615,-0.18139,0.200029,0.240503,-0.0431298,-0.215247,0.494445,-0.170853,0.398074,0.159415,0.275161,0.0142323,0.0578377,-0.279505,-0.157568,-0.256523,-0.0923297,0.341315,-0.268577,-0.207463,0.258776,-0.248435,0.584448,0.245551,-0.535676,0.133801,-0.187925,-0.520149,-0.53525,0.450271,0.102732,0.264704,0.320519,0.514494,-2.74167 +3440.47,0.39403,0.0848144,4,1.45931,0.96317,-0.399861,0.0171292,0.752374,-0.160657,-0.049799,-0.235291,0.706228,0.505448,0.137758,0.0110685,-0.0830792,0.348256,0.244856,1.31155,-0.129657,-0.270231,0.0175741,-0.0384376,-0.360528,-0.376591,-0.577572,0.320516,-0.32496,0.22482,0.238597,0.57125,-0.154236,0.18969,1.26113,0.057889,0.322232,0.400644,0.156372,0.0989035,-0.232928,0.666157,0.702762,-0.505389,1.42509,0.313077,0.139432,-0.474348,-0.112776,-0.789651,-0.249488,0.13994,0.731498,0.623823,0.665932,0.51589,-0.16577,-0.0240809,1.42375,-0.539497,0.521749,-0.856204,0.515515,-0.101339,-0.0237212,0.945669,-0.11492,-1.29048,-0.912253,-0.00192778,-0.300004,0.09491,0.0712215,-0.340237,0.132393,-0.160207,0.462433,-0.65345,0.0699398,0.635515,0.414935,0.308185,-0.155091,0.230766,0.20031,0.260364,0.0982915,-0.000852465,0.283324,-0.160011,-0.102693,-0.396632,0.511001,-0.649711,-0.334695,-0.25169,-0.127845,0.0901263,0.157475,-0.393793,-0.286094,-0.372438,0.26404,-0.0894776,0.173624,-0.319511,-0.178613,-0.223332,0.593178,0.171143,0.192954,-0.55228,-0.161175,0.142358,-0.073951,0.498518,-0.177353,0.112257,0.578642,0.361313,0.198249,0.372551,-0.271757,0.342214,-0.393989,-0.295339,0.251585,-0.470513,0.123596,-0.0396184,0.0929717,0.00917369,0.182845,-0.116562,0.00239845,-0.0223181,-0.358293,-0.160136,0.140683,0.278828,0.394304,-0.33459,0.510754,-0.484286,-0.0572147,-0.192728,-0.216993,-0.896266,-0.221469,0.333238,-0.232842,-0.158065,-0.505841,-0.408736,0.110742,-0.00549395,0.0704559,-0.428677,0.218363,-0.250177,0.272129,-0.125322,-0.240079,-0.182145,0.614744,0.813121,0.665134,0.723084,-0.091855,-0.0753619,-0.170508,-0.279613,-0.395892,-0.0436057,0.580363,-0.0552779,-0.0602964,0.133093,-0.245076,-0.0604196,0.129557,-0.417363,0.345626,0.835544,-0.0802728,-0.231453,0.519077,-0.136343,0.434373,-0.342774,-0.15799,-0.0550596,0.244001,0.311811,-0.103374,-0.0841911,0.225125,-0.17363,0.0347314,0.163362,0.144164,-0.26367,-0.378886,-0.351352,-0.300507,-0.129083,0.409675,-0.500298,0.223095,-0.0815543,-0.460468,0.357362,-0.156188,0.0149507,-0.0825367,-0.215648,-0.263843,0.398234,-0.192584,-0.153564,0.138928,-0.363706,0.246084,-0.738633,-0.232388,-0.269097,-0.0516384,-0.252534,-0.193788,0.219585,-0.734625,-0.30932,0.243428,-0.122808,-0.0200029,-0.293668,-0.200872,-0.208122,-0.526173,0.275784,0.211206,-0.211917,0.538561,-0.0457782,0.20439,0.101534,0.0809015,-0.173319,-0.0281187,-0.285106,0.50378,0.4249,0.0147959,-0.489585,-0.448677,-0.389195,0.40476,0.0975261,-0.417325,0.0570713,0.0235897,0.322117,0.0792211,-0.0133358,-0.598078,0.200447,0.187515,0.00704946,0.555365,-0.0136392,-0.175139,-0.371475,0.158258,0.112186,-0.638393,-0.127061,-0.22201,0.286727,0.370898,-0.0963793,-0.00789675,0.547828,-0.0125383,0.506757,0.412563,0.31138,0.122223,0.113383,-0.263034,-0.283862,-0.396542,-0.0102561,0.404216,-0.523451,-0.171504,0.24717,-0.0381803,0.379193,0.190418,-0.32985,0.15103,-0.0452704,-0.274151,-0.542056,0.387005,0.105929,0.280843,0.325467,0.529946,-2.50723 +3415.07,0.98079,0.0848144,4,1.43847,0.985885,-0.21391,-0.00495116,0.935584,-0.185254,0.0205233,-0.137454,0.744525,0.496425,-0.0369878,-0.0596337,-0.25268,0.43188,0.296635,1.50293,-0.223779,-0.155812,-0.172162,0.0721157,-0.467974,-0.575038,-0.784276,0.340375,-0.229751,0.27193,0.146175,0.393332,-0.168777,0.0743966,1.3332,0.187733,0.289775,0.310957,0.330176,0.144595,-0.0922124,0.584436,0.564343,-0.395402,1.31554,0.396548,0.0935939,-0.616495,-0.155201,-0.880882,-0.388858,-0.0226353,0.726448,0.930317,0.518824,0.860068,0.0533138,-0.25545,1.52596,-0.453959,0.488384,-0.955762,0.418462,-0.121927,0.0609883,0.836328,-0.411527,-1.02459,-0.778239,-0.243774,-0.468708,0.130726,0.0963617,-0.555903,0.0595766,-0.03968,0.360508,-0.537728,-0.051167,0.601451,0.606089,0.277545,-0.241252,0.350718,0.410568,0.197256,-0.0296129,-0.00985813,0.221545,-0.236472,0.10451,-0.502863,0.47405,-0.761881,-0.144767,-0.0324459,-0.0206276,0.150207,0.24435,-0.39828,-0.275565,-0.188269,0.318738,-0.151765,0.236183,-0.45203,-0.129478,-0.33589,0.54811,0.212408,0.163585,-0.718879,-0.113867,0.340038,-0.0298079,0.471287,-0.130446,0.149882,0.458142,0.14821,0.244316,0.284104,-0.367744,0.351753,-0.453083,-0.0929828,0.206511,-0.0952517,0.302056,0.0432243,0.147935,-0.0688266,0.424209,-0.223163,0.291609,-0.0275536,-0.385002,-0.028618,0.0713996,0.175473,0.405406,-0.119767,0.622312,-0.166411,0.0431349,-0.114736,-0.35783,-0.88118,-0.190452,0.625831,-0.28095,-0.0119266,-0.612353,-0.238325,-0.257558,0.0853403,0.0918316,-0.17321,0.38632,-0.145189,0.297896,-0.111212,-0.208148,-0.191354,0.183965,0.781076,0.486691,0.662409,-0.0180253,-0.0800628,-0.178766,-0.0168423,-0.347253,0.0870519,0.52735,-0.188706,-0.240992,0.305373,-0.043638,-0.176718,0.149805,-0.325084,0.415583,0.915873,-0.0230618,-0.037957,0.623428,-0.231543,0.245305,-0.394107,-0.12932,-0.10269,0.0242091,0.369862,-0.0188712,-0.0419674,0.322848,-0.417991,-0.0611918,-0.0296799,0.156421,-0.271896,-0.39181,-0.690093,-0.329556,-0.0159806,0.300468,-0.502645,0.230656,0.154855,-0.444178,0.428241,-0.195452,0.0412081,-0.181996,-0.419913,-0.570522,0.325433,-0.191613,-0.329782,0.226034,-0.273247,0.39384,-0.853824,0.0823308,-0.123117,-0.183129,-0.367734,-0.152652,0.18199,-0.797596,-0.307515,0.274231,0.0846412,-0.0954781,-0.183124,-0.287744,-0.294289,-0.531675,0.279567,0.110152,-0.141318,0.586913,-0.0222921,0.474564,-0.023696,-0.0431096,-0.100312,-0.127675,-0.359723,0.477383,0.530096,0.0186885,-0.548062,-0.377684,-0.456918,0.665176,0.0747061,-0.530211,0.00165942,0.239176,0.308482,0.132358,0.0702207,-0.556554,0.0365748,0.179932,-0.0378145,0.657695,-0.197086,-0.407077,-0.279917,0.211352,0.313895,-0.49859,0.153361,-0.252968,-0.016443,-0.00708849,-0.499868,0.143008,0.738829,-0.0460262,0.154382,0.677379,0.320436,0.275623,0.0241855,-0.0530274,-0.155165,-0.194256,-0.0981004,0.218614,-0.811773,-0.141281,0.567993,-0.249215,0.343406,0.437692,-0.168168,0.321542,0.115957,-0.290231,-0.607132,0.447717,0.116427,0.251202,0.341214,0.5012,-3.24706 +3424.75,0.913615,0.0848144,4,1.52397,1.13261,0.326514,-0.317962,0.713092,-0.170355,0.224601,0.271609,0.882864,0.540219,-0.245173,-0.0706396,0.0503736,0.199462,-0.0789457,0.823166,-0.0583216,-0.176015,0.225764,-0.110091,-0.728309,-0.744655,-0.0732144,0.0710764,0.00967447,0.328603,0.454185,0.369138,-0.0566727,0.250162,0.986377,0.0878518,0.209069,0.416845,0.0488517,0.207399,-0.521093,0.662951,0.719126,-0.0501693,1.34773,0.373284,0.557967,-0.38638,0.267063,-0.77475,-0.636507,-0.459145,0.899594,0.308795,0.238634,-0.0510162,0.0701941,-0.0801261,1.54285,-1.04351,0.471842,-0.774968,0.86596,-0.269058,-0.242982,1.10579,-0.984571,-0.69549,-0.273466,-0.110326,-0.255101,-0.364909,-0.561474,-0.403017,0.194245,0.558474,0.8004,0.397529,0.640579,0.487453,0.302485,-0.174407,-0.238843,0.392999,0.338115,0.0323896,0.203278,-0.270038,-0.222032,-0.256636,0.224006,-0.856361,0.0902351,-0.845901,0.249734,0.396958,-0.0885629,0.329337,0.123367,-0.358652,-0.446822,-0.323588,-0.426307,-0.0138017,-0.169297,0.248302,-0.27612,-0.00106153,0.242162,-0.385058,0.0832806,-0.22533,-0.371001,0.0474341,0.0307195,-0.317811,0.190666,0.20732,0.182707,-0.116878,-0.0362864,0.251123,-0.0864602,0.0956754,-0.929011,-0.135512,-0.462141,0.24758,-0.107521,0.359797,-0.226744,-0.197827,0.0201729,-0.438821,0.676908,-0.0731895,0.0739611,0.169372,0.140004,0.142772,0.22661,-0.053692,0.73997,-0.0381834,0.0411978,-0.113021,-0.132133,-0.617343,-0.428063,0.336838,-0.178021,0.174593,-0.246879,-0.181962,-0.530987,0.22076,0.488753,-0.3322,-0.0305208,-0.244656,0.202433,-0.0462022,-0.166096,-0.303367,0.350383,0.223144,0.517152,0.446753,-0.208648,0.344464,-0.483559,-0.252695,-0.0849202,0.52651,0.300963,-0.186072,-0.257304,0.20426,-0.384619,0.06769,-0.308694,-0.733464,0.0346399,0.345701,0.049347,-0.0966729,0.0939014,-0.360062,-0.176908,-0.368506,-0.374589,-0.0497206,0.160705,-0.170759,-0.19787,0.0672515,-0.122078,-0.128364,-0.314501,0.526743,0.109326,-0.219857,-0.905059,-0.21906,-0.0736948,0.00077585,0.179214,0.125738,-0.470533,-0.0420947,-0.221698,0.506296,-0.467584,-0.13248,-0.0576125,0.155284,-0.747118,0.682387,0.0142205,0.438883,-0.193952,0.0745841,0.362445,-0.744937,0.166608,-0.392297,0.33012,-0.0703039,0.223484,0.499568,-0.0648469,-0.322312,-0.378408,0.123106,-0.337615,-0.130978,-0.112707,-0.359251,0.0411152,0.600931,-0.418217,0.0467888,0.31001,-0.551784,-0.349521,0.620637,-0.0820093,0.312723,0.601665,0.201354,1.008,0.32868,-0.186423,-0.403501,-0.535589,-0.602331,0.459483,-0.123449,-0.501199,0.576442,0.0611997,0.12326,-0.131706,-0.0452395,-0.612656,-0.0985582,0.366497,0.254306,0.487877,0.334977,-0.291536,-0.216432,0.035976,-0.260786,-0.0697565,-0.169955,-0.777046,0.348293,0.12723,-0.0281504,-0.153,0.100577,0.156823,0.632961,-0.243794,-0.103912,0.224832,0.352748,-0.451298,-0.111027,-0.454736,-0.0996253,0.62101,-0.271347,-0.0786589,0.386634,-0.63492,0.259065,0.207483,-0.207539,0.303806,0.147285,-0.125469,-0.290503,0.0364334,0.122855,0.474124,0.350507,0.688567,-2.67316 +3423.43,0.987825,0.0848144,5,1.3803,1.29673,0.348431,-0.395217,0.721932,-0.119521,0.328761,0.657765,0.895219,0.735799,-0.338833,-0.332969,-0.159881,0.307371,-0.191669,1.19014,-0.0282678,0.0381943,0.0778878,-0.00153884,-0.683689,-0.893958,-0.824066,-0.0316818,0.43354,0.0515001,0.166874,1.02925,0.025749,0.454018,0.876528,-0.309892,-0.0389348,0.154473,0.375257,0.371913,-0.482676,0.67273,0.92476,-0.116655,1.15615,0.666261,0.32268,-0.199361,0.114226,-0.762097,-1.08724,-0.539205,0.814574,0.345339,0.776415,-0.428511,0.289414,-0.65568,1.44678,-0.145355,0.247412,-0.768175,0.60457,0.327488,0.540755,0.787732,-1.06552,-0.963638,-0.29576,0.590116,-0.309023,-0.523337,0.449422,-0.0667853,0.0654545,0.210435,0.361836,-0.157626,0.513731,0.281295,0.434142,-0.431408,-0.579251,0.308559,0.595591,-0.758876,0.0115329,-0.391086,0.119554,-0.415137,-0.0191578,-0.492996,-0.324135,-0.569735,0.204189,0.400625,0.143177,-0.0460507,0.27804,-0.0137699,0.197362,-0.648506,0.660097,0.300908,0.20078,-0.84584,0.122793,-0.256439,-0.407011,-0.123191,0.570701,-0.148093,0.440608,0.420198,0.299036,0.0750551,-0.281565,0.302271,-0.0670492,-0.407771,-0.266541,0.240539,-0.444895,0.225892,0.0156756,0.00157413,0.204063,-0.162676,-0.317256,0.146266,0.700322,0.104136,0.652653,-0.215298,0.0619373,-0.131054,0.0343015,0.47546,-0.306902,-0.287004,-0.543443,-0.229437,0.380868,-0.788608,-0.475063,-0.168562,-0.201055,-0.14126,0.25118,0.414065,-0.22098,0.0302656,-0.812967,-0.552224,0.427503,0.177139,0.417592,-0.266726,0.526982,-0.104541,-0.469424,-0.0370377,-0.166579,-0.163959,0.131987,0.0490724,0.967409,-0.676344,0.118757,0.064657,-0.0917347,-0.376769,0.0489801,-0.0110801,0.500603,0.300858,-0.0779096,-0.0877812,0.0492881,0.0739649,0.298973,-0.27631,0.427362,0.944085,0.659063,-0.435485,0.406111,0.492027,-0.147506,-0.160582,0.0479603,-0.264784,0.247936,-0.556832,0.0256746,0.300439,-0.0133725,-0.67089,0.27273,0.338397,-0.270551,0.287867,-0.0947549,-0.137355,-0.150296,-0.1033,0.631502,-0.131495,0.640909,-0.264304,-0.374897,0.467072,-0.0794239,0.292847,-0.243087,0.181206,0.114197,-0.121617,0.0941372,-0.390446,-0.0720866,0.256001,-0.246802,-0.579122,-0.376353,-0.141914,0.335913,-0.056259,-0.0532595,0.170555,-0.258275,-0.341662,0.4932,0.0500393,0.248391,0.0401565,-0.218252,-0.19973,-0.453571,0.525245,-0.080261,-0.161685,0.616798,0.101049,-0.364213,-0.127841,0.299755,-0.110327,-0.243739,-0.166226,0.370398,0.0502407,-0.25533,0.0418525,0.115274,-0.396237,0.138852,0.0483909,0.318753,-0.0176002,0.0705141,-0.247351,0.150695,0.117252,0.201566,0.531858,0.241462,-0.218102,0.138739,-0.0779294,-0.388734,-0.0115137,0.382161,-0.180908,-0.171481,-0.1262,0.238324,-0.111181,0.111408,0.407661,0.116148,-0.360064,-0.148371,0.24463,0.0963941,0.061625,-0.317497,-0.18351,0.00711708,0.687534,-0.141997,-0.0331396,0.197001,0.324985,-0.0577914,-0.0394981,0.477515,0.122814,0.610455,-0.316558,0.0229795,0.217233,0.0732032,-0.429053,-0.130882,0.100163,0.304351,0.316485,0.551681,-3.08729 +3430.63,0.757261,0.0848144,4,1.44752,1.21443,0.262127,-0.324185,0.489994,-0.153017,0.136955,0.391159,0.897719,0.505638,-0.549042,0.202015,0.431276,0.18866,0.166423,1.26973,0.374197,-0.0145448,-0.236859,-0.038953,-0.650982,-1.14283,-0.40998,-0.364564,0.16837,-0.45057,0.342858,0.956568,-0.168689,0.3733,1.09963,-0.582744,-0.220848,0.458436,0.29603,0.0323914,-0.387107,0.419793,0.796494,-0.0581958,1.24014,1.00721,0.0493734,-0.489382,-0.162699,-0.88,-0.627743,0.178979,0.528316,0.157181,0.233673,-0.219538,0.312037,-0.776286,1.49956,-0.176883,0.0773256,-0.657857,0.51405,0.0734906,0.149076,0.794059,-0.324598,-1.26459,0.149462,0.324753,0.0350525,0.0286851,0.352873,0.0336061,0.073636,0.446207,0.495257,-0.024232,0.412374,0.310093,0.224871,-0.117644,-0.11508,0.0668762,0.528621,-0.0500875,0.376579,-0.343266,-0.376722,-0.173623,0.0222406,-0.298084,0.0862116,-0.69356,0.168916,0.0399062,-0.0772745,-0.120349,0.0976318,-0.187114,0.000373656,-0.495414,0.198032,0.283384,0.287502,-0.492446,0.620877,-0.012685,-0.200917,0.132021,0.531137,-0.417151,-0.145298,0.508919,-0.2846,-0.207309,-0.250489,0.209744,0.638531,0.125382,-0.0878039,0.24326,-0.127994,0.013375,0.194043,-0.716677,0.261671,0.335013,-0.489668,0.0878416,0.461352,0.313155,0.431868,-0.149045,0.382063,-0.305435,0.2636,0.700068,-0.567664,-0.383283,-0.233742,-0.435485,0.223542,-0.466215,-0.344727,-0.373577,-0.0642087,-0.153222,0.477971,0.0442657,-0.727258,0.240387,-0.442897,-0.109613,0.0970505,-0.120219,0.24544,-0.274269,0.634324,0.0194515,0.149949,-0.0146426,0.0205206,0.15665,-0.0809115,-0.182534,0.846646,0.196146,0.033211,0.28235,0.133963,-0.042823,0.132135,-0.380197,0.00501909,0.0592732,-0.279756,-0.0531851,0.049131,-0.0495193,0.260118,-0.180943,0.163459,0.855554,0.0548328,-0.670696,0.184176,0.163425,0.00608671,-0.0605972,-0.00336607,-0.166221,0.302505,-0.333434,-0.154191,0.210546,-0.0866025,-0.824533,-0.275966,0.574247,-0.169761,0.0130552,0.0207834,-0.228238,0.349974,-0.528205,0.542132,-0.0692687,-0.267009,-0.903843,-0.540057,0.481405,0.384619,0.547182,-0.172153,-0.113973,0.23775,0.123462,0.312505,-0.0459154,0.287943,-0.260527,-0.408916,-0.577423,-0.0636627,0.00762728,0.10274,0.0961617,-0.25962,0.256899,-0.389102,-0.39664,0.195931,-0.328419,0.124507,-0.156955,0.390301,-0.0118746,-0.204367,0.536119,-0.188116,0.156059,0.610718,-0.405476,0.398366,0.450422,0.801422,-0.219322,0.368997,0.122028,0.568144,0.161168,0.284238,-0.555429,0.107742,-0.878608,0.149661,-0.341116,0.339409,0.204928,-0.247825,-0.207285,0.373745,-0.127664,-0.17093,0.293384,0.366943,0.205969,0.236835,0.116216,-0.269316,0.432968,0.21391,0.030267,-0.193096,-0.165509,-0.0926323,0.0559637,0.433224,0.0168687,0.357447,-0.274853,0.527958,0.200238,0.202498,0.0444229,-0.0187469,-0.294754,0.274908,0.519573,-0.431108,-0.361834,-0.128532,-0.136674,-0.0550574,-0.0238831,-0.0375837,0.510957,0.381398,-0.708778,-0.283882,0.243494,0.409331,0.0479063,-0.512071,0.128746,0.343905,0.358812,0.586434,-2.11824 +3420.57,0.867291,0.0848144,4,1.44759,1.22529,0.187915,-0.230491,0.507314,-0.108942,0.384304,0.492031,0.861432,0.507505,-0.467543,-0.161206,0.236449,0.310966,0.276098,1.25245,0.218223,0.131734,-0.308857,-0.0112309,-0.293887,-1.16075,-0.156696,-0.264038,0.157056,0.0425157,0.116008,1.15104,0.125267,0.16775,0.859018,-0.713705,-0.115585,0.348779,0.065449,0.00288639,-0.582405,0.402456,0.720878,0.0279646,1.05209,0.912952,0.328003,-0.741927,0.0505242,-1.03602,-0.666633,-0.29229,0.646036,0.475104,0.410989,-0.212762,0.741317,-0.855387,1.21445,-0.20693,-0.0623491,-0.543393,0.376911,0.00990164,0.0238003,0.84829,-0.679839,-1.5031,0.0746618,0.446275,-0.352258,0.361255,0.125505,0.118965,-0.196322,0.274371,0.438516,0.150079,0.260122,0.0868846,0.345823,-0.0458849,-0.00759776,-0.00722438,0.51388,-0.290174,0.308476,-0.175895,0.0374839,-0.194857,-0.10644,-0.260722,0.0977564,-0.499786,0.17734,-0.0455967,-0.338522,0.404618,0.213329,0.150588,-0.151304,-0.763687,0.274358,0.15525,0.210136,-0.425401,0.20376,0.180878,-0.0635955,0.139573,0.203646,-0.417824,-0.21065,0.22483,-0.246419,-0.567002,0.153137,0.137421,0.200874,-0.344356,-0.143495,0.39815,0.0150235,0.0800794,-0.351246,-0.465509,-0.0345578,0.418382,0.0557706,0.0571102,0.396018,0.0228768,0.617236,-0.080291,0.0347777,-0.304003,0.12968,0.378924,-0.455853,-0.428899,-0.111112,-0.230053,0.00849701,-0.573873,-0.437953,0.209906,0.0210035,-0.0187879,0.759451,0.348918,-0.785604,0.196374,-0.501549,-0.150283,0.204458,-0.137262,0.0237541,-0.265851,0.710351,-0.421994,-0.118365,-0.260297,0.261211,0.156761,0.359636,-0.189302,0.684225,0.430453,-0.047987,0.292749,-0.258607,0.072112,0.162347,0.0992947,-0.0941309,-0.214284,-0.196609,-0.193521,-0.192893,0.319886,0.0646114,0.0923941,0.250536,0.828772,0.47981,-0.791596,0.37584,-0.120953,0.238172,-0.0912867,0.204002,0.0261118,-0.176341,-0.527408,0.16482,0.449576,-0.0635947,-0.664087,-0.208586,0.381239,-0.402791,-0.124572,0.340046,-0.061875,0.221166,-0.380872,0.258984,0.188878,-0.27031,-0.873398,-0.768791,0.392576,0.244121,0.221584,-0.171415,-0.061247,0.394589,0.26592,-0.0953571,-0.19034,-0.0330482,-0.145125,-0.367526,-0.306667,-0.198708,-0.221877,-0.248632,0.357415,-0.361013,0.140411,-0.442891,-0.595572,-0.156758,-0.282726,-0.0360108,-0.0420993,0.708923,-0.231989,-0.300217,0.872206,-0.35712,-0.106879,0.820559,-0.101677,0.0946921,0.243845,0.356905,-0.205572,0.280944,0.0413837,0.397557,0.140632,0.517745,-0.51009,-0.0343892,-1.14416,0.0432962,-0.423301,0.377543,0.135341,-0.13208,-0.500485,0.00449327,0.288098,0.123078,0.18428,0.360148,-0.279561,0.408336,0.0755224,-0.172732,0.204356,0.149792,0.063982,-0.11007,-0.23693,0.215564,-0.068603,0.761622,-0.283475,-0.030425,-0.513673,0.536651,0.306603,-0.254157,-0.427613,-0.0404657,-0.362479,0.117523,0.21033,-0.345916,-0.256564,-0.0809473,-0.455065,-0.248441,0.328202,0.205821,0.270657,0.319132,-0.903274,-0.455567,0.33257,0.0163325,0.538339,-0.628609,0.11761,0.447258,0.342943,0.668773,-2.25576 +3415.67,0.967129,0.0848144,4,1.45228,1.24536,0.0251189,-0.185441,0.5807,-0.101442,0.359274,0.383265,0.627282,0.73388,-0.423949,-0.156914,0.217995,0.361396,0.181276,1.10427,0.147671,0.279443,-0.349626,0.161285,-0.453795,-1.02622,-0.0806427,-0.441787,0.24935,0.115044,0.0828634,1.37917,0.182128,0.24848,0.900395,-0.731773,0.0424237,0.513173,0.107554,-0.127955,-0.515557,0.428144,0.545865,0.0226379,1.06048,0.895838,0.242286,-0.727678,0.236755,-0.95982,-0.29618,-0.174122,0.656562,0.0876321,0.283631,-0.524909,0.63341,-0.83924,1.22616,-0.27464,-0.061486,-0.440222,0.507935,0.102574,-0.129826,0.835479,-0.771041,-1.84283,0.0665154,0.425953,-0.331484,0.499645,0.0615637,0.238968,-0.195287,0.230786,0.400771,0.134434,0.0981664,0.111707,0.415739,0.00464217,-0.0337677,0.161806,0.546003,-0.231114,0.2989,-0.0411094,0.159974,-0.254333,-0.171403,-0.466976,0.0672412,-0.470786,-0.0363167,-0.173778,-0.34765,0.415263,0.18255,0.189576,0.108134,-0.79179,0.203113,0.0566316,0.0150994,-0.452752,0.0794495,-0.103757,0.0347118,-0.0773173,0.0998361,-0.350145,-0.115995,0.30725,0.0235619,-0.642803,0.237858,0.124119,0.232551,-0.390776,-0.114445,0.468211,-0.101789,0.248353,-0.593957,-0.552683,-0.0138685,0.517339,0.198147,0.0454351,0.0245522,-0.14874,0.481297,0.000312094,0.0550016,-0.282007,0.158085,0.278412,-0.360554,-0.520887,-0.149794,0.019073,-0.115637,-0.622577,-0.413527,0.120327,-0.0992423,-0.102663,0.556538,0.388455,-0.399179,0.281587,-0.378397,0.120027,0.0940457,-0.0428795,0.0580159,-0.229165,0.743908,-0.42209,0.19183,-0.268822,0.245096,-0.0360824,0.250466,-0.179245,0.455615,0.320325,-0.0316167,0.154428,-0.231872,0.181465,-0.0226178,0.0136859,-0.122541,-0.344368,-0.192412,-0.110059,-0.0188036,0.423647,0.0310844,-0.0788477,0.3428,0.766927,0.382112,-0.778283,0.367627,0.0308614,0.399045,0.0701643,0.224089,0.0821755,-0.0482927,-0.420538,0.0324409,0.495933,-0.0338272,-0.309702,-0.12889,0.391851,-0.316879,-0.182217,0.468086,0.181595,0.255779,-0.427959,0.119274,-0.0365288,-0.519574,-0.844467,-0.839453,0.516208,0.265237,0.0611369,-0.0491478,-0.0113583,0.510652,0.403162,-0.00606503,-0.1172,0.0841351,-0.0100638,-0.45939,-0.342534,-0.137202,-0.285657,0.0716319,0.41741,-0.189594,-0.0101592,-0.472998,-0.564345,-0.145899,-0.446323,-0.0237717,-0.0301097,0.585813,-0.15398,-0.226466,0.848118,-0.165394,-0.224019,0.794012,-0.129899,0.207191,0.124855,0.369044,-0.272308,0.468445,-0.0325707,0.287353,0.145863,0.556761,-0.652729,-0.0908979,-1.02652,0.203477,-0.367019,0.124462,-0.00879714,-0.273008,-0.255807,-0.040392,0.30243,0.317341,0.422242,0.174631,-0.420145,0.23268,0.315996,-0.371488,0.120818,0.23877,-0.0495073,0.167373,-0.333844,0.179755,0.11372,0.80264,-0.0711555,-0.00234119,-0.511103,0.579992,0.163831,-0.297137,-0.761129,0.128743,-0.390931,0.18621,0.367286,-0.425568,-0.16933,-0.0207884,-0.314058,-0.170973,0.195367,0.417031,0.327921,0.326207,-0.793355,-0.383679,0.191744,-0.0239969,0.488639,-0.580328,0.108487,0.405553,0.329374,0.636831,-2.48922 +3416.32,0.890642,0.0848144,4,1.44836,1.24042,0.100486,-0.197898,0.648308,-0.123925,0.301872,0.444315,0.55578,0.783836,-0.369363,-0.118196,0.213282,0.250711,0.2359,1.11804,0.191291,0.291122,-0.253818,0.185478,-0.451466,-1.02609,-0.0663419,-0.434917,0.334259,0.147698,0.0566246,1.37832,0.329229,0.326053,0.954899,-0.646284,0.001193,0.489548,0.000887583,-0.110745,-0.461612,0.416912,0.362386,-0.027354,1.09883,0.949352,0.266884,-0.707308,0.256156,-0.818986,-0.379484,-0.288092,0.638266,0.0104734,0.259498,-0.454314,0.681414,-0.774957,1.28806,-0.265984,-0.0951306,-0.530037,0.491023,0.0590272,-0.135617,0.806931,-0.695693,-1.72792,0.0066189,0.475561,-0.287182,0.549135,-0.00274943,0.181427,-0.0142307,0.267884,0.435904,0.0338985,0.123185,0.146104,0.419784,-0.0482401,0.0439913,0.276851,0.549366,-0.1517,0.277938,-0.0933889,0.13513,-0.12473,-0.194921,-0.639304,0.00501069,-0.48431,-0.0676818,-0.172361,-0.41161,0.357807,0.223342,0.139325,0.143641,-0.688319,0.196102,0.0160273,0.0118626,-0.431162,0.0388083,-0.0622481,0.0424589,-0.0256455,-0.0239219,-0.300794,-0.117342,0.407737,0.180276,-0.687133,0.203648,0.117402,0.245831,-0.389277,-0.187353,0.519423,-0.158034,0.240818,-0.50141,-0.63208,-0.0526835,0.425762,0.244009,-0.0700347,-0.0478844,-0.209138,0.560171,-0.133191,0.0932502,-0.367856,0.177775,0.276291,-0.333875,-0.546409,-0.166919,0.110033,-0.193074,-0.457181,-0.349308,0.0877549,-0.0168259,-0.0578939,0.554984,0.353861,-0.348532,0.340377,-0.37627,0.162226,0.15037,0.0120281,0.0326273,-0.210318,0.524905,-0.348764,0.20922,-0.246731,0.226639,-0.00821601,0.146777,-0.0937644,0.407248,0.321373,0.17343,0.217365,-0.0569906,0.154668,-0.158018,0.0615046,-0.170961,-0.243349,-0.203315,-0.0873993,0.0205897,0.339641,0.0525934,-0.0308579,0.326055,0.840773,0.403967,-0.87034,0.203753,-0.048114,0.229692,0.118675,0.213695,0.171553,0.010442,-0.419651,0.0112328,0.377185,-0.0741108,-0.251792,-0.0986474,0.351714,-0.269081,-0.15997,0.448846,0.176078,0.259867,-0.567549,0.0136753,-0.186921,-0.537656,-0.792071,-0.753569,0.579425,0.339336,-0.0457326,-0.00695459,-0.168856,0.502015,0.473689,0.125577,-0.0572217,-0.00605528,0.0932073,-0.511015,-0.295447,-0.244377,-0.110081,0.163542,0.422127,-0.331221,-0.0327567,-0.534492,-0.471766,-0.171433,-0.541116,0.136845,-0.153249,0.55166,-0.339002,-0.311062,0.780449,-0.277513,-0.261319,0.788954,-0.086221,0.16993,0.089814,0.348697,-0.223595,0.382476,-0.138505,0.304936,0.130057,0.476749,-0.668304,-0.0367697,-0.96896,0.166891,-0.296441,0.237773,0.0385595,-0.232436,-0.264937,-0.0489505,0.423311,0.142637,0.300137,0.0950176,-0.374659,0.210838,0.316276,-0.28849,0.104454,0.17334,0.0197848,0.185506,-0.380646,0.228417,0.0564349,0.867136,-0.0392833,0.00130071,-0.615858,0.637189,0.304926,-0.223202,-0.684928,0.0979222,-0.406999,0.0986307,0.234919,-0.257952,-0.184656,-0.082101,-0.283678,-0.183748,0.0422478,0.329208,0.364778,0.330027,-0.734076,-0.346278,0.151481,0.0492302,0.625124,-0.728743,0.102145,0.381414,0.319601,0.617588,-2.73102 +3433.34,0.559651,0.0848144,5,1.4539,1.14141,0.00340859,-0.151795,0.163576,-0.20807,0.400657,0.677105,0.615216,0.99563,-0.379969,-0.0706571,0.380173,0.454782,-0.191387,1.56549,0.399923,0.267624,-0.203677,-0.148397,-0.63434,-0.789525,-0.501747,-0.289267,0.00151664,0.128243,0.200498,0.861372,-0.019866,0.405311,0.861373,-0.779832,0.0902864,0.243658,-0.29929,0.119079,-0.333129,0.812345,0.257305,-0.160557,1.20261,0.958412,0.258404,-0.29203,0.502483,-0.3739,-0.426834,-0.0820661,0.683395,0.305062,0.200518,0.153877,0.64413,-0.541932,1.35966,-0.840335,0.0304671,-0.996171,0.0944208,-0.145989,-0.210028,0.914373,-0.404928,-1.50695,0.0521518,0.427079,-0.353979,-0.544178,-0.794242,-0.103616,-0.020932,0.202956,0.65328,0.177004,0.400816,-0.0310618,-0.209252,0.299524,-0.572043,0.261182,0.419686,-0.355628,0.453856,-0.619583,-0.328458,-0.214566,-0.259169,-0.0097306,0.0102042,-0.910033,-0.0157706,0.290992,-0.0241895,0.485043,0.117948,-0.228983,0.360812,0.122039,0.112425,0.124117,-0.0832445,-0.260716,0.230031,-0.471996,-0.0147085,0.00601601,0.0450792,-0.140941,-0.104842,0.693215,-0.222746,-0.424529,0.490826,-0.00829749,0.395717,-0.177703,-0.369255,0.315437,0.577419,-0.180889,-0.539994,0.322353,-0.311293,0.457023,0.328295,-0.0555809,0.534977,-0.931938,0.0983348,-0.179353,-0.00687501,-0.12849,0.0665792,0.401108,-0.283203,-0.78838,-0.104511,-0.112381,0.718723,-0.61971,-0.553414,0.141308,-0.31979,-0.327149,0.162976,-0.31618,-0.55485,-0.230002,-0.320889,-0.175045,0.114823,0.088413,0.203002,-0.456834,0.0713238,0.193663,0.394918,0.155738,0.193286,-0.444012,0.0555889,0.429447,0.328041,0.35638,-0.437376,0.164442,-0.0540021,0.0638176,-0.127374,-0.246303,-0.111493,-0.259812,-0.259732,0.385956,0.130235,0.13815,-0.366579,-0.00800165,0.0762029,0.919511,0.155962,0.0537023,-0.0762215,0.456511,0.245994,-0.0988173,0.0118598,-0.337549,-0.118047,-0.395896,0.0278522,-0.022024,-0.218956,-0.745599,-0.637686,0.39089,0.0608937,-0.0158647,-0.0942797,0.00674156,0.00238295,-0.222695,-0.0200734,0.407154,-0.37433,-0.315211,-0.447532,0.696097,-0.71231,-0.114658,-0.223036,0.0472542,0.497533,0.187899,-0.208983,0.186164,0.0906645,-0.13172,-0.172533,-0.253738,0.322666,-0.553665,0.257643,0.209516,0.0389927,0.350645,-0.570349,0.215395,0.210391,-0.156494,0.0539571,-0.215647,-0.00919786,-0.145667,0.168811,0.955258,0.0844918,0.0313289,0.178213,-0.374712,0.121775,0.21251,0.00822818,0.0574941,0.694599,0.322734,0.565621,0.185384,-0.1679,-0.318696,0.323956,-0.963584,0.023571,-0.15069,-0.533566,-0.050769,-0.0432614,0.176642,-0.0196647,0.337827,0.281285,0.397109,0.300029,0.194294,0.38463,-0.0418121,-0.192186,0.0170169,0.223353,0.0802932,-0.465024,-0.311267,-0.132238,-0.0387164,0.74,0.150264,0.0766274,0.195891,0.659256,0.0970747,0.0471846,-0.0700224,0.128737,0.51777,0.213782,0.455978,0.215574,-0.00668841,-0.321148,0.286543,-0.182189,0.529913,-0.167581,0.260911,0.289481,0.0818654,0.171447,0.494924,-0.62572,0.394422,0.158685,0.124401,0.342371,0.352706,0.585125,-0.912919 +3439.34,0.85722,0.0848144,5,1.43556,1.11893,0.0749291,-0.213548,0.0987438,-0.120221,0.18724,0.937864,0.0766825,1.0652,-0.0115662,-0.231149,-0.0428824,0.414427,-0.0321767,1.45578,0.423729,0.528923,-0.292694,-0.0904541,-0.855771,-0.891659,-0.379063,-0.0446558,0.02857,0.243195,0.127368,0.677727,-0.284187,0.134713,0.904221,-0.277915,-0.56893,0.0282822,0.111697,0.193338,-0.643252,0.726717,0.336879,-0.428716,1.15432,1.18063,0.254911,-0.722625,0.312976,-0.18428,-0.757711,-0.0679568,0.799724,0.0641848,0.324696,-0.323131,0.672902,-0.903748,1.46436,-0.436542,-0.00774572,-0.839692,0.599479,-0.403436,-0.182331,0.701782,-0.339434,-1.25074,0.0643624,0.220322,0.0568515,0.194616,-0.743135,-0.356543,-0.0677237,0.467774,0.726807,0.065769,0.0508804,-0.0765655,-0.0235346,0.375536,-0.24406,0.000263812,0.086353,-0.148661,0.326507,-0.451921,-0.186835,0.0129742,0.239776,0.232568,-0.0199337,-0.750166,-0.187121,-0.0545067,-0.131265,0.323691,0.0057354,-0.183259,0.383772,0.370888,0.336874,0.253481,-0.023466,0.0041508,0.0892165,-0.461788,-0.751295,-0.173178,0.455294,-0.151931,0.580995,0.451314,-0.534973,-0.17037,-0.328228,0.0816412,0.302816,0.18273,0.0281212,0.135063,0.479993,-0.128681,-0.532663,0.142691,-0.17853,-0.0710081,0.44456,-0.313366,0.321511,-0.357098,0.274848,-0.291873,-0.195329,-0.283191,-0.161377,0.332975,-0.264695,-0.436082,0.145762,-0.143442,0.61222,-0.454079,-0.43284,0.0455651,-0.21346,-0.677051,0.204659,0.37083,-0.344944,-0.0512572,-0.358155,0.0322546,-0.241957,0.204443,0.362276,-0.306858,-0.130285,0.0112784,0.212682,0.181819,0.143368,-0.515858,-0.0547624,0.198135,0.782349,-0.364137,-0.489479,0.21796,-0.0842626,-0.132845,-0.351161,0.039546,0.120456,-0.0335459,-0.300745,0.431799,-0.0971568,-0.201022,-0.389625,-0.396079,0.250707,1.01122,0.0182231,-0.113077,-0.325173,0.663652,-0.185345,-0.165834,-0.0979732,-0.532332,0.0841261,-0.433589,-0.124139,-0.0349602,-0.390595,-0.693655,-0.382502,0.349939,0.313011,0.00537122,-0.241785,0.226044,-0.00996684,0.0354399,-0.07044,0.420364,-0.080065,-0.515338,-0.146112,0.843215,-0.734595,-0.104881,-0.137912,-0.0659701,0.523356,-0.18422,-0.183657,0.386461,-0.213434,0.423523,-0.251612,-0.109278,-0.0415885,-0.301803,0.473161,0.188831,-0.118271,0.272014,-0.472247,0.268333,0.0655472,-0.00747668,-0.206467,-0.227584,-0.021327,-0.481819,-0.519842,0.72691,0.173563,-0.243539,0.295482,-0.371619,0.186955,0.534443,0.251176,-0.153323,0.435231,0.0836426,0.0673955,0.027934,-0.0162,-0.205737,0.290314,-0.824866,-0.0699738,-0.289803,-0.305869,0.179847,0.259082,0.00182494,-0.205239,-0.0427546,0.174514,0.253489,0.515767,0.136734,0.504086,0.145149,-0.250555,0.366564,0.460106,0.182712,-0.533415,-0.185172,-0.31311,0.00776167,0.395149,0.437876,-0.0945656,-0.0765574,0.708979,0.336192,-0.327111,-0.54932,0.0584934,-0.454774,0.225053,0.229757,0.160361,0.485529,-0.428412,-0.0324838,-0.0070679,0.587722,0.0116242,0.300858,-0.0121641,-0.124807,0.226368,0.524812,-0.239028,0.322611,-0.240314,0.111145,0.3861,0.333384,0.621369,-0.677253 +3477.01,0.997388,0.0848144,4,1.47856,1.01118,-0.205631,-0.0428118,0.0404253,-0.0663434,-0.237403,0.329595,0.94694,0.456411,-0.343753,0.0992695,0.11066,0.779728,-0.0447257,1.16688,0.540565,0.111954,-0.257611,-0.0937175,-0.444398,-0.827119,-1.40069,0.26573,-0.37278,0.156355,0.356748,0.28977,-0.294019,0.0133356,1.0831,-0.284563,-0.128989,0.0526758,-0.0676736,-0.0105355,-0.355182,0.67503,0.0777736,-0.377123,1.20663,0.534217,0.315607,-0.527543,-0.0482558,0.355146,0.172885,0.237268,0.561786,-0.0195298,0.402102,0.416397,0.594557,-0.520559,1.43628,-0.167744,0.266824,-0.964719,0.909747,-0.252969,0.101023,1.01012,-1.08105,-0.761036,0.487272,0.456156,0.0985117,0.00369918,-0.190459,-0.0496399,-0.252445,-0.148546,0.0142463,-0.27727,0.0965485,0.108025,-0.512205,0.246993,0.247969,0.210345,0.393108,-0.124817,4.73903e-05,-0.133658,0.0928525,-0.384142,0.309882,-0.572415,0.212914,-0.53759,-0.147583,-0.0197743,0.0887742,0.0916661,0.0937552,-0.23393,-0.0190168,-0.393786,0.0736415,0.276891,0.0446689,0.0221899,0.190823,-0.0134546,-0.11157,0.0983603,0.0135407,0.17176,0.188063,0.573443,0.0185009,-0.0902321,0.400017,0.101155,0.226939,0.124739,0.0295752,0.0327471,0.095183,-0.0945076,-0.0125887,0.12063,-0.0785854,-0.258474,0.0690834,0.294341,0.0792789,0.389737,0.368632,-0.393932,0.360074,-0.0209236,0.260714,0.184203,-0.30424,-0.312699,0.125938,-0.0373485,0.67426,-0.282602,-0.0459708,-0.0611359,-0.166267,-0.370084,-0.14549,0.176888,-0.304151,0.146079,-0.146738,0.0131542,0.335963,0.315075,-0.049564,-0.282961,0.439549,0.339158,0.0618197,-0.216019,0.000563997,-0.0671815,-0.140212,-0.252434,0.527809,0.402604,-0.0758077,0.0377302,0.195556,-0.0295104,0.00119024,0.0894588,-0.142486,-0.200818,-0.317256,-0.143621,-0.294597,-0.00236976,-0.403938,0.303476,0.0946295,0.411844,0.403268,-0.0951661,0.425143,-0.0676213,-0.534966,-0.227218,-0.67028,-0.118428,0.279759,-0.246894,-0.0117477,0.803964,0.253116,-0.388863,0.0236387,0.40217,0.237729,0.115053,0.0239242,0.186678,-0.0963965,0.0598813,0.0528152,-0.455309,-0.136709,0.00208824,-0.182215,0.500759,0.498375,0.00305562,0.096227,-0.228997,0.365136,-0.1068,-0.340927,-0.324014,-0.00345321,-0.141101,-0.0123586,-0.201648,-0.0893986,-0.419083,-0.339178,-0.179692,0.0255394,0.599723,0.0758079,-0.0349317,-0.287721,-0.418299,-0.264551,-0.314389,-0.130314,0.475734,-0.00187982,0.0810854,0.228795,0.514864,0.799284,0.0261881,-0.414837,-0.149813,0.142078,-0.18229,0.237498,-0.137848,0.236123,0.0296305,-0.135897,-0.3337,-0.0954536,-0.127372,0.0183849,0.0429088,0.176232,0.25165,-0.140902,0.0490788,0.518189,0.0573944,-0.0440833,0.189444,0.143572,0.211962,0.302683,0.250432,-0.156613,-0.147217,0.161344,0.26976,-0.28917,-0.0646569,-0.128353,-0.402087,0.0810255,0.087784,0.11364,-0.0828888,0.15465,0.226359,-0.276377,0.104558,-0.42338,0.177695,-0.0537494,0.335929,0.0316255,0.179962,-0.202367,-0.389696,-0.535368,0.765296,-0.237755,0.31295,-0.362679,-0.180901,0.241408,-0.0793196,0.253292,-0.0102187,-0.213372,0.0745862,0.419319,0.273105,0.647548,-0.278134 +3478.46,0.907702,0.0848144,4,1.52011,0.978465,-0.522619,0.161178,0.285641,-0.274245,0.0826176,0.16477,0.565132,0.410877,0.124253,-0.0226196,0.22502,0.420084,-0.248123,0.732356,0.143312,0.28512,-0.0394357,0.161608,-0.425519,-0.942943,-0.548451,0.301586,-0.2165,0.0676848,0.50385,0.446892,-0.101862,0.18134,1.12076,0.376327,0.204847,0.0665341,-0.29604,0.0121919,-0.510354,0.595322,0.598339,-0.378842,1.02503,0.686395,0.217174,-0.577957,0.10781,-0.185428,-0.748485,-0.28084,0.458417,-0.267657,0.0470203,0.0765827,0.18108,-0.741111,0.902461,0.00720308,-0.312541,-1.02216,0.445048,0.14552,0.39966,1.01634,-0.81599,-1.09527,-0.464349,0.146797,-0.36683,0.111175,0.11486,-0.456363,-0.249451,0.441594,0.782146,0.321404,0.719474,0.408297,0.684257,-0.13285,-0.719147,0.218641,0.281456,0.166036,0.150481,0.124016,-0.167434,0.258406,-0.230531,-0.214118,0.0887392,-0.558373,-0.204109,-0.054308,0.117484,-0.16155,0.117097,0.110168,0.342499,0.0626669,-0.109718,0.311669,0.276552,0.154789,-0.297462,-0.220485,0.128222,0.0201888,0.221976,-0.301879,0.411416,0.470191,0.435412,-0.222315,-0.0281576,0.017562,0.184854,0.0994909,-0.0430096,0.0701319,-0.0653147,0.403864,-0.49101,-0.169321,-0.241124,-0.0536907,0.0305646,-0.133838,0.0299747,0.135348,0.116033,-0.190362,-0.232865,-0.417948,0.431176,0.619081,-0.126058,-0.365407,-0.298239,-0.183368,0.171962,-0.0718261,-0.572661,-0.0579634,0.468588,-0.604402,0.156708,-0.151594,0.00728553,0.418478,-0.520425,-0.111806,-0.336458,0.0807401,0.210559,0.245741,-0.0903077,-0.178887,0.107377,0.123883,0.0446888,0.163681,0.0992409,-0.0588845,0.397584,-0.11185,-0.291426,0.477715,-0.077115,0.0508164,-0.164932,-0.25542,0.299712,0.247318,-0.350194,0.223412,0.111036,0.296213,0.0284059,-0.61303,-0.0942254,0.4462,0.115731,-0.145745,-0.292209,-0.0736673,0.495711,-0.106629,-0.00983344,-0.0486403,0.0289452,-0.232119,-0.0679129,-0.652051,-0.0935733,-0.459234,-0.126115,0.322358,0.070983,-0.182633,-0.668198,0.0543592,-0.0849463,0.142077,-0.274025,0.225703,-0.0377942,-0.270528,-0.451806,0.645137,-0.639248,0.152034,0.0561461,0.138227,0.0483871,0.211509,-0.270371,0.540735,-0.337085,0.154063,0.515817,0.262877,0.121103,-0.117059,-0.0963101,0.13837,0.000429864,0.134344,-0.295824,0.152782,0.126181,0.0367992,0.103055,-0.182445,-0.221312,-0.53133,0.185149,0.661576,-0.0907708,-0.396726,0.0499167,-0.0083324,0.0736339,0.484054,-0.0776478,0.239153,-0.0484668,0.261581,0.360065,0.0668523,-0.0349065,-0.0357057,0.0174392,-0.245691,0.588784,-0.533275,0.137175,0.492519,0.11929,0.0966359,-0.17173,0.0498526,0.326428,0.149312,-0.623289,0.0448022,0.573557,-0.0694466,-0.215185,0.0227945,0.247748,0.161536,0.0274411,0.0580018,-0.555578,0.26896,0.0239631,0.425484,-0.0924366,-0.137446,-0.00508158,0.0361006,0.0620273,-0.230823,-0.0423523,-0.0620199,0.407619,0.466573,-0.161568,0.00871852,0.0934473,0.49398,0.0581363,-0.514932,0.161962,0.306926,0.144182,-0.0300797,-0.197499,-0.0479919,-0.294019,-0.0202656,0.0787053,0.0913536,0.216342,0.302248,0.465126,-0.967735 +3448.07,0.854804,0.0848144,4,1.47568,0.896907,-0.522943,0.190977,0.406153,-0.226924,-0.461257,0.141375,0.70706,0.233681,0.202025,0.251444,-0.153602,0.530617,-0.176577,0.710978,0.197341,0.340609,0.0663804,0.291705,-0.24676,-0.995317,-0.702631,0.375779,-0.269915,0.488141,-0.0224077,0.169286,-0.118214,0.219508,0.991018,-0.368747,0.633045,0.35897,-0.124298,0.0361411,-0.635141,0.720568,0.551264,-0.506063,0.881324,0.720722,-0.0166942,-0.522964,-0.0179846,-0.230937,-0.225129,0.61714,0.623235,-0.152435,-0.219623,-0.0536901,0.135808,-0.654101,1.05141,-0.472959,-0.27384,-0.747069,0.0381015,-0.0320053,0.729856,1.27194,-0.883777,-1.01206,-0.391198,0.0289209,-0.37048,-0.0312912,0.0162788,-0.519836,-0.389303,0.396026,0.54263,0.478337,0.317851,0.561543,0.253575,-0.0734863,-0.523351,-0.0907789,0.641233,-0.247239,0.00134789,0.112559,-0.224381,0.380137,0.065816,0.271847,0.0858206,-0.510449,0.28394,-0.205057,-0.0814298,0.0360852,0.0641522,0.0439971,0.49365,-0.0412333,-0.0203009,0.0655749,0.265589,0.377362,-0.293241,-0.559453,-0.0858422,-0.290011,0.0349057,-0.161032,0.414336,0.54505,0.0477509,-0.32039,0.4589,0.235049,0.0265482,-0.0965563,0.210201,0.246096,-0.174669,0.0838586,-0.261676,-0.149338,-0.0642844,-0.159186,-0.0041888,0.432742,-0.143624,0.308978,0.0311976,-0.236998,-0.152824,0.0177414,0.464564,0.693757,-0.177331,-0.511037,-0.231678,-0.344592,0.489189,-0.116702,-0.114615,-0.21678,0.263908,-0.781699,0.582026,-0.0773193,-0.132427,0.613747,-0.464013,-0.447722,-0.586609,0.270887,0.32917,-0.386975,0.208035,-0.408802,-0.16353,0.196452,0.133096,0.140124,0.358069,-0.212214,0.410555,0.140181,-0.355731,0.15455,-0.287522,0.193368,0.0431075,0.225618,0.203591,0.271932,-0.185466,0.538838,0.598756,-0.0214574,0.193227,-0.118694,-0.284312,0.465586,-0.0103788,0.112681,0.0197145,0.0158047,0.62442,-0.263836,-0.262219,-0.475572,-0.20991,-0.119565,0.0263258,-0.301399,-0.327927,-0.293771,0.132277,0.0832895,-0.0826851,-0.418371,-0.396127,0.252606,0.0642263,0.109751,-0.433183,0.0749423,0.107735,-0.0294705,-0.427002,0.758999,-0.278246,0.244411,-0.102121,-0.0644967,0.114148,0.32727,0.091224,0.346386,-0.0820134,0.0177915,0.0987909,-0.0958638,0.36115,-0.038964,0.330577,0.172308,-0.372473,0.194985,-0.278263,-0.00217276,-0.404997,-0.0688037,-0.740266,-0.242335,-0.40746,-0.556296,0.0227098,0.666106,-0.20047,-0.497817,0.0262406,-0.0568951,0.0336372,0.552715,0.31751,0.43196,0.0992203,0.522492,0.464451,-0.0998919,-0.00359344,-0.114967,0.183875,0.223519,0.0982965,-0.505228,0.0595757,0.0545426,0.260919,0.134021,-0.193991,-0.243547,0.506952,-0.0698291,-0.505057,-0.590555,0.300672,0.229999,0.0555942,-0.33643,0.232892,0.371401,-0.0171556,-0.335277,-0.817815,0.410632,-0.0657681,0.482694,0.175603,-0.172047,0.125051,0.21431,0.207245,0.208588,-0.0891519,0.359435,0.384728,0.386167,-0.0359292,0.334404,0.158217,0.201235,-0.0587372,-0.200127,-0.344961,-0.293003,0.206668,-0.204387,0.000487213,0.158644,-0.00709029,-0.314028,-0.378369,0.0961825,0.258123,0.310133,0.508058,-1.30797 +3458.26,0.982787,0.0848144,4,1.49096,0.887115,-0.99247,0.407918,0.543223,-0.0474285,0.0437268,0.13072,0.512705,0.0702777,0.318016,0.0850378,0.24678,0.265186,-0.0132299,0.993842,0.330372,0.269355,0.300748,0.347832,-0.1054,-0.919945,-0.498552,0.55761,-0.144296,0.190895,0.183551,0.357222,-0.282643,0.146045,0.978638,-0.110355,0.300026,0.181803,-0.281322,-0.14445,-0.401018,0.241487,0.724141,-0.264577,0.977194,0.321665,0.12673,-0.774759,-0.00316068,0.0191873,-0.0824147,0.130395,0.177749,0.00457846,-0.0475335,0.0351244,0.541197,-0.553245,0.773026,-0.184201,-0.304267,-1.1109,0.532535,0.398009,0.282017,0.945294,-1.21664,-1.06795,-0.661106,0.349813,0.057179,0.236047,-0.197607,-0.134235,-0.525547,0.328845,0.672091,0.163356,0.688313,-0.0147963,0.352634,-0.091079,-0.162925,0.0415057,0.850178,-0.800197,-0.197203,0.21895,-0.00372335,-0.322404,-0.3152,-0.215266,0.28535,-0.0773307,0.0555741,0.246752,0.0859417,-0.0655284,0.257176,-0.220239,-0.241039,0.154615,-0.060355,0.456058,-0.0385967,0.0645542,-0.202782,-0.426495,-0.444326,-0.171236,-0.239893,-0.420058,0.123297,0.602695,-0.191942,-0.57703,0.302538,0.135537,0.124611,0.257741,0.0336616,0.205544,-0.144437,0.380098,-0.976575,-0.236343,0.0208511,-0.294221,-0.190938,-0.341925,0.305908,0.565587,0.0303251,-0.0961966,-0.0150392,0.406391,-0.0816629,0.563769,0.0451069,-0.305203,-0.143001,-0.418732,0.645203,-0.734637,-0.427534,0.0543065,-0.470462,-0.315995,0.323509,0.253203,0.15051,0.391905,-0.189918,-0.256088,-0.303593,0.224461,-0.0545185,0.209617,0.0660915,0.369776,0.0328705,0.214916,-0.0261014,0.216466,0.533414,0.21911,0.415673,-0.136579,-0.222252,-0.487591,0.115692,-0.119171,0.231257,-0.218797,-0.0218571,-0.0756262,-0.266918,0.556502,-0.0166054,0.490435,-0.301121,-0.522298,-0.485744,0.433968,0.0555168,0.0833404,-0.244987,-0.0115155,0.693715,-0.077043,0.0905548,-0.281625,-0.152756,0.108103,-0.156553,0.190024,-0.257835,-0.266133,-0.21794,0.340201,-0.162934,-0.204906,0.00549708,0.378705,-0.333228,0.268142,0.225105,0.435028,-0.125127,0.171345,-0.386739,0.799272,0.371094,0.0765992,0.507378,0.0605908,0.305327,0.371204,-0.296396,0.274351,0.0939298,0.217881,-0.0244207,-0.0580875,-0.416448,0.0750285,0.182493,0.219112,-0.383786,0.420074,-0.376104,-0.122592,0.590476,-0.335056,0.104537,-0.120398,-0.0902191,0.191361,0.0311568,0.48783,-0.530673,-0.0210979,0.268856,0.248713,-0.202978,0.888155,0.173191,0.298591,0.0172273,0.0465502,0.359284,-0.311072,0.140385,-0.268259,-0.416761,-0.220978,0.470429,-0.236142,0.259314,0.153778,-0.330092,0.211636,0.313124,-0.216148,0.397134,0.00310844,-0.0701565,0.110592,-0.110195,0.167862,-0.0771967,0.206173,-0.388171,-0.284476,-0.176617,-0.256207,-0.0300991,0.0969378,-0.362381,0.100681,0.224526,0.0364986,0.478232,0.0517128,0.0307004,-0.0322909,-0.221095,-0.0928235,0.0874651,0.146151,0.285118,0.185162,-0.0655309,-0.306483,-0.199059,0.528878,0.177632,0.127246,-0.132284,-0.806266,0.168943,-0.160098,0.0753824,-0.203848,-0.0203393,0.0959983,0.248097,0.309836,0.498094,-1.73434 +3454.64,0.75317,0.0848144,4,1.51551,0.831005,-0.908808,0.337829,0.694425,-0.173985,0.209911,0.156311,0.397556,-0.216285,0.164121,-0.00222489,-0.187394,0.259318,-0.0329509,0.725503,0.174172,-0.0678854,0.0850778,0.321175,-0.164567,-0.910584,-0.196601,0.55435,-0.26151,0.104387,0.234559,0.531292,-0.0962984,0.254577,1.01417,-0.223772,0.283713,0.322223,-0.192675,0.0317521,-0.515759,0.481642,0.582367,-0.100284,1.12534,0.562574,0.151225,-0.527969,-0.0456415,0.462201,-0.0961223,-0.276639,0.270622,0.382788,-0.17827,0.161573,0.581511,-0.859668,1.0038,-0.501406,-0.212564,-1.12875,0.366383,0.0579264,0.260248,0.979247,-1.17156,-1.16352,-0.651225,0.476077,0.135482,0.15201,0.0216874,-0.251631,-0.588042,0.394025,0.888113,-0.321225,0.709863,0.297523,0.26015,-0.24891,-0.403983,0.092158,0.80661,-0.714664,-0.201984,0.223718,-0.164993,-0.457986,-0.245278,-0.0080004,0.336305,-0.362012,0.0254948,0.215607,0.125419,-0.108988,0.013667,-0.139217,-0.437843,0.0967019,-0.245673,0.43407,-0.117666,-0.206967,-0.284014,-0.789412,-0.12616,-0.365343,-0.221711,-0.0256114,0.183709,0.411942,-0.0876733,-0.333809,0.01008,0.224637,-0.0486515,0.0255747,-0.189559,0.0229425,-0.090856,0.219919,-0.731048,-0.036887,0.356523,-0.372041,-0.238146,-0.419301,0.427351,0.497411,0.0640891,-0.327293,0.484435,0.151793,-0.0764748,0.400814,0.0884723,-0.379259,-0.134489,-0.73292,0.368459,-0.549625,-0.521932,0.105895,0.0478967,-0.157595,0.0516313,0.066948,0.196727,0.35717,-0.212779,-0.288043,-0.260814,0.309727,-0.0288071,0.243938,0.434024,0.254689,0.109335,0.0988116,-0.0862869,0.364245,0.456054,0.258493,0.598656,-0.206026,-0.329963,-0.5276,0.131665,-0.127636,0.430909,-0.114549,-0.0807837,-0.533441,-0.482665,0.324658,-0.0362564,0.608022,-0.168602,-0.513724,-0.331225,0.354013,0.187601,0.0795224,-0.190128,0.0695957,0.368844,0.170816,-0.182698,-0.350998,-0.125463,0.0340934,-0.351917,0.145171,-0.325537,-0.166406,-0.262498,0.18859,-0.0925472,-0.138214,0.214538,0.11264,-0.208381,0.0446665,0.574794,0.616877,-0.0396575,0.128479,-0.374592,0.767581,0.0222535,-0.112516,0.325994,-0.0698242,0.0724625,0.423262,-0.199084,0.231553,-0.175817,0.0534946,0.335258,-0.0519869,-0.262857,-0.281698,0.150749,-0.215182,-0.237019,0.224747,-0.382691,-0.193123,0.423631,-0.166217,0.222985,-0.0656775,-0.0304987,-0.0152773,0.0470776,0.61612,-0.599768,-0.046113,0.376401,-0.508685,-0.405247,0.639136,0.284231,0.418535,0.295483,0.104503,0.370172,-0.406903,0.0703271,-0.217275,-0.187069,-0.290094,0.753182,-0.0512948,-0.126465,0.401365,-0.111089,0.0437424,0.26365,-0.0713328,0.450083,-0.0576242,-0.213868,0.174762,-0.171527,-0.0512078,-0.152288,-0.331954,-0.0820921,0.126103,-0.0781072,-0.400567,-0.174558,0.372341,-0.00423779,0.346097,0.197541,-0.0998892,0.295843,0.223432,-0.177708,-0.298231,-0.37265,0.0981922,0.0667687,0.0643017,0.449283,0.322676,-0.0180026,-0.357732,-0.206316,0.707867,0.0583053,0.31023,0.118327,-1.00839,0.258356,0.0493532,-0.0238193,0.276745,-0.134305,0.106913,0.211379,0.326975,0.45976,-2.0584 +3428.57,0.693971,0.0848144,5,1.67463,0.867389,-1.32682,0.568071,0.908542,-0.0792292,-0.395597,-0.0992013,0.349794,0.164374,-0.0883311,-0.269567,0.155192,0.327474,-0.212968,0.59221,-0.335442,-0.0333848,0.330933,0.15607,-0.110136,-1.11618,-0.917921,0.0141009,-0.454414,-0.00238031,-0.161445,0.240887,-0.978621,0.372154,0.648188,-0.652441,0.242698,-0.274158,-0.100567,-0.207182,-0.108505,0.552792,0.0225541,-0.687021,1.03775,0.79508,0.545577,-1.08282,-0.127581,-0.149983,-0.803263,0.485975,0.159556,-0.254297,-0.120563,0.466665,-0.0342681,-0.0961238,0.461407,-0.161069,0.0391689,-0.905534,0.43753,-0.630251,-0.00420727,0.773695,-0.578324,-1.13449,0.720542,-0.0393066,-0.0967582,-0.026289,0.436237,-0.556464,0.311186,0.133199,-0.000771338,0.237438,0.553275,0.907501,0.406722,-0.0627934,-0.362404,-0.242698,0.372011,0.215549,0.186123,-0.140108,-0.582632,-0.0302025,0.134528,0.275833,-0.500561,-0.340389,-0.0519669,-0.246944,0.360644,-0.221763,-0.0345332,-0.207692,0.289067,-0.189371,0.564445,-0.168809,-0.0371043,0.00565095,-0.17846,0.25461,0.150903,-0.401288,0.404612,-0.474153,0.318429,0.61643,0.145789,-0.184083,0.0982291,0.267146,-0.0934861,-0.16224,-0.105699,-0.0343581,0.164634,-0.357575,-0.593492,0.328609,-0.394485,-0.017319,0.418803,0.748842,-0.0861646,-0.243143,0.186439,-0.237105,-0.70648,-0.417442,-0.0505302,0.670673,0.102624,0.36209,-0.0142303,0.0768082,0.104729,0.172046,0.0964831,-0.291816,0.178558,-0.715372,-0.0209849,0.0640355,0.0565668,-0.0538042,-0.100374,0.235179,-0.292664,0.420501,0.272211,-0.272739,-0.0261619,0.459306,0.357913,-0.117006,0.0386853,-0.812832,-0.179255,-0.119579,0.577168,0.142289,0.215968,0.278735,-0.366538,-0.147179,-0.660566,0.0432206,0.0351112,0.41792,-0.0291637,-0.257989,-0.369408,-0.411149,-0.423839,0.0779362,0.586765,0.7952,0.29362,-0.385851,0.522171,0.143678,-0.541868,-0.897981,0.183349,-0.156943,0.614172,-0.67853,0.122312,-0.078067,0.596266,-0.524904,0.375502,-0.0586819,-0.0935357,-0.476586,-0.504236,-0.615452,-0.00387412,-0.0470059,-0.718641,-0.492262,0.0890149,0.125782,-0.684431,0.93114,-0.331393,0.23318,0.15308,-0.117717,0.0268692,-0.209211,0.019323,0.446301,-0.138496,-0.034745,-0.466003,-0.472197,0.515026,-0.592814,-0.118848,0.404239,-0.644403,0.356371,-0.252515,-0.148652,-0.0243694,0.00181538,-0.307425,-0.0557583,-0.212221,-0.575509,-0.348282,0.0786807,0.268566,0.057733,0.459017,-0.115753,0.0156742,-0.984828,-0.0705644,-0.136741,0.110387,0.369161,0.378284,0.810804,-0.0858996,-0.360921,0.122092,-0.382011,0.369133,-0.0937397,-0.288254,-0.226271,-0.417231,0.290817,-0.393746,0.173377,-0.274487,0.257869,0.452789,0.0949173,0.541093,0.126057,0.184034,0.170922,-0.0943164,0.553925,0.0185289,-0.0439675,-0.32873,-0.428427,-0.178314,-0.366082,-0.138834,0.0138273,0.0418819,0.149568,0.0357912,0.0421792,0.0323626,-0.184141,0.0388794,0.183345,-0.71937,0.0426349,0.109851,-0.265297,0.00296528,-0.246149,-0.18364,0.340305,-0.291537,0.241056,-0.125872,-0.155731,0.161072,-0.260622,0.134884,0.132518,0.299176,0.364031,0.54697,-2.69683 +3427.77,0.85345,0.0848144,4,1.67612,0.907274,-1.34816,0.564672,0.56895,-0.0663008,-0.0329004,-0.146991,0.107288,-0.147023,0.301239,-0.337035,-0.102629,0.192708,-0.218861,0.423687,-0.342224,-0.339098,0.104823,-0.339491,-0.125565,-0.735497,-0.882834,0.213135,-0.406575,0.0039002,-0.281982,0.262122,-0.952907,0.34945,0.457315,-0.635399,-0.217546,-0.064049,-0.254083,-0.279529,-0.207791,0.461859,0.227214,-0.432763,1.06555,0.545907,0.297808,-1.04634,-0.0443132,0.0897656,-1.03679,0.272274,0.0873776,-0.0212454,0.0570869,0.674938,-0.0779996,0.084805,0.201242,-0.25593,-0.134202,-0.899646,0.501369,-0.596885,-0.00997759,0.526316,-0.663,-1.00038,0.405988,0.321512,-0.0582069,-0.159877,0.268603,-0.436444,0.0821287,-0.0129012,0.359935,0.0972253,0.51882,0.795609,0.268127,-0.0820357,-0.218469,0.148516,0.14772,-0.0555032,0.270756,-0.166297,-0.477378,-0.369735,-0.137564,0.184132,-0.60949,-0.387109,-0.0914929,-0.764823,0.119818,-0.411378,-0.0559205,-0.380616,-0.231473,0.331838,0.172291,0.00612174,-0.258821,-0.269478,-0.468128,-0.0335211,-0.18899,-0.199127,0.265794,-0.682187,0.298585,0.527293,0.270509,0.1186,0.49274,0.290767,0.0568533,-0.164898,-0.134015,-0.141251,0.117014,-0.499469,-0.639531,0.26596,-0.707508,-0.122932,0.190089,0.412027,-0.0195725,-0.434944,-0.203961,-0.623016,-0.0967315,-0.146986,-0.255127,0.513656,0.141205,0.457575,0.0196481,-0.142505,0.0658335,-0.282004,-0.202136,-0.0511273,0.102412,-0.391561,0.089511,0.3833,-0.19747,-0.0613538,0.121292,-0.0217778,-0.677579,0.237291,-0.114729,-0.420009,0.020121,0.618544,0.537428,-0.122882,-0.00511644,-0.651257,-0.155121,0.0259287,0.616362,0.149535,-0.16143,0.377641,-0.187813,-0.359906,-0.778735,0.0746952,0.120279,0.0389554,-0.0682585,-0.337337,-0.333455,-0.457119,-0.38504,0.0479933,0.90714,0.909906,0.375165,-0.398432,0.643932,0.0619822,-0.133053,-1.13668,-0.0644892,-0.313376,0.483862,-0.996282,-0.00448148,0.129956,0.424821,-0.494751,0.367751,-0.0485187,0.310631,-0.317249,-0.0259396,-0.39317,-0.179786,0.168083,-0.0338288,-0.578203,-0.0864453,-0.0689337,-0.796058,0.974792,-0.3675,0.505427,0.219694,-0.385288,0.0757319,-0.120105,0.194333,0.423967,-0.258986,0.025932,-0.252786,-0.362031,0.279881,-0.43767,0.245412,0.153923,-0.55817,0.265084,-0.169697,-0.240016,0.226302,0.0769497,-0.522069,0.0549129,0.23369,-0.820364,-0.398155,0.184801,0.396133,0.0202207,0.536861,-0.123726,-0.132154,-0.694348,-0.448908,-0.22068,-0.0420987,0.280837,0.272355,0.718662,0.179049,-0.501942,-0.0558752,-0.519489,0.472803,0.177851,-0.277288,0.199703,-0.573515,0.316334,0.0342765,0.0730716,-0.0375279,0.172352,0.410448,0.127684,0.496898,-0.355767,-0.125271,0.103153,0.424262,0.427956,-0.181433,0.308278,-0.321696,0.10003,0.119611,-0.415449,-0.397055,-0.118411,0.0428554,-0.253709,0.0428896,-0.0392576,0.208314,-0.160853,-0.0209341,0.214395,-0.729201,-0.210347,0.334136,0.036217,-0.0181686,-0.544612,0.158736,0.491877,-0.390096,0.378707,-0.0762115,-0.083881,0.502194,-0.127873,0.585683,0.102964,0.396172,0.32088,0.629422,-1.62728 +3423.61,0.941917,0.0848144,4,1.64351,0.68938,-1.53043,0.626487,0.826861,-0.172179,-0.10892,0.0810504,0.233918,-0.614665,-0.0579359,-0.53021,-0.12029,0.367836,-0.248602,0.960519,-0.118523,-0.32705,-0.00695294,-0.187077,-0.0666342,-0.818337,-0.45733,-0.00358743,-0.365627,-0.23288,-0.664425,0.0747453,-0.62677,0.341689,0.758797,-1.06223,-0.370154,-0.0118589,-0.0599849,-0.368101,-0.31429,0.0944207,0.117304,-0.091364,0.893247,1.05921,0.123346,-1.19474,-0.186081,0.00364089,-0.709164,0.0721219,0.352069,0.142348,0.191928,0.854625,-0.401766,-0.161545,0.658006,-0.422331,-0.0304482,-0.879935,0.667551,-0.880012,0.259417,1.01964,-0.620599,-1.33385,0.107821,0.14317,-0.0752031,-0.0779926,-0.338878,0.0930598,-0.174361,0.0182586,0.341233,0.2536,0.226425,0.376671,0.271126,0.332244,0.164112,-0.0135601,0.545417,-0.285051,0.197434,0.241489,-0.217018,-0.04707,0.0662484,-0.150938,0.281485,-0.256512,-0.141531,-0.254909,-0.19413,-0.254384,0.119638,0.0629147,-0.29348,0.0553833,0.316886,0.0720319,-0.234523,-0.219195,-0.529747,-0.171739,0.0539785,0.586691,0.0499829,-0.116183,0.00571411,0.126562,-0.114894,-0.0424182,0.246843,0.330511,-0.0164539,-0.221545,-0.292022,-0.122079,0.441155,-0.452945,-0.708909,-0.337589,-0.57742,0.0396218,-0.449223,0.32646,-0.343154,-0.115938,0.0319613,-0.662306,-0.161531,-0.281894,-0.00917257,0.388815,0.146057,0.178843,-0.252137,-0.0360825,0.420885,-0.394358,0.216042,-0.0261512,-0.0865194,0.150794,0.0148135,0.414614,-0.0846949,0.477067,-0.279802,-0.264942,-0.0451686,0.595923,-0.128053,0.577697,0.301673,0.729918,0.58155,0.421404,0.174726,-0.516029,0.14403,0.313528,0.93455,-0.0645152,-0.357409,0.404584,-0.313484,-0.149597,-0.225816,-0.572762,0.246735,-0.119361,-0.0894311,-0.971699,-0.0919843,-0.715593,-0.593202,0.0212363,0.456559,0.746026,0.0523423,-0.0757305,0.105497,-0.211924,0.2854,-0.671578,-0.220563,-0.15897,0.63464,-0.504453,0.0676535,0.00330635,-0.0955565,-0.178771,0.399625,-0.130586,-0.183855,-0.191935,-0.262666,-0.213607,0.110721,0.0195328,-0.239,0.409138,0.400171,-0.294337,-0.488899,0.985001,0.327465,-0.226945,0.0190539,-0.0180106,0.547582,-0.0735537,0.0919902,0.419709,-0.684385,-0.0642717,-0.39901,-0.380216,0.485446,-0.557359,-0.19154,0.433989,-0.227756,0.365452,-0.309813,-0.188761,0.417392,0.484923,-0.391744,-0.14223,-0.124681,0.00145171,-0.497461,0.0763367,0.362813,0.0394889,0.825353,0.383595,0.384159,-0.43465,-0.512012,-0.22596,0.365931,0.56421,0.418349,-0.0774561,0.11648,-0.415477,-0.141568,-0.447799,0.592976,0.24732,-0.0361076,0.293299,-0.849482,-0.0889366,0.0311284,0.227834,0.31436,0.333068,0.361151,0.226902,0.142319,0.125634,0.162472,-0.30171,-0.401784,0.0912365,-0.205896,-0.00109828,-0.706696,0.0485919,-0.108666,-0.412582,-0.142126,-0.28958,0.205144,-0.00118076,-0.150285,-0.78165,0.509746,0.0878736,0.256494,0.256801,-0.756573,0.524603,0.152257,0.289541,0.0378748,0.139824,0.24937,0.697636,-0.375339,-0.452695,-0.564479,0.0683731,-0.132089,-0.438728,0.35682,0.157118,0.245725,0.396382,0.495707,-2.06726 +3396.82,0.993746,0.0848144,4,1.65293,0.782555,-1.32103,0.516416,0.53366,-0.0308651,0.0109892,-0.258349,0.261742,-0.338581,-0.0934473,-0.826076,0.021775,0.599828,-0.399015,0.634648,0.00832459,-0.346956,-0.424477,-0.240504,0.00353834,-0.477099,-0.693473,0.114447,0.0354285,-0.460027,-0.334461,-0.238219,-0.069888,-0.187979,0.730493,-0.694904,-0.288135,0.0861049,-0.525265,-0.291255,-0.308946,0.349211,0.476934,-0.159739,0.896628,0.539351,0.0752034,-0.441113,0.129872,0.2799,-0.398774,-0.109703,0.319747,-0.146878,0.0750415,0.551022,0.103871,-0.70239,0.528811,-0.229519,-0.0880867,-0.536837,0.654694,-0.112962,0.270839,0.475972,-0.374029,-1.13067,-0.224688,-0.676818,0.138457,-0.0464869,-0.0869711,0.021447,0.616968,-0.0656362,0.473668,0.137617,-0.333128,0.315987,0.110317,0.423226,-0.0493587,0.0147882,0.181088,-0.245381,0.510983,-0.324418,-0.119664,-0.337451,0.114134,0.284458,0.194852,-0.252153,-0.305934,0.314025,0.343912,-0.0186895,0.435433,0.185662,-0.511415,-0.288556,0.0519606,0.606471,-0.212731,0.630507,-0.649173,-1.05629,-0.0992835,0.749834,0.557292,-0.609913,0.379879,0.12419,-0.519326,-0.398912,0.679403,0.417732,0.622259,-0.0820343,-0.504023,-0.294663,0.32466,-0.159202,-0.58034,-0.189685,-0.352146,-0.189014,0.0165274,0.575324,0.392355,-0.323427,0.233151,-0.847828,-0.384789,-0.232839,0.288193,0.808639,0.0117662,0.0798183,0.339215,-0.0643884,0.0123833,-0.797925,0.0946622,0.280497,-0.512799,-0.483008,0.0403488,0.180146,-0.405126,0.0858839,-0.35205,-0.792695,0.2789,0.410352,0.407729,-0.51409,0.0275099,0.832085,0.553646,0.50816,0.172566,-0.0773624,-0.178002,-0.191462,0.898542,-0.114552,0.243501,0.77827,0.156108,0.153094,-0.0881468,-0.531646,0.234611,-0.337747,-0.109904,-0.744549,0.0677084,-0.98207,-0.567311,-0.755825,0.457416,0.940636,0.32242,-0.237528,0.197796,-0.268144,0.138606,-0.478774,-0.406327,-0.0360085,0.556267,-0.620216,-0.292592,-0.143438,0.0100726,-0.0934521,0.685808,-0.188803,-0.126004,-0.13154,-0.703751,0.288161,0.232981,0.0691094,-0.0209783,-0.191265,-0.124271,-0.156199,-0.456145,0.847671,0.744634,-0.149045,0.436098,0.300751,0.487379,0.0156648,0.484745,0.325568,-1.02126,-0.00380955,0.573862,-0.517861,0.0775818,-0.73597,-0.402923,0.431233,-0.736582,0.16648,-0.145196,-0.258669,0.457757,0.374154,0.0480193,0.0480385,0.322592,-0.339779,-0.512678,0.117217,0.0476591,-0.145617,0.680156,-0.669245,0.881359,-0.262209,-0.526537,-0.349839,-0.367159,0.528749,0.485048,-0.0600164,0.124157,-0.745914,0.340139,-0.951831,0.534137,0.0700611,-0.144213,0.47075,-0.750942,-0.210372,-0.105954,0.0293238,-0.061814,0.572473,-0.124226,0.0948909,0.670203,-0.148286,0.0297749,-0.403102,0.441092,-0.0694999,-0.225267,-0.355798,-0.550551,0.457264,0.355982,0.0472333,-0.170135,-0.254711,0.0956931,0.222001,-0.00919437,-0.417617,0.268558,0.0729229,0.0542254,-0.0131146,-0.51491,-0.0768728,-0.274931,-0.010483,-0.0863641,-0.295037,-0.0616008,0.35632,-0.537971,-0.938513,-0.16065,-0.0089476,-0.40227,-0.345659,0.235274,0.146171,0.276861,0.382323,0.526176,-1.29017 +3414.41,0.980635,0.0848144,4,1.61592,0.782674,-1.37316,0.541725,0.675546,-0.0160276,0.422476,-0.317174,0.296722,0.109653,-0.0720442,-0.603445,0.107396,0.704236,-0.380795,0.775017,-0.0408184,-0.0386899,-0.147051,-0.118908,0.0594533,-0.571263,-0.98589,0.0471461,-0.190296,-0.371956,-0.202839,0.184741,-0.413136,0.0368967,0.71383,-0.249997,0.0041485,0.0335053,-0.337436,-0.524807,-0.121913,0.0342858,0.515244,-0.0726367,0.790308,0.527011,0.0705474,-0.581669,0.0418408,0.344171,-0.722538,0.127308,0.121899,-0.101552,0.00553898,0.46568,0.191864,-0.905692,0.579094,-0.258756,-0.343726,-0.461011,0.694976,-0.15881,0.387966,0.613086,-0.73538,-1.09631,0.0115248,-0.820084,-0.0492325,0.227649,-0.121904,-0.0983238,0.217327,-0.0296803,0.247435,0.178385,-0.298937,0.557449,0.265591,0.433347,-0.276424,0.125662,-0.00958854,-0.202208,0.447212,-0.215006,0.117909,-0.305403,-0.0335119,0.145509,0.303975,-0.312405,-0.190076,0.389222,0.139129,-0.0280509,0.409952,0.306493,-0.0937187,-0.427744,-0.0542099,0.382929,-0.160432,0.285615,-0.969922,-1.07327,-0.293768,0.377382,0.39736,-0.455911,0.440236,0.220246,-0.547181,-0.535199,0.608299,0.41817,0.641603,-0.277481,-0.735872,-0.0224405,-0.108442,-0.0216803,-0.459082,-0.348749,-0.100283,-0.183369,0.13338,0.547627,0.282335,-0.319517,0.107432,-0.588493,-0.359313,-0.314625,0.199814,0.471845,0.114876,0.0105114,0.572649,0.00825181,0.287038,-1.09449,-0.116023,0.250139,-0.302229,-0.260902,0.146182,0.0372317,-0.511086,0.441261,-0.30284,-0.543588,-0.149411,0.2265,0.408163,-0.496552,-0.0957376,0.77679,0.768005,0.349866,0.0683448,0.0805069,-0.494928,-0.0546138,0.488708,-0.020749,0.231214,0.733312,0.0617149,0.497548,0.0772462,-0.553661,0.207287,-0.439174,-0.202033,-0.573455,0.143005,-0.904588,-0.732874,-0.631658,0.146101,0.753669,0.474737,-0.113882,0.0925671,0.00217598,0.20691,-0.482698,-0.000781728,0.107254,0.13112,-0.72046,-0.273917,-0.0851206,-0.138584,-0.128417,0.414395,-0.163495,0.114377,0.00217813,-0.507478,-0.232687,0.213474,0.021567,-0.0102882,-0.218439,-0.299155,-0.37245,-0.622428,0.968722,0.154686,0.345747,0.293482,0.512897,0.37931,0.164226,0.403093,0.589038,-0.890648,0.192248,0.822291,-0.184609,0.00615581,-0.733602,-0.598961,0.400457,-0.405276,0.288042,-0.152753,-0.0796813,0.524101,0.144015,-0.134817,0.207953,0.149771,-0.427755,-0.668801,0.00720182,-0.112604,-0.176827,0.875954,-0.641997,0.54508,-0.452651,-0.533691,-0.112671,-0.0753301,0.199431,0.567608,0.106309,0.227292,-0.812359,0.224338,-0.965599,0.381332,-0.00403195,-0.18212,0.335922,-0.796814,-0.524133,-0.119269,0.192684,-0.120377,0.340853,0.185396,0.0416526,0.665915,-0.0260408,0.071482,-0.133811,0.505976,-0.18951,-0.00593214,-0.552135,-0.51615,0.416519,0.134455,0.164811,-0.173885,-0.357706,0.282137,0.156015,0.0639744,-0.621355,0.0551406,0.15937,-0.115581,0.0555407,-0.46185,0.074637,0.0606917,-0.412755,-0.41188,-0.302676,0.0625332,0.152424,-0.540704,-0.975051,-0.22542,-0.0862213,-0.654252,-0.193359,0.480738,0.179614,0.190873,0.423809,0.43689,-1.79874 +3400.46,0.713789,0.0848144,4,1.54893,0.784721,-1.16376,0.469783,0.658121,0.00524848,0.0693506,-0.25204,0.561845,0.00969939,-0.0337971,-0.2462,-0.325505,0.509747,-0.413082,1.1919,-0.101205,-0.434951,0.0166819,-0.1294,-0.0206069,-0.25149,-1.10403,-0.126494,-0.233554,0.191698,-0.00622629,0.194579,-0.0214068,0.251085,0.927474,-0.436184,-0.0610306,0.262484,-0.535691,-0.364368,-0.407998,0.593603,-0.070325,-0.046917,0.635677,0.562487,0.0188726,-0.668333,0.37453,0.0714268,-0.855601,-0.0642053,0.531204,-0.176255,-0.0170225,0.220207,0.117832,0.205079,0.694763,0.0243705,-0.0656427,-0.421734,0.582468,-0.37422,0.800043,0.454711,-0.645748,-0.867213,0.0916215,0.118505,0.559638,-0.0512022,-0.595407,-0.145534,-0.297712,0.0620242,0.343129,0.221964,0.569489,0.665788,0.125908,0.382435,-0.498977,-0.248673,0.37836,-0.926953,0.635439,0.0095559,-0.091589,0.0445416,-0.0271106,-0.337888,0.157987,-0.526001,0.427957,0.642659,0.503703,-0.122349,0.558275,0.0616966,0.426107,0.200603,-0.475554,0.69668,-0.0440058,0.493466,-0.607831,-0.539045,-0.480402,-0.159289,-0.233749,-0.237112,0.66157,0.462849,-0.13739,-0.691628,0.0305927,0.303714,0.121285,-0.29632,-0.636452,-0.136743,0.330075,-0.273413,0.219902,-0.761767,0.0435551,-0.103007,-0.473973,0.503972,0.150237,-0.350437,0.558191,-0.912202,-0.0484621,-0.165906,0.134415,0.269185,-0.013366,0.422736,-0.127971,0.15566,0.376967,-0.89104,-0.210514,0.164793,-0.486436,-0.276591,0.243809,0.0502802,0.0146884,0.286309,-0.0411727,0.171887,-0.306445,0.546524,0.177929,-0.1651,0.314979,0.568648,0.869394,-0.0899052,0.350486,0.0853944,-0.589187,0.17062,0.0923052,-0.0345593,-1.61139e-05,0.32646,-0.272695,0.075644,-0.164484,-0.117537,0.0272412,-0.217475,-0.0822264,-0.407318,0.359631,-0.745002,-0.329668,-0.453528,0.108153,1.38575,0.282244,0.0405737,0.186333,0.103473,0.148703,-0.177083,-0.35402,-0.236925,0.356934,-1.14716,-0.0463479,0.320426,-0.21213,-0.446698,0.131147,-0.0126606,0.567153,-0.593651,-1.10424,0.508853,-0.0315791,0.428536,0.313376,0.0742261,-0.0778488,-0.0272915,0.203575,0.917786,0.2507,0.423092,0.00789242,0.00890966,0.246372,0.105409,0.069545,0.0535266,-0.0674964,0.187533,0.430411,-0.0506513,-0.0849702,-0.426377,-0.487586,1.25117,-0.431126,0.340661,-0.824665,0.118653,0.257066,0.00611878,-0.312569,-0.125599,-0.707958,0.109719,-0.148196,0.205677,-0.0289085,-0.252208,0.978009,-0.912306,-0.366012,-0.446987,0.0788595,-0.493435,0.131962,0.294457,0.65444,0.370016,0.0806604,-0.845323,0.489485,-1.23138,0.643248,-0.317253,-0.350403,-0.0011676,-0.103563,-0.351674,0.474394,0.184916,-0.174034,0.412363,0.0872799,-0.0407374,0.43987,0.517014,0.084042,-0.405249,0.534774,0.0590798,-0.0287205,-0.899832,0.148702,-0.0752917,-0.197758,-0.182695,0.291355,-0.0885156,0.806158,0.239144,-0.432184,-0.29573,0.44385,-0.150381,0.129664,0.0966919,-0.384817,1.02037,-0.161461,-0.225985,0.130907,-0.22582,0.162734,-0.087727,-0.496615,-1.1922,-0.200271,-0.310937,-0.264739,0.0406711,0.0238161,0.161056,0.218304,0.401318,0.467231,-1.85861 +3405.32,0.752756,0.0848144,4,1.5802,0.701817,-1.79121,0.708013,0.592514,0.00397261,0.22116,-0.639755,-0.202763,0.568446,0.14164,0.0453861,0.0140069,0.604138,-0.012778,0.74554,0.0924406,0.274017,-0.211024,-0.367325,-0.164692,-0.856407,-0.577825,-0.0760943,0.163147,-0.0988295,-0.188752,0.584038,-0.581416,-0.358516,0.793284,-0.530727,-0.0451337,0.239719,-0.609051,0.154862,-0.119412,0.200261,0.513335,0.00283686,0.820409,0.594552,0.302114,-0.452056,-0.22781,0.35112,-0.580896,-0.0828701,0.321512,0.494493,0.00517458,0.349105,0.264996,-0.550259,0.494254,-0.100636,-0.433862,-0.552877,0.0928166,-0.0266666,0.214981,0.423292,0.108172,-0.475476,0.259666,-0.17874,0.46184,0.538972,0.0440277,-0.514447,-0.101043,0.173545,0.384631,-0.211764,0.175997,0.436961,0.443885,0.0219279,0.251663,0.116501,0.467165,0.0820118,0.0528757,-0.853793,-0.354808,0.416312,0.000344049,-0.0537276,-0.166244,-0.463095,-0.0830107,0.221733,-0.39008,0.105725,-0.123244,-0.0333372,0.286732,-0.0638517,0.74915,0.0397714,0.133582,-0.0275259,-0.423205,-0.237076,0.559953,-0.0328856,1.00772,-0.0266685,-0.104105,0.625575,-0.600557,0.0949741,0.717844,0.414185,0.219199,0.53085,-0.269298,0.17895,0.269499,-0.849687,-0.0317022,-0.796516,-0.0090429,-0.123936,-0.017691,1.08358,0.394363,-0.638822,0.189882,-0.610764,-0.0969812,-0.256147,-0.244778,-0.142563,-0.28045,-0.121208,0.12624,0.155696,0.329365,-0.390415,-0.591645,0.232649,0.146236,-0.784391,-0.000167983,-0.0862586,-0.452164,0.940537,-0.0812709,0.182492,-0.17359,0.074387,0.302919,-0.102188,0.134922,0.0992772,0.429485,-0.635835,0.252984,0.313263,0.0573581,-0.345038,0.668918,-0.330696,-0.0782873,0.936036,0.0749607,-0.340059,-0.601554,0.336953,0.27665,-0.157759,-0.0835496,0.236001,0.10582,-0.582019,-0.144161,-0.188165,0.233153,0.897578,-0.165457,0.2539,-0.113422,-0.341456,0.417942,-0.00667471,-0.320002,0.173844,0.0602623,0.0403408,-0.576087,-0.22166,-0.14066,-0.401405,0.41092,0.600795,0.171103,-0.0996056,-0.621351,0.698568,0.394782,-0.467684,0.108595,0.303149,-0.222403,-0.163956,-0.609361,1.05023,-0.151587,-0.480378,0.0896371,0.0758294,-0.344185,0.0712913,-0.460045,0.581081,-0.593451,0.209859,0.247754,-0.535418,-0.295646,-0.0636888,-0.00621193,0.205993,-0.138932,0.20698,-0.490262,-0.318422,0.165193,0.00826182,-0.316178,0.142153,0.227003,-0.406098,-0.183393,0.813598,-0.309355,0.0574839,1.19658,-0.320619,0.000814902,-0.34749,-0.829973,-0.573497,0.301408,-0.213694,0.33638,0.0337863,-0.133747,-0.72609,-0.402825,-0.779192,0.39744,-0.423712,-0.161948,0.888677,-0.433813,0.0908802,0.179083,-0.163289,-0.534501,-0.254246,-0.294933,-0.0120738,0.308721,-0.345146,-0.173402,-0.461163,-0.687583,-0.0149381,0.196712,-0.323179,-0.113738,0.547377,-0.00770573,-0.115924,-0.0971631,-0.684641,0.72661,-0.164195,0.123855,-0.181148,0.262584,0.983295,-0.0652018,-0.294162,0.222165,0.405251,-0.238374,-0.0370649,-0.438812,0.241705,-0.328195,0.329637,-0.0720766,-0.387995,-0.400391,0.513853,-0.211805,0.0911311,-0.222368,0.151407,0.133557,0.389111,0.365454,-1.35891 +3403.24,0.999259,0.0848144,4,1.53285,0.85681,-1.6925,0.646121,0.293094,0.199995,0.123431,-0.584173,-0.0969602,0.243351,0.000606825,0.154765,-0.128691,0.601431,-0.112889,0.693881,0.128947,-0.180728,-0.688644,-0.383406,-0.166944,-0.837788,-1.06161,0.163679,0.133895,-0.127718,-0.150178,0.381925,-0.425974,-0.108011,0.743331,-0.6162,-0.252082,0.186475,-0.505071,-0.0166204,-0.254989,0.579748,0.450184,-0.541295,1.09235,0.726381,0.709667,-0.237969,-0.223478,0.166571,-0.678485,-0.0432061,0.463679,0.425139,0.077119,0.498734,0.023194,-0.550387,0.187237,-0.31018,-0.156011,-0.636767,0.124282,0.278699,0.434168,0.523166,-0.274669,-0.66804,0.447876,0.122963,0.24824,0.884617,0.113781,-0.691522,-0.0796371,0.255279,0.564441,0.0300706,0.254487,0.28691,0.31839,-0.331796,-0.0417737,0.0573226,0.309231,-0.218748,0.502399,-0.661703,-0.255199,0.288218,-0.0610351,-0.150548,-0.313411,-0.592327,-0.135669,0.104385,-0.343958,0.354374,0.0149474,0.0397563,0.240437,-0.0652068,0.517109,-0.150735,0.0501437,-0.139721,-0.583429,0.144049,0.654132,-0.363229,0.977854,-0.0519151,-0.017926,0.671064,-0.138373,0.384761,0.765534,0.288964,0.0107366,0.0852813,-0.266813,0.222428,0.262895,-0.40935,0.00243812,-0.712737,0.0961787,0.369451,-0.431814,1.11622,0.0277602,-0.0507858,0.414023,-0.365786,-0.447749,-0.48797,-0.697642,0.34086,-0.296219,-0.352886,-0.110288,-0.0883477,0.391924,-0.537572,-0.7016,0.32478,0.0438691,-0.418675,0.0947141,-0.165095,0.131111,0.716843,-0.0663272,-0.0878303,-0.0974176,0.103115,0.68827,-0.210609,0.156361,-0.0531667,0.288412,-0.401985,0.177781,0.0346634,0.468888,-0.503939,0.58194,-0.492405,0.0322461,0.927263,0.427334,-0.445687,-0.310239,0.122732,0.240134,-0.405083,-0.0745605,0.235873,0.113307,-0.338129,-0.0417029,-0.0207283,0.253345,1.31147,-0.104196,0.274765,0.204547,0.0456756,-0.0878683,-0.0715323,-0.302247,-0.330904,-0.377138,-0.2116,-0.224073,-0.450704,-0.100323,-0.297158,0.175803,0.486709,0.585856,-0.00373653,-0.502456,1.09511,0.160184,-0.593193,0.475843,0.327202,-0.435276,0.0493936,-0.18719,0.825797,-0.00573017,-0.63004,-0.168604,-0.30005,-0.131455,-0.214769,-0.180285,0.229625,0.0758106,0.276108,0.226481,0.098624,-0.5041,-0.0648305,-0.027903,0.325924,-0.0176607,0.245893,-0.615212,-0.3024,0.224805,0.402138,-0.46712,0.0583786,0.00271288,-0.222882,-0.244107,0.725935,-0.112468,-0.0681136,1.33102,-0.314961,-0.221235,-0.0253151,-0.54408,-0.647919,0.477851,-0.661243,0.120116,-0.0667232,-0.160687,-0.652732,-0.510024,-0.777258,0.401931,-0.331151,-0.124517,0.651468,-0.341555,-0.22814,-0.112931,-0.158376,-0.581644,-0.0585386,0.196366,-0.326902,0.152922,-0.522492,0.00195506,0.0240978,-0.729835,-0.0569406,0.123156,-0.416837,-0.573177,0.290492,-0.625984,0.00459797,0.107666,-0.609963,0.615207,-0.366243,0.194602,-0.0632961,0.390902,1.27896,-0.401668,-0.320805,0.300727,0.627772,-0.107135,-0.198534,-0.21328,-0.268418,-0.399493,-0.31142,0.0246976,-0.447052,-0.402908,0.102823,-0.520249,-0.254035,0.100111,0.169515,0.19879,0.411722,0.445858,-0.728452 +3407.47,0.935698,0.0848144,4,1.52642,0.823666,-1.3335,0.438321,0.27342,-0.0291113,-0.301328,0.215886,-0.206817,0.131399,-0.242663,-0.336376,-0.273679,-0.0406945,-0.333491,0.398237,-0.0140805,0.422599,0.348624,-0.0505442,-0.158737,-0.676872,-0.813261,0.116957,-0.795975,-0.772582,-0.129309,0.335566,-0.357707,-0.181472,0.767376,-0.327865,0.536948,-0.133746,0.00109086,-0.176307,-0.541973,1.07971,0.629154,-0.291886,0.929078,1.03232,-0.20068,-0.682921,-0.0692821,0.248784,-0.424929,0.10136,0.90133,0.256906,0.407682,0.26583,0.265111,0.164003,1.03028,0.196339,-0.426841,-0.896894,0.517817,-0.413886,0.430649,0.689688,-0.717993,-0.590771,-0.00130609,0.175817,-0.143596,-0.720917,-0.545915,0.0679908,-0.251504,-0.0249008,0.878963,-0.277018,0.718041,0.828047,-0.141873,-0.117203,-0.202242,0.0737598,0.469179,-0.276613,0.0130097,0.285098,0.0225201,-0.289409,0.0773032,-0.37521,0.519852,-0.0781668,-0.200818,-0.335899,0.367269,-0.0929429,-0.119998,0.180137,-0.735506,-0.588528,0.302559,0.876497,-0.279569,-0.00624689,-0.639904,-0.493919,-0.515171,-0.46067,0.094866,-0.595617,0.0873382,0.322268,-0.130195,-0.687468,-0.421578,-0.0424432,-0.339086,0.379705,-0.180606,0.000831895,0.336076,0.141041,-0.489776,0.309985,-0.150102,-0.510614,0.207731,-0.712746,0.939528,-0.167901,0.0867285,-0.585174,0.586449,0.6694,0.810722,0.523369,0.176405,-0.307601,0.0202831,0.197606,0.407918,-0.883131,0.186701,-0.172586,0.0421256,-0.0290732,-0.0162747,-0.224727,-0.205238,-0.0161934,-0.212109,-0.266322,-0.606999,0.261347,-0.123662,0.0690437,0.611311,0.381487,0.1126,0.655271,0.184118,-0.280171,-0.031317,0.0196624,0.982165,0.387556,-0.172653,0.262312,-0.793918,-0.159534,-0.0671792,0.131476,0.0692477,0.060524,-0.23033,-0.6464,0.0533312,0.911404,-0.4094,-0.594975,-0.113593,1.09376,0.389529,-0.776303,0.15369,-0.318419,0.15314,-0.127604,-0.395509,-0.187284,0.381222,-0.7995,0.572879,0.495414,-0.0526594,-0.554257,-0.433245,-0.341529,-0.0771115,-0.559984,-0.447741,-0.284432,-0.132497,0.356132,0.0027976,-0.322265,0.0490676,-0.0623001,-0.696753,1.08559,-0.251463,-0.0419923,0.308703,0.138544,0.153791,0.453628,-0.465268,0.266461,-0.111888,0.15019,0.150638,-0.349435,-0.182465,-0.708724,-0.0897535,0.611928,0.088445,0.284565,-0.399385,-0.281595,0.321485,-0.346692,-0.25723,-0.240031,-0.67488,0.275137,0.0670514,0.227478,0.125384,0.168708,0.644163,-0.245018,-0.633885,-0.120601,0.54366,0.159082,-0.0370753,0.0974614,0.604046,-0.0420084,-0.222202,0.114017,0.0388695,-0.766136,0.310197,-0.654091,-0.610506,0.0244116,-0.331463,0.125297,0.20722,0.226911,0.829105,0.777331,-0.586921,0.337131,-0.0404265,0.195334,-0.293563,-0.285703,0.209818,0.031009,-0.517987,-0.264559,-0.00912745,-0.296976,0.318289,0.0242125,0.0819423,-0.18167,0.293723,-0.14228,-0.507381,-0.174394,-0.661492,-0.885489,-0.14354,0.0373873,-0.804608,-0.120299,-0.0332976,-0.0597964,-0.285167,-0.0692906,0.554925,0.576267,-0.402799,-0.393868,0.185448,0.304515,-0.0616826,-0.0630298,0.0662186,0.163019,0.370097,0.403756,0.608356,-0.545238 +3403.71,0.96623,0.0848144,4,1.45308,0.846617,-0.841631,0.219506,-0.0458703,-0.107109,0.134319,-0.0116217,0.279381,0.785258,-0.0528165,0.00696339,0.217155,0.195103,-0.355586,0.796666,0.0189051,0.230096,-0.312364,0.140696,-0.119404,-0.656549,-0.892035,0.271126,-0.165702,-0.05489,0.20422,-0.0977823,0.165958,-0.0786204,1.0053,0.0360483,-0.357302,0.367991,0.132312,0.289342,-1.07148,0.615531,0.496664,-0.527302,0.842599,0.933051,0.805666,-0.63975,0.356147,0.0509919,-0.356977,0.431445,0.826893,0.0166118,0.214064,0.218436,0.512627,-0.573338,1.09589,0.11205,-0.308864,-0.396926,0.613372,0.157953,0.093109,0.775886,-0.811225,-1.07814,-0.0821595,1.03048,-0.122981,0.31521,-0.0421432,-0.163057,0.180008,0.507339,1.03088,-0.350798,0.738726,0.763147,0.370256,-0.372501,-0.0522288,-0.15117,0.251868,-0.646165,0.333142,0.248566,0.0477538,0.189203,0.12606,-0.0393146,0.454617,-0.567563,0.363056,0.285502,-0.0865192,-0.41841,0.410006,0.437117,-0.0896365,-0.516307,0.324594,0.00450028,0.124396,-0.566963,-0.0645797,-0.568703,0.414978,-0.202769,0.658777,-0.493087,0.470637,0.611334,0.169768,-0.30142,0.451395,0.472778,0.332618,0.384289,-0.395803,-0.287836,0.311393,0.237981,-0.825675,0.513045,-0.437979,-0.27609,-0.230714,-0.40418,-0.191699,-0.0427055,0.319716,0.0390441,0.0714383,0.482239,0.469447,0.795036,0.00463818,-1.10512,-0.229522,-0.401686,0.0963168,-0.209513,-0.0111005,0.123684,0.438458,-0.350608,0.209711,0.413028,-0.0323551,0.467184,0.033472,-0.0103211,-0.404847,-0.112817,-0.337916,-0.495914,0.386279,0.505425,0.00274494,0.0795565,0.705177,-0.149374,0.32272,0.232853,0.229306,-0.458822,-0.734519,0.0540912,-0.0715925,-0.230832,-0.288209,-0.426851,0.134843,0.0781472,-0.255918,0.266108,-0.0178979,-0.355789,-0.208752,0.253789,0.131898,0.804769,0.217584,-0.0146183,0.926144,0.194063,-0.233794,-0.615278,0.0793817,-0.0544377,-0.14703,-0.808583,0.0802061,-0.271149,0.035463,-0.132477,-0.545976,0.208941,0.183009,-0.29272,-0.435457,0.54924,-0.17348,-0.406458,-0.349055,0.011043,-0.358605,-0.381936,-0.5403,0.840842,-0.315107,-0.172003,-0.242562,-0.602174,0.405095,0.729202,-0.968186,-0.113273,0.0718527,0.625608,0.173243,0.0271294,0.234471,-0.64085,0.0247999,0.164603,-0.842655,-0.121846,-0.5719,0.0866417,0.912683,-0.295853,-0.243592,-0.0159308,-0.377869,0.111125,-0.64826,0.535528,-0.0521884,0.320791,1.10381,-0.0761234,-0.279973,0.4946,-0.332135,0.101887,1.06985,-0.354449,0.496838,0.0761141,-0.251891,0.000171318,0.0129692,-1.33232,0.498367,-0.340982,-0.0958216,0.429464,-0.25444,-0.627361,0.526149,-0.0472008,0.304783,0.298978,0.224692,0.441955,-0.0653583,0.462076,-0.0855979,0.0846162,0.117454,-0.128187,-0.16363,-0.407198,-0.407728,0.125496,-0.162456,0.491098,0.4805,-0.939181,-0.36263,-0.239634,-0.316585,-0.180668,-0.347165,0.380651,-0.189244,0.142545,0.432633,0.349956,0.211584,-0.644488,-0.0913937,-0.246065,0.321631,-0.321574,-0.314832,-0.249997,0.152985,-0.170989,0.307513,-0.360098,1.02294,0.149579,0.187926,0.386754,0.433504,0.369398 +3405.16,0.613943,0.0848144,4,1.4172,0.702885,-0.903445,0.328854,0.210599,-0.0456182,0.0419736,-0.130176,0.369004,0.213291,0.162525,-0.205099,0.180506,0.348963,0.0709497,0.371376,0.104937,0.549403,-0.20292,0.517383,-0.0645228,-0.629131,-0.558858,0.393766,-0.440382,-0.304964,0.0103134,0.0925146,0.0152475,0.0227812,1.00788,-0.580991,0.38827,0.534969,-0.0694267,-0.0498251,-0.168946,0.390996,0.291483,-0.102378,0.888724,0.508865,-0.0990891,-0.520903,0.170154,0.240588,-0.550595,0.166591,1.1617,0.00864284,0.353225,-0.0376272,0.34426,-0.998266,0.876615,-0.319028,-0.287948,-0.575578,0.506925,-0.30696,0.224378,0.832537,-0.980911,-0.379838,-0.000653131,0.356511,0.445321,-0.285214,0.0471236,-0.565088,0.363475,0.0840517,1.1336,-0.642016,1.40889,0.917472,-0.108102,0.159737,-0.677558,0.0891144,0.627358,-0.0329667,0.181197,-0.458081,0.00624169,-0.0911035,0.313583,-0.418045,0.339761,-0.308552,-0.317031,0.154731,-0.093758,-0.155543,0.136729,0.490709,0.0975144,0.00667475,0.192126,0.518712,-0.0470859,0.064164,-0.126915,-0.809727,0.11899,-0.692674,0.162527,-0.666848,0.375026,0.566063,-0.360027,-0.542472,0.346911,0.426969,0.465603,0.867593,-0.334126,0.0295046,0.0547694,0.268964,-0.458165,-0.010082,-0.132266,-0.250718,-0.659142,0.152269,0.0747418,0.525535,0.123563,0.159415,0.0507533,0.300062,0.19795,0.438478,0.262566,-0.336384,0.11178,-0.521747,0.942369,-0.752246,-0.0507542,0.186762,0.407458,-0.422842,-0.176941,0.239185,-0.539906,0.556792,-0.179506,-0.283685,-0.0223207,0.231717,-0.00686073,-0.0827288,-0.191028,0.835452,0.155641,0.132995,0.0777096,0.0535754,-0.270198,-0.0100451,0.448058,-0.381337,-0.266233,-0.0143991,-0.612393,-0.079134,-0.365652,-0.329354,0.258616,0.288342,0.16076,-0.0023781,0.127455,0.0696098,0.161934,-0.333436,0.169655,1.01677,0.607295,-0.884552,0.707411,0.511832,0.333858,-0.552955,-0.545104,-0.473104,-0.198056,-0.661104,0.399234,1.06709,-0.0960667,-0.116751,-0.290699,0.667136,0.169786,0.0821187,-0.681692,0.409656,0.146199,-0.125245,0.699895,-0.260701,-0.00605631,-0.510061,-0.473429,1.17541,0.31406,0.215629,-0.351853,-0.25979,0.357698,-0.133064,-0.738867,-0.218515,-0.395804,0.00742356,0.248714,0.519835,0.138245,-0.10964,0.308227,0.30243,0.356656,0.0753957,-0.235421,-0.252251,0.649952,-0.109559,-0.640076,0.322044,-0.105795,-0.0926012,-0.441381,0.377207,-0.0981912,-0.0474631,0.451288,0.396312,0.036108,-0.100094,-0.133453,0.518902,-0.298064,-0.645401,0.519926,0.338963,0.0268344,-0.111485,0.415995,-0.24892,0.710923,-0.287306,0.477054,-0.314847,0.022703,0.126141,0.0905205,0.0486606,0.358803,0.493279,0.216128,0.169422,-0.0264359,0.157369,0.128975,0.503348,-0.110255,0.167332,0.007489,-0.647256,-0.578938,0.189971,0.364431,-0.489516,0.662612,0.099727,-0.149417,-0.00401539,0.312464,-0.357327,0.469047,0.449199,-0.275988,-0.29533,-0.187338,0.539017,-0.276291,0.491234,0.155847,0.392307,-0.252011,0.413584,-0.243035,-0.210475,0.132652,0.397554,0.604413,-0.708817,0.278239,0.176062,0.340739,0.419597,0.583728,-0.350394 +3374.81,0.76027,0.0848144,5,1.44176,0.87939,-1.08246,0.308507,-0.285513,-0.0930441,0.323235,0.0320266,0.458075,0.263364,0.0688457,0.0329178,0.158218,0.627007,-0.422076,0.765142,0.113781,0.348674,-0.504489,0.645974,-0.51477,-0.11888,-0.133973,0.122333,0.0195382,-0.341701,0.106494,-0.301149,0.235205,0.497799,0.59491,-0.416838,-0.603972,0.322114,-0.465057,0.525821,-0.407384,0.197335,-0.392359,0.0960357,0.906987,0.675666,0.876622,-0.93453,0.175454,0.229099,-0.268072,0.437764,0.812734,0.383456,0.337436,-0.172036,0.286476,-0.104583,0.609843,0.0772108,-0.422305,-0.160553,0.417352,-0.014341,0.4132,0.399022,-0.480798,-1.4717,-0.106973,-0.1268,-0.260331,-0.130283,0.343889,-0.300142,-0.634129,0.191076,0.480138,0.0868504,0.0453282,0.437534,-0.149608,0.0816388,-0.316855,0.247906,-0.320564,-0.66879,0.329359,0.192754,0.0822105,-0.474575,-0.0251169,-0.109582,-0.379133,-0.0561838,0.603169,0.324135,-0.0728692,0.210136,-0.364844,-0.918038,0.105216,-0.37647,-0.720166,0.326226,0.0766897,0.149337,-0.296454,-0.0782546,-0.329738,-0.282228,0.269377,-0.175784,-0.0925916,0.476648,0.120284,-0.5346,0.389888,0.64545,0.172894,0.164182,-0.0686252,0.11096,0.783669,-0.275342,-1.05732,-0.567265,-0.137575,-0.306102,-0.547885,0.485575,-0.111859,0.119184,0.083169,-0.403428,0.0550942,0.213474,-0.122556,0.95663,0.252751,-0.307261,0.0411493,0.0134974,0.381135,-0.35687,-0.493705,-0.0336028,0.305352,-0.397346,0.0771241,1.05114,-0.164982,-0.113199,0.519562,0.0072888,-0.334337,-0.454384,0.545615,0.069896,0.388647,0.962081,0.484451,-0.268729,0.261932,0.135506,0.448851,0.177129,0.369477,0.949572,-0.113253,0.515323,-0.0503775,-0.294848,0.33674,-0.407961,-0.0149088,0.205653,0.0271014,-0.241243,-0.152748,0.183032,-0.279295,0.0869349,0.603334,1.11902,-0.472839,0.488715,0.200756,-0.155058,-0.0331195,0.126727,-0.138939,0.0658729,0.418447,-0.110264,0.0349873,-0.0326279,0.650889,-0.197884,-0.474317,0.669382,-0.692408,-0.207997,-1.50598,-0.312727,-0.226183,0.159763,-0.189633,-0.0765657,-0.392039,-0.0808734,-0.568541,1.12973,0.367393,-0.558513,-0.0904342,-0.33551,-0.299395,-0.169197,-0.109606,1.06167,-0.066176,0.382205,0.634491,-1.12389,0.594314,-0.871818,-0.345287,0.166805,-1.04999,0.419069,-1.18062,-0.00227965,0.0383467,0.372754,0.264653,0.0409372,0.147283,0.403786,-0.105363,0.330597,0.212208,0.0610973,1.26512,-0.984509,-0.643297,0.325845,0.0101438,0.400565,0.186086,0.852469,0.287248,0.0171566,-0.721048,-0.230255,-0.552368,-0.636143,0.733354,-1.12098,-0.749739,0.00408609,-0.00414053,-0.340255,-0.746201,0.113678,0.0993735,0.389212,0.173445,0.432585,0.444912,-0.234393,0.13251,0.0177081,-0.606979,-0.358247,-0.234094,-0.0905465,-0.378573,-0.106882,0.431929,0.190431,0.0156724,-0.195317,0.143272,0.257983,-0.814574,-0.597618,-0.863357,-0.198083,-0.06524,-0.0973528,0.281495,0.109416,0.0153785,-0.275868,0.0706676,0.0276979,0.651903,-0.226092,-0.0349076,-0.128143,-0.441857,-0.072269,0.359739,0.144215,-0.0649281,0.213297,0.166223,0.461841,0.407705,1.13431 +3378.05,0.922861,0.0848144,4,1.42735,0.891053,-1.06047,0.313104,-0.24987,-0.0626113,0.352219,0.0160033,0.397332,0.0859987,-0.00279074,-0.0138607,0.13952,0.632439,-0.385967,0.720216,0.0720947,0.252633,-0.531319,0.640429,-0.670483,-0.179637,-0.300172,0.238091,-0.0411914,-0.37973,0.196485,-0.294935,0.180822,0.412038,0.561005,-0.381672,-0.569098,0.293855,-0.459483,0.503798,-0.493295,0.187178,-0.409316,0.0172474,0.919462,0.66884,0.922912,-0.979116,0.210066,0.276594,-0.329928,0.372863,0.775444,0.537715,0.387544,-0.21306,0.276019,-0.142407,0.553264,-0.0193373,-0.430754,-0.249837,0.462876,-0.0762198,0.448809,0.462407,-0.485574,-1.46751,-0.180473,-0.0103684,-0.194599,-0.071575,0.385044,-0.405249,-0.627821,0.315855,0.476186,0.0729958,0.135301,0.410662,-0.265947,0.110928,-0.31771,0.225649,-0.26824,-0.642525,0.331805,0.304179,-0.0498064,-0.598463,0.0849988,-0.158324,-0.459792,-0.0186412,0.456895,0.248914,-0.25518,0.168077,-0.492504,-0.8578,0.0849071,-0.357506,-0.709548,0.387007,0.104437,0.0420178,-0.31908,-0.0521719,-0.27346,-0.220463,0.211887,-0.0846661,-0.111495,0.542471,0.160543,-0.435381,0.417744,0.661977,0.204309,0.245134,-0.204917,0.161009,0.715017,-0.426098,-1.1571,-0.518232,-0.107846,-0.222324,-0.592833,0.383372,-0.169661,0.265792,0.205569,-0.394457,0.0689986,0.246003,-0.0836719,0.934097,0.220958,-0.305027,0.114922,-0.00175377,0.415642,-0.43604,-0.412941,0.0590334,0.28719,-0.469564,0.0181484,0.998561,-0.131549,-0.0741678,0.43752,0.0804153,-0.304213,-0.480617,0.507844,0.0805279,0.32979,0.987435,0.609934,-0.363653,0.29955,0.0331243,0.535144,0.196411,0.297327,0.850802,-0.133527,0.478659,-0.116096,-0.315252,0.260233,-0.394713,0.0712015,0.28085,-0.019021,-0.217164,-0.110612,0.182105,-0.334476,-0.142346,0.629973,1.06819,-0.524782,0.530994,0.180174,-0.126313,-0.0544816,0.157909,-0.261439,0.0947341,0.435562,-0.143741,-0.00628775,0.13575,0.635856,-0.247855,-0.42853,0.659376,-0.730731,-0.279544,-1.61471,-0.402603,-0.226822,0.0684116,-0.241852,-0.042568,-0.405749,-0.0810152,-0.568599,1.17997,0.468597,-0.477341,-0.145543,-0.364819,-0.3425,-0.113233,0.0468002,1.13084,-0.00245763,0.447696,0.469139,-1.14634,0.567031,-0.740552,-0.287632,0.24406,-0.933558,0.42902,-1.28334,-0.0799693,0.0549909,0.295372,0.316941,0.00959203,0.060135,0.358962,-0.25607,0.320785,0.142317,0.26171,1.20888,-0.937007,-0.596462,0.205902,0.027594,0.345761,0.100164,1.03558,0.340106,-0.0772705,-0.662547,-0.122988,-0.605871,-0.628836,0.720315,-1.03053,-0.63492,-0.0535497,-0.0227268,-0.448861,-0.746913,0.063468,0.221454,0.320438,0.150488,0.394763,0.448233,-0.292277,0.251561,-0.102039,-0.609963,-0.350043,-0.210304,-0.0733176,-0.480743,-0.0533761,0.392684,0.31776,0.0504031,-0.0927655,0.371692,0.356088,-0.744441,-0.498227,-0.838699,-0.242776,-0.0261227,-0.138339,0.240506,0.11301,0.101864,-0.258228,0.0927554,-0.0878851,0.68182,-0.163409,0.0116968,-0.296041,-0.420246,-0.0373291,0.305182,0.19906,0.0655464,0.191288,0.163264,0.437365,0.404059,0.957433 +3358.81,0.95998,0.0848144,4,1.52134,0.753127,-0.850314,0.184659,-0.369481,0.00765954,-0.0553261,-0.238318,0.294026,-0.466829,-0.0917931,0.084635,0.00568781,0.584553,0.017966,0.727244,0.076482,-0.0469949,-0.384627,0.381931,-0.46068,-0.149424,-0.238205,0.321533,-0.48935,-0.290994,0.329398,-0.247001,-0.126217,0.012333,0.445047,-0.667007,0.186115,0.506369,-0.112035,0.173106,-0.253652,0.0607017,0.348223,0.0327801,1.09831,0.878052,-0.208342,-0.70588,0.255914,0.36788,-0.27439,0.45858,0.431439,0.655553,0.37075,0.383856,0.184961,0.332442,1.05267,0.17157,-0.431658,-0.166338,0.569483,-0.559867,0.455689,0.699872,-0.91659,-1.14998,0.36635,-0.430828,0.414849,0.0668446,0.493035,-0.363854,-0.931877,0.323413,0.886017,-0.041383,0.163914,0.872711,0.155797,0.306868,-0.311355,0.665727,0.501622,-0.71788,0.411376,0.174272,-0.321449,-0.722727,0.431558,-0.576108,0.108042,-0.147637,0.406304,0.0814675,-0.393073,0.338623,-0.368227,-1.49305,-0.271632,0.0296423,-0.691559,0.516914,0.398732,0.0216093,-0.0537526,-0.265238,-0.104468,-0.377277,0.485577,-0.13645,-0.232478,0.833352,0.337617,-0.432638,-0.162835,0.315718,0.0656574,0.0978467,0.00669805,0.174007,0.979611,-0.271582,-1.07919,-0.0365011,-0.263101,-0.0197004,-0.000831249,0.418194,0.636564,-0.102024,-0.0633639,0.132566,-0.139319,0.251698,0.280643,0.550556,0.323605,-0.121354,0.275392,0.0261403,0.919309,-0.201442,-0.85022,0.0174108,0.972417,0.176202,-0.0826773,0.893959,-0.144909,-0.192498,0.427519,0.833214,0.312207,-0.535624,0.50967,0.235531,0.419862,1.00566,0.429569,-0.712196,0.204345,-0.162538,0.720486,0.179568,0.160819,0.917799,-0.212162,0.239617,0.285035,-0.550511,0.112443,-0.537683,0.713573,-0.0282167,0.25472,0.273205,0.611048,0.28078,-0.203071,-0.199817,0.742618,1.25309,-0.642157,0.918111,0.632475,0.119929,-0.411997,-0.556142,0.358718,-0.0359871,0.160796,-0.583186,-0.124674,0.140133,0.153937,-0.56861,-0.130101,0.284676,-0.669043,-0.00958899,-1.06375,-0.62907,-0.0334355,0.189615,-0.0585534,-0.54574,-0.097315,-0.291636,-0.81721,1.29869,0.358293,-0.607568,-0.107358,-0.0392932,-0.0516889,-0.193841,0.306655,0.144667,-0.0447452,0.661519,0.577878,-0.738389,0.123309,-0.415796,0.125458,0.439833,-0.639218,0.794882,-0.977719,0.0188528,-0.278507,0.0844285,-0.305238,-0.00157141,0.0883359,-0.00583802,0.152008,0.395472,-0.173412,0.372731,1.3614,-1.15522,-0.477576,0.140152,-0.0166434,0.199518,0.128878,0.683947,0.133358,0.408899,-0.527362,-0.544176,-0.000818253,-0.451016,0.623278,-0.805285,-0.548399,-0.282151,0.000624899,-0.492064,-0.722591,-0.0390951,0.270296,-0.00336156,0.000753289,-0.0217948,-0.0546197,-0.153327,0.452612,0.259239,-0.560359,-0.447885,-0.479057,-0.478903,-0.0729688,-0.230302,-0.224102,0.392334,0.0630888,0.515114,0.0357325,0.144443,-0.40133,-0.487092,0.042709,-0.11056,-0.243281,-0.224196,-0.136849,0.359512,0.150961,-0.463471,0.126603,-0.0895261,-0.163935,-0.0115099,0.259704,0.0987036,-0.605729,0.212688,-0.172826,-0.0451037,0.854364,0.210159,0.274053,0.458431,0.5235,1.68617 +3365.43,0.890315,0.0848144,5,1.24894,0.638844,-1.50632,0.49485,-0.00663216,0.0195982,0.439645,0.116717,0.372899,0.285516,0.420959,0.183461,-0.0968188,1.05652,-0.35874,0.422284,0.769483,0.274854,-0.149949,0.218903,0.693921,-0.552789,-0.691793,0.730999,-0.24714,0.107164,-0.19083,0.212457,-0.123658,0.314179,1.01491,-0.633497,-0.425209,0.389748,0.325179,0.79882,-0.18306,1.08903,0.980186,-0.291446,1.59248,0.820141,1.14004,-0.446358,0.445799,-0.31763,-0.570886,0.765679,0.720167,0.656335,0.417606,0.518341,0.863528,-0.872227,0.976595,0.403194,-0.0385479,-0.680269,0.376958,0.490263,0.29699,1.06901,0.0327501,-0.292032,0.616147,0.119503,-0.664028,-0.0380759,0.537517,-0.642826,0.560962,0.153113,0.585441,0.279291,1.25968,0.529853,0.459661,-0.40098,-0.429566,-0.282945,-0.220827,0.00445742,0.349105,0.208344,-0.148603,0.645105,-0.0353428,0.511529,-0.0567175,-0.0299313,0.471952,-0.122835,0.198541,-0.660526,0.0371403,0.617799,0.413323,-0.648953,1.00601,0.119747,-0.0689653,-0.298287,-0.32494,-0.580578,0.623627,-0.230411,-0.0294652,-0.126369,0.0433368,0.631756,0.0719996,-0.166657,0.374749,0.607164,0.437396,0.586882,-0.113137,0.520619,0.132212,0.735933,0.246526,0.55618,0.0540957,-0.335229,0.331942,0.681039,-0.689335,0.952632,0.233842,-0.925055,0.519724,-0.113815,0.341257,0.739262,-0.213575,-0.374049,0.266933,-0.528778,0.159504,-1.25536,0.00884038,0.171972,-0.338689,-0.473678,0.0748562,-0.0442606,-0.138211,0.73089,-0.078834,-0.735647,-0.812331,0.493668,-0.346235,-0.594224,0.43035,0.52737,0.0552656,0.637751,0.115874,-0.0808431,-0.404227,-0.0532663,0.737893,-0.35172,0.255154,-0.0477655,-0.248224,-0.212972,-0.173841,0.237991,-0.381371,0.485661,0.128696,-0.761066,-0.169786,0.248509,0.172405,0.441816,0.188614,1.20655,0.261435,-0.578036,0.0870203,-0.791231,0.361137,-0.366736,-0.56678,-0.765596,0.130686,-0.250249,0.396367,0.298975,0.00210144,-0.400655,0.214238,0.5968,0.551211,-0.336263,-0.493547,0.267146,0.142506,-0.205386,0.220824,0.640053,0.269308,-0.138334,-0.390202,1.10194,0.821263,0.890669,-0.124629,-0.338607,-0.283274,0.560315,-0.0468827,0.362693,-0.640326,-0.349565,0.315211,0.260492,-0.0829464,-0.904573,0.398336,0.633391,-0.0598346,0.159878,-0.200953,-0.114237,0.480496,-0.0741135,0.00587895,0.307354,-0.572773,0.0320715,-0.415034,1.11569,0.261413,-0.364826,0.688573,-0.292189,-0.0164906,-0.241964,0.0142913,-0.0690239,0.275149,-0.0219309,0.19513,-0.451229,-0.120966,-0.0991628,0.240349,-0.65938,0.244463,-0.142509,0.555518,0.23962,-0.564039,-0.399203,0.24603,-0.119648,-0.110572,0.605002,0.273215,0.478928,0.36906,0.0494636,-0.15956,-0.384641,0.527491,-0.0227205,-0.272925,-0.541665,-0.301754,0.395861,-0.119219,0.100688,-0.0494515,0.0551094,0.712498,-0.0749907,-0.439768,-0.141782,-0.563442,-0.0242591,0.241664,-0.0928752,-0.248232,0.460469,-0.0750468,-0.172044,0.122384,0.0915665,0.58799,0.671742,-0.2579,-0.407328,0.69808,0.300725,0.0805916,-0.619259,-1.01841,0.215216,0.477778,0.463914,0.691215,0.458759 +3359.2,0.920864,0.0848144,4,1.23265,0.749316,-1.34852,0.474592,0.138439,0.0413447,0.412208,0.157833,0.325436,0.244012,0.610518,0.435718,0.0728468,0.829227,-0.407908,0.345805,0.44949,-0.226714,-0.274403,-0.0130378,0.46999,-0.1152,-0.824476,0.79546,0.0210598,0.00931445,-0.195619,-0.029594,-0.101072,0.250018,1.19544,-1.12527,-0.020285,0.367061,0.41568,0.391663,-0.122971,1.0298,0.582895,-0.125119,1.69438,0.716455,0.457946,-0.205809,0.724495,-0.231581,-0.466856,0.832184,1.02647,0.465946,0.139766,0.819817,0.780963,-0.87532,0.882958,0.25833,-0.608666,-0.549781,0.511817,0.177851,0.0586434,0.86139,-0.639568,0.083939,1.2014,0.0482405,-0.647145,0.348469,0.413573,-0.599238,0.556747,0.457607,0.382845,0.438524,0.502645,0.757241,0.662347,-0.614345,-0.323831,-0.379001,0.0648423,0.116305,0.189861,0.284281,-0.343357,0.699673,0.144072,-0.0426238,-0.311822,-0.296951,0.537015,-0.0851607,-0.103395,-0.455023,0.0454854,0.281505,0.585664,-0.808065,0.821517,-0.113102,-0.327968,-0.0570249,-0.403367,-0.836801,0.517054,-0.230443,0.130733,-0.143828,0.0412058,0.940863,0.309308,-0.0110649,0.859947,0.583924,-0.0269788,0.667364,-0.0378989,0.562079,0.369421,0.516035,-0.326577,0.575326,0.241498,-0.223924,-0.0211584,0.538209,-0.432277,0.934393,-0.0652519,-0.532059,0.284396,-0.0513242,0.490921,0.812351,-0.196313,-0.0509725,0.731277,-0.485471,-0.00976401,-0.778586,-0.544413,0.103372,0.189387,-0.419693,-0.453994,-0.391998,-0.913496,0.563403,-0.194698,-0.41601,-0.249297,0.542932,-0.26651,-0.60567,0.230463,0.144251,-0.0531259,0.719757,-0.167484,0.727954,-0.408304,0.00390518,0.699881,-0.259564,0.210219,-0.0654602,0.103217,-0.0664177,-0.163192,0.158223,-0.158847,0.461775,0.276714,-0.755558,-0.222989,0.195088,0.23435,0.546308,0.221023,1.17023,0.431908,-0.42002,-0.333818,-0.54486,0.0897505,0.0716765,-0.652283,-0.783007,-0.159681,-0.0152048,0.26219,0.444791,0.0139007,-0.357517,0.186758,0.520338,0.912413,-0.212206,-0.497686,0.0525754,0.167719,-0.317848,0.0346579,-0.144618,0.32193,-0.125596,-0.455908,1.18987,0.706483,0.865805,-0.0326269,-0.174089,-0.573446,0.180435,-0.133877,0.4963,-0.308762,-0.362008,0.281018,0.605859,-0.270279,-0.729246,0.451215,0.271359,0.26185,0.0701149,-0.136541,-0.163861,-0.112629,0.204342,-0.290351,0.158592,-0.455937,0.110749,-0.107534,1.07608,0.00801565,-0.299396,0.942894,-0.270782,-0.0901674,0.176995,0.0629285,0.231858,0.23305,0.457615,0.0507104,-0.00581999,-0.272658,-0.237025,0.395606,-0.106944,0.157212,0.259547,0.37652,0.330664,-0.550843,-0.323406,0.402818,-0.297888,0.045314,0.309741,0.366739,0.124199,0.451666,0.132056,-0.00044721,0.131979,0.114867,0.05296,-0.148471,-0.37472,-1.0536,0.39275,0.0547505,0.0345742,-0.0190211,0.54176,0.58727,0.2161,-0.135945,-0.0916264,-0.604414,-0.287489,0.0522862,-0.339443,0.0636197,0.509169,-0.323325,0.259222,0.0502686,0.100256,0.711953,0.620836,-0.216049,-0.763686,1.05699,0.0755965,0.134911,-0.594444,-0.06877,0.206086,0.347233,0.453967,0.589265,-0.303573 +3398.58,0.970241,0.0848144,4,1.3147,0.636676,-1.2419,0.449735,0.333402,-0.0498968,0.188197,-0.277798,0.503268,-0.300554,0.854538,-0.0256703,0.279068,0.776915,-0.273105,0.761072,0.520558,-0.194016,0.0959518,0.0987736,0.333033,-0.123175,-0.444339,0.720298,0.0298804,0.100148,-0.0307046,0.372501,-0.337701,0.224207,0.856012,-0.408756,-0.354086,0.592914,0.269155,0.326695,-0.199308,1.2087,0.812965,0.150212,1.48015,0.659206,0.227151,0.0326806,0.177525,0.0331634,-0.245036,0.572489,0.693856,0.598704,0.68886,0.181379,0.275759,-0.728577,1.02373,0.151559,-0.272201,-0.80681,0.299471,0.197883,-0.0467533,0.861738,-0.341338,-0.634832,0.57309,-0.0660337,-0.022597,-0.0880748,0.127867,-0.679321,0.19262,0.00861715,0.778548,0.534147,0.770533,0.50566,0.633018,-0.239392,-0.881995,-0.0346755,-0.365246,-0.214977,0.0225945,-0.196315,-0.146216,0.890455,0.263706,-0.0550804,0.368154,-0.121688,0.813709,-0.0399758,0.0757802,-0.293368,0.686136,0.633085,0.112088,-0.704975,0.62715,0.192535,-0.198689,-0.14305,-0.5331,-1.04078,0.492617,-0.0598226,-0.0989239,-0.110885,0.459743,0.549876,0.343024,-0.0335977,0.94074,0.538207,0.23789,0.164903,-0.0524457,0.461897,0.49875,0.378871,-0.265482,0.552845,0.0577831,-0.343851,0.0405198,0.615493,-0.660821,1.04035,-0.0673012,-0.330771,-0.133867,0.0992618,0.0923682,1.02838,-0.359687,0.349878,-0.100873,-0.507939,0.376725,-0.779252,-0.579195,0.113364,-0.0141253,-0.637583,-0.671097,-0.0856346,-0.382798,0.617978,-0.0446829,-0.0309926,-0.438865,0.335872,0.0498073,-0.605125,-0.0651272,0.210633,0.433529,0.367958,0.227846,0.385245,-0.108973,-0.0278936,0.69854,-0.387227,0.0855171,0.355271,-0.0686887,0.229325,-0.0794814,0.0279675,0.113545,0.88407,0.0575263,-0.390198,0.0285977,-0.0888386,0.0949499,0.0951045,-0.125663,1.13606,0.664155,-0.314052,-0.226653,-0.188325,-0.370459,-0.0511912,-0.0264291,-0.438403,0.424763,-0.529365,-0.13292,0.077492,-0.0632627,-0.169476,0.327196,0.604738,0.418011,-0.162914,-0.783758,0.179711,-0.175417,-0.205401,0.183435,-0.109132,0.316069,-0.262579,-0.621508,1.02352,0.216579,0.773151,0.265234,-0.0268228,-0.108092,0.274801,-0.467287,0.500508,-0.424545,-0.0556919,0.148533,0.0950285,-0.194064,-0.482825,0.410381,0.722214,-0.109137,0.573489,-0.088664,0.108578,0.174592,0.0976268,-0.817554,0.333788,-0.575397,0.288009,-0.184057,0.914361,-0.0129029,-0.293088,0.883831,-0.531325,-0.0154303,0.16438,-0.402524,0.741629,-0.0513086,0.0831965,-0.0956222,-0.0364382,0.117228,-0.256514,0.720348,-0.625039,0.195068,0.0480845,-0.0686917,0.284245,-0.494609,-0.65857,0.21734,-0.0111132,-0.00692815,0.254047,0.11321,-0.223257,0.493511,0.24916,0.245403,-0.169209,-0.154307,0.0424135,-0.384111,-0.0151907,-0.784701,-0.0456227,-0.0607006,0.205265,-0.335668,0.721533,0.461859,-0.00391952,-0.27603,0.00621615,0.12823,0.15306,0.260567,-0.269772,-0.175094,0.301521,-0.189083,0.130333,0.0472893,0.101918,0.569391,0.878744,-0.00974564,-0.56313,0.6199,0.259059,-0.253777,-0.0153385,-0.456912,0.156204,0.319242,0.395227,0.565015,-0.679259 +3416.92,0.960009,0.0848144,5,1.52026,0.656587,-0.939946,0.368116,0.0838929,-0.0174956,0.580278,-0.0576526,-0.0410318,0.344374,-0.00582502,0.151304,0.0127594,0.960364,-0.307065,0.500452,0.591253,-0.270413,-0.0516216,0.162074,0.445788,-0.314645,-0.864493,0.995144,-0.472078,-0.0883072,-0.121245,-0.209333,0.170556,0.0263047,0.339156,-0.506313,-0.189733,0.357177,0.0177487,-0.0444734,-0.0337961,0.281752,0.0991694,-0.598807,1.19789,0.467141,0.126195,-0.482905,0.250301,0.247879,-0.576192,0.163661,0.498147,0.161782,-0.0572583,-0.177222,0.028986,-0.379793,0.822394,0.117611,0.221461,-0.43176,0.336897,-0.297914,0.319664,0.855387,-0.497052,-1.16004,0.282536,-0.25706,0.077904,-0.618106,0.162013,-0.313234,-0.709541,0.137876,0.402415,0.448163,-0.0127138,0.583229,0.950296,0.310472,0.26537,-0.222189,0.81994,0.18698,-0.0532464,-0.364664,-0.239053,-0.301981,0.140949,-0.0532041,0.368826,0.131915,0.0281395,0.365043,0.0504616,0.175403,-0.114245,-0.40257,0.287254,0.472538,0.128419,-0.0175254,0.586831,-0.0357665,-0.129723,-0.375966,0.00311669,0.17002,0.232118,0.00143006,0.0120421,0.712674,0.0397474,0.578671,0.286068,0.590102,0.00382936,0.210912,-0.244451,0.039442,0.319142,-0.0853214,-0.0907815,-0.102263,-0.429441,-0.551059,-0.336031,0.539344,0.444415,-0.207041,0.524878,-0.295635,0.30149,-0.228121,0.226765,0.319334,-0.220668,0.0243626,-0.116848,0.408456,0.156877,-0.255858,-0.413769,-0.520198,0.146746,-0.631944,0.407446,0.0385119,0.0504881,0.294511,0.674768,0.0337147,-0.561895,0.092127,0.138027,-0.16483,-0.0534704,0.223316,-0.0517462,0.167336,-0.279673,-0.102954,0.83746,-0.317173,0.907508,0.690128,-0.25544,-0.152529,0.018314,-0.474938,0.200048,-0.0166476,0.703331,-0.140334,0.223412,0.227748,-0.183904,-0.240342,-0.456598,-0.0643732,0.575202,0.856682,-0.089534,-0.081462,0.688434,-0.0186959,0.316805,-0.217297,-0.288394,0.0937951,-0.165395,-0.386841,0.0398994,0.729018,0.352959,-0.409491,0.0737453,0.157005,0.380803,-0.66177,-0.560568,0.160402,-0.293262,0.241895,-0.0681886,0.284796,0.112592,-0.462733,-0.557705,1.57575,0.278978,0.395546,0.10087,-0.835319,0.250957,-0.33715,-0.187499,0.454895,-0.069609,0.0490432,0.26526,-0.00535429,0.0394648,0.000531298,-0.109658,-0.806231,-0.597117,0.404644,-0.957678,-0.108352,-0.298146,0.0294809,0.131223,0.110686,0.49262,0.0386244,-0.29667,0.372078,0.112033,0.134416,0.91402,-0.0471648,0.0575828,0.0911928,-0.0248391,0.0588013,0.434168,0.29514,0.2994,0.390885,-0.843578,-0.473961,-0.14033,-0.746585,0.439831,0.391754,-0.253681,0.42923,-0.179965,-0.0875774,0.128466,-0.615386,0.582626,0.57217,0.167883,0.335957,0.0293461,0.246966,0.322993,-0.116344,0.168322,0.187225,-0.168924,0.0109774,-0.297738,-0.0323576,0.441865,-0.0710838,0.0021559,0.0190343,0.454958,0.0508776,-0.658255,-0.11034,-0.124116,0.689476,0.0673852,0.225657,-0.194181,0.162047,0.641209,-0.707977,0.155979,0.188842,-0.438773,0.455759,0.221167,-0.555389,-0.195548,0.192185,-0.235487,0.164206,-0.830024,0.123958,0.208656,0.352076,0.456789,0.230065 +3418.89,0.784028,0.0848144,5,1.4396,0.780782,-1.14645,0.345874,0.166762,-0.00259061,0.0697157,-0.392427,0.166602,0.489124,0.200916,-0.156087,0.245222,0.795054,-0.444227,0.958417,0.173923,-0.335479,-0.0351282,-0.150705,0.111588,-0.511157,-0.632959,0.729507,-0.339302,-0.176736,-0.0446311,0.455585,-0.639314,-0.19133,0.586406,-0.736715,-0.178277,0.122989,-0.0132791,0.104012,-0.0345957,0.647425,0.255998,-0.407906,1.16599,0.212722,0.155873,-0.3486,-0.487065,0.381946,-0.430259,0.0182265,0.729332,0.290419,0.209522,0.451027,0.0272008,-0.903436,0.928395,0.0550585,0.134517,-0.534583,0.49893,0.0614068,0.222505,0.519598,-0.255077,-0.86138,0.0882749,0.117479,-0.152887,-0.185918,-0.0308299,-0.0619389,-0.216916,0.13206,0.481877,0.214661,0.0416601,0.576217,0.338192,-0.426499,-0.173589,-0.0169185,0.169142,-0.13314,0.017202,-0.212399,-0.378079,0.156993,0.312453,-0.422007,0.463366,-0.054675,0.0916491,0.246937,-0.0181023,-0.261916,0.435605,-0.447433,-0.0653657,-0.224194,0.443298,0.323012,0.0658475,0.10181,-0.429003,-0.04347,-0.707085,-0.382859,0.166819,0.108467,0.451734,0.792672,0.614092,-0.0807988,0.852063,0.390645,0.0525767,-0.31644,-0.192739,0.20018,0.398173,0.144164,-0.443819,0.409651,-0.398106,-0.0531428,-0.100999,0.761462,-0.187831,0.172709,0.307108,-0.577931,0.140119,-0.276582,0.44713,0.434056,-0.436851,0.154798,-0.244276,-0.175391,0.158715,-0.849597,-0.230783,-0.10273,-0.133944,-0.11695,0.417642,-0.159981,0.0135507,0.741147,0.282422,0.447206,-0.0209203,0.205339,0.0989633,-0.013039,-0.254824,0.688451,0.33497,0.248085,0.106302,0.00981249,0.344763,0.0331707,0.95732,0.199386,-0.168074,-0.376435,-0.134567,0.16375,0.533076,-0.0167639,0.312261,-0.561861,-0.0978033,-0.0825843,-0.138795,0.410235,-0.108426,0.156501,0.134113,0.719485,0.608787,-0.617465,0.00594252,-0.699953,-0.124305,-0.0720985,-0.415218,-0.091757,0.550926,-0.461523,0.0838848,0.150455,0.174532,-0.310168,0.518759,-0.311501,0.0928309,-0.49661,-1.11618,-0.0562142,-0.512021,0.0093685,0.385698,0.184818,0.287739,-0.209229,-0.524414,1.40573,0.620716,0.481076,0.59595,-0.563428,-0.0751633,0.610867,0.0728487,0.267965,0.279641,0.274612,0.476203,-0.404825,0.338905,0.265629,-0.532862,-0.397001,0.0447195,0.43397,-0.395719,0.322937,0.279912,0.260506,-0.247142,0.085362,-0.312741,-0.417868,-0.429113,0.896061,-0.215518,-0.000518943,0.533958,0.0145946,0.103183,-0.503069,-0.225145,-0.203163,0.613439,0.0355179,0.100996,-0.0969623,-0.217789,-0.26817,-0.00924598,-0.63381,0.395689,-0.57691,0.660833,0.380074,-0.209051,-0.396399,0.0964035,-0.117913,0.451839,0.19053,0.160985,0.448093,0.0821916,-0.0532345,0.346979,0.33308,0.13124,0.149047,-0.627341,-0.286255,-0.394025,-0.668256,0.415773,-0.0152025,-0.0886992,-0.142729,0.289761,-0.716021,-0.519052,-0.38662,-0.278095,0.048383,-0.123299,0.291087,0.591545,0.185329,0.239718,-0.640868,-0.155257,0.0753411,-0.29214,-0.0713367,0.0660706,-0.26769,-0.143828,0.127019,-0.421282,-0.296751,0.00585212,0.168637,0.187719,0.410654,0.433266,-0.219399 +3420.4,0.971053,0.0848144,5,1.50257,0.886108,-0.699834,0.218349,0.0403304,-0.00848923,0.399073,-0.0544104,0.776937,0.275938,0.00370158,-0.313973,-0.0417463,0.491033,-0.190193,0.753094,0.203424,-0.216369,-0.103572,0.485788,-0.0650198,-0.40582,-0.960558,0.465354,-0.444286,-0.194516,0.130394,-0.117869,0.143354,-0.148433,0.148515,-0.564265,0.187495,-0.163291,0.334276,0.109459,-0.433164,0.785943,0.361001,-0.323079,0.976244,0.349487,0.332017,-0.556461,-0.0472818,0.16365,-0.805647,-0.0880591,0.430037,-0.0207004,-0.404432,0.464249,0.131764,-0.507883,1.02936,0.12881,0.274953,-0.382431,0.457891,0.00385909,0.166988,1.31994,-0.520257,-0.306178,0.114037,0.268184,0.246533,-0.159031,0.323469,-0.272148,-0.0484325,0.657047,0.432734,0.0320637,0.316751,0.779353,0.273406,0.10104,0.0154178,-0.250591,0.452583,0.0227663,-0.0636154,0.0790601,-0.074901,0.0670922,0.416111,-0.348361,0.300153,0.216372,-0.0628763,0.00403429,0.337719,-0.0581027,0.14171,-0.23639,-0.0821421,-0.721174,0.16689,0.194092,-0.166228,-0.0308541,-0.25654,-0.296254,0.0112946,0.0676781,-0.121378,-0.0421228,0.484424,1.19054,-0.217038,-0.269478,0.538268,0.177119,0.195148,0.386773,-0.0100367,0.0853659,0.384887,0.0108809,-0.507608,0.303011,-0.310288,0.29375,0.0524047,0.664695,-0.128414,0.351691,0.198256,-0.743492,0.0647614,0.0410834,0.735478,0.59612,-0.168769,0.256057,-0.19049,-0.13526,0.35839,-0.542503,0.202303,-0.631172,0.400113,-0.481718,-0.143927,-0.212292,-0.13055,0.887881,0.607576,-0.246441,-0.618748,0.331119,-0.403904,0.0944818,0.211056,0.662028,0.177403,0.480526,0.275363,-0.0877963,0.228228,0.111045,0.96526,-0.0159187,-0.0697308,0.107235,0.0180702,0.189979,0.12183,0.261591,0.110853,0.144319,-0.155159,0.146326,-0.0372621,0.324317,-0.308999,0.446508,-0.0666606,0.733543,0.188151,0.455102,0.689299,-0.14405,0.121218,-0.466749,-0.23293,0.0803897,0.311152,-0.0851654,-0.100731,0.361577,0.0335424,-0.391058,-0.46312,-0.0427458,-0.311246,-0.0974526,-0.0255819,0.639906,-0.0122175,0.641526,0.0502653,0.0596223,0.0355112,-0.177387,-0.376566,1.57282,0.597922,0.00643838,0.302168,-0.648163,0.141401,0.0242496,-0.407908,0.738518,-0.421573,0.0785712,0.514985,-0.264152,-0.116353,-0.463081,-0.115041,-0.316481,-0.420629,0.351835,-0.482023,-0.137969,-0.0332193,0.439825,-0.15711,-0.288422,-0.151193,-0.486306,-1.08938,0.271076,-0.965265,-0.133545,0.793186,-0.393603,0.147277,0.46529,-0.63715,-0.065671,-0.435253,0.019823,-0.0749621,0.475882,0.310559,-0.404748,0.350281,-0.846326,0.327075,-0.158738,-0.00802876,0.182294,-0.268594,0.0442355,-0.0940832,-0.178859,0.38041,0.0369837,0.281284,0.298606,0.309801,0.38231,0.371396,0.461936,0.351677,0.971875,-0.522022,-0.364321,-0.240251,-0.0123577,0.401307,0.0610818,0.171189,-0.0307653,0.0997218,0.20097,-0.345742,-0.125668,0.0542391,0.519387,0.0343594,-0.0646958,0.105302,0.0897574,0.151427,0.0647438,-0.21078,-0.0584282,-0.192027,0.346489,-0.249919,-0.630106,-0.183588,-0.101957,-0.542303,-0.143942,-0.120332,0.129582,0.206537,0.359975,0.454463,-0.035166 +3403.52,0.979111,0.0848144,4,1.65323,0.823187,-0.405762,0.179202,0.858328,-0.0979318,-0.0956045,-0.231273,0.10758,0.201981,0.245324,-0.165046,-0.227331,0.333554,-0.36345,0.691716,0.665089,0.232004,-0.395008,0.0826301,-0.191705,-1.15515,-0.343943,-0.121174,0.161154,0.0995531,0.032486,0.686181,-0.275671,-0.0329137,0.393154,-0.615126,-0.317628,0.332723,0.0232194,0.114433,-0.543279,0.0698708,0.29584,-0.231787,0.553269,0.819803,0.10046,-0.35306,0.198582,-0.0373709,-0.536986,0.00579059,0.373762,-0.131889,0.0921294,0.246585,-0.136068,-0.286668,0.774705,-0.688429,-0.103097,-1.17186,0.163912,-0.807233,0.254795,0.714683,-0.849601,-1.4001,-0.716916,0.18931,-0.0067256,0.205142,0.137364,-0.601165,0.279244,0.0244129,0.448713,0.109048,0.973396,-0.175909,0.51665,-0.128948,-0.71902,0.381425,0.701971,-0.464054,0.51152,-0.414061,-0.520283,-0.269129,-0.327117,-0.0576551,0.646432,0.0957291,-0.19188,0.312423,0.2045,-0.618593,-0.203693,-0.19848,-0.00217054,0.357006,-0.0177836,0.485502,-0.00185993,-0.586884,-0.217569,-0.538372,0.0329345,-0.321712,0.927279,-0.480885,0.365253,0.391039,-0.0510838,0.140917,-0.271591,0.596226,0.0389881,-0.341854,-0.201061,0.157758,0.409346,-0.179568,-0.315464,-0.0612344,0.328289,-0.149868,-0.173107,0.0953842,0.423054,-0.302323,-0.0218773,0.41575,0.282908,-0.133811,-0.123103,0.610823,-0.36236,-0.251923,0.370044,-0.115468,0.592132,-0.563583,-0.779786,0.681654,-0.126649,-0.571433,0.176336,0.370514,-0.0679248,0.492982,0.209663,0.427934,0.449599,0.400999,0.179893,0.170414,0.404998,-0.0908758,0.440134,-0.246129,-0.035558,-0.130416,0.0720764,0.281997,0.0632314,0.150755,0.000996464,0.351738,-0.220136,-0.0499882,-0.057046,-0.4726,0.366629,-0.15056,-0.0925663,-0.807778,-0.199289,-0.0777297,-0.084059,-0.170093,-0.0884075,1.12077,0.0741739,-0.748158,0.195877,0.0840804,0.419691,-0.701812,-0.306889,-0.753388,0.217946,-0.224614,0.0748123,0.0111281,-0.00279502,-0.769637,0.5096,0.55366,0.313104,-0.161658,-0.798544,-0.576092,-0.00198834,-0.843517,0.41345,-0.365927,-0.11348,-0.504567,-0.0652763,1.1666,-0.144181,0.459619,0.282499,-0.0362798,-0.109957,0.637324,-0.372242,0.0211283,0.210398,0.372032,-0.158806,0.0750268,0.50141,-0.335399,-0.189627,0.697926,-0.39315,0.243354,0.264817,-0.0673821,-0.0360907,-0.2385,-0.298762,0.332552,0.0851904,0.00438944,0.318479,0.57156,0.864686,0.167911,0.600755,-0.237341,-0.87763,0.245759,0.191964,0.401878,0.865197,0.502713,0.629849,0.140392,-0.741586,-0.273761,-0.439469,-0.0644697,0.101729,-0.0617028,-0.367028,-0.0157042,-0.0692264,0.219687,0.440183,0.381024,-0.162326,0.406299,0.0856319,0.112064,-0.115777,0.0313064,0.579606,-0.535522,-0.0950246,-0.48806,-0.099683,0.0471683,-0.241354,0.385527,-0.605589,-0.35651,0.105868,-0.228112,-0.0528267,-0.134645,-0.0586993,-0.574213,-0.506612,-0.0842383,-0.268418,0.620958,0.0782853,0.166775,0.303492,-0.487515,-0.0237547,0.318688,0.379999,0.443131,-0.192845,0.311876,0.243473,0.116684,0.586941,-0.525191,0.15552,0.14706,0.329912,0.383484,0.57438,-2.58387 +3412.8,0.998693,0.0848144,4,1.64827,1.07419,-0.620351,0.289197,0.731532,-0.0734448,-0.0754183,-0.112336,0.447265,0.326496,0.526442,-0.573649,0.404552,0.360441,0.218915,0.614164,0.13314,-0.329361,-0.2401,-0.0800022,-0.504392,-0.75431,-0.605644,-0.367908,0.35962,-0.188256,0.113761,0.126832,0.10578,0.099577,0.430968,-0.924441,0.310165,0.0383953,-0.637518,-0.494408,0.173348,0.518546,0.0658982,-0.19192,0.972673,-0.114434,0.476038,-1.44793,-0.0171967,-0.024572,-0.556411,-0.254171,0.201863,-0.503901,-0.231634,0.562688,-0.0741544,-0.447842,0.34507,-0.107269,-0.412434,-1.46217,0.127473,-1.2003,0.200571,0.631745,-0.535414,-1.08105,0.236154,0.453577,0.215176,0.147572,-0.611914,-0.755391,-0.425419,-0.230022,0.393534,0.0840361,0.811556,0.523168,0.209564,-0.564533,0.00617557,0.0100925,0.733814,-0.405513,0.49398,-0.726259,-0.212412,-0.110293,0.126899,-0.443677,-0.280739,-0.161521,0.676412,0.486417,-0.0512556,-0.23448,-0.057579,-0.320577,-0.0054102,-0.164604,0.366753,0.183877,-0.336289,-0.455827,-0.395107,-0.114572,0.3301,-0.167637,0.033264,-0.212877,0.593762,0.342273,0.122166,0.220997,0.479812,0.152933,0.520083,-0.0761111,-0.401428,0.291584,0.434623,-0.522553,-0.606661,0.193696,0.144387,-0.225957,-0.387745,0.204518,0.39915,0.318182,-0.142456,-0.304121,0.0799389,-0.364692,-0.109394,0.668282,-0.496417,0.0455474,-0.0304319,0.202969,0.390429,-0.421145,-0.328449,0.0293476,-0.207751,-0.0216122,-0.324518,0.7423,-0.0297205,0.657685,0.0113828,-0.441805,-0.0488885,0.377941,0.164833,-0.22934,-0.0943439,0.345617,-0.398737,-0.148151,-0.151515,0.465108,0.461102,-0.463893,0.533984,-0.123471,-0.32752,-0.127065,-0.0563539,0.351367,-0.267468,-0.0213492,0.242667,0.30259,-0.0269302,-0.0368252,-0.0698029,0.182265,-0.608001,-0.0852375,-0.110072,0.5596,0.0204112,-0.359608,0.928618,0.404509,0.728781,0.109863,-0.192742,-0.699633,0.723452,-0.751251,-0.373074,0.261017,0.0499688,-0.526537,0.166769,0.898463,-0.311509,-0.148021,-0.536188,0.409319,0.343445,-0.436456,0.0454687,0.120496,0.0997769,0.384378,-0.512388,1.15082,0.013276,0.526212,0.0239936,0.0509128,0.308332,0.119045,-0.1994,0.638808,-0.306832,0.098886,0.532219,-0.421922,0.405379,-0.867218,0.118163,0.00634646,-0.517176,0.445385,-0.411689,-0.219469,-0.0677945,0.155447,-0.324374,-0.230376,-0.390242,0.016463,0.113299,0.420894,-0.149651,-0.289288,0.317371,-0.468239,0.249382,-0.110493,0.179755,0.319902,0.463785,0.0229049,-0.386799,0.144999,-0.654036,-0.234067,-0.304947,-0.235492,-0.144213,-1.20724,-0.237884,-0.11861,-0.0684382,-0.23642,-0.217972,0.207004,-0.267769,0.276471,0.135961,-0.359567,0.079454,-0.00385146,0.139631,0.175081,0.345601,0.143745,0.00928444,-0.729434,-0.0649781,0.223127,0.337865,-0.151464,0.357342,-0.0820937,0.577411,0.438763,-0.276615,-0.511395,-0.483601,0.10908,0.181834,-0.0844598,-0.1706,0.0324232,-0.249891,-0.194169,0.0851581,0.224704,-0.0637716,0.508124,-0.0578221,-0.239971,-0.427658,0.0292675,-0.45028,0.281412,0.161771,0.142782,0.197723,0.377865,0.444661,-2.60934 +3397.07,0.885601,0.0848144,5,1.65856,1.15545,-0.577828,0.176032,0.508826,-0.137998,0.048741,-0.120039,0.378975,-0.0169716,0.518659,-0.324089,0.224187,0.238991,-0.186064,0.764733,-0.071695,-0.209904,-0.0335916,-0.535092,-0.580497,-1.19826,-0.505556,-0.487965,0.548015,0.0148983,0.130168,0.241705,-0.0870434,-0.114486,0.347277,-0.671438,-0.116054,0.100628,-0.64744,-0.334503,-0.225501,0.324283,0.579058,-0.0669222,0.607826,0.0975026,-0.401625,-0.879201,0.0924555,0.264134,-0.86322,0.144319,0.111118,-0.254491,-0.0337219,0.0785422,-0.0419194,-0.682264,0.48658,-0.213837,-0.284013,-1.18518,0.14974,-0.55877,0.508986,0.864225,-0.436364,-1.00508,-0.158997,0.539929,0.502598,0.279969,0.255317,-1.06599,-0.50419,-0.17638,0.379308,0.091263,1.04618,0.259833,0.168675,-0.614934,-0.313334,0.231115,0.47465,-0.328021,0.471293,-0.785247,-0.390029,0.233345,0.641758,-0.459065,-0.125204,-0.371189,0.748692,0.121613,-0.0450228,-0.463777,-0.289047,-0.424319,0.426789,0.167786,0.343711,0.190246,-0.0146037,-0.544586,-0.0896019,-0.37871,0.0473894,-0.216,0.739008,-0.25967,-0.0796845,0.570658,0.17539,0.0966344,0.196489,0.20905,-0.0734531,0.00746256,-0.1063,0.109103,0.181119,-0.256447,-0.536612,0.486292,0.356846,-0.15095,-0.521151,0.332848,0.299479,0.866659,-0.90554,0.164585,0.4531,-0.299567,0.110619,0.56187,-0.32626,-0.248621,0.425057,0.0427717,0.426852,-0.398741,-0.376106,0.243489,-0.511026,-0.161317,0.0698253,0.903189,0.321319,0.505034,-0.0888363,-0.820389,0.114569,0.415353,0.575839,0.0351959,-0.271771,0.489516,-0.388274,-0.386523,0.198991,0.199597,0.829153,-0.473682,0.614247,-0.0649722,-0.166003,0.33594,0.304891,0.182347,-0.337524,-0.420599,0.569367,0.319457,-0.38965,-0.58239,-0.0307846,0.0934417,-0.325909,0.576215,-0.145954,0.643876,-0.0722123,0.172432,0.684194,0.10702,0.39418,-0.276201,0.25612,-0.623332,0.783316,-1.06851,-0.287323,-0.259185,0.272194,-0.417586,0.155652,0.431719,0.341697,-0.0999272,0.0471296,0.177826,0.19164,-0.708519,0.0230829,0.255448,0.600582,0.476263,-0.126243,0.991613,0.102575,0.45451,0.132835,-0.179936,0.283594,0.334153,0.0552839,-0.00810697,-0.211136,0.291606,0.519189,-0.196448,0.316704,-0.732736,0.229085,0.197122,-0.465884,0.281366,-0.412323,-0.0658224,0.399126,0.0843528,0.0228144,0.0830938,-0.12961,0.149845,-0.481073,0.62369,-0.221695,0.0555449,0.361183,0.275344,-0.307772,-0.0487683,0.27227,0.377257,0.491876,0.040692,-0.604867,0.161838,-1.16906,-0.461008,-0.319077,-0.82915,0.120086,-0.545795,-0.501217,0.0458225,-0.325985,0.412449,0.453225,0.271543,-0.448952,0.441723,-0.189137,0.00798766,0.111048,-0.370635,0.452654,0.108489,-0.0110826,0.0463023,-0.197992,-0.337919,-0.383012,0.318512,0.433996,0.231585,0.0656448,-0.121591,0.43084,0.666157,-0.421636,-0.666962,-0.455103,0.0501483,-0.109564,-0.0352553,0.277806,0.210919,-0.342357,0.567895,-0.00957307,-0.014777,-0.0471619,0.106279,0.494736,0.0250736,-0.152485,-0.0203238,0.3882,0.574792,0.283288,0.158452,0.415774,0.39806,0.644805,-1.90227 +3392.84,0.923734,0.0848144,4,1.66418,1.16286,-0.676279,0.210362,0.612794,-0.110904,0.0127712,-0.111555,0.381752,-0.0448997,0.504549,-0.334212,0.188627,0.318699,-0.187371,0.727133,0.00475924,-0.240187,0.091375,-0.552934,-0.528303,-1.07688,-0.558622,-0.513246,0.455533,0.0351303,0.271324,0.290927,-0.163926,-0.107956,0.290733,-0.666586,0.00154121,-0.0010076,-0.691569,-0.418878,-0.213101,0.290017,0.59143,-0.146291,0.578829,0.204097,-0.371096,-0.950889,0.16926,0.393226,-0.853688,0.00964788,0.189252,-0.300916,0.0481924,0.00977504,0.0174864,-0.632509,0.405313,-0.245107,-0.346345,-1.23874,0.119109,-0.516433,0.399242,0.926035,-0.547187,-1.07051,-0.273473,0.542766,0.50938,0.273828,0.419849,-1.18311,-0.489155,-0.113506,0.328215,-0.072575,1.05904,0.292038,0.236275,-0.596274,-0.34304,0.155564,0.388926,-0.231246,0.409336,-0.710053,-0.363637,0.144144,0.563146,-0.584279,-0.164676,-0.350432,0.759302,0.077071,-0.00577571,-0.438409,-0.316177,-0.582687,0.494904,0.18009,0.311966,0.253154,0.0461345,-0.473633,-0.0488665,-0.45529,-0.0468245,-0.237257,0.708247,-0.195579,-0.128233,0.71823,0.112659,0.202804,0.11894,0.247139,-0.122555,0.0019054,-0.190752,0.0191722,0.0736808,-0.254324,-0.574598,0.34546,0.35995,-0.225929,-0.452822,0.410695,0.342871,0.965255,-0.994133,0.243799,0.440568,-0.380279,0.0525958,0.640538,-0.169254,-0.375726,0.430797,0.0817146,0.471502,-0.331259,-0.305152,0.157516,-0.593167,-0.204724,0.101203,0.878827,0.192348,0.478184,-0.0754358,-0.714081,0.0417003,0.30235,0.592803,0.127539,-0.366526,0.397076,-0.374574,-0.458009,0.126956,0.149946,0.90925,-0.532048,0.636568,0.0823957,-0.305453,0.386089,0.389382,0.041318,-0.252354,-0.404995,0.518866,0.364773,-0.387319,-0.475873,-0.0667866,0.0892642,-0.267536,0.579677,-0.152854,0.611577,0.00890596,0.146785,0.575774,0.365707,0.352245,-0.304277,0.298007,-0.532867,0.935635,-0.985672,-0.378095,-0.269804,0.210881,-0.48932,0.339498,0.432255,0.430191,-0.0807098,-0.105288,0.316422,0.208505,-0.674581,0.0758959,0.182987,0.596512,0.612089,-0.0339024,0.942633,0.0951557,0.687468,0.0961874,-0.20932,0.206962,0.277467,0.0136485,0.00689141,-0.273694,0.335686,0.4742,-0.246793,0.299057,-0.689015,0.206193,0.162065,-0.45629,0.318822,-0.451451,-0.0968447,0.512047,0.067489,0.0108479,0.107577,-0.0586095,0.0128408,-0.498308,0.70959,-0.207178,-0.0925963,0.367496,0.26963,-0.280262,-0.105181,0.25954,0.298697,0.522643,0.0557414,-0.671566,0.14519,-1.15455,-0.472494,-0.250995,-0.723979,0.0264748,-0.544772,-0.500699,-0.0151374,-0.36753,0.384852,0.291771,0.237305,-0.358292,0.467596,-0.165136,0.152536,0.0494895,-0.256578,0.353685,0.19757,0.147068,0.128426,-0.21505,-0.36906,-0.445729,0.362614,0.449621,0.311512,0.0489228,-0.0649988,0.404103,0.725572,-0.453,-0.595545,-0.41296,0.155692,-0.172467,0.0165337,0.286061,0.46138,-0.322515,0.693428,0.00353066,0.0575194,-0.0732116,0.0267258,0.391043,-0.0230907,-0.0740848,-0.0366354,0.268984,0.54422,0.127768,0.155215,0.389806,0.393974,0.624344,-2.24249 +3388.69,0.745578,0.0848144,4,1.66084,1.1303,-0.708307,0.23246,0.603516,-0.0975407,-0.097889,-0.0562484,0.470286,-0.056691,0.506535,-0.308541,0.194475,0.359778,-0.203577,0.74341,0.0636126,-0.192226,0.103955,-0.612093,-0.59182,-1.10721,-0.572533,-0.574547,0.500457,0.0394606,0.312255,0.362779,-0.146881,-0.102075,0.312575,-0.640824,0.00718215,0.0225023,-0.660942,-0.340664,-0.324903,0.323583,0.522881,-0.141904,0.624045,0.21908,-0.399209,-0.901324,0.190823,0.433334,-0.911724,0.0433949,0.175068,-0.292126,0.0343414,-0.0676231,-0.0540615,-0.616432,0.350637,-0.370237,-0.432913,-1.18176,0.0851634,-0.564143,0.382937,0.878083,-0.419974,-1.16021,-0.260634,0.575879,0.580064,0.253623,0.353256,-1.25082,-0.38608,-0.153777,0.283898,-0.0825953,1.11673,0.227798,0.142707,-0.659007,-0.370241,0.150437,0.39287,-0.287059,0.433514,-0.660646,-0.332018,0.0556196,0.468516,-0.437659,-0.136485,-0.373544,0.723868,0.163895,0.0217277,-0.494189,-0.307165,-0.581926,0.5408,0.157292,0.289825,0.271808,0.0690842,-0.423702,-0.0293919,-0.414931,0.0611338,-0.244491,0.715049,-0.247074,-0.149664,0.663862,0.0753818,0.193768,0.0455897,0.237232,-0.0595862,-0.0487591,-0.178606,0.00673302,0.132591,-0.215318,-0.521544,0.342937,0.42565,-0.24391,-0.471416,0.50338,0.287871,1.08191,-0.984744,0.334264,0.42261,-0.312148,0.00910808,0.633134,-0.179897,-0.350736,0.463924,0.088898,0.467561,-0.363321,-0.256268,0.205413,-0.60795,-0.184543,0.189042,0.920998,0.223339,0.48334,-0.0523326,-0.689171,0.0119954,0.320942,0.63863,0.193788,-0.287447,0.333075,-0.329396,-0.422215,0.118145,0.0798203,0.823115,-0.578657,0.654036,0.106645,-0.294374,0.417387,0.339501,-0.0562056,-0.172155,-0.307785,0.57405,0.308829,-0.41038,-0.519386,-0.0424338,0.180654,-0.22399,0.578306,-0.112633,0.633729,-0.0235228,0.222502,0.631447,0.343374,0.312061,-0.281719,0.304884,-0.523575,0.93112,-0.909257,-0.379262,-0.356204,0.219789,-0.517038,0.396875,0.43518,0.415627,-0.0581851,-0.0608847,0.24877,0.26053,-0.596748,0.078953,0.153104,0.539931,0.6617,-0.0554339,0.995407,0.122424,0.677057,0.0651187,-0.181057,0.130358,0.298057,-0.0174204,0.0598298,-0.350064,0.345901,0.483319,-0.182504,0.315215,-0.655189,0.119681,0.201596,-0.441182,0.295227,-0.441408,-0.0597079,0.496492,0.141425,0.0255104,0.127385,-0.0182914,0.0614473,-0.473709,0.724341,-0.325013,-0.0168858,0.351392,0.349639,-0.43146,-0.0647331,0.184351,0.362451,0.564699,0.0602529,-0.619865,0.0926488,-1.11511,-0.515108,-0.215003,-0.783481,0.000677896,-0.545791,-0.484777,-0.0399669,-0.325212,0.375215,0.267139,0.259039,-0.377512,0.418542,-0.146692,0.209029,0.0830813,-0.185017,0.35207,0.186666,0.0233571,0.10547,-0.23495,-0.256179,-0.557099,0.45485,0.513139,0.276894,0.0903869,-0.0349426,0.442587,0.733955,-0.415319,-0.647491,-0.419926,0.0508759,-0.16904,0.0256415,0.309635,0.46911,-0.298797,0.703168,0.0465821,0.165655,-0.0325808,0.0789498,0.373631,-0.0630066,-0.0849939,-0.0685258,0.243619,0.503088,0.118374,0.153111,0.410773,0.391294,0.640915,-2.16494 +3439.29,0.802355,0.0848144,4,1.64403,1.30033,-0.0583667,-0.0430081,0.603087,-0.0957479,0.424435,-0.158186,0.727782,-0.394433,0.195967,-0.412138,-0.0713132,0.174173,0.0172601,0.587618,-0.00314161,-0.68686,0.199132,-0.0852917,-0.628647,-1.12199,-0.764944,-0.583569,0.639942,-0.011066,-0.101168,0.771883,-0.47457,-0.00603577,0.539735,-0.399348,0.100591,-0.0487925,-0.558304,-0.334971,-0.643249,0.399882,0.449558,-0.509338,0.929644,0.597054,-0.75774,-0.956108,-0.253992,0.11202,-0.788996,0.113118,0.324435,0.10321,-0.464145,0.321183,-0.468539,-0.436819,0.405326,-0.304264,-0.0818432,-0.634761,0.00701389,-0.699947,0.36002,0.808327,-0.785387,-1.00407,-0.0419691,0.511069,0.209712,0.408161,0.130178,-0.445397,0.208836,0.180898,0.410014,-0.296164,0.916727,0.100565,0.417686,-0.261526,-0.284748,-0.264991,0.211005,-0.0968561,0.491895,-0.556864,-0.203582,-0.0124935,-0.287566,-0.155163,0.0258672,-0.319023,0.450361,-0.490592,0.135661,-0.435566,-0.427605,-0.554388,-0.34775,-0.488889,-0.117839,0.0978389,-0.472867,-0.166574,-0.25978,-0.33885,-0.173405,0.174704,0.411823,-0.341165,0.107237,0.50903,-0.0433033,0.40144,0.510349,0.319698,-0.50638,0.00806992,-0.599712,-0.0272733,-0.129951,-0.249999,-0.79975,-0.0256296,-0.411973,0.164889,-0.245807,0.411368,0.259849,0.233031,-0.0976344,-0.115504,0.192184,-0.227631,-0.216385,0.784578,-0.447386,-0.261649,-0.22546,0.222075,0.207878,-0.578501,0.109786,0.317327,-0.583203,-0.449477,0.597762,0.483137,0.181377,0.55327,-0.461012,-0.293569,-0.165981,0.209697,0.468493,0.101118,0.537516,0.31566,-0.051779,-0.0841689,-0.0167319,-0.127767,0.28701,-0.137334,0.524595,0.103643,-0.0180792,0.30583,-0.253641,-0.278187,-0.218912,-0.370484,0.455809,-0.0662776,0.0240491,-0.838861,0.14911,-0.180318,0.0821819,0.371312,-0.0516396,0.855344,0.331324,0.177423,0.76018,-0.0283528,0.255133,0.137058,-0.0993874,-0.769974,0.56921,-0.342133,-0.035473,-0.363118,0.27312,-0.732489,0.232273,-0.0173787,0.112797,-0.431696,-0.335772,0.34973,0.137698,-0.605236,-0.00572864,-0.0211356,-0.0588499,0.160088,0.000883154,0.743903,0.0404549,0.743098,0.0461217,0.141549,0.204647,-0.236532,-0.637977,-0.179538,-0.344545,-0.00665896,0.399465,-0.332176,0.376908,-0.664611,-0.0296169,0.484598,-0.226679,0.127456,-0.154888,-0.135763,0.513157,0.386182,0.0647727,-0.0437525,-0.352562,-0.171788,0.0539154,0.570814,0.299928,-0.285614,0.470866,-0.52406,-0.606244,-0.0932624,-0.0040882,0.107311,0.73186,0.420157,-0.0150489,0.182095,-0.436595,-0.572832,0.235769,-0.512621,0.239679,-0.0843085,-0.855815,-0.0400007,-0.153484,0.163583,0.410615,0.189286,-0.430102,0.170158,-0.0989778,0.227511,-0.181824,0.207217,0.110471,-0.114472,0.27659,-0.0186444,0.184801,-0.0907091,0.039679,0.000657249,0.275727,-0.0436053,0.113759,0.680802,0.0452182,-0.102296,-0.475423,-0.00855673,-0.439125,-0.130349,-0.0150547,-0.392711,-0.0272216,0.381459,0.0691987,-0.113195,0.00104652,0.352661,0.188892,0.200713,0.124652,-0.397582,-0.555486,-0.108775,-0.288187,-0.556121,-0.0293934,0.149872,0.259828,0.387133,0.509734,-2.56162 +3430.13,0.945457,0.0848144,4,1.67306,1.31668,-0.0158982,-0.0511698,0.491681,-0.0433322,0.498209,0.074647,0.971905,-0.285185,0.159938,-0.374166,-0.0555978,0.353054,0.0347241,0.702004,0.110069,-0.657704,0.353421,-0.0627094,-0.52308,-1.32798,-0.485014,-0.628401,0.579652,-0.132299,-0.136477,0.530628,-0.428906,0.168171,0.476304,-0.414724,0.0927621,-0.1574,-0.494162,-0.252394,-0.472106,0.385793,0.54457,-0.286932,1.06254,0.697826,-0.758482,-1.12075,-0.267753,0.037848,-0.628791,0.116905,0.388439,0.26302,-0.55645,0.320063,-0.462628,-0.675126,0.309735,-0.156473,-0.0909222,-0.637865,-0.111424,-0.46943,0.303927,0.640978,-0.59692,-0.995484,-0.0375684,0.296651,0.278259,0.476881,0.0520115,-0.576901,0.216208,0.180667,0.245494,-0.0536839,0.818399,0.0327185,0.413058,-0.43188,-0.180691,-0.0620488,0.00484479,-0.0915267,0.312781,-0.641206,-0.304081,-0.0755169,-0.184808,-0.0501327,-0.0508215,-0.459632,0.529133,-0.518284,0.252002,-0.267095,-0.295227,-0.584714,-0.274682,-0.259606,-0.0431442,0.0896671,-0.295288,0.0833668,-0.269663,-0.13955,-0.335892,0.081579,0.422204,-0.422274,0.0305457,0.714497,0.0274874,0.253388,0.183773,0.369773,-0.498422,0.156288,-0.415677,0.0332243,-0.160382,-0.33915,-0.761706,-0.0922639,-0.186405,-0.0165041,-0.296888,0.318938,0.178015,0.132012,-0.11551,-0.197735,0.246273,-0.268811,-0.183525,0.805898,-0.395866,-0.271221,-0.421921,0.202456,0.100993,-0.65705,0.0983708,0.347244,-0.386553,-0.407457,0.709671,0.594526,0.263472,0.470687,-0.504313,-0.348488,-0.201792,0.198289,0.390242,0.0975835,0.740156,0.228303,-0.00839563,-0.0562263,-0.00443652,0.0311582,0.38135,-0.268274,0.391401,0.190304,0.173375,0.288146,-0.458659,-0.171743,-0.175234,-0.318083,0.367171,0.0140781,-0.00450446,-0.970574,0.207121,0.0168586,0.108936,0.249002,0.061752,0.723501,0.205018,0.126132,0.673016,-0.125788,0.412434,0.416367,-0.37126,-0.642222,0.397317,-0.303505,0.0870247,-0.362976,0.0833299,-0.764679,0.0763172,-0.0576964,-0.0887882,-0.393933,-0.468116,0.371578,0.13205,-0.494357,-0.0939455,-0.110791,-0.193229,0.0608052,-0.0925053,0.689027,-0.165483,0.690058,0.0348874,0.00998677,0.166836,-0.213269,-0.370383,-0.272475,-0.302024,-0.105288,0.187583,-0.395408,0.386833,-0.670314,-0.1533,0.20799,-0.580171,0.113483,-0.0178201,-0.0999086,0.670885,0.431402,0.0478768,-0.115554,-0.343809,-0.124137,-0.079518,0.652512,0.352746,-0.288308,0.554697,-0.583106,-0.444457,-0.136951,-0.20403,0.374543,0.803813,0.302739,-0.0244194,0.185712,-0.308663,-0.485128,0.16738,-0.555679,0.135475,-0.10596,-0.58272,-0.0973155,-0.242465,0.0440141,0.395101,0.153126,-0.352731,0.282529,0.053894,0.108604,-0.215345,0.214812,0.298868,-0.0632024,0.415442,0.211961,0.227625,-0.0757338,-0.016515,0.218375,0.215142,-0.0141363,0.0759062,0.361758,-0.0779119,-0.0309348,-0.301261,0.302222,-0.543595,-0.042063,-0.157071,-0.236875,-0.0999307,0.236901,0.0200524,0.0638412,0.0292975,0.441894,-0.0141573,0.129147,0.149922,-0.213005,-0.621704,-0.154512,-0.123632,-0.605438,0.0085869,0.139011,0.226135,0.372842,0.475537,-2.21932 +3453.64,0.961529,0.0848144,5,1.65913,0.813933,-1.22785,0.583628,0.727183,-0.111247,-0.140582,0.0609023,0.0173324,0.668663,0.319834,-0.0882125,-0.0512009,0.159156,-0.308573,0.745193,0.0594192,-0.172031,-0.511451,0.0283212,-0.070368,-0.915121,-1.1048,0.313132,-0.580448,-0.0777758,0.137398,0.290111,0.126681,0.189814,0.871019,-0.314079,0.33478,0.69409,-0.505109,-0.180761,-0.0723206,0.638981,0.297954,-0.551951,0.622999,0.307569,0.598235,-0.634648,-0.293984,0.045197,-0.442257,-0.163993,-0.217499,-0.226665,-0.285597,0.110203,0.190017,-0.0393372,0.271956,-0.640334,-0.537176,-1.13617,0.50205,-0.424042,-0.0025576,0.890559,-0.692313,-1.14564,-0.300265,-0.00929058,-0.324287,-0.491668,0.167356,-0.330815,-0.201179,0.275182,0.651573,-0.214897,0.261562,0.498035,0.165953,0.355729,-0.171087,-0.0458213,0.36261,-0.298857,0.0102143,0.175914,-0.00581868,0.128142,0.245019,-0.179814,0.160435,-0.466041,-0.4066,0.579815,-0.300662,0.431496,0.227846,0.0690877,0.265598,-0.071857,0.22209,0.525152,0.382971,-0.344845,-0.195257,-0.321839,0.539122,-0.584422,-0.0687526,-0.154007,0.396403,0.00882447,-0.0871641,-0.595632,-0.102687,0.319438,0.437539,0.193387,0.0542392,-0.184741,0.391322,0.0435308,-0.303773,0.0430403,0.146349,-0.269158,0.256189,-0.0676965,0.147538,0.0816525,0.245847,-0.155241,-0.0599304,0.248576,0.231819,0.210311,-0.111294,-0.342196,0.31074,-0.455217,0.366,-0.254079,-0.532755,-0.48021,0.183121,-0.35232,-0.488169,-0.312715,-0.316756,0.0725545,-0.0870537,0.250014,-0.0565989,-0.292289,0.0282926,-0.211826,-0.535046,0.254289,0.25429,-0.000386804,0.268266,-0.116653,-0.338872,0.252154,0.573896,-0.23122,-0.340401,-0.129422,0.310149,-0.123756,-0.190615,0.320717,-0.274388,-0.100801,0.00419458,0.732849,-0.0848346,-0.0337357,-0.663215,-0.478223,-0.0693133,0.303096,-0.0856103,-0.261759,-0.482429,0.0761822,-0.498449,-0.829347,0.051019,-0.090779,0.092775,-0.23924,0.016525,0.433231,0.105041,-0.301156,-0.0832065,0.228802,0.254926,-0.192724,-0.357707,-0.260325,0.00152185,-0.123909,0.185408,0.144839,0.277297,-0.107136,-0.568477,0.899127,0.262461,-0.430393,-0.169356,-0.0588224,-0.096495,0.292016,0.0841936,0.687166,-0.0104479,0.490247,0.142667,-0.139419,-0.294936,-0.149631,0.120222,-0.0845454,0.0829067,0.406293,-0.56302,-0.403587,-0.560334,-0.631317,-0.288409,-0.124464,-0.0193726,-0.00316262,-0.250828,0.085872,-0.404509,0.0899427,0.333299,0.11661,0.322608,0.243064,0.249683,-0.346794,-0.301827,0.0361206,0.485136,0.292882,0.227446,0.0688097,-0.17781,-0.0777292,0.378585,-0.256194,0.309983,0.546621,-0.301543,-0.0470205,-0.234111,0.253089,0.412426,0.109605,0.0934249,0.204148,0.541647,0.0457949,-0.470233,-0.00984648,-0.472514,-0.214939,-0.234681,-0.261686,-0.319697,-0.0881119,-0.132147,0.0975046,0.269412,-0.366178,0.150287,0.231198,0.00239017,-0.560878,0.12143,0.159663,0.293777,0.45107,0.0394254,0.13237,0.0413307,-0.260423,-0.116415,-0.373128,0.349218,0.265186,-0.388109,-0.292855,0.390687,0.123926,-0.0463504,0.441336,-0.0715492,0.0799517,0.266167,0.282757,0.515914,-2.0745 +3448.19,0.926308,0.0848144,4,1.54982,0.900227,-1.16993,0.469667,0.67612,-0.0842735,0.192014,0.295537,0.250969,-0.126798,0.166836,-0.284509,-0.330115,0.409332,-0.240972,1.4548,0.139911,-0.0339873,0.245297,-0.232773,-0.131071,-0.689851,-0.35928,0.167959,-0.308144,-0.293728,0.0586181,0.551352,-0.432459,0.197249,0.716206,-0.635913,-0.254223,0.248553,-0.444179,-0.419631,-0.866757,0.847377,0.677053,-0.398269,0.880361,0.513967,0.290543,-1.17331,-0.26084,0.211016,-0.318274,0.471915,0.594157,-0.0535203,0.341759,1.09593,-0.193078,-0.74945,0.572664,0.157221,-0.293055,-0.726344,0.20379,-0.627003,0.134639,0.44769,-0.49192,-0.809346,0.331805,0.203897,-0.180841,0.68854,-0.378276,-0.0158057,0.0372384,0.398276,0.381719,0.106536,0.00766864,0.176953,0.475913,0.1971,-0.0841902,0.126796,0.407197,-0.212751,0.172969,0.134364,0.0409304,-0.258506,-0.0831226,-0.295186,-0.101669,-0.190368,0.104559,-0.234815,0.0772805,-0.187974,0.00428072,0.0869132,-0.046235,-0.0866226,0.215847,0.370489,0.310422,0.0466629,-0.511649,0.0244496,-0.307763,0.162559,0.480043,-0.436114,0.230343,0.373681,-0.12812,0.355921,0.638851,0.130988,-0.334754,0.193313,-0.344326,0.364081,0.138949,0.213631,-0.206047,0.0190289,-0.0731912,0.266406,-0.396258,-0.204063,-0.111668,-0.154782,0.166511,-0.356195,-0.0822028,-0.2203,-0.302724,0.112609,-0.176229,0.228963,-0.263923,-0.0974201,0.198537,-0.447407,0.219956,0.269656,-0.0194119,-0.0206727,0.609305,0.11074,-0.198322,0.340168,-0.247195,-0.270347,0.215963,0.0906963,0.306757,0.108138,0.860203,-0.0969599,0.148227,0.102891,0.293931,-0.101914,0.438354,-0.107148,0.42672,0.165563,0.169232,0.0395346,-0.418018,0.180062,-0.26531,-0.262318,0.472837,-0.0455282,-0.31168,-0.598659,0.0367086,-0.259136,0.204003,0.124518,0.265607,1.1759,0.155595,-0.0681951,0.706273,-0.263729,0.311084,0.38346,-0.335794,-0.0488392,0.277509,-0.157296,-0.0404333,-0.516503,-0.411075,-0.603756,0.260419,0.0469136,-0.00819674,-0.312789,-0.456872,0.22123,-0.237145,0.196167,0.411581,-0.214703,-0.205727,-0.126878,-0.242765,0.713916,-0.423693,0.737471,-0.0153808,-0.366466,0.294664,0.0620571,-0.380467,-0.479062,-0.551498,0.249742,0.35704,-0.0872941,0.401895,-0.257551,0.19444,0.245188,-0.446743,0.0687643,0.0337778,-0.176015,0.709615,0.72502,0.0502715,0.00307541,-0.280295,-0.0831638,-0.384298,0.702202,0.379314,0.0342758,0.887707,-0.436613,-0.523858,-0.0557694,-0.239816,0.157405,0.930482,-0.244983,0.425091,-0.0288211,-0.319213,-0.560126,0.336051,-0.794219,0.151954,0.0600244,-0.70866,0.0481027,-0.0277016,0.154869,0.323647,-0.27701,0.0303282,0.54075,-0.0606812,-0.0217848,-0.344241,0.199985,0.324849,-0.213751,0.192799,0.00789579,-0.0293603,0.155574,0.291136,0.0281126,0.417666,0.411538,0.446326,-0.472495,0.202267,-0.145763,-0.179971,0.42902,-0.563322,-0.247282,-0.111965,0.157237,-0.377978,0.112447,0.302716,-0.165154,0.0644166,0.371026,0.209099,0.0158943,0.144494,-0.147474,0.0314218,0.135683,-0.153987,-0.55822,0.0513678,0.090259,0.220349,0.300431,0.469414,-2.09596 +3433.98,0.621288,0.0848144,4,1.59003,0.815447,-1.20722,0.584107,0.503273,-0.100728,0.104382,-0.262739,0.233354,0.843247,-0.451267,-0.28124,-0.0118385,0.342807,-0.144764,0.590087,0.10952,-0.0195374,-0.121781,-0.0337094,0.12197,-0.657105,-0.918669,0.418644,-0.296869,0.0570426,-0.317218,0.466925,0.124394,-0.0170157,0.747368,0.00777763,-0.484475,0.244806,-0.48766,-0.134649,-0.521363,0.317118,0.370037,-0.611461,0.52485,0.906489,0.434128,-0.568848,-0.076021,0.476672,-0.859139,-0.0648448,-0.260438,0.186468,-0.133437,-0.303994,-0.406679,0.0703084,0.425008,-0.0928588,-0.348201,-0.525423,0.0574109,-0.402508,0.608353,0.777781,-0.748828,-1.00347,-0.339725,-0.296007,0.478234,-0.313321,-0.177431,-0.0737753,-0.00992744,0.441726,0.642502,0.275749,0.32409,0.414392,0.215242,-0.341318,-0.219383,-0.271703,0.13991,-0.353787,0.052693,-0.220887,0.158339,-0.199592,-0.0850316,-0.200704,0.531957,-0.40566,0.198335,0.21084,0.0609413,-0.186732,0.0749185,-0.0261563,0.122842,-0.212112,-0.0394833,0.593548,-0.446877,-0.137921,-0.0258233,-0.709959,0.484604,-0.643094,-0.0102244,-0.195511,-0.0389994,0.397043,0.545377,-0.370705,0.190492,0.257513,-0.00858935,-0.0883954,-0.0124774,0.297166,0.166502,-0.446931,-0.625503,-0.1595,-0.246039,-0.320297,0.488661,-0.0669437,0.104603,-0.240682,0.312627,-0.0607739,-0.130126,0.0524344,0.326519,0.552427,-0.258388,-0.388063,0.47777,0.0917335,0.364806,-0.879181,-0.747578,-0.362177,0.648073,-0.332382,-0.273601,0.255608,-0.4556,0.00527968,-0.00599557,-0.570044,0.0186836,0.182143,0.103692,-0.260271,-0.0612592,0.728942,0.159202,0.325342,0.291134,0.12931,0.20842,0.295726,0.823121,-0.278597,0.0934179,-0.0943489,0.423846,-0.360384,-0.290072,-0.11805,0.43683,0.377349,-0.144644,-0.0170124,-0.148357,-0.144658,-0.383593,-0.0624723,0.165656,0.699,-0.0885157,-0.289284,0.241086,-0.337255,-0.346524,-0.741304,0.0582709,-0.0483811,0.542443,0.0716195,-0.0631811,0.284954,-0.265829,-0.326577,-0.0933439,0.383374,0.282388,-0.326353,-0.301718,0.176615,-0.113602,-0.438551,-0.0751953,0.141883,-0.588959,0.256393,-0.585044,1.0654,-0.147519,0.397894,0.289289,-0.0953594,0.223208,0.371345,-0.15607,0.709993,0.229807,0.487568,0.0875515,-0.666995,-0.0869539,-0.308685,-0.0578176,0.265519,-0.178384,0.566718,-0.755075,-0.525031,-0.327203,0.19158,-0.360122,-0.270346,-0.104415,-0.126798,-0.290994,0.819141,0.0324609,-0.140267,0.826737,-0.102206,0.10651,0.100981,0.231552,0.294572,-0.303224,-0.121485,0.815582,0.178993,0.347521,-0.345867,-0.388477,-0.164301,0.392419,-0.137848,-0.283447,0.665103,-0.467858,0.109586,-0.570765,0.094288,0.283937,0.148871,-0.153259,0.230818,0.348052,0.232919,-0.402592,0.158464,0.0555336,0.278054,-0.0531773,-0.428672,-0.247235,-0.116816,-0.23256,0.31981,0.299778,-0.268372,0.143235,0.169047,0.0745666,-0.0484513,0.639053,0.0262983,0.1583,-0.119471,-0.213391,-0.230687,0.125226,0.141297,-0.471082,-0.405547,0.307923,0.0582883,-0.082802,-0.460251,-0.333088,-0.29306,-0.404051,0.211303,-0.641514,0.0959888,0.246892,0.309821,0.496883,-1.41687 +3440.37,0.997698,0.0848144,4,1.63544,0.780687,-0.903053,0.403517,0.245267,-0.109601,0.0140729,-0.133951,0.115444,0.642449,-0.213481,-0.401338,0.160337,0.549162,-0.50212,0.655677,0.145072,0.105864,-0.13374,-0.291362,0.093222,-0.787475,-0.672983,0.55728,-0.436981,-0.0502814,-0.273961,0.433859,-0.0181242,-0.223462,0.759148,-0.354585,-0.513966,0.210066,-0.310215,-0.455196,-0.45174,0.38778,0.172524,-0.505307,0.745137,0.548321,0.297071,-0.951419,-0.281464,0.72289,-0.680418,-0.036555,0.197055,0.217488,0.304326,0.00796864,-0.424014,-0.66358,0.504298,-0.229742,-0.149306,-0.807942,-0.0856962,-0.36351,0.316766,0.718134,-1.05556,-0.64122,-0.333288,0.0728628,0.408847,0.0493276,0.0103961,0.102359,-0.131594,0.377723,0.562344,0.0185968,0.734307,0.51754,0.15495,-0.00134234,-0.331658,-0.180947,0.155293,-0.643427,-0.0663732,-0.263441,0.000472471,-0.135526,-0.19803,-0.287282,0.484688,-0.228246,0.363484,0.738878,0.128534,-0.55967,0.281167,-0.0262293,-0.175807,-0.279005,-0.0770243,0.38993,-0.521729,-0.00401398,-0.243777,-0.665327,-0.135847,-0.785388,0.0941923,0.0798757,-0.107935,0.363072,0.312571,-0.149446,0.0192797,0.263294,0.0452258,-0.56433,-0.122338,0.518397,0.274922,-0.60386,-0.619961,-0.462993,-0.21221,-0.357085,0.350482,-0.0454851,0.0251877,-0.0578608,0.293998,0.105728,-0.055531,0.112162,0.0672935,0.916173,0.0640906,-0.111519,0.373787,0.153115,0.224206,-0.487689,-0.670155,-0.414048,0.750969,-0.514905,-0.195767,-0.133477,-0.0540716,0.0963384,0.197394,-0.283983,-0.285437,0.184981,-0.0263019,-0.120855,-0.0975074,0.460096,0.558771,0.157541,0.399211,0.264728,0.114223,-0.0370218,0.44269,-0.0328535,0.277841,-0.0100308,0.212272,-0.277828,0.121951,0.0122948,0.483814,0.57946,0.0861333,0.0246982,0.312587,0.148553,0.120097,-0.307039,0.596975,0.715439,-0.072412,0.016651,0.49632,-0.415082,-0.0759271,-0.194486,0.0115923,0.219106,-0.000793766,0.325829,-0.30714,0.264644,-0.511258,-0.458063,0.0654714,0.146354,0.0912323,-0.323581,-0.484449,0.0894376,0.0197414,0.0940314,-0.281188,0.0603019,-0.395264,-0.028031,-0.558327,1.02264,0.250332,0.0639927,0.409293,-0.0670234,0.218715,0.276599,-0.0361708,0.22621,0.0463786,0.227429,0.00352088,-0.345179,-0.255881,-0.517775,-0.560586,0.0198362,-0.574846,0.520842,-0.681782,-0.158109,-0.130478,0.335943,-0.255746,-0.0517512,-0.0222845,-0.307812,-0.121853,0.774282,0.153808,-0.882977,0.846907,0.0854381,0.0427361,0.201448,-0.014115,0.401566,-0.288169,0.0835555,0.92832,0.342654,0.159933,-0.492635,-0.291969,-0.0757797,0.274209,0.249187,-0.0859869,0.375372,-0.761585,0.172218,-0.158239,-0.145521,0.0839661,0.454173,-0.245445,0.140503,-0.108077,-0.116694,-0.25108,0.229525,-0.217204,0.0350863,-0.267971,-0.430088,-0.00888868,0.614163,-0.0130942,0.291011,0.0140418,-0.156472,0.0472258,0.244049,0.169831,0.0870782,0.162209,0.0147094,0.335274,0.104789,-0.136376,-0.0130688,-0.103613,-0.221565,-0.181962,-0.189423,0.64053,0.16816,0.0218253,-0.0442707,0.134376,-0.111611,-0.242316,0.117019,-0.442509,0.129265,0.209772,0.359535,0.458009,-0.439811 +3443.41,0.981757,0.0848144,4,1.6955,0.943365,-1.03278,0.373041,-0.121964,-0.0911496,0.620069,0.0395316,0.648475,-0.175671,-0.511802,0.0586066,-0.504914,0.116135,0.0473937,0.461369,-0.107037,-0.10474,-0.231317,0.0417167,-0.400605,-0.592057,-0.317829,0.0172543,0.161447,-0.440225,0.451719,0.349018,-0.329798,0.433256,0.468465,-0.383675,-0.328262,-0.0941086,-0.608154,0.062983,-0.503724,0.302221,0.37211,-0.488158,0.423257,0.625298,0.451454,-0.642677,-0.387732,-0.170459,-0.548334,0.559463,0.253884,-0.340103,0.102364,0.268471,0.167256,-0.309085,0.0836623,-0.126547,-0.603339,-0.809941,0.0156088,-0.674903,0.152429,1.09544,-0.585429,-0.83755,0.0592706,-0.325196,-0.147625,-0.0740824,0.0892761,-0.232534,0.0625629,0.0694256,0.727358,0.105693,0.716645,0.398977,0.244664,0.0923769,-0.109829,-0.19399,0.122778,-0.0429627,0.246253,-0.0786346,-0.174736,0.163313,-0.0791319,-0.102007,-0.616977,-0.172268,-0.206843,-0.429486,-0.176492,0.134807,-0.278379,-0.368715,0.518356,-0.170779,0.295761,0.45282,0.276108,-0.3086,-0.584422,-0.165678,-0.174611,0.374572,0.221911,-0.218959,0.364348,0.334278,-0.379656,-0.0877485,-0.00984617,0.509998,-0.0273357,0.648942,-0.344989,0.0146527,0.314476,0.247256,-0.596791,0.362686,-0.0254662,0.0261408,-0.699545,0.232631,-0.104411,0.084907,0.695069,-0.941387,0.133286,0.0897612,-0.00181739,0.309806,-0.238783,-0.292721,-0.362269,-0.0934053,0.116918,-0.534597,0.0363816,0.229218,-0.83032,-0.151892,-0.105282,-0.315416,-0.0905209,0.257089,-0.224783,0.0201517,-0.0740272,0.166654,-0.10447,-0.0669129,0.430468,0.256275,-0.554434,-0.0246201,0.266484,-0.420872,-0.115635,-0.261735,0.638699,-0.215779,-0.420529,0.221165,-0.0417982,-0.295518,-0.60904,-0.592367,-0.369307,-0.207907,-0.171708,0.0641767,-0.409105,-0.198985,-0.170975,0.582396,-0.225616,0.376542,0.0129254,-0.167485,0.305435,0.0931537,0.166146,-0.281978,-0.31705,0.0484617,0.0988018,-0.812878,0.488572,-0.0516309,0.444555,-0.229289,0.0235115,0.140373,0.190949,-0.490798,-0.491801,-0.385942,-0.266466,-0.316911,0.126038,-0.18198,0.0467032,-0.484391,-0.257731,0.939913,-0.350814,0.162191,-0.366807,-0.488305,-0.0207768,-0.31436,-0.437612,0.0899385,-0.692215,0.647441,0.350704,-0.411478,-0.0130208,-0.191579,0.487173,0.130328,-0.294818,0.471083,0.0612535,-0.249922,0.138923,-0.277555,0.000734111,0.252792,-0.479589,-0.116837,-0.197418,0.425201,-0.0585672,0.587305,-0.0439603,-0.494425,-0.44499,0.0848337,-0.288418,-0.207682,0.489441,0.128319,0.194969,0.0267993,-0.041359,0.204533,0.266981,-0.35871,0.498166,-0.848724,-0.205665,0.212564,0.026035,-0.531405,-0.235722,0.0406314,0.0193422,-0.0299639,-0.0778853,-0.120443,0.389936,0.0127734,0.367329,-0.286321,0.532146,0.0755853,-0.318251,0.01345,-0.353816,-0.362114,-0.123808,-0.264678,0.679175,0.167415,0.221841,-0.392341,-0.402161,-0.35466,-0.695139,-0.320197,0.0416006,0.134354,-0.0483886,0.279285,-0.038483,-0.199609,0.170389,-0.0186256,-0.716793,0.226764,-0.0727841,-0.312267,-0.190158,-0.157311,-0.0559071,-0.443351,0.593188,0.129497,0.143078,0.359857,0.378256,0.64422 +3450.07,0.389334,0.0848144,5,1.61954,0.796324,-1.10211,0.440766,0.55296,-0.219164,-0.343899,0.282526,-0.243624,0.275399,0.143461,-0.425016,-0.256084,0.320163,-0.163648,0.782392,0.292935,0.0195775,0.183412,0.108668,-0.110478,-0.698769,-0.837987,0.300363,-0.350339,0.0355892,-0.305052,0.0933183,-0.268779,-0.53211,0.793984,-0.253066,0.242617,0.359501,-0.208532,-0.223589,-0.438169,0.282445,0.652369,-0.291441,0.532375,0.659394,0.1137,-0.894516,0.314941,0.344147,-0.396612,-0.0599573,0.450769,0.0297698,0.0530415,0.414883,0.0786457,-0.106129,0.544234,-0.0544693,-0.174103,-0.322235,0.340906,0.0298678,0.302424,0.608575,-0.529377,-0.56179,0.256481,0.514033,-0.379604,0.118339,0.488457,-0.354681,-0.275388,0.495449,0.701852,-0.613212,0.398859,0.32124,0.164348,-0.226547,-0.36001,-0.218258,-0.0226491,-0.336646,0.106152,-0.142404,-0.403993,-0.171855,-0.187725,-0.0644253,0.347889,-0.367624,0.400472,0.186459,0.154193,-0.027495,0.202482,0.0501633,-0.138246,-0.536088,-0.0133844,0.803465,-0.226155,0.2909,0.0742832,-0.695151,0.211816,-0.721419,0.0980383,-0.251616,0.135198,0.740148,-0.0988354,-0.0349021,0.173276,0.314859,0.221201,-0.181129,-0.119619,0.309907,-0.0840669,-0.696543,-0.643849,-0.581575,-0.369764,-0.482075,0.233113,-0.0465316,0.150348,-0.232217,-0.118754,0.00281765,0.546186,0.425547,0.0746618,0.758524,-0.0833873,-0.240364,0.07036,-0.24205,0.193426,-0.616122,-0.487326,-0.260834,0.128015,-0.395162,0.0493063,0.3171,-0.353797,0.320931,0.0441,-0.349315,-0.0779592,-0.00752638,0.0110277,0.129784,0.520957,0.439341,0.311618,0.0868849,0.606685,0.0348699,0.0490642,0.1976,0.201151,0.170579,0.157764,-0.0389462,-0.227828,-0.181174,-0.221071,-0.102564,0.422134,-0.15223,0.161321,-0.179016,0.617954,-0.058269,-0.119505,-0.722545,0.170123,0.69626,0.244744,0.201576,0.00666752,-0.101258,-0.097002,-0.267307,0.0463322,-0.289324,0.269227,0.738155,-0.214432,-0.0687902,0.0345215,-0.56454,0.0836583,0.0302372,-0.0409594,-0.285713,-0.360529,0.110399,0.258235,0.0793037,0.0244738,-0.0761019,0.0150715,0.312527,0.0379136,0.959156,0.083914,-0.144463,0.191363,0.161849,-0.0490505,0.0718674,0.17847,0.027898,0.302386,0.331587,-0.0602176,0.058656,-0.626032,-0.630899,-0.24753,0.2052,-0.193156,0.00312053,-0.156207,0.0668269,0.102168,0.146171,-0.276112,-0.112073,0.176421,-0.157868,-0.22854,0.53613,0.22002,-0.589256,0.697826,-0.185093,0.379867,0.0998316,0.0896798,-0.0223185,0.333891,0.39206,0.515893,0.197308,0.182313,-0.309382,-0.326776,-0.320642,0.117678,0.0887778,-0.436144,0.0536028,-0.67744,0.529592,0.289734,0.265186,0.110079,0.575027,0.120509,0.333482,0.151247,0.0657456,-0.257326,-0.017438,-0.496791,-0.139848,-0.185462,-0.506348,0.0829951,0.0708444,-0.372749,0.582682,0.680701,-0.266683,0.408896,0.181569,-0.0836616,-0.167567,0.367783,0.13177,-0.190693,-0.0449986,0.000764871,0.394546,-0.538167,-0.25367,-0.00918374,-0.318843,0.643634,0.0541474,0.0505832,-0.0641336,-0.129928,-0.0520244,-0.234405,0.435408,-0.305722,0.119293,0.150094,0.345388,0.38742,-1.40817 +3466.21,0.936453,0.0848144,4,1.60233,0.90192,-0.870409,0.200676,0.468764,0.0178456,0.0888765,0.0183796,0.873888,-0.219007,-0.0927831,-0.167266,-0.159859,0.271888,-0.472755,0.431188,-0.16547,-0.16055,-0.287104,0.153232,-0.539751,-0.796926,-0.208691,0.0714544,-0.357717,-0.511843,0.276119,0.401694,-0.399979,0.299947,0.618448,-0.497372,-0.215978,0.167546,-0.201912,-0.090708,-0.198563,0.629957,-0.119566,-0.383458,0.83829,0.338111,0.343992,-0.364001,-0.0724717,-0.215349,-0.408325,0.206067,0.125546,-0.199359,0.0689558,0.0470873,0.159354,-0.536393,0.822407,0.0458479,-0.116398,-0.719571,0.595685,-0.525883,0.115379,1.02968,-0.34706,-0.733382,0.120786,-0.0694724,0.177528,-0.263721,-0.00403855,-0.358848,0.30925,0.121725,0.373529,0.59346,0.771859,0.418816,0.371968,0.166779,-0.192679,0.0479162,0.778258,-0.155816,0.332333,0.102125,0.216402,0.00551952,0.294321,-0.155768,-0.496216,-0.23372,-0.49864,-0.190723,-0.0879151,0.0190689,-0.180942,-0.162336,0.0659751,0.209125,0.290501,0.345044,0.158911,-0.254929,-0.604364,0.00134511,-0.104854,0.258109,0.282306,-0.300954,0.515308,0.235429,0.0625771,-0.00370922,-0.0850143,0.449052,-0.241746,0.437263,-0.380875,-0.0869061,0.362626,0.643062,-0.354497,0.247956,0.196386,0.034581,-0.253287,-0.0632081,-0.0503888,0.500391,0.323059,-0.334386,-0.29182,-0.529073,-0.0789737,0.270796,-0.180648,0.154654,-0.145367,-0.314242,0.209824,-0.0837444,0.00992632,0.353958,0.0156842,-0.153522,-0.0814493,-0.0254902,0.178298,-0.0536034,-0.208142,0.155312,-0.250248,0.235965,0.230459,-0.233947,-0.00998204,0.12511,0.0890162,0.0567941,0.0292177,-0.113059,0.124118,-0.284997,0.60127,-0.15851,-0.278852,0.400109,-0.0652559,0.291705,0.0652372,0.188183,0.0302623,0.115495,-0.0783634,0.0505408,-0.584905,-0.217079,-0.215719,0.576524,0.0219297,0.554888,-0.26661,-0.362327,0.187205,0.078987,-0.259511,-0.304858,-0.22167,-0.284828,0.176991,-1.11905,0.12277,0.0860206,0.178536,-0.256088,-0.0292975,0.0932039,-0.0540934,-0.449914,-0.323596,-0.147293,-0.288819,-0.163096,0.0485174,-0.0912477,0.147042,-0.460897,-0.826971,0.783092,-0.143912,0.0917118,-0.123362,-0.356582,0.167223,0.183056,-0.384671,0.46838,-0.49597,0.592964,0.29046,-0.292846,0.424724,-0.165711,0.181943,0.0329441,-0.240619,0.446384,0.084867,-0.336662,0.0725451,-0.040363,0.108228,0.308602,-0.645182,0.111906,-0.280328,0.393318,-0.122266,0.610929,0.242574,-0.410037,-0.569949,-0.314333,-0.0313211,-0.110861,-0.0158742,0.0366576,-0.030727,0.0342456,-0.0835278,-0.307234,0.224501,-0.156823,0.409816,-0.408733,0.148054,0.00914889,-0.134633,-0.320506,-0.288979,-0.115645,0.154534,-0.291539,-0.0820342,-0.121217,-0.0852363,-0.182477,0.19938,-0.141967,0.339128,0.166289,-0.0721387,0.0278823,-0.314691,0.014848,0.42861,-0.400066,0.0655953,0.266976,0.0292097,-0.244765,-0.323235,-0.0250827,-0.742162,-0.0869222,0.0244813,0.542923,-0.0972734,-0.0438188,0.611512,0.0412825,0.107391,0.328687,-0.483536,0.0450463,-0.175453,-0.4484,-0.0328504,-0.0384357,-0.0693113,-0.590393,0.153093,0.100265,0.189211,0.316647,0.434984,-1.28587 +3461.05,0.656164,0.0848144,4,1.62937,0.901678,-0.818501,0.152895,0.418473,0.000262486,0.0313414,0.0556102,0.935155,-0.23961,-0.0961647,-0.149692,-0.0318888,0.338858,-0.442276,0.43679,-0.136783,-0.103355,-0.368534,0.050353,-0.425376,-0.776168,-0.313395,-0.0123798,-0.330919,-0.389652,0.174508,0.415588,-0.432993,0.321889,0.647571,-0.462451,-0.232339,0.123404,-0.100984,-0.0101184,-0.202246,0.657302,-0.147738,-0.435484,0.921328,0.390879,0.408414,-0.37672,-0.0730919,-0.266592,-0.386297,0.388567,0.0694857,-0.131988,0.0511908,0.135117,0.0488045,-0.467931,0.835735,-0.000726685,-0.12186,-0.678488,0.710194,-0.517465,0.0195684,0.985806,-0.351715,-0.708705,0.103494,-0.191139,0.206707,-0.15106,-0.0936262,-0.18868,0.369905,0.105404,0.42727,0.56108,0.797995,0.506165,0.407891,0.134277,-0.180769,-0.104021,0.879651,-0.169208,0.322168,0.025331,0.242456,2.83687e-05,0.322214,-0.17499,-0.419308,-0.215263,-0.599229,-0.100178,-0.100543,0.113446,-0.159166,-0.0667483,0.243806,0.362139,0.395193,0.296477,0.352385,-0.343872,-0.550021,-0.00795275,-0.187903,0.327049,0.254242,-0.33845,0.550177,0.275291,-0.00402866,-0.039462,-0.135032,0.428212,-0.299808,0.424025,-0.544865,-0.00807345,0.27489,0.69852,-0.417883,0.324079,0.0894928,0.0643458,-0.249943,-0.0522479,-0.0026063,0.431561,0.333731,-0.305007,-0.187496,-0.529936,0.0326629,0.247982,-0.278258,0.0907332,-0.214073,-0.310497,0.156148,-0.0813388,-0.0333987,0.407103,-0.11485,0.0576116,0.0634006,-0.020828,0.189055,-0.0658322,-0.180679,0.128061,-0.33108,0.15069,0.273953,-0.189605,-0.0202298,0.216186,0.119385,0.0683008,0.00964097,-0.0849105,0.320246,-0.237977,0.716539,-0.160827,-0.175408,0.412072,0.0566398,0.230119,0.112245,0.0490825,0.125267,0.107856,-0.0964259,0.0504999,-0.480642,-0.182263,-0.307131,0.594612,0.0732106,0.539696,-0.277625,-0.385358,0.186714,0.0913417,-0.306711,-0.418688,-0.344676,-0.258132,0.0376959,-1.10146,0.0938218,0.116162,0.26348,-0.245665,-0.0818247,0.104307,-0.0720167,-0.511946,-0.281875,-0.0319967,-0.206256,-0.200582,0.00494775,0.00890111,0.203126,-0.261251,-0.829273,0.831829,-0.118541,0.164302,-0.234894,-0.444187,0.142599,0.289751,-0.404745,0.466647,-0.413581,0.498273,0.316172,-0.340076,0.403122,-0.20883,0.246226,-0.110015,-0.223764,0.584747,0.0977484,-0.456544,0.0636788,-0.152754,0.0732043,0.323689,-0.729842,0.0155844,-0.239645,0.376713,-0.210367,0.596903,0.292957,-0.398578,-0.565177,-0.317162,-0.0641861,-0.140113,0.0395114,-0.0914135,0.0151732,-0.0344911,-0.0541799,-0.29814,0.334926,-0.186487,0.424684,-0.289383,0.176557,-0.026241,-0.18113,-0.268178,-0.28002,-0.169252,0.228543,-0.311241,0.00338465,0.00749629,0.107633,-0.0845054,0.271186,-0.234684,0.353576,0.219823,-0.0845888,0.050197,-0.31525,0.048032,0.380667,-0.282212,0.117089,0.398345,0.1363,-0.0968711,-0.240504,-0.220084,-0.741975,0.0518616,0.0450606,0.553218,-0.0519766,-0.197334,0.458472,0.0187682,0.129109,0.398119,-0.4192,0.0660288,-0.143036,-0.364283,-0.0497734,0.0042541,-0.0284742,-0.573654,0.213126,0.0950345,0.198334,0.308277,0.445348,-1.069 +3451.79,0.979626,0.0848144,4,1.60007,0.939255,-0.776543,0.324673,0.743582,-0.0368022,0.205537,0.181915,0.0551658,-0.0210617,-0.0416767,-0.54481,-0.397078,0.528903,-0.275309,1.05113,0.130174,0.152892,-0.241735,-0.16008,-0.0107514,-0.801639,-0.585548,-0.00996199,0.127691,0.0810879,-0.407568,0.377741,-0.207076,0.184517,0.722246,-0.0979074,0.327296,0.251463,-0.165221,-0.483383,-0.949925,0.358056,0.506865,-0.148818,0.628328,0.231442,0.436721,-0.647766,-0.192914,0.116617,-0.720204,-0.535675,0.227533,-0.213643,0.188228,0.134254,0.0184286,0.105025,0.495762,-0.283472,-0.0284686,-0.702616,0.324861,-0.29659,-0.0787452,1.11925,-0.596527,-1.21761,0.0959817,0.298234,0.117637,0.186197,0.222286,-0.332618,-0.242215,0.306169,0.190471,0.111204,0.105142,0.222545,0.126373,-0.143421,-0.162541,0.216262,0.0231583,-0.00445882,0.0867839,0.308154,0.230391,0.39794,-0.0373615,0.345609,-0.392335,-0.308359,-0.00369497,-0.02077,0.135666,-0.0362046,0.42294,-0.0967464,0.330765,-0.0311233,0.422381,0.314143,-0.00773469,0.0787222,0.178527,0.288769,-0.0227506,0.181555,0.098627,-0.127831,0.134164,0.511177,-0.551812,0.117428,-0.109361,0.467106,-0.0521867,0.254907,-0.327552,-0.0216493,0.408752,0.301216,-0.797284,-0.2162,-0.234456,-0.142565,-0.310671,0.270286,0.187959,0.332538,0.372386,0.0722287,0.122772,-0.396696,-0.158184,0.713698,-0.0578328,0.337634,0.354826,-0.00675454,0.354382,-0.154948,-0.274328,-0.00683788,0.387022,-0.294472,0.302312,-0.06526,-0.0495932,-0.0181186,-0.155991,0.431201,-0.501601,-0.120431,-0.013602,0.237829,0.285383,0.421046,0.525933,-0.330868,0.313926,0.48704,-0.148421,0.23574,0.925615,-0.265918,-0.117777,0.251063,0.354052,0.115321,-0.13361,-0.133962,0.436601,-0.479939,0.148962,0.175288,-0.438143,-0.57505,-0.492342,-0.104194,0.292729,0.392551,0.339565,-0.759025,0.482632,0.0140342,-0.417397,-0.489198,-0.428428,-0.295911,0.396073,-0.561039,-0.0307184,-0.239308,-0.238271,-0.385286,-0.102613,0.376782,-0.158083,-0.431597,-0.739953,-0.725062,-0.0750116,-0.361595,-0.0442303,0.219722,0.0440085,0.0182165,-0.0518254,0.845478,-0.65561,0.0350349,0.305232,-0.117097,0.241969,-0.0784622,-0.326924,0.17177,0.275151,0.269239,0.311882,-0.213562,-0.511088,-0.464611,-0.232855,-0.342631,0.0489551,0.505645,-0.0419289,-0.474011,0.16231,0.137336,-0.466421,0.167418,-0.695625,-0.369998,-0.35133,0.29003,-0.00371239,0.129109,0.210604,0.0218541,0.155991,-0.761347,-0.144323,-0.376284,-0.0178387,0.221602,0.330695,-0.280447,0.0548749,-0.552941,0.0293702,-0.370165,0.257284,-0.4515,0.090685,0.339797,-0.521962,0.356911,-0.19248,-0.188979,-0.372362,0.13146,0.432272,0.242714,0.432873,-0.14079,-0.279527,0.47227,0.18574,-0.169969,-0.451376,-0.163906,-0.289752,-0.653031,-0.168093,-0.146327,-0.085854,0.242718,-0.0797998,0.153421,-0.190157,-0.235279,0.290758,0.221846,0.408169,0.431485,-0.11528,0.0438331,0.210899,0.141689,-0.0157233,-0.352351,-0.184503,0.399143,-0.151373,-0.099973,0.0373912,-0.336739,-0.363214,-0.147012,-0.470077,0.107188,0.143791,0.327395,0.379198,-2.41972 +3459.26,0.449684,0.0848144,4,1.65142,0.931067,-0.86359,0.311824,0.628863,-0.101259,0.228127,0.0242954,0.320628,0.092037,-0.049458,-0.479264,-0.355082,0.546483,-0.250226,0.996716,0.268774,0.132846,-0.330561,-0.169111,0.015566,-0.782382,-0.757242,0.0922472,0.200209,0.183022,-0.40348,0.261274,-0.428695,0.146106,0.682328,-0.16467,0.422665,0.131149,-0.297532,-0.538814,-0.86462,0.422382,0.502998,-0.223222,0.524721,0.188034,0.394633,-0.693301,-0.297465,0.102932,-0.838745,-0.419577,0.200024,-0.201824,0.121667,0.17665,-0.098653,0.294934,0.335424,-0.465928,-0.0736088,-0.693048,0.355395,-0.401597,-0.0776106,0.954292,-0.738278,-1.14073,0.0926844,0.11135,0.168738,0.187555,0.164833,-0.374257,-0.216723,0.163599,0.243044,0.0687343,0.0474106,0.132085,-0.0813419,-0.0312646,-0.0977253,0.0728658,0.065747,0.0637194,0.123467,0.314258,0.115571,0.197094,-0.239634,0.239454,-0.282935,-0.235323,-0.352571,0.0706746,0.0858706,-0.0454133,0.203902,-0.0983095,0.328011,0.0385543,0.110693,0.263096,0.158536,0.0876465,0.289167,0.24086,-0.0152897,0.166456,0.10049,-0.072521,0.246139,0.528413,-0.235474,0.0900607,-0.132256,0.521285,-0.163944,0.371431,-0.460859,-0.0520659,0.421402,0.121839,-0.872335,-0.189253,-0.194559,-0.0244589,-0.274396,0.259735,0.51748,0.135453,0.268783,0.0557008,0.0590465,-0.359966,-0.118824,0.587757,-0.0278319,0.353102,0.445193,0.103259,0.122241,-0.274211,-0.114066,0.0497107,0.131109,-0.421828,0.389781,0.0558088,-0.0470272,-0.204484,-0.0543512,0.54746,-0.353209,-0.158637,-0.0178023,0.316761,-0.0498839,0.329916,0.312315,-0.403148,0.430917,0.39033,-0.246281,0.13092,0.819722,-0.208743,-0.0152858,0.368497,0.395543,0.11697,-0.0531321,-0.113241,0.19225,-0.559497,0.163461,0.104525,-0.366865,-0.6169,-0.453135,0.319874,0.433996,0.372409,0.419545,-0.741753,0.354278,-0.0709482,-0.428349,-0.299618,-0.437196,-0.44314,0.24708,-0.493317,0.0446332,-0.27822,-0.100556,-0.454332,-0.212986,0.251698,0.0721415,-0.43868,-0.378779,-0.695834,-0.00260832,-0.304982,-0.0814054,0.387462,0.00538872,0.093348,-0.0472897,0.744296,-0.402278,0.156322,0.542221,-0.304352,0.404228,-0.0895628,-0.173364,0.283732,0.239332,0.182538,0.174816,0.133586,-0.249131,-0.416093,-0.292523,-0.321952,0.0907111,0.537703,-0.0121277,-0.224786,0.0222123,0.356971,-0.592474,0.0951167,-0.643405,-0.454356,-0.44739,0.331818,-0.104154,0.311788,0.21254,-0.170435,-0.0413016,-0.525418,-0.313997,-0.53664,0.0790716,0.15704,0.259853,-0.0845063,-0.0789453,-0.531478,0.208842,-0.322014,0.257366,-0.39795,0.0173117,0.459505,-0.462517,0.159659,-0.352169,-0.101066,-0.286278,0.0456403,0.307423,0.396719,0.290771,-0.189531,-0.134691,0.240436,-0.0240902,-0.120173,-0.471688,-0.177276,-0.259825,-0.449164,-0.121949,-0.145482,-0.103829,0.412279,0.0792311,0.140856,-0.166305,0.0413602,0.349542,0.186271,0.564205,0.450841,-0.0862841,0.193759,0.35173,-0.0248008,0.012557,-0.2476,-0.306242,0.422715,-0.113776,-0.12216,0.154807,-0.175268,-0.588663,0.0683499,-0.478329,0.0918648,0.175284,0.303092,0.418669,-1.89901 +3455.91,0.958763,0.0848144,4,1.61803,0.91124,-0.751231,0.313109,0.410812,-0.0801558,0.230494,0.0982694,0.348011,0.0917714,0.143617,-0.38114,-0.33252,0.446229,-0.149581,0.76739,0.186787,0.120679,-0.29443,-0.215676,-0.156944,-0.900143,-0.531701,0.161692,0.155417,0.305413,-0.320545,-0.0751371,-0.545361,0.0870227,0.659725,-0.14997,0.188304,0.0910774,-0.113969,-0.606857,-0.349609,0.420372,0.247194,-0.0511595,0.605042,0.0688306,0.510133,-0.688199,-0.271032,0.0852785,-0.785914,-0.556069,0.123983,-0.131161,0.287466,0.0142274,-0.00600321,-0.020267,0.371719,-0.362614,-0.0543539,-0.495108,0.621869,-0.262501,-0.125792,1.05499,-0.621999,-0.792976,-0.0185657,0.346717,0.218113,0.12908,0.00878522,-0.56804,-0.0230506,0.0844958,0.0625947,-0.298444,0.165784,0.185147,-0.0964081,0.062464,-0.225832,0.123181,-0.00104871,-0.0144369,0.22846,0.34477,0.135714,0.19867,-0.291326,0.229785,-0.309948,-0.224559,-0.409201,0.144781,0.161369,-0.116591,0.0728736,0.0344343,0.253088,-0.320574,0.296146,0.133364,0.156667,0.0270747,0.128407,0.197632,-0.0248414,-0.150715,0.00685452,-0.0916058,-0.0247684,0.360138,-0.335255,-0.0731127,-0.167834,0.538623,-0.0786235,0.198088,-0.419103,-0.108938,0.256455,0.025831,-0.961791,-0.0628137,-0.285314,-0.197973,-0.45332,0.111295,0.273577,0.300771,-0.074958,0.0727174,-0.100667,-0.285379,-0.121202,0.457536,0.0643671,0.390796,0.677823,0.205858,0.264986,-0.0551434,0.0528988,-0.0564557,-0.00613865,-0.442924,0.347102,-0.16753,-0.0131606,-0.122771,-0.0836011,0.511106,-0.342167,0.113197,-0.0941642,0.196551,0.0502541,0.0259294,0.201659,-0.391984,0.308876,0.661798,-0.400492,0.207901,0.811106,-0.400737,-0.427832,0.152041,0.363532,0.0549799,-0.172637,-0.0118613,0.221325,-0.597812,0.147519,0.309772,-0.221958,-0.305423,-0.54069,0.210921,0.299584,0.474316,0.240751,-0.666352,0.623198,-0.139571,-0.146518,-0.257183,-0.528069,-0.224931,0.128748,-0.464675,0.0139443,-0.0548937,-0.0807266,-0.423418,-0.147491,0.392007,0.098253,-0.366644,-0.213806,-0.400565,0.0299186,-0.456531,-0.0374697,0.390123,0.144921,0.305634,-0.093048,0.827739,-0.400373,0.149568,0.400572,-0.240349,0.263216,-0.0801964,-0.226765,0.574114,-0.0130375,0.166734,0.00519506,0.148989,-0.540454,-0.426893,-0.468292,-0.218694,-0.00867179,0.346077,-0.0180765,-0.0816461,0.250212,0.48118,-0.854795,0.196174,-0.487557,-0.237727,-0.38725,0.238631,-0.099646,-0.0406446,0.140517,-0.287551,0.215321,-0.507082,-0.118508,-0.561827,0.0282787,0.0960379,0.204621,0.0743195,-0.160579,-0.485183,0.203469,-0.346091,0.153411,-0.364523,0.0162235,0.451659,-0.476342,0.142903,-0.123683,-0.133844,-0.635137,-0.0761722,0.308388,0.489868,0.287902,-0.164193,-0.188464,0.135686,-0.134154,0.0460514,-0.574482,-0.323183,-0.162624,-0.193212,0.0249849,-0.101632,-0.122348,0.466193,-0.13505,0.137815,-0.16072,-0.0194978,0.311453,0.313138,0.569877,0.313643,0.118685,0.319035,0.328569,0.213356,-0.142921,-0.284985,-0.248222,0.214845,-0.0660943,-0.0645347,0.253938,-0.0631931,-0.598497,0.0158168,-0.344433,0.0983688,0.194339,0.313638,0.440839,-1.239 +3465.09,1,0.0848144,4,1.54427,0.875785,-0.85707,0.315826,0.732764,-0.174674,-0.342809,0.300135,0.502196,0.302421,-0.196329,0.000451335,0.200761,0.0634244,-0.382176,0.627396,0.0170881,-0.0748868,0.359717,0.0567858,-0.389591,-0.602942,-0.705658,0.19962,-0.613798,-0.377133,0.34735,0.653312,-0.0374256,0.0349554,1.07562,-0.599022,-0.108028,0.323708,-0.442606,0.284748,-0.234891,0.144571,0.387134,-0.377759,0.942329,0.623563,-0.443856,-0.309075,0.023527,-0.238246,-0.150907,0.595487,0.40717,0.0836137,-0.0354549,0.158281,-0.0804802,-0.737562,0.546042,-0.0146341,-0.267874,-0.537971,0.2507,-0.48146,0.298033,1.16486,-0.389844,-0.706865,-0.482667,-0.0194259,-0.302584,-0.193624,0.160007,0.0821235,-0.0454852,0.154003,0.777372,0.363952,0.636794,0.672046,0.742169,-0.0428173,-0.0616914,0.0740695,0.388707,-0.426009,-0.05611,-0.519822,-0.224581,-0.190563,0.0537298,-0.339032,0.290731,-0.472674,0.403381,0.0188401,0.0597944,-0.0724252,-0.139251,-0.308499,-0.0283965,-0.0245924,-0.148072,0.163465,-0.0347921,-0.16756,-0.519162,-0.4536,0.0937603,-0.135217,0.114899,-0.0355573,0.473315,0.534259,0.297225,-0.029072,0.17569,0.505419,0.130313,0.00643865,-0.0652675,0.332008,0.130897,-0.0463269,-0.155755,0.149423,0.169148,-0.0633081,0.435885,0.0274909,-0.101607,-0.146752,0.524563,-0.47585,0.0870543,0.200719,0.159164,0.246532,-0.221268,-0.335188,-0.590068,-0.280823,0.477539,-0.702968,-0.467075,-0.105277,0.0913873,-0.0438237,-0.21677,0.10138,-0.0427503,0.50595,-0.371201,-0.658926,0.28663,0.266232,0.129923,-0.331212,0.203374,0.493505,-0.03834,0.344213,-0.248759,-0.790717,0.515528,-0.178343,0.216491,0.320394,0.386252,-0.166534,-0.238478,-0.123762,0.0365566,-0.0405355,0.135786,0.429761,0.163657,-0.366541,0.199786,0.120685,0.23255,-0.17562,-0.0651571,0.411552,-0.0700267,0.434063,-0.503664,0.0565348,-0.00686673,-0.150253,0.255772,-0.0255334,0.147396,-0.0711393,0.013149,0.143055,0.110709,-0.214013,0.359719,0.00437526,0.0937202,0.043588,-0.535607,0.358453,-0.189614,0.186033,0.218192,-0.385264,-0.23099,-0.370786,-0.503969,0.643347,0.384662,0.16041,-0.188301,-0.165713,-0.216178,0.177817,0.0544197,-0.307962,-0.2269,0.00389314,0.32733,-0.637514,0.461876,-0.114823,0.40019,0.432075,-0.460673,0.523466,-0.240472,-0.158378,-0.107459,-0.299082,0.527868,0.214414,0.255632,0.0702656,-0.0446023,0.570246,0.276254,0.148964,0.384211,0.0378928,-0.437212,0.56,0.129039,0.382977,0.274094,0.0759203,0.502428,0.089095,-0.0885029,-0.080298,-0.192026,-0.344022,0.420252,0.173964,-0.183194,-0.0737917,0.119968,-0.307346,0.104316,0.0155615,0.725202,0.500876,-0.211618,-0.448658,-0.0939687,0.19228,-0.187257,-0.226267,0.175666,0.112552,0.0713176,-0.20403,-0.0839746,0.333268,-0.054916,0.0899707,0.0932803,-0.340116,0.258924,-0.103912,0.0417075,-0.246487,-0.540389,-0.39629,-0.371326,0.0305937,-0.24869,-0.0654203,-0.112296,-0.511741,-0.0272178,0.328624,0.342227,-0.125254,-0.0768973,-0.364496,-0.253002,-0.246597,0.422003,-0.123472,0.204834,0.0898643,0.271083,0.299774,0.520656,-2.24223 +3422.56,0.955867,0.0848144,4,1.6892,0.824802,-1.24831,0.482905,0.94542,0.101086,-0.233681,-0.325901,0.133143,-0.170944,-0.12168,-0.157058,-0.295427,0.0122972,-0.534364,0.675951,-0.223244,-0.172329,0.0692281,0.137774,0.000892181,-0.586776,-0.790207,0.246703,-0.294482,-0.234927,0.649066,0.661603,-0.323341,0.0681944,1.10203,-0.545452,0.0782931,0.277741,-0.544725,-0.311279,0.110035,0.343924,0.691418,-0.645558,1.09235,0.27029,-0.0867393,-0.648394,0.015602,-0.750223,-0.602231,0.200247,0.42686,0.17976,-0.118058,-0.0590208,0.0367645,-0.210542,0.485393,-0.425217,-0.474019,-0.483105,0.0740302,-0.601697,-0.328373,0.921835,-0.52546,-0.765277,-0.163978,0.472567,-0.144261,-0.526659,-0.525209,-0.260362,0.0324974,0.0639527,0.839794,0.0074009,0.461677,0.378194,0.493353,-0.450423,-0.509454,-0.061718,-0.061753,-0.219364,0.125907,0.00697347,-0.198499,-0.309851,-0.436913,-0.367602,0.132841,-0.996859,0.0676974,-0.0440939,-0.0354675,0.175152,-0.0729231,-0.136863,0.594187,-0.388788,0.580393,0.154025,-0.0645054,0.00830662,-0.797912,-0.287052,0.196074,-0.0207105,-0.264947,-0.634562,-0.101777,0.615488,0.281381,0.105656,0.278338,0.428818,-0.126046,-0.142914,-0.0514099,0.410884,0.270266,-0.115497,-0.146555,-0.130072,0.17315,-0.226316,0.313253,-0.148416,0.161927,-0.313152,0.533314,-0.480282,0.369889,-0.00339554,0.590311,0.337637,0.0361822,0.329644,-0.157755,-0.311312,0.153464,-0.618865,-0.508906,-0.0304702,0.22637,-0.455404,-0.499743,0.0802286,-0.340091,-0.0156578,-0.404223,-0.464479,-0.0239876,-0.358354,0.162882,-0.408145,0.159843,0.438914,0.624571,0.266514,-0.32476,0.288659,0.234537,-0.0563246,0.39782,-0.257555,0.252417,-0.679987,-0.580049,0.18098,-0.14806,-0.420254,0.190562,0.357411,-0.0454174,-0.467928,0.314965,0.0320668,-0.227115,-0.692579,0.19078,0.292116,0.501631,0.0265016,0.0916045,0.580023,-0.482266,-0.460483,0.200878,0.271177,-0.142147,-0.368967,0.132472,-0.137748,-0.273751,-0.548041,0.295787,-0.0866566,0.0882711,-0.139094,-0.447205,-0.00753768,0.29639,0.0648715,0.444579,-0.689118,0.129492,-0.20331,-0.471786,0.481367,0.00194309,0.629178,-0.132027,-0.0896589,-0.700817,0.531073,0.117388,0.164896,0.124923,-0.0693732,0.335276,-0.226563,-0.141284,-0.259041,0.204555,-0.0709011,-0.0320669,0.0875178,-0.55715,-0.179178,0.871812,-0.0291657,0.137697,0.140358,-0.0629541,0.223323,-0.150224,0.449073,-0.19295,0.0538758,0.148766,0.212393,0.528294,0.0090638,0.363012,-0.20604,0.404719,0.157899,0.287104,0.0994484,-0.689729,0.0143191,0.364343,-0.134356,0.512583,-0.0359458,-0.219191,-0.144913,-0.681769,-0.648497,-0.0695182,-0.234769,0.0259838,0.494249,-0.284836,-0.619831,0.191008,-0.0770816,-0.685571,-0.101429,0.203843,0.166441,0.144074,-0.215094,-0.371463,-0.0589763,0.331252,-0.180099,-0.203591,-0.428582,-0.161175,0.125817,-0.308691,-0.912877,-0.0154918,-0.52916,-0.0318846,0.385665,-0.0341975,-0.520489,0.253221,-0.0536222,0.0348316,0.12583,-0.0606856,0.237978,0.461977,-0.314733,0.0852193,0.250553,-0.561658,-0.0524833,-0.157571,0.116886,0.216882,0.341885,0.465705,-2.73496 +3444.35,0.694026,0.0848144,5,1.6211,0.993317,-1.10435,0.407256,1.08954,-0.149572,-0.410194,0.34577,0.66518,0.269187,0.128335,0.140018,0.05504,-0.171291,-0.285797,0.951687,-0.150357,-0.0153022,-0.0109266,-0.355886,-0.0317464,-0.780645,-0.173449,-0.291219,-0.31225,0.0321668,-0.164526,0.294308,-0.391924,0.269933,0.648934,-0.274481,-0.128804,0.284354,-0.353583,0.0192479,-0.634654,0.298162,0.175096,-0.209051,0.787783,0.883765,0.286363,-0.696421,-0.158376,0.78651,-0.252099,0.295076,0.434826,0.0259785,-0.27001,0.126655,-0.128524,-0.297491,0.342583,0.0275946,0.133146,-1.4646,0.0106378,-0.332636,0.334742,1.16785,-0.804022,-0.8606,0.257803,0.52977,0.256818,-0.0580253,0.526772,-0.348415,-0.305423,-0.0328605,0.463811,-0.187226,0.445579,0.695494,0.199035,0.559001,-0.0967613,-0.342824,0.632704,-0.144546,0.506989,-0.214987,-0.373326,0.0780429,0.340258,0.437226,-0.0768418,-0.419063,0.00396205,0.327731,0.096363,-0.0115855,-0.230202,0.333399,-0.162474,0.160927,-0.558257,0.180066,-0.224791,0.0170266,-0.155143,-0.295915,-0.214066,-0.868278,0.161641,-0.354852,0.189624,0.502441,0.166683,-0.450996,-0.221604,0.429843,-0.255141,-0.135754,-0.0247621,-0.0413743,0.0110869,0.416444,-0.942997,0.0820854,-0.479706,0.154386,0.297215,0.461994,0.344954,-0.00107247,0.104788,-0.640301,0.0821452,0.142134,-0.281487,0.116933,-0.234488,-0.420094,0.284214,-0.0155589,0.129021,-0.218335,-0.595099,0.242785,0.210439,0.292308,0.279878,0.0875573,-0.385846,0.233469,-0.305252,-0.105115,-0.0976754,0.406322,0.26205,-0.0334873,-0.236725,0.762159,-0.196425,0.0519602,0.0727969,-0.409112,0.4834,0.185388,0.634498,0.202731,-0.0702389,0.485752,0.0297847,-0.299094,-0.349594,0.548812,0.093422,-0.114854,0.0797993,-0.320541,-0.266804,-0.0894411,0.198641,0.217457,-0.09588,0.478932,0.0731303,-0.403641,0.0462074,-0.481935,-0.403516,-0.189957,-0.31801,-0.472243,-0.143063,-0.510425,-0.0362704,0.321959,0.288135,-0.473853,0.0312213,0.141331,-0.0720456,-0.384676,-0.691038,-0.31427,-0.154362,-0.563528,0.0938576,0.0567858,-0.00513082,0.324452,-0.909596,0.690925,0.127272,0.316392,0.168868,0.195547,0.453691,0.360178,0.139154,0.516734,-0.24721,0.135487,0.164652,-0.0869517,-0.0435648,-0.149015,-0.0788597,0.101096,-0.433722,-0.194253,-0.353963,-0.158325,-0.00270018,0.231281,0.087032,0.0614877,-0.44517,-0.64023,-0.583997,0.656205,-0.247383,0.316546,0.449401,0.301255,-0.663626,-0.418509,-0.363638,0.138984,-0.380933,0.196448,0.184693,-0.105886,-0.00886657,-0.74308,-0.384054,-0.478541,0.326123,-0.161138,-0.285475,0.069104,-0.300159,0.357186,0.0211556,0.488683,0.0228131,0.156824,0.109835,0.341529,0.151285,0.404811,-0.0952367,-0.249437,-0.0269405,-0.0207271,-0.203976,-0.298442,0.135203,0.0925487,-0.0632124,0.184901,0.245761,-0.555711,0.12311,0.158444,-0.0296872,0.523182,-0.011105,-0.198622,-0.342605,-0.212471,-0.306132,0.652136,0.064072,-0.0832155,0.0226277,0.101105,-0.139483,0.313742,-0.36577,-0.121,0.0823813,-0.42324,0.120094,0.225932,0.0748529,0.0873507,0.176906,0.295552,0.420602,-3.52067 +3465.47,0.978289,0.0848144,4,1.59822,1.03707,-0.868017,0.351624,0.767838,-0.0562134,0.137232,0.124155,0.766121,0.217669,0.208049,0.0812497,0.155749,0.151733,-0.572296,1.14474,0.0287696,0.135293,-0.085113,-0.281043,-0.253447,-0.694956,-0.427385,-0.460279,-0.352663,0.209283,0.0523709,0.214303,-0.79758,-0.0313925,0.848673,-0.0578145,0.0460935,0.0247719,-0.489031,-0.284794,-0.599444,-0.0947986,0.376736,-0.0768152,0.974923,0.547343,0.257608,-0.416641,0.0623024,0.299751,-0.161548,0.242582,0.357801,-0.0296773,-0.309349,0.100066,0.112741,-0.235131,0.157636,-0.0346465,-0.234674,-1.64798,0.245378,-0.564934,0.0297579,0.900863,-0.766149,-0.734828,0.1098,0.247511,0.00495769,-0.0630625,0.407635,-0.357524,-0.328424,0.109717,0.713587,-0.000459416,0.294314,0.265308,0.308342,0.236015,0.0506823,-0.0318101,0.450221,0.0390448,0.371003,-0.15118,-0.390465,0.774985,-0.00370342,0.399473,0.199544,-0.303664,0.305791,0.577895,0.0933278,0.30251,-0.0648381,-0.0976515,-0.0259826,0.151879,-0.248406,0.132133,-0.586688,-0.0430073,-0.0155879,-0.709587,-0.318536,-0.938525,0.10036,-0.444025,0.392653,0.828195,0.545929,-0.473606,-0.127391,0.509686,-0.0213838,0.0920804,0.0108915,0.0796371,-0.348258,0.136417,-0.531684,-0.0347169,-0.642639,0.298993,0.0611876,0.257899,-0.00937206,0.218159,0.12463,-0.533848,0.115103,-0.131838,-0.370233,-0.019029,0.245939,0.0694749,0.0357589,-0.0108646,0.113919,-0.368468,-0.780733,0.239878,0.259863,0.0878177,0.0714872,0.258469,-0.0841826,0.475182,-0.27128,0.226454,-0.249728,0.275524,0.26745,0.0234509,0.157549,0.388976,0.2187,0.0682565,0.293301,-0.131909,0.638227,-0.262486,0.59837,-0.150615,-0.0532608,0.346935,-0.134892,-0.50736,-0.160903,-0.000892716,0.0549615,-0.0555039,0.0300111,0.227877,-0.194434,-0.2077,-0.277998,0.295017,-0.0377193,0.322158,-0.0898984,0.227118,-0.165143,-0.0979911,-0.146516,-0.282391,-0.0744637,-0.492556,0.00475206,-0.291402,0.341392,0.317921,-0.0126525,-0.236935,-0.0330144,-0.0335603,-0.152892,-0.436712,-0.471199,-0.132437,0.0288624,0.0225984,0.197063,0.0096844,0.0217017,0.0368368,-0.328052,0.694175,0.294702,0.118508,0.279189,0.090804,0.285946,0.0665732,0.0205395,0.451576,0.208271,-0.025853,-0.18813,-0.176564,-0.114549,-0.0526821,-0.223336,0.155821,-0.261478,0.138606,-0.54912,-0.349675,0.0301013,-0.167075,0.0591678,0.158717,-0.142493,-0.150236,-0.108169,0.83225,-0.107963,0.035694,0.313731,0.18263,-0.116213,-0.01745,-0.0778592,0.276651,0.174057,0.536699,0.20279,0.428278,-0.275809,-0.531658,-0.380276,-0.434899,0.0783303,-0.134432,0.027946,0.369697,0.105624,0.250077,0.126385,0.579778,-0.188791,0.112846,0.333806,0.0732992,0.257584,0.151362,0.00690212,-0.196504,-0.343405,-0.137735,0.0495018,-0.217574,0.132858,0.00666567,0.239944,0.243797,0.12927,-0.0601784,0.648015,-0.0941729,-0.226485,0.201441,-0.247584,-0.242237,-0.459883,-0.0672251,0.0756931,0.442132,0.413731,-0.00171087,0.214232,0.10055,-0.351,0.506096,-0.0758343,-0.720573,0.132121,-0.222023,0.379674,0.121486,0.193089,0.0996782,0.23031,0.315718,0.479906,-2.64767 +3464.23,0.835646,0.0848144,4,1.68366,0.924965,-0.796995,0.247318,0.692087,-0.00446816,0.1033,-0.0825293,-0.122492,0.0511016,0.335759,-0.303058,-0.316912,0.374226,0.264495,0.50146,0.0195386,-0.288419,-0.150884,-0.110658,-0.377502,-1.07565,-0.673364,-0.160165,-0.131054,-0.253271,-0.69968,0.397835,-0.288767,-0.141085,0.76299,-0.79117,0.489318,0.370723,0.0265867,-0.22443,0.00649657,0.379426,0.448575,-0.74302,0.757758,0.531146,0.133757,-0.773643,-0.482639,-0.746135,-0.473635,0.114368,0.154087,0.377108,0.146522,-0.0165877,-0.266017,-0.695644,0.415871,-0.164895,-0.114952,-0.590955,0.655825,-0.232238,0.251858,0.955553,-0.605845,-0.603597,0.0688497,-0.154899,0.0417502,0.216683,-0.327608,-0.896155,0.306002,0.0920163,0.174897,0.0491177,0.662707,0.17633,0.347162,-0.138466,-0.293365,0.0411984,0.292579,-0.437763,0.249883,-0.134414,0.384294,-0.575831,0.306161,-0.069059,0.193442,-0.509115,-0.302495,-0.357708,-0.102292,0.0958226,-0.0394194,0.325167,0.291966,-0.412979,0.576919,0.369419,0.596249,0.0212049,-0.0404194,0.587876,0.396873,-0.211005,-0.151809,-0.00794123,-0.049888,0.15625,-0.351308,0.684841,0.145571,0.689246,-0.0631906,-0.0311316,0.0344093,0.120831,0.387095,0.0332606,-0.460624,-0.216944,-0.266941,-0.202058,0.0376916,-0.195961,0.0742545,-0.236575,-0.208583,-0.304673,0.072532,-0.0792727,-0.0772051,0.559268,-0.297362,0.0250616,0.373772,-0.112765,0.610541,-0.140546,0.0706159,0.100874,-0.00526268,-0.430071,0.150701,0.0961552,-0.0873709,0.501967,-0.159218,-0.268464,-0.31298,0.155572,0.0927626,-0.174842,-0.0652419,0.25872,0.0980764,0.109071,0.00375112,0.0646201,-0.289813,0.320485,0.611918,0.112077,0.159712,-0.35744,0.0599547,0.0773737,0.0522759,-0.0727362,0.369724,-0.332848,0.351689,-0.488926,0.20784,0.0974133,-0.100499,-0.315232,0.0473474,0.581945,0.36537,-0.337781,0.0377057,-0.164076,0.376354,0.107786,-0.423605,-0.103551,-0.1797,-0.0123603,-0.33563,-0.241204,0.240387,-0.430841,0.133755,-0.0487742,-0.0270933,0.0224345,0.105038,0.302979,0.1645,-0.21664,0.00924226,0.592222,-0.236921,-0.0603043,-0.327768,0.769197,-0.181561,-0.017837,-0.0624596,-0.211127,0.314811,-0.271777,0.0291476,0.0469091,-0.290137,0.327536,-0.0307553,0.100706,0.00579143,-0.102752,0.2406,0.264863,-0.751495,0.387878,-0.100561,0.0895833,-0.0113434,0.122229,-0.294691,0.377162,-0.0420955,-0.148022,-0.310401,-0.127522,0.0911151,0.101156,0.447735,-0.365407,0.0685553,-0.254849,-0.0391768,-0.530245,0.380885,-0.0682208,-0.38888,-0.265656,0.0702971,-0.0471802,-0.427545,-0.43009,0.27834,-0.293986,-0.313479,0.165147,-0.456234,-0.188399,0.119482,-0.211446,0.134228,0.0958949,0.320337,0.466487,0.0746857,0.0605316,-0.412697,-0.140479,0.141866,0.16539,-0.145544,-0.18937,-0.179069,0.253098,-0.151284,-0.126656,0.121296,-0.19813,-0.420585,-0.0602254,0.273193,-0.227306,-0.0980638,-0.0927866,0.312012,-0.0515007,-0.513639,-0.137505,-0.101217,-0.371286,0.0703792,-0.269849,0.393901,0.126904,0.053579,-0.257085,-0.566365,-0.356947,0.147738,-0.116938,-0.413753,0.0950152,0.168747,0.308245,0.410789,-2.06389 +3448.95,0.554135,0.0848144,4,1.63627,0.938219,-0.648269,0.156004,0.706608,0.0121557,0.0935437,-0.0231876,-0.446753,0.139471,0.0794364,-0.0381808,-0.28859,0.2703,0.0707393,0.594727,0.0370588,-0.119595,-0.00802843,0.0252441,-0.406873,-0.835737,-0.485747,-0.0356537,-0.187321,-0.37429,-0.63918,0.444613,-0.310456,-0.000817638,0.574071,-0.305039,0.524647,0.184175,-0.231616,-0.089352,-0.133127,0.253604,0.499596,-0.916132,0.82828,0.510649,0.140936,-0.562636,-0.379143,-0.443495,0.0698732,-0.159946,0.323371,0.165762,0.112332,0.274309,-0.129014,-0.341797,0.773338,-0.202112,-0.319948,-0.766537,0.642433,-0.427006,0.450979,1.06447,-0.610342,-0.453934,0.241095,-0.330689,0.0303685,0.135459,-0.259597,-0.683632,0.0410655,0.348619,0.199885,-0.211425,0.629666,0.32875,0.043992,-0.102578,-0.65487,0.0164769,0.457981,-0.379455,0.0628377,-0.0560217,0.147628,-0.326447,-0.416963,0.167762,0.146476,-0.440165,-0.157958,-0.425165,-0.466465,-0.133091,-0.223099,-0.111037,0.178189,-0.620996,0.361381,0.491272,0.0117865,0.0440426,-0.187027,0.442592,0.190675,-0.619202,-0.0568552,0.0986065,0.304172,0.266704,-0.312044,0.21353,-0.052416,0.689583,-0.0727999,-0.349901,-0.326304,0.226324,0.772953,-0.203877,-0.499294,0.169449,-0.260167,-0.147949,-0.0814442,-0.392591,-0.28254,0.148468,-0.0944505,-0.00865731,-0.111514,0.0070323,-0.379036,0.417756,-0.418667,-0.0666226,0.578245,-0.204515,0.565129,-0.372232,-0.332569,0.388201,0.097663,-0.270802,0.194857,-0.016372,-0.206392,0.319258,0.0232448,-0.270821,0.0150808,0.192374,0.0898668,-0.208019,0.342769,0.293943,0.403836,0.238108,-0.102575,0.307287,-0.357888,-0.161193,1.10575,0.630219,0.0907105,-0.0743736,-0.0278938,0.250601,-0.207194,0.112992,0.386483,-0.324948,0.151661,-0.454274,0.362133,-0.0625729,-0.291189,-0.131924,0.229739,0.915977,0.540222,-0.235992,-0.0182603,0.556117,0.381808,-0.0441264,-0.353658,-0.251972,-0.10018,-0.531612,-0.425366,-0.42747,-0.0648257,-0.400687,0.0816419,-0.0177253,-0.0659294,0.0287021,-0.00792732,0.0342858,0.238081,-0.00139389,0.0550211,0.337451,0.189126,0.0261207,-0.676191,0.833384,-0.421876,0.00231528,-0.0642655,0.114934,0.100103,-0.00824839,-0.146437,-0.086691,-0.663163,0.265106,-0.0212885,-0.0709918,0.385619,-0.300104,0.103523,0.484158,-0.269021,0.540986,-0.321969,-0.0411079,0.259508,0.147499,-0.34627,0.357886,0.0929084,-0.661212,-0.136974,0.0476022,-0.187346,0.392209,0.148593,-0.0362995,0.152645,-0.0738885,0.0946365,-0.107881,0.340596,0.37095,0.0821977,0.112727,-0.116877,-0.397986,-0.380237,-0.615598,0.164129,-0.405707,0.192965,-0.335662,-0.467585,0.184054,0.153876,-0.0901188,0.451905,0.115895,0.181576,0.34047,0.287329,-0.26157,-0.203586,0.0217957,-0.079576,0.0987827,0.0739682,-0.0400836,-0.260894,-0.0813673,-0.218429,0.216497,0.0930143,-0.439457,-0.188099,-0.266633,0.541881,-0.225673,-0.202073,-0.305996,0.142678,-0.0301081,-0.281288,-0.673655,0.0369933,-0.423481,0.0904685,-0.414896,-0.141343,0.276403,0.00880744,-0.10343,-0.394248,-0.748914,-0.0415757,-0.24007,-0.212258,0.0924396,0.176933,0.304039,0.420634,-2.17862 +3465.51,0.948863,0.0848144,4,1.60695,1.00207,-0.491391,0.125523,0.543399,0.0393806,0.0550536,-0.0303899,-0.22826,0.14346,0.181337,-0.270606,-0.24244,0.343258,0.29403,0.379492,0.252934,-0.194401,-0.0971023,-0.0618849,-0.448454,-0.946118,-0.495336,-0.185765,-0.249887,-0.345048,-0.0579878,0.0677054,-0.296029,0.281472,0.587545,-0.154723,0.483575,0.165681,-0.209823,0.183739,-0.224289,0.0613896,0.31883,-0.59559,0.831304,0.657274,0.13586,-0.326037,-0.570405,-0.522932,-0.501954,-0.368313,0.304884,-0.102111,0.178727,0.562575,-0.0165324,-0.257099,0.628016,0.186623,-0.116967,-0.690208,0.731368,-0.283021,0.0802775,0.885777,-0.727567,-0.84418,0.136364,-0.162541,0.331923,-0.149332,-0.437948,-0.310209,0.00889465,0.215288,0.316799,-0.280367,0.514115,0.198143,0.119062,0.0802034,-0.580615,0.333999,0.258817,-0.642946,0.299008,-0.275698,-0.024355,-0.255193,-0.178782,0.348956,0.000301888,-0.0554424,-0.336422,-0.374626,-0.538245,-0.0675171,-0.475239,0.0756998,0.360202,-0.352167,0.0542004,0.442429,0.216714,0.446396,0.20107,0.294587,0.293102,-0.703229,0.0531566,-0.0614698,-0.194794,0.633197,-0.138389,0.359308,0.285202,0.716024,-0.0297687,0.178101,-0.192331,0.10317,0.283399,-0.376218,-0.261757,0.320303,-0.136202,-0.114888,0.0411719,-0.152962,0.165729,0.359843,0.0433978,-0.108697,0.353433,0.00507867,-0.0444392,0.816353,-0.25799,-0.0372474,0.435666,-0.471106,0.420468,-0.194621,-0.55082,0.300439,0.0566041,-0.589081,0.4346,-0.330143,-0.207115,-0.0893986,0.242846,0.170468,0.106471,0.257869,0.214798,-0.236128,0.114598,0.154945,0.46193,-0.0324707,-0.127378,0.134135,-0.204554,-0.197975,1.1721,0.171229,-0.0607587,0.0155376,-0.0368047,0.136128,-0.682545,0.441914,-0.0537876,0.0438655,0.173865,-0.15253,0.288488,0.340424,-0.251087,-0.00480147,0.227853,0.685591,0.268508,-0.330638,0.528813,0.405891,0.38094,0.150779,-0.228909,-0.355887,-0.153184,-0.349256,-0.188062,-0.100823,-0.192113,-0.350595,0.144525,0.311413,0.0408838,-0.0331796,-0.275047,-0.0258634,0.106172,-0.277522,0.136285,0.129675,0.317137,0.0771909,-0.547409,0.999815,-0.472074,0.195463,0.0673813,0.116648,0.05837,0.399612,-0.291273,0.422891,-0.616154,0.212382,0.235185,-0.299874,0.0464218,-0.32088,0.0829073,0.195708,-0.0323641,0.410431,-0.155142,-0.128794,0.00300424,0.0179256,-0.287503,0.207803,0.121694,-0.295628,0.110689,0.309007,-0.11478,0.255147,0.558706,-0.176174,-0.216055,-0.0610741,0.112383,0.0923605,0.0928373,0.355397,0.0663683,0.268577,-0.143781,-0.262483,-0.459409,-0.676444,0.184074,-0.558462,0.509612,-0.0546074,-0.429481,-0.072064,0.529606,-0.138829,0.406142,0.481678,0.0196755,0.350799,0.176962,-0.0991353,0.0139898,0.17155,-0.0809765,-0.137621,-0.136533,-0.248638,-0.107788,0.0332543,-0.0571133,-0.150568,0.151875,-0.318384,0.203766,-0.169992,0.527107,-0.145621,-0.322885,-0.399141,0.094306,0.00273438,-0.223249,-0.0291074,-0.0195749,-0.463135,0.14164,-0.451959,0.0227781,0.630987,-0.18504,-0.267705,-0.481333,-0.339258,0.306742,-0.0658429,-0.260794,0.104686,0.136895,0.323552,0.369994,-1.83933 +3457.34,0.9886,0.0848144,4,1.63007,0.835993,-0.904955,0.276554,0.628881,-0.0133753,-0.0867041,-0.156037,0.264503,0.0316326,-0.0692105,-0.345606,-0.0445662,0.26282,-0.201081,0.481737,0.148234,0.198011,-0.209418,0.00905151,-0.151582,-0.5566,-0.45292,-0.0524689,-0.167599,0.141859,0.145258,0.262896,-0.482251,0.14291,0.597421,-0.152738,0.0500408,0.07927,0.0836309,-0.300545,-0.357741,0.27165,0.587368,0.0447427,0.588278,0.188011,0.0665912,-0.586641,-0.0462873,0.225773,0.0390297,0.302269,0.400164,0.0114129,0.221525,0.187961,0.354126,-0.468359,0.635788,-0.235483,-0.1678,-0.576017,0.333955,-0.214618,0.123798,0.63934,-0.407068,-0.0781743,-0.28806,-0.253541,0.0377462,0.236188,0.0576423,-0.225296,-0.136981,0.499359,0.62598,-0.213531,1.12736,0.312327,0.291343,-0.102935,-0.143985,0.163902,0.230688,0.104317,0.474427,-0.425629,-0.0876394,0.270972,0.120964,-0.225218,0.115375,-0.0862474,-0.433622,-0.594536,0.634156,0.0702432,0.271458,0.475587,-0.544042,0.0718583,0.400398,0.364212,0.0714079,-0.448967,-0.240805,0.200765,0.298385,-0.128662,-0.0472543,0.221801,0.971831,0.368159,-0.286606,-0.358373,0.424675,0.454674,-0.323061,0.234718,-0.566146,0.141349,0.151291,0.0918589,-0.373729,-0.206725,-0.73445,-0.00718198,-0.383442,-0.209287,0.368202,-0.185996,0.313397,-0.285593,0.269005,0.089752,-0.362642,0.774224,-0.0900698,-0.214669,-0.310256,0.116692,0.295186,-0.759736,-0.0869306,-0.0750055,0.00679483,-0.487977,-0.52182,0.0714453,-0.0747288,0.486123,-0.041847,-0.220673,-0.853648,0.0945967,0.186394,0.244653,0.15738,0.924478,-0.348165,0.360767,0.540819,-0.307242,0.108869,0.388931,0.769889,-0.0463977,-0.276158,0.166797,0.177922,-0.0437167,-0.449008,-0.543282,0.150436,0.00402352,0.175605,-0.634314,-0.159092,-0.22284,0.0686552,-0.170298,0.726233,0.643716,0.28714,-0.174654,-0.14819,0.252857,0.0022517,-0.421342,0.00352898,-0.179529,0.150413,-0.144865,-0.21562,-0.16202,0.232895,-0.671561,0.09429,-0.0394949,0.136233,-0.350516,-0.223236,0.143819,0.158755,0.345844,-0.256704,0.315929,-0.429834,0.488757,-0.790412,1.1126,-0.0856039,0.0767786,0.266206,-0.285653,0.360661,-0.0343448,-0.477185,-0.0595677,0.353244,0.13362,0.111776,-0.302992,0.236973,-0.500273,-0.0176483,0.14258,-0.336994,0.388472,-0.353859,-0.387266,-0.0243648,0.077691,-0.0426119,0.322247,-0.204306,0.260892,-0.465069,0.624113,-0.375855,0.0404936,0.701865,-0.166418,-0.13116,0.345149,0.228268,-0.140473,0.51604,-0.370048,0.244585,0.491569,-0.287628,-0.698622,0.0662876,-0.408173,0.296053,-0.123409,-0.101988,0.162262,-0.316004,0.312115,-0.10442,0.491145,-0.443592,-0.0602684,-0.0298909,0.156625,0.457576,-0.160234,0.0256348,-0.587129,-0.379666,-0.0186309,0.0072165,-0.122897,-0.405485,0.751048,-0.00908256,-0.257705,0.0243693,0.212755,0.0580172,-0.142338,-0.252983,0.147489,-0.20875,0.592915,0.146245,0.35808,-0.15238,0.101585,-0.0430621,0.160797,0.108492,0.195461,-0.152369,0.10582,-0.00182821,-0.924512,-0.184758,0.0139417,-0.464307,-0.166941,-0.187415,0.147917,0.111357,0.3846,0.333701,-1.71913 +3419.34,0.930895,0.0848144,4,1.64215,0.869976,-0.545664,0.234011,0.665845,-0.112315,-0.349093,0.0675376,-0.399925,0.163883,0.108048,-0.28679,-0.339016,0.419511,-0.059792,-0.0392796,-0.0622721,0.185285,-0.0209156,-0.0988019,-0.0421653,-0.930146,-1.129,-0.00517289,-0.280612,0.0957573,0.231213,0.412761,-0.264507,-0.0196666,0.74392,-0.105078,0.616843,-0.0187424,-0.106833,-0.220165,-0.204558,-0.0746936,0.3102,-0.369527,0.775567,0.521975,0.285814,-0.291394,-0.197588,-0.312689,-0.27923,-0.3032,0.0272907,-0.0867848,0.0832167,-0.0999781,-0.0438801,-0.1757,0.746608,-0.0533316,-0.0523295,-0.214953,0.153602,-0.330044,0.317083,0.757155,-0.671011,-0.846897,0.025851,0.724886,-0.0944322,0.433058,0.603028,-0.575529,-0.15721,0.0126091,0.352932,-0.0792817,0.958738,0.737756,0.0874481,-0.0605926,-0.375115,0.0598156,0.83062,-0.509949,0.476678,-0.0218399,-0.36724,-0.225572,-0.28119,0.565916,0.148179,-0.387265,-0.768871,-0.517379,0.357587,-0.00498747,-0.0883111,0.244259,-0.486244,-0.42368,-0.24663,-0.0204947,-0.210131,-0.180486,-0.340235,0.384745,0.489772,-0.475366,0.551625,-0.191716,0.254464,0.288269,-0.0388527,-0.611083,-0.0874409,0.463262,-0.0190504,0.0486427,-0.5312,0.692552,0.142283,-0.869898,-0.195579,-0.0515994,0.065837,-0.0107695,0.0621548,-0.525777,0.431801,-0.236761,0.48951,-0.285931,0.0823384,-0.0512447,-0.477823,1.13389,-0.463498,-0.299937,-0.224969,-0.23974,0.15912,0.345154,0.292187,0.058661,-0.0277188,-0.389128,-0.27189,0.125676,-0.378143,-0.0604603,-0.395908,-0.188099,-0.296091,0.440944,0.122597,-0.274202,0.335824,0.613233,0.181258,0.19576,0.345233,0.364314,0.137949,-0.0910816,0.658502,0.121702,-0.579024,-0.018923,0.177109,-0.048639,0.0851826,0.107022,-0.085419,-0.352137,0.0193038,-0.66397,-0.353474,0.208354,-0.246248,-0.35463,0.106415,0.792599,0.00431922,-0.326715,-0.800046,0.168551,-0.338054,-0.601635,-0.366119,-0.289598,0.78102,0.268716,-0.420675,0.216335,-0.0993424,-0.0237899,-0.359174,1.27288,0.00116049,-0.245845,-0.438278,-0.0147995,0.297571,0.035676,-0.333135,-0.256398,-0.272571,0.193548,-0.124395,1.13289,-0.307913,0.251332,0.276945,-0.280449,-0.184691,-0.352689,-0.00526381,-0.187051,-0.443847,0.348216,-0.229154,-0.00629883,0.283894,-0.916186,-0.27277,-0.136972,-0.811977,0.350287,-0.638616,-0.482104,0.173838,-0.450607,-0.37482,-0.0877653,-0.106562,-0.207492,-0.646113,0.690181,0.0671996,0.0971695,0.353699,-0.275732,-0.0304398,0.0839265,0.503806,0.365131,0.4117,0.353981,0.595363,0.195004,-0.530021,-0.456201,-0.148639,-0.35347,0.452293,-0.306135,-0.106303,0.137704,-0.139781,0.432455,-0.0057648,0.181141,0.0628156,-0.259558,-0.193529,0.338296,0.182611,0.433897,0.319144,-0.542557,-0.21371,0.0691675,-0.55695,-0.791772,-0.406278,0.121782,-0.50904,0.018327,0.310554,-0.0238837,0.0742569,0.0322428,-0.313806,-0.318923,-0.464499,0.170935,0.174468,0.13979,-0.12614,0.52944,0.249286,-0.404131,0.0194208,-0.0457481,0.0752525,-0.060337,0.389563,-0.379346,-0.580887,-0.187303,-0.420682,-0.27867,-0.186838,0.142273,0.106991,0.377191,0.327095,-2.01353 +3417.17,0.908216,0.0848144,4,1.57771,0.797817,-0.599959,0.2389,0.813947,-0.0829462,-0.0805285,0.257987,-0.0902172,0.05624,0.216917,-0.296868,-0.487282,0.452682,-0.156889,0.281948,-0.02693,0.209374,-0.284501,0.104541,-0.13878,-0.937362,-0.810656,0.12299,-0.329593,0.252282,0.142113,0.672198,-0.563234,0.0137088,0.720553,-0.0475889,0.508533,-0.0963615,0.0549162,-0.122465,-0.436725,-0.0136487,0.258521,-0.378919,0.619381,0.535412,0.113829,-0.319553,-0.081398,-0.752901,-0.453836,-0.299865,0.0746989,-0.11606,-0.0609466,0.0283729,0.0475196,0.22287,0.805484,-0.211546,-0.0868161,-0.183493,0.280724,-0.385414,0.107033,0.818153,-0.377553,-0.948197,0.219237,0.857332,-0.233721,0.377586,0.678405,-0.618004,-0.192383,-0.146808,0.466893,0.0833152,0.958304,0.584741,0.0521854,-0.0518106,-0.409977,0.147314,0.818465,-0.345294,0.376872,0.0247441,-0.178524,-0.0341224,0.124811,0.622154,0.0625054,-0.131651,-0.739194,-0.658424,0.328909,0.101265,-0.0740176,0.00720864,-0.291682,-0.292328,-0.207117,0.258505,0.20602,-0.175098,-0.381331,0.446977,0.702138,-0.554991,0.414564,0.0910108,0.186743,0.316374,0.0229952,-0.491326,-0.0952145,0.433941,0.154971,-0.407907,-0.386841,0.504428,0.245024,-0.837153,-0.215606,0.0963165,0.130324,0.143409,0.216891,-0.267154,-0.0750942,-0.127016,0.41274,-0.281122,0.0435797,-0.00270529,-0.362431,1.10801,-0.334021,-0.404676,-0.242389,-0.477046,0.551453,0.31584,0.380818,0.340693,0.225682,-0.522017,-0.100342,-0.171544,-0.515251,-0.157565,-0.443135,-0.49153,-0.286699,0.473865,0.0761147,0.000420428,0.371978,0.662537,0.177453,0.19289,0.242237,0.125352,-0.0345716,-0.495675,0.776111,-0.0325127,-0.623029,-0.0911741,0.236129,0.0835438,0.35736,0.0624976,-0.206151,-0.420455,0.0539583,-0.724418,-0.425788,0.108289,-0.0887799,-0.255708,0.233122,0.761736,0.261486,-0.375296,-0.7067,-0.136949,-0.255516,-0.607811,-0.398368,-0.402308,0.550185,0.340501,-0.325401,0.374488,-0.0346895,-0.360159,-0.143227,0.765764,-0.0891958,-0.0117198,-0.285777,-0.177435,0.335067,0.29265,-0.0908264,-0.315585,-0.240146,0.290921,-0.219727,0.947025,-0.386567,0.173928,0.720207,-0.486955,-0.0447133,-0.182814,-0.0992943,-0.124996,-0.394135,0.188387,-0.371946,-0.102657,-0.157132,-0.75215,-0.43287,0.0766375,-0.744976,0.529432,-0.640705,-0.479665,0.284419,-0.142512,-0.477087,-0.0107766,-0.146103,-0.333061,-0.558632,0.680153,-0.115696,0.275275,0.387694,-0.435657,-0.270894,0.154102,0.336885,0.592327,0.300645,0.287308,0.677175,0.393139,-0.786212,-0.546613,0.221654,-0.287915,0.224428,-0.131102,-0.0744767,0.0779487,-0.256013,0.428832,-0.119097,0.254494,0.224464,-0.447232,0.236857,0.26631,0.155654,0.51125,0.47105,-0.309034,-0.207515,0.0911369,-0.219928,-0.645624,-0.37357,0.0923647,-0.391442,-0.0808094,0.230725,0.0557542,0.0682429,0.199437,-0.319198,-0.475325,-0.260054,0.259815,0.293688,0.196806,0.0932653,0.0481725,0.0562171,0.155371,0.0674561,0.522956,0.221244,-0.212345,0.462603,0.0717787,-0.574435,-0.16463,-0.243809,-0.324083,-0.243909,0.146901,0.102929,0.383277,0.320826,-2.42552 +3430.63,0.996785,0.0848144,4,1.63155,0.823272,-0.505232,0.150392,0.458169,-0.140016,-0.141391,0.120364,-0.19598,0.0378798,-0.0949355,-0.282279,-0.215925,0.236269,-0.354982,0.204331,-0.145718,0.16009,-0.197385,0.154277,-0.283951,-0.939133,-0.713085,-0.0961435,-0.303352,0.268573,-0.23003,0.312271,-0.690264,0.0607259,0.627192,-0.213323,0.240591,-0.149383,-0.0759397,0.180284,-0.281114,0.213481,-0.107555,-0.329585,0.68428,0.400175,-0.0240969,-0.16539,-0.0829377,-0.371782,-0.492989,-0.18201,0.306337,0.0985565,0.0866335,0.149241,0.0617331,0.180776,1.00302,-0.266936,0.00129984,-0.224747,0.0113327,-0.358027,0.181559,0.92678,-0.509852,-1.0232,0.0176085,1.02497,0.172473,0.848391,0.366434,-0.586819,-0.0583565,0.0553804,0.686956,0.163646,0.998181,0.644407,0.119131,-0.370615,-0.315794,0.34844,0.689928,-0.323076,0.320855,-0.027692,-0.171077,-0.351664,-0.109805,0.221018,-0.120193,-0.327216,-0.301212,-0.3793,0.623876,-0.061589,-0.140637,-0.539197,-0.349284,-0.244054,-0.145342,0.350059,0.373752,-0.0751274,-0.260356,0.211606,0.741175,-0.415873,0.600982,-0.0380406,0.568531,0.330562,0.456583,0.0151291,-0.430067,0.226899,0.17953,0.272054,-0.306535,0.83687,0.188289,-0.632712,-0.203397,0.125121,-0.0601315,-0.279571,0.174855,-0.303392,0.0689073,-0.0925183,0.191208,-0.497155,0.366993,0.0114064,-0.0558452,1.10356,-0.0977728,-0.197472,0.111329,-0.674008,0.620372,-0.0611491,0.0664759,0.331561,0.0508003,-0.512899,0.371519,-0.122503,-0.495464,0.0746755,-0.333863,-0.305601,-0.492018,0.917535,0.136384,0.0570769,0.285386,0.217045,-0.117665,-0.0814379,-0.0355078,0.307677,-0.249481,0.00920862,0.469844,0.0076436,-0.329247,0.291758,0.476513,0.229054,0.11479,0.0248135,0.0654094,-0.124838,0.0528813,-0.305084,-0.310102,0.11703,0.111837,-0.252427,0.162556,0.756503,0.19188,-0.467713,-0.259219,-0.21189,-0.16121,-0.00330624,-0.21016,-0.00395612,0.412274,-0.00344613,0.0371501,-0.151456,0.224952,-0.0390362,0.0445434,0.590047,0.120804,-0.41246,-0.327816,-0.0302823,0.103981,0.19723,-0.296512,-0.215845,-0.101487,0.388051,-0.282933,1.1633,-0.313966,-0.241512,0.649308,-0.298732,0.0140915,-0.316627,0.384737,-0.0517689,-0.491658,0.146032,-0.38449,-0.661268,-0.197104,-0.754716,-0.553309,0.214045,-0.52299,0.388338,-0.914637,-0.253698,0.0499492,0.462188,-0.38231,-0.151027,-0.252002,-0.295264,-0.518353,0.911787,0.377245,0.359081,0.569573,-0.403936,-0.24759,-0.139465,0.663648,0.583366,-0.0530162,0.240069,0.585433,0.471242,-0.40222,0.00771144,0.221082,-0.560479,0.51602,0.0583122,-0.427167,0.33711,-0.166995,0.624921,-0.150607,0.129755,-0.258893,-0.379556,0.157359,0.0698208,0.175477,0.246836,0.0198439,0.256139,-0.582495,0.600636,0.0141643,-0.445557,-0.608144,-0.148622,0.0363654,-0.151068,0.36573,0.230719,0.22271,0.252153,-0.227495,-0.42978,-0.606887,0.176217,0.370561,0.187674,-0.378647,0.183425,0.0656179,0.124091,-0.0515679,0.653891,0.145492,-0.283446,0.369958,-0.00328345,-0.396498,-0.257325,0.421643,-0.0600695,-0.309284,0.14535,0.133715,0.381247,0.36567,-1.18714 +3419.5,0.897434,0.0848144,4,1.61902,0.922884,-0.866693,0.323215,0.587855,-0.125788,-0.197379,0.347795,0.20001,0.141339,-0.130135,-0.152895,-0.0488354,0.33347,0.044331,0.253699,-0.210104,-0.028307,-0.0937048,-0.231214,-0.158982,-0.930794,-0.972921,-0.0960258,-0.250469,0.351971,-0.0451026,0.133378,0.0759134,0.0385373,0.806239,-0.191725,0.147141,-0.523755,-0.264099,-0.0202548,-0.144984,0.293216,0.393904,-0.0895715,0.766496,0.156017,0.14586,-0.959855,-0.403456,-0.639443,-0.405085,0.358555,0.0817811,0.320194,0.173698,0.128756,-0.34149,-0.540408,0.556306,-0.481021,-0.114679,-0.42832,0.00706396,-0.70623,0.147613,0.432836,-0.540496,-0.547034,0.238949,0.335355,0.168518,0.318701,0.345636,-0.189434,0.491038,0.121944,0.465215,0.507372,0.640393,0.76351,0.265495,-0.179946,-0.268484,-0.213991,0.5316,-0.0602479,0.351025,-0.568347,-0.497767,-0.0136246,0.0883216,0.524404,0.106347,-0.212653,0.139452,0.354664,0.541652,0.245316,-0.336444,0.199499,-0.290732,0.332395,0.417009,0.351104,0.568921,-0.00882061,0.0221055,0.273488,0.648281,-0.0142805,-0.170228,-0.115602,0.0882533,0.0825585,0.0585137,-0.0843284,0.132377,0.371882,0.00157939,-0.0230976,-0.125366,0.213244,0.501862,-0.10213,-0.670755,0.0286056,0.113147,-0.311779,0.447832,-0.423572,0.277201,0.0715565,0.0833902,-0.84434,0.506342,0.0909193,-0.0518162,0.873571,-0.277805,-0.513017,0.176973,-0.459597,0.237847,-0.548236,-0.135094,0.192662,-0.00923776,-0.471654,0.34667,0.24835,-0.0410822,0.741516,0.135849,-0.801443,-0.0632384,0.583833,0.149542,-0.244056,-0.195573,0.266461,0.263029,0.210702,0.140057,-0.196503,0.51909,-0.404052,0.568849,-0.710184,0.405986,0.315718,-0.218947,-0.351735,-0.440332,0.106179,-0.215189,0.340819,-0.301226,-0.0515094,-0.620451,-0.531587,-0.126266,-0.235096,-0.0857179,0.933752,0.197673,0.196789,-0.404437,-0.0652487,-0.527624,-0.0574544,-0.439983,-0.206492,-0.130855,-0.171827,-0.0162603,-0.119609,0.114815,-0.291582,0.172175,0.105171,-0.280509,-0.116225,-0.409264,0.402287,0.153194,0.0980214,-0.478963,0.0981878,0.0655661,-0.0597086,-0.337196,0.875801,-0.587723,0.247638,0.277555,-0.242508,-0.0109335,-0.169346,0.361551,0.328443,-0.749056,0.596282,-0.231725,-0.547127,-0.0962674,-0.258891,0.162494,0.0335064,-0.392012,0.78939,-0.361751,-0.0629297,-0.138543,0.606086,0.510229,0.0602199,0.150916,-0.0273035,-1.05378,0.941233,0.199138,0.495816,0.266222,-0.132265,0.202044,0.130487,-0.25995,0.29523,0.00667374,0.150251,0.805106,-0.273798,-0.0297894,-0.419314,-0.402819,-0.478604,0.919543,-0.368501,-0.021852,0.347345,-0.524977,0.393658,0.426481,0.355707,-0.250352,-0.090323,-0.252517,0.434113,0.663449,0.276188,0.0562607,-0.409585,-0.120835,0.246548,-0.203445,-0.902563,0.0964878,0.262675,-0.166314,0.144126,0.381442,0.127993,0.421317,0.255688,0.0460457,0.0196897,-0.100083,0.512337,0.139439,-0.0325951,0.364586,-0.0535307,-0.0231399,0.294275,-0.150915,0.1097,0.0977116,0.339116,0.196678,0.151142,-0.222234,0.211696,0.265584,0.137474,0.0367408,0.131874,0.171661,0.363144,0.41432,-1.78385 +3426.89,0.903432,0.0848144,5,1.52429,0.96199,-0.845471,0.31238,0.149618,-0.104979,0.236798,-0.0235441,0.281003,0.0960197,-0.0507517,-0.00159292,-0.0308675,0.373986,-0.0789119,0.919444,0.282875,-0.110037,0.244652,0.141953,-0.172559,-0.389897,-0.266737,-0.0960769,0.0366013,-0.289037,-0.0966057,-0.0830459,-0.842264,-0.461409,0.543844,0.0738039,-0.1316,0.0122355,-0.553843,0.0562243,-0.108732,0.425396,0.231743,-0.0831231,0.690313,0.503608,0.115749,-0.751037,-0.160166,0.0132678,-0.538167,-0.115748,0.242024,-0.593454,0.00926606,0.155252,-0.00986993,0.0404536,0.399692,-0.135838,-0.160746,-0.328452,0.132857,0.0668668,0.0260933,0.581111,-0.379426,-0.459901,0.272699,0.413969,-0.368829,-0.0421885,0.225229,-0.288828,-0.782454,0.177278,0.703301,-0.952111,0.456587,0.528408,0.439078,-0.210263,-0.385775,0.00972943,0.10705,-0.674313,0.526373,-0.0880144,-0.234307,0.121654,0.290548,-0.533313,0.651589,-0.183869,-0.327807,0.0298346,0.0515682,-0.109439,-0.176783,-0.735652,0.12227,-0.46714,-0.451635,0.505352,0.385129,0.120353,-0.0182829,-0.407392,-0.0937534,0.101015,0.564829,-0.299409,0.832854,0.830558,-0.480554,0.287655,-0.552399,0.381923,0.442747,0.00622296,-0.791536,0.199687,-0.0805106,-0.161213,-0.282826,-0.515525,-0.538202,-0.77255,-0.317215,0.238531,-0.0700894,0.478701,0.357993,-0.141972,-0.53969,-0.204645,-0.214664,0.35926,-0.052428,0.205191,-0.465447,0.12742,0.159811,-0.93276,0.121298,0.346886,-0.136131,-0.228602,-0.278527,0.377036,0.244599,0.374188,0.0289441,-0.309566,-0.437984,0.26597,0.45563,0.0948269,0.513455,0.80872,-0.275938,-0.637495,-0.0144896,-0.541245,0.285575,0.313593,0.875571,0.38128,-0.0929721,0.148008,0.343945,-0.00082202,-0.175752,0.445321,0.725595,0.413676,0.222953,0.204729,0.331054,-0.143064,-0.133039,0.0789436,0.851796,0.874302,-0.197526,-0.92978,0.732782,0.0392951,0.0857574,-0.0709134,-0.0696535,-0.445357,-0.0239363,-0.195483,0.124645,0.250788,0.196666,-0.867158,0.356146,-0.124558,0.042811,-0.418301,-0.68397,-0.342097,0.101443,0.0415279,0.457192,0.248594,0.54189,0.0498878,0.0376227,1.3444,0.253485,-0.00972273,0.461026,-0.00677053,-0.253681,-0.294803,-0.483944,0.144023,-0.218398,0.460411,0.442585,-0.332498,0.260069,-0.547072,0.681554,0.110489,-0.297909,0.393409,-0.476468,-0.477624,0.0172694,-0.0304135,-0.657763,0.0804565,-0.0732018,-0.26143,0.0934318,0.523311,-0.706783,-0.265409,1.06404,-0.175595,-0.255752,-0.340408,-0.0313581,-0.0155588,0.409546,-0.014456,0.0402256,0.393829,0.0814212,-0.153497,-0.113645,-0.586627,-0.0127408,-0.47662,-0.425451,-0.133961,-0.342702,0.000421303,0.24495,0.23558,0.179409,0.496854,0.757251,0.236607,0.125127,0.0533393,0.0967742,-0.271981,0.123528,0.443488,0.0659287,0.511061,-0.632359,-0.236162,0.346607,-0.602632,0.394846,0.302829,-0.00521366,0.404053,-0.00789328,0.485227,-0.190241,-0.389595,0.339065,0.0798989,-0.458433,0.467693,0.49055,-0.599951,0.211055,0.222568,-0.162942,-0.241032,0.326298,-0.136814,0.382045,0.301034,-0.225066,0.00539064,-0.291021,0.175622,0.099725,0.419072,0.315793,-0.498946 +3440.61,0.567344,0.0848144,4,1.5167,0.827462,-0.87785,0.496746,0.518625,-0.0757592,-0.340134,0.15753,0.347271,0.0737146,0.325118,-0.054802,-0.180208,0.503479,0.17432,0.286794,0.054755,0.250974,0.401928,0.415432,0.127169,-0.563238,-0.648499,0.454728,-0.388477,0.224822,-0.0944393,0.15575,0.491323,0.528208,0.998661,-0.666736,0.208702,0.0112395,-0.127564,-0.43743,-0.326319,0.398725,0.59175,-0.456783,0.678688,0.211737,0.302616,-0.234739,0.298369,-0.0469817,-0.410466,-0.0508557,0.315967,-0.0232916,-0.337163,0.567796,-0.0976099,-0.37444,0.447822,-0.262076,-0.218711,-0.921057,0.120255,-0.443798,-0.0816479,0.794322,-0.487363,-0.652842,0.0128817,0.25827,0.317352,0.0452003,0.0386074,-0.592561,0.192973,0.445882,0.471485,0.235113,0.819363,0.483461,0.226139,-0.461837,-0.335825,-0.143044,0.547669,0.00311657,0.251828,0.234595,0.097585,0.145945,-0.0560791,-0.473389,-0.225775,-0.139103,0.432156,0.414395,0.591633,-0.0724919,0.421802,-0.276881,0.0471026,-0.103022,0.15628,0.245753,0.0553638,-0.177695,-0.62656,-0.243418,0.275814,-0.188724,0.213071,-0.0951754,-0.105299,0.269957,0.257385,-0.212969,0.369888,0.405311,-0.325523,0.137125,-0.0191237,0.231908,0.479096,0.11883,-0.734584,-0.0464972,-0.500361,0.329541,0.515133,0.182173,-0.177565,0.141559,-0.0932691,-0.468532,0.746658,0.207271,-0.0293117,0.681553,-0.0982667,-0.604816,0.105277,-0.624992,0.278336,-0.0851912,-0.878048,-0.00558271,0.260658,-1.02742,0.348054,0.244803,-0.218309,0.453747,0.110687,0.20689,-0.384882,0.584991,-0.30257,0.0325199,-0.451511,0.0496333,0.22963,0.201254,0.387731,0.553501,0.240054,-0.472977,0.301994,-0.401683,0.0916919,0.375097,-0.27938,-0.14571,0.0154947,-0.567647,-0.392111,-0.739094,-0.11392,-0.118302,-0.506516,0.0978789,-0.0483307,-0.358671,0.0325982,0.958515,-0.0203784,0.352769,-0.048669,0.348517,0.0178333,-0.480973,-0.130915,-0.2619,0.318273,-0.571543,-0.049503,-0.311887,0.0329584,-0.0840092,-0.278314,-0.115254,-0.046185,-0.380842,-0.153932,0.381037,0.15694,-0.26217,-0.0593612,-0.248478,-0.269284,-0.217145,-0.50992,0.933053,0.0190249,0.342567,0.149074,-0.342438,0.889165,0.202771,0.0296478,0.271244,-0.67198,0.0614552,0.389608,-0.344218,-0.0925278,-0.594035,-0.326652,-0.0707619,-0.253168,0.455394,0.204734,0.166746,-0.195547,0.0673875,-0.0980713,0.251958,-0.105462,-0.160584,-0.235358,0.627866,0.391736,0.482792,0.410342,-0.482153,-0.221631,0.100923,0.473903,-0.0358584,0.376154,0.552614,0.548133,-0.313326,-0.196669,-0.420018,0.0900216,-0.503756,0.835916,0.138241,-0.531129,0.373441,-0.375138,-0.248314,-0.133805,0.250894,0.450453,0.0363622,0.135195,0.198832,0.253622,0.336569,0.204877,0.0743455,-0.253934,0.261267,-0.510846,-0.671611,-0.0706322,0.391246,-0.460829,-0.585867,0.00813596,-0.116096,0.617239,-0.328507,-0.303566,-0.789442,-0.433419,0.448549,-0.254683,0.310868,-0.00538992,-0.102917,-0.244604,0.197369,0.00190838,0.0899263,0.282418,0.569867,-0.241039,-0.691465,0.287959,-0.0626977,-0.45198,-0.0740469,0.211157,0.133784,0.18813,0.365765,0.433739,-1.65886 +3436.61,0.993547,0.0848144,4,1.59574,0.752922,-1.00327,0.619263,0.506806,-0.0931518,0.0803013,-0.0718478,0.541597,-0.316645,0.39954,-0.121028,0.0619283,0.945991,0.0759242,0.682338,0.0578254,0.41103,-0.145234,0.29285,0.252708,-0.414028,-0.469154,0.338937,-0.107936,0.103807,0.203,0.131014,0.278072,0.510648,0.749315,-0.517445,0.351041,0.244492,-0.356611,-0.693924,-0.616329,0.331009,0.160171,-0.522893,0.864156,0.388535,0.121897,-0.723416,0.0219476,0.006379,-0.361556,0.0345278,0.0868906,-0.116165,-0.116071,0.711054,0.0283888,-0.288361,0.307206,-0.339558,-0.477704,-0.957319,0.0486864,-0.409574,0.220912,0.779372,-0.564222,-1.00312,-0.0690515,0.18181,0.10988,-0.316851,0.0482538,-0.816095,0.217007,0.437303,0.307884,-0.417025,1.04793,0.97006,0.222844,-0.0855617,-0.553996,-0.21546,0.667866,-0.0302016,0.437608,-0.0902915,-0.549311,-0.339477,-0.410378,-0.48493,0.0990099,-0.181941,0.348486,0.0892184,0.143568,0.0546636,0.0540405,0.0569899,-0.231686,0.0106778,0.136689,0.202361,0.184406,0.445313,-0.899345,-0.21667,0.146729,-0.132147,0.0442812,-0.38539,0.0448014,0.356559,-0.0528198,-0.182113,0.0199721,0.405699,0.286399,-0.589678,-0.268769,0.251217,0.432106,-0.188505,-1.04838,0.537906,-0.4401,0.507373,0.391272,0.576728,0.115387,0.599043,0.164776,0.150131,-0.0315597,-0.0367621,0.0889174,0.540791,-0.144721,-0.812095,-0.0338492,-0.521071,0.348283,-0.427144,-1.32287,0.190089,0.185541,-0.766602,0.113896,0.397846,-0.61623,0.195982,0.0431566,-0.130397,-0.304791,0.254047,0.0730899,0.174916,0.374198,-0.0277758,0.206431,0.289009,0.23084,-0.00512481,0.640739,-0.335416,0.406892,-0.0604849,0.0521744,0.42246,-0.159608,0.0250502,0.27779,-0.16094,-0.191006,-1.03394,-0.251365,-0.425415,-0.101752,-0.167153,-0.27329,-0.41565,-0.0727165,0.612606,-0.0670897,0.0866946,-0.0932072,0.196167,0.0581607,-0.480292,-0.159562,-0.106892,0.11211,-0.224585,-0.0969724,-0.0334146,0.156919,-0.297125,-0.0225088,0.389242,-0.0807553,-0.23642,-0.521162,0.101616,0.0339771,-0.258497,-0.279744,-0.413804,0.42328,-0.519448,-0.457349,1.03042,-0.413496,0.128824,0.200412,-0.133397,0.819153,0.387528,0.144382,0.265283,-0.242465,0.198839,0.217698,-0.0910291,-0.173296,-0.76095,-1.07043,-0.113595,0.15198,0.481153,-0.3505,-0.0829916,-0.366005,0.414108,-0.44787,-0.187051,0.0977635,0.041359,-0.391641,0.653753,0.608391,0.450899,0.483061,-0.820497,0.00795564,-0.0194059,0.164194,0.12969,0.399334,0.355287,0.341633,0.124055,-0.492901,-0.724067,0.124748,-0.294579,0.733012,-0.477246,-0.558923,0.509583,-0.259859,-0.243604,0.472272,0.0473717,0.0666065,-0.207761,0.309377,-0.0079879,-0.295015,0.0621347,0.21514,-0.926862,-0.180069,0.135047,-0.30762,-0.317928,-0.536978,0.236049,-0.288362,-0.300554,0.137705,-0.0506516,0.296866,-0.40279,-0.0560068,-0.50628,0.193904,0.616184,0.0752943,0.439836,-0.350214,0.0783444,-0.0983105,0.169251,-0.178903,0.209822,0.0180469,0.218941,0.0439471,-0.210576,0.242183,0.137084,-0.788913,0.073743,0.219092,0.152276,0.196343,0.390226,0.443107,-1.45474 +3421.51,0.586434,0.0848144,4,1.5624,0.790132,-1.01172,0.495537,0.35113,-0.0813658,0.0718352,0.125415,0.322669,-0.277006,0.1539,-0.110254,0.134364,0.677184,-0.1468,0.68259,-0.00450968,0.275481,0.195997,-0.233191,0.219952,-0.727717,-0.777809,0.212236,-0.267364,0.515805,0.0811537,0.367214,0.124141,0.229484,0.913534,-0.396194,0.0826359,0.23734,-0.518934,-0.353906,-0.192582,0.56243,0.28312,-0.596651,0.77652,0.627503,-0.167862,-0.442723,-0.122111,-0.352931,-0.559445,0.396199,0.352768,-0.0873933,-0.229033,0.93876,-0.106765,0.288954,0.370143,-0.592664,-0.261718,-0.849081,0.0235055,-0.632874,0.34687,0.570369,-0.646476,-1.43253,-0.490224,0.492306,-0.117252,0.188997,-0.041904,-0.806195,-0.0265894,0.490593,0.465684,-0.34293,0.704957,0.667553,0.286713,-0.297206,-0.408394,-0.411494,0.82437,-0.474553,0.483926,-0.148307,-0.296554,-0.133774,-0.20615,-0.317937,0.0280981,-0.120409,0.173463,0.0749076,0.0554164,-0.283175,-0.0692319,-0.129821,-0.311206,-0.0323418,-0.145049,0.449269,0.295695,0.146194,-0.865109,-0.04185,-0.0289357,-0.411812,-0.379016,-0.0349882,0.302732,0.636481,0.0514579,-0.187063,0.00147564,0.34433,0.336797,-0.254713,-0.0221733,0.270487,0.231238,-0.390905,-0.492592,-0.00869247,-0.328108,0.357671,0.262254,0.249476,0.34729,0.504648,0.163149,-0.0779059,0.0486887,-0.38633,-0.0430333,0.471026,-0.0129213,-0.486859,0.0979821,-0.342095,0.0955565,-0.0293015,-1.00038,0.121939,0.0776317,-0.360671,-0.0209587,0.723764,-0.37961,-0.0586466,0.0595697,-0.0453083,-0.310579,0.610532,0.359688,-0.118515,0.879394,0.410114,0.106852,0.390099,-0.079956,0.0335226,0.26963,-0.060175,0.680515,-0.0772787,-0.231102,0.160815,0.0637302,-0.31499,-0.0557212,-0.171924,-0.426505,-0.453142,-0.393377,-0.260862,0.100337,-0.741606,-0.456514,0.322154,-0.0880548,0.742961,0.14749,0.257585,0.0739289,0.717494,0.30423,-0.359303,-0.189625,-0.491441,0.108548,-0.329644,0.0362539,-0.165721,0.118211,-0.354571,0.0550909,0.00451782,-0.222604,-0.323922,0.336173,-0.0063604,0.304727,-0.377263,-0.213492,-0.256399,0.285278,-0.357818,-0.410101,0.96604,-0.511981,0.128533,0.600923,-0.478734,0.517563,0.131138,0.261655,0.435713,-0.140249,-0.129022,0.210852,0.0534971,0.0610173,-0.705297,-0.715696,-0.169747,0.186658,0.360372,-0.471226,0.066352,0.19045,-0.0387303,-0.0610355,-0.0281855,0.12445,-0.221796,0.0740169,0.34318,0.357567,0.413439,0.743356,-0.73878,0.0511232,-0.0389367,0.0508725,0.564349,0.310881,0.534206,0.400775,0.207991,-0.451086,-0.768995,-0.171897,-0.185917,0.643438,-0.492701,-0.16013,0.384133,-0.44865,0.0556024,0.539431,0.249631,0.0695887,-0.0580683,0.25803,0.128515,-0.109331,0.463398,0.323908,-0.359695,-0.212999,0.365543,-0.196777,-0.33009,-0.7566,0.0827119,-0.164915,-0.00980664,-0.227485,-0.267482,0.601331,-0.832566,-0.181315,-0.123444,0.131207,0.886543,0.0523365,0.297345,-1.00546,-0.323146,-0.471853,-0.277916,-0.131106,0.424957,-0.323411,0.0858127,0.0145458,-0.203362,-0.0805884,0.052947,-0.474653,0.164498,-0.0557549,0.136223,0.244763,0.369084,0.494735,-0.918225 +3417.3,0.994725,0.0848144,4,1.68677,1.00482,-0.941456,0.439867,0.748055,-0.104758,-0.627182,0.145155,-0.0056339,-0.0139118,0.198328,-0.15103,0.114059,0.539287,0.256416,1.10345,0.106702,0.173651,-0.115489,0.00490206,0.0871769,-0.821781,-0.316611,-0.120564,-0.215197,0.145894,-0.432528,0.481124,0.190478,0.481665,0.469906,-0.150413,-0.0298468,-0.221858,-0.413499,-0.347883,-0.617404,0.314409,0.277822,-0.416561,0.764603,0.358799,0.142809,-0.832061,-0.00306733,0.299898,-0.772751,-0.274017,-0.139634,-0.37402,-0.0253189,0.629478,-0.0118879,-0.346416,0.176835,-0.715949,-0.215916,-1.05377,0.473096,-0.785743,0.199488,0.834867,-0.842036,-1.17323,-0.190329,0.421189,-0.240818,0.250636,0.745456,-0.567961,0.135273,0.13166,0.392291,-0.464807,0.29929,0.353676,0.318762,-0.0191928,0.248136,-0.198939,0.231514,-0.308715,0.361543,0.038274,-0.205839,0.0322976,0.134745,-0.0134007,-0.335255,-0.42611,-0.051179,0.293992,0.308543,-0.299021,-0.229272,-0.447986,-0.314195,-0.752312,-0.255953,0.420022,-0.0888647,-0.0203541,-0.147411,-0.365381,0.779139,-0.458634,-0.26613,-0.412282,0.288897,0.706406,-0.138177,-0.26952,0.0541772,0.192496,0.244464,-0.00989064,0.202792,-0.211231,0.104334,0.463384,-0.678362,0.262218,-0.979384,-0.24484,0.266466,-0.530885,0.391103,0.54791,0.0668559,-0.464037,-0.424737,-0.124821,0.418422,0.488254,-0.159919,0.182488,0.206318,0.0154166,-0.0466351,-0.552231,-0.69087,0.118922,0.0794708,-0.440977,-0.717889,0.48334,-0.775827,-0.0657657,0.18153,0.102154,-0.0804998,0.217394,-0.0132728,0.371497,0.302639,0.633527,-0.394727,-0.0826335,-0.0051825,-0.250927,0.642726,-0.163717,0.505007,-0.0576827,-0.325212,0.0868837,0.172705,-0.142158,-0.309346,0.366828,0.130159,-0.485455,0.0392123,0.246378,-0.364566,-0.367438,-0.28651,-0.0928905,0.242315,0.713554,-0.0691496,-0.0439698,0.23803,0.432954,0.149339,-0.529635,-0.379674,-0.564466,0.356093,0.142313,-0.25031,-0.324526,-0.00824306,-0.462479,-0.270322,0.14198,-0.097227,-0.769915,-1.12075,0.0621922,0.0256403,0.26943,-0.213828,0.0560774,-0.037423,-0.643591,-0.503611,0.979648,-0.171313,-0.193262,0.172021,0.15363,-0.0515847,0.442934,0.542133,0.224249,-0.161513,0.173605,0.286698,0.086842,0.153306,-0.737364,0.00982818,-0.0337178,-0.0229879,0.429321,0.0785926,-0.288463,-0.683991,-0.0853969,-0.111065,-0.0673004,0.382056,-0.614131,-0.431754,0.134569,-0.0820917,-0.118297,0.63214,0.0288037,0.331186,-0.507707,-0.0289344,0.0776011,0.167951,0.535403,0.440531,-0.325839,0.0928359,-1.00924,-0.0142822,-0.667698,0.503497,-0.409874,-0.284874,0.65261,-0.423389,0.144947,0.091917,-0.136563,0.305381,-0.222127,0.330018,-0.240701,-0.072631,0.18157,0.124869,-0.394501,0.104673,-0.0151452,-0.631501,-0.723226,-0.27977,0.156905,-0.046064,0.170781,0.0822926,-0.516217,0.712766,-0.488421,-0.485509,-0.0898562,-0.103583,0.0682622,0.24728,0.0194597,-0.568236,-0.0265864,-0.303884,-0.578834,-0.0915357,0.519364,-0.0667122,0.149034,-0.172545,-0.175461,-0.217469,0.496982,0.0688401,0.333285,0.813683,0.130528,0.209152,0.361287,0.457332,-2.4694 +3413.08,0.489487,0.0848144,4,1.66285,0.944696,-1.22677,0.514772,0.170602,-0.142249,0.464477,0.181847,0.35679,-0.0119472,0.040244,-0.149869,-0.0993372,0.317387,-0.446148,0.596911,0.195846,0.0235912,-0.325059,-0.313397,-0.599572,-0.739492,-0.61418,0.0935519,-0.280552,-0.0862893,0.51168,0.225517,-0.490463,-0.214818,0.320549,-0.370117,0.204031,0.247536,-1.05591,-0.246457,-0.328589,0.643571,0.981632,-0.606925,0.894937,0.624429,0.353537,-1.05732,-0.518296,-0.0284371,-0.955337,0.432551,0.569689,-0.117944,-0.0874626,0.524307,-0.263783,-0.396013,0.270409,-0.275864,-0.0676493,-0.642662,0.478989,-0.0112879,0.114856,0.726203,-0.882327,-0.877191,0.106739,0.081923,-0.112524,-0.91244,-0.0117312,-0.330532,-0.690069,0.196836,0.516961,0.510627,1.02268,0.468843,0.0908368,-0.490583,-0.384707,0.259737,0.588104,-0.358515,-0.216687,-0.580467,-0.134365,0.141702,0.0410873,-0.372179,0.442985,0.238811,0.17348,-0.314848,-0.169273,0.295341,-0.197677,0.0786464,0.319675,-0.0532989,0.501954,-0.00655343,-0.0512558,-0.386558,-0.494527,-0.212645,-0.549762,-0.0352205,0.270076,-0.282404,0.311758,0.390457,0.289825,-0.114015,0.588923,0.117477,0.0849669,-0.570387,-0.675952,-0.035632,0.341731,-0.653834,-0.513457,-0.118806,0.355606,-0.496168,-0.0805228,0.632849,0.216377,0.0757047,0.403178,-0.28147,0.646369,-0.15862,-0.382461,0.310058,-0.0167238,-0.654007,0.0313066,-0.105433,0.573121,-0.333355,-0.390778,-0.376147,0.285651,-0.614149,0.237956,-0.385345,0.303539,0.590278,0.144824,-0.207524,-0.266033,-0.2429,0.435604,-0.56253,0.0894034,0.0693588,0.037835,-0.026206,-0.0940416,0.238088,-0.345223,0.277172,0.448136,-0.130816,0.21929,0.23508,-0.422955,-0.017346,-0.121385,-0.599645,0.171231,0.647471,-0.485734,-0.468567,-0.16604,0.0499434,-0.593191,-0.299604,0.0132479,0.745504,0.43437,-0.329005,0.413588,-0.0105539,-0.238702,0.651412,0.286976,-0.211499,-0.0723229,-0.682887,0.0975281,0.240721,-0.161978,-0.491011,-0.322594,0.534982,0.0701318,0.11627,-0.130068,-0.233762,-0.31717,-0.587607,0.427947,-0.214551,0.039555,0.444768,-0.572038,1.30059,0.0589,0.239116,0.0575361,-0.572392,0.18127,0.0154008,-0.685736,-0.369904,-0.0671344,-0.201394,0.264536,-0.424573,0.0718812,0.0114363,-0.159999,0.335304,-0.339877,0.0247425,-0.385639,0.148386,0.578654,0.291186,-0.201513,-0.218804,-0.141069,-0.0773701,-0.448197,0.324435,-0.197589,0.0313089,0.370223,-0.187528,-0.737241,0.619006,0.254745,0.254888,0.924608,0.145571,0.305794,0.806055,-0.580387,0.116432,-0.216891,-0.329344,0.360186,0.061327,0.66226,0.253217,-0.185613,-0.230797,-0.0623025,0.00787062,0.252788,0.586826,0.292722,0.254478,0.424966,-0.00328729,0.404345,-0.0248787,0.223779,0.242818,0.172753,0.256954,-0.0144008,-0.135441,-0.492542,0.0235201,0.0793504,0.213481,-0.454495,0.292985,-0.179612,-0.532207,-0.592888,0.0104435,-0.314502,-0.130014,-0.167661,-0.0296329,0.120605,-0.605582,-0.220775,-0.0329528,-0.697939,0.192726,-0.639392,-0.52059,0.202798,-0.426139,-0.251877,-0.35788,-0.434259,0.13814,0.284412,0.371671,0.533303,-0.381758 +3415.5,0.397182,0.0848144,5,1.64884,0.943353,-1.12181,0.459386,0.502226,-0.152253,0.618801,0.328539,0.22596,0.133413,-0.182681,0.0508352,0.0376963,0.305395,-0.629209,0.515459,-0.0115004,-0.0882541,-0.149121,-0.264922,-0.784752,-0.959571,-0.532251,0.310542,-0.286422,-0.14633,0.412123,0.0701701,-0.102436,-0.227513,0.344113,-0.184769,0.0984674,0.0361272,-0.986412,-0.396238,-0.158333,0.495285,1.1394,-0.454568,0.862876,0.658921,0.173755,-0.855287,-0.363171,0.132266,-0.85213,0.380989,0.404647,-0.0130422,-0.0929657,0.492941,-0.0954388,-0.0821043,0.389881,-0.30633,-0.0439461,-0.913498,0.460489,-0.065658,0.398382,0.776655,-1.09084,-0.875573,0.160215,0.0481868,0.0996897,-1.03765,-0.186372,-0.486764,-0.626289,0.142263,0.38991,0.650902,0.879763,0.561474,0.0741361,-0.221087,-0.285729,0.131767,0.475744,-0.182076,-0.231743,-0.625654,-0.25378,0.272149,0.0908807,-0.313379,0.424961,0.358628,0.0435607,-0.457603,-0.359565,0.277657,-0.183317,0.15054,0.217586,-0.184593,0.456076,-0.0331594,0.153542,-0.345652,-0.536094,-0.352562,-0.352029,-0.0993327,0.24797,-0.404737,0.199765,0.535761,0.144097,-0.141245,0.710315,0.143255,0.150391,-0.59296,-0.53438,0.0922986,0.368426,-0.55409,-0.596375,-0.079824,0.509162,-0.581283,0.0921105,0.580764,0.126984,0.272707,0.431908,-0.235474,0.289704,-0.24725,-0.20155,0.239881,-0.292666,-0.616137,-0.0995342,-0.12363,0.630508,-0.28437,-0.568992,-0.266028,0.157059,-0.672053,0.146976,-0.198273,0.43917,0.424412,-0.0835226,-0.106756,-0.206556,-0.132307,0.347428,-0.440665,0.149117,-0.0645242,-0.176444,0.141341,0.0502538,0.149048,-0.260452,0.284746,0.611133,-0.0170467,0.0992866,0.139331,-0.534993,-0.00128533,0.140353,-0.566972,0.277688,0.408068,-0.46307,-0.359199,-0.456001,0.11555,-0.706035,-0.0210479,-0.0112488,0.605669,0.167115,-0.0399261,0.194781,-0.300501,-0.112396,0.459627,0.251125,-0.242741,-0.180042,-0.798544,0.0408883,0.279971,-0.346682,-0.444089,-0.131756,0.510902,0.211968,0.0717133,-0.286684,-0.23993,-0.241831,-0.631771,0.426553,-0.284348,0.190347,0.0914504,-0.747408,1.23521,-0.0485745,0.674711,0.0630613,-0.399199,0.0723614,-0.0161324,-0.659295,-0.41053,-0.202081,-0.169488,0.157607,-0.2657,-0.115104,-0.138212,-0.365528,0.333517,-0.202706,-0.0203267,-0.874267,0.136435,0.35394,0.265296,-0.05695,-0.145789,-0.0941731,-0.04791,-0.456377,0.300682,-0.315294,-0.126222,0.249948,-0.0888401,-0.676796,0.759375,0.336819,0.337355,0.855819,0.276043,0.355958,0.556214,-0.38903,-0.134051,-0.0542208,-0.58396,0.398337,0.0723953,0.694618,0.424763,-0.258171,-0.149407,0.00229715,-0.0309985,0.0512568,0.521406,0.112509,0.167942,0.343346,-0.0523921,0.459562,-0.0381419,-0.172488,0.181707,0.217199,0.120858,-0.179002,-0.271135,-0.319198,-0.149897,0.101872,0.402041,-0.486229,0.369988,-0.0365343,-0.562587,-0.293426,-0.0467977,-0.146853,-0.0570081,-0.155498,-0.162438,-0.0255203,-0.945685,-0.258806,-0.159181,-0.513957,0.0901608,-0.67549,-0.719976,0.139295,-0.378134,-0.149656,-0.405315,-0.0749258,0.135278,0.28474,0.367802,0.53361,-1.49443 +3411.86,0.975856,0.0848144,4,1.62805,0.916562,-1.04935,0.389964,0.250796,-0.175147,0.260271,-0.0969604,0.115793,0.00510486,-0.25726,-0.077953,-0.191133,0.440303,-0.269933,0.487989,0.0498356,-0.00931949,-0.359198,-0.31108,-0.720636,-0.889452,-0.658327,0.425255,-0.327974,0.0526605,0.372772,0.207284,-0.248296,-0.0894826,0.337201,-0.134719,0.126605,0.193897,-0.957728,-0.216082,-0.148505,0.759021,1.31557,-0.515212,1.1432,0.613562,0.201537,-0.718578,-0.384022,-0.17951,-0.815262,0.322707,0.493825,0.233885,-0.204864,0.373298,-0.210202,-0.310674,0.54894,-0.0800383,-0.223373,-0.718669,0.458877,-0.321639,0.409513,1.06968,-0.73583,-1.24826,0.231637,-0.255138,0.138712,-1.22645,-0.0800105,-0.457792,-0.4461,0.0873681,0.364795,0.327727,0.960272,0.463797,0.039818,-0.122383,-0.281744,0.443253,0.273311,0.00618203,-0.146128,-0.513193,-0.208418,0.317441,0.31282,-0.218358,0.467599,0.549066,0.0423251,-0.00627915,-0.162558,0.254125,-0.40192,-0.299285,0.186837,-0.178507,0.38021,0.00571986,0.0631869,-0.140874,-0.434158,-0.216044,-0.320116,-0.254063,0.234964,-0.45631,0.226449,0.561658,0.238845,-0.422809,0.888172,0.182565,0.106198,-0.548773,-0.541693,-0.016489,0.225089,-0.328956,-0.486762,0.0801059,0.712387,-0.318967,-0.124824,0.599444,0.0525139,0.199482,0.163207,-0.312235,0.0944109,-0.345052,-0.316052,0.0443879,-0.0670185,-0.267116,-0.169978,0.206021,0.530903,-0.352586,-0.70759,-0.264739,0.129697,-0.257472,0.365363,-0.215792,0.490731,0.383888,-0.214685,0.0899128,-0.118061,-0.0481886,0.49769,-0.205315,0.390645,-0.116407,-0.142987,0.00765158,0.0231586,-0.0156914,0.0335072,0.373441,0.819698,0.379588,0.0768402,0.0350484,-0.409672,-0.0464173,0.107801,-0.389998,0.222397,0.289741,-0.419445,-0.460369,0.0269854,0.116088,-0.44572,0.0945778,0.0410012,0.674946,0.208307,0.0306905,0.429909,-0.17766,-0.491758,0.479921,0.0950225,-0.311882,0.352394,-0.657209,0.149757,0.358911,-0.270485,-0.550848,-0.262263,0.515432,0.151502,0.0969949,-0.208844,-0.117865,-0.481,-0.373284,0.170801,-0.119595,0.342557,0.0334843,-0.928679,1.14283,-0.0789656,0.873389,0.165616,-0.362844,0.143786,-0.215917,-0.492746,-0.121292,-0.0172195,-0.398294,0.3098,-0.603518,-0.126067,-0.209069,-0.210264,0.582825,-0.108113,0.252329,-0.996375,-0.0895611,0.235131,0.333072,0.114777,-0.126109,-0.328724,-0.394422,-0.425828,0.482464,-0.0158394,0.191701,0.362771,-0.232783,-0.915253,0.609506,0.107247,0.40512,0.511023,0.15445,0.827812,0.305437,-0.624928,-0.174522,-0.142103,-0.637827,0.407401,0.221745,0.729908,0.305542,-0.430744,-0.0196386,-0.038182,-0.141883,0.400132,0.252275,0.340303,0.613171,-0.081679,0.0412893,0.451277,0.147028,-0.304061,0.163096,0.0430827,-0.0320742,-0.252897,-0.453945,-0.116732,0.125036,0.167498,0.276895,-0.278397,0.311941,-0.147,-0.135138,-0.146853,-0.0167778,-0.134838,0.133982,-0.124482,-0.0958756,0.0535212,-0.840101,-0.146558,-0.0374909,-0.159849,0.312899,-0.574608,-0.650365,0.456784,-0.348333,-0.368394,-1.05539,-0.301636,0.184311,0.236333,0.429315,0.486141,-0.599672 +3398.1,0.981665,0.0848144,5,1.62439,1.00886,-0.873431,0.288759,0.448513,-0.192205,0.345911,0.0531967,-0.00490132,0.062127,-0.481341,-0.430893,-0.242138,0.436551,-0.33465,0.761477,-0.0464142,-0.0847651,-0.447559,-0.299031,-0.925203,-1.0011,-0.600969,0.296892,-0.228239,-0.132396,0.256924,0.0513355,-0.249947,0.065759,0.241558,-0.30084,-0.0864429,0.158065,-0.666089,-0.0470587,-0.0870065,0.773361,1.26264,-0.378757,1.25945,0.461906,0.395618,-0.588673,-0.379627,-0.478918,-0.955835,0.209487,0.522736,0.201289,0.0520367,0.52841,-0.168444,-0.451605,0.69562,-0.141465,-0.208603,-0.801849,0.474481,-0.551059,0.4492,0.755149,-0.948866,-1.32897,-0.191097,-0.267647,0.514489,-0.989626,0.143341,-0.347304,-0.197484,-0.0175194,0.137145,0.0599149,0.729939,0.551204,-0.222491,-0.375853,-0.300624,0.537437,0.232637,-0.21285,-0.105002,-0.2681,-0.253991,0.569286,0.360753,-0.317055,0.460481,0.477338,0.357485,-0.0680071,0.014298,0.262358,-0.442273,-0.3683,0.197342,0.110823,0.225352,-0.201319,-0.121578,-0.0165537,-0.367061,-0.0727941,-0.460355,-0.532466,0.46721,-0.611872,0.193892,0.322796,0.125182,-0.365274,0.922396,0.212181,0.306262,-0.68488,-0.829289,-0.120793,0.135164,-0.358757,-0.353255,0.0369653,0.375425,-0.0923905,-0.0934374,0.497759,-0.409014,0.205474,0.210783,-0.369094,0.0846823,-0.210964,-0.174679,-0.102116,0.218218,0.0353103,-0.25236,0.249492,0.682111,-0.243391,-0.857341,-0.303818,0.373514,-0.417801,0.163853,-0.175231,0.41594,0.408436,-0.313425,0.156797,0.270672,-0.135538,0.668431,-0.141678,0.271316,0.326701,-0.453731,0.121113,0.0110604,-0.236942,0.0632852,0.266578,0.496315,0.451316,0.0431193,0.0683671,-0.421246,-0.209922,0.170099,-0.391838,0.483638,0.0239856,-0.295034,-0.497752,-0.0469361,0.230533,-0.268248,0.264769,-0.134432,0.576629,0.261572,-0.123595,0.281299,-0.0625141,-0.40398,0.447058,0.0377465,-0.309061,0.49809,-0.756983,0.0645443,-0.00581566,-0.184158,-0.511397,-0.292694,0.146718,-0.0397012,0.230466,-0.454421,-0.0817625,-0.446854,-0.139713,0.241904,0.123262,0.33744,0.159852,-0.802491,1.26175,-0.216868,0.869495,0.180466,-0.225369,0.0564302,-0.226313,-0.278151,-0.24849,-0.179756,-0.280907,0.324489,-0.702684,-0.323011,-0.20107,-0.138909,0.374443,-0.11267,0.160162,-0.885464,-0.218515,0.230681,0.129383,0.37431,-0.192937,-0.504248,-0.720622,-0.291044,0.673815,-0.124267,0.0633445,0.350732,-0.384158,-1.08862,0.627452,0.25633,0.191993,0.555236,0.0525432,0.854063,0.350056,-0.53306,-0.175802,-0.0659162,-0.697874,0.554562,0.113345,0.644569,0.42027,-0.406801,0.141087,0.0292352,-0.0983544,0.177863,0.588459,0.308371,0.456944,-0.0826461,0.00435438,0.473927,0.357792,-0.295385,0.389782,0.0877811,0.116382,0.0109655,-0.627305,-0.310675,0.135931,0.207966,0.570185,-0.374647,0.132472,-0.0867717,-0.228706,-0.220674,0.102668,-0.187593,-0.0210239,-0.0641891,-0.629231,0.0434183,-0.688096,-0.157157,-0.354238,-0.214889,-0.0181812,-0.421439,-0.376876,0.414706,-0.0345146,-0.835941,-0.657549,-0.380422,0.165688,0.241006,0.407048,0.490924,-1.41509 +3398.29,0.861182,0.0848144,5,1.59809,1.09003,-0.675727,0.219197,0.691753,-0.183409,0.0749564,0.408797,0.540293,0.262082,-0.0677061,-0.142248,0.377766,0.197047,-0.201986,0.930709,-0.202517,-0.0627516,-0.398014,-0.267757,-0.734697,-0.877431,-0.377171,0.206472,-0.241125,-0.048961,-0.455012,0.65661,-0.54517,0.0487465,0.125159,-0.372203,-0.356014,0.0839432,-0.590283,0.0489604,-0.376357,0.970123,0.511115,-0.667741,1.23649,0.56131,0.561815,-0.415708,-0.11878,0.0848805,-1.44486,0.0125975,0.45349,0.274639,-0.0609281,0.703544,-0.177,-1.01916,0.668782,-0.24846,-0.0819112,-0.830837,0.432049,-0.869884,0.159326,0.885257,-0.800957,-1.24045,-0.0129997,-0.164174,0.839035,-1.1865,0.136505,-0.117254,-0.277847,0.317753,0.17394,-0.394358,0.409155,0.554804,-0.0892083,-0.188138,-0.182597,0.703903,0.0855081,-0.809508,-0.029512,-0.254089,-0.280144,0.467674,0.419686,-0.546027,0.411935,0.158035,0.335993,0.103683,0.153035,0.316116,-0.340571,-0.373977,0.130759,0.162261,-0.371721,-0.154013,0.0530943,-0.0956063,-0.294415,-0.16228,-0.302,-0.626341,0.203339,-0.311845,-0.141022,0.260026,-0.114139,-0.430661,0.652407,0.23696,0.126995,-0.240312,-0.52209,-0.190866,0.120206,-0.426029,-0.588158,0.0901625,0.330883,-0.300843,-0.112945,-0.169613,0.185286,0.319456,0.288814,-0.489998,0.571511,-0.278302,-0.237995,0.135267,-0.109332,0.250941,-0.169997,0.194024,0.542995,0.292291,-0.612688,-0.476941,0.355776,-0.517919,0.0135333,-0.383738,0.344781,0.266973,0.323182,-0.158978,0.202449,-0.318261,0.610282,-0.21157,0.0631659,-0.288934,-0.158064,0.325626,-0.3255,0.0189276,-0.113328,-0.0769066,0.500702,0.028732,-0.0659951,-0.00261328,-0.485805,-0.225506,0.125504,-0.0981315,0.115673,0.600013,-0.442427,-0.0980736,0.341193,0.430741,-0.588963,0.416626,-0.281382,0.691029,0.539854,-0.212251,0.355732,0.331255,-0.229104,0.170802,-0.00126003,-0.311084,0.338559,-0.201006,0.189906,0.18147,0.373655,-0.510572,-0.0243464,0.324102,0.174155,0.240015,-0.518913,0.145626,-0.815,-0.554781,-0.152622,0.257671,0.432685,-0.0515942,-0.820051,1.36964,-0.235076,0.710208,-0.0371368,-0.482875,0.419143,0.394889,-0.0699466,0.0653832,-0.424139,-0.327167,0.142193,-0.698489,-0.529739,-0.257868,-0.389015,0.250611,-0.143293,0.295115,-0.532205,-0.493099,0.288837,0.128439,0.382183,-0.102961,-0.301302,0.130844,-0.763057,0.334033,0.239192,-0.157568,0.576571,-0.131758,-1.12586,0.354029,0.504683,-0.191714,0.56862,-0.275743,0.465843,0.390231,-0.645472,-0.152318,-0.22867,-0.564528,0.663392,0.215955,0.601233,0.615287,-0.0979891,0.250007,0.360195,-0.106121,0.271174,1.269,0.28133,0.371332,-0.108196,0.213109,0.4726,0.472941,-0.766002,0.363029,0.279623,-0.179484,-0.301933,-0.349687,0.103316,0.466763,-0.0288457,0.354308,-0.390219,0.22464,-0.446973,0.104963,0.0421833,0.0246091,-0.10805,-0.14982,-0.0581724,-0.00563502,0.0692046,-0.675909,-0.212726,-0.139712,-0.268284,0.33,-0.0548697,-0.239561,0.329993,-0.109498,0.095509,-0.139386,-0.703117,0.139947,0.391713,0.374095,0.625869,-2.43249 +3385.02,0.608072,0.0848144,5,1.53357,1.13311,-1.02149,0.371264,0.297845,-0.132059,0.587012,-0.0387865,0.787328,0.60036,-0.29576,-0.0964717,-0.0777326,0.585855,0.149765,1.06026,-0.408927,-0.0805161,0.00464215,-0.538103,-0.84379,-1.49376,-1.04145,-0.00377973,0.303995,-0.295115,0.198887,0.131983,-0.0478586,0.0478115,0.205677,-0.30928,0.722332,0.0189953,-0.256509,-0.631772,0.0846578,0.393782,0.835192,-0.276439,1.15808,0.752741,0.864842,-0.854287,-0.204311,0.360341,-0.739246,0.036202,0.32328,0.263341,-0.11949,-0.0710958,-0.132977,-0.150249,0.178746,-0.189005,-0.135767,-0.76602,0.262032,-0.276378,0.366798,1.16984,-1.06686,-1.36737,0.393442,0.15365,-0.573058,-0.216607,-0.110297,-0.617166,-0.283572,-0.0529256,0.363738,-0.272892,0.767289,1.14368,0.539221,-0.507236,-0.324334,-0.18089,0.919283,-0.246361,-0.2083,-0.552989,-0.692182,0.330965,0.175008,0.412221,-0.143325,0.107676,0.0703068,-0.370814,0.222813,-0.104961,0.512806,-0.000167119,0.19576,-0.577877,0.386678,0.0308058,-0.097863,-0.234267,-0.474288,-0.429372,0.85321,-0.282136,0.401658,-0.290622,0.305509,0.8014,-0.029671,0.293726,0.57849,0.130857,-0.191709,-0.00552357,-0.286077,0.145661,0.520654,-0.336145,-0.507654,0.103864,0.377405,0.201243,-0.78368,0.27087,0.138648,0.139213,0.202926,-0.336588,-0.295565,-0.117247,0.0839549,0.766288,-0.28901,-0.0281637,0.684093,0.107652,0.717475,-0.424089,-0.899524,-0.147791,-0.0812264,-0.762265,0.547824,0.58708,-0.324216,0.511783,0.292745,0.462187,0.223348,0.61523,-0.0401513,0.302664,0.0470654,0.50247,-0.000224867,0.208994,-0.169605,-0.236862,-0.658976,-0.0894431,0.916918,-0.112707,1.09542,0.0023087,0.0703488,-0.373775,0.241644,0.460761,0.723654,-0.635923,0.0182764,0.328295,-0.607896,0.267866,-0.490423,-0.771204,0.455781,0.575847,-0.772349,0.199394,0.22193,-0.076659,-0.237763,0.333403,-0.823277,-0.607526,-0.126627,-0.584396,-0.332154,-0.243262,-0.381916,0.207943,-0.343004,0.126738,0.44944,-0.191306,0.0109241,0.636208,0.0105346,-0.526319,1.07265,0.428292,-0.219387,0.147475,-0.32773,1.24951,-0.0879144,-0.112474,-0.121715,-0.0915789,-0.0727827,-0.0214348,-0.144574,-0.139688,0.610117,-0.250807,0.00683392,-0.344586,-0.0710048,-0.253877,-0.0766889,0.634776,0.474726,0.255313,-0.713181,0.0415033,0.284227,0.404126,0.0208721,-0.108218,-0.295713,-0.329235,-0.657759,0.30793,0.659694,0.206499,0.244602,-0.0541306,-0.627713,-0.25694,-0.279734,0.321874,-0.419611,0.169257,0.722194,0.0592753,-0.420188,-0.324257,0.0286856,-1.34936,1.01824,-0.382308,0.204429,0.155287,0.0667967,0.513446,0.298867,-0.210366,-0.815377,-0.210097,0.0953633,0.278906,0.500681,0.110146,0.34381,-0.0875484,-0.030152,0.130845,-0.13432,0.0619264,-0.155064,0.147628,0.184972,-0.183042,-0.397276,0.183812,0.188582,-0.0514051,-0.0864247,-0.339447,0.530426,-0.000759273,0.0610445,-0.275136,-0.406643,0.907867,0.162032,0.172053,0.110036,0.638139,-0.0766887,0.162686,-0.325046,-0.571252,0.340204,-0.338231,0.141569,0.235768,0.00913415,0.187205,0.296786,0.432672,0.544781,-1.24087 +3397.65,0.701745,0.0848144,4,1.57202,0.964327,-0.858395,0.181532,-0.0828095,-0.0245157,0.0710545,-0.0896758,0.520884,1.01137,-0.492766,-0.227099,0.10952,0.591768,-0.475745,0.497215,0.201289,-0.107773,-0.214161,-0.0452723,-0.636255,-1.12575,-0.56877,-0.0649408,-0.276201,-0.0380808,0.00168156,0.708195,-0.957971,-0.13449,0.432112,-0.552701,-0.212391,-0.0851222,-0.113451,-0.0746443,-0.477516,0.769845,0.486181,-0.714354,1.17042,0.790697,0.0285891,-0.265451,-0.00505886,0.34221,-0.443952,0.418317,0.751125,-0.122258,0.238966,0.665936,-0.334917,-0.536177,0.95582,-0.433617,0.248786,-0.466843,0.365636,-0.890504,0.228519,1.35687,-0.60788,-0.907574,0.1902,-0.019092,1.01534,-0.22725,-0.0445638,0.0948497,0.0981871,0.506246,0.652368,0.205432,0.425008,0.353331,0.334852,0.314953,-0.119081,0.416033,0.415472,-0.210593,0.184167,-0.236826,0.26872,-0.393166,-0.133637,0.147794,-0.00588359,-0.206635,-0.0638408,-0.0695527,-0.00656828,0.111107,0.218212,-0.524815,0.294554,-0.097065,0.323498,0.086264,0.186777,0.0502559,-0.315542,0.11782,-0.536804,-0.0588469,-0.0616021,-0.177903,0.131046,0.69304,0.236422,0.248717,0.0600023,0.333295,0.640066,-0.2965,0.0114239,0.0691153,0.554839,0.213894,-0.900885,0.205859,-0.321,-0.639294,-0.192337,0.279612,0.133111,-0.619705,0.449272,-0.206748,0.454487,-0.23531,0.0779517,0.0753948,0.368723,-0.0823039,-0.365227,-0.36076,0.0505732,-0.457272,0.0134087,-0.194547,-0.243028,-0.734851,-0.324672,-0.167866,0.333139,0.285837,0.0562164,-0.10837,-0.548243,-0.117695,0.295649,0.0185276,0.181367,0.348833,0.0631387,0.10352,-0.0616514,0.307526,1.04499,-0.0770001,0.840738,0.293517,-0.959221,0.660224,-0.22326,-0.0483129,-0.0978681,-0.617071,0.387102,-0.0458723,-0.304816,-0.0441764,-0.0162931,-0.684,0.0595373,0.677369,-0.393043,0.34652,0.637781,-0.428056,0.23327,-0.0788184,0.0754188,-0.837871,-0.184321,0.1786,0.441124,-0.417108,0.211803,0.542223,0.540277,-0.543491,0.428843,0.223389,-0.282485,-0.189522,-0.440098,-0.665234,-0.449757,-0.427472,-0.762278,-0.655684,0.272434,0.125353,-0.122314,1.10101,-0.0509777,0.191147,0.215283,0.0522881,0.433103,0.134922,-0.281427,0.494544,-0.54807,0.112855,0.0241098,-0.289706,-0.107149,-0.555622,-0.458623,-0.529857,-0.679091,0.419095,0.318805,-0.11274,0.178915,0.473552,-0.361282,-0.125006,0.602454,-0.536051,0.0929908,0.596272,-0.0811223,0.103116,0.347207,0.249266,0.168452,0.526792,0.212412,0.18954,0.700528,-0.885292,0.29339,0.235753,0.422973,-0.434833,-0.205268,-0.0370932,0.305474,-0.146321,-0.496643,0.372877,-0.645058,-0.20932,0.127812,-0.0436418,0.446712,0.685967,0.171581,-0.482936,-0.113395,0.330534,0.171298,0.126493,-0.250486,0.195696,-0.106355,-0.159472,-0.443217,0.189558,-0.3283,0.162835,0.155716,-0.0127024,0.213133,0.0828729,0.205187,0.0898424,-0.554374,0.311181,-0.449209,0.273854,0.512319,0.0280436,0.410999,-0.497132,-0.387626,-0.330974,-0.341525,0.3618,0.0976519,0.372878,0.0997109,-0.245502,-0.343167,-0.590447,0.0898597,0.138398,0.353993,0.372018,0.594973,0.427035 +3414.76,0.870471,0.0848144,5,1.48529,0.890322,-0.552922,0.0253962,-0.15215,-0.124313,0.420841,0.176109,0.327379,0.198786,-0.218728,-0.539024,-0.471454,1.14733,-0.0982985,0.614282,0.117004,-0.410138,-0.196806,-0.434287,-0.252204,-0.534567,-1.05578,0.0507585,-0.104193,-0.599058,0.315452,0.0989656,0.145519,-0.278826,1.06289,-0.279239,0.204315,0.0301858,-0.221141,0.167111,-0.0385758,0.0361684,0.569452,-0.272443,1.30249,0.752572,0.340422,-0.502723,-0.125887,-0.538686,-0.43338,0.0872678,0.489465,0.214422,0.371671,0.243061,0.472205,-0.680839,1.36484,0.146018,-0.15245,-0.728606,0.703866,0.193015,0.717043,0.898169,-1.1958,-1.12405,0.351754,0.0159666,-0.631963,-0.0855841,0.0798138,-0.422065,0.130206,0.360215,0.171085,0.247923,0.701455,0.892455,0.547615,-0.0739934,0.0392597,-0.463324,0.163642,-0.312187,0.263146,0.259941,-0.186099,0.0719689,0.0570769,-0.120418,0.397675,-0.569881,0.209536,0.126138,0.146416,0.262695,-0.142556,0.1763,-0.00553426,-0.487289,0.142998,0.189492,-0.135095,0.39071,-0.230547,-0.208088,0.724438,-0.0755339,0.253288,-0.195656,0.614291,0.451262,-0.307351,0.121197,0.171217,0.0631701,-0.370213,0.394477,0.0829571,0.293325,0.114229,-0.690426,-0.448768,0.137908,0.240097,0.24478,-0.239858,-0.072007,0.184454,0.346001,0.253342,-0.192805,-0.180596,-0.229533,0.332979,0.882663,-0.303364,0.229425,0.64199,0.506485,0.358946,-0.560224,-0.283901,0.146466,0.359703,0.189901,0.226467,0.145783,-0.217234,0.38528,-0.450273,-0.240887,-0.254692,0.479137,0.560234,-0.0396648,0.0581751,0.600794,-0.205311,0.641648,-0.0362607,-0.373982,-0.625131,0.200897,0.903856,-0.416533,0.641541,-0.329332,0.142393,-0.0276423,-0.0354976,0.17828,0.412099,0.133507,-0.278402,-0.103933,-0.314583,0.452859,-0.277734,-0.457959,0.552218,0.820533,-0.0410162,-0.216012,0.186746,0.0550639,-0.0689916,0.169983,-0.614021,-0.255239,0.092123,-0.0578496,-0.533064,-0.288033,-0.29454,-0.1969,-0.146431,-0.00269742,0.785037,-0.34124,-0.507418,1.01613,0.404766,-0.346451,1.14673,0.410802,-0.234002,0.0627644,-0.209184,0.546656,-0.0419395,0.031025,-0.0712884,0.206048,-0.0590659,0.0162139,0.0393529,-0.297164,0.0491169,-0.162347,0.328119,-0.23635,0.0849576,-0.207239,0.507887,0.678427,0.0534247,0.319309,-0.611074,-0.131521,-0.109826,-0.00500401,0.0392553,-0.32982,-0.405171,0.227816,-0.087792,0.492596,0.479086,-0.130348,0.482595,-0.100924,-0.140252,-0.309297,-0.158205,-0.389594,-0.00415895,0.680103,0.899801,0.0090763,-0.580612,-0.44391,0.538377,-0.783639,0.810263,-0.230635,0.154967,0.451367,-0.0850379,-0.0865071,-0.0284431,0.259223,0.034514,-0.0112705,0.122802,0.229499,0.461442,0.37896,-0.295852,0.189375,0.275002,0.0149488,0.389957,-0.196452,-0.178568,0.0410082,0.246595,0.211192,-0.166415,-0.0796347,0.205687,0.166346,-0.156625,-0.215813,0.0986045,0.081084,0.639242,0.508994,-0.772411,-0.108641,0.196315,0.386854,-0.121052,0.535018,0.25567,0.0115316,-0.215948,-0.759085,-0.164345,0.0915434,0.165541,0.342715,-0.284396,0.11531,0.29637,0.339573,0.544399,0.713851 +3429.98,0.990246,0.0848144,4,1.34791,1.01338,-0.393297,0.0572632,0.266052,-0.239213,0.376061,0.105951,0.361795,0.338958,-0.215753,-0.117556,-0.163168,0.820717,0.155716,0.876481,-0.186694,0.116596,0.181171,-0.102489,0.0226723,-0.408335,-0.641978,0.106286,0.317385,-0.0133191,0.101089,0.464554,-0.302548,0.13247,1.14594,-0.0259246,-0.0287132,0.242279,-0.431145,0.1926,-0.663556,0.771143,0.515605,-0.223538,1.35511,0.662293,0.590895,-0.175721,0.138946,-0.954679,-0.635235,0.429902,0.868524,0.265641,0.649985,0.747196,0.216581,-0.1908,1.18611,0.292114,0.304124,-1.1379,0.631317,-0.213537,-0.052071,0.843833,-0.263556,-0.715624,0.380561,-0.0238599,-0.405513,-0.381434,0.0602976,0.228431,-0.0707503,0.766037,0.0701689,-0.21064,0.71761,0.739671,0.473256,0.219775,0.112569,-0.181048,0.422857,-0.202684,0.399535,-0.441346,-0.704452,0.30966,-0.105657,0.0667156,0.026873,-0.57352,-0.154312,-0.0826481,-0.0671459,0.259781,-0.194859,-0.429401,-0.236315,0.0907392,0.21676,0.0450476,-0.302719,-0.155127,-0.412352,-0.381231,0.297646,0.0578451,-0.000918444,-0.433028,0.264381,0.552187,-0.107724,-0.090628,0.0125359,0.359166,-0.0998092,-0.000942073,-0.109628,-0.0603665,0.139494,-0.653896,-0.532898,-0.587355,-0.154125,0.00301773,-0.277441,-0.0177594,0.431349,0.23717,0.30479,-0.0129724,-0.304876,-0.532207,0.0803697,0.864973,0.049313,-0.123228,-0.300776,0.00339513,0.468096,-0.489149,0.0876927,0.311462,0.284209,0.0720065,-0.28804,0.402713,0.202519,0.469795,-0.556952,-0.301035,-0.398512,0.0247735,0.429699,0.130298,0.196338,0.6153,-0.0801572,0.341266,-0.0448402,-0.238838,0.247721,0.340487,1.01078,0.351885,0.0508702,0.405689,0.144655,0.199084,-0.32776,0.101777,0.179149,0.0430952,-0.19782,0.372339,-0.0905165,0.746943,-0.128256,0.134697,0.674955,1.18003,-0.212569,-0.487323,0.30301,-0.113596,-0.202435,0.038307,0.165079,-0.163157,-0.0127492,-0.0399406,-0.508893,0.272462,-0.559866,-0.164163,0.0762756,-0.136017,0.36858,-0.569729,-0.567713,0.649671,0.102451,-0.511605,0.00424077,-0.0123439,-0.165753,-0.323399,0.224218,0.593134,0.247488,0.255541,0.558157,-0.131231,0.287001,0.337164,-0.0268314,0.0140075,-0.279532,0.0343932,0.548022,-0.270953,-0.349373,-0.12053,1.06449,0.319207,-0.240925,0.286915,-0.691153,0.0289941,0.196969,-0.14705,-0.0924825,-0.0175749,-0.488388,-0.334697,0.436063,0.420324,0.278698,0.0378931,0.331905,-0.257523,0.249536,-0.200294,0.0754698,0.00991985,0.666233,0.358832,0.745107,0.306137,0.19925,-0.600639,-0.349236,-0.842727,0.649667,0.0405984,-0.00694986,0.765464,-0.232354,-0.21649,0.20243,0.554255,0.0711866,0.0501949,-0.131652,0.679129,0.0365612,0.402047,-0.257613,0.410375,0.335108,0.152476,0.144643,0.140306,-0.172095,-0.0145408,-0.147384,-0.216818,0.129759,0.590925,0.0969607,-0.0808257,0.0390657,0.37653,-0.688818,-0.0169872,0.046663,0.261052,-0.399464,-0.345069,-0.103201,0.373482,0.0365247,-0.386842,-0.0073575,0.370398,-0.0608608,-0.469288,0.291247,0.323342,0.0267181,0.746758,0.0986989,0.157838,0.29394,0.397289,0.542162,-1.11479 +3422.06,0.990105,0.0848144,4,1.40187,0.956947,-0.656191,0.0800185,0.0662298,-0.333518,0.505924,0.447891,0.685478,0.185021,-0.070348,0.0187488,-0.261154,1.01142,0.238787,1.10419,0.0362296,0.120937,-0.172462,-0.160413,-0.340661,-0.649213,-0.496486,-0.202723,0.28828,-0.209732,0.167074,0.845963,-0.0338287,-0.130524,1.15727,-0.00870389,0.00555578,0.0729769,-0.40264,0.118348,-0.639838,0.384868,0.560026,-0.393677,1.2451,0.353256,0.344786,0.0654889,-0.211184,-0.600496,-0.278384,0.536599,0.54769,0.37818,0.380751,0.807117,0.0629033,-0.309956,1.10255,-0.0775421,0.333381,-1.03339,0.67769,0.16477,0.048629,0.967613,-0.57082,-0.785661,0.067907,-0.19193,-0.414577,-0.23479,0.248208,-0.243361,-0.162009,0.216441,0.251243,-0.286281,0.512977,0.608751,0.315231,-0.172224,-0.0130463,-0.252742,0.781072,-0.262396,0.20673,-0.413656,-0.761636,-0.158541,0.0555199,0.12198,0.183456,-0.622581,-0.0233894,0.179314,0.0555586,0.317525,-0.207073,-0.236829,0.0262815,0.290916,0.499752,0.265734,0.384364,-0.500542,-0.705651,-0.287323,0.409454,-0.18021,-0.149068,0.17253,0.311153,0.662775,-0.0423101,-0.116643,-0.0314176,0.205718,-0.706986,-0.141481,-0.371398,-0.161869,-0.416097,-0.374574,-0.946526,-0.382313,-0.172359,-0.0176661,-0.201949,0.00626855,0.0470764,0.0726214,0.0520235,-0.584701,-0.0992391,-0.510044,-0.137384,0.522407,0.401227,-0.309222,-0.353882,0.236829,0.35783,-0.780952,-5.17127e-05,0.208515,0.03778,0.0170861,-0.0299547,0.0734975,-0.21397,0.569967,-0.48718,0.207483,-0.14837,0.0634725,0.553955,0.0454618,0.424499,0.438543,0.454637,0.414667,0.0357767,-0.056482,0.156038,0.179858,1.24315,0.200354,0.0546032,0.0616261,-0.0255756,-0.25457,-0.348043,0.292982,-0.01902,0.189904,-0.176711,0.463309,-0.139844,0.363483,-0.120379,0.399889,0.692877,0.63881,-0.450413,-0.44409,0.5798,0.0270472,0.118159,-0.402071,-0.319744,-0.391608,-0.16141,-0.100371,-0.279272,0.163175,-0.363336,-0.415071,0.214388,-0.0267084,0.823569,-0.593215,-0.707822,0.550482,0.157143,-0.509556,-0.199817,0.234679,-0.329187,-0.552645,-0.217109,0.602012,0.105711,0.141013,0.179113,0.0082323,0.116948,0.0274322,-0.122626,-0.110139,-0.209329,-0.0225483,0.185608,-0.366358,0.00494751,-0.292377,0.75289,0.143397,-0.091888,0.498946,-0.675444,-0.140085,0.540509,-0.179374,-0.52801,-0.0713352,-0.446317,-0.305986,0.18771,0.595151,0.19218,0.26967,0.362535,-0.306789,0.551665,0.403399,0.14435,0.138482,0.720864,0.533917,0.636545,0.45039,0.370722,-0.612813,-0.25351,-0.81702,0.356103,-0.555279,-0.232042,0.622923,-0.428211,-0.0717994,0.0693534,0.551609,-0.102407,0.598669,0.0509764,0.155528,0.444665,0.561731,-0.164856,0.142212,0.0469888,0.304101,0.0502355,0.633114,0.195234,0.156929,-0.199776,0.134787,0.00999059,0.534925,0.559444,0.222158,0.469329,0.456236,-0.9086,-0.494075,0.317706,0.499645,-0.480646,-0.071204,-0.0861765,0.350072,0.159564,-0.123037,0.337757,1.05783,-0.0190093,-0.607875,0.57814,0.413317,0.060097,0.0846671,0.343644,0.127369,0.229952,0.356888,0.479534,-0.157564 +3415.87,0.97135,0.0848144,4,1.39449,0.981602,-0.682544,0.129472,0.120515,-0.341816,0.572066,0.169183,0.636335,0.260101,-0.0914751,-0.118936,-0.337053,0.758343,0.28499,0.613202,0.0896933,0.178843,-0.295632,-0.0479064,-0.119312,-0.77356,-0.474211,0.13383,0.0127143,-0.325047,0.206726,0.734389,0.23624,0.136873,1.21594,0.422576,-0.0353124,0.120001,-0.334903,0.01289,-0.537251,0.621668,0.329382,-0.0741963,1.39241,0.404415,0.190087,-0.293438,-0.14168,-0.410398,-0.153377,0.484815,0.664358,0.387383,0.297952,0.590957,-0.0954586,-0.382718,1.06117,0.102325,0.312876,-0.806198,0.445395,-0.0125983,-0.000303451,0.942168,-0.51682,-0.787314,-0.258499,-0.0944507,-0.420299,-0.152947,0.106188,-0.111287,-0.310507,0.210626,0.404555,-0.113664,0.632505,0.413914,0.343172,-0.034897,0.230652,-0.240818,0.265827,-0.372226,0.463996,-0.444543,-0.614177,-0.000558793,-0.24871,0.140962,0.0188936,-0.777448,-0.0836878,0.102125,-0.0118966,0.429042,-0.0874455,-0.356295,-0.150025,0.0954526,0.508176,0.145202,0.297381,-0.178239,-0.902412,-0.41653,0.314011,-0.0202584,-0.105532,0.019269,0.227994,0.880734,0.107553,-0.292241,0.124833,0.161596,-0.343777,-0.346745,-0.63349,-0.265577,0.108387,-0.528346,-0.790636,-0.447553,-0.433951,-0.0213644,0.0883399,-0.0103147,-0.0102341,0.231312,-0.15947,-0.536091,0.244219,-0.449528,-0.189314,0.513763,0.308913,-0.449205,-0.440136,-0.0158922,0.425989,-0.618455,0.108527,0.014114,0.242578,-0.294473,-0.263882,0.0569038,-0.101702,0.568756,-0.294993,-0.0725851,-0.355753,0.347464,0.607256,-0.234007,0.806504,0.41255,-0.177518,0.259982,-0.0578915,-0.0772088,-0.233018,0.138867,0.844401,0.512159,-0.0851148,0.0414458,0.0877401,-0.332226,-0.0878476,0.243433,-0.130121,0.484271,-0.327407,0.331856,-0.130215,0.422901,0.214969,-0.0790103,0.740886,0.689046,-0.360695,-0.640598,0.674501,0.0881368,0.0657693,-0.275037,-0.344864,0.0704944,-0.0779322,-0.200399,-0.29706,0.162871,-0.200621,-0.338716,0.490328,0.158723,0.354578,-0.381304,-0.25086,0.475574,-0.140345,-0.578262,-0.0934013,0.0287286,-0.626755,-0.105835,-0.362758,0.502822,0.0876648,0.379738,-0.160978,0.116003,0.150041,0.425803,0.142576,0.251496,-0.350367,0.0474624,0.350326,-0.125762,0.257784,-0.640517,0.4993,0.135896,-0.109609,0.461918,-0.824606,-0.160484,-0.0796537,0.0458091,-0.669392,-0.0990222,-0.592012,-0.335691,0.0208553,0.5453,0.244773,0.296951,0.468261,-0.192488,0.383608,0.178006,0.310455,0.292783,0.537893,0.198027,0.732877,0.490127,-7.13713e-05,-0.331515,-0.218612,-0.37157,0.0420555,-0.530215,-0.262025,0.421964,-0.67248,0.424915,-0.403263,0.601464,-0.595148,0.821125,-0.101145,0.35875,0.197763,0.393608,-0.00508385,-0.0294493,-0.333303,0.33596,-0.0309327,0.477145,0.328753,-0.013919,-0.621204,-0.236849,0.0562741,0.421939,0.725548,0.41024,0.650099,0.438497,-0.921049,-0.484649,0.307508,0.343269,-0.569435,0.546946,0.466208,0.190327,0.183776,-0.285046,0.281565,0.92198,0.219739,-0.740369,0.171698,0.64368,0.0340334,-0.117004,0.111024,0.154709,0.242346,0.39333,0.492287,-0.419734 +3423.11,0.995822,0.0848144,4,1.46746,0.996998,-0.453561,0.0320085,0.0657991,-0.377721,0.636416,-0.156052,0.409657,0.269255,-0.10239,0.0389003,-0.174677,0.493199,0.138536,0.907177,0.194432,-0.260847,-0.14024,-0.14652,-0.222545,-0.896216,-0.470446,-0.0636461,0.296651,0.265809,0.704252,0.304331,0.00160727,0.254013,0.844482,-0.184684,0.47976,-0.0279036,-0.500118,-0.063375,-0.336318,0.873622,0.358398,-0.449089,1.2476,0.192597,0.379331,-0.560111,-0.194287,-0.355258,-0.390003,0.653129,0.690088,0.0368182,0.265233,0.613509,0.426621,-0.471776,1.04788,0.180732,0.230772,-0.762868,0.473843,-0.175237,0.296519,0.886495,-0.446777,-1.39086,-0.181288,0.138115,-0.635546,-0.345619,0.245916,-0.292752,-0.571045,0.722,0.307363,-0.117753,0.730351,0.51291,0.466149,-0.198001,-0.396137,-0.0517388,0.284038,-0.524369,-0.00127352,-0.596,-0.177255,-0.22128,-0.508197,0.209997,0.284575,-0.410761,0.187588,-0.31791,0.195626,0.594835,0.0696821,-0.336723,-0.228967,0.396012,0.706448,0.135787,0.37432,-0.118459,-0.699079,-0.240423,0.590596,-0.468353,-0.174544,-0.269657,0.415952,0.425948,-0.0313368,-0.322711,0.371582,0.099162,0.0354699,-0.392761,-0.221114,0.203423,0.117041,-0.566389,-0.56652,-0.583805,-0.250377,-0.438984,-0.335293,0.0776027,-0.258966,0.282688,-0.00888765,-0.227516,0.472284,-0.518231,0.133839,0.391573,-0.350429,-0.470872,-0.440711,-0.0297941,0.321303,-0.399851,-0.198769,0.130204,0.108526,-0.200677,0.389038,-0.20155,-0.32007,0.385437,-0.151859,-0.115236,-0.488549,0.20377,0.385399,-0.275586,0.486921,0.48407,0.612801,0.327096,-0.117532,-0.144527,0.376776,-0.0630284,0.686179,0.629646,-0.0542438,-0.365897,-0.365363,0.115258,-0.424635,0.455426,0.250707,-0.194415,-0.10426,-0.0927529,-0.409549,-0.0134232,0.234637,0.14926,0.207115,0.680552,0.259693,-0.125716,1.08865,-0.000943063,0.0169422,-0.263455,-0.592623,-0.215162,-0.490685,-0.1883,0.195465,-0.284254,0.162633,-0.135319,-0.00747516,-0.0408921,0.159385,-0.180775,-0.733699,0.308079,0.118382,-0.329978,0.0350173,0.225558,-0.692259,0.0144759,-0.484713,0.663145,0.0469351,0.492499,0.255639,0.264727,0.372654,0.449442,-0.304083,0.217727,-0.79447,-0.243122,0.480886,-0.61589,0.00266965,-0.726498,-0.249975,-0.229182,-0.665495,0.389456,-0.691584,0.160116,-0.163825,0.0190455,-0.349934,0.0398781,-0.33142,-0.359789,0.27254,0.293433,0.0771426,0.0750806,0.210423,-0.34354,0.261241,0.462425,-0.60747,0.12175,0.274264,0.329805,0.716803,0.161114,0.0598356,0.382043,-0.125367,-0.425783,0.624029,-0.267007,-0.292308,0.212771,-0.129262,0.446598,-0.263648,0.502733,-0.451753,0.575987,0.118723,0.732307,-0.144114,0.23207,0.021742,0.230687,-0.00950224,0.365694,0.213943,0.619125,-0.109951,0.602915,-0.23382,0.0668753,0.1124,0.448296,0.537828,0.0805261,0.342198,0.330897,-1.04514,0.0491101,-0.0171626,0.486174,-0.330006,0.499793,0.424678,0.0325746,0.160585,0.209933,0.142676,0.326514,-0.0398661,-0.307186,0.348153,0.500066,-0.296711,0.518119,-0.0951586,0.134546,0.227856,0.366806,0.477342,-0.211239 +3394.95,0.830496,0.0848144,4,1.48961,1.02995,-1.24806,0.333336,0.173179,-0.291711,-0.0727798,0.0373844,0.70466,0.205741,-0.378816,0.214783,-0.580849,0.168578,-0.241719,0.538314,-0.257954,-0.142831,0.303854,0.0257412,-0.687791,-1.14686,-0.5084,-0.273416,-0.412474,-0.211158,-0.228891,0.53465,-0.664251,0.039529,0.415187,-0.473742,-0.738564,-0.395803,-0.777416,0.146156,-0.104902,-0.339475,0.280158,-0.408117,1.09211,0.56849,0.508436,-0.210051,-0.510781,-1.08346,-0.0519384,0.249688,0.757321,-0.218419,0.418522,0.322046,0.0333146,-0.340465,0.493022,0.238501,0.0445501,-0.636289,0.349972,-0.151703,0.373347,0.745764,-0.180748,-1.7037,0.267825,0.48978,-0.527756,-0.627753,0.367659,-0.551938,-0.521149,0.461855,0.715969,-0.0284478,0.756946,0.200845,0.451118,0.221387,0.0677761,0.0327999,0.54817,-0.827942,0.523112,0.0426911,-0.631031,-0.113118,-0.420549,-0.69269,-0.561211,-0.346168,0.66007,-0.0693532,0.0917665,0.374891,-0.137613,-1.07991,-0.0145927,-0.27395,-0.0479915,-0.224011,0.554271,-0.219539,-0.534678,-0.150277,0.305836,-0.683735,0.459625,-0.291174,0.337086,0.311475,-0.0386455,-0.298247,0.0977995,0.456341,-0.774505,-0.138455,-0.286328,0.167771,-0.310735,-0.00810637,-0.513826,-0.232483,-0.607819,-0.0819162,-0.0318122,0.358568,0.136094,-0.0570986,0.312509,-0.820317,0.384112,-0.0102819,-0.392597,0.413816,-0.0409637,-0.423423,0.293376,-0.141321,0.793065,0.0627377,-0.80471,0.134617,0.449342,-0.717119,-0.563193,0.231722,0.313584,0.20814,-0.114659,-0.015636,-0.440971,0.597,0.488561,-0.383702,-0.0498551,0.68996,0.346818,-0.0952216,0.39973,0.0486062,0.293007,-0.332569,1.2655,0.221333,-0.125951,0.155838,-0.0247526,0.310505,-0.112012,0.324149,0.156,0.396612,-0.177543,-0.121809,0.355217,-0.406297,-0.470669,-0.248216,-0.143643,1.03517,-0.384476,0.184896,0.529746,-0.521357,-0.11958,-0.260043,0.112552,-0.515266,-0.230075,-0.64732,-0.126876,-0.183757,-0.0291936,-0.830083,-0.165161,-0.106761,-0.178521,0.00824482,-0.946241,-0.86446,0.0524146,-0.104116,-0.660859,-0.351414,-0.16097,-0.079207,-0.78019,1.06411,-0.0168848,0.596593,0.434151,0.495065,-0.294043,-0.0952774,0.129091,0.154188,-0.0939064,-0.176206,0.473331,-0.4959,-0.492872,0.100607,-0.210565,0.295326,-0.858492,-0.357446,-0.26289,-0.466235,0.495912,-0.298908,-0.178851,-0.152868,0.076206,-0.147047,-0.191009,0.536277,0.232567,-0.0845591,0.83427,-0.318977,0.371495,0.00944875,-0.285842,-0.0507427,0.625346,0.409179,0.454668,0.177094,-0.365225,-0.358538,0.191351,-0.252468,0.6245,0.12245,-0.040002,0.281274,-0.144993,0.498403,0.110053,0.33544,-0.236374,0.0551454,-0.287136,0.0738578,0.482383,-0.233905,0.260819,0.0782503,0.544214,0.278632,-0.000977633,-0.295053,-0.415065,0.614933,-0.214761,0.623167,0.435798,0.833518,-0.0265809,0.104421,-0.0701582,0.115358,-0.467891,0.169728,-0.0767247,0.711776,0.24852,0.451469,0.19163,-0.3207,0.199487,0.0455629,-0.137403,0.799839,0.268685,-0.629378,0.496607,0.0865001,-0.278556,-0.58854,-0.180041,0.179892,0.363464,0.424137,0.60288,-0.493656 +3403.21,0.988016,0.0848144,4,1.65517,0.884457,-1.21644,0.444489,0.187263,-0.204194,0.0869869,0.0183769,0.459061,0.0323409,-0.109824,-0.395789,-0.828557,0.389141,-0.436707,0.695404,0.271087,-0.545811,-0.599747,-0.117151,-0.527173,-0.970812,-0.190083,0.0117242,-0.690509,0.306737,0.157737,0.229441,-0.467671,0.294775,0.842107,-0.584799,0.12711,-0.182494,-0.622237,-0.010888,-0.00878374,-0.29812,0.488974,-0.625147,1.11847,0.629403,0.528969,-0.697667,-0.765896,-0.824672,-0.238403,1.26365,0.400858,-0.375816,0.139398,-0.325544,0.120451,-0.220913,0.298697,-0.0653187,-0.622478,-0.446828,0.290009,-0.0991172,0.24385,0.821215,-0.312791,-1.19466,0.33569,0.0816644,0.19456,-0.101329,0.812636,-0.832179,-0.284272,0.950069,0.380691,-0.556746,0.845826,0.367153,0.504202,-0.190245,-0.335942,0.213047,-0.112478,-1.0856,0.131126,0.0901961,-0.165309,-0.0885964,-0.0819908,-0.196122,-0.463189,-0.495767,0.483182,0.0413645,0.358627,0.238158,0.098007,-0.498492,-0.0200717,-0.795294,-0.0843979,0.252085,0.200583,-0.0676873,-0.28001,-0.246997,0.0469496,0.00601211,-0.142068,-0.399021,0.482597,0.502859,-0.0249267,-0.0577778,0.0452627,0.332901,-0.423709,-0.435134,0.0231344,-0.00058566,0.464412,-0.280604,-1.02491,-0.189855,-0.360001,-0.342723,0.391749,-0.057629,0.0307618,-0.217378,0.221693,-0.401154,0.147283,-0.191808,0.201018,0.28153,-0.113526,-0.00302057,0.203113,-0.235134,0.180987,-0.392476,-0.528795,0.114701,0.229747,-0.287282,-0.356369,0.218171,0.362652,-0.241428,-0.250369,0.0222571,0.100184,0.257443,0.225021,-0.0680642,-0.116336,0.591897,-0.09848,-0.287102,-0.3147,-0.403084,0.411515,-0.346412,1.33671,1.0071,-0.16384,-0.280063,-0.041693,0.405276,-0.120917,1.44571,0.370818,0.171029,-0.0512893,0.217275,0.152862,-0.924448,-0.407024,-0.335409,-0.124747,0.997825,0.056706,-0.0820583,-0.209076,-0.83029,0.065947,-0.360363,-0.0294727,-0.140194,-0.233826,-0.442,0.0131519,-0.502349,0.278433,-0.611967,-0.328103,0.132089,-0.101919,-0.039932,-0.140478,-0.462762,0.050373,-0.106227,-0.24976,0.308634,-0.388347,0.108622,-0.40744,0.756364,-0.0426041,0.608873,0.495113,-0.024382,-0.282781,0.222665,0.25994,0.101067,-0.146555,-0.200385,0.81365,-0.144785,-0.237052,-0.200502,0.260657,0.0332502,-0.432645,0.00547111,-0.449923,-0.52525,-0.230542,-0.53408,0.0340478,0.249339,0.0275169,0.116692,-0.491244,0.243318,0.114939,-0.0111613,0.292924,-0.068354,0.167596,-0.452059,-0.184391,-0.342005,0.430127,-0.377292,0.630203,0.0962974,0.473235,-0.277555,0.471118,-0.271894,0.262927,-0.135311,-0.271682,0.0718516,-0.266799,0.420928,0.144453,-0.113949,-0.215044,0.351396,-0.23234,-0.294202,0.592637,0.0992173,0.0240851,-0.39082,-0.140527,0.199743,-0.35271,-0.19284,-0.644331,0.865455,-0.175205,0.150344,-0.0781228,0.735228,-0.184741,-0.248093,0.404687,-0.133271,-0.719064,-0.613467,0.300849,0.470411,-0.34752,0.87535,0.0670217,-0.489262,0.284985,-0.0751215,0.212592,0.0275547,-0.0260896,-0.692282,0.140683,0.191025,-0.360307,-0.327889,-0.0244451,0.157591,0.274069,0.396978,0.523516,-0.261529 +3404.61,0.600571,0.0848144,4,1.61362,0.979825,-1.32368,0.469712,0.17877,-0.191544,0.191998,-0.0219347,0.179532,0.0843393,-0.144839,-0.323969,-0.876048,0.505898,-0.409854,0.663444,0.135208,-0.514402,-0.622198,-0.212458,-0.547881,-0.984773,-0.098011,-0.0688943,-0.61777,0.236669,0.180331,0.225802,-0.408243,0.263948,0.685797,-0.572817,0.0281777,-0.264926,-0.614594,0.0493629,0.112613,-0.302132,0.632569,-0.592838,1.00978,0.682325,0.535507,-0.707141,-0.698832,-0.860447,-0.169821,1.31656,0.368303,-0.319778,0.077821,-0.500182,-0.00284395,-0.25258,0.123611,-0.00305313,-0.652267,-0.524591,0.0954637,-0.22327,0.171166,0.7943,-0.295439,-1.40154,0.442501,0.0359889,0.320936,0.00159246,0.733176,-0.909964,-0.272438,0.737225,0.227592,-0.730833,0.901104,0.3635,0.481724,-0.154411,-0.495991,0.184458,-0.103663,-1.14259,0.222941,0.0322058,-0.240853,-0.176717,-0.360961,-0.219907,-0.4623,-0.43458,0.531292,-0.00739063,0.264375,0.209922,0.0603233,-0.667621,0.0143541,-0.713795,0.00193547,0.306306,0.213271,-0.13418,-0.324056,-0.256755,0.368676,-0.187818,-0.0855091,-0.460254,0.518194,0.460006,-0.0250395,-0.0865487,0.0652255,0.329092,-0.357391,-0.303185,-0.051905,-0.11873,0.479369,-0.248434,-1.03491,-0.201655,-0.444108,-0.432455,0.319805,0.0570388,0.13456,-0.261573,0.192214,-0.416896,0.46052,-0.166803,0.266502,0.405545,-0.304728,0.0671815,0.146066,-0.215703,0.270627,-0.517211,-0.550014,0.150626,-0.0358689,-0.284202,-0.329426,0.313763,0.135702,-0.163317,-0.196118,0.0556127,0.0779095,0.239361,0.223218,-0.146474,-0.111788,0.786602,-0.0957173,-0.312186,-0.277778,-0.586809,0.409278,-0.328838,1.22663,0.819454,0.0449156,-0.393606,-0.0622893,0.377284,-0.138375,1.44084,0.453506,0.1672,0.0435215,0.22595,0.260082,-0.804459,-0.502081,-0.448412,0.0331985,0.863014,0.0665797,-0.317624,-0.23017,-0.842546,0.119155,-0.195304,-0.0170274,0.020243,-0.144319,-0.514325,0.112614,-0.381347,0.284458,-0.553666,-0.388659,0.0624968,-0.000828172,0.0531105,-0.0257663,-0.494172,0.10208,-0.41332,-0.23343,0.256047,-0.42503,0.0565346,-0.430105,0.725567,-0.00372713,0.518201,0.523637,-0.00320734,-0.284961,0.0732849,0.319809,0.131088,-0.00819822,-0.164236,0.610991,-0.388256,-0.0906537,-0.20936,0.486901,-0.00800502,-0.286376,0.0317821,-0.303732,-0.603546,-0.170475,-0.630094,-0.0865835,0.224577,0.151512,0.0728732,-0.45305,0.246126,0.0812392,0.0349007,0.316683,-0.235718,0.0946786,-0.468489,-0.0164188,-0.175078,0.327268,-0.202034,0.546208,0.178121,0.455452,-0.185314,0.414306,-0.333869,0.335601,-0.0399691,-0.39687,0.159498,-0.171528,0.388549,-0.0345597,-0.0336014,0.00773636,0.498316,-0.057676,-0.354898,0.597489,0.119706,-0.0625129,-0.313856,-0.0589162,0.195221,-0.342794,-0.30469,-0.53888,0.804571,-0.159881,0.0208583,-0.126081,0.598984,-0.221011,-0.289392,0.278768,0.0274543,-0.664241,-0.510184,0.310615,0.612591,-0.278333,0.83928,0.152003,-0.657103,0.283451,-0.039263,0.226058,-0.132961,-0.055506,-0.502035,0.178012,0.231327,-0.310139,-0.570762,-0.0651356,0.168033,0.269216,0.409918,0.51886,-0.414228 +3406.35,0.918093,0.0848144,5,1.64334,0.976446,-1.23702,0.41271,0.262789,-0.138128,-0.0413987,-0.425631,0.452201,0.10985,-0.132977,-0.38446,-1.02844,0.231921,-0.258656,0.370332,0.0384957,-0.3996,-0.868544,0.468957,-0.442911,-1.0725,-0.409924,-0.243275,-0.478711,-0.120606,-0.126964,0.0411537,-0.588276,0.245124,0.621904,-0.663128,0.0857202,-0.152639,-0.72379,0.459664,-0.174049,0.015066,0.668214,-0.408681,1.3376,0.664616,0.175422,-0.319291,-0.474727,-0.16763,-0.383498,1.34175,0.320745,-0.164347,0.323581,0.0868519,-0.0914808,-0.567218,0.158086,0.0509299,-0.701273,-0.517712,0.363854,-0.22059,-0.0168627,0.872926,-0.348754,-1.6476,0.13371,-0.0301586,0.028276,0.213487,0.266225,-0.773033,-0.168383,1.20783,0.416296,-0.433689,0.930494,0.247044,0.632905,0.313144,-0.39148,0.0616923,-0.203018,-0.9925,0.279902,0.148432,0.443502,-0.0884544,-0.451435,0.0950586,-0.128592,-0.256259,0.694226,-0.0873286,0.279067,0.190151,0.0369483,-0.798582,0.0782896,-0.471188,0.149757,-0.101463,-0.0242958,-0.188437,-0.317511,-0.0912203,0.148757,-0.365489,-0.0699259,-0.179547,0.292032,0.307813,-0.457719,0.122273,0.335638,0.434157,-0.206595,0.274644,-0.360332,0.192049,0.700808,-0.484724,-0.830665,0.2556,-0.193476,-0.428404,0.389627,0.345059,0.311369,-0.331227,0.194854,0.0482471,0.465615,0.0234376,0.333751,0.824719,-0.578071,0.100433,0.301445,-0.360152,0.108531,-0.200599,-0.157572,0.0167291,-0.080473,0.204823,-0.436442,0.253654,0.32039,-0.0585841,-0.229177,0.0894898,-0.621603,0.471993,0.260974,-0.350751,-0.0644036,0.984696,0.0201256,-0.31055,-0.100981,-0.118154,0.46379,-0.252156,0.738466,0.737393,-0.718397,-0.293722,0.0593706,0.3271,0.0958054,1.15202,0.379915,-0.10047,0.00325045,0.126312,0.18212,-0.405261,-0.462647,-0.527632,0.398126,0.923115,-0.0486463,-0.105091,0.0160762,-0.43852,0.33039,-0.578568,-0.0367194,-0.384269,-0.264227,-0.412834,-0.0426025,0.0323899,0.862738,-0.633451,0.0611113,0.0409898,-0.334592,0.0852689,-0.153813,-0.424066,0.392963,-0.2355,-0.480421,-0.073678,0.467582,0.0364251,-0.540428,1.00163,-0.158386,0.253523,0.205225,-0.168143,-0.267451,0.403597,0.540429,0.00440792,0.373639,-0.304908,0.340452,0.0174732,-0.371266,-0.0656985,0.157549,-0.204149,-0.387142,0.338525,-0.0685469,-0.63249,-0.0121429,-0.498485,-0.281994,0.116518,-0.228793,0.346717,-0.466107,0.340025,-0.42537,-0.0188847,0.29276,-0.701416,0.120835,-0.158695,0.434469,-0.250076,0.543929,-0.200473,0.635505,-0.0520545,0.533254,-0.336208,0.322162,-0.213677,0.199467,-0.000988386,-0.213734,-0.167636,-0.182322,0.12683,-0.150511,0.039494,-0.123674,0.582886,0.0671588,-0.254995,0.615665,0.0534589,-0.109561,-0.007429,-0.344051,0.191343,-0.341042,-0.689589,-0.812334,0.386073,-0.4878,0.0846595,0.0327572,0.355888,0.00680017,-0.390128,0.275931,0.331115,-0.441763,-0.434362,0.129476,0.465005,-0.301619,0.453405,-0.0365365,-0.27941,0.152155,-0.0570842,0.0592601,-0.0224972,-0.139951,-0.217423,0.102613,0.247711,0.0762757,-0.594779,-0.2174,0.128875,0.351013,0.358991,0.592464,-0.662286 +3415.73,0.846441,0.0848144,5,1.66613,0.831444,-1.11392,0.357903,0.389275,-0.137032,-0.283213,-0.000165306,-0.0351342,-0.0171681,-0.14285,-0.221599,0.253844,0.401251,-0.533327,0.928989,0.0233438,-0.06086,-0.0981032,-0.269551,-0.673831,-0.87293,-0.822519,-0.104912,-0.630914,-0.520875,-0.218448,0.182853,-0.324794,-0.164928,0.482251,-0.182475,-0.440267,0.158599,-0.707765,-0.444564,-0.09594,0.726811,-0.0361212,-0.167671,0.93728,0.443786,0.223339,-0.959513,0.00993518,0.337329,-0.530205,-0.536239,0.540669,-0.0243269,0.0985028,0.466683,0.191307,-0.131513,0.617092,0.278541,0.0746717,-0.594201,0.262813,-0.204261,0.75917,0.741977,-0.757205,0.0606056,0.477241,0.26183,-0.251362,-0.328048,-0.0206195,-0.000557648,-0.0683158,-0.813784,0.611177,0.418548,-0.0208281,0.374559,0.0672605,-0.131938,-0.575992,0.531162,0.84979,0.39664,0.343111,-0.165207,-0.342912,-0.1897,0.44715,-0.564804,0.163483,-0.398879,-0.668146,0.217178,-0.0890291,0.249773,-0.165373,-0.733926,0.259818,-0.0873817,0.0894866,0.298629,0.211181,-0.0904074,-0.562225,-0.298451,0.0187273,-0.0249849,0.303634,-0.38634,0.335274,0.39923,0.369408,-0.394737,-0.167109,0.280078,-0.0613088,0.0730964,-0.693859,-0.07346,0.00320787,-0.253278,-0.396532,-0.144349,-0.534431,-0.233775,-0.140603,0.0727321,0.0518739,0.494917,0.456157,-0.895226,-0.331206,-0.277821,0.0250725,0.288486,0.0203374,-0.3111,0.0164694,-0.250934,0.987956,-1.02499,-0.851232,0.309808,0.469526,-1.15023,0.359453,-0.201406,-0.268726,0.622775,-0.0506089,-1.08731,0.178617,-0.10712,0.317404,0.224003,0.134127,-0.285699,0.324296,0.313615,-0.1184,0.252352,0.330049,-0.109737,0.747472,-0.608283,0.272496,-0.215202,-0.359996,-0.451879,-0.594001,-0.724665,-0.115645,0.181299,0.204231,-0.628602,-0.404928,-0.0986264,-0.0675573,0.364186,-0.850423,0.334952,0.181983,-0.220749,-0.279192,0.349988,-0.113641,-0.387425,-0.303335,0.0577884,0.331576,-0.163001,-0.138282,0.340072,-0.69764,-0.663563,0.236219,0.615351,0.330028,-0.22989,-1.20905,0.231258,-0.148983,-0.146307,0.968997,0.0472276,-0.53192,0.182521,-0.431209,1.0747,0.222566,0.0311552,-0.00911331,0.299269,0.320856,-0.595999,-0.496544,0.211049,-0.521076,0.18348,0.287929,-0.560272,-0.0573887,-0.698279,-0.167605,0.543875,-0.673902,0.251789,-0.640189,0.055138,-0.368278,0.389809,-0.0868752,-0.0768585,-0.664986,-0.398588,-0.0538922,0.505737,0.353735,-0.198213,0.690875,-0.106546,-0.321958,-0.618643,-0.206973,0.190489,0.00293951,0.0234025,0.476877,0.215847,-0.680895,-0.44792,-0.0857302,-0.351278,0.285269,-0.25495,0.103204,0.646637,0.00529517,-0.258744,-0.111858,0.505737,0.621589,0.185656,0.0892967,0.547292,-0.136322,0.133966,0.0365241,-0.280792,0.0329329,0.110492,0.236415,0.0196153,0.461927,0.00334331,0.278682,-0.223462,-0.151673,-0.127206,0.664899,0.268886,-0.252472,-0.699114,-0.0776598,-0.122393,-0.108726,-0.22242,-0.00654491,0.166239,0.115073,0.00794887,0.0327331,-0.493052,0.17008,0.302521,-0.115284,-0.326472,-0.219981,-0.298935,-0.319412,0.258628,-0.0440712,0.143254,0.193385,0.378489,0.439756,-0.816022 +3404.08,0.409559,0.0848144,5,1.57805,1.01951,-1.28962,0.361594,0.321667,-0.0860713,-0.0879996,-0.160909,0.667777,-0.0728597,-0.34364,-0.402965,-0.191298,0.60218,-0.110445,1.02581,-0.174135,0.124043,-0.354466,-0.337652,-0.369195,-0.904991,-0.962777,0.162533,-0.295399,-0.269284,-0.214744,0.209478,-0.528982,-0.229252,0.399562,-0.100951,-0.347823,0.136236,0.142578,0.066407,-0.299268,0.363755,0.284761,0.0383059,1.28462,0.888875,0.758226,-0.910308,-0.235771,0.615051,-0.98154,0.839726,0.439864,0.793751,0.36751,0.277478,-0.187369,-0.818034,0.377566,0.31756,-0.143401,-0.575544,0.350332,-0.819316,0.0436686,1.26614,-0.492875,-1.44078,0.504024,0.52439,-0.151789,-0.245461,0.562015,-0.608725,0.21341,0.32093,0.0329074,-0.451581,0.427832,0.478471,0.121473,-0.435869,-0.0338944,-0.345013,0.0830176,-0.645898,0.0264489,-0.599833,-0.141769,0.0566175,-1.10427,-0.315349,-0.188343,-0.0692665,-0.218992,0.536342,-0.149024,-0.628354,-0.0047714,-0.758358,-0.00553968,0.500272,-0.205236,0.231602,-0.264261,-0.357468,0.15861,-0.574807,0.356204,-0.0641745,0.209937,-0.495361,-0.644841,0.433892,-0.0584658,0.0850401,0.3759,0.367893,-0.398008,0.0660501,-0.439772,0.410672,0.287882,-0.0554169,-0.801169,0.1175,-0.0137158,-0.627384,0.256991,0.52773,0.440356,0.0389565,0.00814269,-0.537562,-0.146021,-0.0419698,0.0328145,-0.0155536,-0.213615,-0.509808,-0.168816,0.0538749,-0.143983,-0.222766,0.161115,-0.312875,-0.127961,-0.23981,-0.219854,0.444198,0.536706,0.0917581,0.0990215,0.0953142,0.137574,0.0148259,-0.514284,-0.184897,0.596135,1.18712,0.547023,-0.356438,-0.0472878,-0.114749,0.215291,-0.0286851,0.624356,0.15273,-0.59824,0.569691,0.190828,-0.268128,-0.575196,0.328071,0.731277,-0.187894,-0.2129,-0.174643,0.0073228,-0.303715,-0.605913,-0.0822677,-0.0624853,0.905728,-0.0993607,-0.181647,-0.038083,-0.67021,0.287451,-0.42153,-0.0815134,-1.06911,-0.0370931,-0.0903254,-0.430966,-0.0907457,0.000462701,-0.147215,-0.357714,0.12242,-0.110346,-0.327061,-0.568253,-0.279753,-0.282501,-0.0231371,-0.282488,-0.112122,0.689757,0.0426189,0.0910962,0.915784,-0.291906,0.0377968,-0.15067,-0.412456,0.343852,0.405729,-0.0119691,0.471714,-0.208739,-0.236074,0.0220349,0.241841,0.702191,0.0533413,-0.536692,0.116107,-0.186518,0.365906,-0.62583,-0.503692,0.067291,-0.0302045,-0.188472,0.262498,-0.0482363,-0.611212,-0.398938,0.524384,-0.0121964,0.359014,0.0249425,-0.324758,0.0873265,-0.0614567,0.18933,-0.0473309,0.186831,0.209395,0.479508,0.0815947,-0.376672,-0.62348,-0.101319,-0.5806,0.257143,-0.52724,-0.654513,0.24439,-0.137099,-0.108605,0.516319,-0.36018,0.239489,0.847286,-0.642701,-0.261986,-0.315004,0.460535,0.0102935,-0.290317,-0.00996806,-0.192157,-0.584834,-0.267401,-0.516869,0.472448,0.277312,-0.106495,-0.0593375,-0.0414584,-0.373267,0.462416,0.346374,0.18807,0.0216121,0.340442,0.351169,-0.319805,-0.0107073,0.130588,-0.146681,-0.349466,0.198823,0.044371,-0.418675,0.276545,0.299313,0.211201,0.513953,0.0647072,0.0982785,-0.738624,0.296883,0.142606,0.373975,0.377632,0.611535,-0.936083 +3427.93,0.927879,0.0848144,4,1.62875,1.01778,-1.21378,0.348139,0.0564339,-0.191541,0.103026,-0.265033,0.164686,0.0193532,-0.0432498,-0.0737114,-0.0624239,0.341926,-0.140384,0.962939,-0.165013,0.0153624,-0.132774,-0.227494,-0.41396,-1.13745,-0.631719,-0.165217,-0.236773,-0.491664,-0.30539,0.106746,-0.498546,-0.47195,0.373226,-0.69173,-0.481901,-0.0310368,-0.201523,-0.156808,-0.160154,0.559464,0.285703,0.307381,1.28647,0.83269,0.94637,-0.998559,-0.283861,-0.00664526,-0.706524,0.470797,0.484302,0.345792,0.227586,0.729202,-0.286458,-0.921405,0.400505,0.0570631,0.0585977,-0.46766,0.124391,0.141315,0.228872,0.999406,-0.530044,-0.637372,0.451039,0.00806929,0.467812,0.383712,0.415911,0.095942,0.0646559,0.340177,0.203844,-0.637983,0.371557,0.422889,-0.221692,-0.38027,-0.0484292,0.503255,0.61696,-0.285045,0.251989,-0.981456,0.189289,0.0933175,-0.315886,-0.646151,0.155718,-0.317005,-0.159127,0.724171,-0.333566,-0.428171,0.345619,-0.898436,-0.545971,-0.00970471,-0.228487,0.106742,0.179809,0.400861,0.271633,-0.159931,-0.149065,-0.413544,0.560297,-0.625441,-0.0228352,0.429538,-0.0621954,0.0785668,0.426403,0.231847,-0.394004,-0.0850765,-0.410995,-0.256033,0.490983,-0.100042,-0.35715,-0.103707,-0.152669,-0.0613906,-0.270586,0.153573,0.153481,-0.154674,0.329562,-0.706336,-0.262209,0.057765,-0.0198993,0.0122234,-0.081246,-0.742181,-0.103502,-0.189535,-0.173314,-0.463998,-0.173109,-0.203012,0.146007,-0.610627,-0.0477001,0.395703,0.446627,0.539167,0.0571404,0.159263,-0.0811295,-0.19657,0.00933337,0.304866,0.257526,0.834211,0.216746,-0.147259,-0.188592,-0.166279,0.345775,-0.323132,0.593393,-0.306263,-0.566063,0.434538,-0.078615,-0.178521,0.0825158,-0.012008,0.383979,-0.10925,-0.0176567,-0.243208,-0.211839,-0.0224423,-0.451005,0.147883,0.284342,0.64737,-0.347227,-0.0788968,-0.127354,0.196252,-0.00411267,0.104783,-0.180523,-0.683036,-0.299489,0.0317354,-0.0654937,-0.223299,0.237592,-0.234464,-0.486334,0.224502,0.0201259,-0.52946,-1.11454,-0.618673,-0.116227,-0.246528,-0.789988,0.0719221,-0.131954,-0.0222062,-0.314248,1.10824,-0.409125,0.194172,0.299276,-0.829457,0.318613,0.0701627,-0.0957237,0.206786,-0.385324,-0.274082,0.0894709,0.0111277,-0.0125617,-0.526917,0.0562353,-0.0207369,0.128904,0.390105,-0.483158,-0.429222,-0.163894,-0.128294,0.147831,0.133445,-0.114371,-0.720198,-0.0341215,0.712203,0.127046,-0.307859,0.292472,-0.0449768,-0.0544623,-0.00272892,0.505933,0.193516,0.104119,0.0151682,0.0312923,-0.269477,-0.164706,-0.570883,-0.485331,-0.492898,0.616506,-0.12654,-0.469828,0.230324,-0.33288,0.305098,-0.190766,0.0428224,0.497323,0.792163,-0.0859839,-0.339815,-0.267964,0.254329,0.0516889,-0.109008,-0.192503,-0.11694,-0.547308,0.0767633,-0.217849,0.345907,0.250525,-0.324084,-0.0174768,-0.226753,0.0426551,0.428112,0.298521,0.249258,-0.0813667,0.416061,0.183179,-0.369173,0.099135,0.202548,-0.0664496,-0.145813,-0.0251347,-0.01002,-0.023262,0.101867,0.177937,-0.452031,0.146969,-0.057552,-0.385348,-0.604962,0.245859,0.124587,0.28498,0.352969,0.533835,-0.00251312 +3457.92,0.944341,0.0848144,4,1.6094,0.959067,-1.5644,0.488244,-0.0596167,-0.0769538,-0.284831,-0.0853677,0.114663,0.0879405,-0.504058,-0.307147,-0.537186,0.530145,0.152602,0.1837,0.040201,-0.433101,-0.356076,-0.00521715,-0.510628,-1.10684,-0.649441,-0.195992,-0.362675,-0.265846,-0.416632,-0.0266116,0.109834,0.0457515,0.639147,-0.0343023,-0.454077,-0.140618,-0.417506,-0.223561,-0.4341,1.09906,0.66487,-0.610865,1.10817,0.672401,-0.217812,-1.01597,-0.18274,0.329601,-0.374958,0.42439,0.190641,-0.152415,-0.0658155,0.11994,0.195894,0.129854,0.277633,-0.257442,-0.0590347,-0.521463,0.0949327,-0.704316,0.318636,1.1684,-0.771314,-0.887703,0.335274,0.184929,-0.30195,-0.296015,0.363977,-0.546937,-0.506904,0.406185,0.537337,-0.280758,0.890986,0.581607,0.5981,0.278784,-0.273607,-0.638245,0.25109,0.0394119,0.203954,-0.138754,-0.427113,0.0029714,-0.183392,-0.0593658,-0.1764,-0.179531,0.123479,0.0259314,0.242841,-0.325887,0.0335792,-0.132919,-0.290198,-0.293819,0.0804542,0.209559,0.311961,-0.395599,-0.259941,-0.513874,0.268937,0.0402055,-0.221923,0.0686539,0.125509,0.682566,0.206214,-0.220119,0.00962015,0.445677,0.46362,0.0353091,-0.126627,0.372459,0.244713,0.298097,-0.746429,0.232372,-0.0361424,-0.275268,0.0932322,0.145446,-0.0834169,0.188673,-0.152674,-0.223542,-0.0424723,-0.332364,-0.224386,0.245636,-0.293275,0.131427,-0.35485,-0.35411,0.532304,-0.642691,-0.230362,0.204945,0.130693,0.100093,0.13665,0.358519,-0.394832,0.185284,-0.153833,-0.361194,-0.340781,0.21425,0.00648945,-0.213704,0.091923,-0.13405,0.0852915,0.14086,-0.124243,0.264624,0.0508213,-0.346864,0.677836,0.0674818,0.204851,-0.171112,0.157952,0.121295,-0.0519073,0.366484,0.334178,-0.283329,-0.168438,0.0763589,-0.138494,0.122271,-0.00394183,-0.259407,0.294939,0.355489,0.452808,-0.173088,0.164366,-0.38728,0.242717,-0.0777321,0.153723,0.0865998,0.164314,-0.484779,-0.119768,0.0122536,-0.0491731,-0.637997,0.429736,0.20959,-0.172714,0.0109285,-0.213161,0.210301,0.0100552,-0.138719,0.148365,0.439032,0.175689,-0.139984,-0.599001,0.759584,0.117581,-0.0452934,-0.255777,-0.183104,-0.0987017,0.123462,0.341322,-0.0829604,0.31802,0.238848,-0.0521977,-0.168336,0.385393,-0.00374534,0.174356,0.220217,-1.20813,0.489601,-0.207562,0.186677,0.194829,0.266178,-0.0259527,-0.125208,0.412288,0.0870054,-9.47465e-05,0.577236,-0.00129954,0.1949,0.563739,0.116035,-0.121736,0.20818,-0.706159,0.252007,0.2523,-0.00289602,0.696565,0.458623,0.118018,-0.274957,0.0436532,-0.518874,0.131796,-0.313551,0.186592,0.137512,-0.31848,0.0542389,-0.750345,0.123932,0.136574,-0.129412,-0.0036793,0.663962,0.0532169,0.128204,0.0191299,0.0812833,-0.394121,0.134802,0.0106091,-0.0389049,0.112679,-0.645603,-0.277492,0.290481,-0.0494688,0.0689458,0.615009,0.138386,-0.241927,-0.152706,0.00361775,-0.125946,0.176447,-0.140873,-0.235702,-0.116178,0.239713,-0.2321,0.055231,0.305209,-0.346557,0.121747,0.449611,0.019076,-0.12921,-0.141137,0.285217,0.308757,-0.225042,0.0952489,0.193407,0.308624,0.43978,0.489895 +3423.96,0.936553,0.0848144,5,1.71938,0.80675,-1.3054,0.346984,0.180318,-0.217659,-0.0917205,-0.347113,-0.0189863,-0.103018,-0.2026,-0.710047,-0.0841461,0.369284,-0.770131,0.931521,-0.132249,-0.393483,-0.526907,-0.225308,-0.384834,-0.73567,-0.905695,-0.0989861,-0.0261492,-0.287637,-0.513502,-0.124153,-0.606236,-0.322961,0.507386,-1.23764,-0.510967,-0.2122,-0.564785,0.371055,-0.175901,0.279107,-0.0727962,-0.325821,0.935108,0.494053,0.0717025,-0.65749,-0.33326,0.390682,-1.16663,0.784319,0.182312,0.145752,-0.0531057,0.243785,-0.0584637,-0.697485,0.612775,-0.514244,-0.210547,-0.862967,-0.230249,0.302392,0.452324,0.74852,-0.732242,-0.316738,0.103472,0.229999,0.396407,-0.0759392,-0.0206784,-0.153968,0.554673,0.196681,0.313745,0.235875,0.291841,0.457575,0.269836,-0.497302,-0.249664,-0.112934,0.132162,-0.377917,0.266968,0.0613277,-0.0180147,0.39444,-0.0183379,-0.190085,-0.122033,-0.281736,0.107881,0.0103967,0.0013245,0.0200183,-0.26658,0.232825,-0.00197161,-0.182704,0.335133,-0.120803,0.243862,0.158878,-0.0829581,0.212457,-0.598682,-0.253546,-0.0317321,0.0788912,-0.0488416,0.666902,0.243295,-0.225002,0.744721,0.360991,0.507019,-0.305101,-0.278411,0.348853,-0.0308424,0.156568,-0.441349,-0.562287,0.0459421,-0.0182322,0.314637,0.249318,-0.385738,-0.125663,0.426887,-0.352091,-0.000630282,-0.463342,-0.157494,0.328439,0.240352,-0.467252,0.394777,-0.213669,0.309974,-0.433766,-0.599367,0.0585696,-0.143012,-0.268133,-0.0694856,-0.0917354,0.0322346,0.345942,-0.0659331,0.273433,0.574313,-0.00382673,0.272733,0.0917592,0.122512,0.704674,-0.0871522,-0.11044,0.298044,-0.333694,0.506056,0.0346391,0.79051,0.515899,-0.641227,0.176659,-0.108066,0.0342698,-0.0517258,0.033188,-0.214771,-0.0759245,0.211904,0.395948,0.0979842,-0.126005,0.218046,0.0695001,-0.165074,0.924792,0.452381,-0.403132,-0.0587458,0.406189,0.0572533,0.212103,-0.368805,-0.0151963,0.266575,-0.123547,-0.177781,0.405093,-0.362891,-0.367253,0.0294495,0.140023,0.121919,-0.324937,-0.61295,-0.143588,0.0394801,-0.743301,-0.00927073,0.439631,-0.0616881,-0.422563,-0.152117,1.08334,-0.0853661,-0.338491,0.70099,0.169876,0.137659,0.110728,-0.0637269,0.477049,-0.410307,0.236484,0.603017,0.323333,-0.0489727,-0.0174973,0.218779,0.615374,-0.636761,0.591514,-0.304959,-0.0644461,0.564124,0.232976,-0.0546058,0.317196,0.0424554,-0.0407283,-0.393158,0.895362,0.155503,-0.0907545,0.47217,0.210454,-0.190159,0.0802777,0.226734,-0.0474477,0.62993,-0.118453,0.180133,0.377948,-0.205746,-0.536177,0.0332216,-0.503648,0.567666,-0.558581,-0.808662,0.44684,-0.255676,0.191166,0.381652,0.381464,0.0204408,0.122804,-0.182773,0.0105619,0.382351,0.0330103,-0.206298,0.107369,0.454286,-0.283882,0.211955,-0.465897,-0.302321,0.366611,0.458954,0.704202,0.168948,-0.0947973,0.694397,0.113571,-0.0487421,-0.306916,-0.330401,-0.163302,0.704477,0.403919,0.800039,0.429268,0.0664769,0.0592756,0.223312,0.557012,0.209298,0.645958,0.127315,-0.0924195,0.195681,-0.410877,0.34758,-0.203204,0.286916,0.134342,0.261693,0.366527,0.511559,0.105695 +3390.54,0.892537,0.0848144,4,1.58411,0.909014,-1.15529,0.337797,0.270027,-0.130322,0.249918,-0.206651,-0.101694,0.252059,-0.382981,-0.991626,0.10254,0.570341,-0.929771,0.564776,-0.233615,-0.112569,-0.638696,-0.382266,-0.246341,-0.32044,-1.02073,-0.0456082,-0.0221597,-0.491304,-0.134973,0.183465,-0.702537,-0.252619,0.304737,-0.395882,0.0730764,-0.310916,-0.268184,-0.0186882,0.266186,0.396835,0.268863,-0.385671,1.10648,0.371534,0.162743,-0.348714,-0.384758,0.490388,-1.08506,0.602169,0.15789,-0.0812266,-0.207317,-0.148038,0.0109904,-1.15325,0.412786,-0.103965,0.0905859,-1.09824,0.219486,0.0952578,0.0970567,0.801502,-0.3202,-0.429747,0.101683,0.0368545,0.199635,0.0944294,0.100386,0.182942,0.753701,-0.0741972,0.522887,0.252342,0.250086,0.405323,0.335945,-0.40282,-0.533038,0.231889,-0.104299,0.1382,0.536836,0.380349,-0.161054,0.24255,0.323636,0.128314,0.131023,-0.381691,0.0881092,-0.0179196,-0.00594147,-0.0496321,-0.114463,-0.575789,0.390358,-0.365519,0.154744,-0.274806,0.0606289,0.206902,-0.263202,0.485189,-0.286415,-0.194129,-0.282406,0.00246363,0.0552127,0.650611,0.45362,-0.199727,0.280641,0.535916,0.150403,0.243418,-0.220502,0.160725,-0.16841,-0.457507,-0.695728,-0.812136,-0.0928419,-0.581728,-0.523975,0.261073,-0.218888,-0.152944,0.614638,-0.273275,0.333931,-0.343266,-0.00165986,0.5726,0.225921,-0.0468438,0.210118,0.0142828,0.2359,-0.648937,-0.515438,-0.117061,-0.315399,-0.587334,0.152192,-0.035239,0.164634,0.26003,-0.28974,0.457134,0.000411064,0.0526269,0.453358,0.147377,-0.242599,0.967198,-0.0239537,-0.271178,0.0014483,-0.387316,0.504537,-0.187507,0.856712,0.0436834,-0.0769844,-0.334015,-0.338554,0.059743,0.209646,0.362285,0.312419,-0.228259,0.10072,0.119344,0.18875,0.140702,0.745955,-0.142313,-0.0109969,1.20772,0.189572,-0.12914,-0.342623,-0.0165211,0.141904,0.147233,-0.606115,-0.0972641,0.148013,-0.19668,-0.123748,-0.0177059,-0.297187,-0.390744,0.177803,-0.0134283,0.217999,-0.420414,-0.916337,-0.530142,-0.115829,-0.513648,-0.0798192,0.823141,0.138155,-0.394583,-0.306346,1.29282,0.436676,0.0130946,0.277225,-0.033265,0.121668,-0.300445,0.607876,0.433608,-0.239363,0.28102,0.175739,0.176326,-0.0142042,0.18025,-0.187762,0.650836,-0.787701,0.814,-0.777298,-0.0231317,0.713699,0.484017,-0.23579,0.0968733,-0.423265,-0.062702,-0.155256,0.678458,-0.330308,-0.231914,0.719959,0.322926,-0.0310872,0.467893,0.281894,-0.0437091,0.361041,0.0893662,0.201774,-0.107188,-0.388549,-0.456478,-0.117467,0.0304062,0.794601,-0.122256,-0.170973,0.230062,-0.379606,0.0559656,-0.0785025,0.179225,0.135136,0.459119,-0.063868,-0.114476,0.604407,0.0487254,0.218153,0.322901,0.0875715,0.622246,0.05807,-0.666929,0.215696,0.41971,0.645556,0.274583,-0.0306503,0.212205,0.405777,-0.227078,-0.429614,-0.469484,-0.239041,-0.0980487,0.301878,0.486557,0.549076,0.851499,0.301817,0.22081,0.268822,0.430304,0.00763349,0.208292,0.497643,-0.00723473,0.293299,-0.653686,-0.206253,0.139179,0.236177,0.139901,0.205354,0.374034,0.45316,-0.60018 +3419.18,0.996303,0.0848144,5,1.62815,0.990215,-0.589187,0.244686,0.246618,-0.13837,-0.0239301,0.0893234,0.326142,0.103177,-0.241564,-0.0716552,-0.291401,0.824015,0.111979,0.57192,0.068894,-0.0990552,0.285458,-0.02918,-0.374525,-0.976204,-0.573242,0.0866908,-0.187038,-0.251166,-0.111518,0.255781,-0.145495,0.0041339,0.749682,-0.331471,-0.100582,0.0597944,-0.492391,-0.295648,-0.733989,-0.0969194,-0.0700456,-0.292917,0.708981,0.654179,-0.0410739,-1.04427,-0.0750811,-0.594007,-0.378409,-0.373801,0.151152,0.16029,-0.0844181,0.6442,-0.0426244,0.371524,0.355549,-0.305309,-0.254397,-0.578189,0.156016,-0.571301,0.250184,0.359907,-1.24036,-1.02158,-0.150585,-0.142329,0.140993,-0.0230817,0.09888,-0.598821,-0.440814,0.56265,0.162113,0.0432332,0.779538,0.500314,0.557029,0.253518,-0.127734,-0.108727,0.336023,-0.380399,-0.160959,-0.801287,0.261326,0.0247509,-0.519607,-0.122047,0.247956,-0.224167,-0.197052,-0.386036,0.223614,0.0251072,-0.0148008,-0.0634499,-0.0697936,0.310169,-0.124899,0.575403,0.0730291,-0.0497603,-0.598225,-0.598096,0.215864,-0.347325,0.443885,-0.13252,0.153776,0.761459,-0.200772,-0.228608,0.119867,0.471814,-0.206054,-0.286678,0.123191,0.50576,0.454282,0.182827,-0.0073979,0.881285,0.0460517,-0.0903597,0.0918916,0.00743096,0.80324,0.279079,-0.0216857,-0.0494523,-0.246167,-0.234434,-0.155428,0.395562,-0.309839,0.00101563,0.119211,0.0298659,0.463064,-0.316029,0.265976,0.0856608,0.0278731,0.186513,0.0678821,-0.117902,-0.144059,0.364861,0.0255688,-0.69958,-0.332385,0.369646,-0.0600351,-0.294195,0.152925,0.403128,0.705985,0.612986,0.0343994,0.202615,0.0315198,0.0108977,0.542492,0.0645819,0.396931,0.687186,0.401204,-0.153738,-0.224923,-0.448495,-0.0925555,0.173229,-0.0917329,-0.548788,-0.728661,-0.0423284,-0.752608,-0.258963,0.210919,0.411008,0.211735,0.0339668,0.515385,-0.394573,-0.0109346,-0.162948,0.210971,-0.146457,0.398038,-0.439477,-0.26134,0.0280265,-0.229595,-0.335353,-0.145785,0.132165,0.0462014,-0.245664,-0.169396,0.642671,0.0395676,-0.511378,0.314626,-0.888561,-0.319109,0.230771,-0.730914,0.574629,-0.257784,0.222979,-0.0560638,-0.235553,-0.152607,0.430359,-0.478908,0.517868,-0.0702344,-0.184247,0.0360073,-0.255353,0.0839175,-0.535598,0.410716,0.126264,0.113196,0.247674,-0.331188,-0.06855,-0.520963,-0.395761,-0.288348,0.235953,0.339664,-0.663103,-0.022085,0.697567,0.262086,-0.0746322,0.619435,-0.491639,-0.412432,0.155355,-0.151363,-0.0574957,-0.00742558,0.0634756,0.710277,0.757879,0.0933507,-0.431978,0.414349,-0.600502,0.0644913,-0.56958,-0.190804,0.414713,-0.0141023,-0.418019,-0.177725,0.030606,0.198242,0.564338,0.132164,0.444679,-0.00517479,0.2078,-0.164504,-0.883974,0.138759,-0.204123,-0.17417,0.0241733,-0.659237,-0.0642393,-0.479703,-0.66679,0.0677136,-0.066517,0.337115,0.205406,0.438985,0.0105649,-0.39498,0.106388,0.146115,-0.233244,-0.419281,-0.328497,0.135098,-0.776198,0.0248291,-0.0454767,-0.146688,0.369813,-0.176626,-0.50285,0.175877,0.302408,0.421538,-0.361908,0.222582,0.126041,0.172901,0.355023,0.415813,-0.829111 +3434.05,0.981936,0.0848144,4,1.65978,0.862267,-1.04814,0.479686,0.597582,0.00962298,-0.20566,-0.412407,0.244942,0.645239,-0.253045,-0.120577,0.281002,0.513246,-0.198103,0.765164,0.338864,0.364221,-0.0132032,-0.128929,-0.19836,-0.67224,-0.761053,0.320143,0.176248,-0.0399001,-0.143058,0.167979,-0.340615,-0.388569,0.694252,0.254332,0.265619,0.232478,-0.402771,-0.179953,0.327788,0.0951823,0.117463,-0.397456,0.761869,0.400387,0.20154,-1.0514,-0.0299047,0.0569416,-0.318602,0.114938,0.130987,0.10551,-0.263495,0.266389,0.297838,-0.212094,-0.0112352,-0.487184,0.0159963,-1.04622,0.0614452,-0.50599,0.335418,0.61637,-0.89584,-0.739882,-0.0591182,-0.132955,-0.0582908,0.0666444,-0.0810009,-0.536204,-0.564933,0.662161,0.139189,0.20987,0.792826,0.283769,0.016124,-0.525228,-0.142286,0.429412,0.454562,-0.306767,0.36102,-0.639085,0.110839,0.15509,-0.00928181,0.243426,0.380074,-0.39398,0.338892,-0.184953,-0.0369663,0.291897,-0.0336565,-0.496061,0.158736,0.107847,-0.459881,0.239831,0.660654,-0.468733,-0.0875586,-0.425541,0.55664,-0.509898,0.119098,-0.200059,0.181427,0.67937,-0.154653,-0.0238498,0.142592,0.656758,-0.547998,-0.0942601,0.365668,-0.172011,0.355154,0.0323933,-0.617911,0.717314,0.0631462,0.585788,0.0322549,0.180575,0.73622,-0.14896,0.826164,-0.812365,0.236212,-0.253208,-0.0984528,0.508895,-0.0489572,0.143327,-0.0828049,-0.143908,0.158795,0.0278576,-0.438426,-0.149491,0.415453,-0.310813,0.496359,0.337492,-0.327248,0.446484,-0.0981262,-0.363227,-0.286353,-0.00864389,0.0268492,-0.0486627,0.290545,0.697184,0.227428,-0.0991394,0.291497,0.206629,-0.241289,0.506502,0.352829,-0.388303,-0.353493,0.452815,-0.160435,-0.296603,0.14038,0.148921,-0.378641,-0.203637,0.296785,0.204833,-0.302415,-0.0105676,-0.791346,-0.212667,0.0644523,0.615967,-0.164433,0.124272,0.588595,0.146833,0.144417,0.0800212,-0.240739,-0.151107,0.329677,-0.760368,-0.13189,-0.161702,0.0382924,-0.324059,-0.520348,-0.0938238,0.374239,-0.252603,-0.617596,-0.0120013,-0.261413,-0.185892,0.392644,-0.351912,-0.279327,-0.196002,-0.00161798,1.16646,0.0589717,0.636432,-0.24223,-0.220211,0.171043,-0.106161,-0.601623,0.359397,-0.161741,0.161167,-0.274693,0.0944864,0.259538,-0.223761,-0.38148,0.16817,-0.514219,0.354276,-0.488469,-0.165003,-0.48308,0.238007,-0.279371,0.233444,0.4096,-0.548194,0.135444,0.575292,-0.0421576,-0.189774,1.07759,-0.092434,-0.214249,0.398746,0.113468,0.399667,0.213356,-0.286719,0.761801,-0.312556,-0.279975,-0.497238,-0.240587,-0.353006,-0.0492621,-0.527381,-0.235911,0.337773,-0.363675,0.13382,0.439396,0.0449245,-0.197526,-0.0559698,0.461565,0.116059,-0.0094767,0.556643,-0.105777,-0.207907,-0.171405,0.491041,-0.368455,-0.161946,-0.398983,-0.24902,-0.30219,0.0312185,0.109473,-0.358072,0.158685,0.350333,-0.62186,-0.393713,-0.439477,-0.380077,0.385827,0.273296,-0.432151,0.117832,0.0860729,-0.470711,0.279804,0.136446,0.00699831,0.260916,0.0916406,-0.375987,0.222647,-0.0983127,0.0224278,0.00865749,-0.0286802,0.131267,0.175317,0.362308,0.418709,-1.75512 +3408.3,0.946903,0.0848144,4,1.67311,0.992815,-0.632597,0.23976,0.411927,-0.00950702,0.244109,0.77809,0.613958,-0.269528,-0.366871,0.0105998,-0.372632,0.17429,-0.201212,0.548847,0.224117,-0.0710759,0.281134,-0.0672262,-0.449992,-0.81222,-0.397077,0.105344,-0.392886,0.219461,0.153633,0.633312,0.241303,0.331997,0.617601,-1.07599,-0.198415,0.0110293,-0.498776,-0.429308,-0.674834,0.363248,0.748461,0.301517,0.735279,0.666451,0.118152,-0.765663,-0.2299,-0.109707,-0.181351,0.0899413,-0.2055,0.0369503,-0.229472,0.176532,-0.488459,-0.618759,0.23557,-0.48814,-0.343885,-0.801384,0.469479,-0.421149,-0.0138793,0.710058,-0.266686,-0.374831,0.0460716,0.494353,0.0665527,-0.331716,0.369543,0.17014,0.221248,-0.277265,0.615039,0.423282,0.696718,0.289389,0.286295,-0.124284,-0.0470156,-0.422516,0.0867251,-0.178254,-0.0415082,0.161831,-0.46851,0.0630805,0.0288594,-0.513108,-0.161801,-0.0379,0.0475707,0.208312,0.0400659,-0.179305,-0.238288,0.140317,0.131987,-0.484853,0.161374,0.415111,-0.407344,0.411394,-0.33897,0.0835595,0.0685749,-0.775862,0.327488,0.337444,0.23781,0.453881,0.757671,0.265822,0.624112,0.617608,0.746764,-0.0179154,-0.587865,-0.0528252,0.0673075,-0.40896,-0.484528,-0.352766,-0.991925,-0.96803,-0.019995,0.180092,-0.498391,0.610876,0.152842,0.310361,0.183662,-0.0883055,-0.159803,0.766267,-0.420349,-0.487881,0.0765592,-0.215518,0.495114,-0.931984,-0.0116839,0.0747715,-0.379681,-0.801956,-0.0762906,-0.282864,-0.128964,0.326995,0.217168,0.291934,0.123469,0.692684,0.457363,0.208285,-0.321169,0.542966,0.007616,-0.468553,0.152717,-0.546225,0.683543,-0.118199,0.775401,0.708624,0.0305383,-0.172724,0.348131,-0.448662,-0.214614,-0.0783674,0.824573,0.480335,0.0638879,0.41569,0.0610064,0.389832,-0.0520616,0.262432,0.315643,0.930236,0.193688,-0.584186,-0.0806079,0.215703,-0.617266,-0.454529,-0.45661,0.0223596,-0.199055,-0.0725744,-0.178109,0.145398,-0.0316186,-0.846202,-0.202392,0.170475,0.13625,-0.244624,-0.51553,0.462854,-0.016226,-0.0575336,-0.616872,-0.337387,0.227396,-0.0921493,-0.323563,0.932331,0.20365,-0.120198,0.665749,-0.127146,0.445225,0.0761088,-0.153999,0.0406046,-0.739975,0.333038,0.303025,-0.752445,0.119267,-0.925378,-0.0726218,-0.239943,-0.324751,0.924439,-0.332587,-0.237906,0.424798,-0.323529,-0.101352,0.353514,-0.253225,-0.196272,-0.677966,-0.0101231,0.377504,0.281806,0.180518,-0.887809,-0.194877,-0.00705536,0.0728619,-0.497128,0.161588,-0.268672,0.43591,0.25643,-0.0750778,-0.49114,0.208552,-0.328491,0.119218,-0.122123,-0.238826,0.17594,-0.460197,0.0938224,-0.570942,-0.168499,0.313897,0.504317,-0.135972,-0.00151134,-0.237922,-0.26472,0.133553,-0.0380548,0.349282,-0.354455,0.159342,-0.062475,-0.246612,0.478317,-0.0972057,-0.615057,0.328365,0.0505133,0.637258,0.230573,-0.0489198,-0.0517967,-0.203258,0.218487,0.000507992,-0.402694,0.368867,0.606629,0.236093,0.754034,0.123859,0.0333053,-0.0292842,0.21771,-0.490089,-0.0786859,-0.241735,0.408074,-0.157414,-0.0795154,-0.00200318,0.163498,0.192504,0.404349,0.438753,-1.34227 +3440.94,0.894565,0.0848144,5,1.55004,0.983987,-1.27481,0.558063,0.297005,-0.125789,0.504557,-0.1493,0.501012,0.582278,0.25488,-0.408797,0.171989,0.120724,-0.162582,1.21959,0.277871,0.357409,-0.138093,-0.0629141,-0.0861561,-0.247862,-0.562561,0.174101,-0.0821533,-0.137067,-0.0472806,0.0933474,-0.253298,0.0957792,0.804143,0.469522,0.204855,0.367726,-0.78359,-0.278968,0.119083,0.805266,0.134914,-0.564325,0.976629,0.712032,0.478228,-1.11344,-0.163184,0.134189,-0.393434,0.459778,0.122494,0.0907207,0.0268852,0.0413007,0.0803203,-0.383311,0.161529,-0.553,-0.390478,-0.880564,0.0510728,-0.44625,0.31677,0.953823,-0.935065,-0.845301,0.368052,-0.316177,-0.120702,0.0103493,0.072939,-0.768453,-0.121492,0.297608,0.647771,-0.131913,0.725883,0.409832,0.268352,-0.0571235,-0.424481,-0.023169,0.0886185,-0.50331,0.253291,-0.535653,0.284144,0.344796,0.245597,-0.158053,0.0915737,-0.445278,-0.289642,0.111488,0.0209473,0.250414,0.171913,-0.410047,-0.303968,0.00307282,-0.128877,0.298452,0.281244,-0.131639,-0.107295,-0.422975,0.438519,0.0242092,-0.0853621,-0.144348,-0.105782,0.628414,-0.470362,-0.219291,0.476458,0.173627,0.0185817,0.128744,-0.216915,-0.147181,0.193273,0.143286,-0.744565,-0.12605,0.354291,0.415696,-0.376736,0.174717,0.511328,0.22518,0.208652,-0.79598,0.390069,0.344299,-0.0452559,0.246361,-0.210311,-0.456858,-0.188658,0.0180947,-0.252503,-0.40948,-0.298677,-0.30761,0.771142,-0.0980417,-0.141677,0.456342,-0.111316,-0.233452,-0.340139,-0.341726,-0.72889,-0.184066,-0.0686063,-0.123023,0.0982587,0.0747242,0.175262,0.0588713,0.32519,-0.170732,-0.405224,0.452511,0.542119,-0.268543,-0.801306,0.139603,0.19013,0.247374,0.165283,0.155665,-0.0707854,-0.338831,-0.189535,0.118353,-0.328233,-0.190594,-0.62015,-0.0510799,-0.0182347,0.482224,0.233808,0.224722,0.209962,-0.334771,0.184569,0.142945,-0.520537,-0.292312,0.551385,0.13106,0.0469512,0.0670512,-0.060713,-0.206901,0.135641,0.216546,0.0273855,-0.484496,-0.684823,-0.473025,-0.213831,-0.496544,-0.0765323,0.43279,-0.0296249,-0.216084,-0.181853,1.07646,-0.161083,0.440267,-0.407194,-0.132588,0.124669,0.38564,-0.0300564,0.226821,-0.0918007,0.283565,0.1119,-0.103425,0.0540126,-0.112158,-0.356457,0.0411628,-0.398229,0.440245,-0.943922,0.149483,0.273559,0.342801,0.135864,-0.262757,0.289281,0.0320188,0.112197,0.521918,-0.00892555,-0.295531,0.976856,0.224494,-0.240035,-0.0105011,-0.618296,0.215961,0.607192,0.782903,0.295467,-0.265787,0.0279155,0.12074,0.195473,-0.265357,0.173605,-0.489828,-0.265255,0.334856,-0.495495,-0.360045,0.104682,0.0823496,0.358235,0.0684937,0.0965559,0.166814,0.337396,0.444486,-0.0798289,-0.0620621,0.288212,0.369361,-0.541406,-0.4216,-0.245872,-0.0908715,0.135647,0.23332,-0.112235,0.076935,-0.0259084,-0.20421,-0.221308,-0.459796,-0.210374,-0.225458,-0.0430212,0.328271,-0.17428,-0.0704364,0.0920402,-0.417088,-0.149067,0.583773,0.152549,0.264525,-0.141068,-0.561118,-0.0187999,-0.568554,0.012463,-0.0231586,0.343101,0.116488,0.180162,0.341303,0.424455,-1.00359 +3424.42,0.996306,0.0848144,4,1.54514,1.01392,-0.806682,0.395948,0.33874,-0.0919167,0.372314,0.475795,0.624329,-0.434613,-0.104458,0.0203658,0.21522,0.381165,0.0552027,0.488298,0.0581631,0.147664,0.0377239,0.0644153,0.0631358,-0.164949,0.069854,0.504805,-0.242988,-0.0458245,0.228456,0.624151,-0.374165,0.155774,0.901906,-0.190937,0.254703,0.0811621,-0.455689,0.0289687,-0.218053,0.515463,0.740842,-0.814643,0.517141,0.270075,0.452128,-0.94939,-0.102454,-0.546381,-0.433838,0.838284,-0.00472137,-0.373089,-0.0970176,0.991164,-0.0158375,0.0787457,0.153806,-0.114263,-0.381763,-0.682013,0.152819,-0.125707,0.560551,0.884695,-0.298443,-1.00111,0.227598,0.103577,-0.417523,0.106575,0.0469283,-0.192425,-0.0975574,0.0490734,0.679738,0.113305,0.744456,0.549434,0.150415,0.421932,0.0789459,0.027803,-0.0752687,-0.773399,-0.1751,0.20599,0.270392,0.260891,-0.312862,0.00844739,0.226818,-0.509136,-0.299671,-0.592685,0.488168,-0.292325,0.0292492,0.191527,0.128401,-0.703224,0.402325,0.480251,0.412024,-0.034988,0.29043,-0.430105,0.118014,-0.381986,0.228806,-0.0600244,0.102639,0.572251,0.517572,-0.303571,0.13613,0.277063,0.205479,0.458475,-0.325888,0.255256,0.234778,-0.205928,-0.226757,-0.0536093,0.0835216,-0.620248,0.100776,0.397822,0.274374,0.473832,-0.0744311,-0.305866,0.256277,0.0533538,0.101619,0.289315,-0.731996,-0.581761,-0.201369,-0.491091,0.285868,-0.622793,-0.29904,-0.405574,0.342966,-0.0293849,0.495009,0.0631049,0.19021,-0.184847,-0.444996,-0.243682,-0.0703269,0.0764288,-0.0491782,-0.434114,-0.380381,-0.203386,0.192365,0.339689,0.0371815,0.21402,0.177235,-0.0132339,0.0865918,0.360995,0.184701,-0.140278,-0.0116731,-0.0629398,-0.297774,-0.0608919,-0.265223,-0.101531,-0.147526,-0.0125233,-0.180732,0.178378,-0.145237,-0.297924,-0.433665,0.372666,0.122994,-0.0208347,0.325716,-0.301991,-0.343149,-0.620018,-0.590016,-0.435812,0.563502,-0.298678,0.320961,-0.240378,0.184204,-0.288353,-1.02762,0.0828446,0.180143,-0.539791,-1.01781,-0.225592,-0.154717,-0.179186,0.0865982,-0.135727,-0.766104,0.0552657,-0.457372,0.781396,0.0510984,0.310009,-0.232027,0.201536,-0.0542968,-0.027398,-0.206347,0.0794674,-0.383418,0.258445,-0.17047,0.121072,-0.148216,-0.450948,-0.408338,0.220087,0.0142257,0.62338,-0.415608,-0.306338,0.16622,-0.279741,-0.610087,0.197875,0.0486643,-0.275891,-0.0831219,0.446847,-0.0322465,-0.115414,0.190814,0.0757214,-0.106462,-0.211275,-0.0698234,-0.171019,0.379225,0.354894,0.214405,0.397803,-0.498824,-0.288898,-0.17833,-0.530915,0.409137,0.0424035,-0.3827,0.330973,-0.731994,-0.794665,0.00935187,-0.117689,0.174272,-0.0388021,-0.344637,0.355028,0.953783,0.396203,-0.0297248,-0.600408,-0.0214277,-0.0974418,-0.126632,-0.112372,0.312221,-0.414422,0.0483438,0.650031,-0.0708962,0.158588,0.378253,0.214558,-0.0569498,0.283485,-0.439981,-0.264944,0.416432,0.314049,-0.349684,0.219118,0.00359725,-0.221571,-0.100683,-0.0500135,0.453952,-0.0753224,0.0317401,-0.462514,-0.364037,0.431795,-0.328139,-0.351946,0.223662,0.111073,0.211111,0.333276,0.459468,-1.30064 +3427.25,0.943877,0.0848144,4,1.44525,0.965208,-1.03329,0.364723,0.452077,-0.0830847,-0.216023,-0.0904739,0.659995,0.426634,-0.172213,-0.504251,-0.0945702,0.157505,-0.0739411,1.2245,0.516471,0.223325,-0.00101659,-0.0870394,-0.149811,-0.821132,-0.39345,-0.13539,-0.148888,0.00475743,0.214169,0.26772,-0.393738,0.100922,1.07987,-0.0859818,0.266619,0.336739,-0.436993,-0.0406495,-0.358413,0.990576,0.100739,0.0212686,0.919577,1.01494,0.0825546,-0.852211,-0.00132575,0.174309,-0.252988,-0.32128,0.240666,0.19932,0.380535,0.14064,0.317078,-0.65876,0.620906,-0.0530411,-0.0765463,-0.609695,0.538705,-0.159537,0.288233,0.99211,-0.942112,-1.08663,-0.357897,0.144305,0.0110132,-0.517959,0.356595,-0.621117,-0.200616,-0.310749,0.875188,0.000752864,0.287327,0.0302731,0.344397,-0.530672,-0.663768,-0.270394,0.549656,-0.465795,0.71193,-0.21181,-0.351328,-0.49419,-0.00874378,-0.163187,0.0396261,-0.555964,0.431535,0.274845,0.0190857,0.0335904,-0.0566779,0.020034,0.0510602,0.164039,0.234242,0.732431,-0.184285,0.456665,-0.255485,0.00906997,0.14161,0.296406,0.455547,0.0168895,0.0394351,0.0454063,-0.0351621,-0.0816602,-0.104144,0.347213,-0.0112584,-0.144043,-0.0809617,-0.0804595,-0.0891528,0.186224,-0.563377,-0.0235751,-0.315906,0.263226,-0.0171595,-0.190728,-0.153317,0.281947,0.500593,-0.027319,0.110398,0.151153,-0.41589,0.486749,-0.264954,-0.40869,0.245312,0.421345,0.0500562,-0.642192,-0.638837,0.636235,-0.0557188,-0.824931,-0.434534,-0.133132,-0.354677,0.507991,-0.151458,0.134432,-0.293421,0.223725,0.348203,0.268741,0.553592,0.415398,-0.247767,0.381227,0.370948,-0.209764,0.285375,0.429564,0.815071,-0.410665,-0.213122,-0.166617,0.482661,0.0985543,-0.124576,0.0610467,0.109326,0.310286,-0.0892662,0.0519962,-0.286879,0.245916,-0.00829422,-0.1149,0.065178,0.812693,0.266231,0.250586,-0.00573771,0.00853371,0.245883,-0.619115,0.41211,0.0605337,0.312254,-0.243783,0.0419077,0.0473853,-0.466124,-0.5965,0.311738,0.0577398,-0.0471774,-0.354873,-0.0324294,-0.0992633,0.424704,0.0660917,0.322391,-0.0756007,0.466405,-0.0288988,-0.528182,0.547844,0.151008,-0.194311,0.246553,0.0183793,0.0363102,-0.160297,0.00182044,0.457031,-0.00521454,0.674605,0.0887588,-0.383029,0.231358,-0.307562,0.552776,-0.177371,-0.394332,0.57086,-0.212348,0.171993,-0.0901245,0.315498,0.299315,-0.314446,-0.237147,-0.0759124,-0.133505,0.487619,0.285806,0.397267,0.818081,0.29713,0.241032,0.17351,0.513661,0.0350095,0.0408361,0.525772,0.53883,-0.407291,-0.182606,0.151647,0.27544,-0.512764,-0.0630557,-0.458293,-0.131248,0.175252,-0.233972,-0.0277788,-0.523542,0.341121,0.257989,0.312883,0.453089,0.0245033,-0.109824,-0.0382874,-0.380745,-0.182449,-0.313249,-0.166012,0.135861,-0.502965,-0.360936,0.313965,-0.52356,-0.674566,0.479946,-0.224387,0.19653,0.103441,-0.348219,-0.816726,0.260551,-0.0754052,-0.0722439,0.539794,0.274114,0.129076,0.307702,0.842056,-0.0133755,0.16453,0.0061629,-0.111287,-0.335847,-0.903739,-0.316289,-0.0972302,0.0968481,0.0959996,0.0947215,0.116097,0.213644,0.340731,0.462216,-1.5442 +3423.82,0.974746,0.0848144,4,1.50875,0.867338,-1.16565,0.456125,0.520608,-0.0843227,0.26399,0.251344,0.291602,0.107173,0.152016,0.266286,0.115097,0.35309,0.103639,0.781135,0.12679,0.0532206,0.297053,0.0911702,0.129774,-0.841877,-0.267183,0.0176905,-0.241562,-0.0373653,0.259004,0.655851,-0.129515,0.202959,0.905702,-0.220602,0.253665,0.0953045,-0.421366,0.16374,-0.119977,0.488391,0.616923,0.0232224,0.592508,0.846368,0.562094,-0.699542,-0.18666,-0.287319,-0.298892,0.713122,0.354772,-0.417599,-0.156321,0.726815,0.0840067,-0.49133,0.440479,0.294782,-0.213774,-0.417525,0.210283,-0.409939,0.246272,0.955318,-0.237482,-1.35677,0.442376,0.289151,0.0491695,0.314272,-0.483,-0.383195,-0.186502,0.0987925,0.427158,-0.263834,0.397846,0.0671048,0.284035,-0.250591,-0.0422806,0.234463,0.298877,-0.232896,0.657903,-0.0196528,-0.663914,-0.121526,-0.0386671,-0.358644,0.221246,-0.447911,-0.127487,0.218761,0.125773,-0.138456,0.196224,-0.0877807,-0.572804,-0.124399,0.152903,0.289386,-0.0165735,-0.0619046,-0.169532,-0.060165,0.796349,-0.386798,0.301771,-0.137817,0.436728,0.981687,-0.811578,-0.29626,0.291465,0.340825,-0.0229364,0.438608,-0.551565,0.245427,0.153029,0.459449,-0.665177,-0.154042,0.0232523,-0.490069,0.177795,0.360746,0.127508,-0.398231,0.0233317,-0.0832569,-0.193992,0.0343273,0.217345,0.191281,-0.154308,-0.607034,-0.206237,-0.328267,0.387823,-1.1375,-0.711329,0.0634574,0.170729,-1.06179,0.102865,0.432443,-0.458378,0.359921,-0.29161,-1.04782,-0.251475,0.225072,0.493167,-0.269518,0.122362,0.0039996,0.514234,-0.109393,0.297781,-0.25605,0.247831,0.19396,0.743712,0.054776,-0.295873,-0.266655,-0.225401,0.208993,-0.292989,0.0858741,0.0477442,0.396392,-0.00345481,0.041232,0.496622,0.338419,-0.290314,-0.062087,0.195657,0.704674,0.359872,-0.108268,0.248261,-0.481454,-0.303211,-0.0664761,-0.206995,0.0385981,0.0557038,0.220713,0.500922,-0.0165714,-0.127371,-0.578624,-0.146035,-0.0971548,-0.000362859,-0.303019,-0.725775,-0.044947,0.212244,0.0795917,-0.244849,-0.128569,-0.271674,-0.367805,-0.279811,0.884661,0.200951,0.200296,0.192433,0.35816,-0.0164003,0.588234,-0.0755104,0.796055,-0.143837,0.298527,0.424183,-0.343578,0.50171,-0.473301,0.155294,-0.30661,-0.810885,0.668342,0.132362,0.0646641,0.0214636,0.0325229,-0.28778,0.317509,-0.386724,-0.0947395,-0.213137,0.76717,0.110147,0.681647,0.750197,0.0942203,-0.59751,0.143341,-0.516463,0.0689479,0.102262,-0.197485,0.303857,-0.0730982,-0.659333,-0.015928,-0.412017,-0.383474,0.159942,-0.0562765,-0.0955896,0.0976438,-0.547458,0.0657907,0.301043,0.702839,0.132841,0.324698,0.504333,0.380042,0.322787,-0.0864009,-0.0793209,-0.701101,-0.79203,0.166194,0.321721,-0.375865,0.0292577,0.064361,0.147822,-0.0754429,0.363461,-0.124698,0.175227,0.16532,-0.0996434,-0.212253,0.139334,0.431898,0.259065,0.333421,-0.552625,0.771002,0.231861,0.328498,0.0180054,0.368544,0.548061,0.074965,0.705942,-0.168107,-0.3859,-0.251056,-0.378126,-0.862563,0.376291,0.134372,0.255729,0.366568,0.505697,-1.552 +3421.48,0.959687,0.0848144,4,1.39174,0.920143,-1.4011,0.472552,0.712661,-0.0674656,0.399379,0.338203,0.678554,0.789691,0.222972,-0.0561684,0.362426,0.0609651,0.00379406,0.805353,0.414559,-0.0537803,0.0368046,0.203054,-0.308496,-0.660527,-0.384074,-0.116554,-0.2141,0.0118817,0.0010743,0.189275,-0.515042,-0.144085,0.920118,-0.137454,-0.0311023,0.0356982,-0.226766,0.131349,-0.430712,0.877483,0.572064,-0.0625798,0.719731,0.855124,0.818538,-0.72055,-0.166217,-0.0803444,-0.280865,0.40183,0.185572,-0.115855,-0.0850168,0.780409,0.298631,-0.00603731,0.542816,0.180515,-0.39483,-0.415657,0.107752,0.201791,0.045268,1.05248,-0.0700885,-0.832789,0.584324,0.481792,-0.140322,0.333495,-0.66103,-0.259217,-0.256802,-0.405037,0.702885,-0.0818639,1.06176,0.334244,0.219655,-0.103299,-0.43363,-0.163809,0.276607,0.274184,0.447774,-0.136032,0.140801,-0.342944,0.187625,-0.431853,0.0262342,-0.888233,0.206941,0.540932,0.25449,0.162744,0.137218,-0.0576611,-0.91708,-0.296803,0.360709,0.319943,0.131223,0.0331708,-0.281991,-0.0604134,0.311402,-0.412776,0.497901,0.0691832,0.350958,0.870317,-0.0878856,0.481384,0.192298,0.663709,-0.156028,0.549328,-0.37274,0.291134,0.293469,0.418665,-0.645159,-0.12866,0.0744037,-0.528637,-0.0122439,0.460738,0.0959247,0.233979,-0.0970692,-0.325938,-0.28859,-0.0301512,0.243034,0.79304,0.0571799,-0.367017,-0.033801,-0.387104,0.431661,-1.13022,-0.588964,0.0300966,-0.0717665,-0.858439,-0.0555406,-0.294402,-0.422311,0.482347,-0.165345,-1.12921,0.107443,0.639052,0.376652,0.0165031,0.633409,0.686036,0.354223,-0.107431,0.415467,-0.0701972,0.0510725,-0.124123,0.980571,0.110564,-0.514549,-0.120703,0.0482967,0.352841,-0.126031,0.0497952,0.355403,0.885171,-0.0550518,-0.279934,0.207982,-0.341218,-0.26637,0.144044,0.00950865,0.661829,0.230687,-0.326153,0.567483,-0.286479,-0.21649,-0.523513,0.10419,-0.330002,0.0179002,-0.089182,0.203701,-0.0830537,-0.24867,-0.628371,-0.0379453,-0.00552672,-0.00215818,-0.155768,-0.677605,-0.0425193,-0.0461466,0.227455,-0.140711,-0.294817,-0.565962,0.240754,-0.366222,0.701802,0.0767756,-0.195806,0.0886123,0.268711,0.270498,0.394815,-0.0645755,0.227769,-0.300226,0.333195,0.322804,-0.678821,0.542131,-0.343706,-0.178792,0.290694,-0.366179,0.771173,0.187355,-0.162965,-0.1575,-0.364805,-0.149319,0.0154394,-0.141983,0.358776,-0.65535,0.723966,0.0264454,0.921057,0.785502,0.0947529,-0.262925,0.133657,-0.196666,0.0902206,0.297666,-0.446715,0.424607,-0.195473,-0.47671,-0.237969,-0.525278,-0.123532,0.0963351,0.43266,-0.0537337,0.231209,0.177187,0.157019,0.00324502,0.278753,0.194164,0.371583,0.0674851,0.158113,0.312542,-0.152299,0.103468,0.0706474,-0.395205,0.162612,0.323536,-0.648119,-0.0373261,0.284196,0.331871,-0.121637,0.53849,0.0309303,-0.223246,0.190809,-0.070713,-0.285573,-0.294105,0.262685,0.0475847,0.444826,0.0422483,0.734442,0.126881,-0.236929,0.275758,0.126654,0.400954,0.255689,0.395509,-0.119354,-0.358258,0.20457,0.290107,-0.94493,-0.483412,0.150853,0.199506,0.388398,0.446661,-2.29603 +3418.03,0.978113,0.0848144,5,1.57652,0.91113,-0.714887,0.414691,0.308496,-0.147375,-0.0358276,0.153887,0.052464,0.553992,0.129548,-0.560697,-0.281778,0.406625,0.118231,1.35757,0.304105,0.180087,0.189347,-0.146336,-0.0505703,-0.816014,-0.878842,0.520755,0.297624,0.285649,0.329716,0.386331,0.0232772,-0.0761591,0.716253,-0.17065,0.00556435,0.470778,-0.21658,-0.270636,-0.583419,-0.254387,0.209179,-0.521571,1.18939,0.262171,-0.111331,-0.697722,-0.27636,0.212136,-0.429888,0.322931,-0.093857,0.0961217,-0.0887843,0.0013239,-0.113456,-0.450235,0.348146,-0.334005,0.195489,-0.744235,0.264354,-0.35065,0.323719,0.578451,-0.796472,-0.359907,-0.385746,0.00241205,0.268927,-0.413074,0.620705,-0.490909,0.212011,0.799364,0.700894,-0.0561479,0.375594,0.528886,0.264789,-0.185137,0.189079,0.242464,0.489534,-0.767566,-0.0888173,-0.218578,-0.244512,0.170248,-0.149495,0.226074,0.029469,0.187774,-0.191949,-0.609168,-0.0760024,-0.0950697,-0.108167,-0.444011,1.10902,-0.113142,-0.355454,-0.240045,0.122648,-0.0601792,-0.353159,-0.394244,0.00639578,-0.361432,0.205636,-0.170501,0.276845,0.247776,0.178193,-0.660293,0.126779,0.358824,0.361058,-0.256807,-0.420769,-0.341104,0.211167,-0.433115,-0.456531,-0.107268,-0.457447,0.222331,0.0448901,-0.0981691,0.294294,-0.24849,0.372443,-0.258362,0.295605,0.0600406,-0.351073,0.532142,-0.472686,0.165396,-0.203091,0.468604,0.337366,0.117395,0.163358,-0.073089,0.0767722,-0.0387401,0.0722547,0.520162,0.301692,-0.0866285,0.173127,0.895856,-0.7012,-0.20631,0.00146944,-0.0735189,-0.313077,0.198514,-0.132616,-0.0901838,-0.594299,0.109069,0.210624,0.0537357,0.305488,-0.0234016,0.151815,0.439446,0.251566,-0.44415,-0.0872369,0.0969611,-0.0839762,-0.746741,-0.307054,0.366153,-0.289437,-0.0969181,-0.39476,-0.201255,0.507594,1.05849,-0.237586,0.0742856,-0.264742,0.33212,0.26863,0.0325276,-0.806336,-0.214222,0.23189,-0.702395,0.118748,0.059043,0.364439,-0.616996,0.137457,0.112788,0.442228,-0.302616,-0.399848,0.254413,-0.102988,-0.74406,0.429947,0.126553,0.547801,-0.324474,-0.441755,1.10502,-0.0916908,0.385096,0.0376238,-0.458945,-0.0510591,-0.332937,-0.0562601,0.177479,-0.261382,-0.475413,0.352829,0.13682,-0.55776,-0.488395,-0.00648148,-0.292133,-0.0842559,0.403713,-0.631176,-0.156419,0.457968,0.479622,-0.039104,-0.247796,-0.116173,-0.525918,-0.159596,-0.061225,0.0800017,-0.709303,0.492734,-0.612344,-0.0224834,-0.217062,0.547374,-0.121894,0.441209,0.380895,0.558543,0.65886,0.214378,0.119294,0.536149,-0.586662,0.649238,-0.741889,-0.346579,0.728386,-0.529915,0.0304785,0.502811,0.0409316,0.0306801,0.406461,0.197073,0.253203,0.124443,0.552646,0.179344,-0.209263,0.311237,0.255922,-0.387675,0.305403,-0.405208,0.0865551,-0.18134,0.145422,-0.455661,0.332455,0.544922,0.0300359,-0.195886,0.08583,-0.328173,0.0243819,0.677983,0.176817,-0.0197887,-0.0676169,0.215648,0.0294944,0.0953001,0.197602,-0.0533918,-0.142888,-0.561807,-0.444417,0.470878,0.208559,-0.47612,0.615669,0.501788,0.156289,0.201775,0.395334,0.449193,-1.03928 +3415.73,0.75199,0.0848144,5,1.53524,0.997094,-0.660576,0.319005,0.123614,-0.188519,0.199385,0.266609,-0.178253,0.530697,-0.114616,-0.0414538,-0.369844,0.70594,-0.00386703,0.639124,0.423292,-0.0711284,0.118259,-0.442195,-0.175273,-1.15131,-1.10161,0.16148,0.312488,0.103618,0.166485,0.319091,-0.499379,0.155107,0.618149,0.371711,0.355548,0.325765,-0.681554,0.0129399,-0.295467,-0.0611418,0.8294,-0.021486,1.22964,0.262274,-0.339831,-1.15069,-0.0572195,0.470566,-0.388349,0.395564,0.0935129,-0.190388,0.218996,0.37215,-0.151554,-1.37568,0.318507,-0.411974,-0.255729,-0.379941,0.31386,-0.564361,0.131039,0.487649,-1.02195,-0.120546,-0.482213,0.368696,0.0295742,-0.0744263,0.177253,-0.189782,0.318108,0.92797,0.202127,0.156717,0.491583,0.202586,0.283592,-0.0675961,-0.15488,0.26152,0.302018,0.0174791,0.265311,-0.0264724,0.126163,0.0010372,0.0698497,0.186321,0.480616,-0.184874,-0.102403,-0.281603,0.146124,0.0552053,-0.544099,-0.399503,0.84904,-0.384121,-0.469442,0.0167577,0.364795,0.0626576,-0.231521,0.284574,0.255551,-0.73808,-0.0562286,-0.0753477,0.278415,0.199121,-0.100313,0.0854949,0.285562,0.176424,0.443101,-0.303879,-0.128265,0.197585,0.112056,-0.0230798,-0.22899,0.0862789,0.1845,0.11627,0.267246,0.262635,-0.124351,-0.479866,0.375495,-0.677597,0.537627,-0.0501476,-0.34792,0.812116,-0.237656,-0.0799036,0.00811492,0.239879,0.28167,-0.102332,0.0631641,-0.106998,0.17279,-0.0714712,0.228954,0.4236,0.36254,0.440543,-0.116426,0.150783,-0.553518,0.121494,-0.122709,-0.116216,-0.274955,0.0990108,0.252877,0.151591,-0.22909,0.528688,0.19564,-0.362618,0.394927,0.200177,0.516464,0.0777621,0.325774,-0.47083,0.164931,0.109051,0.187547,-0.703102,-0.02289,0.190521,-0.251952,0.171463,-0.165614,-0.565663,0.257734,0.732987,0.323122,0.242727,-0.293021,0.478181,-0.464367,-0.288259,-0.103716,-0.562608,0.236479,-0.808249,-0.0071747,-0.236479,-0.448048,-0.743243,0.31338,0.334957,0.25688,-0.423102,-0.135553,0.195407,-0.0811248,-0.137885,0.157006,0.0264007,0.0512793,-0.130327,-0.611529,1.12828,0.580454,0.382437,-0.279476,-0.0134364,0.29481,0.134942,0.0183413,0.168372,0.260868,-0.199609,0.739095,0.31084,-0.158382,-0.449349,-0.438207,-0.241251,-0.277339,0.455601,-0.873949,-0.634713,0.536791,0.0373443,0.155903,0.0561577,-0.201529,-0.430273,-0.675286,0.291644,-0.423199,-0.361006,0.486257,-0.424475,-0.301833,0.347552,0.146003,-0.878594,0.351546,0.509416,0.814599,0.0574867,-0.0521727,-0.2585,0.0858198,-0.851575,0.312431,-0.189396,0.149397,0.46084,-0.430412,-0.27186,0.685133,0.0552631,-0.2164,-0.00314427,0.193092,0.373577,0.512296,0.32662,0.426163,0.152717,0.0121519,-0.0485753,-0.158274,-0.233836,-0.775998,0.320323,-0.213556,-0.0982158,-0.321803,0.587314,0.451196,0.051406,-0.355167,-0.181815,-0.664133,0.309512,0.148204,0.158522,-0.0689079,0.124797,0.285206,-0.0408917,-0.14839,0.346742,0.200314,0.433572,-0.0550256,-0.586635,-0.00691971,0.316726,-0.432434,0.284275,0.0215796,0.114899,0.215453,0.338968,0.46417,-0.546277 +3406.59,0.970097,0.0848144,4,1.58109,1.00824,-0.914887,0.369156,0.239564,-0.0977102,-0.273626,0.303927,-0.0287777,0.6408,-0.21839,-0.293532,0.0776862,0.422319,-0.202732,1.4494,0.156201,0.334428,-0.180525,0.0404562,-0.186424,-0.379817,-0.601069,0.116954,-0.167391,-0.368586,0.171808,0.315315,-0.779557,-0.161175,0.577302,-0.487859,0.542154,0.536152,-0.309026,-0.337477,0.191073,0.374881,0.252829,-0.141903,1.05987,0.298686,-0.141177,-0.559597,-0.391249,0.0215449,0.0428791,0.418494,0.120595,-0.15178,-0.0169546,-0.41321,-0.097579,-0.897918,0.280951,-0.347797,-0.194825,-0.81948,0.117509,0.216471,0.180947,0.764343,-0.946485,-0.417792,0.658696,-0.426747,-0.0267656,0.201263,-0.142311,-0.24653,-0.0907497,0.362624,0.479331,0.265752,0.297917,0.485261,0.164525,0.315057,0.0117825,-0.325554,0.233293,0.00474575,-0.00658519,-0.649858,0.138076,-0.437785,0.259326,0.337856,0.409905,0.046767,0.011827,0.443305,-0.725182,-0.0163218,-0.158863,-1.1944,0.364101,-0.610426,-0.222412,-0.21504,0.372219,0.272427,-0.200354,-0.185339,0.376211,-0.468155,-0.187756,-0.482504,0.391375,0.0400598,0.559589,-0.0585676,0.85853,0.472242,-0.074532,-0.00421453,-0.415441,-0.0114977,0.195615,0.258848,-0.862239,-0.135234,0.275591,0.485599,-0.172406,0.374477,0.101248,0.0137326,0.160378,-0.052818,0.899043,-0.085933,-0.21471,0.567145,0.00817648,-0.223955,0.173677,0.0793692,0.23411,-0.498075,-0.659644,0.100495,-0.267991,-0.00974403,-0.365944,0.0225411,0.00718353,0.225373,-0.259409,0.303936,-0.333435,0.10847,-0.254766,-0.138532,-0.326781,0.293663,0.101952,-0.125815,-0.283985,0.141931,0.33577,0.293669,0.368957,-0.447894,-0.205242,-0.107801,0.163557,0.176517,-0.0112578,-0.278696,0.0425545,-0.527341,-0.0374156,0.125109,-0.22231,-0.0946598,-0.326849,0.183033,0.125751,0.680529,-0.385164,-0.183101,-0.331464,0.211348,0.071141,-0.668337,0.259428,-0.173821,0.126196,-0.313923,-0.471206,0.167315,-0.125045,-0.41218,-0.0353714,0.102175,0.0765697,-0.242307,-0.652268,-0.359402,0.0486159,0.438646,0.434547,0.0841418,0.595538,0.270303,-0.181273,1.16794,0.253114,0.124248,-0.606679,-0.219682,0.289566,-0.450667,-0.243077,0.0951321,-0.241938,0.0827679,-0.108101,-0.271472,-0.0367142,-0.7972,0.322521,0.0860722,0.497547,0.333846,-0.479577,-0.51829,0.0550634,0.148102,0.454072,-0.251319,-0.164761,-0.563307,-0.677244,0.298435,0.286739,0.0611645,1.08696,-0.0538672,-0.195256,0.198321,-0.338362,-0.0661026,0.199742,0.0117338,0.468059,-0.188243,0.10739,-0.536731,0.364873,-0.434695,-0.143304,-0.0197732,-0.279918,0.422569,-0.339789,0.148408,0.601893,0.0364004,-0.0338106,0.290547,0.1989,0.439559,0.102645,0.378126,-0.0202905,-0.179974,-0.159322,-0.0316322,-0.0433128,-0.0256907,-0.154729,0.00785291,0.10258,-0.0889691,-0.022994,0.162479,0.161389,-0.0633362,-0.256468,-0.0287768,-0.849087,0.0435279,0.375544,0.645976,-0.174442,-0.302255,0.326226,0.199347,0.226196,0.410256,0.212052,0.188385,-0.206202,-0.425993,-0.285354,0.189167,-0.644578,-0.281771,-0.363668,0.136396,0.327103,0.369318,0.571929,-0.841702 +3447.68,0.563506,0.0848144,4,1.56947,1.12512,-0.90721,0.360352,0.622919,-0.0627555,0.0278051,0.241689,0.07698,0.413869,-0.147971,0.0684905,-0.229863,0.499326,-0.120539,1.32456,0.129557,-0.0782559,-0.485391,-0.316311,-0.102897,-0.816506,-0.425171,0.015225,0.188316,-0.291997,0.218517,0.395676,-0.175216,-0.011643,0.729443,-0.498837,0.295403,0.424339,-0.3296,-0.521246,0.668775,0.463113,0.362902,-0.16028,0.991253,0.362525,0.130415,-0.965718,-0.174949,-0.477087,0.0734727,0.109695,0.0697147,-0.107453,0.193819,-0.208124,0.00670379,-0.972918,0.116214,-0.627565,-0.121928,-0.812102,0.309606,-0.263587,0.22163,0.511132,-0.721798,-0.263582,0.434232,0.00334129,0.337523,-0.0975455,-0.193824,-0.0511178,-0.0728692,0.129779,0.404631,0.181351,0.38985,0.182565,0.482955,0.411553,0.0775095,-0.218835,0.228124,0.0702185,-0.310135,-0.550307,0.258254,-0.216445,0.0336635,0.0849928,0.288047,-0.288872,0.0696791,0.285962,-0.407378,0.147996,0.140414,-0.805095,0.152365,-0.195778,-0.0367511,-0.289277,0.541942,0.361216,-0.261409,-0.00406164,0.43388,-0.954384,0.128834,-0.189619,0.27725,0.149886,0.00954058,0.11352,0.156833,0.378982,0.452362,-0.00531778,0.0214022,-0.00539353,0.0421171,0.0353719,-0.527513,0.0819387,0.0801404,0.462881,-0.157773,0.206219,0.0254154,-0.107003,0.072461,0.00359532,0.530508,-0.0731595,-0.324805,0.3545,0.0437312,-0.233957,0.10074,0.0606296,0.413978,-0.734376,-0.265948,-0.142825,-0.158603,-0.128807,-0.471857,-0.130459,-0.0993863,0.112809,-0.116358,-0.147831,-0.145262,-0.167163,-0.0524384,0.049112,-0.12625,0.050774,-0.0925365,-0.465272,-0.172121,0.0537427,0.113713,0.247366,0.568445,-0.0312556,-0.169215,-0.114939,0.0724977,0.107972,0.0965929,-0.27139,0.225883,-0.559423,-0.0957231,-0.0930747,-0.140842,-0.420036,-0.667703,0.492101,0.357911,0.883249,-0.274909,-0.481949,-0.105555,0.0374094,0.112465,-0.574726,0.140016,-0.0719125,0.185251,-0.100803,-0.394094,-0.195512,-0.206664,-0.726611,0.247261,0.428011,0.0820221,-0.545685,-0.748524,-0.465998,0.0107385,-0.135161,0.202236,0.229109,0.413718,-0.102914,-0.263238,0.783322,0.0741894,0.283001,-0.525237,-0.505945,0.310379,-0.0939444,-0.417613,0.0299896,-0.121331,0.00358952,0.137902,-0.237837,-0.239057,-0.727423,0.250845,-0.0444698,0.000241238,0.304866,-0.676597,-0.536159,-0.20495,0.0294047,0.937643,-0.0586518,-0.382458,-0.342943,-0.500054,0.474304,0.217801,-0.296484,0.836968,-0.329895,-0.427754,0.270552,-0.329035,-0.0174567,0.157855,-0.109687,0.330133,0.0331622,-0.226258,-0.637167,-0.0143401,-0.293161,0.419399,-0.395714,-0.0287295,0.476194,-0.202057,0.227804,0.44576,0.0934924,0.0808728,0.328414,0.338698,0.387073,0.0979316,0.578816,0.0321018,-0.417949,-0.0536941,-0.15823,-0.144349,-0.0125354,-0.475449,0.0597207,-0.0584281,-0.227589,0.388469,0.407423,0.00499267,0.134887,-0.102822,0.148211,-0.746424,0.0985453,0.190114,0.341534,-0.156062,-0.445408,-0.260308,-0.0222702,0.250772,0.10602,-0.199887,0.36579,-0.0275187,-0.510585,-0.155203,0.4711,-0.37634,-0.335356,-0.23634,0.110851,0.17702,0.332942,0.420738,-2.33704 +3464.87,0.998957,0.0848144,4,1.63537,0.907432,-0.748452,0.229246,0.374071,-0.229717,0.397563,0.172798,0.419391,0.0847092,-0.0548196,-0.207273,0.103821,0.275014,-0.00930186,0.504334,0.194272,-0.0121179,0.0638335,-0.20427,-0.370602,-0.864769,-0.663818,0.0297571,-0.15883,-0.153106,-0.0772398,0.0665357,-0.0184543,-0.512894,0.732605,-0.270095,0.0266313,0.275362,-0.310699,-0.200716,-0.0594168,0.75088,0.0792699,-0.345654,0.978862,0.460583,-0.249219,-0.752958,-0.0536574,0.44243,0.273567,0.347181,0.373453,-0.123797,0.118445,0.493625,-0.0471015,0.12886,0.691483,-0.16165,-0.311403,-0.493697,0.692685,-0.794017,0.137274,0.917066,-0.432976,-0.429582,0.206025,0.403228,-0.0657486,0.231955,-0.0999019,-0.227866,0.0395908,0.381379,0.5195,0.181589,0.391665,0.296404,0.374097,0.150013,-0.0162503,-0.113592,0.129415,-0.39269,0.396281,-0.545128,0.11276,0.0710257,-0.0401076,-0.0636618,0.464325,-0.226967,0.100247,0.028918,0.214705,0.00524298,0.29442,-0.460296,-0.00123503,-0.309526,0.348129,0.33348,-0.320379,0.627692,-0.0507526,-0.151499,0.0786443,-0.158024,0.276558,-0.139918,0.300989,-0.0459234,0.201621,-0.0558819,-0.0771782,0.300665,-0.258019,0.353627,0.0819,-0.198188,0.347322,-0.0162117,-0.650276,-0.153403,0.162938,-0.243126,-0.207401,0.296987,0.757125,-0.330264,0.129811,-0.176738,0.186456,-0.181042,-0.085975,0.346128,-0.14739,-0.22734,-0.0557881,-0.0294966,0.26954,0.119884,-0.94049,0.223898,-0.0127548,0.459617,0.085789,0.46241,0.00925272,0.64202,-0.20012,-0.369874,-0.331385,0.0605152,0.0336404,0.293568,0.193275,0.537211,0.753528,0.253944,-0.0405318,0.113272,0.0218274,0.363265,0.559713,0.163506,-0.694899,-0.336716,0.182817,-0.320828,-0.179481,0.234016,-0.0408662,0.106132,-0.0247674,-0.220673,-0.0904069,-0.338993,-0.312394,-0.0594587,-0.00721264,0.861625,-0.120468,0.00207681,0.20447,0.0843301,-0.617777,-0.242619,0.0030561,-0.357357,-0.175186,-0.405405,0.0127309,0.174654,0.35727,-0.885952,-0.145096,-0.0312977,0.281535,-0.330612,-0.452047,0.49978,0.347326,-0.623905,0.212008,0.0128959,-0.215444,0.330415,-0.362261,0.903947,0.578011,-0.07261,0.0836963,-0.126057,0.336048,-0.246053,0.0295652,0.183574,0.0178782,0.287814,0.261576,0.209691,0.288218,-0.130742,-0.0113539,-0.114829,-0.217763,0.367713,0.421747,0.0802119,-0.132641,0.148333,-0.0429965,0.0412141,-0.162941,-0.334365,-0.197019,-0.127004,0.33827,0.384552,0.336718,-0.259768,-0.21466,-0.229761,0.2555,0.245433,-0.0465746,0.292484,0.450635,-0.22793,-0.117532,-0.478616,0.00419117,-0.577117,0.242499,-0.113557,-0.462683,0.426654,-0.575354,0.0475296,-0.256271,0.215743,0.32217,-0.283494,0.158843,0.102087,0.461322,0.327023,0.0672305,0.0762403,0.0673994,-0.0817161,-0.0267841,0.092164,-0.266866,-0.416275,0.214119,-0.232863,-0.207835,-0.117997,-0.132422,0.293097,0.0640581,0.227491,-0.269116,-0.113259,0.228855,0.392758,-0.213003,0.267804,0.267539,-0.565666,-0.140754,0.156559,-0.206522,0.00999434,-0.313748,-0.102692,0.139532,-0.183192,-0.351877,-0.546998,-0.155629,0.0850177,0.185882,0.291578,0.43114,-0.977492 +3459.67,0.960601,0.0848144,4,1.58905,1.04534,-0.765158,0.253241,0.275804,-0.0928439,0.223984,-0.134293,-0.0289817,0.0620699,-0.184402,-0.0312047,-0.0735707,0.504311,0.112612,0.578815,0.0569898,-0.177392,0.00556856,0.00460257,-0.203029,-0.716643,-0.847443,-0.422543,0.227483,-0.479758,-0.00052897,-0.0690009,-0.466119,-0.370472,0.503166,-0.247307,-0.0699425,0.147483,-0.488995,-0.284916,-0.0469628,0.365719,-0.127806,-0.0793489,0.691512,0.678761,-0.353166,-1.13636,-0.335143,0.168112,0.249131,0.698732,0.204706,-0.065296,-0.0703363,0.112201,0.136934,-0.073378,0.585152,-0.0888461,-0.284857,-0.608172,0.449676,-0.7003,0.0122813,0.780706,-0.80995,-0.508429,-0.216756,0.410409,-0.0930969,0.236706,-0.155552,-0.229264,-0.277985,0.664883,0.421821,0.093823,0.495749,0.38912,0.390662,0.610111,-0.242508,0.0846814,0.493941,-0.248147,0.436043,-0.1249,-0.00334185,-0.31696,0.189771,-0.318168,0.308479,-0.187681,0.277759,0.356202,-0.322715,-0.0724847,0.490788,-0.198435,0.206896,-0.328408,0.111464,0.493424,-0.178309,0.279109,0.0271956,-0.188412,-0.00616088,-0.373827,-0.0922681,-0.177784,0.193912,0.314984,-0.0305273,-0.071222,-0.167299,0.143377,0.23091,0.363819,0.109823,-0.426721,0.120121,0.100442,-0.461401,-0.300502,0.401489,-0.166785,-0.204556,0.0953208,0.586096,-0.000885692,0.571185,-0.281274,-0.0661888,-0.482144,-0.257501,0.481049,-0.273683,-0.11313,-0.0718821,-0.0202064,0.3318,0.344152,-0.589379,0.161119,-0.0920841,-0.0769477,0.291071,0.38108,-0.0787819,0.386389,-0.120837,-0.156537,-0.223932,0.137061,0.334924,-0.0664995,0.233611,0.465449,0.348901,0.200086,0.330128,0.169368,0.0965863,0.0391952,0.135947,-0.202477,-0.427916,-0.250489,-0.199352,-0.232731,-0.204711,-0.0173321,-0.112204,-0.476362,-0.0688172,0.237605,-0.209045,-0.190256,-0.205307,0.0808719,0.0498167,0.644905,0.088717,0.0735572,0.0831198,-0.14768,0.148259,-0.240358,0.28511,-0.182821,0.0163193,-0.357935,0.0489988,0.0812029,-0.0537025,-0.818532,0.329536,-0.270664,0.107946,-0.366097,-0.383522,0.364567,0.190742,-0.126127,0.183493,0.145354,-0.282065,-0.0763155,0.0415926,0.97983,0.747439,-0.149166,-0.0507479,0.153096,0.337773,-0.685797,0.139303,0.0800223,0.21355,0.0607153,-0.417375,0.574312,0.260279,-0.0612303,0.264607,-0.022883,-0.18179,0.318992,0.468465,-0.0580298,0.0626062,0.100769,0.103827,-0.084303,-0.120257,-0.425968,0.455584,-0.0285018,-0.113157,0.173244,0.419199,0.0671627,-0.060875,-0.179521,0.093314,0.441786,-0.0610261,-0.0826664,0.314181,-0.0910611,-0.106456,-0.527784,-0.203571,-0.519754,0.312804,0.00734482,-0.383947,-0.0890226,-0.732673,0.0201137,-0.0485291,0.229494,0.426263,0.348329,0.0145665,-0.104783,0.170901,0.171257,0.101045,0.217409,-0.0423322,-0.0893426,-0.326772,-0.183593,-0.50379,-0.241263,-0.00250211,-0.232904,-0.268333,0.0965716,-0.109712,0.217296,-0.0478742,-0.256057,-0.381594,-0.107569,0.289171,-0.0517486,-0.0965922,-0.0458275,0.0442453,-0.415034,0.0552614,-0.217002,-0.138298,-0.306032,0.00575557,0.0660898,0.115154,0.272245,-0.0434334,-0.095735,0.317484,0.0893457,0.177597,0.298908,0.421423,-0.989605 +3474.06,0.662851,0.0848144,4,1.69425,0.995642,-0.907189,0.265562,0.279687,-0.0953136,-0.142216,0.119346,0.340439,-0.135407,-0.415391,-0.193901,-0.580512,0.297537,0.123323,0.754992,0.0372993,-0.554638,-0.110129,-0.24008,-0.43082,-1.13434,-0.573734,-0.0374255,-0.0908624,-0.300063,0.232072,0.619949,0.0450452,-0.365922,0.440852,-0.514163,0.184991,0.0211836,-0.713067,-0.181379,0.0707267,0.0398351,-0.021361,0.0755035,0.801358,0.541496,-0.00146587,-0.758422,-0.205419,-0.119509,0.0513425,0.20719,0.128653,-0.268362,0.0497908,-0.203584,0.105814,-0.204821,0.436404,-0.0387524,-0.021902,-0.671448,0.420596,-0.339286,0.271162,1.14332,-0.498294,-1.05067,0.194799,0.575795,-4.17948e-05,0.305502,-0.0362403,-0.599177,-0.041676,0.529777,0.386913,-0.313944,0.123316,0.181192,0.26407,0.498709,-0.0896521,0.0860559,0.218945,0.11245,0.232834,-0.667836,0.176308,-0.192688,-0.183013,-0.297722,-0.022994,0.145324,0.317622,0.115204,-0.16506,-0.118381,-0.13686,-0.162895,0.202175,-0.0144343,0.20945,0.363031,0.0487046,0.0983966,-0.122247,-0.244252,-0.129731,0.0775105,0.122794,-0.0517441,0.358936,0.448415,0.0665067,0.327781,0.11407,0.233905,-0.0977651,-0.0712378,0.0860866,-0.148005,0.000268254,0.086491,-0.630652,0.0601578,0.276816,-0.217285,-0.431554,0.572054,-0.0460807,0.281708,0.259406,-0.376107,0.327641,-0.263662,-0.0500478,0.0745914,-0.129459,-0.162258,-0.056614,-0.263667,0.271707,0.0715543,-0.57351,0.25374,0.295582,-0.286322,0.394713,0.321702,-0.262483,0.343853,0.112503,-0.258852,0.0712692,-0.147387,0.541033,-0.115829,0.49364,0.333773,0.301488,-0.322422,0.23812,0.249546,0.122775,-0.313358,0.0698452,0.180707,0.154967,-0.261245,-0.172073,0.0125661,-0.303231,0.511658,0.245454,-0.308382,-0.0859348,0.578647,-0.31295,-0.224925,-0.0231098,0.230156,0.130128,0.559036,0.0531358,0.214407,0.40874,0.265149,0.0726071,-0.167619,-0.251532,-0.424318,-0.412251,-0.0185493,0.139809,-0.139942,-0.00346416,-0.780514,0.000772015,0.0860017,0.218667,-0.211811,-0.238364,0.262009,0.00968105,0.0403575,-0.107945,0.178289,-0.304076,-0.038809,-0.225602,0.909288,0.280172,0.162374,0.0846865,-0.0128126,0.371659,-0.18443,-0.00291368,0.295344,0.184326,0.0278452,-0.329056,-0.178761,0.15306,0.0103038,0.247721,0.196791,-0.33356,0.377418,0.0165863,-0.0507278,0.553637,0.225487,-0.268319,0.116286,-0.0835172,-0.0796337,-0.113945,0.30848,0.0507536,0.126481,0.0951641,-0.0427989,0.31153,0.17033,-0.254192,0.231771,0.172298,0.18812,0.343042,0.237894,-0.371842,-0.428602,-0.0893017,-0.609528,0.471125,0.0407632,-0.175232,0.0289477,-0.603068,-0.198626,0.00426118,-0.2501,0.187674,0.0265926,0.294427,-0.246342,0.321582,0.561244,-0.233779,0.0373457,0.303094,0.118674,0.165987,0.190406,-0.174594,0.188655,0.239523,0.0930954,0.293653,-0.0078417,0.251666,0.242941,0.117511,-0.125052,0.283049,-0.157493,0.356702,-0.282439,-0.204108,0.466441,0.356609,-0.0304632,-0.209479,-0.161055,-0.143452,0.108416,-0.153702,-0.0683025,0.138493,-0.0504454,-0.169628,-0.161812,0.348387,0.0650565,0.156737,0.255062,0.3959,-0.745865 +3494.12,0.768889,0.0848144,4,1.60221,1.02227,-0.467974,0.0755607,0.315789,-0.053559,-0.0462821,-0.0471408,0.415082,-0.0972586,-0.185207,-0.440692,-0.298029,0.316201,-0.233003,0.666183,-0.120974,-0.421305,-0.418702,-0.0924285,-0.548665,-0.895238,-0.637014,-0.0719014,-0.144234,-0.0271513,-0.0496641,0.479949,0.00403696,0.160404,0.37157,-0.605161,0.101309,0.0763967,-0.183806,-0.281714,-0.203904,0.124093,0.0685778,0.15264,0.815675,0.616384,0.265029,-0.69072,-0.0240353,-0.113572,-0.383496,0.500983,0.271515,-0.0637158,0.111132,0.0985192,0.111791,-0.294478,0.8355,-0.0923912,-0.00943452,-0.350085,0.39615,-0.873001,0.119596,0.976019,-0.618218,-0.837795,-0.11576,0.396738,-0.46718,-0.0450302,0.0971496,-0.34861,-0.17149,0.395876,0.358368,0.0602156,0.207986,0.417792,0.235856,0.145694,-0.463304,0.141204,0.267711,-0.255718,-0.121967,-0.168038,0.00876116,-0.161247,0.176282,0.128951,-0.0761637,-0.101492,-0.724059,0.120802,0.159353,0.186388,0.179361,-0.107467,-0.111478,-0.0940702,0.080232,0.317888,0.0764083,-0.0536521,-0.160098,-0.0930667,0.0855472,0.310297,-0.395811,-0.241389,0.313732,0.333901,0.435598,0.0355488,-0.307859,0.321383,-0.185592,0.190664,-0.237248,-0.150193,0.4647,-0.0688136,-0.608543,0.11228,0.146876,0.169236,0.267397,0.722727,0.183651,0.171109,0.341781,0.253182,-0.133115,-0.0649904,-0.0943911,0.137436,-0.162971,0.175046,-0.178371,-0.212653,0.444609,-0.124141,-0.142499,-0.0618716,0.270444,-0.273674,0.297304,0.104237,-0.0126362,0.321637,0.275246,-0.237287,0.0898014,-0.116029,0.206858,-0.0761707,0.191622,0.2894,0.128844,-0.0761244,0.301587,0.136988,0.157874,-0.20461,0.221925,0.268682,-0.0354709,-0.00788169,-0.0585112,-0.139697,0.277171,0.587827,0.415131,0.20494,-0.0714314,0.198272,-0.0792398,-0.611921,-0.313182,-0.244107,-0.0918211,0.317655,0.351062,-0.0769219,0.0407072,0.166437,-0.222841,0.290458,-0.167711,-0.451906,-0.0495842,-0.70012,-0.095589,0.141992,-0.000774938,-0.693187,-0.0913848,-0.270356,0.298353,-0.0716543,-0.386289,0.144323,-0.122877,-0.141412,-0.206536,-0.0204952,0.0910887,0.0282448,-0.322947,0.936268,-0.33439,-0.129421,-0.0272709,-0.31706,0.243591,-0.205329,0.239071,0.320754,-0.141573,0.153871,-0.0317981,0.278631,-0.104874,-0.496137,-0.310743,0.00907953,-0.189944,0.32852,-0.744467,-0.0577946,0.324345,-0.0431857,-0.223038,0.128898,-0.145411,0.00640627,-0.406131,0.511924,0.255397,0.187933,0.253738,-0.133294,-0.0113199,-0.0346232,0.132579,0.15427,-0.29779,0.277704,0.175955,-0.251906,0.189739,-0.383447,-0.054624,-0.151945,0.479941,0.0107293,-0.221579,0.265057,-0.362192,0.148063,-0.216977,-0.0107048,-0.0640599,0.452848,-0.0603359,-0.357059,0.198033,0.235611,0.238489,-0.153685,-0.159894,0.138747,0.255789,0.268661,-0.516812,0.278092,0.316168,-0.261994,0.16575,0.000894749,0.0995936,0.0336715,0.164112,-0.313146,-0.286315,0.0285838,0.100064,-0.0927811,-0.154966,0.148025,0.169227,-0.17671,0.062237,-0.278701,-0.475597,0.0822514,-0.0125817,-0.265001,-0.1872,-0.414392,-0.575098,-0.476761,-0.119037,0.0824957,0.180574,0.287221,0.42494,-1.06585 +3494.02,0.645862,0.0848144,4,1.63589,0.818648,-0.697909,0.201309,0.0667998,-0.112409,-0.131289,0.0655006,0.366765,-0.0385324,0.0546174,-0.324399,-0.122963,0.47924,-0.156616,1.05641,0.482891,-0.125124,0.0829547,-0.213209,-0.131303,-0.91381,-1.00117,0.265302,0.00710507,-0.453867,-0.0505884,0.0456657,-0.518075,-0.499922,0.87052,-0.560275,0.0967223,0.0749628,-0.444476,-0.0876946,-0.71282,0.168884,0.137233,-0.935187,0.744942,0.335445,0.439391,-0.44734,0.225748,-0.194502,-0.916967,0.104048,0.470717,-0.0995624,0.0905052,0.621731,-0.328734,-0.0298853,0.753576,-0.18492,-0.285278,-0.905303,0.448202,-0.0243564,-0.0307826,0.851124,-0.810288,-1.06567,-0.447324,-0.0960571,0.478966,-0.0225317,0.295951,-0.400533,0.00747545,0.22229,0.236048,0.104211,0.0632632,0.0611088,0.192813,0.133771,0.166453,-0.0395326,0.35704,0.072748,0.265228,-0.141892,-0.197105,-0.215368,-0.290973,-0.287013,0.283965,-0.387806,0.763055,-0.38122,-0.0526038,-0.342177,-0.0214543,-0.103422,0.0308282,-0.182956,0.093152,0.132658,0.0956412,-0.310341,-0.146463,-0.385848,0.00567914,0.03146,0.0987198,0.165562,0.164836,0.401192,-0.240462,0.0932704,0.338906,0.516424,0.276575,-0.302665,0.190725,0.103554,0.0638697,0.10595,-0.333436,-0.0649871,-0.22857,-0.224547,-0.409358,-0.313564,-0.0611266,0.154039,-0.114808,-0.498206,0.292799,-0.242303,-0.00309371,0.359791,-0.424742,0.133979,0.223818,-0.045264,0.0177174,-0.531197,-0.19246,0.0256115,-0.252712,-0.325199,0.0102061,-0.0432928,-0.00151801,0.0753276,-0.342534,0.212679,-0.0529601,0.240785,-0.0605031,0.0943643,0.20512,0.27162,0.56703,-0.243856,0.185821,0.0964705,-0.30246,-0.062258,0.274496,-0.188797,-0.148011,-0.0211721,0.0453753,0.189742,-0.387112,-0.212701,0.237663,-0.424744,0.0931123,-0.185665,0.0853095,0.281812,0.0407303,0.208631,-0.00696202,0.488725,-0.268301,-0.0289544,-0.057048,0.0792223,-0.433834,-0.752297,-0.074717,-0.222223,0.453777,0.250283,-0.164173,0.0985793,-0.202115,-0.418356,0.249711,0.263108,0.0251591,-0.183868,-0.215579,0.242583,-0.131466,-0.498664,-0.201032,0.449893,-0.163365,-0.132196,-0.199693,0.812238,0.16308,0.151157,0.113056,0.0723622,0.0807193,0.222774,-0.754074,0.0468814,0.154411,0.418322,-0.0921286,-0.515732,-0.08323,-0.358487,0.13448,-0.0558862,-0.442125,0.188472,-0.0273146,-0.210969,-0.175047,0.210959,0.00782955,0.103022,-0.171656,0.0432223,0.122824,0.277423,-0.0897115,0.00975666,0.577829,-0.128179,-0.146061,0.00745942,0.0483212,-0.0359315,0.565734,0.323698,0.288593,0.446066,-0.192705,-0.0193771,-0.343125,-0.40402,-0.0739617,-0.0651001,-0.208562,0.0621751,-0.0393555,-0.0794432,0.0616796,-0.0452501,0.127205,0.07502,-0.0949327,0.439621,0.0486488,0.283016,-0.352311,-0.0503879,0.105234,-0.1411,-0.351275,-0.414534,0.406758,-0.187625,-0.409495,0.0566941,0.0806211,-0.256189,0.0977594,-0.0654939,-0.522821,-0.138515,-0.103841,-0.0251617,0.12644,-0.020661,-0.0553026,-0.208317,0.0651359,-0.199247,0.0871791,0.276846,0.0919417,-0.165624,-0.333741,0.0527158,-0.151753,0.0180421,0.026007,0.130391,0.496485,0.0587167,0.236266,0.242315,0.486072,0.170679 +3489.09,0.989921,0.0848144,4,1.68501,0.826662,-0.718212,0.204925,0.190457,-0.11658,-0.171742,0.100311,0.509233,0.10148,0.181731,-0.491028,-0.130487,0.545641,-0.0393499,1.09717,0.37886,-0.231884,-0.0367145,-0.269632,-0.0960824,-0.872752,-0.887481,0.203569,0.059715,-0.517108,-0.110452,-0.0728965,-0.519533,-0.394682,0.939953,-0.543974,0.204771,0.0750513,-0.644668,-0.0430544,-0.648529,0.218897,0.182897,-0.811003,0.732693,0.372946,0.339669,-0.361354,0.0638505,-0.226213,-0.892986,0.0082636,0.538008,-0.260102,0.150205,0.795244,-0.315916,-0.0335283,0.753265,-0.25919,-0.219624,-0.912551,0.480367,0.0295329,-0.0409355,0.767193,-0.908868,-1.15634,-0.492006,-0.165292,0.497489,-0.00273733,0.181428,-0.477588,-0.133321,-0.0307175,0.311373,0.138785,0.125977,0.139312,0.0976601,0.167885,0.0675843,-0.185619,0.332314,0.0839226,0.286547,-0.12828,-0.0894443,-0.262646,-0.051306,-0.432688,0.292701,-0.261509,0.618202,-0.176591,-0.0589576,-0.269031,0.107599,-0.174577,0.0105763,-0.255646,0.0903202,0.248657,0.195357,-0.341919,-0.27005,-0.387697,-0.0681202,-0.0665574,0.103388,0.0137647,0.102964,0.329384,-0.0787381,0.0738875,0.271225,0.426468,0.250255,-0.244772,0.0558678,-0.031987,0.0966971,0.0234417,-0.283529,-0.0934673,-0.253335,-0.257592,-0.372268,-0.472423,0.0196743,0.158903,-0.195722,-0.510972,0.444776,-0.247389,4.06456e-05,0.150597,-0.533948,0.0295628,0.364115,0.0294027,-0.145939,-0.386949,-0.249821,0.0524406,-0.343648,-0.316172,0.165115,0.0263663,0.135472,0.20203,-0.462292,0.306359,-0.13062,0.174351,-0.0814111,0.0779506,0.0859378,0.0465577,0.504944,-0.2457,0.158709,-0.0790383,-0.390285,-0.016758,0.286753,-0.277389,-0.182658,0.00697874,0.0264516,0.191504,-0.232789,-0.255663,0.126508,-0.362568,0.172934,-0.0743726,-0.0663006,0.446962,0.181478,0.278702,-0.0486996,0.444732,-0.216346,-0.11893,0.21886,0.11222,-0.437656,-0.604933,-0.129843,-0.146172,0.353585,0.347583,-0.240285,0.104155,-0.0914772,-0.436103,0.237717,0.378348,0.0591434,-0.13633,-0.175532,0.123952,-0.162568,-0.239431,-0.103843,0.445902,-0.0137345,-0.149855,-0.195575,0.769924,0.2024,0.0835941,0.202249,0.129826,-0.052487,0.209645,-0.880245,-0.0716567,0.241009,0.449449,-0.103639,-0.457838,0.135579,-0.41414,0.037853,-0.184892,-0.432178,0.37338,0.109022,0.0112293,-0.192394,0.282839,-0.112733,0.16743,-0.112239,0.145636,0.243268,0.298913,-0.133148,0.0629573,0.512424,-0.33232,-0.147881,0.0944385,-0.120405,-0.103589,0.330608,0.106974,0.192766,0.590995,-0.280006,-0.00731813,-0.262924,-0.389311,0.0739125,-0.303384,-0.161542,-0.0781217,-0.0366095,0.0413544,0.202091,-0.100123,-0.00896488,0.0929877,0.0324765,0.377071,0.0580106,0.0970369,-0.226447,0.145509,0.00232373,-0.184288,-0.16329,-0.252599,0.356815,-0.277553,-0.327784,0.0388818,0.179693,-0.330988,0.0807779,-0.0144533,-0.355844,-0.285757,0.0026491,-0.00791769,0.0380209,-0.0363421,-0.119914,-0.0971057,-0.0374911,-0.252458,0.062826,0.249129,0.0875002,-0.198182,-0.329597,-0.00266524,-0.130508,-0.0397206,-0.162754,0.179814,0.433724,0.0620714,0.189348,0.249141,0.435141,-0.196606 +3481.85,0.784782,0.0848144,4,1.63109,0.934543,-0.131161,-0.0896186,0.282113,-0.0884771,-0.125665,-0.047799,0.227254,-0.369031,-0.463796,-0.392681,-0.138707,0.386733,-0.406204,0.906364,0.308277,-0.101858,-0.1718,0.216974,-0.60403,-0.862292,-1.01107,0.189847,0.218532,-0.198561,-0.026273,0.0704084,0.0507075,0.0697179,0.989869,-0.175177,-0.84641,-0.0272092,0.21366,-0.261351,-0.064155,0.0888233,0.334922,-0.443059,1.11495,0.0161564,0.155091,-0.711853,-0.08352,-0.150152,-0.262098,-0.0778736,0.627005,0.128619,0.00941604,-0.214831,0.16423,-0.711355,1.14824,-0.461368,0.00251862,-0.786258,0.497046,-0.553005,-0.212698,1.06815,-0.426551,-1.11448,0.176542,0.0635077,-0.465366,-0.0821934,0.430024,-0.0451225,0.367659,0.318702,0.47562,-0.367542,0.143356,0.148449,0.19735,-0.406837,-0.267756,0.0667472,0.173708,-0.132598,-0.0938189,-0.123827,0.149124,0.29734,0.183703,0.114361,0.0578541,-0.47025,-0.362193,0.451348,0.0532723,0.0557846,0.104699,-0.241685,-0.0213277,-0.192836,0.180785,0.0275622,0.0960702,0.296595,-0.445128,0.0170197,0.214908,0.104568,0.346221,-0.201194,0.32659,0.463924,-0.262838,-0.00675119,-0.317328,0.563234,-0.0596529,0.241963,-0.330354,0.255125,0.23901,0.184888,-0.314916,-0.149889,-0.030671,-0.0811239,0.472471,0.578389,-0.0436014,0.141896,0.286004,0.457701,-0.1603,-0.0764254,0.206157,0.322297,-0.154941,-0.0648274,-0.350281,-0.323753,0.620705,-0.0678077,-0.00986681,-0.18092,0.0115461,-0.116015,-0.253332,0.267096,-0.354351,0.25702,-0.0220973,-0.387144,-0.0272935,0.0170047,0.129887,0.151916,-0.00661342,0.493522,-0.318697,-0.139461,0.0177209,0.0790898,0.309069,0.00478999,0.442946,0.37208,0.244968,0.115129,0.0125178,-0.207924,0.186124,0.258859,0.398005,0.247135,0.00267874,0.0875422,0.0165466,-0.148545,-0.253661,-0.481293,0.352728,0.312947,0.101761,-0.0461469,0.184878,-0.0251199,0.227356,0.352995,0.224606,-0.347683,0.0554074,-0.707919,0.0853099,0.0446482,-0.217084,-0.426508,0.062904,-0.31824,-0.180184,-0.442997,-0.563568,-0.088666,0.118607,-0.27519,0.148495,-0.219184,0.106201,0.247755,-0.103538,0.613013,-0.0345889,0.228445,0.00320201,-0.214754,0.536972,-0.265048,0.506008,0.202423,-0.314223,-0.290531,0.893373,0.0291422,-0.1904,-0.279523,-0.0888724,0.205811,0.0324417,0.143204,-0.456637,-0.245141,0.121629,0.0250043,-0.339517,0.186663,0.23404,-0.242384,-0.346184,0.437651,-0.0714806,0.025107,0.0929296,-0.199322,0.157733,0.333154,-0.179699,0.247419,0.0515009,0.666518,0.043477,-0.15831,-0.126469,-0.386358,0.220143,-0.447752,0.105625,-0.0617642,-0.0425028,0.235657,-0.281865,0.0295022,-0.0990516,0.218972,-0.326575,0.440405,0.203063,0.0790101,0.0570061,0.264667,-0.14469,-0.277478,-0.289377,0.249209,-0.269972,-0.20007,-0.528097,0.515511,0.239326,0.388297,-0.203293,0.104775,0.10921,0.169633,0.0468819,0.301432,-0.340681,0.117872,-0.0880656,0.114641,0.0816731,0.278739,0.199172,-0.146348,0.193862,0.0474266,-0.16938,0.371183,0.127692,-0.456008,-0.0128951,0.00590849,0.125849,-0.0337347,-0.335794,0.0698829,0.303098,0.264354,0.550543,-0.781662 +3457.37,0.954376,0.0848144,4,1.52298,0.858337,-0.227595,-0.0176011,-0.136016,-0.0582983,0.0438241,-0.61642,0.396756,0.174512,0.181966,-0.721085,0.130544,0.706562,0.220216,0.726913,0.361495,-0.354175,0.3713,0.142315,-0.0633535,-0.890619,-0.26264,0.340756,-0.0255741,-0.286087,0.0554956,0.312761,-0.139553,0.0762007,0.799068,-0.208278,-0.233531,0.348545,-0.133087,-0.079087,-0.691686,0.275156,-0.136828,-0.250826,1.25482,0.249645,0.0929508,-0.166,0.229017,0.179886,-0.645327,0.26798,0.788387,0.0399989,0.408189,-0.545797,-0.0680756,-0.90415,1.09166,-0.207735,0.311454,-0.901057,0.537293,0.194135,0.0448578,0.913885,-0.468937,-1.25469,-0.499098,0.314576,0.845496,0.0993072,0.529332,-0.503196,-0.0114842,0.133895,0.497359,0.0922276,0.699321,0.368332,0.415037,0.422096,-0.341287,0.14496,0.455904,-0.187507,0.23364,-0.235806,-0.205532,-0.155133,-0.274018,-0.184459,-0.101,-0.39893,-0.217725,-0.164416,0.132221,-0.23721,0.0646468,-0.690669,0.241155,0.225969,-0.134223,0.232622,0.063878,-0.114861,0.0930674,-0.396348,-0.455539,-0.397112,0.391047,0.0489269,0.35919,0.595451,0.145207,-0.17409,0.216419,0.389362,0.304881,-0.155614,-0.171446,0.0355549,0.0213962,-0.254004,-0.801215,0.220214,0.120131,0.0290744,0.0752693,-0.0997656,0.235544,0.00349435,0.0975546,-0.167013,-0.0571533,0.20815,0.525015,0.20071,-0.205735,0.175196,0.0635372,0.342767,0.130277,-0.289591,-0.340073,0.0374583,0.0132225,-0.131301,-0.077136,-0.109031,0.175416,0.171776,-0.150182,0.231291,0.551264,0.0457496,0.0401253,0.139495,0.0665877,0.297145,0.112271,0.102231,-0.39523,0.0776221,-0.00756438,0.117417,0.617,-0.0644409,-0.136208,-0.380129,-0.175478,-0.0883029,-0.0661301,0.398867,0.0939043,0.89653,0.0903816,0.310189,-0.0201681,0.480421,0.0290262,-0.0290992,0.169727,0.597025,-0.0260501,0.0579865,0.0952424,-0.0551465,-0.0978341,-0.336955,-0.378604,-0.0730148,0.322807,0.111758,0.0685661,0.0523964,0.0248671,-0.242363,-0.0543614,0.0979429,-0.134347,0.280307,-0.0311342,-0.567677,-0.0616746,0.346799,-0.0413191,-0.366457,0.309467,-0.115376,-0.367311,0.786613,-0.105728,-0.0149367,-0.297421,-0.0990404,0.451876,-0.10179,-0.498349,0.342161,-0.107791,0.423655,0.287007,-0.354988,-0.219222,-0.350279,-0.466397,0.223325,-0.608715,0.469584,-0.360352,0.109502,-0.0802469,0.0212806,0.00787609,0.16824,-0.455641,-0.129195,-0.292322,0.647171,0.166336,-0.148094,0.190001,-0.091655,-0.101107,-0.0576716,0.245615,-0.0949721,-0.0854045,0.397962,0.424139,0.556051,0.343916,-0.348221,-0.282502,0.296235,0.188142,-0.169103,-0.554249,-0.0460034,-0.144573,0.104723,-0.359523,-0.0242899,-0.189217,-0.089391,-0.0873678,-0.345773,0.101871,-0.0943909,0.0390992,-0.11851,0.455848,-0.277349,-0.307621,0.199348,-0.0505676,-0.249512,-0.0716732,-0.535488,0.00229203,-0.348156,-0.204543,0.286789,-0.165259,-0.460764,-0.124919,-0.111532,0.0588482,-0.102002,0.0490063,0.139025,0.524305,-0.00684563,0.0569986,0.237706,-0.252339,0.113352,-0.371207,0.354078,0.10993,-0.143961,-0.492751,-0.0957202,-0.223923,0.0863196,0.217597,0.293802,0.466472,0.607875 +3479.05,1,0.0848144,4,1.61763,0.863942,-0.165165,-0.0586443,-0.125391,-0.0599271,-0.0251063,-0.0543032,0.396267,0.0779321,-0.295979,-0.257799,0.0985253,0.451738,0.0798398,0.6829,0.380093,-0.180799,-0.136015,0.19033,-0.427609,-1.10719,-0.137674,0.416202,-0.145241,-0.112346,-0.141835,-0.0167897,-0.0376535,0.0425062,0.96292,-0.235058,-0.0808052,0.443215,0.31813,-0.238082,-0.408826,0.495721,-0.180565,-0.148229,0.762742,0.203827,0.0920235,-0.776289,-0.28751,0.363231,-0.747716,0.287529,0.483178,-0.025769,-0.0791112,-0.628635,0.204375,-0.587556,1.13482,0.136496,0.0658262,-1.00466,0.329963,-0.0529723,0.279775,0.956953,-0.794107,-1.07231,-0.29272,0.351384,-0.0669686,0.0109414,0.220722,-0.527604,-0.0361986,0.267734,0.641878,-0.243943,0.552494,0.246084,0.511444,0.137294,-0.440822,0.29008,0.113575,-0.784948,0.0783635,-0.501889,-0.44863,-0.151007,-0.370007,0.328085,0.119542,-0.316707,-0.504001,-0.0256635,-0.310896,-0.402573,0.382537,-0.31051,0.304008,-0.296399,-0.148684,0.244021,0.205954,-0.202393,0.118007,-0.0785556,-0.655405,-0.0880108,0.117596,-0.229613,0.274577,0.761156,0.171352,-0.0613494,0.512261,0.449268,0.163075,0.072633,-0.100729,0.153249,-0.158717,-0.560242,-0.65128,0.438725,0.105468,0.3001,-0.191862,0.195655,0.188618,0.199883,0.308382,-0.332589,-0.0311568,-0.0164566,-0.0309137,0.443131,-0.427816,0.126587,-0.266843,-0.1069,0.392604,0.10087,0.00879012,0.180937,-0.271979,-0.504709,0.00934896,-0.154586,0.227323,0.216538,-0.143011,0.121092,-0.193733,-0.276262,-0.0868726,-0.147599,0.685022,-0.0328835,-0.070585,-0.0660408,0.161095,0.23967,-0.143801,-0.0612361,0.727668,0.0857209,-0.257389,-0.180151,-0.00247291,-0.0404678,0.598228,-0.258691,0.240701,0.0190765,0.0821116,0.179574,-0.0708831,0.181783,0.0911476,-0.381208,0.180845,0.551804,-0.144058,-0.152152,0.0060383,0.160623,0.495508,-0.537701,-0.190034,-0.112353,0.100597,-0.128529,0.153652,0.152802,0.240805,-0.430266,0.192884,-0.166719,0.221902,-0.220966,-0.0578355,-0.155342,-0.0454418,-0.227418,0.234728,0.302459,0.303384,-0.1374,-0.54114,0.813581,-0.0629437,-0.294405,-0.372618,-0.0458657,0.35333,0.218542,-0.633578,0.228916,0.248116,0.386598,0.11086,-0.547382,-0.0990915,-0.247599,-0.022233,-0.176198,-0.524257,0.550266,-0.0899592,0.00736019,-0.314452,-0.0208061,0.0467059,0.042608,-0.355298,-0.491978,-0.403369,0.63855,-0.168928,0.0493165,0.325695,-0.115482,-0.12572,0.345283,0.0658508,0.166329,0.506317,0.235078,0.40538,0.201013,-0.340091,-0.270607,-0.161799,-0.450826,0.428984,-0.00854963,-0.111077,0.121716,-0.0607669,0.138644,-0.0475351,0.0621986,0.0390224,0.530561,0.251059,0.572184,-0.0158132,0.25621,0.0173781,-0.387747,-0.103843,0.250584,-0.131213,-0.225695,-0.680751,0.0093726,-0.0294335,0.152284,0.180253,-0.203555,0.261847,-0.342001,0.122854,-0.0137846,-0.00170952,-0.0527332,0.00337042,0.383431,0.188609,0.154077,0.513779,0.0273488,0.105577,0.329071,-0.430471,0.49998,-0.0343559,-0.301145,0.418215,-0.033735,-0.258735,-0.236689,0.128531,0.0953738,0.225885,0.308826,0.475273,0.663874 +3446.92,0.83321,0.0848144,5,1.49385,0.925988,0.0834166,-0.0601605,0.312967,-0.00693213,0.0700665,0.16714,0.675455,0.0017501,-0.0100169,0.241395,0.0609801,0.669963,0.285361,1.11583,0.658301,0.000931497,0.0570087,0.12357,0.00326612,-0.413212,-0.399194,0.314688,0.245739,-0.265021,0.331839,0.358158,-0.320081,0.290288,1.04247,0.366458,-0.0816054,0.206017,0.189527,-0.125855,-0.697886,-0.0746937,0.599775,-0.828035,1.11452,0.609218,0.0406376,-0.296569,-0.209111,-0.897726,-0.507914,-0.228388,0.45489,-0.482329,0.322439,-0.236573,-0.103839,-0.568669,1.39564,-0.761363,-0.180745,-0.554881,0.20701,-0.464022,-0.331185,1.04999,-0.654666,-0.555272,0.250943,0.192291,0.0789916,-0.120812,0.511724,0.0149849,-0.162912,0.519716,0.346084,0.0892318,0.388405,0.0467424,0.188809,0.0590735,-0.0618108,-0.362249,0.282616,0.0349578,0.345416,0.418263,0.569021,-0.237426,0.249324,-0.443498,0.101774,-0.266306,0.123291,0.121877,0.196771,-0.232067,-0.168054,0.115145,-0.141649,-0.228324,0.237151,0.273355,-0.313239,0.0267651,-0.783156,-0.0569233,0.697222,-0.369857,0.255641,-0.00957552,0.767419,0.468254,-0.150676,0.0186431,-0.351747,0.154514,-0.0918989,0.0595515,-0.115779,0.477922,0.315182,0.0384817,-0.32138,-0.509403,-0.384712,-0.607045,0.344885,0.294321,0.0386868,0.473078,0.182155,-0.224994,0.0903151,0.0101365,-0.116985,0.340049,-0.126132,0.183979,0.0381527,0.101155,0.0904073,-0.690587,-0.958422,-0.142358,0.0448562,0.223344,0.255577,0.770147,-0.01626,0.493394,-0.188077,-0.500152,0.420234,0.386818,0.0613385,0.468766,-0.432797,0.685524,0.136439,0.1368,0.0382808,-0.28248,0.339268,-0.181484,0.669762,-0.164366,0.226275,0.600036,-0.0870612,0.163606,-0.481271,0.220034,0.378458,-0.669489,-0.263156,-0.0727292,0.106778,0.0753291,0.0377729,0.197815,-0.306662,0.419654,0.207853,-0.284859,0.257037,0.187943,-0.111561,0.232554,0.0941725,-0.0738041,0.337538,-0.623367,-0.169357,-0.262772,-0.242481,-0.680207,0.098581,0.746142,0.183753,-0.252245,-0.554112,-0.0951637,0.0372675,0.00646751,0.195708,-0.412509,0.0509671,0.17697,-0.0898627,0.884694,-0.229324,0.930454,0.332541,-0.704619,0.265866,-0.00784714,0.309856,0.0650896,-0.31967,-0.279042,0.289397,0.138433,-0.0103072,-0.572683,-0.27046,0.381932,-0.103077,0.298685,-0.364781,-0.0706841,0.19034,0.214289,-0.151737,-0.0991203,0.149169,0.31329,0.403527,0.647009,0.0752359,0.298841,0.431605,-0.803199,-0.19125,-0.389799,0.300584,-0.020558,-0.242056,0.337243,0.405548,-0.175502,-0.143072,-0.420685,0.00506172,-0.426581,-0.382093,-0.263552,-0.293665,0.535573,-0.569258,0.238621,-0.114171,0.0722242,0.0823833,-0.0834247,-0.0083111,-0.206173,0.181126,-0.109436,-0.0339477,-0.016329,0.00363125,-0.428006,-0.427604,0.106865,0.247237,-0.236746,-0.18652,-0.0927221,-0.0163746,0.115047,-0.10432,0.137744,-0.0105483,-0.503711,-0.39267,-0.0997472,0.22057,0.415352,-0.098283,0.367772,-0.242644,-0.200327,-0.176525,-0.129094,0.588601,-0.12181,0.313565,-0.382757,-0.144173,-0.287943,0.192184,-0.118283,-0.319829,0.120593,0.220519,0.347265,0.469595,-1.16727 +3439.08,0.84284,0.0848144,4,1.52377,0.901567,0.0296116,-0.0357355,0.357787,0.0190364,0.0887507,0.126586,0.856651,-0.0540556,-0.0362628,0.208961,-0.116735,0.715751,0.324553,0.883945,0.64613,-0.00799589,0.186167,0.103027,0.328356,-0.561359,-0.345537,0.287101,0.17867,-0.122111,0.156136,0.186996,-0.119367,0.325474,1.02451,0.432142,-0.0516578,0.154793,0.213069,-0.0201183,-0.653325,0.0927685,0.696981,-0.715141,1.01025,0.577686,-0.0532803,-0.195118,-0.158572,-0.825473,-0.445347,-0.0967849,0.430135,-0.374551,0.297741,-0.223161,-0.0519319,-0.330347,1.43954,-0.564727,-0.275297,-0.767158,0.315461,-0.41951,-0.270747,0.992618,-0.771389,-0.407683,0.382978,-0.258228,0.247139,-0.192802,0.706705,0.161244,-0.00683871,0.5834,0.37202,-0.102978,0.255021,0.160971,0.207332,0.155066,-0.174643,-0.332725,0.189173,0.0233212,0.486779,0.379194,0.327152,-0.0330241,0.599905,-0.44115,0.178,-0.264544,-0.0804614,0.173049,0.162671,-0.216403,-0.25282,0.165609,-0.0714416,-0.364658,0.327892,0.367317,-0.132944,0.191837,-0.653533,-0.104919,0.658368,-0.233538,0.161061,-0.0369717,0.949233,0.610131,-0.122578,0.0592565,-0.0271688,0.166459,0.0801967,0.0989963,-0.150104,0.579689,-0.00284944,0.0129745,-0.248134,-0.367042,-0.0956555,-0.408032,0.295002,0.180335,-0.168767,0.21381,0.122238,-0.291274,-0.0900736,0.0829166,-0.22191,0.37645,-0.211242,0.142108,0.226301,-0.100777,0.137358,-0.615273,-0.82425,-0.0949622,-0.0500528,0.16023,0.379883,0.600355,-0.00567521,0.646234,-0.283222,-0.515534,0.378701,0.426205,0.145802,0.298049,-0.233348,0.755617,0.214873,0.329005,0.057844,-0.273531,0.371055,-0.0601018,0.695602,0.151823,0.245089,0.613871,-0.147765,0.257306,-0.742998,0.069986,0.285685,-0.44097,-0.199248,-0.0145532,0.0668837,0.112685,0.0272505,0.218511,-0.39339,0.404957,0.200935,-0.337667,0.266327,0.18079,0.156982,0.201282,0.19494,-0.259035,0.401144,-0.687547,-0.116374,-0.348074,-0.105629,-0.748789,0.0561549,0.558905,0.360116,-0.166966,-0.857288,-0.0263453,-0.0267505,-0.0343978,0.285802,-0.397123,0.293647,0.246328,0.00199324,0.833555,-0.0606241,0.728196,0.117379,-0.535197,0.128048,0.0437228,0.208782,0.0208509,-0.233983,-0.10742,0.365807,-0.151007,-0.170797,-0.819279,-0.138821,0.455223,-0.238362,0.351473,-0.22945,-0.189442,0.152215,0.306919,-0.19536,-0.0108097,0.342183,0.448817,0.452349,0.611061,0.114771,0.402562,0.410713,-0.8582,-0.230239,-0.359867,0.39432,0.034627,0.0130333,0.0584371,0.423536,-0.0315442,-0.29549,-0.473421,-0.137918,-0.446728,-0.424055,-0.0575916,-0.291701,0.765344,-0.351184,0.421112,-0.363362,0.076816,0.0483243,-0.231904,-0.0655713,-0.0949318,0.122647,-0.0737386,0.152632,0.202892,0.0226881,-0.346706,-0.191109,-0.0974819,0.382454,0.0111905,-0.0731685,-0.0517373,-0.163919,0.0704207,-0.157186,-0.0276886,0.0839096,-0.247113,-0.428651,0.0276614,0.260541,0.629928,-0.046054,0.0419696,-0.354936,-0.282326,-0.369898,-0.125933,0.690773,-0.172855,0.221876,-0.354554,-0.215443,-0.131552,0.0272776,-0.243427,-0.218224,0.113186,0.216107,0.336432,0.464873,-1.24436 +3429.11,0.982488,0.0848144,4,1.47702,0.782281,-0.242395,0.120184,0.132368,-0.0667291,0.024732,0.193916,0.388051,0.053365,0.322528,0.157416,0.173673,0.885974,-0.0262509,1.26007,0.830073,0.360761,0.456436,-0.0265793,0.022882,-0.413196,-0.289976,0.438576,0.16297,0.154522,0.102304,0.464569,-0.210013,0.157234,1.23129,0.426476,0.0523451,0.800941,-0.0708141,-0.155434,-0.918251,0.25579,-0.143909,-0.4549,1.01679,-0.0740548,-0.096458,-0.463502,-0.0180669,-0.900302,-0.686106,0.0818821,0.655129,-0.230788,-0.156034,-0.404236,0.0367352,-0.661401,1.27727,-0.318072,-0.152573,-0.908467,0.599643,-0.281971,-0.00101775,0.793645,-0.543328,-0.482335,0.171344,-0.205668,-0.158975,-0.082944,0.500755,-0.372753,-0.205916,0.0708049,0.541004,0.357663,0.561933,0.169511,0.527442,0.15928,-0.0839178,-0.179668,0.586265,-0.400496,0.140175,-0.478929,0.0240527,-0.284754,0.227154,0.00753915,0.0894535,-0.332632,-0.291425,0.0422349,-0.227769,-0.153892,0.206332,0.052158,0.5717,0.106815,0.940653,0.194752,0.366842,0.411001,-0.197127,0.0295783,-0.136073,-0.195683,0.0234436,0.00918342,0.302826,0.606525,0.129539,-0.0533149,-0.429133,0.114892,-0.0918653,0.574998,0.0463242,-0.355683,-0.113105,-0.449237,-0.53861,-0.327095,0.0784831,-0.35108,0.148145,0.49081,-0.0198799,-0.0714305,0.636267,0.3422,0.308593,0.0543559,-0.193983,0.365964,-0.237732,-0.0512803,-0.213325,0.0747264,0.443549,-0.201611,-0.333597,0.147914,0.411117,-0.302755,-0.0460262,0.454368,0.0696139,0.175149,-0.221127,-1.01865,-0.0158446,0.203317,0.149786,-0.0198569,0.264702,0.467379,0.371286,0.270404,-0.0232082,0.308145,0.419687,-0.174175,1.03006,0.0451931,-0.454639,0.250496,-0.594204,0.35279,0.368526,-0.187269,-0.173208,-0.276999,-0.214966,0.0957625,-0.20985,-0.518316,0.0365048,-0.789991,0.201492,0.604132,-0.312544,-0.485311,-0.0808595,-0.496222,-0.0594286,-0.526273,-0.537046,-0.220802,-0.0943605,-0.793751,-0.177347,0.184572,0.404203,-0.782182,-0.249526,-0.0517281,0.441296,0.11262,-0.333977,0.0936667,-0.0834957,-0.492007,-0.231888,-0.246745,-0.294208,0.480326,-0.292787,0.760604,0.0408525,0.334143,-0.0177822,-0.0812195,-0.208823,0.347541,0.30537,0.351303,-0.285777,0.473294,0.117322,-0.533908,0.248716,-0.812606,-0.131009,0.119146,-0.348936,0.397398,-0.988196,0.225933,0.185391,0.357371,-0.53307,-0.161034,-0.167399,-0.195014,0.0638171,0.360931,0.209309,0.320428,0.494125,-0.440359,-0.365195,-0.0696631,0.219167,0.0830657,0.189348,0.393438,0.49002,-0.0838866,-0.0624221,-0.414294,-0.402365,-0.557635,0.0206467,0.377175,-0.443589,0.261108,-0.525742,0.269502,-0.699251,0.313446,0.029719,0.04156,0.280706,0.114796,0.186949,0.160363,-0.242305,-0.186311,0.0388523,-0.0817417,0.0150035,-0.351603,0.634115,-0.294411,0.0589674,0.301342,-0.024544,0.109959,0.540375,-0.266913,0.0734637,-0.108466,-0.288609,-0.691395,-0.0380602,0.262781,0.261263,0.186468,-0.512923,-0.473818,-0.172421,0.502696,-0.0640274,0.571036,-0.0470262,-0.425269,0.12073,0.169986,-0.305035,-0.958901,0.123863,0.126972,0.291244,0.356331,0.53967,-0.315391 +3421.19,0.986459,0.0848144,4,1.51505,0.758366,-0.0304464,0.0447143,0.455898,-0.0601904,0.366985,0.2205,0.285536,0.163926,0.167127,0.130187,0.473777,0.754419,0.0899733,1.07273,0.656126,0.331624,0.411492,0.160731,-0.13453,-0.55775,-0.270884,0.666217,0.0642312,0.0386239,0.0830241,0.433623,-0.275149,0.237074,1.33324,0.0607056,-0.0666717,0.662959,0.0460059,0.0981762,-0.951761,0.0634307,-0.148264,-0.355955,1.04326,-0.120301,-0.0795676,-0.161348,0.0365332,-0.952702,-0.62634,-0.103486,0.6153,-0.150681,-0.190308,-0.754488,-0.119521,-0.610812,1.53676,-0.146854,-0.0143788,-1.00449,0.611371,-0.317147,-0.0945714,0.865506,-0.623426,-0.451454,0.298519,-0.0442328,-0.140118,-0.129124,0.50581,-0.182548,0.00392822,-0.115603,0.48519,0.332679,0.5121,0.300114,0.416629,0.0206224,0.139952,0.054696,0.494354,-0.517182,0.384333,-0.104139,-0.0270781,-0.366991,-0.180301,0.131101,0.0740595,-0.597922,-0.187224,0.171939,-0.39411,-0.105264,0.171699,0.0574936,0.450828,0.203924,0.839481,0.385595,0.447062,0.351585,-0.403127,-0.308518,-0.157823,-0.485404,0.154113,0.323078,0.45304,0.716725,-0.0239502,-0.177992,0.0169039,0.173151,-0.263831,0.161749,-0.08551,-0.192948,0.0280693,-0.073238,-0.613824,-0.147172,0.0730185,-0.748564,0.0129336,0.484065,0.0802478,-0.123537,0.656278,0.477084,0.314246,0.07741,0.0291242,0.266063,-0.292967,-0.0265223,0.0210428,-0.00652337,0.581866,-0.277652,0.121159,0.120182,0.0514451,-0.417724,0.0681969,0.543427,-0.0107314,0.131744,-0.183001,-1.01226,-0.159055,0.28181,0.102903,0.0218496,0.238302,0.509904,0.381603,0.112661,-0.0956964,0.407011,0.0751709,-0.0407356,0.726136,-0.0086724,-0.309633,0.349617,-0.278272,0.336175,0.312138,-0.435492,0.152144,-0.206785,-0.400384,-0.0384885,0.0385656,-0.473738,0.00742041,-0.651217,-0.0146702,0.552252,-0.577633,-0.31519,-0.184807,-0.440985,0.0920533,-0.402911,-0.591948,0.0194145,0.0334325,-0.929454,-0.243669,0.134261,0.397801,-0.70202,-0.454347,-0.00323918,0.609837,0.172703,-0.496595,0.015768,0.100608,-0.384885,-0.457917,-0.134629,-0.191896,0.379455,-0.325098,0.731055,0.0868668,0.106979,-0.193536,0.0896255,-0.352144,0.468677,0.248057,0.404389,-0.110883,0.513673,-0.0192425,-0.509378,0.270222,-0.630522,-0.310335,-0.0899129,-0.401288,0.627865,-0.898755,0.0859527,-0.0964722,0.329268,-0.447794,-0.120796,-0.154559,-0.185934,-0.214224,0.0908796,0.0792316,0.21881,0.481266,-0.50102,-0.299774,-0.006659,-0.0544491,-0.0267526,-0.0679056,0.237366,0.665815,-0.0933067,0.105,-0.268316,-0.283305,-0.650747,0.0492169,0.546659,-0.203333,0.171047,-0.321729,-0.037501,-0.493607,0.351616,0.12164,-0.179916,0.479643,0.137084,0.046717,0.0399718,-0.281273,0.128358,-0.141133,-0.272978,-0.125198,-0.492523,0.396633,-0.427186,0.189113,0.317189,0.149444,-0.454002,0.561736,-0.0349936,0.173909,-0.366372,-0.330872,-0.688918,0.0633155,0.346037,0.130435,0.373567,-0.4618,-0.345288,-0.137451,0.69802,-0.0042214,0.539047,0.094277,-0.111647,0.222535,0.408121,-0.0697419,-0.67544,0.342943,0.121593,0.329892,0.348701,0.574362,-1.35056 +3429.17,0.878932,0.0848144,4,1.44756,0.738967,-0.227446,0.152838,0.348852,-0.176416,-0.06038,0.0255737,-0.0963217,0.723748,0.346339,-0.268793,0.364113,0.968264,0.339688,1.0273,0.537471,-0.172955,0.134295,-0.209247,0.319685,-0.772377,-0.311634,0.476052,-0.1392,0.220639,0.53251,0.600912,-0.45803,0.683076,1.27622,0.337998,0.0706017,0.868252,0.254776,0.0142582,-0.794749,-0.117779,0.406879,-0.976381,0.814272,0.211369,0.536216,-0.572834,0.0980054,-0.286947,-0.631547,0.133392,0.444499,0.457233,-0.00243782,-0.691661,0.184353,-0.642627,1.30798,-0.183351,0.0232799,-0.754417,0.887559,0.244715,-0.152412,0.614468,-0.634108,-1.05349,-0.190726,0.581124,0.128086,0.618879,-0.262824,-0.453629,0.2059,-0.00113887,0.517689,-0.203777,0.178107,0.820429,0.242196,-0.200625,0.138884,0.22648,0.608007,-0.665532,0.382928,-0.405046,-0.105072,-0.303724,0.0806713,-0.301648,0.0913311,-0.374618,-0.606716,-0.0610281,-0.0529469,-0.0437649,-0.193929,-0.000224684,0.163615,-0.289266,0.515595,0.351275,0.311378,0.0485195,-0.509243,-0.0243153,0.191623,-0.665501,-0.365973,-0.348433,0.276834,0.921954,0.406637,0.0696227,-0.363456,0.136434,-0.0756462,0.304691,-0.44408,-0.136167,-0.261671,-0.29894,-0.500743,-0.539125,0.0655379,-0.549944,0.0242106,0.29626,0.384083,-0.103661,0.39378,-0.544906,0.132247,-0.218213,0.175186,0.297548,-0.391048,-0.344277,-0.0259222,0.167754,0.576096,-0.602061,-0.283705,0.235704,0.329418,-0.776375,0.514756,-0.0351431,0.0994378,0.176173,-0.472952,-0.120621,0.332749,0.0612507,0.0599768,-0.0992158,0.658607,0.444625,-0.00285383,-0.318015,0.0317331,0.702992,0.250153,-0.252522,0.241235,-0.0687574,-0.0951591,0.000471448,0.172264,-0.308334,0.0028173,-0.809206,0.339592,-0.0281816,-0.298973,-0.406604,-0.228835,0.419875,-0.26451,-0.476729,0.178342,0.934074,0.194297,-0.0107204,-0.215613,-0.00498824,-0.0896451,0.0939634,-0.165186,-0.31656,0.476257,-0.28796,0.168718,0.0133399,-0.289232,-0.27099,0.0932964,-0.0729279,0.539662,-0.131541,-0.439699,-0.201665,0.0861157,-0.565992,0.331083,-0.0868277,-0.0241418,0.280601,-0.405375,0.744052,-0.229553,-0.0191705,-0.42635,-0.402403,-0.049476,0.080831,-0.356788,0.31779,-0.524761,0.0219931,0.747625,-0.143369,-0.0542409,-0.132563,0.217549,0.481526,-0.533201,0.38773,-0.594455,-0.315181,0.347413,-0.0857371,0.00428324,-0.172229,-0.0295303,-0.160955,-0.4282,0.473979,-0.414307,-0.0483315,0.669403,-0.0544009,-0.446083,0.237059,0.0331607,0.0583906,-0.542691,0.268602,0.494219,0.653989,0.208036,-0.479411,-0.112006,-0.924888,0.00909675,0.081121,-0.392207,0.431654,0.0329129,0.149952,-0.168958,0.484377,0.272411,0.04246,0.217698,-0.15769,0.857821,0.390848,-0.142263,-0.219422,-0.289776,0.209927,-0.0663124,0.00288387,0.270019,0.134174,0.0558424,-0.237928,0.175087,0.34898,0.550329,-0.282957,0.586603,-0.0680027,0.071848,0.215027,-0.189877,0.0872499,-0.162416,0.244497,0.0846237,0.126945,-0.236772,0.276563,-0.343146,0.0177699,-0.216234,-0.23575,-0.0433883,-0.162872,-0.529145,0.036766,-0.268561,0.126804,0.336011,0.356095,0.579665,-0.998357 +3416.16,0.947674,0.0848144,4,1.46113,0.782229,-0.0887517,0.0629134,0.495329,-0.110084,0.289059,-0.288955,0.084504,0.662908,0.113197,-0.173202,0.349751,0.912514,0.326372,1.17572,0.443257,0.231522,0.0874888,-0.215713,0.0173324,-0.596024,-0.691091,0.283042,-0.165817,0.194766,0.441928,0.691583,-0.368878,0.311804,1.31863,0.157364,0.0754292,0.799688,0.185624,-0.0765443,-1.13737,-0.272457,0.361451,-0.805217,0.984271,0.17468,0.267862,-0.914566,0.0847521,0.0787297,-0.60035,0.187429,0.20855,0.149878,0.0783946,-0.654363,0.0776678,-0.416858,1.56879,-0.258291,0.0263701,-0.718299,0.751411,-0.149847,-0.157899,0.677142,-1.10717,-0.724576,-0.460931,0.57926,0.352604,0.775416,-0.791637,-0.275355,-0.23344,0.446077,0.297139,-0.132467,0.0601384,0.612306,0.297983,0.216226,-0.106719,0.37781,0.648355,-0.327967,0.581169,-0.140841,0.0927105,-0.278284,0.169547,-0.0584283,0.257039,-0.425926,-0.334018,-0.0447708,-0.163981,-0.242232,0.392257,0.109108,-0.0304379,-0.856149,0.899871,0.110432,0.132828,0.418167,-0.0467681,-0.0120707,-0.435842,-0.711053,-0.336717,-0.539051,0.445795,0.980122,0.25275,-0.05145,-0.293801,0.10999,-0.107855,0.234749,0.0251543,-0.175479,-0.0387106,-0.366901,-0.504423,-0.373407,-0.110541,-0.0171562,-0.17417,0.344507,0.418777,-0.162322,0.275586,-0.285003,-0.0664003,-0.226786,0.105365,0.608742,-0.518248,-0.382157,-0.0416039,0.0374928,0.450906,-0.20932,-0.0688989,0.371258,0.576487,-0.569944,0.421192,-0.0470064,0.209199,-0.189999,-0.381441,-0.0204592,0.0471827,-0.250486,0.173842,-0.442193,0.299497,0.592862,-0.0161352,-0.483155,0.309676,0.386594,0.117801,0.0622788,0.677698,-0.17135,-0.0876565,-0.0958998,0.327963,-0.331392,-0.148295,-0.643096,0.115998,0.00809104,-0.472235,-0.107066,-0.0371691,0.475688,-0.571627,-0.343216,0.275549,0.982498,0.108038,-0.00457278,0.158935,-0.218232,-0.338062,-0.256294,0.0918567,-0.493862,0.356377,-0.521314,-0.0659664,0.269286,-0.152496,-0.579399,0.0238862,0.134845,0.323197,-0.0273139,-0.426318,-0.320265,-0.0447272,-0.492414,0.239636,-0.07485,-0.127236,0.240803,-0.0970251,0.820388,-0.524618,-0.307025,-0.396586,-0.585209,0.0604631,-0.0449444,-0.307294,0.17793,-0.329461,-0.0627357,0.377707,-0.257908,-0.215841,0.293249,-0.477519,0.422202,-0.402773,0.698821,-0.839615,-0.0418391,0.382206,0.234304,0.0194031,-0.458542,-0.164575,0.0466236,-0.645565,0.456563,-0.585346,0.205894,0.611293,-0.0686196,-0.039976,0.268493,0.237312,-0.0540116,-0.296134,-0.0513794,0.723792,-0.0744956,0.135142,-0.402084,-0.389283,-0.715571,0.0929,0.19664,0.031505,0.242059,0.0642624,-0.0247276,-0.0762909,0.180636,0.457214,0.0432775,0.172645,-0.0515726,0.67022,0.457743,0.083552,-0.197144,-0.280672,-0.0903528,0.20059,-0.146758,0.292215,0.68923,0.27091,-0.116341,0.164658,0.401669,0.505188,0.289887,0.043236,-0.316234,-0.0457535,0.505686,-0.127487,-0.17702,-0.421757,0.561096,0.138696,-0.238966,-0.113402,0.145906,-0.281759,0.44395,-0.567023,0.170453,-0.0497617,0.273351,-0.311925,0.105283,0.143035,0.13284,0.330221,0.364473,0.574649,-1.55171 +3400.41,0.880987,0.0848144,5,1.60233,0.886377,0.149541,-0.0508995,0.180978,-0.071977,0.316839,0.357433,0.143148,0.148919,0.438737,-0.0800919,-0.738214,0.641492,-0.089033,0.702152,-0.111934,0.415069,-0.399642,-0.00915166,0.119073,-0.896594,-0.53386,0.629001,-0.161509,-0.408791,-0.0687733,0.248491,-0.056477,0.0446155,0.901167,-1.02875,0.334234,0.152816,-0.317276,-0.00311215,-0.577739,0.374456,0.379062,-0.0490984,0.979202,0.425021,-0.549333,-0.773484,-0.107476,-0.0238475,-0.522547,-0.0988322,0.465094,0.436505,0.0227753,-0.124988,0.249218,-0.762391,1.36582,-0.68685,-0.499333,-0.88166,0.918687,-0.91729,0.271375,1.15046,-0.886807,-1.98811,0.24863,-0.281049,0.0831131,-0.923783,0.250431,-0.444352,0.0512618,-0.0692177,0.579569,-0.274458,0.946507,0.665059,-0.00147416,0.110481,-0.315544,-0.418637,0.291741,0.0343206,-0.216702,-0.33642,-0.120226,0.0885091,-0.238578,-0.168251,-0.295646,-0.0671988,0.566135,0.113542,-0.0439516,0.376582,-0.132255,-0.201983,0.220331,0.527005,-0.625807,0.251992,0.19626,-0.607404,-0.32313,-0.461495,0.162311,0.0593569,0.608874,0.0498881,-0.366797,0.505074,-0.186248,-0.223236,0.360469,0.0423122,0.465785,0.206603,-0.13901,-0.176666,0.768274,-0.129595,-0.70661,0.180935,-0.484725,-0.329112,-0.185844,0.071278,0.247348,0.432902,0.0307015,-0.208619,0.625064,-0.0559093,-0.162557,0.372066,0.379755,0.00587729,0.445294,-0.375791,0.328956,-0.652525,-0.384596,-0.374247,-0.108554,0.163736,-0.404613,0.20911,-0.406869,0.594002,0.220438,0.00210373,-0.515064,0.15885,0.145136,0.193631,0.206267,0.327704,-0.0339357,0.024026,-0.327931,-0.109477,0.465859,0.095962,0.740999,0.0687533,-0.076543,0.0822443,-0.57093,-0.343896,0.142474,-0.0416464,-0.0515368,0.130051,-0.443272,0.139183,0.149208,-0.272803,-0.317345,0.356957,0.0555846,0.149863,-0.0800261,-0.328278,0.0089504,0.176877,0.336351,-0.400681,-0.453421,-0.282696,0.310835,0.323772,-0.192058,-0.218734,0.276115,0.0982634,-0.13417,0.124991,-0.204232,-0.369936,-0.128051,0.232675,-0.0273619,0.448054,0.319099,-0.0147369,0.0930555,-0.34467,-0.800127,1.04372,0.66627,0.596524,0.185273,0.291842,0.292924,0.503959,-0.0118948,0.127069,-0.0754715,0.234694,0.0133628,-0.0531199,0.308439,-1.07578,-0.0228863,-0.167427,-0.233025,-0.165241,-0.253731,0.0744033,0.0400111,-0.335832,-0.371497,-0.262465,0.187666,-0.0756015,0.104393,-0.176237,0.610395,-0.0563629,0.258504,0.360673,-0.439825,0.0554551,-0.467253,0.272178,1.46049,0.0559294,-0.00810238,0.546582,0.0810718,-0.360446,0.00312857,-0.247372,1.01107,-0.617617,0.0040636,0.327491,-0.42342,0.230415,0.221979,-0.00456226,-0.259716,0.676811,0.201644,-0.163996,-0.186005,-0.430603,0.040927,-0.0313551,0.0413024,-0.0164722,-0.387891,-0.149624,-0.707239,-0.214762,-0.294251,0.349542,-0.107836,-0.808432,0.208599,-0.0183776,0.0378765,-0.0793863,-0.344927,-0.460946,0.113344,0.0851003,0.657534,0.135405,-0.263432,0.0399017,-0.46839,-0.291235,0.581911,-0.306264,-0.107904,-0.719363,0.10216,-0.376531,0.227854,-0.294629,-0.213687,0.131434,0.312219,0.362538,0.558766,-0.577856 +3414.14,0.932947,0.0848144,4,1.52411,0.823679,-0.751984,0.354872,0.388846,-0.00119119,0.145995,-0.143139,0.283305,0.508873,0.226135,-0.124524,-0.134383,0.651827,0.0853325,1.04533,0.10938,0.350712,-0.15816,0.250165,-0.040909,-0.384204,-0.689871,0.607764,-0.121495,-0.271036,0.432516,0.884006,0.174212,0.351852,0.816487,-0.436991,-0.112399,0.686119,-0.134074,-0.326106,0.179563,0.0773191,-0.145117,-0.546496,1.14198,0.39287,0.325304,-0.535948,0.197659,-0.337891,-0.153948,-0.16089,0.499115,0.120893,0.0282813,-0.161389,0.300401,-0.261396,0.82691,-0.129429,-0.528028,-0.257529,0.650145,-0.545944,-0.212933,0.904965,-0.796546,-0.227843,-0.0482271,0.364962,-0.0535935,-0.173131,0.169941,-0.509978,-0.0380678,0.813981,0.219763,0.27889,0.202188,0.687917,-0.0015024,0.145117,-0.198443,0.0451481,0.225623,-0.557629,0.254242,-0.11529,0.651002,0.548479,0.158124,-0.0234482,0.31487,-0.169323,0.390964,-0.124021,-0.0417345,-0.0673109,0.36611,-0.409574,0.136111,-0.826615,0.518694,0.0201845,-0.0858157,0.41288,-0.352719,-0.23065,0.136186,-0.567291,0.223463,-0.301853,0.219252,0.496461,0.112848,-0.0665827,0.0659947,0.0258199,0.0025001,0.874997,-0.645928,-0.231603,0.317684,0.232926,-1.07424,0.0858683,0.00641386,0.0287671,-0.142167,0.0580865,-0.0554781,0.126145,0.0884492,-0.638099,0.384066,-0.375427,0.20825,0.441735,-0.17901,-0.203656,0.77314,0.0245877,0.269869,-0.0380544,0.113672,-0.180071,0.241893,-0.441675,-0.225494,-0.0743526,-0.709279,0.199771,-0.119639,0.314943,-0.417542,-0.0429833,0.257759,-0.121646,-0.396364,0.125426,0.713402,-0.052687,0.193508,-0.23825,0.444986,-0.586649,0.485837,-0.278664,0.395784,0.0981814,-0.00151334,-0.457796,-0.588499,0.4166,0.162524,-0.0761997,-0.338722,0.126689,0.295675,-0.0675236,-0.619467,0.214177,0.749389,0.716103,-0.260604,-0.833949,0.328939,-0.0734467,-0.344763,0.238162,-0.808817,-0.737822,-0.162475,-0.124326,-0.0572831,-0.0229145,0.0369383,-0.839509,-0.201145,0.264282,0.292687,-0.027035,-0.979552,0.213741,-0.279991,-0.0976839,0.601644,-0.103725,0.0365241,0.33429,-0.230727,1.26802,-0.229598,0.281511,-0.300735,-0.194825,0.191906,-0.237641,-0.148752,-0.0996189,-0.0675438,0.211284,0.490062,0.0229343,0.367269,-0.482773,-0.194601,-0.130919,0.0341053,0.582785,-0.505936,-0.239489,-0.609573,-0.617991,0.201492,-0.340754,0.281709,0.229112,-0.350005,0.509336,0.414707,0.028889,0.596375,-0.0991693,0.00688347,-0.465161,0.432963,0.637247,-0.27291,-0.189781,0.315025,0.212558,0.35049,-0.516804,-0.0348954,-0.771327,0.223557,-0.553149,-0.56072,0.252717,-0.590119,-0.0497281,0.0497765,-0.367158,0.66735,0.201688,0.19156,-0.477402,-0.0466089,0.246928,-0.00360491,0.389911,0.12371,-0.394532,0.00421731,-0.332451,-0.413141,0.212228,-0.179527,-0.293529,-0.388296,-0.096864,0.740214,0.30386,-0.581119,-0.5504,-0.30128,0.600078,0.079955,-0.328074,-0.625834,0.292687,0.154533,-0.659831,-0.386232,-0.0969865,0.0672771,-9.80637e-05,-0.601326,-0.610902,-0.422397,-0.219029,-0.0922112,-0.411578,-0.242199,0.165879,0.228781,0.407282,0.478311,-1.16414 +3399.53,0.865273,0.0848144,5,1.53128,0.869355,-0.892819,0.344907,0.480441,0.129392,-0.136035,0.402947,0.182853,-0.00194008,0.355513,0.0594077,-0.347702,0.890827,-0.374932,1.05256,0.287405,0.651872,-0.304201,-0.135053,0.215275,-0.851979,-0.581992,0.350236,0.0600357,-0.716594,0.398942,0.518093,0.25471,-0.163907,0.529101,-0.522908,0.220442,0.782769,-0.494811,-0.274969,0.13565,0.0568954,0.0471053,-0.396824,0.893399,0.218211,-0.0580053,-0.830322,-0.157337,-0.379827,-0.174365,0.408017,0.188136,0.181039,0.490206,0.0190114,0.0482136,-1.0859,0.855055,-0.299608,-0.594555,-0.160787,0.78056,-0.654896,-0.0496122,0.79923,-0.64375,-0.989379,-0.117388,0.194002,0.00533245,-0.381814,-0.145417,-0.1907,0.0766383,0.833479,0.0105277,0.0687772,0.276379,0.638201,-0.018335,-0.0111861,-0.124102,-0.217984,0.419079,-0.383952,0.223654,-0.157022,0.334259,0.190808,0.0906882,-0.0139238,0.00338011,-0.20184,0.284455,-0.560283,-0.257833,0.124412,-0.34735,-0.0930443,0.462514,-0.290312,0.35988,0.0879,-0.360287,0.183515,-0.163238,-0.322372,-0.164595,-0.508159,0.00750122,-0.624749,0.0609626,0.491756,0.202399,-0.28957,0.391489,0.311944,0.290179,0.556386,-0.703947,-0.340043,0.471781,-0.0668321,-0.938379,0.0895831,0.247013,-0.0600455,0.032932,0.446875,-0.0305353,-0.0342958,0.00221048,-0.0437466,0.580199,-0.213373,0.373721,0.652292,-0.0358922,-0.598154,0.660533,0.101303,0.35028,-0.395478,-0.406834,0.199332,0.0956434,-0.342425,0.108321,0.237749,-0.0623082,0.0663482,0.304116,0.0185692,-0.451895,-0.0168579,-0.108192,0.167401,-0.433394,0.469333,0.329242,0.0447502,0.0744733,-0.44772,0.110747,-0.205645,0.552657,0.248449,0.327273,0.289157,-0.0670086,-0.239886,-0.230165,0.222765,-0.0465147,0.239716,-0.223209,0.476749,-0.10115,0.031121,-0.523218,0.335543,0.470055,1.06051,-0.419846,-0.392894,0.370928,0.0734095,-0.106492,0.0942923,-0.860728,-0.70932,-0.496554,-0.321426,-0.32376,0.345015,-0.083217,-0.977199,-0.0261723,0.162645,-0.114999,-0.393708,-0.855243,0.146793,-0.439055,-0.0929028,1.12781,-0.711796,-0.163188,-0.102286,0.262625,1.20654,-0.516181,-0.040824,-0.424514,-0.163423,0.0981921,-0.644751,0.287616,0.561473,-0.143111,-0.0156958,0.612687,0.185867,0.232964,-0.836012,-0.306286,-0.655083,-0.00451229,0.305403,-0.540074,-0.310397,-0.7498,-0.492051,0.721107,-0.0485875,-0.00590487,0.0278124,-0.392087,0.341023,0.224623,0.487723,0.896203,-0.0716222,0.0821223,-0.268045,0.177816,-0.242606,0.0248455,-0.0341085,0.135815,0.200485,0.0810002,-0.355682,0.183045,-0.891476,0.405968,-0.345139,-0.453923,0.325705,-0.376518,-0.436479,-0.296206,-0.33288,0.168289,0.237697,0.0404363,-0.840098,-0.314232,0.310016,0.106623,-0.0996882,0.189168,-0.551157,-0.0977644,-0.226356,-0.113559,-0.228075,0.393366,-0.057867,-0.104965,0.224569,0.626882,-0.148726,-0.307487,-0.383768,-0.0105686,0.0153473,0.0123969,0.101579,-0.599354,0.290672,0.0560134,-0.26418,-0.358373,0.282747,-0.161417,-0.424712,-0.858506,-0.367418,-0.474856,-0.69066,-0.174298,-0.318373,-0.446862,0.13469,0.200797,0.367002,0.448104,-1.491 +3414.34,0.990806,0.0848144,5,1.51649,0.94544,-1.03039,0.507448,0.677047,-0.0558502,0.339,0.0136969,0.574903,0.407857,0.124503,-0.269057,0.348299,0.262166,0.177629,0.778949,0.0550338,-0.508845,0.18664,-0.211574,0.324202,-0.872755,-0.506115,0.212699,-0.222627,0.352902,0.354,0.223224,-0.601424,0.151526,0.9607,-0.462248,-0.165213,-0.0705173,-0.715435,-0.159932,-0.793404,0.516836,0.943028,-0.385447,0.779636,0.514731,0.373288,-0.740206,-0.445714,0.312876,-0.595156,-0.0581748,0.0153431,-0.133455,0.15784,0.708241,-0.123386,0.0520127,0.061499,-0.749122,-0.523089,-0.950738,0.735012,-0.428477,0.189831,1.32723,-0.988242,-1.13829,-0.170361,0.204042,-0.0662181,0.204324,-0.10365,-0.466143,-0.127464,-0.226725,0.807395,0.0437384,0.496234,0.514351,0.552761,-0.0446201,-0.271013,-0.0397369,0.428933,-0.469051,0.119447,-0.261702,-0.218427,-0.708,-0.194632,-0.299327,0.268553,-0.225672,-0.0528695,0.764088,0.303573,0.103859,0.479988,-0.448763,-0.0628682,-0.18812,-0.15674,0.318061,0.425047,-0.121522,-0.606019,-0.0678169,0.381076,-0.44944,0.325457,0.120893,0.283157,0.442999,-0.104766,-0.188893,-0.0285925,0.575169,0.134866,-0.25486,-0.0387886,0.0760008,0.0977311,0.194923,-0.245249,0.0801271,0.0781224,0.0716899,-0.0389226,-0.263225,0.259195,-0.00906876,0.554289,-0.574152,-0.358068,-0.116902,0.112331,-0.029249,-0.00142054,0.32667,-0.521298,-0.0919548,-0.00887463,-0.535457,-0.327181,-0.239114,-0.153806,-0.309659,-0.340558,-0.279604,-0.154015,0.663518,-0.393538,-0.236271,0.252444,0.334173,0.589577,0.0057043,0.680357,0.474777,-0.0201463,-0.187574,-0.11284,0.532652,0.483207,-0.0326226,0.801563,-0.0904351,-0.559962,-0.25276,-0.123018,-0.0514436,-0.182044,-0.0868275,-0.00639802,-0.215438,0.180096,0.00721549,0.0404869,-0.406409,-0.362795,-0.377886,0.0632654,0.242227,0.670203,-0.0389102,0.453486,0.0582893,-0.113776,-0.586882,0.200579,0.251221,0.790743,-0.229686,0.0764842,0.00783946,-0.140876,0.27414,0.0708331,0.278168,0.363084,-0.355453,-0.00276512,-0.179975,0.362146,-0.464755,-0.456356,0.259151,0.160252,-0.0224586,-0.825509,0.901173,0.653004,0.0260692,0.584193,0.0989919,0.292059,0.81896,-0.287423,-0.0259977,-0.253899,0.1881,0.192301,-0.271855,-0.512493,0.0822112,0.433191,0.674595,-0.599175,0.378646,-0.210515,-0.19814,0.797637,0.211055,-1.04149,0.0599839,-0.161827,-0.124259,-0.309847,-0.00614993,-0.0656421,-0.0408975,0.0919949,-0.0266352,-0.196717,0.714434,-0.307325,0.0890996,0.370596,-0.0994538,0.625108,-0.0346699,-0.389305,-0.710502,-0.406364,-0.256925,0.480521,-0.222558,0.170767,0.110623,-0.417217,0.33814,0.157831,0.0964406,-0.275599,0.411413,-0.155111,0.919481,0.495677,-0.0363417,-0.0257115,-0.186168,-0.205275,0.516035,-0.135903,-0.156453,-0.418334,0.339186,-0.379168,-0.0113722,-0.000258167,-0.182083,-0.203566,-0.139322,-0.0418815,0.161841,-0.560731,-0.240317,-0.165984,-0.117209,0.234674,-0.0120753,-0.379569,-0.0144142,0.215942,0.242182,0.304349,0.465498,-0.0581105,-0.255503,0.447906,0.307459,0.143909,0.220543,0.572497,0.113757,0.200183,0.337279,0.447418,-2.32855 +3404.45,0.907389,0.0848144,4,1.5728,0.833239,-1.23864,0.479153,-0.202964,-0.117622,-0.225244,0.310633,0.30032,-0.0641397,-0.569687,-0.334584,0.134137,0.587468,0.275031,0.834983,-0.0898924,-0.335976,-0.424797,0.0630521,-0.0942501,-0.866361,-0.443269,0.265436,0.366473,0.0426347,-0.233898,0.26529,-0.181873,-0.204571,0.963025,-0.575293,0.192614,0.0329297,-0.539842,-0.189816,-0.34605,1.03848,0.598713,-0.138349,1.04077,0.517529,0.116091,-0.829494,-0.164331,-0.289712,-0.333287,0.625859,0.261323,0.303556,-0.271494,0.13797,0.271998,-0.620615,0.126588,0.00636611,-0.193886,-0.702342,0.121404,0.155156,0.071626,1.06395,-0.526666,-1.45709,0.151067,0.194994,-0.0309516,-0.150997,0.130706,0.0563837,0.474719,0.277541,0.283972,-0.636308,0.961512,0.520291,0.727739,-0.100763,0.221989,-0.390901,0.353846,-0.204099,0.460486,-0.0828137,-0.343898,0.228199,-0.0564448,-0.156402,-0.442598,-0.305242,0.391775,-0.0744782,0.504062,-0.145311,-0.141972,0.110945,-0.328608,-0.279716,0.197086,0.364251,0.377723,0.091946,0.0401618,0.0853796,0.164969,-0.606978,0.14,0.228709,0.328941,0.927346,0.0188832,0.223335,-0.097765,0.46508,-0.140328,-0.16615,0.200367,0.122632,-0.358065,0.586346,-0.555009,0.2544,0.0690361,-0.080017,0.176391,-0.200596,-0.204415,-0.0168074,0.579506,-0.0784222,-0.297847,0.144503,-0.263068,0.480206,-0.10076,0.626571,-0.0874623,-0.401075,0.153878,-0.432185,0.428619,0.0603042,-0.25245,-0.340936,0.280197,-0.308985,0.292295,0.400801,-0.324641,-0.257769,0.123606,0.0698913,0.216532,0.0312007,0.106194,0.465872,0.224071,-0.240148,0.219107,-0.0365815,0.248392,0.0104081,0.435599,-0.404003,-0.0776028,0.179678,-0.0149914,-0.362238,-0.01468,0.182724,-0.176119,-0.00345809,0.0705272,0.109273,0.493219,0.0532458,-0.0523139,0.299448,0.290498,0.252458,0.138507,-0.238072,-0.157283,-0.439587,-0.759849,-0.431412,-0.198864,-0.396476,-0.210528,-0.060987,-0.129095,-0.391293,-0.0778921,-0.374943,0.323948,0.143422,0.221102,-0.680735,0.352915,-0.0748597,-0.303615,-0.504395,-0.171496,0.0724633,0.0906131,0.155976,-0.582633,0.654012,0.620079,-0.173613,0.187585,-0.207223,-0.179089,0.548288,-0.131269,0.179419,-0.389039,0.285324,-0.771443,-0.042012,0.559578,-0.0270471,0.40152,0.256648,-0.586141,0.716018,-0.65094,-0.489238,0.56378,0.0115917,0.211676,0.229896,0.0961188,0.615035,0.317947,0.437596,0.252279,-0.415327,0.531663,0.173795,-0.0927378,0.196239,0.280165,0.0841487,0.339524,0.33033,0.651172,0.282358,0.334385,0.0398274,-0.238923,-0.017999,0.636672,0.0377697,-0.0312414,0.500455,-0.235604,-0.0675322,-0.0496544,0.123966,0.525983,0.200476,0.0948441,0.264158,0.36292,0.532739,-0.176136,-0.0971001,-0.0833281,0.0596325,0.320387,0.22468,-0.424439,0.0218901,-0.00487032,-0.210449,0.0123375,-0.124179,0.174926,0.434302,0.0320966,-0.107903,0.267317,0.265229,0.590548,-0.235843,-0.216772,0.074317,0.15665,-0.0606806,-0.00971323,0.865162,-0.0598541,0.379496,-0.340071,-0.308515,-0.388753,-0.551921,-0.432684,-0.347248,-0.213695,0.129536,0.468601,0.359911,0.684544,0.999268 +3421.19,0.984744,0.0848144,5,1.54187,0.823381,-1.3496,0.468722,0.0656705,-0.13949,-0.0850353,0.292247,0.524693,-0.252699,-0.486145,-0.239011,-0.0514761,0.556999,0.351643,0.820123,-0.0350132,-0.330868,-0.599209,0.111478,0.0446348,-0.969245,-0.409426,0.333176,0.268559,-0.0778673,0.0502256,0.341353,-0.113703,-0.295026,0.979239,-0.692464,0.217986,-0.0770555,-0.862593,-0.23297,-0.272749,0.784749,0.638756,0.0461108,0.969036,0.432057,0.505813,-1.00277,-0.185262,-0.180194,-0.352725,0.503135,0.270092,0.19853,-0.369288,0.310824,0.235056,-0.439133,0.43591,-0.0119508,-0.326101,-0.948149,0.332332,-0.120463,-0.183542,1.20649,-0.465517,-1.51716,0.466899,0.122944,-0.0581041,-0.138659,-0.0316527,-0.078846,0.0753678,0.134134,0.612602,-0.890303,0.896102,0.631029,0.625356,-0.335679,0.157823,-0.476969,0.246535,0.0365541,0.257554,-0.259126,-0.216462,0.109223,0.0260112,-0.539844,-0.226491,-0.471396,0.0619254,-0.0867739,0.783572,-0.214625,0.182347,-0.098834,-0.20985,-0.755637,0.214594,0.437414,0.191702,-0.176078,-0.0551143,0.0473271,0.366177,-0.661714,0.200094,0.178436,0.153777,1.01027,-0.0560502,0.190349,0.278137,0.410389,-0.394917,-0.140771,0.103318,0.14295,-0.00392536,0.592238,-0.494327,-0.0054188,-0.00969038,-0.0910128,0.0697367,-0.167455,-0.247443,0.215964,0.392497,-0.0347728,-0.101562,0.050939,-0.306288,0.429126,0.141759,0.525514,-0.0282704,-0.173622,-0.021944,-0.776607,-0.0681763,0.123819,-0.355601,-0.288917,0.0959899,-0.376462,0.542998,0.154032,-0.243213,-0.33729,0.164453,0.127349,0.172532,0.161511,0.148771,-0.0735668,0.23201,-0.361172,0.0549265,0.028374,0.120825,-0.133766,0.585479,-0.284413,-0.354474,0.232746,-0.00397979,-0.488177,0.16686,-0.0808186,-0.12332,0.15283,0.164803,0.234876,0.357686,0.0901742,0.0108875,0.553703,0.439186,0.331481,-0.0430611,-0.0259749,-0.249681,-0.341434,-0.596118,-0.226551,-0.249726,-0.333887,-0.0862451,-0.245553,-0.175652,-0.245664,-0.250444,-0.364663,0.468787,0.283137,0.0653717,-0.522512,0.127621,-0.170448,-0.279713,-0.498212,0.0914501,0.190278,0.0539543,-0.00570522,-0.52538,0.881057,0.512477,-0.126863,0.269626,-0.249614,-0.292698,0.566346,-0.0258604,0.292123,-0.468139,0.258572,-0.634418,-0.0758388,0.838446,-0.0028994,0.496652,0.134313,-0.374643,0.561891,-0.367864,-0.566489,0.0921009,0.0990528,0.276415,0.3163,0.160153,0.41515,0.424016,0.467845,0.329945,-0.0938608,0.460798,-0.125442,-0.163078,0.0588433,0.45883,-0.0926556,0.0654646,0.261896,0.638221,0.271925,0.00698932,-0.0409646,-0.208921,-0.55895,0.5155,-0.196794,-0.25735,0.246083,-0.372411,0.138235,0.0579442,0.0641784,0.397756,0.306067,0.0487093,0.268247,0.241597,0.797824,-0.177161,-0.0947727,-0.0766323,0.329632,0.228603,0.22003,-0.356617,0.0972928,0.0603496,-0.248323,0.167005,0.0254082,0.234188,0.29464,0.143809,-0.408856,0.201307,-0.029342,0.422533,-0.0923536,-0.0444457,-0.223666,0.19555,-0.375527,0.10434,0.615667,0.125888,0.61051,-0.676151,-0.574949,-0.492506,-0.735094,-0.414631,-0.873582,-0.205164,0.142003,0.3004,0.376832,0.548088,0.167619 +3444.59,1,0.0848144,4,1.56504,0.995706,-0.85823,0.345385,0.15226,-0.0904504,0.0473161,0.315395,0.424762,0.0560823,-0.262466,-0.584881,0.258096,0.52873,0.14577,0.789313,0.0718769,-0.537024,-0.301552,-0.105476,0.177854,-0.695854,-0.659907,0.24303,0.0126039,-0.170934,-0.154427,0.237308,-0.130693,-0.0676526,0.937746,-0.412622,0.222204,-0.100555,-0.647007,-0.163448,-0.179122,0.672827,0.400174,0.0852782,0.87941,0.355286,0.507818,-1.03431,-0.190968,0.0493607,-0.183961,0.202164,-0.00858653,0.253589,-0.135538,-0.295919,0.0332237,-0.677597,0.2615,-0.176788,-0.218063,-0.961958,0.292011,-0.375762,-0.349173,1.07011,-0.629266,-1.02678,0.337254,0.323359,-0.0562683,-0.0974221,-0.1196,0.0462013,-0.345992,-0.0938303,0.523316,-0.585104,0.864634,0.761644,0.877472,-0.574127,0.105366,-0.469682,0.208491,-0.0725775,0.321129,0.0084675,-0.205254,0.143933,-0.084987,-0.223804,-0.233552,-0.492983,0.190034,-0.0978054,0.384173,-0.160377,-0.241832,-0.524648,0.0282962,-0.505452,0.175109,0.224457,0.0413112,0.238623,-0.196475,0.470914,0.163713,-0.781515,0.0543649,0.0567547,-0.25724,0.973648,-0.357363,-0.186262,0.386388,0.402532,-0.502975,-0.053159,0.0701579,0.404449,0.108221,0.209485,-0.579988,-0.288359,0.0925371,-0.332922,-0.38487,-0.381911,-0.132837,-0.119491,0.574022,-0.0996647,0.0710811,0.0272316,0.0565731,0.76712,0.322021,0.710515,-0.0412061,0.115441,0.212194,-0.872662,-0.369697,-0.156441,-0.148982,-0.194599,0.14231,-0.375586,0.378342,0.357537,-0.280712,-0.24439,0.0663957,0.20343,-0.0832903,0.527422,-0.0085267,0.326412,-0.0161316,-0.194365,0.0106187,0.0478082,0.00199116,0.0237507,0.951924,-0.0202191,-0.00389845,0.0325105,-0.0208577,-0.462422,0.0598444,-0.127615,0.319196,0.00981806,0.0339222,-0.367714,-0.149251,-0.0305242,-0.124898,0.186526,0.433637,0.468836,-0.150548,-0.0929264,-0.0327614,-0.572249,-0.451965,-0.282586,-0.282767,-0.142189,0.0682471,-0.0924424,-0.0929958,-0.271282,-0.147451,-0.556544,0.287472,-0.0134688,0.169347,-0.642599,-0.425393,-0.0183918,-0.0691385,-0.44967,-0.0931615,0.142795,0.30854,0.201414,-0.198302,0.782562,0.386306,0.0723284,0.281637,-0.201756,0.223577,0.92059,-0.454422,0.315621,-0.220943,0.0188663,-0.373668,0.186297,0.441261,-0.130016,0.508157,0.125768,-0.257472,0.70041,-0.398596,0.0820939,-0.115725,-0.362163,-0.119327,0.159912,-0.0459716,0.228067,0.00579883,0.300615,0.327971,-0.00347732,0.299239,-0.159757,0.15624,0.388303,0.726272,-0.334924,0.230605,0.476479,0.710452,0.362858,0.00446123,0.257488,-0.104368,-0.719433,0.512614,-0.128764,-0.360662,0.00532798,-0.65529,0.312556,0.0615649,-0.145101,0.0997441,0.518207,-0.00165138,0.082907,-0.257643,0.275777,-0.156255,-0.0956345,-0.0966348,0.131706,-0.107926,-0.0286503,-0.0327554,-0.00891806,-0.210427,-0.515929,0.198153,-0.143359,0.132673,0.431331,0.363901,0.0114075,-0.142714,-0.116387,0.249172,0.14125,0.0436425,-0.167075,-0.129478,-0.230853,0.0318921,0.404677,0.0708088,0.041767,-0.541656,-0.550815,0.0246838,-0.0862323,-0.542271,-0.460623,-0.0564145,0.096019,0.253341,0.309869,0.50333,-0.554799 +3447.64,0.998425,0.0848144,4,1.64794,0.908241,-0.784873,0.222696,0.22605,-0.0807661,0.0658835,0.561014,-0.12249,0.616845,-0.149757,0.128694,0.186182,0.339808,0.145374,0.864117,-0.242181,-0.00661852,0.0458405,-0.317274,-0.233628,-0.605697,-0.51113,0.131341,-0.151903,-0.190152,-0.0274151,0.0860231,-0.204914,0.220481,0.789075,-0.268805,-0.634691,0.0371432,-0.0572032,0.00782293,-0.104671,-0.38772,0.303381,-0.531832,0.93348,0.489182,0.0875306,-0.602199,-0.383814,-0.270946,-0.886438,0.18497,0.270332,-0.0541059,0.0523772,-0.220976,0.301527,0.0157008,0.726029,-0.00264666,-0.188718,-0.0496343,0.404705,-0.199154,0.258695,1.1256,-0.651526,-0.666256,0.188732,0.281487,-0.190504,0.0509488,0.158607,-0.310959,0.170249,-0.0807053,0.583261,-0.0124749,0.199436,0.599269,0.135086,-0.12881,-0.00959913,0.258989,0.2486,0.340691,0.236124,0.00956638,0.160587,0.221349,0.254383,-0.2424,-0.0106265,-0.11769,0.146213,0.188753,-0.0134009,0.0166658,0.207969,-0.326084,0.283042,0.144274,-0.237022,0.283165,0.272404,0.378292,-0.182186,-0.807252,0.287225,-0.519887,0.35773,0.315017,0.0741215,0.495995,0.153773,-0.383896,0.248787,0.411646,-0.303906,0.336505,-0.283526,0.0418022,0.535225,0.791534,-0.674151,-0.455877,0.293004,-0.18107,0.23445,-0.0352421,0.0210357,-0.211713,0.213478,0.262659,0.0230673,-0.183816,-0.417045,-0.114953,-0.278422,-0.414086,-0.305941,0.431236,-0.199674,-0.204233,0.0286041,-0.0150266,0.0736725,-0.0775645,-0.1148,0.184614,-0.174032,0.0886137,-0.0342948,0.352482,-0.282973,0.284925,-0.0304017,-0.330156,0.110941,1.04628,0.163028,-0.202134,0.11748,0.054868,0.199847,0.175363,0.394041,0.354169,0.146955,0.365474,0.422665,0.089674,-0.332236,-0.338294,-0.324122,0.00769182,0.00655311,0.167851,-0.108391,-0.237384,-0.177853,-0.241455,0.0184046,0.330978,0.0881666,-0.56555,0.0564078,-0.178381,-0.53262,-0.211324,-0.277746,-0.40377,-0.111624,-0.397682,0.0525735,0.0808576,0.22896,-0.465202,0.0922592,0.0443152,0.160495,-0.743419,-0.78453,-0.375473,0.0628528,0.0406539,-0.442923,-0.119705,0.0117485,-0.361557,-0.378635,0.734958,-0.476944,0.289165,0.106863,-0.128021,-0.0297378,-0.552546,-0.169286,-0.102535,-0.274012,-0.032833,-0.668497,-0.345967,0.114024,-0.425934,0.185705,0.00973597,-0.0432251,0.427648,0.0275632,-0.0418651,-0.246065,0.147698,0.0959643,-0.0534705,-0.602374,0.100358,-0.482146,0.352017,-0.0325296,0.0612006,-0.164806,0.240723,0.417133,-0.0088173,0.0486442,0.168759,0.404498,-0.609096,0.0269217,-0.0519033,-0.651227,-0.434123,-0.359669,-0.886666,0.706983,-0.247043,-0.116845,0.259974,-0.223295,-0.182304,-0.218653,0.0230206,0.187747,-0.0625013,0.207353,0.228506,0.283325,0.00222113,0.054302,-0.160115,0.0719427,0.0261646,0.11918,-0.652992,-0.436247,0.133818,0.23974,0.170586,0.365435,0.140023,0.116958,-0.274133,-0.354271,0.296591,0.0847642,0.0898915,0.462673,-0.386686,0.190259,0.643569,0.196085,-0.142482,0.0382649,-0.355384,-0.0192295,0.0118848,-0.107461,-0.088196,0.215375,-0.300214,-0.104413,-0.0708016,-0.120211,0.10519,0.130435,0.32433,0.361157,-0.486845 +3429.66,0.900206,0.0848144,5,1.51568,0.952938,-0.276974,0.13516,0.0119229,-0.0507829,0.232823,0.166452,0.645907,0.419334,0.0737736,-0.511407,0.312145,0.674542,-0.0501136,1.07387,0.5061,0.307935,0.169999,0.136647,-0.098051,-0.678617,-0.0438768,0.214951,0.0157824,-0.0332165,0.27527,0.133652,-0.2331,0.242855,0.611551,-0.327343,0.144872,0.351354,-0.575801,0.0880399,-0.146497,-0.0211614,0.270983,-0.253718,0.733352,0.215403,0.127388,-0.915064,0.259785,0.052852,-0.366033,-0.110895,0.00111393,-0.248201,-0.10072,0.106708,0.209008,-0.304235,0.576789,0.250845,-0.199273,-0.484025,0.097863,-0.470197,0.0523333,0.919704,-0.544113,-1.1104,-0.209537,0.225161,0.275355,0.188782,-0.227596,0.00814155,0.288901,0.0560266,0.555073,0.185537,0.73174,0.702132,0.455558,-0.363145,-0.0811054,0.116301,-0.233506,-0.26817,0.170953,-0.429404,-0.0235834,0.151756,0.149753,0.138924,0.16829,-0.182058,0.313666,-0.104219,0.0275227,-0.0811057,-0.454281,-0.249962,-0.0908758,-0.281709,0.180454,0.312354,0.458128,0.32138,-0.168953,-0.0753743,0.0925179,-0.216384,-0.0583316,0.301323,0.466098,0.859905,-0.364554,0.135434,-0.148349,0.38437,0.0155193,-0.262841,-0.242903,-0.185085,0.397081,-0.329723,-0.578425,0.753444,-0.401921,0.403168,-0.508059,0.147778,-0.131389,-0.0799405,0.206878,-0.313288,-0.185169,0.204939,-0.30007,0.42432,-0.390653,0.225005,-0.433777,-0.211501,0.328657,-0.265407,-0.086103,0.307368,-0.333026,0.458091,0.109909,-0.0991698,-0.558068,0.185917,0.135123,-0.620447,-0.0847419,-0.0404301,0.102534,-0.121488,-0.319694,0.815542,-0.168741,0.103877,0.295346,-0.545446,0.626995,-0.276776,0.564059,-0.198078,-0.0439126,0.435936,0.115539,0.0847103,0.200616,-0.551751,0.124476,-0.444443,-0.232075,-0.110581,0.123671,-0.185103,0.21088,0.393562,-0.528163,0.720872,0.0480618,-0.211142,0.289152,-0.371168,-0.301701,0.163626,-0.0933251,-0.21675,0.185664,-0.33358,-0.207752,0.113274,0.199542,-0.47626,-0.473562,0.388403,0.443822,-0.152674,-0.292442,-0.210096,-0.00793526,0.0722093,0.200975,-0.079869,-0.229852,0.598488,-1.07442,1.31515,-0.231965,0.777344,-0.390561,0.11421,0.100112,-0.0393572,-0.437245,0.18725,0.0334731,0.0876684,0.0234253,-0.0356558,0.173718,-0.566459,-0.107695,-0.503655,-0.52798,0.575148,-0.360339,-0.135239,0.0149721,-0.38655,-0.208537,0.2799,-0.0428845,0.0977328,-0.607423,0.728451,0.153739,-0.0834428,0.474987,-0.167727,-0.843766,-0.0236411,-0.116904,-0.529342,-0.0381843,0.132456,0.388277,0.356038,-0.618431,-0.350486,-0.0181892,-0.901314,0.106743,-0.527432,-0.0905388,0.227326,-0.247433,0.0591646,0.278005,0.123683,-0.10018,-0.0312989,0.00563041,0.335901,0.608736,0.252212,0.17835,0.0233334,0.492995,0.196408,-0.456769,-0.0426586,0.371775,-0.302771,-0.0673199,0.00863806,0.213343,-0.150493,0.108019,0.217527,-0.0871055,-0.621652,-0.27146,0.052115,0.0925222,0.0811795,0.0656376,0.506336,-0.329358,0.129521,-0.115812,0.169123,-0.0988035,0.133905,-0.0257016,-0.217441,0.160038,-0.387736,0.377941,0.206546,0.380625,0.0956032,0.228102,0.309198,0.477601,-0.178612 +3433.51,0.997596,0.0848144,4,1.58436,0.926626,-0.40128,0.204139,0.21098,-0.0154681,0.345682,0.306323,0.818771,0.377548,-0.0496715,-0.370197,0.278251,0.655398,-0.149654,1.00226,0.449601,0.364562,0.18054,0.181731,-0.193266,-0.588748,-0.0657451,0.28167,0.0145286,0.0849914,0.14075,0.203106,-0.389131,0.177346,0.638885,-0.335505,0.133894,0.441169,-0.62437,0.00640089,0.0504134,0.0393312,0.320739,-0.322464,0.677636,0.0646701,-0.0292639,-0.692223,0.188354,0.071007,-0.414359,-0.186363,-0.0209382,-0.247562,0.123914,-0.026798,0.143336,-0.433557,0.625054,-0.114867,-0.0772453,-0.644285,0.00714472,-0.432689,0.160685,0.964738,-0.754993,-0.819704,0.223224,0.10428,0.369803,0.338597,-0.0557583,0.248352,0.073527,0.104175,0.515825,0.176257,0.602671,0.551319,0.207701,-0.0265749,-0.222603,0.0278723,-0.251265,-0.245417,0.0963344,-0.633608,0.13984,-0.054323,0.140125,-0.167858,0.308114,-0.206674,0.127476,-0.149687,-0.139107,-0.0455697,-0.0908064,-0.484911,-0.383434,-0.261615,0.141454,0.218965,0.481382,0.387883,-0.122811,-0.248659,0.198478,-0.421808,-0.0655892,0.372732,0.480445,0.616016,-0.390305,0.28708,-0.392963,0.428636,0.126514,-0.522777,-0.247793,-0.29317,0.631114,-0.211453,-0.280792,0.571565,-0.340619,0.123449,-0.548963,0.261974,-0.251291,-0.0805218,0.236182,-0.340493,-0.110469,0.29161,-0.245155,0.516332,-0.492206,-0.179447,-0.441218,-0.0471011,0.22679,-0.0661035,-0.105031,0.0971963,-0.272305,0.313162,0.0839435,-0.0968063,-0.674883,0.277112,0.1857,-0.517506,0.200562,-0.071543,-0.00213996,-0.0652239,-0.121933,0.740172,0.090927,-0.136949,0.208164,-0.499634,0.404003,-0.464132,0.64853,-0.263145,0.270217,0.602643,0.0426841,0.248457,0.0226577,-0.468607,0.274471,-0.179898,-0.160813,0.24766,0.0284614,-0.387717,0.385592,0.461843,-0.52485,0.67643,0.0417493,-0.430928,0.120341,-0.161268,-0.554797,0.34045,-0.158645,-0.104375,0.086079,-0.539034,-0.127892,0.0430674,0.202936,-0.527007,-0.462425,0.408398,0.538028,0.158008,-0.297192,-0.221365,0.00624712,-0.175513,0.192814,-0.0271102,-0.124608,0.122486,-0.730595,1.32285,-0.0147021,0.465825,-0.453908,0.20635,-0.00487317,0.00126989,-0.197659,-0.0773033,0.082713,0.225317,0.29906,0.17357,0.0841172,-0.523505,-0.192151,-0.660824,-0.797027,0.435577,-0.299154,-0.181518,0.0563346,-0.547941,-0.0391492,0.239141,0.187784,0.130168,-0.37231,0.745383,0.16584,-0.345942,0.552636,-0.059203,-1.02529,-0.294965,-0.134928,-0.323557,0.288581,0.24745,0.581708,0.368792,-0.48362,-0.240906,-0.0617936,-0.71086,0.0101032,-0.331522,-0.078451,0.339151,-0.288256,-0.0801947,-0.0299155,-0.00243572,0.123524,-0.200542,-0.142112,0.0220221,0.858624,0.289026,0.252362,0.0882294,0.0969516,0.0283115,-0.373151,0.00956339,0.325141,-0.206604,-0.0883998,0.28465,0.377839,-0.258889,0.028301,-0.00824913,-0.143557,-0.590242,-0.309343,0.189841,0.127255,0.152256,-0.129404,0.561217,-0.260531,-0.107482,-0.200942,0.115838,-0.0418981,0.244002,0.191042,-0.488937,0.153606,-0.302184,0.148469,0.0832904,0.250066,0.115635,0.21889,0.340051,0.467857,-0.733176 +3416.65,0.971971,0.0848144,4,1.50968,0.989394,-0.615087,0.229913,0.150576,-0.0959058,0.2161,0.417577,0.341615,0.505519,-0.322874,-0.0578535,0.119588,0.165255,0.377884,0.655009,0.249991,0.089035,-0.0243317,-0.296664,-0.154765,-0.695673,-0.334273,0.0500489,-0.209361,-0.225599,0.210699,0.437392,-0.242054,0.248,0.792074,-0.142708,0.227632,0.5668,-0.190491,-0.109075,-0.138161,0.784453,0.475974,-0.478209,0.827293,0.165613,-0.463241,-0.824862,-0.361651,0.353781,-0.247712,-0.0983855,0.535358,0.0986504,0.0499682,0.599163,0.0431209,-0.615307,0.767876,-0.136908,-0.476304,-1.01817,0.358968,-0.71184,-0.0594643,0.517363,-0.83566,-1.33277,-0.104081,0.399852,0.273703,0.267954,0.193499,-0.103892,0.0881561,0.0569722,0.801745,0.403131,1.00444,0.471053,0.317791,-0.314099,0.323116,0.161446,0.140003,-0.236579,0.49,-0.0197318,0.0563333,-0.206342,-0.0922279,-0.250891,-0.193462,0.057995,0.245762,-0.532268,-0.263359,0.161956,-0.354427,-0.106074,-0.559886,-0.35392,-0.037899,0.384105,0.121629,0.259423,-0.285989,-0.0747806,-0.281332,-1.43335,-0.294004,0.0172034,0.498309,0.483925,0.368415,0.0694615,-0.222593,0.208897,0.184676,-0.0827677,0.111725,-0.0264096,0.536377,0.101546,-0.467317,0.0941004,-0.319245,-0.292605,-0.568255,0.165573,0.0389689,0.046194,0.432028,-0.245199,0.228227,0.0178534,-0.390594,0.564854,-0.036978,0.204553,-0.0164484,-0.175043,0.348873,-0.468768,-0.516615,0.115132,-0.0314068,-0.0818442,0.29108,-0.0513886,-0.226008,0.120516,-0.0734851,-0.198602,-0.0292194,-0.0327663,-0.115283,-0.14703,0.302167,0.653546,-0.116749,-0.107254,0.167616,-0.170598,-0.178501,-0.21713,0.388713,-0.0428677,0.534374,0.949601,-0.0827049,-0.206372,-0.472854,0.336822,0.443241,-0.287442,-0.303057,-0.226366,-0.0229251,-0.505232,0.198772,0.0771336,-0.195324,1.12347,-0.0972973,-0.439511,0.0251891,-0.248332,-0.267395,0.0156272,-0.324887,-0.451475,0.3411,-0.651837,0.305524,-0.124248,-0.0667031,-0.59061,-0.474361,0.196583,0.201037,-0.208846,-0.607909,0.137621,0.243727,0.0456547,0.230875,0.115117,0.364688,0.687526,-0.307852,0.711248,0.286748,0.272188,-0.0486034,-0.235602,0.649343,0.132559,0.397454,-0.118171,-0.105953,0.243051,0.616624,-0.239647,0.204777,-0.467931,-0.0907408,0.11668,-0.684422,0.504914,-0.263517,0.230957,0.232634,-0.504432,-0.583803,-0.380483,-0.581404,0.163955,-0.524675,0.386821,0.273372,0.587779,0.613588,-0.282283,-0.686587,-0.349805,-0.294939,0.0517062,0.153311,-0.81579,0.304297,0.813518,-0.69974,0.00643239,0.123388,-0.426754,0.0469206,-0.139927,-0.301761,0.264932,-0.4889,0.0899029,-0.291413,0.124819,0.0272525,0.0596567,-0.216425,-0.181205,0.785528,-0.106439,0.154038,0.48435,-0.0902031,-0.482626,0.241021,-0.556022,-0.605412,0.274128,-0.321454,0.550974,0.56223,0.0566755,0.47355,0.00878935,-0.0247195,-0.546398,-0.683796,0.436333,-0.170853,0.274539,0.309061,0.548533,0.0911908,-0.165759,-0.0898833,0.335377,-0.0637856,0.505946,-0.182196,-0.540848,0.153097,-0.417468,0.101077,0.31334,-0.00440763,0.141748,0.224544,0.376495,0.473861,-0.610288 +3399.09,0.935804,0.0848144,4,1.65062,1.08925,-0.461932,0.15304,0.407334,-0.0366177,0.236559,-0.063816,0.41245,0.835403,0.00938106,-0.803824,0.0584071,0.121326,-0.206082,0.673817,0.0166111,-0.138222,0.330326,-0.0870774,-0.563683,-0.625308,-1.43886,-0.0751498,0.0784807,-0.267773,0.0857845,0.442463,-0.833047,0.116236,0.413126,-0.0901196,0.232365,0.280099,-0.380574,-0.560287,-0.507744,0.479216,0.591105,0.0284422,0.570748,0.477983,0.075637,-0.611238,-0.161442,0.200559,-0.730956,0.038144,-0.223587,-0.196364,0.000904746,0.0902705,0.046888,-0.909528,0.713811,-0.389971,-0.176207,-0.609506,0.0212849,-0.431289,-0.137433,0.536424,-0.121367,-0.473813,-0.302217,0.227421,0.202512,0.205417,0.553528,-0.0976981,0.253787,0.750092,0.823841,0.181124,0.875191,0.655705,0.732112,-0.191508,-0.126253,0.0617241,-0.458009,-1.00965,0.114966,-0.271875,-0.363939,0.00586709,1.02532,-0.238275,0.34536,-0.381289,-0.0969915,-0.182337,-0.370033,-0.0850367,-0.0857312,-0.117724,-0.25772,-0.290287,0.36905,0.477461,0.0732239,0.733204,-0.0864402,-0.125059,-0.0165384,-0.888222,0.126355,0.0316702,0.570793,0.33709,-0.0979663,-0.251296,-0.242629,0.0964001,0.462963,-0.131575,-0.100713,0.490386,0.787211,0.383059,0.183516,0.232464,-0.466243,-0.187894,-0.171793,0.4326,-0.203435,-0.26712,0.13825,-0.0650087,0.361048,0.08197,0.103035,0.136861,-0.112449,0.14006,-0.286948,-0.162725,0.569519,0.0535784,-0.355922,-0.0406776,-0.255112,-0.268807,0.046466,0.529746,0.296744,0.449386,-0.222303,0.31619,-0.403365,-0.325402,-0.250553,0.261077,0.403528,0.335227,-0.138625,0.373462,0.317867,-0.0626561,0.593332,-0.224739,0.88268,0.343453,0.505904,0.0468025,0.405753,-0.487507,-0.0423574,0.314169,0.342474,-0.014527,-0.379825,0.0819418,-0.00398236,-0.0300852,-0.540274,-0.446029,0.0385268,0.981233,-0.247082,-0.495647,0.267756,-0.291586,-0.449834,-0.0204503,-0.763932,-0.0745077,0.673873,-0.516704,0.251445,-0.116717,0.822595,-0.903936,-0.53896,0.112886,0.287331,-0.465223,-0.588248,0.028451,0.00710379,-0.45503,0.266964,0.242162,-0.15217,0.711874,-0.493503,1.17135,0.0432219,-0.164171,-0.198253,-0.25761,0.938286,-0.104244,-0.253536,-0.148314,-0.567506,0.202955,0.679114,-0.386519,-0.01755,-0.623377,0.356426,0.485189,-0.177642,0.745727,-0.373527,-0.275871,0.29095,-0.0335293,-1.06656,-0.192517,-0.629743,0.234018,-0.337591,0.638863,0.156003,0.0283995,1.08197,0.435133,-0.285119,-0.295115,-0.696456,0.254552,0.758307,-0.266861,0.230881,0.399418,-1.03408,-0.16097,-0.527031,-0.488879,0.185465,-0.220321,-0.696639,0.575986,-0.341815,0.160742,-0.133323,-0.0859984,-0.110262,0.325195,0.394964,-0.283023,0.818024,-0.00845123,0.252666,-0.108709,0.0793561,-0.2047,-0.522552,0.0672629,-0.565007,0.11643,-0.0615648,-0.212702,0.338619,0.370123,0.0339227,0.0565237,0.141433,-0.205017,-0.683766,0.0679747,-0.0199913,-0.324126,0.026619,0.139016,-0.143398,0.293426,-0.416438,0.73778,0.194504,0.163548,0.287235,-0.810457,0.0766943,-0.587843,-0.310915,-0.176414,-0.301393,0.170224,0.200139,0.412582,0.447369,-1.52067 +3412.57,0.893461,0.0848144,4,1.64684,1.12008,-0.224883,0.0245501,0.575782,-0.183882,0.275975,-0.0805993,0.253885,0.0159294,-0.253785,-0.318467,-0.0667302,0.0820283,-0.274095,0.711481,0.0360354,0.238279,-0.154099,-0.310118,-0.585889,-0.649385,-0.333402,-0.0164461,-0.136558,0.156682,0.187062,0.210982,-0.253141,-0.143265,0.6217,-0.338458,0.106904,0.566703,0.0385766,-0.637245,-0.492334,0.26778,0.460967,-0.261937,0.878808,0.210022,-0.301216,-0.858851,-0.287138,-0.264106,-0.484163,0.098969,0.436116,0.0477884,0.140629,0.130082,0.0149633,0.305505,0.613408,-0.104736,-0.162617,-1.20022,0.464397,-0.772246,0.141176,0.738531,-1.68698,-0.630897,-0.171974,0.164132,0.111546,-0.278386,-0.314538,-0.584532,0.569985,0.0805523,0.36515,0.213501,1.01264,0.349721,-0.395326,-0.101223,-0.729252,0.30022,0.288268,-0.369748,-0.000167965,0.134815,-0.0704919,-0.0617491,-0.590886,-0.251454,0.11176,-0.174963,0.477027,0.210265,-0.452014,-0.290432,0.78843,-0.480746,-0.363787,-0.33539,-0.834855,-0.0395255,0.0684517,0.668675,-0.533537,-0.567374,0.651225,-0.219584,0.500332,0.120878,0.229254,0.511003,0.26851,-0.596517,0.0853086,0.360505,-0.474746,-0.173285,-0.297004,-0.23862,0.336192,0.0794779,-1.42047,-0.0890939,0.0305009,-0.171509,0.0312363,-0.162299,0.0444884,0.170392,0.0559393,-0.0977676,0.0798547,-0.0154517,-0.126314,0.767942,-0.436187,-0.46526,-0.0244281,0.0366766,0.522796,-1.24604,-0.652326,-0.16795,0.139639,-0.304806,-0.545579,0.0058327,-0.0166455,0.342915,-0.0563002,-0.473425,0.148869,-0.410805,0.209296,0.533473,-0.0271693,0.733643,-0.0295473,-0.551834,0.00626236,-0.0742818,0.0241629,0.167358,0.736353,0.0755387,-0.0123028,0.0246503,-0.207392,0.138139,-0.360425,0.19287,-0.006883,0.236957,-0.00498646,-0.618923,-0.20832,0.176318,0.142789,0.544482,0.321175,0.520612,-0.36414,-0.59716,0.322895,0.544209,0.607237,0.255544,0.00418002,-0.369636,0.341637,-0.214493,0.132219,0.387069,-0.494869,-0.0425417,0.270606,0.341541,-0.213248,-0.0260205,-0.755334,0.139919,-0.329577,0.178043,-0.0989883,-0.697858,-0.0643254,-0.126615,-0.701708,0.804135,-0.539753,0.236842,-0.363629,-0.401679,0.309916,0.302097,-0.144253,0.293109,-0.0609619,0.269264,-0.194995,-0.0121606,-0.247853,-0.109039,-0.723391,0.22404,-0.572029,0.448931,-0.154621,0.0494635,-0.164849,0.146096,0.196407,-0.0064914,-0.0892673,-0.345952,-0.65317,0.352953,0.146297,-0.00400951,0.481876,-0.640308,0.135371,0.0395334,0.180467,0.79103,0.545221,0.467006,0.269016,0.154538,0.0695995,-0.291221,0.558804,0.0670046,0.700824,-0.693187,-0.179405,0.101374,-0.0548691,-0.416325,0.605091,-0.0380529,-0.466303,0.275517,-0.00352619,0.298448,0.483586,-0.0494166,-0.0313216,-0.0818705,0.23052,-0.266644,-0.226033,-0.161214,0.209838,-0.302092,-0.254412,-0.332507,-0.147333,-0.127804,0.217929,0.439294,-0.477279,0.200932,-0.313164,0.233154,0.521885,0.192206,-0.213371,0.616544,0.396456,-0.220613,0.175907,-0.134996,-0.22208,0.663026,-0.1593,-0.307048,-0.406245,0.186432,0.172331,-0.552931,-0.0755353,0.135216,0.241939,0.367718,0.491873,-2.10404 +3439.3,0.983268,0.0848144,4,1.65516,0.992889,-0.168933,-0.0285031,0.303762,-0.214061,0.162129,-0.108036,0.232389,0.0858162,-0.301038,-0.34868,-0.0257431,0.229497,-0.291759,0.86222,-0.112984,0.190024,-0.189199,-0.0154968,-0.778895,-0.875003,-0.779749,0.103657,-0.204252,0.286652,0.473787,0.469326,-0.21613,0.115015,0.659867,-0.547681,0.294648,0.549206,-0.0278731,-0.353585,-0.403184,0.127946,0.357166,-0.131207,0.929372,0.211193,-0.213132,-0.58687,-0.164574,-0.450335,-0.328186,0.0822956,0.135036,-0.197941,0.0567456,-0.125865,0.29208,0.153779,0.915041,-0.117154,-0.257547,-0.927297,0.441516,-0.619384,0.232847,0.727445,-1.3589,-0.43002,0.245567,0.0284984,0.180232,-0.280238,-0.206575,-0.477358,0.649761,-0.0830957,0.516179,-0.191235,0.905899,0.450934,-0.0249185,-0.176781,-0.590636,0.553483,0.392716,-0.274616,0.326116,0.286439,-0.27988,0.179597,-0.495277,-0.183077,0.0561093,-0.170792,0.421543,-0.0864187,-0.20593,-0.170643,0.639021,-0.206904,0.0153476,-0.457985,0.0380906,0.0888064,-0.101814,0.384657,-0.221042,-0.65175,0.50605,-0.123624,0.77183,0.226724,0.139106,0.417866,0.331386,-0.429873,-0.182537,0.394856,-0.0281356,0.134739,-0.408611,0.14036,0.410784,0.195539,-0.963566,0.248424,-0.152311,-0.514038,0.301087,-0.105775,-0.23254,0.112824,0.174854,-0.547319,-0.00822833,0.0608556,0.195685,0.596977,-0.110428,-0.310672,0.175933,0.093404,0.572085,-0.559543,-0.931378,-0.227634,0.40153,-0.544214,-0.434614,0.254512,0.0456357,0.4693,-0.184389,-0.332259,0.107913,-0.335193,0.0109507,-0.141009,0.0658826,0.586034,0.366348,-0.360655,-0.106153,-0.075049,0.0124067,0.0427031,0.708723,0.325811,-0.134851,-0.0479054,0.0333251,-0.239468,-0.59216,0.0374019,-0.17809,-0.13724,0.0456746,-0.497154,-0.0706093,0.405478,-0.11388,0.364835,0.284025,0.393159,0.0084776,-0.486158,0.601432,0.376405,0.189969,-0.0404651,0.209258,-0.412211,0.434063,-0.106749,0.257503,0.468123,-0.614258,-0.412302,0.0336159,0.635704,0.0509125,0.0280621,-1.11093,0.012931,-0.296221,-0.00199779,0.0279107,-0.288427,0.0848146,-0.308922,-0.742114,0.734824,-0.284225,0.234147,-0.254321,-0.310767,0.3101,0.26723,-0.127016,0.059672,0.196731,0.276721,-0.422775,-0.0729397,-0.0456888,-0.14724,-0.436469,-0.184925,-0.656013,0.462892,0.114722,-0.0604281,-0.133594,0.173675,0.0261582,0.16052,-0.322252,-0.250866,-0.428284,0.492756,0.162893,-0.454438,0.677124,-0.764357,0.0692432,-0.226974,0.291195,0.440903,0.344305,0.348124,0.398139,-0.0611652,-0.00837714,-0.375774,0.564835,-0.136832,0.424565,-0.61862,-0.047463,0.150517,-0.0148434,-0.683679,0.526004,0.0552827,-0.461255,-0.131685,-0.00271194,0.298381,0.369798,-0.240125,-0.0562265,-0.0150106,-0.0360892,-0.0437294,0.114449,-0.205851,-0.19886,-0.487164,-0.614051,-0.213354,-0.230871,-0.0855898,-0.151999,0.414516,-0.39071,0.142584,-0.786246,-0.0107257,0.370672,-0.133594,-0.246656,0.386711,-0.0928123,0.0219102,0.276358,-0.468535,-0.201528,0.442632,-0.0954181,-0.27092,-0.300435,0.228202,0.20048,-0.665817,-0.376336,0.126223,0.263202,0.355279,0.513032,-0.939341 +3440.75,0.621824,0.0848144,4,1.62763,1.05808,-0.20016,0.0239311,0.599897,-0.169764,0.00392185,0.233707,-0.0253928,-0.131699,-0.118781,-0.503809,0.119611,0.348218,-0.417865,0.788757,-0.290587,0.0763079,-0.0692629,0.0358477,-0.599836,-0.963085,-0.581825,-0.00303001,-0.507577,0.231442,0.451245,0.33387,-0.180675,-0.0520174,0.658538,-0.338975,0.188758,0.490821,-0.305669,-0.460756,-0.151206,0.000361762,0.174583,-0.289739,1.05989,0.144341,0.332658,-0.748293,-0.108968,-0.404229,-0.430165,0.246439,0.262501,-0.010633,-0.101984,-0.113684,0.222676,-0.253974,0.689691,0.0291642,-0.213161,-0.781512,0.474746,-0.946522,-0.0668415,0.770217,-1.52768,-0.505842,-0.475556,0.721474,-0.250127,-0.093737,-0.0679855,-0.261896,0.400901,0.131715,0.634015,-0.185011,0.574854,0.538009,0.0511083,0.0546319,-0.743549,0.622077,0.542903,0.0681901,0.170917,0.19382,0.00756335,0.209764,-0.462894,-0.310518,-0.195711,-0.404086,0.319248,-0.00589635,0.113586,-0.142261,0.0468909,-0.259418,0.105865,-0.581715,0.0724884,-0.0529147,0.0559355,0.534499,-0.130908,-0.681861,0.45309,-0.100609,0.568302,0.376612,0.458299,0.58899,0.129163,-0.291923,-0.154909,0.320543,-0.176313,-0.0241777,-0.351899,0.335159,0.148434,-0.0360417,-0.820545,0.382935,-0.460934,-0.621661,0.363559,-0.216618,0.115013,0.338622,0.293562,-0.796536,0.229233,0.0589469,0.180929,0.705818,-0.260491,-0.297109,0.206425,-0.241643,0.468664,-0.49655,-0.973192,0.0261062,0.214293,-0.472552,-0.191381,0.00527324,-0.182488,0.483174,-0.00860858,-0.140676,-0.384578,-0.367618,-0.0752287,-0.0452668,0.0969057,0.717178,0.0990849,0.0648918,-0.126674,-0.153951,0.271885,-0.0298811,0.434414,0.0822903,-0.0057581,-0.0652346,-0.0904655,-0.439222,-0.422586,0.318257,-0.0665258,-0.0643227,-0.0563544,-0.627751,-0.0767482,0.752154,-0.152452,-0.337454,0.338146,0.342713,0.363474,-0.649856,0.591756,0.0222711,0.320967,-0.0877874,0.293644,-0.211144,0.588433,0.0753603,-0.0915405,0.234989,-0.388232,-0.373527,-0.0554789,0.518633,-0.196291,0.0334738,-0.872957,0.446672,-0.086153,-0.21999,0.171969,0.0546301,0.318656,-0.272478,-0.61352,1.00116,0.0288379,0.048528,-0.320188,-0.296713,0.306132,-0.106927,-0.189873,0.190772,-0.160771,0.163222,-0.0678449,-0.0450403,0.194859,-0.176748,-0.140711,-0.20586,-0.43564,0.422619,0.245562,0.32673,-0.112141,0.368876,-0.127694,0.228709,-0.359529,-0.0443644,-0.605928,0.502729,0.106612,0.0482892,0.491697,-0.433397,0.0115936,0.0161619,0.536096,0.264596,0.64477,0.17864,0.458398,0.576673,0.318812,-0.371317,0.605591,-0.345004,0.57281,-0.456025,0.194774,-0.0539072,-0.246559,-0.669646,0.415346,-0.0441366,-0.112992,-0.318991,-0.01188,0.259747,0.641866,0.228199,-0.060973,0.251546,-0.0937262,0.138731,0.474974,-0.130728,-0.52489,0.0879637,-0.389274,-0.287245,0.318568,-0.395222,-0.177494,0.196554,0.0298459,-0.188942,-0.736718,0.206704,0.215853,0.199254,0.0262878,0.051937,0.090688,-0.217702,0.160979,-0.0983265,-0.105835,0.705437,-0.25042,-0.307443,-0.240382,0.193248,-0.132526,-0.229849,-0.483427,0.116803,0.232904,0.341765,0.482602,-2.10963 +3416.6,0.65984,0.0848144,5,1.63329,0.968605,-0.46718,0.151425,0.512956,-0.0763974,-0.132519,0.0816263,0.0393092,0.155762,-0.0774331,-0.379291,0.4453,0.293158,-0.452756,0.938061,-0.233588,0.00515635,0.105959,0.028465,-0.543674,-0.790041,-1.246,0.0645382,-0.238007,0.518807,0.343792,0.350932,-0.320223,-0.0701537,0.629296,-0.467418,0.0482745,0.299303,-0.339416,-0.362211,0.23084,-0.0158821,0.152653,-0.377296,0.73557,0.241266,0.309298,-0.448583,0.200376,-0.310997,-0.380228,0.293892,0.0180117,0.0186594,-0.200934,0.158344,-0.0196766,0.102039,0.894056,-0.0811437,-0.120328,-0.49784,0.500645,-0.339878,-0.0788632,0.56862,-0.988615,-0.515443,-0.311169,0.598387,-0.0329532,-0.130056,-0.248441,-0.169442,0.057668,-0.106178,0.595635,0.202639,0.856512,0.512812,-0.240789,-0.112331,-0.794394,0.262224,0.0127729,-0.346426,-0.0597796,-0.0938464,-0.254418,0.358371,0.266003,-0.37591,-0.421546,-0.341888,-0.0330812,0.160143,0.532072,-0.161031,-0.0726525,-0.143971,0.565452,-0.692768,-0.241699,0.124408,-0.375043,0.120908,-0.210978,-0.470416,-0.345495,-0.399866,0.522,-0.00464638,0.349995,0.529007,-0.23187,-0.0931383,-0.385442,0.26532,-0.131469,-0.257988,-0.422287,0.397784,0.524096,0.30543,-0.925759,-0.261985,-0.295917,-0.192487,0.362037,-0.13548,0.0951799,0.282426,0.282474,-0.722595,0.0465072,-0.150594,0.362158,0.536461,-0.205268,-0.137834,-0.182076,-0.248778,0.125833,-0.668313,-0.685896,0.154477,0.287356,-1.08282,-0.701362,-0.292451,0.255073,0.512887,-0.242135,-0.0658615,-0.455962,-0.170735,0.249998,0.0703667,0.0650167,0.698008,-0.0341829,0.032637,0.112655,0.0956176,0.103855,-0.231077,0.326661,-0.20196,0.0655444,-0.199889,0.0377152,-0.128004,-0.179951,0.386447,-0.412716,-0.0528167,-0.202407,-0.649926,-0.484785,0.322715,-0.520497,0.0715196,0.296171,0.396216,0.39164,-0.53438,0.380811,-0.133789,0.492842,0.148493,0.416189,-0.353098,0.414295,-0.136891,-0.274487,0.457457,-0.047059,-0.197508,0.0806828,0.464698,-0.267544,0.250567,-0.631386,0.389321,0.0726734,-0.743702,-0.180483,-0.357291,-0.204942,-0.319959,-0.100246,0.955393,0.233857,0.022171,-0.450147,-0.264361,0.188355,0.226836,-0.63405,0.531349,-0.408797,0.269367,-0.151651,0.287329,-0.0571015,-0.482888,0.177634,-0.0134107,0.0765933,0.767985,0.0384322,-0.117394,-0.129197,-0.0614548,0.15245,-0.0204211,-0.489203,0.0743973,-0.534003,0.45414,0.155272,0.155829,0.634343,-0.235399,-0.00661805,-0.598777,0.340778,0.554844,0.322646,0.0110083,0.594772,0.503916,0.262605,-0.170974,0.181458,-0.218572,1.01572,0.0829487,0.00926097,-0.0187999,-0.0264478,-0.332488,0.435543,0.0930612,-0.190894,-0.329742,0.0598431,0.182735,0.999902,0.150023,-0.193316,0.531055,0.330336,-0.0431034,0.0103732,-0.283663,-0.405459,0.342352,0.118878,0.0465458,0.158967,-0.179482,-0.336522,0.370255,0.016033,0.386038,-0.196792,0.384066,-0.121309,0.175453,-0.424013,-0.0560416,0.369047,-0.505151,0.0584288,0.0222001,0.255194,0.0873957,-0.39478,0.172853,-0.406996,0.180148,-0.0741612,0.42066,-0.64455,0.138209,0.214746,0.371764,0.463407,-1.6611 +3410.66,0.804563,0.0848144,4,1.67449,1.1017,-0.446155,0.12157,0.602042,-0.174934,-0.242927,0.220906,-0.0882787,0.211181,-0.300478,-0.265744,0.101028,0.0530333,-0.358717,0.958642,-0.356197,-0.121059,0.122208,0.218135,-0.489006,-0.766498,-1.20798,-0.0478273,-0.107458,0.491188,0.295286,0.574696,-0.269689,-0.180843,0.571054,-0.384397,-0.269692,0.187068,-0.261833,-0.500721,-0.0930751,-0.0590764,-0.0116162,-0.444942,0.667757,0.652029,0.397937,-0.695747,0.0115549,-0.0171045,-0.394699,0.24786,0.0551417,-0.0963797,0.0198034,0.019312,0.0414221,-0.111054,0.64672,-0.0108606,-0.154999,-0.503747,0.432591,-0.450294,-0.0663853,0.63324,-0.840756,-0.589331,-0.172879,0.754109,-0.1928,-0.189815,-0.172708,-0.294791,0.017005,0.120835,0.705554,0.301219,0.835374,0.328524,-0.092432,-0.115872,-0.812175,0.275251,0.0179505,-0.394121,-0.151916,-0.247198,-0.380834,0.483491,0.230262,-0.237265,-0.0238428,-0.403955,-0.0962313,0.41567,0.498779,-0.223308,-0.148743,-0.0762016,0.308776,-0.814934,-0.196313,0.25766,-0.431416,-0.098858,-0.398717,-0.469037,-0.119798,-0.342882,0.635851,0.179788,0.0520025,0.459363,-0.298442,-0.0993536,-0.428097,0.27114,-0.222094,-0.194089,-0.69308,0.410645,0.359842,0.189453,-0.842452,-0.454963,-0.147125,-0.10575,-0.0352862,0.0304143,0.531929,0.117025,0.270376,-0.82751,0.0398311,0.141778,0.248745,0.657074,0.000827042,-0.205665,-0.0915924,-0.191449,-0.0391371,-0.466398,-0.738184,-0.031532,0.549419,-0.845307,-0.903287,-0.311868,0.322326,0.54242,-0.227184,-0.114753,-0.266418,-0.0928006,0.183732,0.0320677,0.396614,0.909066,-0.199786,-0.22758,0.109069,0.0342555,-0.0322217,-0.188035,0.160829,-0.451542,0.258768,-0.24434,-0.00307877,-0.373083,-0.305329,0.559819,-0.251235,-0.117912,-0.196052,-0.531517,-0.163501,-0.0846927,-0.508919,0.141237,0.114796,0.445127,0.563338,-0.377809,0.551655,-0.358242,0.505564,-0.0855749,0.540812,-0.361279,0.55746,-0.599433,-0.337437,0.328921,-0.261268,-0.373185,-0.0498902,0.57198,-0.62502,0.219586,-0.532186,0.642863,0.0907185,-0.41899,-0.262742,-0.279518,-0.588777,-0.369739,-0.0996437,1.00653,0.083036,-0.166325,-0.377491,-0.302303,0.362799,0.222903,-0.309028,0.770675,-0.33483,0.364002,0.191986,0.0986413,-0.201226,-0.677534,0.191621,-0.128033,0.0625237,0.780881,-0.0327776,-0.495121,-0.240087,-0.0482899,0.190227,-0.232054,-0.681807,0.00911924,-0.737411,0.47483,0.0708962,0.00445884,0.693345,-0.370248,-0.0306585,-0.434811,0.160479,0.616321,0.337564,-0.0312118,0.713187,0.46222,0.234593,-0.266174,0.16323,-0.0728614,1.07739,0.0859522,-0.121175,0.206381,-0.221374,-0.526338,0.457934,-0.0975932,-0.0550895,-0.339525,0.14456,0.299699,0.834209,0.290786,-0.283675,0.432703,0.41517,-0.0406148,0.141444,-0.376168,-0.346793,0.545169,-0.0993208,-0.228736,0.237641,-0.128489,-0.330971,0.468557,-0.071442,0.455475,-0.0141087,0.306158,-0.131661,0.186139,-0.039352,-0.139669,0.0743719,-0.546581,0.0273891,0.19308,0.268481,0.461941,-0.433065,-0.306865,-0.434668,0.280861,0.0702215,0.397959,-0.523851,0.130097,0.243241,0.360689,0.493194,-2.10906 +3422.42,0.989163,0.0848144,4,1.58684,1.0013,-0.268147,0.0864122,0.372591,-0.295335,0.0452881,0.274294,0.0433149,0.402138,-0.0782193,-0.349222,-0.0223044,0.245466,-0.119217,0.459685,0.19701,0.0239949,-0.00248018,0.140834,-0.623448,-0.700603,-0.888374,-0.0359888,-0.661121,0.158489,0.31963,0.824647,-0.0244849,0.14287,0.794995,0.0485325,-0.0213088,-0.00590527,-0.209442,-0.046725,-0.202409,0.251416,0.491549,-0.578874,0.906158,0.484952,0.183209,-0.412584,0.00506205,0.206565,-1.03392,-0.360703,0.109323,-0.155223,0.114367,0.0765814,0.450064,-0.460085,0.949175,-0.0542348,-0.11667,-0.783552,0.301058,-0.745745,-0.435076,0.602468,-0.439786,-1.32247,-0.0150407,0.349858,-0.32367,0.116259,0.541958,-0.725314,-0.227632,-0.408876,0.655664,-0.0593691,0.489424,0.463479,0.222515,0.31439,-0.322902,0.439183,0.268815,0.271979,0.537347,-0.0921512,-0.375235,0.0760281,-0.401549,-0.311006,-0.15218,-0.093232,-0.222197,0.209791,-0.0703481,-0.138592,0.268406,-0.144037,-0.198015,-0.253956,-0.218081,0.183642,-0.229899,0.471117,-0.178252,-0.040359,-0.533098,-0.615493,0.38913,-0.0784479,-0.038724,0.55056,-0.20898,-0.218477,-0.504834,0.0294441,0.236356,0.497857,-0.0145349,0.04621,-0.280131,0.750662,-0.636989,0.244106,0.0785478,-0.40136,0.117481,0.0636025,0.474679,0.208837,0.250151,-0.46794,-0.0345606,0.266367,-0.276167,0.211512,-0.264182,0.0382864,0.0511527,-0.70844,0.666269,-0.546657,-0.161856,0.0148721,0.201109,-0.783051,0.140787,-0.0456944,-0.0506119,-0.0833354,0.169629,0.1258,-0.191108,0.551915,0.175348,0.0656916,-0.011504,0.130488,-0.125962,0.0224145,0.0546101,-0.674749,-0.0886669,-0.0376432,0.824498,0.133206,0.240262,-0.877992,-0.15037,-0.0114523,0.0229658,-0.0777028,-0.230975,0.175451,-0.436654,-0.105495,-0.261921,-0.260825,-0.666408,-0.197312,0.0636797,0.873023,-0.378816,-0.379596,0.0940834,-0.289789,-0.0157412,0.433603,-0.0560875,-0.174596,0.363578,-0.462389,0.372976,-0.179098,0.185302,-0.540009,-0.11704,-0.130558,-0.0121955,-0.107408,0.00151831,0.084694,0.0486129,-0.840266,-0.301278,0.231349,-0.174798,0.388344,-0.347386,0.469673,-0.397075,0.392667,-0.0189994,-0.480855,0.212624,-0.240725,-0.334083,0.189455,-0.730955,-0.152712,0.559667,-0.651567,-0.528301,-0.527617,-0.188863,-0.186737,-0.476261,0.629458,-0.413601,-0.522305,-0.0880291,0.0349984,0.383286,-0.0991059,-0.11876,-0.408967,-0.840331,0.327648,0.631596,0.510034,0.644331,0.102632,-0.0620776,0.0293948,0.0886606,0.000979574,-0.216944,0.335719,0.535357,0.691089,0.282492,-0.350736,0.129008,0.0663448,0.202245,-0.233983,0.202462,0.304131,-0.16943,0.0223544,-0.190929,0.112693,0.230893,-0.0569779,0.114986,0.245577,0.445205,0.589844,-5.97789e-05,-0.364446,0.130276,0.240946,-0.0568027,-0.137288,-0.214557,0.0543918,0.26979,0.571259,0.295694,0.413492,-0.449403,-0.209276,-0.217384,-0.230676,0.0394845,-0.198076,0.278555,-0.0448886,-0.0486476,0.225449,-0.400007,-0.445934,-0.0693861,-0.309708,-0.30579,-0.211152,0.0706778,-0.19979,-0.268081,0.518371,0.590568,-0.125803,0.323957,0.137636,0.188308,0.370994,0.433945,-1.28757 +3441.18,0.997922,0.0848144,4,1.57496,1.08484,-0.334299,0.107261,0.423742,-0.375002,0.033743,0.41877,0.159238,0.504592,0.0206297,-0.193292,-0.0416523,0.16848,0.0672427,0.853726,0.310698,0.0607948,0.0230685,-0.0493778,-0.580263,-0.965805,-0.582297,-0.0175397,-0.509765,0.170847,0.313994,0.80265,-0.264086,-0.0498517,0.695936,-0.0667273,0.0841641,0.0994511,-0.305634,-0.0552497,-0.0430469,0.455149,0.520852,-0.473212,0.714445,0.473016,0.0538739,-0.454444,-0.122746,-0.0109924,-0.808694,-0.198104,0.156213,-0.121716,0.106391,0.0965493,0.439156,-0.737757,0.864819,-0.142935,-0.309396,-0.626058,0.326607,-0.873747,-0.363139,0.505681,-0.513685,-1.41022,-0.0712636,0.439349,-0.367767,-0.0172789,0.450512,-0.626515,0.0290233,-0.42893,0.561404,-0.203799,0.817392,0.433775,0.175535,0.290855,-0.323472,0.437445,0.277437,0.151784,0.387856,-0.212886,-0.101423,-0.166666,-0.558266,-0.355173,0.120559,-0.138937,-0.192352,0.0287445,-0.237755,-0.0407584,0.212376,-0.333176,-0.171577,-0.200542,0.102314,0.167363,-0.215151,0.537994,-0.316183,-0.211321,-0.395713,-0.447595,0.518095,-0.0401767,-0.000530041,0.710987,-0.163319,-0.1894,-0.413341,0.0561591,0.269097,0.365837,-0.206443,0.0162608,-0.107978,0.561363,-0.544466,0.141632,0.17071,-0.497441,-0.0293375,0.188681,0.212582,0.0084734,0.392021,-0.590696,-0.100947,0.156644,-0.114615,0.131196,-0.201806,-0.0707867,0.134375,-0.620483,0.714036,-0.66719,-0.351346,-0.0454239,0.261975,-0.808715,0.0673566,-0.336344,-0.127562,0.115836,0.0969265,-0.152505,-0.0538472,0.698482,0.250542,-0.0277444,0.148045,0.292842,-0.13132,0.104352,0.0104245,-0.522521,-0.0242184,-0.0416497,0.758401,0.259733,0.402972,-0.718619,-0.117228,0.00716711,-0.0511408,-0.0976127,-0.0946949,0.0912572,-0.407732,-0.0303088,-0.157499,-0.318522,-0.76637,-0.215486,-0.161484,0.893131,-0.000484697,-0.232402,0.206484,-0.366154,0.0141269,0.171488,-0.0417771,-0.579752,0.437121,-0.357435,0.10239,-0.146135,0.136764,-0.596691,-0.136784,-0.0727782,0.211479,0.0329935,-0.347712,-0.0125212,0.187956,-0.730528,-0.282909,0.0461138,0.344938,0.435124,-0.300526,0.627466,-0.379309,0.58775,-0.0541213,-0.290748,0.529627,-0.393452,-0.0652648,0.0482487,-0.595156,-0.174989,0.503131,-0.658749,-0.589219,-0.596092,-0.234659,-0.072703,-0.386271,0.51419,-0.440884,-0.516604,-0.0482503,-0.13648,0.190556,-0.253809,-0.444118,-0.525041,-0.700117,0.393457,0.450157,0.688469,0.532252,0.143929,0.265196,-0.00237919,-0.0793228,0.000612763,0.121264,0.278439,0.424768,0.631021,0.277291,-0.143287,-0.0958069,-0.0151485,0.196555,-0.238417,0.324819,0.528045,-0.13255,0.216138,-0.25859,0.108326,0.383368,0.0320161,0.0505306,0.125967,0.336594,0.787539,0.0467782,-0.473032,-0.174403,0.164349,-0.0938136,0.0242237,-0.271123,-0.123,0.0988236,0.467016,0.223941,0.275127,-0.279277,-0.0819029,-0.174308,0.076263,-0.11312,-0.401638,0.39393,-0.061588,-0.195369,0.462369,-0.436329,-0.389312,-0.196515,-0.14833,-0.280054,-0.134539,0.0463362,-0.346772,-0.0977944,0.432323,0.357767,-0.270337,0.256303,0.119789,0.242338,0.346106,0.492278,-1.58204 +3403.62,0.757638,0.0848144,5,1.67177,1.02712,-0.343,-0.0327263,0.443316,-0.00563925,-0.125879,0.0106093,0.218456,-0.177755,-0.293445,-0.572754,-0.0672083,0.00652729,-0.0768911,0.981934,0.0121851,0.00337421,0.0193717,-0.485998,-0.38673,-0.753583,-0.540964,-0.216141,0.0291848,-0.343317,0.0897989,0.00525442,-0.407184,-0.0436946,0.413349,-0.524017,0.129803,-0.0154579,-0.0264101,-0.278236,-0.602833,-0.104738,0.222241,0.114496,0.711325,0.303839,-0.06468,-0.276695,0.24901,-0.753444,-0.658804,0.0315356,0.116263,0.118191,-0.381361,0.0015172,-0.378693,-0.290093,1.23289,-0.357295,-0.170766,-0.639728,0.382839,0.0216055,0.123085,0.735406,-1.0039,-1.02106,-0.200908,0.029416,-0.0829004,0.192612,0.0288141,0.022979,0.0281391,0.689714,0.820554,-0.213077,-0.0934718,0.238717,0.12373,-0.292901,-0.0206261,-0.062786,0.562517,-0.727454,0.0604208,-0.08195,-0.266343,-0.0529623,0.521302,-0.235205,0.138267,-0.500995,0.244569,-0.167312,0.319123,0.154173,0.0637267,-0.40165,0.270612,-0.677898,-0.136216,0.539566,0.240577,-0.376227,-0.272112,-0.353092,0.903531,-0.0990339,-0.181938,-0.136059,0.114107,0.504241,0.198273,-0.0569692,0.45155,0.0592691,-0.388368,-0.128909,-0.539372,0.0295371,0.417183,-0.556792,-0.554456,-0.744658,-0.191865,0.30372,0.235549,0.0508821,0.339796,-0.229404,-0.0281593,0.244962,0.0129156,0.133192,0.163962,0.675033,-0.161759,-0.761277,-0.529766,0.300145,0.227426,0.067127,-0.517355,0.0929203,-0.220755,-0.305765,-0.0462829,0.332821,-0.0817138,0.597664,-0.353031,-0.156785,-0.276033,-0.483715,0.0751535,0.0542102,-0.323692,0.343438,0.252754,-0.817511,0.203201,0.168042,0.0201893,-0.122925,0.244724,-0.381878,-0.645236,0.919909,0.436229,-0.469063,-0.0486061,0.11363,0.413527,-0.38432,-0.215593,-0.0475027,0.113251,0.14424,0.173811,0.0718573,0.263442,0.3694,0.434932,-0.373248,-0.403967,0.420925,-0.104074,-0.237621,-0.545203,-0.0785291,0.0278511,-0.166484,0.271821,0.0784921,-0.471396,-0.296504,0.0246622,0.272051,0.0873463,-0.213273,-0.428464,-0.393905,-0.175439,0.494516,0.82436,-0.397718,-0.658936,-0.514478,-0.399419,1.26095,0.180938,-0.635277,0.120953,-0.172379,-0.133142,0.428443,-0.346345,0.289561,-0.226458,0.573976,-0.514262,0.134527,0.249051,-0.20169,0.391312,0.789157,-0.188927,0.638462,-0.778139,0.519594,0.0551461,0.146426,-0.75513,-0.0618491,0.177287,0.242959,0.344771,0.297325,-0.537026,-0.582745,0.423984,-0.94349,-0.166943,0.180896,-0.167819,-0.177091,0.597567,0.195198,0.430775,0.178052,-0.243838,-0.0716047,-0.18961,-0.6866,0.502422,-0.232786,-0.758672,0.344015,-0.0542215,-0.234987,0.36703,0.177133,0.0690306,0.448797,-0.302689,0.348613,0.408117,-0.430327,0.0224159,0.366449,0.168335,0.108577,-0.357883,-0.438505,-0.110633,-0.11071,-0.216547,-0.551754,0.228481,-0.406516,0.686157,-0.290292,-0.191863,-0.377887,-0.353961,0.49425,0.316845,0.186949,0.491959,-0.245846,0.446024,0.0139799,-0.271498,0.0913831,0.5718,0.136249,-0.239331,-0.220292,0.234032,-0.397606,-0.509557,0.0961778,-0.0734002,0.170666,0.207131,0.413117,0.455117,-1.40317 +3409.63,0.621619,0.0848144,4,1.70881,0.821402,-0.830123,0.186681,0.834918,-0.0432329,-0.106691,0.0462363,-0.0933307,0.17302,-0.00889135,-0.220592,-0.707927,-0.238967,-0.314927,0.632964,-0.327747,-0.0613506,0.0974696,-0.222678,-0.402928,-1.2448,-0.756222,0.121049,-0.674948,-0.616642,-0.264943,-0.135624,-0.652438,0.00219966,0.833835,-0.508281,-0.187546,0.0304748,-0.212659,0.296251,0.0264141,-0.048231,0.267038,-0.138749,0.911851,0.0392346,0.189466,-0.422739,0.131354,-0.37657,-0.475622,-0.375176,0.221687,0.433719,-0.18522,-0.186482,0.0645853,0.0939099,1.26516,-0.331926,0.0566056,-0.929108,0.36814,-0.741156,0.238956,0.926535,-0.682071,-0.995951,-0.154209,-0.0701943,-0.070834,0.200835,0.0765214,-0.448531,0.565617,0.234268,0.826238,-0.489623,0.492832,0.403484,0.287649,-0.266374,-0.343555,-0.0241802,0.466753,0.127038,0.160604,-0.614503,-0.699511,0.0478149,-0.00113226,-0.0291743,0.140912,-0.567879,-0.381255,0.0424269,0.39678,0.326313,-0.0798922,-0.452017,0.727027,-0.0986831,-0.0109884,0.28237,0.208285,0.157828,-0.319486,-0.201787,0.899135,-0.477005,-0.0902182,0.274092,0.0300423,0.896663,-0.14312,-0.327726,-0.161535,0.340175,-0.110543,0.150238,-0.226677,0.424227,0.162167,-0.0720951,-0.797922,0.29521,-0.829194,-0.00450287,0.271542,-0.21828,0.328736,0.06936,0.164812,-0.453429,-0.180977,0.176714,0.295725,0.507812,-0.347618,0.0318027,0.162799,-0.0765833,0.591926,-0.733491,-0.173996,-0.0279587,-0.00492007,-0.226689,0.149565,0.0745426,0.625993,0.0216883,-0.109537,0.0231562,0.434739,0.325792,-0.0402393,-0.31143,-0.0739756,-0.152202,0.306854,-0.334206,0.0167064,0.368231,0.463548,-0.0173955,0.521604,0.176189,0.225649,0.386101,0.187215,0.0821301,0.334392,-0.198246,0.345771,-0.862503,-0.139015,0.171795,-0.33391,-0.00232588,-0.222512,-0.445496,0.245023,0.639317,-0.246316,-0.184476,0.454269,0.107886,-0.12659,0.0157092,-0.147801,-0.068619,0.292949,0.213359,0.261634,-0.66924,-0.586082,-0.305777,-0.678177,0.336952,0.307583,-0.273726,-0.572594,0.252699,0.0351855,-0.233662,-0.0471421,-0.0767877,-0.00205597,-0.186074,-0.541003,0.561575,-0.0940637,-0.816155,0.0463572,0.367639,0.124455,0.0657701,-0.254841,0.551882,-0.179154,-0.191423,0.545248,-0.855638,0.12189,-0.594421,-0.0370554,-0.0995308,-1.05297,0.529777,-0.0515464,0.40929,0.41413,0.77885,-0.498156,-0.127415,0.413004,-0.463118,-0.869616,0.847187,-0.078537,0.332808,0.806667,0.182403,0.560789,0.167845,0.045339,0.124715,-0.362091,-0.0713673,0.132301,0.147012,-0.456484,-0.564941,-0.487639,-0.990229,0.330042,0.0107521,-0.181927,0.04713,-0.43816,-0.547946,0.223179,0.129873,-0.0294802,0.185669,0.284121,0.295839,0.368598,0.451226,-0.036044,0.200193,0.0239574,-0.18465,-0.128117,-0.509925,0.226913,0.0521143,0.0792324,-0.0270874,-0.330266,-0.0678257,0.189768,-0.274725,-0.559354,-0.162414,0.0641097,0.40899,0.0777124,-0.189586,-0.392552,-0.446669,0.20429,-0.74363,-0.141541,-0.404904,-0.40052,0.00259083,-0.410877,-0.856111,-0.577473,0.0690825,0.248884,0.460455,0.037617,0.127362,0.195458,0.356878,0.442107,-2.24521 +3423.47,0.824473,0.0848144,4,1.66835,0.789587,-0.802713,0.178754,0.676969,-0.0246954,-0.148234,-0.161501,0.514231,0.0106434,-0.0419346,-0.68236,-0.482532,0.260757,-0.100463,0.603679,-0.0552649,-0.0836937,-0.390436,-0.205141,-0.266463,-0.933644,-1.01957,-0.0885235,-0.39771,-0.137887,-0.655875,0.199,-0.560554,0.00144519,0.609884,-0.363943,0.135626,0.358832,0.147435,-0.0534684,-0.663504,0.224648,0.250156,0.0614335,1.06484,0.359315,0.0856185,-0.416154,0.0598156,-0.231367,-0.244919,0.0433236,0.40981,0.0122174,-0.170795,-0.0718361,-0.0510575,-0.44125,1.08076,0.181979,0.28015,-0.669683,0.679479,-0.233903,0.264215,0.61816,-0.556112,-1.11085,-0.156289,-0.00847713,0.036359,-0.544781,0.0177248,0.0358091,-0.341447,0.491491,0.663841,-0.685968,0.571246,0.7598,0.187411,0.20088,-0.402046,0.435681,0.985094,-0.441775,0.289832,0.342381,-1.06188,0.200315,-0.34063,-0.336443,0.239734,-0.422362,-0.407595,0.0486289,-0.584023,-0.0473,-0.215318,-0.806941,0.0262048,0.333002,-0.0193926,0.568836,0.101656,-0.869026,-0.278013,0.185791,-0.393359,-0.137719,0.218978,-0.322586,-0.0397238,0.913125,-0.261822,-0.134965,0.133893,0.394931,0.335806,0.0897152,-0.556707,-0.223082,0.351101,-0.29737,0.118359,0.146085,-0.286267,0.0707799,-0.181896,0.366715,0.502957,-0.537368,0.444812,0.240719,0.0380806,-0.197679,-0.0249047,0.588558,0.380335,0.277168,-0.459785,-0.328547,0.326543,-0.874192,-0.783559,0.143086,0.903096,-0.2139,-0.0953141,0.133353,-0.28317,0.219491,-0.182388,0.246635,-0.0662591,0.267388,0.189899,-0.0785575,-0.307075,0.11455,0.405056,-0.32562,-0.174946,0.0518156,0.226494,-0.281285,0.496134,0.0849997,-0.128568,0.333161,-0.149165,-0.596766,0.170499,-0.081433,0.312964,-0.0251875,-0.0270446,-0.211857,-0.432125,-0.213861,-0.103758,-0.12774,-0.323078,0.674732,0.528385,-0.350221,0.273962,-0.277433,-0.0439296,-0.393643,-0.185245,-0.397828,0.311152,0.148184,-0.0596834,-0.428896,-0.366195,-0.521427,0.509072,0.369297,-0.113846,-0.0455393,-0.418303,0.380749,-0.00579881,0.0770448,-0.044659,-0.119767,0.51815,0.0745025,-0.301811,0.961351,0.101289,0.103521,0.130645,0.0485432,0.275798,-0.32487,-0.190879,0.419371,-0.562327,0.348681,0.414049,-0.0580527,0.285913,-0.797698,0.440829,0.114669,-0.181014,0.221108,0.245701,-0.323865,-0.048702,0.146877,0.152626,0.146987,-0.309965,-0.347581,-0.348455,0.423876,0.0672353,-0.189528,0.590501,-0.408545,-0.431802,-0.15925,0.301225,0.0205326,0.162855,-0.246869,0.375392,-0.225242,-0.752268,-0.436647,-0.199995,-0.549447,0.55721,-0.662301,-0.777453,0.470412,-0.0507488,0.276261,0.101137,0.167972,0.277672,0.682797,0.25999,0.62875,0.247736,-0.369274,-0.0479717,-0.365288,-0.400465,-0.358135,0.0406393,-0.773333,0.121778,0.186389,0.0889476,-0.057596,0.098256,-0.402872,0.575415,0.610924,-0.109167,-0.269284,-0.0440743,0.423356,0.628076,0.311894,-0.079213,0.183093,-0.130999,-0.243445,0.0815979,-0.355043,-0.0254546,0.0367454,-0.0986432,-0.768203,-0.369975,0.165638,-0.153642,0.476151,-0.171348,0.15719,0.326885,0.396472,0.571739,-1.71658 +3436.12,0.989128,0.0848144,4,1.6353,0.921501,-1.0658,0.316848,0.597033,-0.126486,-0.414032,0.097876,0.00847646,-0.0838551,-0.153875,-0.232947,0.0634599,0.170757,-0.647768,0.509792,0.150004,-0.0914066,0.126773,-0.170166,-0.353678,-0.838939,-0.985243,-0.0749259,-0.629581,0.00199107,0.303261,0.200072,-0.549649,0.250155,0.491257,-0.80676,-0.00658715,-0.087257,-0.277089,-0.198305,-0.138,0.377738,0.466752,-0.333807,0.986723,0.24695,0.214265,-0.539544,0.0709769,0.284056,-0.689341,-0.229444,0.759845,0.341051,0.0494271,0.487482,0.36854,-0.264481,0.542807,-0.735836,0.0986058,-0.539152,0.192579,-0.0780704,0.303906,0.687822,-0.635696,-0.598781,0.041614,0.795466,-0.14831,0.309277,0.14115,-0.582368,0.300906,-0.257094,0.21929,0.61266,0.758437,0.252027,0.447755,-0.218318,-0.033156,-0.103374,-0.0474708,-0.221522,0.155747,-0.271904,0.614074,-0.490442,0.120059,0.232574,-0.283046,-0.259641,0.539704,-0.0187104,0.444611,0.320671,0.303701,0.123573,0.417241,-0.571827,-0.0653177,0.0969867,0.0686632,0.729571,-0.330687,-0.525468,0.326193,-0.211645,0.374879,-0.493761,0.297195,0.315376,0.271416,0.0867884,-0.210521,0.480859,-0.287891,-0.276367,-0.11878,0.511819,-0.306927,-0.317482,-0.982329,-0.0276606,-0.183749,-0.261458,0.16664,-0.185437,-0.448287,0.747745,0.124038,-0.686488,-0.00709569,-0.08243,0.31831,0.533557,-0.412546,-0.319406,-0.0699957,-0.117365,0.576815,-0.0169282,0.0887483,-0.0963932,-0.626345,-0.654362,0.134944,-0.0878108,0.388237,0.0902991,-0.122275,-0.301885,-0.153843,-0.232787,0.407783,0.114714,0.351006,0.242565,0.124877,-0.0574755,0.206393,0.0148049,-0.463461,0.423346,0.925466,-0.373189,-0.00173199,-0.156845,-0.261505,0.174483,-0.201879,-0.311559,-0.0866771,-0.304252,-0.0994132,0.0960314,0.154175,0.15025,-0.132273,-0.159421,0.0765069,0.963069,-0.0682249,-0.0352048,0.199983,0.449805,-0.103466,-0.165027,-0.283949,0.159543,0.160067,-0.723977,-0.0856129,0.503797,0.335819,-0.187416,-0.396452,-0.152677,0.174512,-0.310103,-0.290332,-0.308053,0.0247836,-0.18609,-0.130167,0.2439,-0.255795,-0.160979,-0.514051,0.728828,-0.0234465,-0.288393,-0.294089,-0.0527486,-0.0422766,0.654966,-0.308866,-0.162419,0.0195809,0.16858,-0.117,-0.584497,-0.02144,-0.258302,-0.517668,0.269167,-0.323261,0.157335,-0.899432,0.178417,0.101826,-0.227648,-0.387417,0.135706,-0.0327043,-0.0873611,-0.139431,0.615283,-0.500279,0.223082,0.72611,-0.159241,0.222267,0.0908023,-0.358135,-0.205731,0.273887,0.521381,0.59577,0.527815,0.182465,-0.162977,0.274255,-0.11357,0.366935,0.270449,0.0965787,0.182105,-0.183127,-0.127317,0.11481,0.148608,0.139423,-0.334583,-0.130942,-0.31789,0.383247,0.199486,0.0337509,-0.18745,0.0252384,0.340368,-0.127137,0.159696,-0.384016,-0.143286,-0.0856855,-0.251508,0.317519,0.287334,-0.395066,-0.354334,-0.0848622,-0.0260195,-0.546289,-0.106518,-0.736173,-0.100294,0.0298335,0.0756745,0.331457,0.13076,0.125268,0.48759,-0.0952534,0.0470953,0.0966029,-0.130118,0.0602841,-0.0412302,-0.375698,-0.570298,-0.0909843,0.118645,0.141708,0.344449,0.376441,-1.68477 +3444.08,0.586721,0.0848144,4,1.64748,0.841679,-0.881218,0.322486,0.696812,-0.120002,-0.232672,-0.284046,0.271363,-0.386412,-0.0766599,-0.129176,-0.240795,0.401149,-0.659813,0.453313,0.0632678,0.0407755,0.0484449,-0.00316403,-0.281443,-0.830539,-0.693393,0.102208,-0.55298,-0.0114414,-0.0692613,0.204622,-0.245645,0.056855,0.647535,-0.737293,-0.16204,0.103486,-0.476447,-0.24859,-0.372344,0.731254,0.612485,-0.570658,0.825974,0.458041,0.0111283,-0.437779,0.153433,-0.155818,-0.450241,0.216305,0.505937,0.380628,0.0540813,0.0795248,0.304864,-0.482414,0.631476,-0.928268,-0.00948949,-0.848321,0.151644,-0.370699,0.52043,0.707169,-0.418108,-0.597349,0.00478173,0.777706,-0.0790657,0.187476,0.309885,0.0172199,-0.402705,-0.0653634,0.42262,0.684781,0.84874,0.348433,0.0158319,-0.00260353,-0.0408126,-0.071321,-0.201625,-0.334909,0.118371,0.0019764,0.726599,-0.132755,0.0865009,0.589454,-0.176389,-0.406062,0.416007,0.273077,0.0711972,0.239927,0.230364,-0.0189817,-0.089774,-0.227495,0.315103,0.013416,0.0917094,0.729266,-0.230665,0.0431544,0.0260121,-0.181139,0.0457644,-0.26145,0.372667,0.529729,0.374525,-0.23352,-0.448197,0.573412,-0.231068,-0.443798,0.235544,0.255742,-0.206671,0.0573724,-0.672518,-0.244242,-0.294009,-0.0168986,0.593579,0.123967,-0.338244,0.363339,0.16115,-0.426919,0.0592346,-0.0146546,0.138151,0.418486,-0.565382,-0.171193,-0.145647,-0.226124,0.470364,-0.648357,-0.154338,0.104754,-0.158362,-0.879452,0.165863,-0.160202,0.152133,-0.240812,-0.00569062,-0.157151,-0.218659,-0.315834,0.33454,0.113656,0.381844,0.149681,0.354742,-0.167036,-0.0157404,0.164913,0.00301689,0.0599592,0.487683,-0.373522,-0.314638,0.0277136,-0.381735,0.156864,-0.439888,-0.370994,-0.00245264,-0.266008,-0.0299857,0.285559,0.110394,-0.0293467,-0.192476,-0.362444,-0.198858,1.03326,-0.0684606,0.01586,0.319061,0.243431,-0.0532773,-0.45374,-0.219761,0.0881609,0.0640985,0.0576091,-0.327715,0.282796,0.291825,-0.298444,-0.0597819,-0.380284,-0.267096,-0.184002,-0.540545,-0.10574,-0.0106674,0.119736,-0.103609,-0.0388607,0.214134,-0.373469,-0.749803,1.09212,-0.0610799,-0.347622,-0.236346,-0.364148,-0.191707,0.365685,-0.215799,-0.0538605,-0.219164,0.221011,0.135089,-0.251191,0.0382368,-0.0833565,-0.743346,0.332804,-0.635338,0.0494729,-0.594438,-0.0801659,-0.10066,0.109699,-0.82362,0.268059,0.0609978,0.0746972,-0.309387,0.614154,-0.598656,0.186409,0.587158,-0.219256,-0.301179,0.303984,-0.456925,0.127698,0.490914,0.587683,0.699474,0.575272,-0.103449,-0.450981,0.668534,-0.527948,0.262398,0.18315,-0.248979,0.0577631,-0.301467,-0.0747805,0.292608,0.0781546,0.191009,-0.0884193,-0.263667,-0.287909,-0.0640242,0.327057,0.244308,0.231065,-0.469699,0.117514,0.199041,0.120927,-0.316499,0.17013,-0.103606,-0.374864,0.304762,-0.0655426,-0.081257,-0.393336,-0.328586,0.107881,-0.672334,0.192052,-0.365039,-0.261636,-0.127597,0.291185,0.170859,0.000462311,-0.0595868,0.205216,-0.264605,-0.19624,0.0827597,-0.463493,-0.113776,-0.258822,-0.524099,-0.739106,-0.162733,0.11976,0.166376,0.346063,0.407892,-1.96666 +3436.03,0.763241,0.0848144,5,1.61443,0.913743,-0.994693,0.355459,0.478628,-0.119119,-0.237598,-0.128021,0.254964,-0.0945821,-0.108913,-0.0138036,-0.209937,0.395378,-0.813101,0.50594,0.228439,0.10313,0.185523,-0.116471,-0.311962,-0.747188,-0.594675,0.134902,-0.399207,-0.131734,-0.0765532,0.285844,-0.456402,-0.0517492,0.462704,-0.52031,-0.303951,-0.0077545,-0.556847,-0.0986105,-0.250221,0.727893,0.534544,-0.690905,0.90532,0.552957,-0.0201547,-0.54197,0.0597858,-0.210482,-0.43451,0.24398,0.364803,0.270747,0.116832,0.386832,0.124173,-0.484878,0.371729,-0.90649,-0.0264112,-0.979825,0.157183,-0.324255,0.563941,0.826238,-0.499509,-0.761079,-0.0443558,0.767911,0.00067055,0.0691923,0.184494,0.191897,-0.201759,-0.332343,0.538032,0.694631,0.64563,0.360175,0.117485,-0.161235,-0.154974,0.00571889,0.0981941,-0.571106,0.219874,0.0395793,0.672586,-0.191372,-0.181698,0.328736,-0.389131,-0.411983,0.558276,0.263842,0.318457,0.302224,0.423558,0.0801009,-0.302058,-0.24783,0.0276087,0.0621413,0.359427,0.582728,-0.342946,0.0310361,0.0418881,-0.130872,0.202419,-0.580416,0.424814,0.377191,0.325153,-0.191359,-0.667985,0.56294,-0.0458565,-0.35637,0.244876,0.29213,-0.00414302,-0.317751,-0.870613,-0.111325,-0.601704,-0.00445785,0.325607,0.0802587,-0.170404,0.579981,0.290834,-0.705815,-0.0830808,-0.0188725,-0.0329884,0.592053,-0.398745,-0.0185206,-0.113657,-0.0217514,0.37965,-0.347761,-0.0614934,0.142198,0.0272994,-0.959307,0.146736,-0.141462,0.279619,-0.278799,0.13804,-0.0554927,-0.319625,-0.115664,0.58993,0.0163738,0.347267,0.114921,0.499241,0.0667035,-0.210424,0.139805,-0.117675,0.104416,0.44872,-0.323708,-0.00701935,0.175624,-0.224185,-0.0161328,-0.447135,-0.420926,-0.276768,-0.196224,-0.0343679,0.159153,0.153011,-0.016505,-0.142941,0.0845809,-0.225931,1.00317,-0.344899,-0.299536,0.451393,-0.00679945,0.307947,-0.719944,-0.345012,0.287263,-0.127882,0.0728322,-0.35684,0.318978,0.39307,-0.464784,-0.134173,-0.272179,-0.277682,-0.353443,-0.534954,-0.0785872,0.00109779,0.101846,0.133227,-0.176619,0.19059,-0.466295,-0.52908,0.970798,-0.0788738,-0.177463,-0.136531,-0.372173,-0.0826122,0.304353,-0.405648,-0.271976,-0.228545,0.255118,0.104495,-0.132968,-0.0437535,-0.0308201,-0.508984,0.141875,-0.605384,-0.0103087,-0.80708,-0.116972,0.19005,0.0895141,-0.958758,0.318393,0.284711,-0.115514,-0.200891,0.65105,-0.417545,0.39201,0.701941,-0.282828,-0.017109,0.371465,-0.368732,0.132717,0.437803,0.620902,0.668234,0.352911,0.0047317,-0.525344,0.611402,-0.390863,0.384116,0.21078,-0.172166,0.0341475,-0.209095,0.0172839,0.274458,0.0999972,0.137632,0.292661,-0.165217,-0.279546,-0.25068,-0.0112929,0.173943,0.0346293,-0.448163,0.0635467,0.320015,0.0660922,-0.366082,0.0883814,-0.229004,-0.40631,0.25589,0.167901,0.013092,-0.263663,-0.220844,-0.0586471,-0.65519,0.254971,-0.322981,-0.369092,-0.0665542,-0.0695972,0.212278,-0.16608,0.17864,0.318871,-0.380996,-0.437842,0.0514435,-0.33918,0.0620499,-0.304472,-0.689412,-0.714774,-0.0336268,0.111386,0.186389,0.333746,0.431728,-1.37466 +3443.88,0.959546,0.0848144,5,1.60542,0.885501,-1.02058,0.373705,0.530472,-0.0982331,-0.191382,-0.176026,0.234252,-0.0825137,-0.125373,-0.046665,-0.181573,0.44876,-0.713082,0.486255,0.237901,0.0992837,0.178491,-0.0659299,-0.313666,-0.706006,-0.609743,0.0757494,-0.38483,-0.0767277,-0.0326358,0.23255,-0.474574,-0.0700478,0.500544,-0.462499,-0.250866,-0.0324526,-0.566376,-0.119695,-0.211911,0.755833,0.514334,-0.604552,0.97476,0.592395,-0.00389782,-0.552775,-0.000782853,-0.244856,-0.404397,0.160462,0.427379,0.244575,0.145068,0.45342,0.133157,-0.458688,0.310231,-0.855441,-0.0178955,-0.916654,0.175322,-0.373502,0.47877,0.744665,-0.476752,-0.872138,-0.123343,0.723994,0.0916807,0.0491973,0.182142,0.203141,-0.251898,-0.283992,0.530067,0.708857,0.641132,0.372002,0.0654197,-0.154897,-0.0900401,0.0208805,0.140322,-0.540551,0.179213,0.0491327,0.654388,-0.277952,-0.145453,0.24671,-0.328479,-0.397052,0.423152,0.284573,0.29658,0.301263,0.451393,0.0825508,-0.293705,-0.249322,0.046062,0.0689252,0.355026,0.543767,-0.4177,-0.0390949,-0.0279731,-0.0853751,0.133158,-0.554242,0.355353,0.35184,0.191667,-0.182378,-0.697377,0.530184,0.00203438,-0.375317,0.225186,0.304795,0.0119807,-0.356908,-0.877733,-0.064081,-0.503611,-0.0284161,0.36916,0.0301363,-0.199921,0.625026,0.195858,-0.566625,6.8042e-06,-0.0489763,-0.0828216,0.559751,-0.409385,-0.0315656,-0.0891884,-0.0291132,0.352811,-0.340606,-0.0397118,0.157309,-0.0398639,-1.01023,0.21589,-0.167984,0.30602,-0.286722,0.152226,-0.182103,-0.267601,-0.0594899,0.629525,0.125149,0.265989,0.123202,0.387836,0.120826,-0.183847,0.0992789,-0.131816,0.137165,0.422591,-0.367468,-0.0336078,0.201418,-0.279216,-0.041053,-0.430465,-0.350344,-0.264595,-0.156501,-0.063701,0.18767,0.230446,-0.0133615,-0.166116,0.109569,-0.164586,1.02731,-0.400029,-0.32049,0.467672,-0.0170082,0.362957,-0.6214,-0.280358,0.266841,-0.210634,0.0441912,-0.352319,0.264261,0.404884,-0.46092,-0.174749,-0.202663,-0.3077,-0.324773,-0.620388,-0.0533827,0.0146507,0.0774777,0.187611,-0.222827,0.178422,-0.429993,-0.479923,0.966838,-0.0976029,-0.165766,-0.131179,-0.361672,-0.0549013,0.272349,-0.389277,-0.218705,-0.121793,0.28619,0.102449,-0.154365,0.0362256,-0.0673448,-0.446185,0.110682,-0.643217,-0.0207394,-0.743908,-0.116716,0.136461,-0.00630695,-0.839658,0.334298,0.229354,-0.146192,-0.183685,0.623661,-0.518678,0.337509,0.766088,-0.320201,0.0174135,0.340982,-0.370792,0.0871517,0.447145,0.581845,0.703007,0.326368,0.0195367,-0.556933,0.441329,-0.367453,0.362625,0.247503,-0.176504,-0.0126069,-0.162676,0.0883694,0.30143,0.162364,0.126312,0.327991,-0.267177,-0.293171,-0.264381,0.00990946,0.168878,0.0727611,-0.407205,0.0376315,0.277662,0.0755501,-0.414569,0.220196,-0.164507,-0.538851,0.259637,0.154005,0.101117,-0.214711,-0.288406,-0.106134,-0.673103,0.264594,-0.305749,-0.452782,-0.087317,-0.136654,0.225977,-0.164469,0.169458,0.390484,-0.357165,-0.413665,0.0825866,-0.363328,0.113377,-0.26901,-0.655592,-0.620542,-0.0302903,0.109592,0.184428,0.331047,0.429451,-1.51477 +3427.08,0.861146,0.0848144,4,1.66307,0.932345,-0.756223,0.210939,0.262271,-0.167246,-0.118376,0.0478714,0.437654,-0.144727,-0.248322,-0.258709,-0.140843,0.263024,-0.703664,0.777247,-0.0826952,-0.200971,0.10524,0.0713672,-0.415261,-0.780088,-0.908986,-0.164905,-0.590666,-0.514568,-0.332386,-0.0202789,-0.642212,-0.151932,0.527087,-0.848497,0.0512356,0.0913885,-0.447562,-0.133212,-0.300512,0.864456,0.504583,-0.776273,0.758717,0.554901,0.232966,-0.873648,0.183412,0.151356,-0.226875,0.491886,0.711898,0.191899,0.198926,0.358717,0.273076,-0.384468,0.636989,-0.515881,0.0137255,-1.02334,0.180663,-0.223961,0.625363,0.527066,-0.705214,-1.15304,0.15589,0.469861,0.102062,-0.100058,0.270638,-0.0669499,0.0230322,-0.025773,0.536071,0.365919,0.815046,0.553575,-0.170043,-0.123503,-0.301226,0.18771,-0.105075,-0.534643,0.222406,0.266851,0.341443,-0.394131,-0.401616,0.102087,0.05037,-0.334748,0.230966,0.0719203,0.434092,0.345854,0.332973,0.298458,-0.18188,-0.211158,0.565822,0.451983,0.504059,0.304709,-0.157733,0.0650336,-0.101331,-0.255107,-0.0689508,-0.594631,0.207053,0.179977,0.349146,-0.0492399,-0.576164,0.396796,0.313152,-0.32773,0.274632,0.200449,0.499039,-0.558643,-1.04802,-0.0150551,-0.336628,0.0604537,0.445206,-0.264179,0.0897023,0.783304,-0.195816,-0.595435,0.111127,-0.06484,0.108575,0.735397,-0.214098,-0.218122,-0.288129,0.148967,0.0990113,-0.43135,0.113438,0.198387,0.0162121,-0.738659,-0.175604,0.0235363,0.443996,-0.0607461,0.211008,0.38798,-0.138192,-0.062812,0.294912,-0.190182,-0.18751,0.373685,0.598221,-0.244006,-0.179113,-0.0872024,0.0887083,-0.00426978,0.475954,0.206453,0.00938633,-0.151958,-0.296796,0.00384176,-0.566389,-0.525586,0.040547,0.0862302,-0.0481862,0.155676,0.450466,-0.175073,-0.315363,0.3935,-0.0976874,0.599601,-0.556684,-0.10299,0.696412,-0.0124012,0.327432,-0.34068,0.392527,-0.246494,-0.0814662,0.161158,-0.0618257,0.13925,0.15454,-0.710157,-0.248307,-0.163238,-0.329404,-0.302305,-0.708082,-0.237222,-0.0837854,-0.30706,-0.0445952,0.152125,0.0249154,-0.465309,-0.369365,1.00733,-0.200906,0.0590174,0.238187,-0.617954,-0.161243,0.300118,-0.259524,-0.359584,-0.310222,0.218264,0.148189,-0.237324,-0.0715181,-0.0475875,-0.388329,0.0232832,-0.857596,0.19198,-0.690197,-0.184684,0.201841,-0.420244,-0.803505,-0.0537885,0.241677,-0.397636,-0.218475,0.573811,-0.540636,-0.103796,0.591603,-0.270813,-0.150917,0.0680449,-0.451392,0.205855,0.296684,0.690548,0.349617,0.389628,0.324845,-0.718736,0.139236,-0.344177,0.580259,0.249135,-0.292725,0.195396,-0.106884,0.107806,0.0808368,0.195775,0.317543,0.910261,-0.370844,-0.0302507,0.278277,0.102906,0.431343,0.424693,0.181954,0.37614,0.156103,0.119891,-0.438047,0.0909322,-0.103245,-0.161274,0.313175,0.25991,0.144168,-0.17019,-0.00255695,0.242833,-0.166654,0.415926,-0.296466,-0.188482,-0.165651,-0.0377336,0.163072,-0.241576,-0.00695133,0.367018,-0.252855,0.223449,-0.190275,-0.456606,0.26701,-0.347786,-0.702867,-0.362405,-0.140182,0.116576,0.224317,0.341432,0.473621,-0.616853 +3413.03,0.94866,0.0848144,4,1.68336,0.999541,-1.0444,0.313376,0.0744439,-0.165886,0.155206,0.343593,0.339107,0.0673104,-0.328528,-0.239897,0.295613,0.328963,-0.104943,0.375895,-0.0697981,-0.117117,-0.0326353,-0.19577,-0.547546,-0.755632,-1.07984,-0.00562601,-0.590694,-0.464964,-0.2683,0.823097,-0.563521,-0.421775,0.359572,0.0913741,-0.582508,-0.491861,-0.299179,-0.352725,-0.268863,0.666236,0.235806,-0.748802,0.906437,0.602558,-0.0914111,-0.468476,-1.00343,0.420226,-0.231978,-0.168825,0.463097,0.143074,0.466757,0.580141,-0.137686,-0.381152,0.349636,-0.410797,-0.567531,-0.177108,0.152857,-0.842494,0.00336322,1.13637,-0.16248,-0.524426,-0.215167,-0.22525,-0.340689,0.102926,0.225564,-0.465457,-0.141751,-0.395326,0.171463,0.305664,0.447546,0.394703,0.572671,0.0373663,-0.306639,-0.0553136,0.145745,0.0789592,-0.0283885,0.400957,-0.390743,-0.136243,0.0924559,-0.182959,0.482443,-0.348385,-0.567926,0.0561425,-0.0524245,-0.5749,0.21674,-0.195787,-0.111239,-0.709686,0.327486,0.442737,-0.0717474,-0.28584,-0.333913,-0.497451,0.152365,-0.214565,0.604484,-0.326645,-0.286192,0.102508,0.122906,-0.507239,0.286209,0.256992,0.248933,0.612569,-0.307698,0.234235,0.620849,-0.402455,-0.562808,-0.181265,-0.199947,0.220515,-0.00463733,0.0665879,0.268856,0.121466,0.250722,-0.701835,-0.0885505,-0.341712,0.0294499,0.612367,-0.218615,-0.0609424,-0.17585,-0.482744,0.682263,-0.352906,-0.288443,-0.328062,0.478044,0.0625023,0.64989,-0.300164,0.0350308,0.901507,0.202987,-0.723216,-0.206682,0.419098,-0.104536,0.0838126,-0.0458926,0.11843,-0.135077,0.546809,-0.029215,-0.168047,0.268675,-0.203439,1.00476,-0.269321,-0.437162,0.660728,-0.32473,-0.685968,-0.265461,-0.0366036,-0.0117856,-0.0365857,-0.122032,-0.399437,-0.149631,-0.167003,-0.191703,-0.531222,-0.42949,0.772166,0.307309,0.114919,0.175687,0.0917842,-0.211117,-0.16141,0.150623,-0.494012,0.403221,-0.939686,-0.00269623,0.465929,-0.0935931,-0.610976,0.00104909,-0.581462,-0.179032,-0.941612,-0.418869,0.371782,-0.320528,-0.605063,0.260912,0.190406,-0.529167,0.100784,0.181178,1.25152,0.170658,0.0253894,0.000624551,0.00678576,0.491393,-0.119722,-0.481352,0.4373,-0.557975,0.0694806,-0.43566,0.634259,-0.195077,0.00155458,0.422101,0.335117,0.244998,-0.0495124,-0.376055,-0.466158,0.231692,0.195888,0.583841,0.035778,0.0893274,-0.249074,-0.221846,0.384713,0.219931,-0.0423247,0.420234,-0.716662,0.477389,0.39693,0.432681,0.0416692,0.32945,-0.603594,0.138666,-0.0509244,-0.172314,0.00528153,-0.476106,-0.351751,0.411158,-0.539344,-0.275086,0.247618,-0.109894,-0.234745,0.261821,-0.125415,0.122982,0.176143,-0.0791017,-0.384447,0.600615,-0.130427,-0.124708,0.152761,0.211783,-0.08296,-0.41659,-0.39883,-0.104644,0.0439784,-0.220151,0.447072,0.135517,-0.128717,0.0203238,-0.182473,0.338154,-0.640435,-0.692515,-0.0677086,-0.0190961,0.0697849,-0.0353037,0.463024,0.252992,-0.446349,0.0369488,-0.120427,0.0935236,-0.154936,0.110694,-0.274668,0.0564792,-0.11154,0.00507942,-0.144784,0.00638329,0.108951,0.257586,0.330078,0.50753,-0.0378981 +3411.19,0.813505,0.0848144,4,1.71455,1.10564,0.00601896,-0.167863,0.611916,-0.156807,-0.238962,-0.209365,0.189944,0.378776,-0.170401,-0.336536,-0.25162,-0.0574819,-0.433252,0.883272,0.110172,-0.37452,-0.00268219,-0.301217,-0.380805,-0.91052,-0.809029,-0.093248,-0.236544,-0.211861,-0.0275976,0.367383,-0.164839,-0.478966,0.358548,-0.920874,0.242997,0.469233,-0.0329259,-0.503577,-0.0856537,0.461837,0.764702,-0.214141,0.98162,0.700101,0.23255,-0.275454,0.125314,-0.892659,-0.395077,0.167125,0.277761,0.127332,0.0249994,-0.545243,0.0886401,-0.730663,0.969426,0.00546328,-0.249463,-1.35831,0.957193,-0.220348,0.316933,0.725296,-0.864714,-1.41675,-0.153032,0.58754,-0.260002,0.163072,-0.111501,-0.496284,-0.309464,0.479447,0.805249,-0.298498,0.767993,0.252695,-0.0598246,-0.344189,-0.342387,0.0313325,0.158841,-0.534919,-0.0874414,0.146724,0.396756,-0.32091,-0.787486,0.172871,0.0378974,0.0687349,0.148659,0.0521999,0.13413,-0.290573,0.135835,-0.691746,-0.136752,0.227613,-0.140412,-0.0155334,-0.250114,0.338262,-0.890381,0.10481,0.282549,-0.268422,-0.320578,-0.639699,0.261564,0.37186,0.0690749,0.357711,0.420203,0.465003,0.139418,0.0252262,-0.0509257,-0.422252,0.0379341,0.0728061,-1.21531,0.253832,-0.437766,-0.0242306,-0.395223,0.472729,0.354847,-0.230266,-0.162644,-0.0209256,0.0346354,0.018839,-0.0272212,0.48564,-0.180662,-0.326051,-0.301123,-0.116714,-0.192304,-0.668119,-0.158852,-0.122184,-0.430083,-0.84235,0.225221,-0.481487,-0.0641131,0.143935,-0.0620491,0.361525,-0.293622,-0.530358,-0.196456,0.164168,0.0597863,0.180686,-0.312741,-0.0800204,-0.521481,-0.642147,-0.00571865,-0.150101,0.788669,-0.0401658,-0.272854,-0.00295941,-0.191287,-0.0535621,-0.164537,0.140594,-0.0215146,0.00815349,0.0170725,-0.133321,0.51779,-0.0167177,-0.609488,0.604854,0.0750547,0.225261,-0.569757,-0.00630265,0.282352,-0.314886,-0.0563325,-0.457007,-0.196969,-0.322162,-0.515228,-0.0880412,-0.250522,-0.504433,0.232041,-0.525977,0.0891864,0.68807,-0.0459166,-0.146413,-0.738656,0.281061,-0.39012,-0.253529,0.379728,-0.436551,-0.126381,-0.28319,-0.0948256,1.00967,-0.0301318,0.368983,-0.186271,-0.260822,0.254851,0.0601091,-0.444943,-0.611239,-0.0279033,0.307972,-0.00757077,-0.901018,-0.430326,-0.295058,-0.5526,-0.181214,-0.682448,0.626324,-0.420752,-0.0446011,0.216473,0.0153885,-0.360495,0.0502418,-0.34606,-0.0525617,-0.00413479,0.21675,-0.171869,0.2347,0.446814,-0.430466,-0.141729,-0.0229598,-0.0524053,-0.474114,-0.122112,0.522392,0.179245,0.511888,0.156798,-0.509042,0.0122551,-0.589655,0.0958621,0.267939,-0.400055,0.177765,-0.497666,-0.364979,0.254782,-0.0523202,0.247381,0.322037,-0.0110484,0.419546,-0.377163,0.501532,0.543853,-0.349328,0.108015,0.314218,-0.0521228,0.399242,-0.77268,-0.0472074,-0.00234978,0.0261749,0.0539494,0.214295,0.499646,-0.156724,0.0726564,0.339932,-0.410327,-0.106785,0.0236301,-0.173185,-0.226493,0.149708,0.313805,-0.039767,0.104123,-0.308631,0.133227,0.772076,-0.61711,-0.350213,-0.0124214,-0.00734415,-0.546525,-0.203562,0.034839,0.12201,0.189336,0.349299,0.435127,-2.07637 +3410.08,0.983473,0.0848144,4,1.62071,1.06761,-0.48312,-0.0795464,0.588863,-0.241931,0.196849,0.100038,0.504641,0.0762381,-0.0678405,-0.235036,-0.361206,-0.0972002,0.0233957,0.492009,-0.270619,-0.0569613,0.0394309,-0.269617,-0.604755,-0.98806,-1.17286,-0.167476,0.0654074,-0.741148,-0.559604,0.885393,-0.127064,-0.0534753,0.173829,-0.497782,-0.00269534,-0.243,0.414411,-0.0803166,-0.467058,0.423801,0.634711,-0.0738653,1.49555,0.362177,-0.162283,0.101339,-0.251899,-0.684065,-0.528362,0.245098,0.583309,0.636379,-0.0367624,-0.133074,0.15286,-0.410121,0.880119,0.148337,-0.330521,-0.726374,0.602069,-0.752915,0.112924,1.33658,-0.993419,-1.87323,0.18103,0.108857,-0.150062,-0.260298,0.0508453,-0.695723,-0.417328,0.521634,0.380661,-0.430927,0.378841,0.298575,0.452629,-0.325675,-0.189451,-0.333906,0.359675,-0.418288,0.0592695,0.0243236,-0.0651152,-0.224688,-0.169807,-0.515356,0.135367,-0.200455,-0.031669,-0.426304,-0.31001,-0.100874,0.450276,-0.326439,0.121577,0.0432318,0.391485,-0.35396,-0.0989969,0.354106,-0.800629,0.569106,0.0762129,-0.544314,0.456946,-0.267267,0.013873,0.781394,0.422919,-0.207291,0.0845722,0.562533,-0.0989997,0.577167,-0.0347841,0.497794,-0.627776,-0.662996,-0.848106,0.12201,-0.0967016,0.0343583,-0.506082,0.257206,0.50125,0.686114,-0.00216692,-0.214114,-0.527414,0.0700959,0.159099,0.489395,-0.523862,-0.270611,-0.388035,-0.153571,0.238746,-0.485241,-0.216427,-0.0150345,-0.0723363,-0.97948,0.00588708,0.267998,-0.0613455,0.252872,0.0971061,0.254172,-0.309339,0.166862,0.247148,-0.0663546,0.295309,0.345711,-0.195895,-0.923189,-0.148213,-0.0844614,-0.0152005,-0.115856,0.493108,0.434975,0.0664598,-0.191058,-0.162835,-0.714052,-0.260267,0.0407958,-0.133883,0.0929876,0.120642,-0.382105,-0.0606838,0.0998089,-0.531308,0.301526,0.261928,0.423805,-0.376151,0.109282,0.0122856,0.0160599,-0.0285832,-0.260008,-0.291609,-0.0769152,0.191614,-0.366605,0.282729,-0.551803,-0.256453,-0.804233,-0.0644454,0.122716,-0.0976462,-0.15936,-0.379771,0.182447,-0.0533822,-0.0248656,0.45914,0.0684501,-0.0127124,-0.416731,-0.285478,0.920993,0.583165,0.303358,-0.280772,-0.208052,0.315124,0.465888,-0.410558,-0.712688,-0.0789671,-0.347103,0.318125,0.0374369,-0.312066,-0.472996,-0.062678,-0.0722663,-0.979433,0.741079,-0.324728,0.0230239,0.228135,0.183447,-0.0364584,0.348947,0.0648566,-0.361875,0.174002,0.374898,-0.120032,-0.380341,0.288943,-0.577623,-0.654094,0.371971,-0.336665,0.177493,0.360908,0.781569,0.0351765,0.120839,0.221797,-0.258317,0.00299033,-0.539968,0.318559,-0.282847,-0.213356,0.222098,0.0220761,-0.539273,-0.618194,0.0320365,-0.428071,0.385031,0.498377,0.129972,-0.436095,0.214035,0.0080522,-0.378269,-0.121908,-0.185358,-0.38193,0.0092517,-0.653878,-0.166863,-0.627152,0.102531,0.0383647,0.227756,0.57522,0.344366,-0.0469401,-0.065223,-0.232182,-0.0481092,-0.0328679,-0.157814,-0.021507,0.411484,0.288004,0.350932,0.220762,-0.0128799,0.466967,0.768618,-0.0757495,-0.416507,-0.338862,0.148799,-0.358266,-0.634868,0.154662,0.150551,0.423704,0.388009,0.650926,-1.8319 +3397.89,0.56972,0.0848144,4,1.61473,0.975219,-0.698354,0.0257415,1.00007,-0.164888,0.263949,0.151937,0.334951,0.107952,0.0678122,-0.257933,-0.313132,-0.322767,-0.187487,0.811707,0.0128082,-0.0919375,0.101651,-0.289472,-0.310159,-1.12317,-0.648907,-0.217902,0.0193058,-0.818919,-0.458753,0.230576,-0.178991,-0.0585656,0.367558,-0.515852,-0.250245,-0.0466903,0.0627292,-0.341511,-0.657141,0.647722,0.643104,-0.0267491,1.33657,0.537275,-0.0977137,-0.108165,-0.271967,-0.787676,-0.396911,0.306811,0.797552,0.759587,-0.201911,-0.147844,0.274567,-0.323339,1.03307,0.226635,-0.149882,-0.785624,0.767112,-0.201396,0.255261,1.169,-1.19874,-1.95835,-0.255798,0.259041,-0.188446,-0.470678,0.221713,-0.693406,-0.423807,0.358093,0.603031,-0.360032,0.598724,0.135497,0.180788,-0.0542851,0.0554583,-0.382542,0.371074,-0.664573,0.145443,-0.283601,-0.0697575,-0.380254,-0.238625,-0.481808,0.19828,-0.140061,0.280746,-0.683073,-0.373151,-0.0662232,0.414554,-0.109904,-0.0206159,0.131834,0.375335,-0.276723,-0.172826,0.304239,-0.561867,0.27944,0.473525,-0.385476,0.521455,-0.192214,0.156218,0.644676,0.377905,-0.339186,-0.358069,0.402672,-0.523226,0.471497,-0.203489,0.307291,-0.606756,-0.435148,-1.03198,0.266446,-0.00667595,-0.0378211,-0.330487,-0.00582326,-0.0673155,0.720402,0.0673949,-0.543659,-0.41347,0.0191096,0.238152,0.257371,-0.660004,-0.169102,-0.382208,-0.308082,0.336717,-0.40284,-0.618468,-0.12846,-0.231253,-1.16951,-0.0615967,0.44902,-0.361914,0.329818,0.1401,0.187147,-0.230154,0.183394,0.154025,-0.150387,0.334137,0.360004,-0.0887204,-0.537755,-0.247737,-0.00427119,-0.251341,-0.162902,0.519453,0.426602,-0.0619325,-0.31885,-0.067431,-0.686032,-0.363583,-0.0867861,-0.118108,-0.148508,0.13078,-0.249073,0.121846,0.447696,-0.475865,0.594647,-0.0940923,0.579201,-0.155669,0.41391,0.0726541,0.0128538,-0.146175,-0.0920191,-0.21478,-0.402273,0.254499,-0.266347,0.247321,-0.576114,-0.00855911,-1.04938,-0.0656082,-0.0319592,-0.000300282,-0.325714,-0.284744,0.439668,-0.293173,-0.159929,0.456237,-0.200125,-0.146639,-0.667007,-0.46755,0.924904,0.422652,0.370043,-0.287971,-0.307105,0.378296,0.379445,-0.32119,-0.554953,-0.0508938,-0.246642,0.184143,0.0282312,-0.319218,-0.305038,0.0581083,-0.12505,-1.02181,0.620811,-0.608936,-0.0360879,0.842587,0.195533,0.0625221,0.332469,-0.365582,-0.587618,0.054048,0.430428,-0.0439705,0.17634,0.432928,-0.46452,-0.576501,0.556836,-0.226419,-0.034378,0.360731,1.01178,0.0890977,0.0291122,0.264774,-0.119571,-0.210223,-0.663879,0.444132,-0.517715,-0.322267,0.0971913,-0.121266,-0.5141,-0.629953,-0.0110984,-0.518137,0.0584822,0.678753,-0.156726,-0.518108,-0.118085,-0.0825218,-0.122193,0.0809827,-0.132212,-0.547019,0.0319702,-0.754726,-0.276096,-0.522134,-0.172363,0.0525578,0.0755937,0.428331,0.436278,-0.168093,0.0518711,-0.265481,-0.559651,0.225752,-0.0329267,-0.156177,0.313536,0.331849,0.440124,0.242509,-0.248791,0.226833,0.584808,-0.10504,-0.417752,-0.236001,0.0838874,-0.413031,-0.789224,0.155821,0.150023,0.349575,0.387328,0.591249,-3.04569 +3412.26,0.968449,0.0848144,4,1.62848,1.0438,-0.817933,0.0852458,0.715313,-0.158391,0.182145,0.407512,0.228967,0.0237077,-0.0345224,-0.290834,-0.203893,-0.302715,-0.110231,0.862698,-0.199605,-0.111642,-0.0144676,-0.361141,-0.609438,-1.21149,-0.357171,0.0620606,-0.152485,-0.80903,-0.671536,0.240528,-0.0643058,0.000193896,0.45472,-0.617616,-0.402434,0.0122393,0.30771,-0.129771,-0.861969,0.896725,0.559151,-0.150985,1.30352,0.460881,-0.141966,-0.218729,0.178172,-0.36076,-0.455936,0.2974,0.436962,0.59156,-0.250129,0.00347762,0.182462,-0.373275,0.950664,0.0392195,0.0336217,-1.15067,1.00545,-0.208649,0.154797,1.3203,-1.1765,-2.17141,-0.234327,0.204879,-0.364711,-0.487233,0.206423,-0.49465,-0.583312,0.15259,0.393916,-0.139947,0.629468,0.0657895,0.0687503,0.0146028,-0.0266422,-0.307311,0.449192,-0.523367,0.219455,-0.368521,0.13326,-0.376917,-0.262674,-0.395404,0.0192873,-0.227683,0.393708,-0.585507,-0.0944887,0.199066,0.0967671,-0.393305,-0.0336425,-0.0472234,0.192118,-0.124486,-0.362762,0.787642,-0.561028,0.308556,0.225942,-0.130678,0.632113,-0.126376,0.04285,0.830718,0.431101,-0.357848,-0.410204,0.488323,-0.27803,0.354443,-0.330764,-0.227699,-0.497488,-0.367822,-0.9068,0.23558,0.11361,-0.15162,0.0125544,-0.345948,-0.282804,0.693508,0.065304,-0.364873,-0.314346,0.2565,0.298746,0.337572,-0.59355,-0.207531,-0.39584,-0.261346,0.221273,-0.485547,-0.735163,-0.215519,-0.136443,-1.01405,0.093501,0.740489,-0.253717,0.435031,0.000182762,0.152027,-0.44425,0.186774,0.312301,-0.216422,0.314072,0.254934,-0.0869732,-0.587616,-0.124338,-0.0857064,0.170707,-0.316402,0.692644,0.329119,-0.0240773,-0.229846,-0.035962,-0.558894,-0.239957,0.165275,-0.461482,-0.15031,-0.00102346,-0.51106,-0.0242414,0.587181,-0.479616,0.174941,0.15078,0.583289,0.00324661,0.214571,0.131548,0.163511,-0.402427,-0.276397,-0.395448,-0.272254,0.206736,-0.11377,0.00998476,-0.162773,-0.200615,-0.900308,0.197333,-0.1242,-0.172601,-0.267281,-0.417399,-0.129349,-0.346758,-0.396575,0.538437,-0.140139,-0.0223301,-0.504209,-0.251296,0.87254,0.272365,0.601341,0.210451,-0.237032,0.409839,0.523987,-0.449366,-0.584294,-0.257937,-0.270769,0.204792,0.112459,-0.0429687,-0.204177,0.0449205,-0.195569,-0.977731,0.336821,-0.555392,0.0585014,0.955024,0.00849763,-0.268333,0.123042,-0.318899,-0.453631,0.0286452,0.237493,-0.109927,-0.138818,0.404417,-0.522208,-0.504519,0.445071,0.0933509,-0.0796702,0.214613,0.717959,0.370083,0.147265,0.0374368,-0.0480813,-0.0365935,-0.680756,0.53172,-0.617721,-0.375172,0.0605072,-0.244338,-0.514491,-0.652357,-0.322282,-0.657539,0.466319,0.643842,-0.127784,-0.610515,0.0510233,0.0893735,-0.0591916,0.0141157,0.0139569,-0.368713,0.17006,-0.754642,0.13233,-0.0363217,-0.174987,0.0254122,-0.134298,0.260351,0.535535,-0.141686,0.232758,-0.179415,-0.351068,0.0755689,-0.212245,0.0734446,0.376726,0.0267795,0.471923,0.2427,-0.0502544,0.427118,0.472734,-0.428191,-0.217465,-0.283609,0.0178742,-0.458812,-0.42394,0.0820629,0.156688,0.313995,0.395838,0.560353,-2.20308 +3411.31,1,0.0848144,4,1.6258,0.986186,-0.651991,0.168789,1.059,-0.168728,-0.200962,-0.186646,0.510623,0.188254,-0.00331645,-0.237102,-0.348355,-0.15798,-0.520686,0.816801,0.00338768,0.156797,-0.307441,-0.643974,-0.145888,-1.11593,-0.79008,-0.36094,-0.0633198,-0.103947,-0.113368,0.352705,0.474734,0.332819,0.374548,-0.724679,-0.541948,-0.0176042,-0.101817,-0.1343,-0.308465,0.548129,0.490624,0.162866,1.07766,0.707659,-0.136485,-0.197317,0.113022,-0.502805,-0.0938076,0.208739,0.412539,0.371801,-0.216784,0.111895,0.501383,-0.251242,0.793821,-0.122552,0.0879206,-0.970411,0.79995,-0.554558,0.290993,0.970501,-0.863926,-1.38601,-0.0446879,0.0244484,-0.951972,-0.325175,-0.496742,-0.372887,-0.650875,-0.110893,0.687269,-0.359195,0.673495,0.172902,0.182705,0.147408,-0.184604,-0.503818,0.369267,-0.535752,0.257627,-0.043068,-0.322553,-0.357269,-0.411944,-0.721856,-0.464189,-0.314649,0.0839791,0.267288,-0.242927,0.0757824,-0.215307,-0.474932,-0.366022,-0.177713,0.620953,-0.0908958,-0.190247,0.726346,-0.702844,-0.385508,0.33812,-0.148653,0.342419,-0.239245,0.515093,0.907192,-0.0709207,-0.731111,-0.141729,0.411615,0.0109382,-0.144596,-0.424599,-0.118511,-0.0958762,0.225613,-0.437987,-0.319133,0.175678,-0.55056,-0.178988,-0.0559099,-0.0320808,-0.332019,0.247831,-0.503266,0.193,0.077357,-0.00997707,0.476753,-0.667213,-0.124799,0.29786,-0.186919,0.420787,-0.604707,-0.397888,0.208898,-0.0961178,-0.182556,0.321946,0.514561,-0.25015,-0.108766,-0.0972783,-0.23261,-0.230757,0.311057,0.293669,-0.265186,0.387745,-0.20138,-0.408285,-0.184193,-0.298543,-0.0999374,0.273981,0.239105,0.400906,0.158564,0.302544,-0.241797,-0.268016,-0.557828,-0.638459,0.183093,0.236241,-0.577847,0.196339,-0.143687,-0.662944,0.762616,-0.435736,-0.183996,0.0361248,0.2453,0.000468771,0.232936,0.389111,0.277543,-0.140381,-0.0654675,0.0358763,-0.499747,-0.109583,-0.42469,0.145449,0.0933457,0.0641822,-0.909364,-0.221636,0.35269,0.440335,-0.282828,-0.185512,0.201334,-0.00881288,-0.324412,0.697909,0.403643,0.648516,-0.0689005,-0.440626,0.891848,-0.313232,0.613897,0.167215,-0.184284,0.248547,0.13389,-0.0441329,-0.0565439,-0.411082,-0.0177644,-0.072056,-0.14528,0.118834,-0.49566,0.140265,0.376926,-1.27206,0.255556,-0.696854,-0.274694,0.33204,-0.172069,-0.0232474,-0.0737896,-0.734251,-0.394892,0.0714244,0.147872,0.0898481,0.00746166,0.699704,-0.0414588,0.520446,0.346442,-0.354605,0.039198,0.339468,0.293578,0.397114,0.194702,0.0338054,-0.304783,-0.0308356,-0.44827,0.399231,-0.283845,-0.165259,0.363014,-0.0427238,-0.496886,-0.475762,-0.137656,-0.140431,1.27325,0.663347,-0.369978,-0.440518,0.0990982,0.237832,0.415998,0.516893,0.175456,-0.800816,0.120203,-0.622564,0.290985,0.121223,-0.295587,-0.123715,-0.26053,-0.34968,-0.0262602,-0.113309,0.196861,-0.422581,-0.242458,0.132856,0.135215,0.203827,0.0812702,-0.486975,0.186207,-0.0249253,0.0845327,0.0843575,0.413355,-0.334387,-0.376731,-0.692885,-0.284705,-0.284321,0.177851,0.269199,0.12695,0.266892,0.3563,0.516616,-3.40869 +3416.35,0.996432,0.0848144,5,1.58637,1.15466,-0.585989,0.0673195,1.036,-0.0873047,-0.603288,0.39267,0.373818,0.164848,-0.338888,-0.27437,-0.406915,-0.315424,-0.201899,0.612807,0.0706148,0.350386,-0.111756,-0.418465,-0.497074,-1.18448,-0.732015,-0.259553,-0.275612,-0.266357,-0.344671,0.431173,0.0232964,0.183623,0.242546,-0.337561,-0.236845,0.145391,0.0678524,-0.40324,0.23717,0.967484,0.478149,-0.142008,1.26293,0.206882,-0.0176595,-0.0477277,-0.130968,-0.434975,-0.582553,-0.0133177,0.308953,0.220578,-0.0970506,0.289049,0.490802,-0.347871,0.84985,-0.368974,-0.0339529,-0.95444,0.904309,-0.495678,0.0948766,0.92721,-0.227053,-0.945007,0.436433,-0.0256098,-0.553132,0.117041,-0.123554,-0.0860648,-0.494256,0.456136,0.717876,-0.465145,0.733106,0.26088,0.0828638,0.0587776,-0.168896,-0.16068,0.539087,0.135755,0.404612,-0.034747,-0.0102908,0.231748,-0.426724,-0.167985,-0.140603,0.00351191,-0.147797,0.492965,0.0684772,0.145676,-0.334625,-0.607346,-0.267944,0.26391,0.328476,-0.0422642,0.146837,0.150105,-1.15753,-0.609959,-0.0230153,-0.797075,0.144452,-0.535567,0.250838,0.518951,0.258045,-0.143713,0.123602,0.415654,-0.0417805,0.110577,-0.0811232,-0.234373,-0.00847401,0.258094,-0.880486,-0.0877265,-0.334312,-0.984629,0.445449,-0.0107423,0.110165,0.276416,0.183981,-0.226634,0.473663,0.293798,-0.0285595,0.921539,-0.737774,-0.12731,0.181739,0.114897,-0.0350494,-0.683171,-0.193869,-0.143673,0.0996851,-0.472923,0.145266,0.0441323,0.0531413,0.353557,0.130855,-0.197562,-0.308757,0.218194,-0.000741794,0.163659,0.179337,-0.463029,-0.447588,0.152587,-0.527329,0.109704,0.013518,-0.0482066,0.148378,-0.644765,-0.208661,-0.275568,-0.0096015,-0.342227,-0.0342331,0.307465,-0.0350564,-0.00163061,-0.116402,-0.17504,-0.178096,0.59896,-0.474732,0.366692,-0.137421,0.229426,-0.0417393,-0.374685,-0.183674,0.0994743,-0.0900606,-0.183908,0.0953718,-0.922244,-0.148215,-0.174714,-0.0963758,0.0382698,0.480819,-0.815948,-0.0221693,0.309688,0.0975565,-0.774648,0.0384274,-0.232429,-0.00945131,-0.243529,0.116311,0.236764,0.670325,-0.196503,-0.629157,1.25448,-0.294396,0.806817,0.320115,0.238049,0.375185,-0.280768,0.111626,0.0428701,-0.437697,-0.134176,0.0749408,-0.560478,-0.622558,-0.296562,-0.199372,0.530851,-0.434894,0.184432,-0.37945,-0.0721422,0.315412,-0.582669,0.386945,0.0733681,-0.608577,0.046258,-0.139606,0.0141536,0.0370214,0.179539,0.8347,0.203136,0.2201,-0.172796,-0.0912317,-0.401536,0.576818,0.277093,0.621009,-0.108674,-0.19987,-0.334648,0.166954,-0.209993,-0.184243,0.00281817,0.113206,0.456669,-0.257167,-0.309632,-0.371855,0.0603218,0.330633,0.44864,0.343795,0.06092,-0.140991,0.0876566,0.0360322,0.224278,0.246951,0.618001,-0.389103,0.156727,0.301042,-0.563973,0.506358,0.24546,0.262628,0.248617,-0.212131,-0.211491,0.230022,0.254086,0.312609,-0.323136,-0.0126564,0.0771435,0.2794,0.439812,0.0857829,-0.542091,-0.0584621,0.35129,0.265972,0.510205,-0.0254566,-0.450097,-0.0733184,0.257829,-0.58378,0.24805,0.197461,0.152269,0.25802,0.390217,0.507957,-3.62845 +3417.79,0.895265,0.0848144,4,1.57541,1.11061,-0.621881,0.105405,1.14225,-0.129697,-0.709598,0.367136,0.490668,0.165055,-0.229838,-0.238436,-0.484659,-0.316138,-0.164004,0.683064,0.0863504,0.367468,-0.077781,-0.520723,-0.40419,-1.26886,-0.776276,-0.440759,-0.276179,-0.309623,-0.408854,0.517021,0.11306,0.280889,0.249334,-0.320721,-0.282747,0.0880156,0.167939,-0.396894,0.215607,1.00273,0.500453,-0.0572717,1.22598,0.196273,0.132462,-0.13583,0.13626,-0.384048,-0.559223,0.131013,0.458302,0.128377,-0.141729,0.247761,0.591964,-0.195517,0.791133,-0.392071,0.060322,-0.950474,0.852355,-0.507927,0.143372,1.04753,-0.176508,-0.905876,0.334142,0.0198544,-0.443222,0.00616695,-0.338029,-0.313215,-0.509829,0.365762,0.70129,-0.609811,0.875838,0.21245,0.199861,0.357273,-0.221484,-0.0642993,0.642817,-0.0100492,0.242688,-0.101431,-0.0944866,0.169038,-0.479472,-0.256164,-0.304279,0.0290078,0.0293016,0.531791,0.0771707,0.231572,-0.304824,-0.620361,-0.276676,0.146772,0.218349,0.126497,0.214879,0.232105,-1.16996,-0.527505,0.0153211,-0.904036,0.211361,-0.624971,-0.0213231,0.673446,0.441169,-0.126955,0.0996139,0.379925,0.0189868,-0.0068608,-0.0354804,-0.199877,0.134956,0.281324,-0.612448,-0.145039,-0.463821,-1.12036,0.326982,-0.0050544,0.167706,0.28441,0.307981,-0.0948079,0.325729,0.259079,-0.109599,0.702693,-0.654451,-0.00717043,0.388716,0.217048,-0.192565,-0.717876,-0.156746,-0.275005,-0.00499424,-0.425382,0.178789,0.0333198,0.0442037,0.266462,0.159296,-0.225969,-0.365876,0.31272,-0.033381,0.13855,0.0992813,-0.465183,-0.318327,0.250748,-0.477013,0.157015,0.173859,-0.0909552,0.198353,-0.646846,-0.256885,-0.15058,0.0831221,-0.380521,-0.00123975,0.450028,0.0018962,-0.158603,-0.142672,-0.266904,-0.164095,0.69964,-0.510957,0.385127,-0.0370152,0.317245,0.0605216,-0.443023,-0.273375,0.0380478,0.038861,-0.359279,0.126118,-0.87543,-0.0843462,-0.279139,-0.0588367,0.0390572,0.465701,-0.960523,-0.0239743,0.240809,-0.0852766,-0.598972,0.0207168,-0.0278038,0.000477489,-0.315305,-0.00812546,0.27949,0.52941,-0.0691725,-0.528055,1.20748,-0.0907837,0.875739,0.293662,0.0773792,0.425085,-0.281654,0.131325,0.0892975,-0.313477,-0.0522744,0.0752571,-0.403862,-0.517123,-0.374211,-0.0789741,0.472855,-0.214244,0.157893,-0.392703,-0.224944,0.349547,-0.688832,0.410783,0.240683,-0.448252,-0.0428572,0.103028,0.0898805,-0.0428884,0.11122,0.852939,-0.0373808,0.063421,-0.249062,-0.0522645,-0.290861,0.773787,0.396447,0.513948,-0.0381649,-0.334048,-0.34347,0.158675,-0.199637,-0.204876,0.0950372,0.0797285,0.3915,-0.0911396,-0.388105,-0.282244,0.0424603,0.267397,0.291357,0.40708,0.0863545,-0.180682,-0.0174163,0.0393658,0.302054,0.1751,0.544508,-0.252859,0.229516,0.376464,-0.510222,0.603598,0.0470873,0.198568,0.372126,-0.0720152,-0.210269,0.232827,0.106219,0.0482182,-0.17794,-0.0699802,0.0307984,0.112769,0.44191,0.0998697,-0.744099,-0.124431,0.314525,0.322408,0.586748,-0.0629513,-0.32379,-0.0933291,0.0572624,-0.459404,0.368926,0.28755,0.142453,0.253081,0.377429,0.503071,-3.92092 +3422.32,0.840905,0.0848144,4,1.54053,1.00713,-0.969423,0.279195,0.870315,-0.159252,-0.183441,0.183527,0.235807,0.0136796,0.0983266,0.0455188,0.000467536,0.128468,-0.287748,0.808439,-0.0844899,-0.385268,-0.0285274,-0.211113,-0.0587044,-0.974178,-0.502087,-0.0788164,-0.283894,0.260838,-0.187866,0.409674,-0.216464,0.124806,0.220353,-0.737508,0.19872,-0.0672616,-0.308679,-0.0593601,-0.263104,1.13106,1.06771,-0.0691418,0.89146,0.658427,0.308416,-0.39417,0.427897,0.057296,-0.275678,0.291948,0.388927,0.316573,-0.0635691,0.259196,0.251986,-0.190761,0.775526,0.136726,-0.0498652,-0.961065,0.596684,-0.46931,0.0535292,0.72284,-0.66285,-1.29414,-0.0599131,0.361136,-0.341632,-0.38748,-0.0122278,-0.443385,-0.251525,0.758783,0.592947,-0.364693,0.598285,0.548505,0.301106,-0.166551,-0.217048,-0.245374,0.297176,-0.0896868,0.0997033,-0.276025,-0.0330002,0.523664,0.245936,-0.362588,-0.199905,-0.0419768,-0.217662,0.356531,0.0811989,0.176424,-0.0359235,-0.447098,-0.372239,-0.816503,-0.00204979,0.0437705,0.099162,0.253966,-0.381364,-0.282089,0.399047,-1.02823,0.586243,-0.293177,0.920032,0.755155,0.44825,-0.415363,-0.601594,0.249744,-0.24079,-0.224062,0.0237816,0.199392,0.0702121,0.308658,-0.620131,0.406763,-0.1094,-0.399581,-0.109818,0.227254,-0.0815854,-0.045974,-0.052684,-0.559216,0.344417,0.208743,0.141795,0.574836,-0.161612,0.261279,0.262597,-0.139329,0.334689,-0.46629,0.0620853,-0.0229118,-0.0843132,-0.113619,0.687021,0.285577,-0.00185616,-0.135826,0.226524,0.0791649,-0.237793,-0.0464502,0.0493697,0.355311,-0.188643,-0.449327,0.121808,-0.64977,0.324213,-0.274195,0.692158,-0.418392,0.409976,0.00233346,0.32837,0.400133,-0.294121,0.0533361,-0.23667,-0.389728,0.0386927,-0.0786902,-0.0509275,-0.337882,-0.284327,0.176844,-0.615549,-0.00570937,0.323072,1.1792,0.198475,-0.415005,0.92369,0.337323,-0.0557827,-0.336688,-0.239539,-0.723972,-0.128933,-0.78991,0.0102741,0.126131,-0.0910901,-0.717577,-0.478859,0.0825268,0.104419,0.0503151,-0.0982646,-0.30353,-0.448363,0.116644,0.502506,0.605507,0.0811674,0.0309596,-0.286584,1.25188,-0.1355,0.949404,0.138302,-0.244362,0.54775,0.0424507,-0.326564,0.205184,-0.285866,0.0255199,0.375433,0.445321,0.241843,-0.662599,-0.0842343,0.393077,-1.05358,0.561796,-0.594439,-0.522754,0.144236,-0.37952,0.138768,-0.279619,-0.131207,-0.433659,-0.480398,0.20222,0.189381,-0.103812,0.486746,-0.0324713,-0.0180789,-0.163995,0.518897,-0.635193,0.463575,-0.47594,0.622238,0.319801,-0.731697,-0.470069,0.0607151,-0.782649,0.385007,-0.129923,-0.0686823,0.361128,-0.974353,0.522329,-0.0880283,0.147849,0.34151,0.218482,-0.248277,0.429636,-0.0206053,0.351537,0.0609649,0.166596,-0.237534,0.261275,-0.197404,-0.773686,-0.399951,-0.378363,-0.050097,-0.0438848,-0.0821503,-0.0726641,0.144089,0.14082,-0.283008,-0.48586,0.341526,-0.301854,-0.13789,0.242503,-0.231653,0.3834,-0.183062,-0.434886,0.129197,0.212069,0.181749,0.096441,-0.0893088,-0.734843,-0.0950791,-0.225158,-0.0804751,0.0538011,0.266001,0.134813,0.211346,0.367169,0.459724,-2.84491 +3416.54,0.859241,0.0848144,4,1.55058,0.977053,-0.807662,0.245417,0.761369,-0.145262,-0.498053,0.377032,0.426284,0.0720647,0.109134,-0.214062,0.187121,0.0194908,-0.30935,0.908941,0.0723555,-0.276194,-0.111969,-0.342082,-0.241002,-1.18921,-0.298751,0.180092,-0.320059,0.0695312,-0.25855,0.393931,-0.458496,0.149771,0.326638,-0.741135,0.271999,-0.0276699,-0.456005,-0.174551,-0.146526,0.728296,0.856378,-0.162156,0.974551,0.743725,0.200374,-0.386554,0.402147,0.316333,-0.0745528,0.171678,0.522144,0.218922,0.0402749,0.313222,0.236393,-0.00864813,0.698589,0.161692,-0.103117,-0.489972,0.619991,-0.16538,0.31483,0.947204,-0.533656,-0.741285,-0.0381662,0.246535,-0.428174,0.0257968,0.184919,-0.303516,-0.23427,0.557653,0.620411,-0.380769,0.531392,0.585755,0.350342,-0.253305,-0.409306,-0.173324,0.265217,-0.141233,-0.101573,-0.0795206,-0.192691,0.469835,-0.11838,-0.404911,0.0280379,-0.218052,-0.271848,0.206153,0.266605,0.181406,-0.149051,-0.389079,-0.411215,-0.976519,0.31031,0.238991,-0.00531852,-0.237926,-0.405644,-0.027342,0.223208,-1.17098,0.502699,-0.245451,0.658261,0.482874,0.252186,-0.475752,-0.303034,0.30975,-0.272092,-0.123014,-0.311158,0.153688,0.195179,0.0695701,-0.801839,0.507803,-0.0895933,-0.526212,-0.215338,0.356257,-0.0572749,-0.431914,0.105411,-0.493518,0.0167496,-0.0384556,0.00971231,0.693718,-0.247995,0.426366,0.345807,-0.106265,0.337427,-0.791504,-0.261811,-0.0213926,-0.0343743,-0.422332,0.637332,0.183257,0.303653,-0.466242,0.305771,0.180566,-0.334586,0.0658289,0.0978999,0.249337,-0.357989,-0.146012,0.0047157,-0.691609,0.33386,-0.367499,0.366379,-0.215957,0.215508,0.061333,0.481187,0.395171,-0.352068,0.0681501,-0.191102,-0.0557903,0.0938192,-0.183681,-0.0675031,-0.25766,-0.51302,0.179577,-0.190548,-0.273381,0.233864,1.11969,0.238832,-0.160291,0.608132,0.539989,-0.138823,-0.310562,-0.282775,-0.819037,-0.315385,-0.765325,-0.0769438,-0.144943,-0.0109885,-0.778889,-0.451322,0.0470931,0.0807746,-0.312317,0.0534833,-0.126787,-0.108116,0.130968,0.412921,0.685297,0.351901,-0.237137,-0.65776,1.13757,0.0322003,0.739031,0.298186,-0.394443,0.666543,0.458383,-0.553892,0.0201738,-0.317809,-0.0642507,0.352524,0.333627,0.193344,-0.482683,-0.207627,0.231559,-0.820105,0.414153,-0.651328,-0.285304,0.0593005,-0.633716,-0.204076,-0.148983,0.244088,-0.238991,-0.214745,0.486043,0.0810386,-0.0178375,0.179015,-0.254956,-0.0313926,-0.359292,0.434574,-0.746996,0.417805,-0.644807,0.600858,0.466034,-0.97823,-0.357775,-0.0456061,-0.745245,0.469698,-0.072861,-0.38512,0.551493,-0.944928,0.488696,-0.178441,0.238411,0.315383,0.19301,-0.313171,0.495923,0.0602857,0.342674,0.12202,0.191536,-0.00522195,0.340364,-0.214794,-0.875935,-0.362047,-0.458701,0.0293444,-0.315033,0.0911872,0.288114,-0.0126203,0.243859,-0.445599,-0.517813,0.247241,-0.174527,0.134264,0.112824,-0.203083,0.157142,-0.515802,-0.305084,0.0265297,0.460617,0.241822,-0.214995,-0.169494,-0.7365,0.00637273,-0.255949,-0.205829,0.51405,-0.271644,0.1645,0.204051,0.405586,0.45172,-2.47646 +3403.51,0.73791,0.0848144,4,1.6065,0.898379,-1.11167,0.403683,0.561383,-0.0549391,0.263755,-0.106573,0.114812,-0.0739584,-0.282963,0.0285936,-0.442786,0.437808,0.0319381,0.55515,-0.108389,0.0262612,-0.109182,-0.315236,-0.278952,-0.682414,-1.21753,0.227398,0.0659268,0.132485,-0.117242,-0.269876,0.236758,0.0427027,0.422759,-0.581041,-0.062706,-0.237128,-0.193699,-0.349547,-0.463997,0.816012,0.743976,-0.0798367,0.692645,0.55322,0.22963,-0.601723,0.131128,0.856162,-0.587116,0.0187212,0.204877,0.178036,0.260695,-0.19475,0.512725,-0.638427,0.497884,-0.518216,-0.0140579,-1.1799,0.349416,-0.0969808,0.518339,0.993801,-1.04508,-0.765042,0.435171,0.165849,-0.112622,-0.226649,-0.146612,-0.485058,-0.187307,0.434101,0.221644,-0.162486,0.219944,0.234085,0.260384,-0.58693,-0.0521708,0.00579706,0.661362,-0.497016,0.138452,-1.10143,-0.679514,0.193564,-0.273215,-0.685444,0.15057,0.0202322,-0.0559774,0.317448,0.20059,0.6784,0.329676,-0.679848,-0.343315,-0.363924,0.00501213,0.489361,0.154719,0.110957,-0.867965,-0.480079,0.122529,-0.820468,-0.310486,-0.322631,0.0927769,0.53318,-0.425424,-0.248145,0.266619,0.382122,-0.400655,0.0399697,0.286227,0.10061,-0.0870558,-0.61299,-1.02003,0.362924,-0.0969662,0.134669,-0.138992,0.199447,0.543318,0.499136,0.404913,-0.0945605,0.22715,-0.213856,-0.0800398,0.423968,0.323249,0.123524,-0.021968,-0.217597,0.425574,-1.39383,0.156163,-0.00655875,-0.149013,-0.133964,0.588566,0.521291,-0.171828,0.631742,0.268311,-0.227132,-0.552185,0.584932,0.262806,-0.190275,0.273263,0.187302,0.218641,0.070905,0.227315,-0.0455965,0.0481243,0.059868,0.42615,-0.838821,-0.0219701,0.00943922,-0.00697783,0.0234621,-0.245683,-0.691579,0.0783589,-0.0716007,-0.0306828,0.228613,-0.277672,0.638445,-0.0344322,-0.00189893,0.0469544,0.4008,1.00781,-0.231917,0.227982,0.0094338,0.250323,-0.788847,-0.317032,-0.535252,-0.225471,-0.323642,-0.080499,0.291959,0.187953,-0.534719,0.154671,0.329108,0.32005,-0.422746,-0.295132,-0.374054,-0.435796,0.115584,0.21737,-0.193339,-0.987036,-0.282182,-0.418454,1.15248,-0.378985,0.0578848,0.535647,-0.0715814,0.186606,0.588915,-0.2477,-0.215598,-0.558584,0.284554,0.0226566,0.147656,-0.294059,-0.637358,-0.485385,0.297751,-0.324437,0.428875,-0.963827,-0.542406,0.605959,-0.206747,-0.308496,0.160053,0.406333,-0.140039,-0.183852,0.356885,-0.0268582,-0.00108028,0.600293,-0.297866,0.330849,-0.206813,0.180517,-0.499252,-0.139426,0.411223,0.258433,0.255541,-0.884167,-0.432327,-0.235984,-0.446589,-0.0561929,-0.0221335,-0.276461,0.586113,-0.221581,0.0706285,0.061972,-0.182275,0.171032,-0.0501135,-0.141686,0.269899,0.280865,0.16861,-0.0203797,0.262814,-0.0288715,0.460395,-0.278965,-0.0861843,-1.15733,0.061329,0.103555,0.696305,0.308472,-0.637495,-0.308296,0.169161,-0.323991,0.223364,-0.0672469,-0.307773,0.127171,-0.262514,-0.0994729,0.309245,-0.192251,0.718605,-0.0410997,0.782195,0.302921,-0.070388,-0.567486,-1.14716,0.0450526,0.0983046,-0.0201898,0.2796,-0.21998,0.143578,0.196413,0.378917,0.443185,-1.63048 +3398.89,0.998903,0.0848144,4,1.56241,0.766642,-1.12134,0.41842,0.8432,-0.232243,0.260196,-0.0775217,0.275175,0.0804486,0.148021,-0.181963,-0.00973893,0.330279,-0.106257,0.576297,0.00897488,0.0528709,0.17159,0.134128,0.403324,-0.733169,-0.697291,0.311727,-0.614182,-0.518195,-0.152967,0.894874,-0.750136,-0.438045,0.735879,-0.185431,0.0114548,0.461442,0.301294,-0.0486803,-0.199476,0.0709485,-0.0131766,-0.622942,0.845389,0.318958,0.494943,-0.117777,-0.165206,-0.900233,-0.327404,0.179101,0.758148,0.188601,0.0649616,0.703218,0.0502333,-0.15503,0.985868,0.163718,-0.0861361,-0.394568,0.662037,-0.527694,0.192285,0.863704,-0.629386,-0.922006,-0.220393,-0.567716,0.113141,0.0720151,0.0781138,-0.481409,-0.0745605,0.16084,0.659682,-0.437732,0.885498,0.615036,0.209147,0.230146,-0.708354,-0.180456,0.292991,-0.091074,0.109253,0.362445,0.0748034,-0.246394,0.060985,-0.0845814,0.360813,-0.385637,-0.0601553,-0.0822898,0.322025,-0.667327,0.206912,0.408014,-0.29583,-0.0426449,0.0216519,0.452662,-0.189279,-0.201174,-0.241802,0.0504966,0.447983,0.284772,0.776188,-0.472778,-0.00311271,0.418969,-0.255488,-0.132282,-0.192457,0.21464,0.259149,-0.107023,-0.432169,-0.275455,0.217471,-0.111709,-0.592392,0.172493,-0.0529444,-0.677645,-0.899672,-0.0498208,-0.269104,-0.158556,-0.257586,-0.691935,-0.346318,-0.0186096,-0.208077,0.384908,-0.429279,-0.731646,0.00470947,-0.147752,-0.0168794,-0.145192,-0.212496,-0.159774,0.0927978,-0.635716,-0.456387,-0.69747,-0.165004,0.164262,-0.260355,-0.594159,0.305417,0.24143,0.0439337,-0.113751,0.385128,0.468283,0.378858,0.0863725,-0.00438584,0.126372,0.162591,-0.244368,0.755035,0.379921,-0.262117,0.0880757,-0.461872,-0.687719,-0.0156186,-0.0224675,0.261481,0.214991,-0.136503,-0.550093,0.2084,-0.472873,-0.715112,-0.202416,0.0793648,0.851206,-0.4254,0.129572,0.215607,-0.29182,-0.195684,0.138908,-0.977519,-0.232514,0.343266,-0.29898,-0.275881,-0.566245,-0.249721,-0.468694,-0.108854,-0.315769,-0.419471,-0.583849,-0.639729,0.948714,0.25317,-0.629224,0.49657,0.298194,0.484157,0.177345,-0.328624,1.01572,-0.074256,0.244175,-0.0749223,-0.183839,0.207817,-0.136973,0.417014,0.760466,0.17317,0.205193,0.554799,-0.891347,0.0266534,-0.578322,0.580586,-0.421783,-0.723364,-0.18156,-0.0444122,-0.0913088,-0.0517905,0.0283172,0.232298,-0.270188,-0.473468,-0.103471,-0.242059,0.158477,-0.0979042,-0.193007,0.310159,0.311749,-0.526548,0.23893,-0.765911,0.272425,0.792455,0.17977,0.280419,-0.426214,0.710012,-0.351547,-0.306596,-0.729275,0.716587,-0.183526,-0.50339,-0.0190131,-0.672613,-0.729882,0.286031,0.196735,-0.00628935,0.762398,0.306047,-0.296263,-0.476413,0.321126,0.255021,-0.938796,-0.125666,0.399487,-0.086071,-0.330639,0.401087,0.206186,0.2626,-0.388905,0.340088,0.63272,0.397238,-0.22395,0.0479209,-0.689426,0.0206496,0.405782,-0.312297,-0.134446,-0.154673,0.566309,0.219529,-0.737307,-0.00124802,-0.626793,-0.211533,0.344293,-0.0721888,0.387383,-0.379337,-0.359853,0.103244,-0.421007,-0.353816,0.148324,0.255157,0.385128,0.50513,-2.3418 +3404.24,0.923331,0.0848144,4,1.63389,0.767086,-0.943181,0.275579,0.599501,-0.156428,0.483461,-0.271673,0.430357,-0.0575448,0.14926,-0.436219,0.246822,0.365986,-0.181051,0.535032,-0.031182,-0.0179529,-0.0919368,0.401464,0.29358,-0.642172,-0.673825,0.150943,-0.781019,-0.694787,-0.323054,0.3676,-0.789527,-0.242558,0.767597,-0.27086,0.515192,0.0401616,0.293018,-0.0629026,0.0327691,0.365491,-0.210548,-0.491048,0.605572,0.149671,0.333712,-0.0267462,0.102053,-0.848523,-0.46277,0.0356437,0.80244,0.429484,0.271573,0.37385,0.129669,-0.234581,1.06805,0.149996,0.167779,-0.302794,0.984257,-0.738662,0.172131,0.885801,-0.240116,-1.10013,0.284928,-0.405777,0.206932,-0.466774,-0.0903288,-0.344459,-0.326801,-0.0285213,0.504153,-0.0383888,0.891669,0.625778,0.342,0.221769,-0.804386,-0.158011,0.65214,-0.0798073,0.291921,-0.149664,0.0260007,-0.432818,0.111597,-0.0249306,0.397886,-0.411601,-0.280209,-0.324491,0.316244,-0.403136,0.192925,-0.159551,-0.418719,-0.4254,-0.0210323,0.267678,0.277027,-0.251896,-0.276078,-0.0338879,0.32121,-0.00149796,0.625142,-0.681123,-0.0728183,0.496964,-0.15953,-0.0222424,-0.00188972,0.31885,-0.0735449,-0.41183,-0.160631,-0.377836,0.366215,-0.187746,-0.324206,0.336522,-0.429661,-0.561646,-0.259715,0.667165,-0.307585,-0.212408,-0.238458,-0.771019,-0.853569,-0.0757255,-0.247513,0.64206,-0.213693,-0.499973,-0.160076,-0.187352,-0.030669,0.125146,-0.703024,0.0414522,0.569091,-0.922457,-0.227346,-0.187984,0.312504,0.220988,-0.141974,-0.0970192,-0.0321074,0.303789,-0.102282,-0.0130895,0.271366,0.599279,0.845295,0.0987938,0.170476,-0.0485198,-0.389942,-0.203806,0.821375,0.509251,-0.0311311,-0.0965981,-0.655788,-0.558096,0.0194678,0.0243913,0.124783,0.0976094,-0.0347,-0.350935,-0.114262,-0.323005,-0.767866,-0.370764,-0.028406,0.866391,-0.67017,0.0981343,0.399593,-0.217849,0.130953,-0.244175,-0.678737,-0.373379,0.13639,-0.25982,-0.394553,-0.518302,-0.144811,-0.154315,-0.194613,-0.349428,-0.394294,-0.567955,-0.840523,0.273053,0.087138,-0.573136,0.761554,0.409805,0.0299678,0.00785597,-0.532775,0.940603,-0.512041,-0.284278,0.297562,-0.45957,0.0965852,-0.0873401,-0.25959,0.919231,0.0378308,0.0831927,0.648608,-1.23746,0.0368465,-0.883291,0.387335,-0.863188,-0.480395,-0.0617982,-0.211922,-0.346269,0.145296,0.333063,0.141447,-0.179965,-0.211914,-0.560086,-0.0274416,0.123579,0.0540067,-0.460633,0.638986,0.0681189,-0.471549,0.244791,-0.148529,0.459982,0.83377,0.625238,0.150102,-0.202713,0.339101,-0.243255,-0.339856,-0.721799,0.323232,-0.254862,-0.644732,-0.124462,-0.801625,-0.328695,0.0192347,0.1393,-0.0646314,0.480171,0.48968,-0.356062,-0.0923585,0.12484,0.40786,-0.208332,-0.200157,0.0623793,-0.0287184,0.0404163,0.329284,0.339311,0.341125,-0.254722,0.637509,0.408177,0.420636,-0.182835,0.223564,-0.255637,-0.0372642,0.410294,-0.0538185,-0.0912211,-0.221163,0.51193,0.161158,-0.233034,-0.0200265,-0.480622,-0.291984,0.0359924,-0.0349653,0.606486,-0.394514,-0.307382,0.204129,-0.854254,-0.732025,0.174962,0.284164,0.418285,0.53307,-1.43918 +3409.43,0.842591,0.0848144,5,1.58224,0.864509,-0.688338,0.143349,0.739829,-0.155151,0.32585,-0.522577,0.250275,0.0648697,0.394044,0.217755,-0.235905,0.489118,-0.178356,0.663401,0.0189396,-0.13824,-0.24307,-0.060313,0.0686723,-1.09253,-1.62653,0.258876,-0.393167,-0.295851,-0.119318,0.524045,-0.538475,0.150111,0.81514,-0.463403,0.370916,0.088485,0.0523243,-0.171333,-0.124746,0.417119,0.0543974,-0.326837,0.940433,-0.0255961,0.491732,-0.927969,-0.106187,-0.132787,-0.433197,-0.410764,0.683532,0.431783,0.0567531,-0.0388555,-0.182195,-0.214768,1.14256,-0.303494,0.22818,-0.22052,1.06903,-0.618279,0.10712,0.744404,-0.965075,-1.00117,-0.269364,-0.789509,0.21272,-0.0274529,-0.212462,-0.564972,-0.189284,0.00214191,0.211872,0.156177,0.534753,0.379058,0.376478,0.0417921,-0.396268,-0.160551,0.332218,-0.590697,0.0628885,-0.220962,0.224635,0.238676,-0.0571212,0.085416,0.292752,-0.453977,0.122782,-0.0817459,0.245833,0.0998637,0.101181,-0.763972,-0.098319,-0.346294,0.0926176,0.448313,0.253001,-0.683887,-0.269815,-0.168334,0.169281,-0.0421375,0.577702,-0.227813,0.11045,0.16442,-0.0168681,0.0264947,-0.934846,0.356684,0.610728,-0.181548,-0.389784,-0.447388,0.40129,-0.325259,-0.29887,0.41888,-0.534659,-0.411462,-0.304844,0.4034,-0.01142,-0.285651,0.0217646,-0.529142,-0.0411048,-0.353828,-0.659633,0.455589,-0.266567,0.538833,-0.142883,-0.218289,0.112441,-0.543199,0.0541196,-0.133422,0.132016,-0.493587,0.102119,0.0496609,0.562925,0.0697508,-0.378658,-0.191962,0.143755,0.404421,0.223123,0.418067,-0.0275129,0.489604,0.699354,0.411299,0.309373,-0.233179,-0.233702,-0.37724,0.74072,-0.0797896,0.314334,-0.556081,-0.235927,-0.892017,0.0395513,-0.0831992,0.220273,0.503389,-0.359729,-0.922705,0.365495,-0.413684,-0.867688,-0.550975,0.567579,0.859136,0.0874741,0.41742,-0.214876,-0.102248,-0.00839357,-0.693696,-0.115675,-0.320996,0.133358,-0.423951,-0.315832,0.0761792,-0.250984,-0.620891,-0.107652,0.313384,-0.260251,-0.667414,-0.00990695,0.508901,0.0229378,0.319622,-0.152355,0.0687627,-0.645984,0.326029,-0.427901,0.945036,0.645056,0.0333071,0.149454,0.0014233,0.0493909,-0.354496,-0.0587693,0.681079,0.479381,0.423211,0.803396,-0.433317,0.459331,-0.667622,-0.214544,0.0964572,-0.242288,0.199525,0.00862651,0.0419385,0.879892,0.231342,-0.501989,0.178789,-0.384563,-0.189651,-0.533393,0.13918,0.843091,0.0395769,0.627332,-0.0781207,-0.118717,0.239726,-0.959918,-0.343036,-0.030636,0.277855,0.473409,0.0594504,-0.386706,-0.492877,0.433074,-0.897582,0.416805,-0.146669,-0.015775,0.190862,-0.838052,-0.145324,0.346209,-0.0861928,0.583691,0.74199,0.258037,-0.270119,0.502587,0.222438,-0.108962,0.397277,0.0697688,0.263716,0.0265883,-0.626948,-0.988377,0.487549,0.159095,-0.348684,0.446169,0.373108,0.5462,0.57166,0.10814,-0.325505,-0.322235,-0.0422513,0.123107,0.146448,0.0501586,0.0134508,0.16705,-0.0737494,-0.0942201,-0.0677518,0.0573047,0.12751,-0.599865,-0.263798,-0.0863888,-0.0378634,0.164713,-0.452722,-0.453288,0.141894,0.281335,0.376688,0.53041,-2.13774 +3404.26,0.993529,0.0848144,4,1.58101,0.959736,-0.586699,0.223338,0.754056,-0.0247268,0.138862,0.206144,0.677237,0.448534,0.0199042,-0.512013,-0.265566,0.267602,-0.469015,0.996825,-0.00587117,0.209219,0.335699,-0.12042,-0.304456,-0.384107,-0.406243,0.152875,-0.769045,0.018191,0.253465,0.619985,-0.629001,-0.27087,0.825773,-1.08722,-0.106132,0.194094,-0.297943,-0.259425,0.0277086,0.119718,0.395797,-0.860044,0.670166,0.0453752,-0.222113,0.211393,0.225878,-0.171429,-0.692908,0.325489,0.208337,-0.0959593,-0.0337534,0.274881,0.267518,-0.658398,0.684346,0.240369,-0.474884,-1.07371,0.439871,-0.360877,-0.246686,0.714347,-0.501369,-0.752417,-0.122175,0.483841,0.045992,-0.304796,-0.0624266,-0.100536,0.440267,1.17149,0.61351,-0.354459,0.327837,0.543089,0.234827,-0.464037,-0.247439,0.00786634,0.596734,0.0613625,0.183841,-0.00696706,-0.0257589,-0.128455,-0.100248,-0.261269,0.514972,-0.217415,0.335627,0.14146,-0.0799563,-0.00799056,0.139007,-0.0892774,-0.245029,0.184089,0.694342,0.340105,0.362539,0.0965739,-0.259382,-0.539059,-0.215036,-0.254435,0.24189,0.0449738,0.170769,0.817527,0.134986,0.1273,0.0352811,0.223848,-0.741165,0.460003,0.115653,0.237048,-0.175962,-0.208991,-1.33292,-0.184439,0.49102,0.262671,-0.672629,0.509718,0.292229,0.173355,0.236781,-0.772704,-0.250555,-0.0866177,0.567663,0.167554,0.115379,-0.660956,0.304974,0.234079,0.248229,-0.657484,-0.106042,0.0725529,0.569059,-0.108954,0.200191,-0.0638182,0.383946,0.525968,-0.178429,-0.543632,-0.465219,-0.0879129,0.272562,0.107682,0.122159,0.132832,0.241953,0.281595,0.211343,0.140838,0.719287,-0.135195,0.428677,-0.231905,-0.361655,-0.113643,-0.115983,-0.034242,-0.609264,-0.168102,0.0527221,-0.0467309,0.120457,0.50675,-0.287253,-0.145711,-0.325553,0.692189,0.368322,0.795504,0.361061,-0.153133,0.962773,0.210785,-0.12346,-0.158694,-1.43743,-0.425279,-0.055885,-0.0546967,0.0728792,0.289226,0.349207,-0.668479,-0.0854662,0.0575539,0.014905,-0.49957,-0.711952,0.213355,-0.115845,-0.149321,0.715008,-0.347725,-0.32272,-0.292766,-0.372337,0.800478,-0.132303,0.327531,0.120043,0.297524,0.148079,-0.178034,-0.0322192,0.273239,-0.395834,0.324106,0.478679,0.318289,-0.672282,-0.698879,-0.149175,0.114275,-0.515299,0.571791,-0.373565,-0.26973,-0.0933713,0.188028,0.453877,-0.192595,-0.181146,-0.239764,-0.378589,0.393108,-0.639066,-0.153937,0.757352,-0.802852,0.193521,0.154409,0.680884,0.0785826,0.491084,0.399915,0.271382,-0.0476453,0.439305,-0.635569,0.0102673,-0.317368,0.424482,-0.220333,-0.701546,0.0714179,-0.131085,-0.505931,0.308697,0.0245182,0.237667,0.0391633,0.066799,0.423044,0.152565,0.390909,0.0268631,-0.0715125,0.0635005,-0.220707,-0.222178,-0.148084,0.495421,0.3981,0.207504,0.286493,0.387902,-0.16171,0.264785,-0.357783,0.201964,1.05464,-0.861044,-0.164746,0.0362568,0.46157,-0.134799,-0.279459,-0.0088941,-0.413169,0.0582246,-0.32651,0.0425475,0.388878,0.153153,-1.13752,0.757497,0.209653,0.307877,-0.0818373,-0.0785082,0.147366,0.196013,0.383882,0.442734,-2.51643 +3405.67,0.48149,0.0848144,4,1.55571,0.997956,-0.278095,0.159007,0.823703,-0.0350543,0.106723,0.267878,0.200387,-0.0989833,0.254285,0.418761,-0.364632,0.469031,0.282292,0.887297,-0.100945,0.359504,-0.0649205,0.0375607,-0.552033,-0.574148,-0.932576,0.141975,0.362623,0.220944,0.265538,0.20535,-0.0360626,0.351286,0.639406,-0.178337,-0.02824,0.222527,-0.373665,0.00686749,-0.75091,0.373396,0.270883,-0.141056,0.747082,0.280479,0.674187,-0.953977,-0.332141,-0.678421,-0.255236,-0.331573,0.00553853,0.0243018,-0.0535752,0.693558,-0.236206,-0.0860991,0.855451,-0.522218,-0.217968,-0.349989,0.242916,-0.309794,0.272827,1.01049,-0.486737,-1.17992,-0.52114,-0.139206,-0.513323,0.32741,0.614346,-0.507826,-0.545648,-0.120629,0.426001,0.189008,0.637276,0.753518,0.389761,0.608145,-0.0572055,0.118054,-0.0372524,-0.229378,0.247925,-0.434721,-0.333662,0.181756,0.285394,0.25111,-0.0285641,-0.204868,0.539317,0.415812,0.309808,0.495057,-0.103155,-0.485687,0.27115,-0.323885,-0.133777,0.339297,0.165419,-0.290786,-0.757586,-0.319701,0.653096,-0.445517,0.265251,-0.493559,0.378776,0.190658,-0.476576,-0.175306,-0.0946593,0.39695,0.48073,-0.219658,-0.652508,0.236805,0.11629,0.0188973,-0.454372,0.0233906,-0.958052,0.126475,0.579131,-0.0781794,-0.261004,0.229355,0.223469,-0.13248,0.0199815,-0.0238349,-0.453051,0.800591,0.215438,-0.105594,-0.376558,-0.169657,0.44107,-0.90251,-0.479617,-0.012141,-0.113189,-0.707647,-0.28283,0.64008,-0.454138,0.396678,0.037503,-0.0984405,-0.173981,0.468083,0.245737,-0.181036,0.140341,0.333013,0.0331485,0.0255598,0.136383,-0.0124191,-0.532772,-0.0154707,0.764773,-0.0746073,-0.0216142,-0.31789,0.151956,0.174771,0.222461,0.134348,0.382237,0.127395,-0.406048,-0.580333,0.286401,-0.185028,0.0171364,-1.10358,0.153592,0.616185,-0.260329,-0.505974,-0.486752,-0.0978149,-0.0189256,0.106108,0.212722,-0.135723,0.016241,0.135908,-0.107379,-0.556713,-0.40933,-0.148464,-0.181699,0.285021,0.380495,0.0883584,-0.837664,0.0253086,0.0856652,-0.610734,-0.343517,0.154576,0.322543,0.110714,-0.0793911,1.23068,0.550409,1.0407,-0.13738,-0.479479,-0.199324,0.270156,0.119897,0.380732,-0.159527,0.15279,0.239756,-0.483394,0.375012,-0.14504,0.411077,0.446755,-0.202176,0.316073,-0.276271,-0.0581335,-0.242571,0.0376104,-0.416719,0.224469,-0.334114,0.210968,-0.154373,0.751203,0.00237793,0.190048,0.279057,-0.274996,0.158381,-0.445762,-0.634741,-0.235918,0.350589,0.03838,0.388733,0.122328,-0.144052,-0.315284,-0.261786,-0.716066,0.536266,-0.526605,0.0921448,0.509622,-0.333754,0.166065,0.0464972,0.170773,0.0849549,0.520563,-0.211694,-0.14165,0.681676,0.242588,0.122015,0.298708,0.370158,0.418536,0.29338,-0.423499,-0.846562,-0.260438,0.133853,0.053406,0.0329287,0.503537,-0.0662417,0.0214991,-0.760167,-1.29108,0.157319,0.302943,0.49268,-0.179385,-0.479347,0.0819635,0.148299,-0.114616,-0.0638406,-0.193848,0.0342227,-0.321449,-0.156076,-0.430912,-0.577102,-0.333343,-0.779439,-0.0131939,0.531393,0.139539,0.192051,0.37355,0.438236,-2.93906 +3384.1,0.898425,0.0848144,4,1.62978,0.830976,-0.437118,0.330902,0.71661,-0.0838982,0.247641,0.383596,0.740055,0.125423,0.0117891,0.0712571,-0.720672,0.572871,0.13668,0.319518,0.054209,-0.0405192,-0.298844,-0.160875,0.0186208,-0.527718,-0.564326,0.147645,0.301579,0.247431,0.127322,0.453343,-0.17222,0.0813229,0.807398,-0.210189,-0.00148186,0.23658,-0.47781,-0.0847795,0.0540105,0.190056,0.341307,-0.0794371,0.318664,0.0569703,-0.304837,-0.447165,-0.378908,-0.0725245,-0.167053,-0.568048,0.040014,-0.231032,-0.101053,-0.0592135,-0.0395546,-0.0838761,0.583765,0.0971121,-0.180934,-0.554614,0.0527222,0.07979,-0.0987334,0.847832,-0.480304,-1.21102,-0.508658,0.0478151,0.0530543,0.111463,0.922363,-0.372005,-0.646436,0.248147,0.463161,-0.367364,0.519654,0.505162,0.505774,-0.0741852,-0.205635,0.0689753,0.629961,-0.511671,0.459445,-0.593946,0.320501,-0.0170986,-0.218246,-0.429883,-0.0266657,-0.22331,0.252436,0.49566,0.40124,0.287217,-0.518321,-0.206594,-0.192819,0.185839,0.114263,0.589913,0.107977,0.405467,-0.248257,-0.339086,0.74042,-0.511804,0.138408,-0.311259,0.0011092,-0.0252186,-0.557984,-0.209432,-0.242152,0.216227,-0.429993,-0.17308,-0.43761,0.131525,-0.716689,-0.262143,-0.633582,0.241861,-0.731163,-0.301161,0.476008,0.394158,0.338695,-0.133593,-0.193713,-0.477288,0.345498,-0.4205,-0.486037,1.32705,0.240247,0.019174,-0.248882,-0.0539708,0.917019,-0.542143,-0.448581,0.0810247,0.0122383,-0.202596,-0.255507,0.172316,-0.0590454,0.395744,0.0725374,-0.0643097,-0.080086,0.572965,0.200004,-0.182784,-0.0538363,0.184373,0.187197,0.117672,0.485455,0.018949,-0.407722,-0.0318291,0.971597,0.668372,-0.142758,-0.154418,-0.0457717,0.438585,0.216875,0.186343,0.43444,-0.477597,-0.143645,-0.307161,-0.394225,-0.0677423,0.122016,-0.873568,0.293924,0.516982,-0.0397494,-0.940315,-0.262865,0.0356276,0.226513,-0.128174,0.0856281,-0.161001,0.116311,0.424581,-0.104182,-0.586575,-0.106275,0.14029,0.198556,0.838184,0.37703,0.00217761,-1.08715,-0.0570906,0.173662,-0.909067,0.0371054,0.109853,0.376214,0.192905,-0.427942,0.99958,0.391733,0.850586,-0.296103,-0.56667,-0.0130425,-0.540156,0.223201,0.523913,-0.149812,0.691515,-0.141867,0.0285073,0.126733,0.159196,0.254796,0.472008,-0.426302,0.632347,-0.176549,-0.0553541,-0.906121,0.0816462,-0.42993,-0.159527,0.0314055,-0.200389,-0.749252,0.664007,0.401013,-0.20416,0.0289276,-0.0888449,0.319229,0.0708052,0.0947248,-0.489204,0.457729,0.0365053,0.588216,-0.108626,-0.478742,-0.423332,0.0877012,-0.613999,0.360309,-0.415217,0.329246,0.520865,-0.219805,-0.265099,-0.133149,0.261304,-0.31946,0.685031,-0.36962,0.5061,0.609083,-0.0864527,-0.298032,0.257655,-0.2076,0.129381,0.282461,-0.223423,-0.840389,-0.164677,0.167566,-0.365758,-0.0469555,0.406787,-0.394943,0.224956,0.13386,-0.866163,-0.45103,0.162912,0.545055,0.462085,-0.243781,0.286532,0.000772136,-0.878584,-0.211218,-0.310736,-0.417764,-0.411935,-0.104611,-0.628021,-0.659283,-0.527433,-0.820358,0.142737,0.300656,0.193483,0.156487,0.439867,0.395584,-2.28151 +3392.34,0.999898,0.0848144,5,1.57616,0.76287,-0.672159,0.342615,1.0868,0.0788985,-0.321342,-0.111616,0.151125,-0.0335049,0.163095,0.0931177,-0.0367325,0.344411,0.227079,0.640785,-0.0144463,-0.0687782,-0.00122785,-0.285116,-0.19141,-0.313544,-0.267006,0.410737,-0.346208,-0.194074,0.434974,-0.0653788,-0.193615,0.360758,0.73071,-0.889203,0.429504,0.62333,-0.0937498,-0.143445,-0.308242,0.109115,-0.220364,-0.259551,0.363219,0.0862756,0.353847,-0.803341,-0.192929,-0.598922,-0.208342,-0.128548,0.184934,0.236966,-0.0427264,0.128077,-0.109345,-0.258555,0.771575,-0.105102,0.391413,-0.139013,0.594936,-0.333422,0.191667,0.996751,-0.692071,-0.871824,0.0932038,0.288853,0.112845,0.297793,-0.469718,-0.236584,-0.0247176,0.586828,0.432934,0.0993602,0.76149,0.594857,0.435236,0.450038,0.347938,0.338126,0.389742,-0.3364,0.141084,-0.00726244,-0.0699866,-0.673586,0.172009,-0.0264555,0.198036,-0.182614,0.0780694,0.533691,0.0170872,0.127389,-0.651023,-0.221048,0.460102,-0.0384011,-0.349465,0.792739,-0.0894753,0.493568,-0.190188,-0.398293,0.383357,-0.39331,0.010789,0.239934,0.151029,0.695297,-0.0568749,0.00340221,0.184435,0.343758,-0.938646,0.0496889,-0.595525,0.268622,-0.632925,0.516372,-0.194325,-0.306074,-0.235979,-0.258459,0.5522,-0.0815982,0.236179,0.360421,0.806328,0.149331,0.236212,0.300284,-0.265014,0.674572,0.0783754,0.139766,-0.169288,-0.577486,0.00909265,-0.276133,0.427683,0.0245849,0.185993,-1.00631,0.112641,0.428637,-0.330956,0.494349,0.0135411,-0.34715,-0.194829,0.112488,0.609174,0.126525,-0.0216936,0.541949,0.92066,-0.269276,0.808548,0.413329,-0.533019,0.046806,0.905464,-0.152293,-0.247916,-0.0103838,0.0620435,-0.414012,-0.378047,-0.445533,0.357537,-0.369929,-0.0844929,-0.13123,-0.405216,-0.602631,-0.0923189,-0.700867,0.162916,0.670998,-0.448474,0.149869,0.334041,0.28782,0.215942,-0.758744,-0.568634,-0.109976,-0.573628,-0.452291,0.0765036,-0.127693,0.511929,-0.687708,0.334932,0.408078,0.259536,-0.305496,-0.467672,-0.214891,0.0794529,-0.624256,0.589861,-0.918415,0.168648,-0.480234,-0.269818,1.08689,-0.69177,-0.344308,-0.480068,-0.000727945,0.0931673,0.529002,0.246294,0.274348,-0.377232,0.126051,-0.062562,-0.196464,-0.465741,-0.508961,-0.518554,0.151512,0.0973373,0.554347,-0.617511,-0.129313,-0.0138972,-0.0393746,0.171638,0.0219818,-0.47544,-0.565787,-0.997971,0.643755,-0.727666,-0.163838,0.28749,-0.466462,0.0802708,-0.0101565,-0.312757,-0.469568,0.128795,0.0821683,0.580298,0.0502015,-0.0963155,-0.561992,-0.517657,-0.0120408,0.438052,-0.312503,-0.227776,0.577544,-0.506068,-0.434289,0.457487,-0.0636899,0.244885,0.0735871,-0.417523,-0.0576632,-0.306043,0.0608931,0.348099,0.266175,0.177765,-0.0732293,-0.331335,-0.298635,-0.0780544,0.575651,0.320976,0.180798,0.425997,0.366568,-0.513712,0.0826897,-0.197261,-0.740734,-0.330495,0.0429629,-0.674244,0.217903,-0.420511,-0.44627,0.195457,0.0822495,-0.0785567,-0.34542,-0.348556,-0.307414,-0.538297,-0.645591,-0.262715,-0.95366,-0.18645,-0.583106,0.0509891,0.173591,0.150803,0.416643,0.388334,-3.37199 +3386.1,0.892712,0.0848144,4,1.52818,0.824577,-0.74348,0.407727,0.422227,-0.00998142,-0.0864516,0.0979928,-0.151549,0.0276853,-0.51862,0.0918772,0.192987,0.705004,0.264288,0.746595,0.244125,0.127555,0.0185468,0.0307604,0.0346872,-0.976829,-1.31752,0.616277,0.261213,0.532137,0.16132,0.035771,0.642941,-0.0122543,0.742394,0.353366,0.0224469,0.499982,-0.509122,0.11653,-1.15909,0.465986,0.148774,0.0725017,0.149367,0.569622,0.790407,-0.497713,-0.209567,0.296986,-0.50173,0.29754,0.428763,0.0746473,0.169107,0.524715,0.0060392,-0.482019,0.55215,-0.0718076,-0.559472,-0.443261,0.0863936,-0.250969,0.0591908,0.569839,-0.55767,-0.986034,-0.283961,0.0299175,0.00762373,0.217499,0.0621654,0.0377192,-0.801072,0.37784,0.873526,-0.31162,0.501523,0.422831,0.211145,0.24877,0.160376,0.00616333,0.952189,-0.060781,0.135588,-0.137305,-0.175836,-0.427572,0.548673,-0.892124,-0.0372362,-0.0569061,0.0885623,0.0891888,0.413552,0.385057,-0.29627,0.150977,0.456974,-0.0726267,-0.0815113,0.895757,-0.2835,-0.167509,0.0482729,-0.00819407,0.236089,-0.156045,-0.217807,-0.0772487,0.413665,0.402777,-0.023597,0.30143,-0.28274,0.397637,-0.629327,0.279953,-1.0931,0.313676,0.385967,-0.23278,-0.783239,0.102174,-0.194732,-0.730095,0.465653,0.654101,0.861343,0.959693,0.764242,-0.310107,-0.978751,-0.143855,-0.783008,0.55779,-0.235394,0.0160118,-0.0187893,-0.252295,0.53005,-0.587366,0.21743,-0.43447,-0.147982,-0.757156,-0.245898,0.48769,-0.480145,0.370894,0.207538,-0.0478056,-0.571548,0.333386,-0.124151,-0.440449,-0.433854,0.164821,0.858862,-0.14378,0.210537,-0.0786578,0.00861781,0.339476,0.84786,-0.135951,0.0508606,0.175043,-0.168293,-0.698121,-0.0899794,-0.359124,0.0610593,-0.137381,-0.0306454,-0.446515,-0.550538,0.0210684,-0.239422,0.21342,-0.126407,1.0629,0.0654487,0.208452,0.556055,-0.155004,0.127427,0.157879,-0.745456,0.0694259,0.317366,0.0873605,-0.106996,-0.328584,0.185741,-0.470518,0.389196,0.179641,-0.075463,-0.0195158,-0.224152,-0.194408,-0.256764,-0.225537,0.359155,0.517625,0.0649937,-0.9573,-0.192989,1.29686,-0.0488934,0.00284868,0.0791914,-0.236503,0.0366061,0.477592,-0.165798,0.571364,-0.831364,0.993904,0.407398,-1.07792,-0.205301,-0.217215,-0.289976,0.331258,-0.690592,0.442913,-0.572441,-0.659448,-0.0930763,0.255724,-0.223488,0.0312264,-0.770189,0.276949,-0.0358695,0.795806,0.329309,0.104742,0.857803,-0.882821,0.116071,0.835219,0.371408,0.191537,1.05222,0.637605,1.00684,0.131908,-0.400465,-0.410079,-0.386604,-0.460922,0.323581,0.226648,-0.116682,0.163429,-0.506715,-0.0525435,0.322405,-0.183845,0.212815,-0.11343,0.392442,0.0902051,0.121862,-0.0158478,-0.245237,-0.746582,0.354606,-0.567108,-0.091259,-0.501883,-0.530622,-0.20418,0.700056,-0.152124,0.750756,-0.394812,-0.481574,0.102545,-0.340169,-0.562457,-0.641969,-0.744937,0.171069,-0.104207,-0.574056,0.231323,-0.017746,-1.07314,-0.328871,0.210407,0.0679012,-0.292624,0.0953654,-1.00786,0.124492,-0.0550767,0.440814,0.493633,-0.0999177,0.214615,0.21,0.463265,0.458258,-1.32488 +3387.25,0.933956,0.0848144,4,1.57816,0.980763,-0.658277,0.368961,0.568297,0.0146536,0.395099,-0.0542223,-0.230347,-0.146189,0.113386,0.0928016,-0.154944,0.424176,0.340823,1.08685,0.318283,-0.0667257,0.17723,0.119276,0.103718,-0.801925,-0.323373,0.262185,0.0432765,-0.0667905,0.0178741,0.860027,0.733732,0.167796,0.838576,-0.505353,-0.145944,0.13082,-0.390951,-0.32882,-0.68156,0.693639,-0.365697,-0.255595,0.656745,0.787414,0.346338,-1.19722,-0.479477,0.464627,-0.947856,-0.131959,-0.39857,0.262895,0.299784,0.550879,0.129121,-0.309627,0.331909,-0.186516,-0.658571,-0.871642,0.279766,-0.821157,0.148745,0.540822,-0.740296,-1.14705,-0.224943,0.256356,-0.173717,0.961029,0.303344,-0.203332,-0.313175,0.903521,0.279751,-0.0100211,0.638458,0.459758,0.125521,-0.209785,-0.189594,-0.0131662,0.611364,0.129652,-0.110926,-0.0402333,-0.66072,-0.311485,0.308843,-0.74148,0.615059,-0.311195,-0.0636425,0.990428,0.175006,0.0821296,-0.253934,0.233561,0.0395491,-0.222147,-0.141301,0.660426,0.22573,-0.173225,-0.38302,-0.084183,0.174258,-0.211633,0.709517,0.299426,0.0934908,0.292863,0.0183201,-0.267622,0.425062,0.195432,-0.164149,0.589067,-1.01685,-0.0234744,0.424947,0.39271,-0.944903,0.194855,0.122292,-0.617331,0.189837,0.2907,0.472111,0.590943,0.554191,-0.186438,-0.274336,-0.177715,-0.739957,1.06524,-0.73044,-0.378645,-0.350416,-0.125304,0.019496,-0.563993,0.329229,-0.186315,-0.471146,-0.010098,-0.415774,0.582399,-0.493047,0.302943,0.00860065,-0.197034,-0.0106205,0.0433946,-0.240061,-0.0200095,-0.166943,-0.0423729,0.260947,0.335762,0.107262,0.111582,-0.154223,-0.105561,0.954112,-0.395175,-0.398588,0.3156,-0.0565193,-0.263384,-0.924527,0.0239121,-0.187891,-0.514918,-0.148293,-0.598015,0.222889,-0.0742259,-0.281663,-0.169501,-0.590267,1.19713,0.769929,-1.12573,0.481836,-0.315419,0.00286194,-0.318267,-0.151099,0.219902,0.0216649,-0.115524,-0.454275,-0.0356715,-0.277185,-0.777756,-0.243775,0.295814,0.196742,-0.611116,-0.266177,-0.164185,-0.150461,-0.399054,-0.294008,0.0685542,-0.0446752,-0.839016,-0.192303,0.942212,-0.296799,-0.0582762,0.25414,0.263386,-0.217027,0.348907,-0.531942,0.558692,-0.654844,0.287202,0.0877951,-0.278687,-0.389452,-0.182031,-0.192406,0.407071,-0.581159,0.671159,-0.584674,-1.12886,-0.498149,0.130958,-0.116161,-0.00113158,-0.608688,0.327272,0.207384,0.160032,-0.14906,-0.32992,0.866416,-0.449145,-0.578943,0.538911,0.336479,-0.489477,0.876458,0.573851,0.353579,-0.450014,-0.0334195,-0.413135,-0.251705,-1.1241,0.184641,-0.0716076,0.0044629,0.299178,-0.747077,-0.175044,0.148444,-0.156338,0.345213,0.477729,0.304644,0.230049,-0.326697,-0.0307662,0.0335397,-0.180395,0.362089,-0.186397,0.00501669,-0.448703,0.0998581,-0.480987,0.258096,-0.358333,0.0567825,-0.429258,0.187785,0.350836,0.0253581,-0.485302,-0.794246,0.0975584,0.365327,0.215521,-0.506067,0.252072,-0.356377,-0.948825,-0.0529084,0.44297,0.233426,-0.00638753,0.132421,-0.221578,0.59318,-0.55833,-0.308075,-0.558042,0.187861,0.177305,0.256994,0.421076,0.506945,-2.05012 +3406.45,0.998456,0.0848144,4,1.47528,1.00514,-0.160543,-0.0018537,0.692549,-0.18528,-0.0253447,0.739009,0.11386,0.123177,0.198219,0.10425,0.307717,0.57236,-0.289976,1.05455,0.385114,0.486279,-0.224347,-0.516308,-0.203392,-0.638482,-0.455034,0.32967,0.419985,0.21991,0.511647,0.323602,0.124767,-0.156475,0.775797,-0.16097,0.228695,0.737534,-0.646015,0.175635,-0.308229,0.562486,0.928821,-0.356593,1.03697,0.158964,0.155411,0.258643,-0.320236,-0.734688,-0.454218,0.102552,0.571804,0.0278963,0.474773,-0.106029,0.136098,-0.249445,1.03126,-0.0890652,-0.475786,-1.11825,0.838283,-0.935344,-0.289986,0.985441,-0.645272,-0.831003,0.25024,0.433107,-0.300408,0.139301,0.354706,-0.37506,-0.218229,-0.0719279,0.381991,-0.352255,0.50004,-0.149039,0.400027,0.156497,0.227479,-0.273616,0.40887,-0.474114,0.0586871,-0.862099,0.529884,0.0294712,-0.114496,-0.538083,0.31732,-0.308943,0.341434,0.475725,-0.00414278,0.734289,0.318377,0.0727227,-0.108919,0.0706699,-0.126274,-0.0209224,-0.177559,-0.14076,-0.502435,0.0322047,0.509559,-0.936641,-0.228248,-0.463688,0.364534,0.0164377,0.164789,-0.12254,-0.260697,0.548687,-0.211068,0.339179,-0.184834,-0.118609,0.772354,0.140024,-0.430806,-0.287543,-0.180133,-0.655244,-0.216022,0.488096,0.731134,0.00370956,-0.151239,-0.507866,0.434873,-0.0534711,0.223556,-0.0263845,-0.248847,0.022186,0.83667,0.00912629,0.206258,-0.403075,-0.778715,-0.229199,-0.516919,-0.44253,0.201267,0.30009,-0.324497,0.8897,-0.0324182,0.133806,0.108331,0.0651182,0.286681,-0.458816,0.747964,0.100116,0.295284,-0.0348195,0.22489,-0.324472,0.412454,-0.351245,0.992284,0.270983,0.503647,-0.42339,-0.0233355,-0.213112,-0.91462,-0.468781,0.128733,-0.015722,0.0516354,0.0441383,0.27296,0.169756,-0.551168,0.22702,-0.0301309,0.438836,0.000820235,0.38281,-0.439001,0.374624,0.205075,-0.720628,0.248695,-0.305469,0.29553,-0.130312,0.0218947,0.286968,0.112557,-0.574677,0.147295,0.39698,0.299183,-0.32873,-0.188298,-0.298474,-0.323524,0.0625891,0.662553,-0.21117,0.0724249,-0.337917,-0.306896,1.09058,-0.434993,0.174435,-0.301224,0.620326,-0.557747,-0.140274,0.0121989,0.313166,-0.0261885,0.0474451,0.164539,-0.242607,-0.0199311,-0.758326,0.167874,0.630403,-0.289666,0.422117,-0.0469227,-0.201077,0.913947,-0.148287,-0.402608,0.0625298,-0.194564,-0.186959,-0.0662889,0.46893,0.420064,0.88717,0.103667,-0.243187,-0.321111,-0.275782,0.0196486,-0.0653878,0.779402,0.699496,0.493495,0.201413,-0.15998,-0.72545,0.0486824,-0.344664,-0.0148322,-0.0868641,0.678385,0.883586,-0.194503,-0.205694,0.102365,-0.0307835,-0.210858,0.276713,0.150337,0.12327,0.134303,0.55382,0.106004,0.391514,0.0460469,0.171849,0.328102,-0.0691212,0.181556,-0.171895,-0.410279,0.641201,0.176224,-0.397581,0.23352,-0.22162,-0.0529467,-0.0924845,0.00712638,0.0585926,-0.125974,-0.383048,-0.199378,0.453531,0.164285,-0.135478,0.119568,-0.150879,0.460087,0.767159,-0.311117,-0.454852,-0.657343,0.394687,-0.443864,-0.170115,0.133467,0.125055,0.260383,0.353631,0.510277,-2.46845 +3387.9,0.811246,0.0848144,5,1.53497,1.01094,-0.420492,-0.0992764,0.346487,-0.120344,0.174275,-0.252871,0.795388,0.0738335,-0.258927,0.0457946,-0.278835,0.299152,0.0310218,0.95714,0.0844003,0.0190071,-0.671278,-0.139186,-0.251406,-1.1291,-0.461373,-0.297473,-0.17292,-0.592191,0.234029,0.861161,0.110154,-0.474403,0.897577,-0.333426,0.0248981,0.269204,0.0155939,0.234566,-0.235412,0.320157,0.0151685,-0.109971,1.002,0.904452,0.30933,-0.105976,0.293291,-1.0509,-0.338117,0.0870315,0.442151,0.528945,0.180098,0.451231,0.589425,-0.462919,1.18165,0.518754,-0.18139,-0.723338,1.08291,-0.247541,-0.18936,1.129,-0.457233,-1.59972,0.348592,0.272111,0.253482,0.513132,0.321195,0.150874,-0.307839,0.511754,0.6051,0.192174,0.881401,0.389841,-0.2792,-0.0105266,-0.382165,-0.298216,0.497286,-0.251559,0.353902,-0.546441,-0.343279,-0.10814,0.166903,-0.977117,0.39613,-0.582903,-0.76427,-0.544857,-0.309256,0.0427613,-0.349845,-0.521892,-0.251646,-0.372334,0.242971,0.566747,0.297112,0.160164,-0.925159,-0.169414,0.122515,-0.124018,-0.386173,0.128116,0.221804,0.52455,-0.190339,-0.602023,-0.200242,0.527663,-0.855358,0.541667,0.45895,-0.121736,-0.1358,-0.0627533,-1.13372,0.516456,0.27336,0.389211,-0.568121,-0.195514,0.256306,0.180785,0.647457,-0.760678,-0.159027,0.180344,0.00341485,0.565225,-0.484115,-0.513674,0.393516,-0.0765619,0.492071,-1.14915,-0.611442,0.200487,-0.0902956,-0.456474,-0.387224,0.0260802,-0.287036,0.999746,-0.413231,0.0292576,0.089249,-0.0879957,0.917783,-0.115839,0.259493,0.217641,0.100991,0.242806,0.123455,-0.0281816,-0.257391,-0.0785052,0.813572,0.0660282,-0.302949,-0.172903,0.0327836,-0.305864,0.362148,0.130629,0.154089,0.518387,0.140203,-0.51405,0.37885,0.595965,-0.337153,0.118988,0.0389248,0.262588,-0.230532,0.0162641,-0.0565907,0.263276,-0.23497,-0.493862,-0.684679,-0.187008,0.00328464,-0.432033,0.0897771,-0.28978,-0.197007,-0.481087,-0.499788,0.516355,0.365988,-0.265738,-1.11163,-0.254191,-0.173919,-0.0455993,0.424141,-0.224613,-0.117203,-0.574027,0.11005,0.54315,-0.275522,0.457242,-0.0541617,0.159695,0.161993,-0.0748749,-0.0807898,0.0569503,-0.649787,-0.450068,0.262307,-0.35275,-0.254802,-0.773906,-0.227392,-0.0399275,-0.314182,0.782357,-0.246125,-0.193872,-0.398269,-0.386618,0.301712,0.365819,0.137921,0.571497,-0.442832,0.213749,0.0121266,-0.294172,0.98308,-0.100977,0.143985,-0.346189,0.559812,0.318189,0.0902301,0.185401,0.580857,-0.00939407,0.0910023,-0.170229,-0.329613,-0.483285,0.285401,-0.180168,0.412822,0.283549,-0.354563,-0.192714,0.284754,0.149277,0.282575,0.384417,-0.361686,0.341546,0.611566,0.574275,-0.203016,-0.764263,-0.617831,-0.190635,0.521651,-0.403921,-0.250191,-0.120124,0.671255,-0.412215,0.0100171,-0.171361,0.428488,-0.522121,0.204858,0.455037,-0.147715,0.14399,0.105819,0.00917091,-0.0652929,0.207981,0.227057,-0.463664,0.380811,-0.389745,-0.164343,0.23976,-0.162056,0.0600524,0.272376,-0.453383,-0.429874,-0.13066,-0.707648,0.15611,0.324361,0.395107,0.569527,-1.05742 +3386.96,0.430499,0.0848144,5,1.56789,0.819213,-0.934645,0.35061,0.615734,-0.101061,-0.374594,-0.117662,0.0521705,0.0914512,0.298165,-0.178343,-0.52494,0.25165,0.324195,0.57011,-0.0369817,0.28279,0.00632183,-0.00716018,-0.304411,-0.842288,-1.41153,-0.049809,-0.30683,0.0459447,0.0384982,-0.114293,-0.319605,-0.443225,1.06371,-0.250406,0.0681635,0.0813718,0.157357,0.220494,-0.976049,0.78584,0.628461,-0.522838,0.796603,0.131308,0.143667,-0.75941,-0.235019,-0.119159,-0.307964,0.0860246,0.617575,0.38941,0.246854,0.298349,0.0635187,-0.168994,0.805213,0.0459048,-0.0507305,-0.472142,0.475186,-0.127433,0.36898,0.987794,-0.756576,-1.5944,-0.593298,0.387931,-0.321294,-0.654838,0.147931,-0.861706,-0.0600927,0.19481,0.831842,-1.27155,0.454465,0.55479,0.371358,0.417422,-0.123277,0.546875,0.612463,-0.318779,0.627209,0.0981726,-0.0663366,-0.272601,-0.108236,0.114781,0.246918,-0.629123,0.164737,0.140676,0.335267,0.122747,0.128487,0.68829,0.377734,0.178255,0.282135,-0.217577,-0.157189,-0.268484,0.369302,-0.190068,0.986826,-0.880249,0.752314,-0.501508,0.191292,0.571114,-0.0368154,-0.0482573,-0.123658,0.268206,0.580116,-0.0463091,-1.12267,0.249969,0.610924,0.135842,-0.350026,-0.255276,0.540658,-0.203781,0.522235,1.07728,-0.285742,-0.153258,-0.159021,-0.246323,0.35226,0.118461,-0.630896,0.758294,0.293935,-0.22634,-0.146202,-0.176513,0.473941,0.173815,0.160153,0.117719,0.0659698,-0.83634,0.279802,-0.341673,-0.0894376,0.351144,-0.378891,-0.538674,0.0234376,0.349831,-0.149129,-0.153418,0.548786,0.0231078,0.218766,-0.189678,-0.122911,-0.203667,0.643182,0.192483,0.628969,-0.254134,0.323664,0.367733,-0.0122757,-0.150204,-0.616272,-0.0832775,0.0700456,-0.54262,0.176013,-0.399549,-0.101722,-0.473041,-0.289436,-0.465906,0.387467,0.906427,0.578097,-0.560085,0.640023,-0.615892,0.228331,0.118162,0.122405,-0.201635,0.0880316,-0.0832959,0.318826,-0.27277,0.314298,-0.683025,0.0886868,0.278651,-0.278623,-0.0585063,-0.121475,0.801558,0.61552,-0.364381,0.327313,0.17782,0.00230393,-0.111332,-0.379045,0.703443,0.0154512,-0.172736,0.0728003,0.00688289,-0.527185,0.790983,-0.257502,0.475849,0.204682,0.604932,-0.0275125,-0.178397,0.378182,0.336242,0.181779,0.0800094,-0.678848,0.112471,-0.29507,-0.390158,0.197691,0.227932,-0.474036,0.201155,-1.30954,-0.348117,-0.128971,0.615138,-0.039208,0.349342,-0.208078,-0.31215,0.0207152,-0.183259,-0.188617,0.00583848,0.302103,0.32812,0.407194,0.0863306,-0.215655,-0.202293,-0.341545,-0.567329,0.530753,-0.564199,-0.256488,0.184105,0.019775,0.405215,-0.013722,0.539865,-0.149456,0.302701,0.163142,0.176899,-0.432485,0.439457,-0.296358,0.347033,0.459621,0.26442,-0.368463,-0.312033,0.0469025,0.178353,-0.30769,0.790739,0.0979835,0.63908,0.17235,0.495751,-0.481148,-0.343864,-0.487537,-0.161877,0.141337,0.378942,-0.329778,-0.074492,-0.0831147,-0.190846,0.0181646,0.0847561,0.636875,0.226724,0.0303469,-0.843187,0.133942,0.149942,0.147016,-0.418713,0.322489,0.176626,0.404448,0.42027,0.635962,-1.74071 +3410.43,0.756516,0.0848144,4,1.57326,0.833826,-0.322085,0.0502432,0.465223,-0.164283,0.266138,-0.559917,0.438127,0.160219,0.264193,-0.383001,0.111341,0.388741,-0.270674,0.569046,0.383875,-0.146598,-0.0072145,0.0242395,-0.243567,-0.945772,-0.471753,0.0783963,-0.223945,-0.152361,-0.00770429,0.641397,-0.519295,0.0875724,0.822691,-0.975947,-0.0486346,0.263181,-0.0106875,0.420935,-0.933464,0.321258,-0.0728745,-0.493676,0.882578,0.58101,-0.309095,-0.423541,0.258898,-0.0644134,-1.21123,-0.0972946,0.71318,-0.195117,0.0801452,-0.156868,0.317805,-0.540018,1.18437,0.0517841,-0.317445,-0.300782,0.378478,-0.743288,-0.211842,0.786241,-0.497341,-1.57852,0.274497,0.142984,0.0140986,0.183633,-0.256526,-0.309469,0.192588,0.434345,0.582909,-0.102535,0.61638,0.465553,-0.0166372,-0.438696,-0.438895,0.179236,0.527358,-0.231449,0.277593,-0.0537527,-0.274355,-0.394555,0.308477,-0.0677921,0.342215,-0.436717,-0.233099,0.0473153,-0.179352,0.129272,-0.373188,-0.293996,-0.527802,-0.106343,0.229333,0.694145,0.412066,0.232452,-0.804137,-0.277231,-0.841254,-0.362539,-0.515354,-0.113172,0.22464,0.487561,0.120284,0.0614585,0.43267,0.477377,-0.639661,0.437526,-0.213442,0.360127,0.0752481,0.392729,-1.06864,0.175423,0.0141973,0.457061,-0.266612,0.0867904,0.321519,0.0660004,0.101002,-0.390158,0.0149918,0.15322,0.362051,0.125417,-0.398119,-0.261275,0.203426,-0.101973,0.50327,-0.922569,-0.410605,0.314507,0.347346,-0.409464,-0.269608,0.334893,0.231761,0.724828,-0.154974,0.315619,-0.529392,0.00651871,0.340194,-0.378744,0.146118,0.358626,0.159072,-0.173627,0.32853,-0.492051,0.399827,0.0379944,0.884522,-0.105846,0.0780056,0.320987,-0.189904,0.2821,0.417949,-0.159829,0.584279,0.154901,-0.13778,-0.309719,0.00480483,0.0982677,0.226149,0.461978,0.0351347,0.350671,-0.874287,0.555549,-0.475412,-0.100287,0.107447,-0.268727,-0.312096,-0.463678,0.115654,-1.31753,-0.187924,0.0500802,0.15621,-0.657111,-0.166867,-0.215483,0.146725,0.0526208,-1.09576,-0.223165,-0.166679,-0.777015,-0.103082,-0.408303,-0.20633,-0.179497,-0.145898,0.841816,-0.0237431,0.264696,0.354494,-0.0680074,0.042709,0.442607,-0.651098,0.602165,-0.609647,0.0380672,0.592374,0.276893,-0.0755262,-0.806824,-0.250918,0.851054,-0.267842,0.400502,-0.191113,0.134194,-0.0504964,-0.147546,-0.374428,0.028416,0.128297,0.360653,-0.95566,0.676788,0.058346,-0.528964,1.0167,0.139743,0.686366,-0.0847221,0.00452618,0.0730508,0.110081,-0.878598,0.0616377,0.357943,0.0188815,-0.0507273,-0.0173337,0.0203831,0.267672,0.169058,-0.660187,0.219527,-0.0837711,-0.166975,0.0989458,0.138095,0.0563937,0.274942,0.35976,-0.288892,0.843486,0.220605,-0.0117209,-0.457969,-0.367381,0.274913,0.176678,-0.506667,-0.233254,-0.171881,-0.0632311,-0.0128713,0.181662,-0.112969,0.604157,-0.290512,0.0833515,0.0124348,-0.311328,0.261644,0.0279717,0.238431,0.321007,0.802923,-0.263431,0.161872,0.166139,-0.040788,0.139196,-0.0499209,0.254375,-0.0735149,-0.578502,-0.298988,-0.246421,0.192982,0.0718918,0.152182,0.213309,0.390106,0.461854,-1.28269 +3424.67,0.992013,0.0848144,5,1.68648,0.888987,-1.0918,0.338732,0.525959,0.0121336,0.143249,0.211358,-0.0159719,0.316383,-0.300184,-0.507194,-0.517288,0.122508,-0.349998,0.778647,0.397775,-0.0456866,0.114768,-0.292262,-0.306339,-0.545998,-0.885186,-0.0890734,-0.0264399,-0.307779,-0.0997794,-0.0227356,-0.382423,-0.421456,0.359155,-0.596001,0.126234,0.0495079,-0.444635,-0.218621,-0.132727,0.690767,0.536074,-0.671714,0.554509,-0.111247,0.204173,-0.284778,-0.229397,-0.370204,-0.622356,0.325119,0.408232,-0.0626501,-0.188791,-0.49758,-0.0262657,-0.0453546,0.513773,-0.456064,-0.355333,-1.0306,0.466896,-0.0954114,0.685714,1.07166,-0.577949,-1.44856,0.0808313,-0.585186,-0.0670219,0.0339324,0.19658,-0.444017,0.0340736,0.300002,0.76174,0.276007,0.359322,-0.0169225,0.553994,-0.117017,-0.236196,0.0676766,0.315678,-0.580003,0.254224,0.042163,0.251356,0.544834,-0.182646,-0.0217692,-0.0368623,-0.0386252,0.118971,-0.463705,0.253766,-0.130087,0.437775,-0.047747,0.186304,0.0599771,0.237426,0.197146,0.221463,0.00756875,-0.275466,-0.458712,0.597229,0.12006,0.36917,-0.427678,0.583114,0.827014,-0.042338,-0.281865,-0.32495,0.285792,0.692757,0.211443,-0.235718,-0.0504368,0.274405,-0.492176,-0.353154,0.125929,-0.386975,-0.726858,0.244267,0.00194483,-0.0329247,-0.185012,0.498166,0.160982,0.0445338,-0.00125417,-0.390477,0.723608,-0.192898,0.369915,-0.288972,-0.162489,0.304487,-0.444657,0.204483,-0.216094,-0.585019,-0.377512,-0.00874261,-0.532565,-0.0255919,0.171053,0.10447,-0.246278,0.00263621,0.0390535,-0.0150075,-0.0369531,0.280776,-0.17008,0.293066,-0.0186564,0.216498,0.873858,0.507923,-0.168667,0.444931,0.156883,0.190056,-0.293895,0.145945,0.113834,-0.177209,0.551426,-0.212581,0.0183154,0.130354,0.277038,0.169518,-0.242937,-0.375045,-0.318389,-0.257835,0.639604,0.274282,-0.31955,0.218258,-0.246283,0.182975,-0.114442,-0.276589,0.174103,0.600655,0.534951,0.375162,0.308312,-0.465357,-0.883468,-0.227175,0.288861,0.113988,-0.354372,-0.0813111,-0.136384,0.238624,0.0430718,0.0141353,-0.328447,0.0467037,0.142783,-0.439018,1.16485,0.18603,0.0139812,-0.149518,-0.528854,-0.112536,-0.217027,-0.0779568,0.13465,0.516932,0.586704,0.0513613,-0.135886,-0.390681,-0.199999,0.725593,0.0521118,-0.346634,0.391444,-0.50264,-0.325244,0.173917,0.149255,0.0496002,0.2402,-0.451541,-0.149088,-0.0961398,0.334516,0.0579495,0.367918,-0.242984,-0.433778,-0.81678,0.159143,-0.483617,0.340517,0.11867,0.695108,0.578392,0.0266343,-0.08556,-0.327682,0.0806306,-0.513394,0.119354,-0.729543,-0.551552,0.183758,-0.209753,-0.225387,0.133041,0.15586,-0.12158,0.0925787,0.154972,0.0814441,-0.368892,0.419645,0.2701,0.306854,0.435649,-0.0211005,-0.301244,-0.366408,-0.315456,0.465092,-0.0283104,0.445531,0.41394,0.175818,-0.0634444,-0.361815,-0.115986,0.0325158,-0.144467,-0.451747,-0.150179,0.193435,0.0335619,0.234488,-0.0797292,-0.791734,0.000345793,0.295723,0.218186,0.393228,-0.183276,-0.408453,0.455008,0.191783,-0.21484,-0.0233932,-0.165416,0.111221,0.334342,0.333498,0.578223,-1.3819 +3434.19,0.669425,0.0848144,4,1.59501,0.914922,-1.03082,0.386116,0.347512,-0.108539,0.143463,-0.125674,0.550878,-0.152813,-0.148495,-0.602841,-0.666406,0.219715,-0.151762,0.660325,0.405036,-0.451559,0.407465,-0.163869,-0.282214,-0.722484,-0.970499,0.172265,0.0305706,-0.106952,0.00339439,0.274461,-0.436183,0.105333,0.477125,-0.367685,-0.0379574,0.168156,-0.136405,-0.213567,-0.0563554,0.530615,0.234161,-0.354194,0.797608,-0.0158498,0.483958,-0.420348,0.184259,-0.179577,-0.279823,0.40046,0.502454,-0.0749048,0.104034,-0.0348602,0.572464,0.249242,0.284891,-0.685115,-0.0672342,-0.902246,0.3184,-0.502824,0.267785,0.771827,-0.753592,-0.955857,0.444721,-0.0391482,-0.56639,0.0211934,0.278151,-0.797804,0.191624,0.114883,0.469038,-0.351413,0.1536,-0.105504,0.409796,-0.116167,0.00240748,0.0887803,0.042757,-0.524061,-0.0364291,-0.246162,-0.0845297,0.359496,0.157726,0.286686,0.189955,-0.0786336,-0.016828,-0.655077,-0.0366606,0.0902764,-0.346351,-0.168716,0.088906,0.145135,0.371756,0.40721,0.439942,0.151706,-0.352515,-0.406316,0.360307,0.170303,-0.32148,-0.106116,0.537129,0.546244,-0.19191,-0.391172,-0.0011313,0.653038,0.816375,-0.417005,-0.0972287,0.0957432,-0.0725209,-0.691195,0.215512,0.049912,-0.0999997,-0.273654,0.0173497,-0.0806804,0.0996472,0.0232602,0.0295525,-0.290591,-0.37031,0.305993,-0.474544,0.500989,-0.389722,0.35196,-0.257281,0.306884,0.215255,-0.488793,-0.597388,-0.0656399,-0.221677,-0.0615456,0.140352,-0.278545,0.0285167,-0.0227252,0.0394862,0.240085,-0.0957917,-0.0300519,-0.173503,0.145648,0.370398,0.279875,0.39634,0.133092,0.119539,0.488239,0.118682,-0.074829,0.672098,0.106995,-0.196779,0.0496542,-0.0923427,0.238628,-0.00632111,0.0696394,-0.0832123,-0.666736,0.115594,0.174463,-0.041478,0.081219,-0.495464,0.687077,-0.156694,0.41727,0.229204,-0.341195,0.0898532,0.395271,-0.282518,-0.631905,-0.263364,0.0856854,0.0780299,0.142041,0.236802,-0.313797,0.30202,-0.523831,0.0807276,-0.0105509,0.0863542,-0.308537,-0.525394,-0.160869,0.00215064,-0.218185,0.380003,-0.572008,-0.339618,-0.133201,-0.242057,1.12415,-0.221047,0.166469,0.084858,-0.168971,0.112449,-0.319124,-0.291769,0.227677,-0.585655,0.507465,0.359144,0.54353,-0.532645,-0.25961,-0.166567,0.0956559,-0.565579,0.117222,-0.433297,-0.196784,0.177745,-0.134012,-0.323321,0.0712372,-0.343058,-0.555781,-0.118006,0.27255,-0.507507,0.380293,0.418322,-0.147203,0.199797,-0.140743,-0.10454,-0.147866,-0.105743,-0.395189,0.44741,0.671738,-0.28074,-0.516089,-0.169622,-0.215375,-0.171972,-0.758522,-0.451906,0.42922,-0.40513,0.0202264,0.382073,0.000523789,-0.348343,0.427053,0.0282198,0.602199,0.259067,0.102577,0.146712,0.456909,-0.0422015,0.185215,-0.346022,-0.0903142,-0.132856,0.244107,0.0853755,0.542103,0.382865,-0.194719,0.432098,-0.454803,-0.149931,-0.21453,-0.79585,-0.47354,-0.420037,0.0323694,0.180225,0.298231,-0.52995,-0.708425,0.151166,0.664153,-0.0103727,0.180593,0.126931,-0.141778,0.0755031,-0.162003,0.644396,-0.442868,-0.125373,0.126159,0.279752,0.355188,0.528916,-0.973626 +3446.44,0.860543,0.0848144,5,1.60146,1.01693,-0.883548,0.273991,0.338075,-0.0444372,-0.187078,0.0871222,0.116817,0.460902,-0.452965,-0.506449,0.265123,0.327726,-0.0764728,0.672,-0.0232123,-0.256993,-0.40819,-0.718036,-0.274169,-0.911219,-0.685692,-0.0125136,-0.502352,-0.0679642,0.0226312,0.202093,-0.155144,-0.233043,0.50045,-0.352479,0.316605,-0.0375403,-0.272134,-0.0108336,-0.581411,0.549574,0.134812,-0.309457,0.689951,0.685805,-0.157588,-0.236516,-0.48548,-0.140532,-0.333603,0.0180455,0.526532,-0.112609,-0.205672,0.950223,-0.212148,-0.474603,0.532808,0.204909,-0.658946,-0.387789,0.138171,-0.417085,0.996925,1.18002,-0.543637,-0.789172,-0.101344,0.262557,0.256111,-0.138326,-0.0293013,-0.0647339,-0.364199,0.513245,0.631643,0.146177,0.651742,0.504065,0.543547,-0.0527891,0.0283476,-0.0524077,0.678715,-0.0847314,0.241979,0.0757273,-0.230742,-0.338625,-0.119018,-0.592379,-0.207098,-0.222573,0.285319,0.581034,0.240876,-0.147141,0.334549,-0.592534,-0.0649114,-0.206205,-0.148539,0.357635,0.00148454,-0.0567647,-0.64522,0.0772628,-0.164433,-0.45779,0.74543,-0.700423,0.149753,0.696657,0.10857,0.165756,-0.319572,0.369201,-0.500247,0.90737,-0.521472,0.183131,0.770443,-0.141047,-1.32132,0.0207107,0.114158,-0.075345,0.141996,0.390368,0.0327424,0.319702,0.523663,-0.196706,0.445591,-0.307757,0.261079,0.324313,-0.152748,0.0174228,0.0638206,-0.0023783,0.338848,-0.376502,0.218343,-0.105718,0.453084,-0.915981,-0.00724768,0.0706629,-0.0756648,0.620302,0.053934,-0.587174,-0.50994,0.320628,0.390092,-0.280938,0.291924,0.334684,0.286187,-0.166149,0.254104,0.0489007,0.302961,-0.580763,0.709328,-0.115653,-0.333902,0.107299,-0.246004,0.00549902,0.051611,-0.0584051,0.174854,0.377959,0.0173435,-0.250213,0.0652268,-0.189599,0.225636,-0.414099,-0.0513657,0.606002,-0.0962876,-0.145305,0.285065,-0.414473,0.354873,0.165696,-0.273193,-0.215356,0.808733,-0.444895,-0.211093,0.0996958,-0.16505,-0.591607,0.208251,0.0438666,0.533567,-0.216743,-0.508249,0.0245792,-0.209063,-0.123397,-0.105681,0.267273,0.168308,0.0399772,-0.551787,0.982967,-0.0533145,-0.128652,0.123255,0.0978296,0.222637,0.393601,0.100576,0.684347,0.340423,-0.0901132,0.534173,-1.00675,0.0213128,-0.120986,0.193917,-0.068962,0.176746,0.280568,-0.0941738,-0.00517009,-0.112639,0.0912052,0.0483845,0.198321,-0.0868516,0.614762,-0.267621,0.682255,0.276416,-0.793548,0.328182,-0.252536,-0.0785248,0.506731,0.160584,0.405018,0.500029,0.289279,0.371579,0.149273,-0.175014,-0.161227,0.021254,-0.522723,0.435236,0.588191,-0.168319,0.687606,-0.270101,-0.306537,-0.127776,-0.0615046,0.394297,-0.0337901,0.119092,-0.203302,-0.0758189,0.0680082,0.0855473,-0.691561,-0.178488,-0.0914336,-0.00532306,-0.693888,-0.186195,0.0348415,0.262155,-0.276118,0.0841177,0.388073,0.3918,-0.0707823,0.0564245,-0.0795076,0.163101,0.464752,0.107908,0.365363,-0.0909387,-0.0526012,0.307451,0.369525,0.103113,-0.135002,0.437383,0.185719,-0.208576,-0.0279244,-0.646873,-0.0414716,-0.532414,0.0055816,0.0453995,0.138345,0.191636,0.371948,0.437762,-1.10327 +3487,0.997359,0.0848144,5,1.76198,0.905237,-0.569485,0.136412,-0.0139824,-0.0813828,0.0761022,-0.410072,0.58831,-0.159446,-0.27218,-0.108176,-0.533941,0.194814,-0.121436,0.65384,0.224159,0.0359056,-0.146344,-0.151569,-0.488547,-1.10675,-0.915738,-0.10928,0.0286818,-0.457325,-0.0979564,0.163511,-0.650985,-0.230188,0.536577,-0.567473,-0.338079,-0.123197,-0.25092,0.0123449,-0.504446,0.298137,0.29043,-0.284218,0.864169,0.120242,0.406318,-1.05321,-0.10666,0.00494828,-0.895088,0.197542,0.247636,-0.131682,0.273243,-0.136772,0.268174,-0.464043,0.696321,-0.455974,0.325328,-0.694009,0.273195,-0.0513611,-0.22252,0.811826,-0.733048,-0.962791,0.0941886,0.104533,-0.190683,0.0626454,0.115686,-0.503451,0.091562,0.0697342,0.367665,-0.0552438,-0.0669465,-0.0850272,0.126811,-0.114637,-0.3677,0.155294,0.274563,-0.111856,0.261778,-0.241936,-0.129582,0.139566,-0.0172479,0.328947,0.398173,-0.342452,-0.344438,-0.313555,-0.189285,0.169654,-0.249743,0.170099,0.106795,-0.0853651,0.243605,0.185123,0.0372288,0.0769613,0.108297,-0.367199,0.149582,0.0917461,-0.166583,0.251857,0.336733,0.298683,-0.239117,-0.463095,0.443647,0.227318,0.343814,-0.390603,0.0471614,0.035214,-0.323177,-0.0257547,0.22375,-0.111359,-0.280603,-0.210443,-0.029545,-0.0728424,0.32668,-0.137242,-0.205722,-0.267163,-0.143648,0.202373,-0.084297,0.39666,-0.21731,-0.112949,-0.0966657,-0.152446,0.322427,-0.390782,-0.368227,-0.0519805,-0.376788,0.0868569,0.0407598,-0.0652809,0.0649172,0.0365655,0.0314061,0.2419,0.198379,-0.0582837,-0.104524,0.101534,0.0859023,0.0696621,-0.187416,0.116243,-0.264993,0.00924876,0.0287833,0.399372,0.16057,0.0225375,0.215285,0.235775,0.2089,-0.0842946,-0.26279,-0.0373335,-0.000986438,-0.290313,-0.0726806,0.0548754,-0.198193,0.0978636,-0.444016,0.328835,0.127289,0.602054,0.157327,-0.00419892,0.00131624,0.403543,-0.268753,-0.475823,-0.0656116,-0.134595,-0.518319,0.000367624,0.297124,0.0165342,-0.0149124,-0.501558,0.0602082,0.167882,-0.299612,-0.242822,-0.197493,0.238164,0.142624,-0.181488,0.125998,-0.316915,-0.104641,-0.112396,-0.0564393,0.871799,-0.0599306,0.390051,0.0778889,-0.236006,-0.171679,-0.325667,-0.285084,-0.236982,-0.456772,0.304365,-0.123684,0.461484,-0.103176,-0.514475,-0.0475183,0.351788,-0.286768,0.300568,-0.143373,-0.515582,0.118895,-0.166653,-0.345965,0.166775,-0.16973,-0.481553,-0.154824,0.380755,-0.0749469,0.739168,0.241504,-0.18676,-0.152002,-0.32673,-0.025931,-0.4257,0.0470116,-0.227543,0.227329,-0.0934345,0.0695621,-0.305722,0.108678,-0.438928,0.0403717,-0.70247,-0.0659041,-0.11407,-0.0732409,0.303578,0.381904,0.271497,-0.128835,0.333952,-0.0595213,0.215402,0.258984,0.228636,0.00909559,0.450372,0.218904,0.317438,-0.108393,0.20028,-0.311796,0.0628778,-0.377113,0.16448,-0.0311224,-0.332429,0.00467588,0.179259,-0.125631,-0.323273,-0.39141,-0.313021,-0.102511,0.102859,0.0274018,0.363419,-0.337102,-0.505242,0.156649,0.168927,-0.236402,0.0795647,-0.0891984,-0.567858,0.439499,0.0478485,0.105541,0.03397,-0.162506,0.0629921,0.188548,0.250982,0.434221,0.398173 +3482.55,0.992283,0.0848144,4,1.79889,0.974882,-0.680523,0.173064,0.383289,-0.18494,-0.497685,-0.520785,-0.129897,-0.28275,-0.257515,-0.573437,-0.0295605,0.183575,-0.0705543,0.552195,0.118567,-0.155563,-0.268742,-0.334222,-0.521732,-0.974018,-0.954915,-0.278984,-0.191072,-0.177563,0.0719497,0.165746,-0.200688,0.0354948,0.551248,-0.206359,-0.7856,-0.0650934,-0.416548,-0.192808,-0.379128,0.297557,0.258439,-0.5248,1.05182,0.0613778,-0.372946,-1.01395,-0.145987,0.152247,-1.21788,-0.0744104,0.289261,-0.397681,0.0226108,0.213837,0.365773,-0.762155,0.571389,-0.695553,0.00496594,-0.676593,0.291397,-0.0878699,-0.222797,0.840723,-0.837349,-0.693667,-0.0696153,-0.16087,0.122444,0.0567858,0.00328104,-0.276859,-0.123105,0.10171,0.344301,0.0628577,0.376226,0.330747,0.337895,0.281065,-0.131693,0.316883,0.154126,-0.183931,0.271029,-0.267371,0.00762632,-0.213415,-0.00352986,0.275602,0.237063,-0.198329,0.111999,-0.204056,-0.0538672,0.187246,-0.345317,0.0567839,-0.0356248,-0.167626,0.114624,0.246559,0.14613,0.0226413,0.0228202,-0.0343464,0.267938,0.0201274,-0.210993,0.151294,0.190504,0.337655,-0.334079,-0.369163,0.319057,0.390215,0.280599,0.096709,-0.49242,0.162031,-0.0860727,0.294598,-0.143572,-0.190339,-0.092982,-0.67089,-0.229769,0.255531,-0.0778693,0.197421,0.111638,0.164505,-0.0998765,-0.207588,-0.443256,0.410703,-0.391715,-0.119069,-0.189811,0.0111855,0.148794,-0.176077,-0.328226,0.215618,0.0713984,-0.582103,0.328405,0.0748027,-0.298391,0.236761,-0.177053,-0.00771736,-0.112893,0.112085,0.238099,-0.119689,0.251771,0.0152465,0.214258,0.0907721,-0.585446,-0.271542,0.232923,0.087976,0.129069,0.0542283,-0.354744,0.177884,-0.116938,0.195428,0.0910807,0.347988,-0.194937,-0.312643,-0.082279,-0.329419,-0.0886897,0.231857,0.0298766,-0.0617703,0.0481223,0.336642,0.306306,0.0297926,0.017961,0.185901,0.16892,-0.168176,-0.384433,-0.159258,-0.155451,-0.351539,0.0727179,0.00568029,0.532561,-0.286504,-0.589312,-0.262625,-0.167813,-0.258149,-0.212339,-0.170856,-0.0507302,0.0575675,0.185134,-0.203873,-0.114256,-0.263821,0.18909,0.68498,0.445413,0.444126,0.266356,-0.165278,0.334574,-0.279706,0.267428,0.0708225,-0.46068,0.150424,0.0923951,-0.150852,0.151823,-0.628862,0.0328802,0.0388865,0.211849,-0.0632828,-0.0300738,-0.160422,-0.116986,-0.64572,0.388053,-0.00916793,0.0438904,-0.546728,-0.223678,0.0267943,-0.18841,-0.223076,0.240486,-0.157311,-0.0208135,0.0227857,0.124658,-0.208003,0.16127,0.165502,0.355718,-0.0141796,-0.350981,-0.249955,0.203959,-0.575289,0.00314305,-0.469064,-0.528689,-0.192379,-0.022474,0.138566,0.0353079,0.107824,0.153985,0.0285647,-0.162972,-0.12862,0.109023,-0.0821526,-0.0278178,-0.362912,-0.438449,0.0113689,-0.357428,-0.18951,-0.0428292,-0.0235952,-0.216246,0.0832624,-0.0517155,0.306075,0.277043,0.109092,-0.398766,0.0588732,0.160315,-0.410938,0.19735,-0.177982,-0.321391,0.425382,-0.052225,-0.198125,0.00101261,0.23764,-0.212497,-0.257706,0.0893483,-0.339514,0.0300934,0.04667,-0.264723,-0.231244,0.531515,0.0640249,0.224694,0.253031,0.474019,-0.957426 +3478.79,0.791906,0.0848144,4,1.81801,0.849856,-1.05408,0.350788,0.47087,-0.111859,-0.0482012,-0.52275,-0.402736,0.137738,-0.164255,-0.278287,-0.262031,0.114143,-0.623761,0.287922,-0.011197,-0.210645,-0.366507,-0.330534,-0.734035,-0.923202,-0.709829,-0.146275,-0.565251,-0.387982,-0.0407969,0.342828,-0.423472,-0.292726,0.735709,-0.755278,-0.368371,0.131623,-0.155327,-0.158802,-0.137684,0.37278,0.352126,-0.708765,0.725303,0.286766,0.318753,-0.660394,0.163169,-0.423058,-0.645113,0.279089,0.146704,-0.224801,-0.147234,0.216118,-0.000665616,-0.670883,0.512764,-0.659115,-0.11462,-0.864742,0.409559,-0.362907,-0.123886,0.884204,-0.150825,-0.967917,-0.123152,0.333117,-0.164376,0.163261,0.33283,-0.477057,0.134736,0.196211,0.381455,0.203313,0.485314,0.169009,-0.0953087,-0.300768,-0.0844874,-0.00722902,0.0653544,0.1598,0.244591,-0.116899,0.073934,0.18532,-0.497501,-0.527215,-0.113724,-0.513604,-0.339895,0.114898,0.196801,-0.124408,0.0734617,-0.18758,0.045308,0.13243,-0.198909,0.279953,0.320034,0.0145274,-0.261512,-0.0381935,0.284291,-0.164706,-6.02738e-05,-0.20493,0.527087,0.171174,-0.0251477,-0.360905,-0.219873,0.101434,-0.0351428,-0.141192,-0.111169,-0.00854726,-0.0889826,-0.125874,-0.777953,0.0289538,0.286658,-0.0644966,-0.146744,0.424341,0.447235,0.172917,0.280002,0.0311891,0.162104,-0.00186135,-0.108222,0.68659,-0.426922,-0.194252,0.127565,0.0247434,0.726122,-0.348884,-0.110342,0.171376,-0.555968,0.0143601,-0.897268,0.0511342,0.21984,0.0482877,-0.0900828,-0.342085,0.0333451,0.0338044,-0.260284,-0.621494,0.192617,0.308083,0.270216,0.00826816,0.0890301,-0.327397,0.420807,-0.0377418,0.0315205,0.163421,0.327361,0.141707,0.14622,-0.0821872,-0.121885,-0.388454,0.0452167,0.364866,-0.125169,-0.0207881,-0.0911586,-0.285459,-0.619666,0.0863555,-0.0404722,0.366435,0.212317,0.0264938,0.0557031,0.0726708,0.176389,-0.109025,0.100144,-0.165215,0.0290709,0.036352,-0.0433226,0.116081,0.419877,-0.644536,-0.360139,0.321787,0.343991,-0.125914,-0.87056,0.0357344,0.249443,-0.429183,-0.262922,-0.193035,-0.0377366,0.213191,-0.349204,0.635427,-0.377555,0.0765715,-0.174341,-0.193698,0.229363,-0.422965,-0.130846,0.347787,-0.147926,-0.159836,-0.369923,-0.392858,0.0256317,-0.32941,-0.0596586,-0.0631462,-0.166409,0.300344,-0.284082,-0.000217304,0.013175,0.0114666,0.150041,-0.0893764,-0.168259,-0.399265,0.0410274,0.0515833,0.0394056,-0.133651,0.03323,-0.393458,-0.133425,0.186197,-0.0807459,-0.226986,-0.105131,-0.290233,0.120482,0.144691,-0.471531,-0.250049,0.204284,-0.395718,0.0539014,-0.465636,-0.244482,-0.147048,0.103985,0.0989799,-0.00728101,0.323724,-0.00938986,-0.0152227,-0.135236,0.252586,0.207244,0.217458,-0.0152653,0.121763,0.516289,-0.223857,-0.197174,0.287354,-0.283218,-0.130936,0.0753234,0.568304,-0.0526222,0.108616,-0.157559,-0.226624,0.14855,-0.129057,-0.275325,0.254208,0.221409,-0.127509,0.149686,0.329481,-0.0606431,0.0281363,0.0457137,0.484381,0.153326,0.362113,0.207265,-0.08792,0.515301,-0.028337,-0.39001,0.0799395,-0.488056,0.0777014,0.220668,0.27875,0.469753,-0.998555 +3463.42,0.882953,0.0848144,4,1.63524,0.632492,-1.17974,0.528587,0.908325,0.0083206,-0.394716,-0.146874,0.611399,-0.0994262,0.378698,-0.555312,-0.233156,0.597282,-0.0603631,0.680045,-0.150468,-0.221622,-0.1448,-0.115768,0.139967,-0.773087,-0.786887,0.555143,-0.415602,-0.181766,-0.615864,0.0476237,-0.580083,0.312449,1.13522,-0.625349,0.209324,0.527087,-0.0765792,-0.565395,-0.360237,0.354998,0.256908,-0.245674,0.941256,0.562819,-0.062298,-0.967945,-0.274779,-0.0537742,-0.903524,-0.173923,0.170154,0.0209076,-0.00849761,0.226544,-0.0100783,-0.47535,0.558532,0.0495946,-0.439735,-0.891315,0.468099,-0.611463,-0.18621,0.926997,-1.02211,-1.35919,-0.275746,-0.369341,0.128143,-0.248288,-0.469645,-0.059193,0.000234321,0.00337925,0.311935,-0.208398,0.372238,0.392979,0.415503,0.270144,-0.178126,0.110965,0.566812,-0.513441,0.352959,0.116395,-0.0983392,-0.279785,0.443247,0.304555,0.224146,-0.325495,0.301691,-0.107423,-0.198008,-0.167316,0.0164111,-0.237875,-0.0445024,-0.29787,0.403199,0.0848263,-0.371164,-0.0125921,-0.099179,-0.433979,-0.169214,-0.0547056,0.210117,0.0185116,-0.217467,0.604514,-0.0339467,0.12451,0.323597,0.68658,0.0268002,0.0845721,-0.32424,-0.0325531,0.365572,0.21066,-0.110892,-0.225937,-0.35921,-0.0339159,0.0833506,-0.163737,-0.319888,-0.266067,0.0203095,-0.29869,-0.197741,-0.322909,0.325864,0.0390463,0.17073,0.0100424,-0.198426,-0.0819953,-0.101058,-0.188816,-0.188124,0.0923247,0.726214,-0.463952,0.984298,-0.0690521,-0.276469,0.429656,-0.460043,0.206486,-0.25096,0.105684,0.317531,0.644792,-0.113273,0.0306662,0.070523,0.0615526,-0.0653343,0.176521,-0.199526,0.0761307,0.797237,-0.157864,-0.35244,-0.268785,-0.136045,-0.0698733,-0.0880198,0.212951,0.0979745,-0.399122,0.137245,-0.0736414,-0.226965,0.090585,0.0825159,-0.193512,0.499317,0.50939,-0.255065,-0.151857,0.209793,-0.131377,-0.138772,-0.25247,-0.528904,-0.216173,0.392537,-0.497667,-0.254335,0.0314116,-0.411578,-0.0879921,0.331205,-0.168872,-0.135741,-0.21099,0.2971,-0.00109773,-0.231366,0.287497,0.55781,0.135597,-0.0700492,-0.310415,-0.174605,0.63276,0.362154,0.0560972,0.170122,-0.140032,0.0389992,0.43485,-0.0748083,0.0835271,-0.0290302,0.251825,0.360935,0.134579,0.0267995,-0.295873,0.0874314,0.363809,-0.198648,0.49,-0.177247,-0.304849,0.0640089,-0.0587947,-0.310769,0.325109,-0.0645341,0.112539,-0.493841,0.436119,-0.000839501,0.342748,0.583481,0.0383361,-0.0167746,0.0722068,0.0582958,0.297003,0.395876,0.211717,0.404476,0.172344,0.265131,-0.492743,-0.207853,-0.195006,0.449273,0.109331,-0.00533102,0.610244,-0.563328,-0.0619668,0.0416551,-0.0146226,0.235567,0.505588,0.294057,-0.239793,0.00290854,-0.0565881,-0.33151,-0.325962,-0.622287,0.189769,-0.164128,-0.594497,-0.0231647,0.148269,0.0425791,-0.522905,0.0785581,-0.273578,0.341217,0.333165,-0.425472,0.00845609,0.00933242,-0.314674,-0.0872315,0.378504,-0.319994,-0.206174,0.0689038,-0.213453,0.0193295,-0.472527,-0.313265,-0.38437,-0.586464,-0.28923,-0.404716,-0.171338,0.197055,-0.198283,0.545896,0.092447,0.240825,0.304051,0.49074,-2.38194 +3454.09,0.921625,0.0848144,4,1.67045,0.634767,-1.12985,0.44927,0.734094,-0.0101761,-0.432901,-0.186129,0.383967,-0.179916,0.216659,-0.727778,-0.161951,0.538306,-0.314091,0.781898,-0.0260986,-0.292148,0.106847,-0.199287,0.45531,-0.799714,-0.63229,0.337381,-0.319694,-0.136552,-0.470584,0.154295,-0.689867,0.17941,1.01984,-0.488441,0.335259,0.465376,-0.155662,-0.408351,-0.331584,0.315905,0.275438,0.0981032,1.04155,0.503189,0.0446181,-0.65749,-0.502697,-0.212466,-1.04186,0.022686,0.316861,0.0442198,0.19966,0.200255,0.0553722,-0.237919,0.58497,0.152588,-0.349709,-1.06199,0.654793,-0.540829,-0.3292,0.826618,-0.580776,-1.3333,-0.471443,-0.530389,-0.0697407,-0.314274,-0.0102065,-0.000873465,0.216435,-0.0958367,0.322221,-0.219235,0.419982,0.582271,0.333,0.12886,-0.143849,0.110779,0.588245,-0.663138,0.141783,0.0261037,-0.0978587,-0.0132521,0.390671,0.398509,0.325266,-0.344411,0.303867,0.0511931,-0.200072,-0.0228899,0.332727,-0.126678,0.0259704,-0.17145,0.422929,0.0753578,-0.477696,0.0315134,-0.316361,-0.269745,-0.352973,-0.323572,0.0741758,0.116414,-0.106135,0.570075,0.256225,0.233563,0.402891,0.772415,0.147966,0.182019,-0.414886,-0.0792006,-0.0571058,0.000520338,0.0295286,-0.0362538,-0.676013,0.102264,0.126504,-0.351169,-0.168693,0.0510719,0.0322509,-0.158679,-0.196122,-0.214889,0.354457,-0.256547,0.0999414,-0.0176219,0.0624951,-0.186339,-0.0336215,-0.473633,-0.171026,0.18726,0.600577,-0.249816,0.450063,-0.126803,-0.314824,0.341133,-0.223493,0.198379,-0.144012,0.077512,0.528488,0.679398,-0.281183,-0.0121943,0.128318,-0.19225,0.15922,0.175497,-0.0837039,0.141385,1.01689,-0.101631,-0.1766,-0.262886,-0.0506426,-0.365472,0.106587,0.108976,0.229126,-0.366409,0.258515,-0.149174,-0.367631,0.134638,-0.26162,-0.378117,0.348561,0.692201,-0.192953,-0.481744,0.100572,-0.0795798,0.17505,-0.465894,-0.601444,-0.0257958,0.41833,-0.360881,-0.160776,-0.0405429,-0.368976,-0.0445578,0.31939,-0.0450001,-0.191661,-0.316653,0.196115,0.165542,-0.180219,0.243638,0.355954,0.170593,-0.418714,-0.255108,-0.205812,0.759438,0.311652,0.251619,0.326843,-0.333801,0.0602992,0.439743,0.0243302,0.202096,0.0507383,0.178152,0.0965109,0.013051,0.135118,-0.319181,0.300531,0.582375,-0.0472631,0.317942,0.0326576,-0.43049,0.0511773,-0.0697094,-0.636263,0.280852,-0.0687482,0.221776,-0.564561,0.478053,0.0310768,0.331515,0.383484,-0.357444,0.0642587,0.452858,0.25364,0.254869,0.154233,-0.0207184,0.362596,0.196305,0.460614,-0.477388,-0.271834,-0.152797,0.383781,-0.093132,0.044679,0.57435,-0.445731,-0.359057,0.0629255,0.0630537,0.321003,0.334859,0.165877,-0.182877,0.132288,0.237528,-0.162236,-0.291474,-0.614183,0.260062,-0.0716109,-0.6195,-0.104994,-0.146736,0.262704,-0.41185,0.365083,-0.293232,0.324425,0.136938,-0.427423,0.0253247,-0.24712,-0.079382,0.00468529,0.311657,-0.331967,-0.153227,-0.0665408,-0.486925,0.0175604,-0.338283,-0.185056,-0.0636289,-0.492469,-0.367684,-0.417978,-0.0803141,0.184745,0.0167797,0.265032,0.0925963,0.280773,0.304296,0.52988,-1.71871 +3435.85,0.967943,0.0848144,4,1.67546,0.819737,-1.46839,0.544937,-0.0123652,-0.129136,-0.0504111,-0.42505,-0.21598,-0.291978,0.228114,-0.32267,0.0744081,0.30269,0.139375,0.980061,0.257215,-0.137926,-0.685878,-0.156597,0.0309524,-1.14079,-0.869812,0.019345,-0.343067,-0.0713473,-0.296137,0.284923,-0.241662,-0.0152082,0.639546,-0.686733,-0.230445,0.174335,-0.704685,0.127307,-0.761496,0.468633,0.385428,-0.764222,1.06089,0.644564,0.293719,-0.806561,-0.452166,0.465431,-1.07776,0.161269,0.203,0.139983,0.192759,0.78564,0.10657,-0.137736,0.272098,-0.309252,0.0368261,-0.418899,-0.0449602,-0.401766,0.490429,0.908948,-0.543392,-0.641952,-0.0749047,0.692851,-0.292754,0.267606,0.499188,-0.829417,0.109161,0.419925,0.540952,-0.202398,0.133157,0.182067,0.47417,0.266541,-0.02924,-0.400489,0.722899,0.144478,0.217484,-0.0577075,-0.460384,0.161981,-0.579238,-0.779348,-0.469868,-0.297149,-0.175227,-0.0348239,0.227218,0.25415,-0.297968,-0.225413,0.233621,-0.304415,-0.382131,0.389288,0.407534,0.0355542,-0.381131,0.257864,0.394974,0.21093,0.392178,-0.440203,0.336487,0.150439,-0.304353,-0.678008,-0.616403,0.234819,-0.0717612,-0.138315,0.0519737,0.339518,0.794851,0.0105192,-0.870046,0.133622,0.171484,-0.277288,-0.107975,0.34024,0.41019,0.0967626,0.0605105,-0.324213,-0.135204,-0.0768804,-0.18148,0.588419,-0.0689062,0.0972178,-0.337386,-0.0191495,0.365269,-0.2988,-0.33883,-0.239779,-0.482895,-0.630904,0.25256,0.0802403,0.321907,0.28391,0.0327059,-0.291296,-0.340705,0.111277,-0.102454,-0.68598,0.934723,0.582859,0.0279224,-0.0542186,0.161414,-0.105798,0.508293,-0.00210546,0.576447,0.161676,0.222533,0.478551,-0.19294,-0.0159872,-0.448147,0.0321561,-0.183975,0.0329187,-0.0575343,-0.00433632,0.178178,-0.046213,-0.151508,0.290405,0.397154,0.595647,0.052667,0.0298566,0.454029,0.255694,-0.496243,0.296387,0.782071,-0.417028,0.217839,-0.431306,0.0542942,-0.174526,-0.164917,-0.631735,0.126284,0.449458,0.466342,-0.609546,-0.544306,-0.116831,0.108914,-0.342938,-0.193245,0.0189792,0.00725345,0.275378,-0.655389,0.933405,-0.490667,-0.38358,-0.411876,0.110498,0.236419,0.349858,-0.00471785,0.458052,-0.436815,0.282499,-0.0257337,-0.0369176,-0.260749,0.241519,-0.0470583,0.394492,-0.356384,0.450074,-0.41955,-0.135383,0.00888688,0.235516,-0.111709,0.0973102,-0.174622,-0.357556,0.155026,0.498205,0.263496,-0.134458,0.573548,-0.741007,0.038678,-0.184865,-0.0704811,0.243958,0.268682,0.52124,-0.0344863,0.477565,-0.914391,-0.375869,-0.0117068,-0.923113,0.245305,-0.388254,-0.133263,0.00431976,-0.330594,0.0332998,0.158546,-0.0786284,-0.267349,-0.0637417,0.16715,0.302788,0.300692,-0.263079,-0.122901,0.102729,-0.0907195,-0.395421,0.0870605,0.11112,-0.151592,0.490077,-0.381696,0.613228,-0.0929857,0.127333,-0.0361235,-0.267032,0.559916,-0.481978,0.213522,0.155871,0.00627662,-0.612731,0.239565,0.154731,0.107632,0.460132,-0.0363196,-0.00546663,0.0529105,0.384457,0.232873,-0.0635925,0.13258,-0.0173388,-0.233823,-0.11681,-0.281653,0.130043,0.29789,0.360615,0.545793,0.554255 +3434.85,0.794327,0.0848144,4,1.62768,0.806938,-1.29605,0.543526,0.366378,-0.0261682,0.0744351,-0.312247,-0.205016,-0.320252,0.397422,-0.138178,-0.101625,0.378992,-0.0269773,0.90269,0.238397,-0.243031,-0.616423,-0.426419,0.206538,-0.710637,-0.728992,0.3352,-0.000284725,-0.172748,0.00138009,0.313031,-0.474091,0.102757,0.652089,-0.433111,-0.241335,0.117799,-0.531981,-0.110138,-0.776057,0.525289,0.0610424,-0.580146,0.915732,0.388592,0.232597,-0.927345,-0.555428,0.589394,-1.20002,0.298595,0.359048,-0.161423,0.14236,0.936788,0.0616126,-0.501079,0.397264,-0.227142,-0.288943,-0.532147,0.0878737,-0.348445,0.134156,0.908291,-0.747422,-0.807292,0.353435,0.460311,-0.07721,0.3135,0.536879,-0.59574,0.127114,0.241552,0.689851,-0.192661,0.2696,0.0875974,0.155298,0.161025,-0.264805,-0.18686,0.355165,-0.158189,0.297841,-0.0322065,-0.0255514,-0.0255865,-0.463164,-0.666249,-0.590449,-0.359775,-0.369654,-0.0913956,0.153562,0.223386,-0.376316,-0.389805,0.157396,-0.298906,0.134488,0.387701,0.275321,-0.262661,-0.491225,0.387621,0.314782,0.267561,0.391985,-0.490715,0.662697,0.252056,0.0659251,-0.409626,-0.403261,0.240691,0.0942607,0.0469432,-0.442824,0.237585,0.455761,-0.0770419,-0.841584,-0.147954,0.345796,-0.263632,-0.178395,0.225055,0.649222,0.122716,-0.0758664,-0.213076,-0.256347,-0.178258,-0.170795,0.377464,-0.279418,-0.114933,-0.310973,0.298576,0.317773,-0.34734,-0.357379,-0.129616,-0.629874,-0.524489,0.493527,-0.0046009,0.192314,0.529067,-0.0895486,-0.278352,-0.500507,-0.00874542,0.0440906,-0.529738,1.1387,0.329001,-0.0798547,0.34204,-0.0579463,-0.247961,0.30712,-0.103413,0.547697,0.364366,0.401077,0.507014,-0.136209,0.157607,-0.354803,0.113127,0.082248,-0.0359991,-0.00224824,0.067006,-0.0020704,-0.0267686,0.0326368,0.368428,0.429005,0.461629,-0.499545,-0.125783,0.276186,-0.115103,-0.259187,0.224359,0.498289,-0.54443,0.302082,-0.278991,0.165026,-0.144718,-0.297638,-0.768032,0.062876,0.660967,0.443851,-0.670331,-0.814796,0.208379,-0.0911169,-0.296867,-0.0797701,0.162832,-0.230114,0.56867,-0.645797,0.662926,-0.291003,-0.13084,-0.407599,0.0352105,0.0162303,0.0507058,-0.0946579,0.197406,-0.485,0.0506864,-0.172194,-0.0210962,-0.125616,0.0985627,-0.178336,0.512227,-0.144093,0.645409,-0.48637,-0.385629,-0.351655,0.00730363,-0.181875,0.219674,0.352748,-0.330889,0.048968,0.271046,-0.2807,0.0835593,0.438875,-0.663888,-0.242005,0.177931,-0.240507,0.29161,0.438474,0.419372,0.120977,0.19538,-0.833341,-0.376372,0.313184,-0.940182,0.28917,-0.263026,-0.341396,-0.0211691,-0.44849,-0.157268,0.336363,0.125893,-0.103253,-0.411298,0.290202,0.120571,0.34494,-0.0806578,-0.145803,-0.00223252,0.0335531,-0.499839,0.10961,-0.181023,-0.388142,0.684465,-0.237682,0.438818,-0.00287625,0.164999,-0.102013,-0.369121,0.772468,-0.298123,0.370382,0.290152,0.018155,-0.223953,-0.090944,0.00637959,-0.129249,0.57105,-0.196922,-0.0952667,0.0939741,0.209382,0.143221,-0.177379,0.120002,-0.00958404,-0.165506,-0.0373728,-0.347016,0.127564,0.292706,0.357161,0.541023,-0.843192 +3429.25,0.353909,0.0848144,4,1.64988,0.823393,-1.39072,0.589265,0.397949,-0.0822901,0.302614,-0.153723,0.204693,-0.64215,0.390701,-0.416271,0.00172837,0.238539,-0.300218,1.24104,0.32608,-0.0681124,-0.706613,-0.348148,-0.0550805,-0.798984,-1.29589,0.178867,0.189008,-0.141331,-0.100544,0.226409,-0.471126,0.0313146,0.849785,-0.412092,-0.238556,0.180314,-0.754139,0.000121298,-0.715307,0.302273,0.391572,-0.347086,0.825893,0.282028,0.50665,-0.758785,-0.581487,0.407225,-0.874305,0.166441,0.104436,0.0695061,0.152896,0.810096,0.133659,-0.461473,0.257324,-0.568296,-0.0374088,-0.840645,0.144195,-0.594689,0.0865928,0.98005,-0.529869,-1.35526,0.483485,0.0684268,0.0479153,-0.12129,0.670125,-0.355187,0.221475,0.149769,0.7238,-0.202389,0.392911,0.20817,-0.188195,0.566127,-0.0685725,-0.21393,0.524168,-0.346478,0.0868564,-0.0632035,-0.431131,-0.0172395,-0.321802,-0.678632,-0.176148,-0.25727,-0.394311,-0.0241741,0.352221,0.189019,-0.252546,-0.216219,-0.0795308,-0.392423,-0.410336,0.164309,0.825066,-0.299638,-0.456066,0.401419,0.212659,-0.0999555,0.347592,-0.357959,0.729074,0.1502,0.244251,-0.243097,-0.187402,0.203839,0.305072,-0.245356,-0.583998,0.244834,0.257721,0.222831,-0.869576,0.0883856,0.269069,-0.0955166,-0.463158,-0.171489,0.560421,0.341257,0.131134,-0.25133,-0.191625,0.0022518,-0.156966,0.268019,-0.493389,0.255272,-0.348567,0.374568,0.399538,-0.268944,-0.647599,-0.209121,-0.785173,-0.651846,0.255471,0.0140021,0.112449,0.168192,0.0405399,-0.378213,-0.628964,0.434211,0.284349,-0.0653884,0.468432,0.00508153,-0.430987,-0.229924,-0.00172555,0.0862079,0.210645,0.0148376,0.52104,-0.204634,0.0408083,-0.043429,-0.00966983,-0.0404028,-0.595553,-0.00441568,0.538155,-0.223522,-0.0105013,-0.00822217,-0.071974,-0.148289,-0.231899,-0.106583,0.287378,0.450038,-0.0682216,0.140491,0.376836,-0.255981,0.0434772,0.271142,0.1199,-0.343798,0.289481,-0.782804,0.273678,-0.404694,-0.355327,-0.658157,0.0965245,0.20956,0.225108,-1.11244,-0.678489,0.178813,-0.18941,-0.60291,-0.111204,-0.278404,-0.343064,0.374963,-0.442184,0.879977,-0.849365,-0.0733466,-0.284312,-0.372436,0.04866,-0.0375762,-0.0450269,0.222874,-0.544251,0.0359748,-0.0619922,-0.287042,-0.240163,-0.0395547,-0.0425719,0.483658,-0.322037,0.502545,-0.491528,-0.21207,-0.56113,-0.172113,-0.325952,-0.0769228,0.282143,-0.206819,0.328948,0.429762,0.00701301,0.0486104,0.303006,-0.786162,-0.527481,0.0128207,-0.225655,0.0589978,0.266313,0.0795178,0.136535,0.231696,-0.59266,-0.0247975,0.337511,-0.987443,0.402306,-0.272918,0.0581485,0.0875585,-0.604339,-0.0407731,0.302705,0.189608,-0.270033,-0.308304,0.384235,0.312582,0.419432,0.171976,-0.208102,0.0316577,0.170064,-0.469258,0.122815,-0.0726359,-0.0869443,0.652276,0.0818129,0.784692,0.160371,0.0638832,-0.480617,-0.113945,0.445421,-0.12451,0.201856,0.539761,-0.166333,-0.268489,-0.220378,-0.273273,-0.33275,0.128679,-0.0377761,0.0818147,0.0931531,0.274481,0.447957,-0.0251916,0.0909416,0.185473,-0.385746,-0.619543,-0.0318825,0.113889,0.250448,0.337475,0.500448,-0.934498 +3425.65,0.739005,0.0848144,5,1.57466,0.967545,-0.697406,0.318771,0.798291,-0.116541,-0.247803,0.0616802,0.676259,1.00985,0.315061,0.255235,-0.427627,0.111274,-0.113415,0.926807,0.147134,-0.1475,0.113476,-0.0372037,-0.488875,-1.12374,0.0669765,0.191082,-0.539589,-0.137419,-0.128462,0.559657,-0.486779,-0.114489,1.07727,-0.316272,0.278097,0.348762,-0.28607,-0.36604,-0.0369091,0.470764,0.422252,-0.239973,0.718243,0.25304,0.0831551,-0.542656,0.221857,-0.374026,-0.619772,-0.0717695,0.0671799,-0.369864,0.0292164,-0.379448,0.095479,-0.176542,0.73757,-0.274226,-0.0217004,-0.792677,0.526462,-0.510634,-0.0216384,0.732737,-0.662186,-0.746736,-0.405103,-0.0904527,-0.0483905,-0.17511,-0.524511,-0.348612,-0.309778,0.242048,0.737741,0.142066,0.340287,0.592479,0.748536,-0.433492,-0.221886,0.0931254,0.472105,-0.317706,0.116242,-0.466374,0.126211,0.0280893,0.0729485,0.555336,0.287456,-0.701434,0.234702,0.218717,-0.292939,-0.304971,0.459538,-0.13153,0.215926,-0.0543438,0.42415,0.283249,-0.70651,0.0801547,-0.272164,-0.746564,0.0109348,-0.0858863,-0.139832,0.00979661,-0.277515,0.513289,-0.319535,0.0137336,0.287291,0.129175,-0.106961,0.0568123,-0.0629819,-0.187259,-0.173979,-0.16743,-0.0937992,-0.0534759,-0.526212,-0.162783,0.182888,0.438654,-0.511965,-0.200532,0.197251,-0.329191,0.281783,0.270054,0.259305,0.432735,0.0864145,-0.347695,0.39465,-0.441712,0.18391,-0.37981,-0.00795095,-0.107448,0.475801,-0.150945,-0.0626446,-0.0290871,-0.0369403,0.480917,-0.576983,0.0715897,0.326736,-0.116994,-0.100765,0.165729,-0.0686308,0.829964,0.51451,0.0304173,0.125729,-0.0724602,-0.0045122,-0.197226,0.606287,0.218488,0.0627299,0.0353567,-0.1884,-0.0913921,0.0175895,0.0391222,-0.254926,0.0881333,-0.342196,0.0448005,-0.255743,-0.156023,-0.37073,-0.109066,0.159363,1.00893,0.232989,-0.258439,-0.218634,-0.0442602,-0.0636264,-0.913945,-0.487069,-0.143627,0.0430493,0.134085,0.0912193,0.471862,0.199367,-0.243044,0.0980859,0.173627,-0.083334,0.415692,0.0620783,-0.349463,-0.106966,-0.0182564,0.23675,0.314747,0.207515,-0.348697,-0.208613,0.243192,0.642863,0.454465,0.311584,0.0162046,0.305429,0.263538,-0.174702,-0.120807,0.0157422,0.292154,0.570453,-0.185874,-0.0337491,-0.603229,0.0601262,0.0301069,-0.271486,0.23903,0.11935,-0.431724,0.677482,0.208107,0.0639139,-0.271701,-0.426435,-0.241946,-0.975663,0.481575,-0.146139,0.185803,0.708501,0.125287,0.346311,0.159524,0.00253491,-0.0328361,0.0578542,0.0309241,0.655201,0.0430999,0.434996,-0.322355,-0.252756,0.101842,0.138012,-0.0449266,-0.21895,0.487049,-0.0632036,0.234024,-0.385764,-0.146981,0.263471,0.620827,-0.345749,-0.211269,0.0734895,0.0987128,-0.299665,-0.327882,-0.116819,0.541059,-0.42091,-0.133676,-0.209256,-0.331596,-0.0863353,-0.994873,0.0719975,0.0908089,0.749222,0.0179712,-0.530272,-0.0245598,-0.445928,-0.626576,0.259585,0.683937,-0.164888,0.582149,0.493226,-0.343261,0.0207938,0.194995,-0.207239,-0.192319,-0.590593,-0.551485,0.141035,-0.074789,0.177745,0.453239,-0.00368476,0.122701,0.154926,0.350286,0.393607,-2.69282 +3410.43,0.757964,0.0848144,4,1.51396,0.961542,-0.378425,0.218914,0.425912,-0.0675632,0.140762,0.480037,0.247281,0.0888727,-0.0764551,0.0369935,-0.1753,0.238547,0.144455,0.816334,-0.238327,0.326237,-0.209856,0.125803,-0.210532,-0.349676,-0.331581,0.175473,-0.44065,-0.323936,-0.111419,0.653405,-0.104266,0.180877,1.0227,-0.611123,0.380727,0.0547048,-0.0670572,-0.396799,-0.788341,0.0930613,0.410307,-0.214311,0.443818,0.216175,-0.0712511,-0.533516,-0.256891,-0.286354,-0.532784,0.336431,0.625001,0.233348,0.00801464,0.116092,-0.0366301,-0.10414,0.657948,-0.204865,-0.212137,-0.308795,0.452309,-0.392343,-0.261239,0.509659,-0.389867,-0.298782,-0.0313449,0.166522,0.0663804,0.52194,-0.536959,-0.955514,0.0268934,0.764189,0.751776,-0.0887144,0.573425,0.629186,0.30515,0.103744,-0.107839,0.256245,0.634549,-0.224039,0.433707,-0.067742,0.472431,-0.305875,-0.243769,0.1444,0.142091,-0.655387,-0.111787,0.156899,0.375024,0.298894,0.220325,-0.590201,0.289743,-0.20695,-0.0694844,0.49938,0.0252035,0.192636,-0.413881,-0.635242,-0.272673,0.0594015,-0.227467,-0.233515,-0.313549,0.401563,0.0176404,-0.00834265,-0.0702664,0.286695,-0.280759,0.0995109,-0.130761,0.11371,0.619261,-0.0384392,-1.17919,-0.278077,-0.441366,0.283115,0.280493,0.520383,0.393931,0.0949382,0.282732,-0.0999448,0.88494,0.51219,0.132228,0.480767,0.170337,-0.67306,0.112466,-0.630262,0.548818,-0.331954,-0.232796,0.0259067,0.37598,-0.437855,0.687664,0.42594,-0.12079,0.487164,-0.239974,0.126958,0.358134,0.0917464,-0.299884,-0.246265,0.230513,0.357696,0.521187,0.0746814,0.7067,0.260741,0.18348,-0.598155,0.764482,0.380562,-0.385577,0.364931,-0.647505,-0.295182,-0.255914,0.22002,-0.0642863,-0.538783,0.0416077,0.16712,0.157474,-0.595938,-0.174723,-0.203594,0.462932,0.769509,0.0111189,-0.0730778,-0.383852,-0.0939702,-0.0650612,0.423246,-0.202375,-0.00698895,0.0619853,0.320105,-0.078403,-0.15209,0.148356,-0.185644,0.0481552,0.109173,0.276935,0.0148295,-0.394705,-0.29979,-0.0574596,-0.451531,0.150439,0.264591,0.0311693,0.16481,-0.18742,0.872296,0.238164,0.195217,0.341749,-0.243693,0.254989,-0.240344,-0.0578333,-0.189897,-0.611956,0.0982828,0.324349,0.30421,0.159934,-0.285051,-0.424679,-0.499987,-0.193211,0.00960644,-0.535463,-0.474224,-0.234141,-0.125543,-0.139534,-0.0540384,-0.0828863,0.194351,0.0999878,0.138674,-0.00326357,0.126427,0.517263,-0.450306,-0.265745,0.537316,0.204815,-1.00394,0.176345,0.11074,-0.0792117,-0.0363115,-0.278999,-0.15518,0.0472248,-0.24342,0.757202,-0.189427,-0.295474,0.304433,0.210962,-0.291648,0.180233,0.175256,-0.125002,0.606961,0.16069,0.314372,0.607563,0.129621,-0.325766,0.00465829,0.210104,0.0944019,-0.196521,0.1118,-0.517252,0.268054,-0.0728528,-0.75292,0.391352,-0.03928,0.375539,-0.050419,-0.454787,-0.643489,-0.105411,0.0255694,-0.169217,0.463333,-0.571713,0.185741,-0.131245,0.189399,-0.307578,-0.0566777,-0.307998,0.616085,-0.698374,0.601565,0.335024,0.227524,0.713418,-0.156126,0.502818,0.122407,0.166534,0.349868,0.408086,-1.59183 +3407.38,0.876465,0.0848144,4,1.58876,0.944748,-0.419272,0.169801,0.412203,-0.0792148,0.200399,0.648783,0.163801,0.0871965,0.0965833,0.08122,-0.273858,0.271365,0.0850418,0.829245,-0.121794,0.239674,-0.444731,0.0423482,-0.128328,-0.258438,-0.317036,0.152221,-0.616207,-0.268329,-0.185172,0.529719,-0.135246,0.229454,0.98792,-0.452624,0.282722,0.166012,-0.146854,-0.303459,-0.759591,0.0704581,0.344942,-0.1924,0.488293,0.178238,-0.0216409,-0.51046,-0.257498,0.118459,-0.407977,0.618912,0.61912,0.198682,0.0221655,0.272369,-0.0804073,-0.0612946,0.748765,-0.304489,-0.468572,-0.357676,0.395471,-0.294773,-0.328081,0.678989,-0.500612,-0.390437,-0.163377,0.343872,-0.158056,0.476568,-0.508153,-0.830742,-0.318521,0.849786,0.666505,-0.0514744,0.729545,0.847204,0.553681,-0.00945298,-0.132478,0.135359,0.498461,-0.29065,0.121973,-0.106918,0.51208,-0.305488,-0.291185,0.120483,0.156091,-0.739092,0.0944208,0.510109,0.486187,0.238512,0.473449,-0.566599,0.0862973,-0.362529,-0.0093895,0.472757,0.0495411,0.0101315,-0.441955,-0.83406,-0.4083,-0.140248,-0.132389,-0.0875019,-0.352086,0.435657,-0.405291,-0.232293,0.0463874,0.312504,-0.0372883,0.231006,-0.289688,0.0936173,0.806143,-0.292447,-0.945979,-0.380728,-0.561106,0.191425,0.287102,0.187588,0.567158,-0.0333234,0.170677,-0.129883,0.614867,0.226149,0.129019,0.47513,0.198751,-0.883766,0.110524,-0.481415,0.544258,-0.56903,-0.106315,0.0992297,0.423432,-0.27498,0.546152,0.690984,0.0458165,0.558011,-0.152241,0.120014,0.252724,0.10848,-0.373158,-0.266194,-0.120124,0.256465,0.372124,0.134064,0.642697,0.32728,-0.18062,-0.805729,0.635762,0.0909159,-0.207584,0.419073,-0.680825,-0.241531,-0.357301,0.377466,-0.0847054,-0.725786,-0.014675,0.171145,0.0548972,-0.486166,-0.238483,-0.137961,0.344479,0.89514,-0.440703,-0.231578,-0.387464,0.0388358,-0.0237933,0.0535824,-0.13522,0.0796423,0.0071022,0.332343,0.0259682,-0.265781,0.228918,-0.261608,-0.0158819,0.138552,0.17923,0.00691772,-0.127362,-0.239083,-0.167442,-0.0514022,0.318383,0.449353,0.0692553,0.0369084,-0.048066,0.810932,0.168538,0.223922,0.216193,-0.117456,0.273594,-0.187709,-0.187504,-0.00937697,-0.618837,0.248416,0.194039,0.443222,-0.000823875,-0.076805,-0.41221,-0.127462,-0.415684,0.0394908,-0.479558,-0.595978,-0.161669,-0.0491742,-0.159082,-0.0923492,-0.0380611,0.527378,0.198955,-0.0277074,-0.237178,0.224087,0.370797,-0.321555,-0.57502,0.64004,0.345338,-0.86348,0.561669,0.0959548,-0.111194,0.022155,-0.462067,-0.159447,0.1487,-0.163923,0.896321,-0.18666,-0.350519,0.266886,0.255481,-0.285823,-0.0375337,0.221731,-0.128264,0.45923,0.0531187,0.582323,0.390343,0.0388847,-0.348618,0.0843178,0.276398,0.149429,-0.226875,0.0139871,-0.464988,0.0858908,-0.142791,-0.944159,0.4484,0.0343867,0.378368,-0.160538,-0.51583,-0.516054,-0.093894,-0.1605,-0.411123,0.263502,-0.425619,0.246193,-0.193202,-0.168604,-0.190499,0.229903,-0.192183,0.564949,-0.69217,0.503243,0.211006,0.0864137,0.417835,-0.00059768,0.407968,0.12495,0.164356,0.353483,0.405409,-1.37088 +3399.95,1,0.0848144,4,1.66675,0.731684,-1.07752,0.409267,0.312305,-0.152943,0.0289926,-0.390086,0.0804917,0.376511,-0.149923,0.160401,-0.46754,0.249174,-0.40434,0.356005,0.0983382,-0.26458,0.028035,0.0582019,0.217684,-0.750674,-0.710137,0.463251,0.0798754,-0.188193,-0.189533,-0.172255,-0.382589,0.258936,0.818132,-0.193276,-0.189878,0.696804,-0.103669,0.0888393,0.147705,0.474967,0.131975,-0.657939,0.766669,0.507475,0.272808,-0.671907,-0.168287,-0.112112,-0.727754,-0.518508,0.150521,-0.196492,0.0243553,-0.0968458,0.374602,-0.533888,0.436828,-0.140759,0.367623,-1.27948,-0.241046,-0.163064,0.638627,0.945688,-0.730434,-0.90892,-0.122907,0.154821,0.322106,-0.364624,0.307974,-0.00904956,-0.228341,0.314332,0.635082,-0.0405694,0.404121,0.626485,-0.0444514,0.203377,-0.204415,0.0610155,0.110846,-0.469572,0.362425,-0.159982,-0.692725,0.496213,0.350219,-0.455755,-0.287707,-0.133121,-0.369531,-0.288999,-0.669745,-0.392381,-0.496986,-0.312899,-0.172947,-0.396415,-0.273544,0.553408,0.313263,0.0892948,-0.347293,0.0431802,0.622653,-0.27594,0.50851,-0.445094,0.676919,0.374529,0.31548,-0.38753,0.268787,0.516599,0.213315,-0.181551,-0.0160145,0.10851,-0.638103,-0.0981931,-0.33377,0.329843,-0.341015,-0.166355,-0.432806,-0.0141123,0.0807788,-0.0970356,0.0915652,-0.73663,-0.191573,-0.0684404,0.306062,0.594208,0.158511,0.528392,-0.094012,0.0957414,0.291163,-0.447045,-0.646626,-0.168931,-0.280698,-0.489721,0.0443138,-0.16023,-0.179253,0.0615131,-0.434919,-0.174489,-0.837841,-0.0582193,0.32446,0.0549972,0.344458,0.0789357,-0.143217,-0.291346,-0.0163513,0.0839354,0.082348,0.323868,0.446221,-0.167188,0.192839,-0.109386,0.490566,-0.164633,-0.0866252,0.246782,-0.12465,0.619851,-0.0567473,-0.322158,-0.33367,0.56258,-0.293789,-0.183544,0.0875076,0.416697,0.606368,-0.356626,1.04768,-0.0878841,-0.242223,-0.663084,-0.60994,-0.818054,0.0718812,-0.640204,0.18331,0.465423,-0.152866,-0.205797,0.0697085,0.206332,0.108503,-0.453887,-0.958244,0.257488,0.13081,-0.278629,0.184604,-0.100082,-0.0791281,0.0768716,-0.9279,0.917088,-0.113934,-0.0578561,-0.393292,-0.41533,-0.292898,0.157848,-0.0720774,0.481143,0.197477,0.548596,-0.147266,-1.32893,-0.547928,-1.00184,0.00106427,0.0869896,0.0529138,0.635914,0.0891054,-0.0812274,0.125254,-0.455165,-0.407569,0.37952,-0.349464,-1.07188,-0.857369,0.878896,0.197565,-0.216413,0.598994,-0.325932,-0.114846,-0.667203,-0.55974,0.564904,0.248379,-0.167356,0.700269,-0.265199,0.643297,-0.220053,0.171569,-0.43354,0.400006,-0.124429,-0.126792,0.386786,-0.746498,-0.102146,-0.203978,-0.160944,0.12367,0.161199,0.398387,0.0699714,0.0399984,0.234513,0.116678,-0.0279347,-0.629659,-0.26147,-0.2689,-0.81505,0.0381934,-0.00771004,0.196953,0.857257,0.00703447,0.244178,0.377496,-0.152169,0.166204,0.184254,-0.526003,0.327137,0.182302,0.00964499,0.0691964,0.126229,-0.24775,-0.0118305,0.168142,-0.00730248,0.148148,-0.156724,0.633047,-1.5099,-0.644359,-0.293808,-1.06443,-0.130668,-0.221052,0.162444,0.185946,0.403044,0.431214,-0.447367 +3396.19,0.976695,0.0848144,5,1.65793,0.762695,-1.13942,0.452822,0.323671,-0.157369,0.127002,-0.392504,0.0439847,0.37746,-0.179157,0.17492,-0.473127,0.236819,-0.42326,0.431863,0.0575466,-0.215262,-0.0241412,0.112902,0.166461,-0.7599,-0.708633,0.400778,0.129027,-0.205447,-0.163556,-0.135774,-0.398064,0.246438,0.811339,-0.164263,-0.295638,0.776832,-0.0699845,0.135923,0.170455,0.377135,0.187178,-0.642204,0.828022,0.521052,0.347167,-0.607405,-0.129069,-0.177484,-0.71861,-0.489363,0.0996592,-0.167196,0.0708164,-0.1635,0.433036,-0.508279,0.454172,-0.141116,0.360662,-1.27084,-0.200744,-0.188259,0.586416,0.940329,-0.716618,-0.891101,-0.223617,0.0756821,0.280084,-0.314147,0.226217,-0.0563628,-0.178186,0.352893,0.652007,0.0134641,0.381881,0.58316,-0.120495,0.260382,-0.20387,0.0556529,0.110053,-0.51445,0.355147,-0.273371,-0.684516,0.492796,0.365201,-0.474031,-0.321317,-0.124428,-0.287242,-0.270153,-0.599659,-0.349722,-0.485895,-0.337599,-0.164061,-0.342138,-0.324393,0.534634,0.276046,0.188704,-0.291266,0.0545481,0.54341,-0.226606,0.530425,-0.445038,0.621324,0.390396,0.121172,-0.363995,0.297026,0.484288,0.233048,-0.194687,-0.128771,0.0684462,-0.58309,-0.155437,-0.317677,0.316067,-0.354851,-0.259802,-0.392504,-0.0028779,0.0872773,-0.161591,0.110155,-0.794879,-0.195692,-0.0367652,0.350592,0.581442,0.128498,0.644075,-0.0795285,0.0682241,0.25898,-0.392472,-0.749311,-0.17757,-0.408964,-0.530893,0.0111941,-0.119896,-0.144626,0.142872,-0.415678,-0.179503,-0.894733,-0.0588072,0.334919,-0.0362374,0.269669,0.0388766,-0.223964,-0.220552,0.0488791,0.0212983,0.0429871,0.299282,0.423,-0.12338,0.150582,-0.0515374,0.555013,-0.115946,-0.111128,0.229625,-0.187992,0.590941,-0.0819488,-0.318697,-0.360767,0.466446,-0.397567,-0.26135,0.107576,0.402926,0.630102,-0.3437,1.03374,-0.204947,-0.129161,-0.756399,-0.755283,-0.83824,0.0996198,-0.594725,0.158,0.474044,-0.0769386,-0.132593,0.0685352,0.189564,0.0870132,-0.406066,-0.931196,0.164261,0.132771,-0.278349,0.21308,-0.150687,-0.117785,0.087308,-0.870889,0.905872,-0.0757599,-0.0679142,-0.349232,-0.433617,-0.20697,0.114732,-0.0392581,0.546488,0.225699,0.541649,-0.11325,-1.29488,-0.518326,-1.05772,0.00829078,0.121146,0.0952201,0.572474,0.0811983,-0.0889211,0.194363,-0.483376,-0.394641,0.377616,-0.364014,-1.01953,-0.900884,0.833049,0.226493,-0.22086,0.609995,-0.298404,-0.130859,-0.715229,-0.550005,0.632233,0.275496,-0.261986,0.724871,-0.233001,0.75116,-0.306084,0.2299,-0.461208,0.416783,-0.0480873,-0.225753,0.367061,-0.758527,-0.155571,-0.171532,-0.141197,0.134469,0.217922,0.442646,0.0992517,0.030447,0.283645,0.0684176,-0.0885581,-0.62207,-0.206597,-0.273201,-0.780944,0.0161068,-0.108104,0.0579553,0.864988,0.00738762,0.187603,0.413222,-0.0922715,0.200846,0.140251,-0.420635,0.297234,0.243391,0.0275933,0.0480288,0.138959,-0.326986,-0.0329362,0.218375,-0.0175535,0.232542,-0.156981,0.627836,-1.47383,-0.643788,-0.232789,-1.13,-0.150097,-0.139523,0.167896,0.180558,0.409751,0.424921,-0.556423 +3397.07,0.752924,0.0848144,4,1.60817,0.720614,-1.36266,0.549296,0.150224,0.0137936,-0.0307285,-0.429847,0.00271666,0.456823,0.103815,0.169067,-0.516111,0.491069,-0.389934,0.85222,-0.139779,-0.307998,-0.510631,-0.0956554,0.0992853,-0.873553,-0.979137,0.48757,-0.0737399,0.240498,-0.54822,-0.013618,0.313071,0.216348,0.693978,-0.77205,0.412193,0.153274,-0.269561,0.176236,0.101484,0.672402,0.299474,-0.218067,0.758745,0.405216,0.236158,-0.644351,-0.0610957,-0.51219,-0.916116,-0.388876,0.544743,0.116196,0.194536,0.571956,0.377586,-0.329987,0.125013,-0.121106,-0.520609,-0.514517,0.344424,0.202959,0.616567,0.771269,-0.51861,-0.157478,0.188544,0.459273,0.0650273,-0.0811106,-0.0183088,-0.437761,-0.100194,0.574629,0.759212,0.302884,0.457221,0.706379,0.195787,0.0312839,-0.0443491,-0.298585,0.525,-0.900983,0.281281,-0.133796,-0.302694,0.403313,0.245286,-0.239058,-0.188411,-0.4594,0.0522333,-0.318708,-0.133009,-0.351703,-0.502514,-0.423418,0.226451,-0.0269202,-0.169139,0.442538,0.178164,-0.514857,-0.604297,-0.17001,0.0534871,-0.0455399,0.832646,-0.371333,0.31796,0.665744,-0.300837,-0.35575,0.729072,0.81039,-0.211448,0.136981,-0.240026,0.542457,0.319056,-0.312926,-0.622168,-0.127295,0.355454,0.0581347,-0.406033,0.28932,0.423442,-0.519033,0.0294306,-0.980288,0.287917,0.307074,-0.326451,0.362139,0.292677,-0.114595,-0.680565,-0.107908,0.148537,0.0371402,-0.258218,0.0668002,-0.0417637,-0.51137,0.484205,0.544359,-0.0777825,0.239913,0.357537,-0.626258,-0.400271,-0.131965,0.0270939,-0.405364,0.0136209,0.207363,-0.161616,0.0951072,0.033642,0.00197875,-0.10785,0.0306141,0.885197,0.343034,0.132064,0.36973,-0.386945,-0.85379,-0.252534,0.151866,0.329271,-0.493638,0.468141,-0.00940552,-0.494583,-0.0407795,-0.124366,-0.856043,-0.172134,0.834741,0.0609492,-0.885047,0.725846,-0.248925,0.406097,-0.95656,-0.471333,-0.236281,-0.374324,-0.656641,-0.139718,0.104335,0.00156421,-0.734673,0.465542,0.720417,-0.334218,-1.00294,-0.419325,1.05262,-0.145822,-0.660714,-0.258271,-0.0671037,-0.136466,0.0634249,-0.526301,1.09367,0.452467,-0.233407,-0.086777,-0.943974,0.201037,-0.522975,0.171075,0.489938,0.034252,0.0445777,0.161108,-1.22525,0.295845,-1.23167,0.1772,0.312672,-0.395629,0.274653,-0.0641657,-0.166613,0.605078,-0.627812,0.376922,0.139932,0.163436,-0.0281718,-0.181433,0.653584,0.405739,-0.0912571,0.646451,-0.186673,-0.27568,-0.399077,-0.188183,0.610287,-0.23061,-0.629222,0.564009,0.206428,0.547237,-0.10524,0.200524,-0.875648,0.584216,-0.0242795,-0.282729,0.180279,-0.716713,-0.189936,0.598749,-0.217256,0.0834151,-0.0957812,0.111955,0.397418,-0.266519,-0.323262,0.162969,0.17974,-0.239335,-0.164011,-0.612079,-0.194555,-0.791382,-0.206094,-0.626297,0.472655,-0.200154,0.335953,0.728752,-0.136211,-0.13664,-0.18192,-0.398915,0.968913,0.0058513,0.215275,-0.455844,0.346536,0.0404766,0.201985,0.273909,0.24487,0.379734,0.183905,-0.229508,-0.73112,-0.0881374,-0.295389,-0.318402,-0.551369,0.0657338,0.184521,0.207271,0.429559,0.45527,0.0270299 +3397.26,0.977249,0.0848144,4,1.56206,0.793152,-1.63665,0.624889,0.21635,0.045786,-0.0904154,-0.406104,0.1366,0.0612024,-0.0664054,0.255846,-0.165043,0.418657,-0.567656,0.5291,-0.000578532,-0.340453,-0.144,-0.181297,0.0989167,-1.05629,-0.778539,0.508175,-0.0652769,0.279949,-0.416712,-0.340858,-0.135212,0.239275,0.699922,-1.02149,0.44121,0.112158,0.0626778,0.214314,0.246198,0.691777,0.324301,-0.264372,0.885381,0.674196,0.397072,-0.579479,-0.216703,-0.526281,-0.919197,-0.341518,0.57804,0.0865677,0.348404,0.505146,0.188685,-0.497603,0.0142777,-0.201173,-0.417934,-0.733279,0.0553119,0.195779,0.6101,0.872445,-0.247573,-0.343378,0.445684,0.40207,0.0894866,-0.0911939,-0.266458,-0.693096,-0.0446309,0.637425,0.771535,0.18893,0.637669,0.546981,0.424977,-0.0171702,-0.309825,-0.163066,0.531308,-0.9934,0.143685,-0.223549,-0.267766,0.387884,0.327098,-0.34069,-0.334687,-0.448261,0.0744666,-0.329248,-0.107762,-0.421462,-0.379518,-0.471082,0.142779,-0.102585,-0.0600573,0.248516,0.256898,-0.0874655,-0.735277,-0.395076,0.0717438,-0.0040756,0.671105,-0.325871,0.408005,0.729316,-0.216752,-0.367409,0.421591,0.594564,0.0827119,0.222927,-0.299341,0.493363,0.153826,-0.29939,-0.252456,-0.374553,0.428944,0.010159,-0.735438,0.481915,0.636974,-0.45323,0.17854,-1.0797,0.107055,0.248739,-0.0982504,0.694786,0.456845,-0.305476,-0.887126,-0.221954,0.00632307,-0.20076,-0.464649,-0.0561345,0.0921774,-0.791618,0.680702,0.479263,-0.283065,0.30716,0.159481,-0.949543,-0.277718,-0.0777963,-0.0872786,-0.751108,-0.00145541,0.234824,-0.125685,-0.20726,-0.125972,-0.203035,-0.117289,-0.0330872,0.723149,0.231312,0.079666,0.20607,-0.376729,-0.780977,-0.368373,0.0318037,0.242364,-0.653552,0.321519,0.140852,-0.650378,-0.204685,-0.105258,-0.679434,-0.137911,0.851753,0.348504,-0.882114,0.65228,-0.0226122,0.440837,-0.679701,-0.188877,-0.302272,-0.254478,-0.834103,-0.09013,0.0677792,-0.00452219,-0.692753,0.316045,0.583567,0.144046,-1.09619,-0.625074,0.958653,-0.309328,-0.744869,0.0307634,-0.219141,-0.297326,0.0674376,-0.690938,0.924192,0.316682,-0.311426,-0.328969,-1.1184,-0.0170705,-0.469541,0.133752,0.34481,-0.284199,0.461513,0.166569,-0.992952,0.272462,-0.719401,-0.154288,0.258404,-0.340049,0.336578,-0.255006,-0.103483,0.699024,-0.261317,0.357592,0.26369,0.220061,0.387678,-0.329455,0.472258,0.416865,-0.142657,0.860916,-0.214755,0.0271392,-0.401415,-0.0439665,0.557396,-0.363364,-0.273202,0.632449,0.237263,0.772874,-0.0299329,0.384933,-0.804013,0.641572,0.219938,-0.0476399,0.0669587,-0.959281,-0.0665787,0.362985,-0.0391178,0.143671,-0.212088,0.118722,0.273855,0.0945697,-0.21626,-0.0123684,0.432127,-0.34512,0.0778166,-0.71689,-0.430825,-0.764433,-0.0197312,-0.646557,0.497547,-0.324542,0.317784,0.770589,-0.0171451,-0.199479,-0.0349991,-0.261892,0.614205,-0.00827474,0.276749,-0.584615,0.801219,-0.173865,-0.17629,0.22142,0.123634,0.0828313,0.231795,-0.164565,-0.537629,-0.292744,-0.389112,-0.350832,-0.450727,-0.0268664,0.216412,0.183574,0.465201,0.428456,-0.302573 +3418.3,0.946557,0.0848144,4,1.62494,0.713522,-0.742972,0.377213,0.704508,-0.00606232,-0.241243,-0.185222,0.205036,-0.0832401,0.745278,-0.247187,-0.372324,0.292376,-0.190981,1.24662,0.563969,0.0711838,0.0802621,-0.30532,-0.145466,-0.843036,-0.806025,0.38663,-0.00434128,-0.528493,0.27468,0.301013,-0.440047,0.432111,1.67133,-0.214582,-0.294661,0.335197,0.144671,-0.422491,-0.932539,0.00471351,0.517012,-0.563244,0.61099,0.521129,0.12466,-0.152166,-0.233919,0.106057,-0.443996,-0.285678,0.513515,-0.0133843,-0.263138,0.186261,0.5334,-0.481887,0.602931,-0.648493,-0.138695,-1.03984,0.356521,-0.544324,-0.0177552,0.685938,-0.68002,-1.23201,-0.288759,0.0518739,0.296476,-0.248037,0.604914,-0.314655,-0.150217,-0.0637738,0.726738,-0.110417,0.184596,0.322963,0.57678,0.07149,-0.0820809,-0.121656,0.54432,0.0670415,0.163033,-0.260142,0.212436,-0.275068,-0.252309,-0.142605,0.128133,-0.785973,0.289575,0.428902,0.289949,-0.154871,0.283711,-0.0313229,-0.159512,-0.420171,0.539037,0.312137,-0.433564,0.172343,-0.408217,-0.107171,0.317568,-0.671501,0.483675,-0.420389,0.0106,0.545978,0.100034,-0.329324,0.113296,0.479585,-0.0995964,0.176679,-0.0916696,-0.112609,0.0420093,-0.393585,-1.11181,-0.628171,-0.356413,-0.214109,0.273084,0.475804,-0.190492,0.52078,-0.0725401,-0.122723,-0.107692,-0.0220633,0.478281,0.0392943,-0.744505,0.0695945,0.411012,0.140329,0.386409,-0.702708,-0.313381,0.0142902,-0.29083,-0.494965,-0.435957,0.413105,0.0764769,0.0743371,-0.991598,0.188837,-0.292911,0.47047,-0.2563,0.349724,0.772043,1.01533,0.251007,0.241968,0.289612,-0.114144,0.420854,-0.300681,0.518322,-0.0732162,0.141937,0.389739,-0.177935,0.366572,-0.0263107,-0.46362,-0.443936,0.469868,-0.126419,0.287961,0.500305,0.258237,-0.13567,0.241238,0.0490365,0.653924,-0.353133,0.0291485,-0.65236,-0.0640827,-0.290089,0.0321088,-0.0673773,-0.686824,0.352647,0.043833,0.441741,0.0269722,-0.487776,-0.528235,0.131055,-0.257674,0.251333,0.0831172,-0.575602,-0.321655,0.145388,-0.286311,0.536408,-0.206637,0.686425,-0.203228,-0.638785,0.337993,-0.026879,0.522955,0.487311,-0.0853391,0.0664422,0.348887,-0.509064,-0.0350583,-0.592874,-0.130428,0.107615,-0.0662999,-0.366344,-0.202592,0.0519167,0.434831,0.161285,0.107072,-0.548199,-0.10596,-0.393585,-0.316462,-0.506313,0.336159,-0.217601,-0.496151,-0.225745,0.687981,-0.613304,-0.185152,0.256227,-0.972864,-0.470631,0.485081,-0.281728,-0.188092,1.07276,0.595823,-0.29468,-0.282459,-0.508998,-0.362689,-0.151297,-0.267236,0.0134896,-0.474305,-0.555575,0.674459,0.0182077,0.101033,-0.0633029,0.0284935,-0.234783,0.721889,0.161656,0.46602,-0.385838,-0.118603,-0.643696,-0.376117,-0.108299,-0.0272038,-0.0957266,-0.479794,0.0197459,0.255522,0.361492,-0.217227,0.313369,-0.211779,-0.337229,-0.119166,-0.214533,-0.115224,0.0126602,0.0630155,-0.291387,0.00328931,0.394587,-0.395845,-0.485844,0.26655,0.0981597,-0.479515,0.249074,0.375419,-0.0110405,-0.630422,0.144286,0.38078,-0.305285,-0.248506,-0.0300784,0.144502,0.279211,0.380134,0.528405,-1.9412 +3411.02,0.892774,0.0848144,4,1.57763,0.80296,-0.58949,0.254776,0.917127,0.0187351,-0.123073,0.0481204,0.0196273,-0.0399037,0.669521,-0.248067,-0.322304,0.320033,-0.149582,1.10174,0.450045,0.124276,-0.0114573,-0.312943,-0.164967,-1.04887,-0.64589,0.430758,-0.030774,-0.7166,0.48831,0.215697,-0.251993,0.460182,1.53232,-0.158525,-0.180633,0.448143,0.098737,-0.192924,-1.09417,-0.100705,0.699376,-0.574216,0.614015,0.460227,0.413524,-0.262699,-0.212341,0.114209,-0.301107,-0.128159,0.64239,-0.0661747,-0.347344,0.512933,0.565712,-0.452019,0.824469,-0.743007,-0.0335716,-1.06375,0.324618,-0.531901,0.00162024,0.789952,-0.44983,-1.27386,-0.101252,0.0536825,0.157186,0.0525416,0.642732,-0.203726,-0.0991365,-0.155585,0.851349,-0.0145464,0.247605,0.207248,0.7457,-0.0292325,-0.0827011,-0.150519,0.518076,0.127581,0.157571,-0.225513,0.338154,-0.229802,-0.400502,0.0110105,0.0930911,-0.781363,0.0426194,0.367515,0.31005,-0.045807,0.314497,0.00314686,-0.118088,-0.325792,0.316881,0.235508,-0.354467,0.235806,-0.508154,0.0651062,0.235498,-0.745653,0.444708,-0.371957,0.146132,0.553589,0.170348,-0.113593,0.0441319,0.52924,0.06379,0.254031,0.035275,-0.0162112,0.270913,-0.516604,-0.983058,-0.573793,-0.350678,-0.265922,-0.0896068,0.271636,-0.243841,0.251248,-0.0893053,-0.447051,0.162643,0.00200286,0.349143,-0.085003,-0.709482,0.423929,0.269335,0.120603,0.503651,-0.505802,-0.377994,0.0389962,-0.182886,-0.610445,-0.338067,0.555539,0.20083,0.159832,-1.00295,0.125375,-0.446875,0.642217,-0.321514,0.0746906,0.631417,1.14533,0.231091,0.316645,0.389288,-0.0251418,0.414674,-0.203091,0.630775,0.183381,-0.0135716,0.416388,-0.187167,0.167095,0.1137,-0.390031,-0.361372,0.407224,0.000520689,0.443084,0.231035,0.242652,-0.19927,0.0410468,0.118298,0.789513,-0.314549,0.28791,-0.507882,-0.151566,-0.07579,0.0944264,0.0210977,-0.615218,0.369169,-0.00562843,0.287968,0.0974569,-0.511037,-0.633925,-0.0429524,-0.184714,0.440861,0.0533938,-0.653049,-0.313951,0.187425,-0.288174,0.561912,0.101099,0.479515,-0.33352,-0.699789,0.261062,0.00997246,0.499554,0.324169,-0.0626546,0.0559729,0.402516,-0.667838,-0.145283,-0.736093,0.0667577,0.252906,-0.102096,-0.393611,-0.111584,-0.219122,0.442201,0.0975824,0.251701,-0.649227,-0.222513,-0.573645,-0.405948,-0.327341,0.342532,-0.160278,-0.531882,-0.397016,0.803269,-0.601691,0.0727706,0.235754,-1.08578,-0.427697,0.357343,-0.323112,-0.122579,1.03287,0.451524,-0.309636,-0.312407,-0.673115,-0.188713,0.052963,-0.170785,0.0848185,-0.236952,-0.610576,0.785409,0.169673,0.145595,-0.177754,-0.0577174,-0.096821,0.603771,0.228048,0.429586,-0.348668,-0.125534,-0.55701,-0.280267,0.105656,0.0491533,-0.151746,-0.613402,0.218091,0.247821,0.406428,-0.202956,0.376357,-0.0688456,-0.344948,-0.00848847,-0.262403,-0.13965,-0.277741,-0.115789,0.0349997,0.245772,0.285574,-0.564173,-0.404113,0.0540551,-0.0329409,-0.325782,0.31381,0.485582,0.0922354,-0.585313,0.140317,0.360085,-0.194134,-0.679492,0.0590179,0.162288,0.268674,0.40285,0.518337,-2.8232 +3417.84,0.772636,0.0848144,5,1.60543,0.984702,-0.749999,0.239097,0.291369,-0.168747,0.189835,0.0136185,0.722963,-0.2163,0.0584326,-0.0602905,0.0615055,0.210861,0.0872692,0.759198,0.237512,-0.366062,-0.220626,-0.161614,-0.183716,-1.00244,-0.647486,-0.0378841,-0.104755,0.567779,-0.286269,0.15806,-0.162614,-0.125751,0.896626,-1.30082,0.195542,-0.188781,-0.704434,-0.306149,-0.308308,0.413871,0.0534776,-0.497593,0.631897,0.23887,-0.279087,-0.687417,-0.0774633,-0.422462,-0.681166,-0.257571,0.55449,0.0856981,0.182189,-0.167871,-0.059033,-0.221461,0.295976,-0.041619,-0.476504,-0.578075,0.419339,0.120182,0.503356,0.893137,-0.272981,-0.562652,-0.0927169,0.630015,0.0342765,-0.277301,0.265842,-0.716928,0.108795,0.470359,0.718247,0.228699,0.365787,0.338565,0.287302,0.451913,-0.129903,-0.255933,0.665844,-0.115845,0.378035,-0.304144,-0.0910064,-0.0534518,0.514638,-0.0513304,0.17402,-0.842058,1.1013,0.0972048,0.0496007,0.0117736,0.0527074,-0.454736,0.153019,-0.304505,0.415214,0.53461,-0.285834,-0.111859,-0.163701,-0.213062,-0.00421592,-0.579905,0.474075,-0.468048,-0.200242,0.428103,-0.613692,-0.246202,-0.262599,0.528928,-0.210567,0.108557,-0.561143,0.333535,0.00728205,-0.0778384,-0.0535074,0.0868682,0.625548,-0.241954,-0.423198,0.224388,0.228715,-0.219187,-0.355237,0.00472292,0.367718,0.378152,-0.755546,0.599916,0.150497,-0.167762,0.0963057,0.210844,0.274215,-0.0490443,0.312725,0.0338057,-0.210586,-0.250048,0.448238,-0.289668,-0.557222,0.390009,-0.0383443,0.164953,-0.194088,0.0450872,0.327545,-0.187005,0.186204,0.256206,0.105538,-0.0355438,0.192271,0.00714126,0.126182,-0.27808,0.676239,0.0737283,0.547209,0.725984,-0.13782,-0.338288,-0.154766,0.0644234,-0.0590358,0.204298,0.19472,-0.380605,-0.311655,-0.577206,-0.387436,-0.696042,0.146571,0.614313,0.151798,-0.462571,-0.127363,0.300299,0.396909,-0.45984,-0.0317844,-0.438071,0.202025,-0.266463,0.405241,-0.0650237,0.124218,-0.692045,0.0840632,0.0825189,-0.143219,-0.326452,-0.490282,-0.217015,-0.155773,-0.385947,-0.362169,-0.504267,0.149684,-0.181916,-0.460331,0.682116,0.589125,-0.19551,-0.137447,-0.216689,0.480625,0.204206,-0.146214,0.15865,0.429302,0.475186,0.376756,-0.267185,-0.295275,-0.408722,-0.119698,0.628905,-0.445058,-0.0789056,-0.12791,0.1043,0.00485485,0.0920456,-1.05155,0.0306263,0.266379,0.225526,0.303428,0.100363,0.0495836,-0.261566,0.636793,-0.504135,-0.102445,-0.460541,-0.249985,-0.250243,-0.171292,0.55106,0.579677,-0.00833842,-0.25259,-0.599159,-0.561404,-0.760783,0.248914,-0.483106,-0.0527129,-0.0581645,-0.602462,0.0968232,0.206419,0.416146,-0.400777,-0.27309,-0.0393828,0.133318,0.31685,0.09653,-0.189163,0.326803,-0.0895658,-0.213334,0.0897747,0.36306,-0.0936123,0.677452,0.00786346,-0.10499,-0.0414588,0.238037,0.773881,-0.0519774,-0.202317,0.444497,-0.326035,0.621332,-0.2073,0.269755,-0.0455656,0.680329,0.494549,-0.014364,0.27147,-0.00232682,0.0679059,0.0911687,-0.502033,-0.367255,-0.258741,-0.36081,0.104413,0.0376063,-0.298059,0.11918,0.197325,0.345224,0.444212,-0.893262 +3414.49,0.930328,0.0848144,4,1.65115,0.849753,-1.16524,0.432316,-0.118705,-0.104068,0.0718144,0.00196105,-0.202015,-0.41905,-0.165606,-0.524572,-0.257117,0.446901,-0.0999674,0.865452,-0.0246591,0.0474219,-0.165938,0.0835672,-0.104066,-0.905292,-0.84003,0.226989,0.0192416,0.0579876,0.0308121,-0.205652,-0.435195,0.0490082,0.758045,-0.825185,-0.185885,0.375266,-0.647924,-0.054822,-0.361575,0.775224,0.211063,-0.748296,0.80533,0.316089,0.42539,-0.82498,-0.16894,0.096186,-0.520356,0.242351,0.365317,0.0111113,0.495138,-0.0943611,-0.459896,-0.275257,0.270984,0.271106,-0.633491,-0.536175,0.31137,0.29224,0.291716,0.67005,-1.24723,-0.713475,0.615676,-0.0316284,0.170144,0.120781,-0.112537,-0.0176516,-0.334165,0.756316,0.5914,-0.0436443,0.280561,0.557339,0.286384,-0.235756,0.0304534,-0.118428,0.619378,-0.187605,0.0124465,-0.300331,-0.342794,0.126369,-0.0190514,-0.580638,-0.0266366,-0.308037,0.414718,0.16127,-0.219034,-0.163435,0.167506,-0.302152,-0.446327,-0.766665,-0.285411,0.653572,0.409748,0.213283,-0.250874,-0.715722,0.178453,-0.317151,0.739389,-0.152149,0.0543361,0.0749256,0.506057,-0.236935,-0.437798,0.540179,0.206626,0.282544,-0.345862,-0.235269,-0.287366,-0.12578,-0.317034,-0.184389,0.427392,-0.278637,0.33106,0.163053,0.332961,-0.295826,0.0340433,-0.0956714,-0.121399,0.110914,-0.600682,0.477045,-0.220805,-0.511915,0.0988749,-0.299451,0.170652,-0.342193,0.000183133,-0.100619,-0.0534353,-0.965332,0.327068,-0.582678,-0.409469,0.0802925,-0.0714091,0.213455,-0.064751,0.167725,0.823898,0.078514,0.375807,0.147028,-0.299588,-0.19565,-0.129412,-0.0309417,0.423478,0.0409337,0.532353,-0.0209628,0.500515,0.561442,0.0785814,0.151835,-0.296173,0.0783339,-0.157597,0.836405,0.052811,0.0135754,0.3705,-0.587518,-0.0156683,-0.491991,-0.156417,0.614883,0.279612,-0.833384,-0.319839,-0.222404,-0.0292332,-0.0378103,-0.0905054,0.124637,-0.200614,-0.0578713,-0.193404,0.285339,0.0203045,-0.0126574,0.314559,0.308678,-0.0583167,-0.255731,-0.149195,-0.123137,-0.0246811,-0.0827886,-0.0905282,-0.365804,0.0127396,-0.0711329,-0.251624,0.730437,0.306139,-0.3146,0.145782,-0.513877,-0.0435908,0.283036,0.367117,-0.154378,-0.190386,0.376363,0.611663,-0.339878,-0.00250107,-0.634783,-0.473219,0.421233,-0.320139,0.728551,-0.349255,-0.228157,-0.318093,0.43615,0.172964,0.194594,-0.0669561,0.132904,0.516183,0.430383,-0.691687,-0.25713,0.462768,0.108271,-0.063391,-0.344388,-0.0651316,-0.326431,0.506755,0.302258,0.0353601,0.579829,-0.137152,-0.0352648,-0.457062,-0.735357,0.323771,-0.442323,0.42366,0.0761898,-0.652589,-0.0233794,-0.0717958,-0.0377285,0.190536,0.135114,0.253273,-0.30709,-0.30988,-0.196454,0.00714519,0.764532,0.0469559,-0.277471,0.149874,0.347854,-0.68072,0.233779,0.180496,-0.311577,0.220279,0.122389,0.390201,0.576812,-0.323892,-0.112167,-0.0324875,-0.356946,0.120253,-0.433518,-0.495845,0.43591,0.660027,-0.362498,0.188165,-0.0536911,-0.0279618,-0.205984,-0.717297,-0.155207,-0.0720993,0.402793,0.220137,0.157273,0.179616,0.142898,0.19954,0.378019,0.446699,0.771166 +3430.67,0.99799,0.0848144,4,1.60491,0.823108,-1.32214,0.496622,0.153637,-0.0920779,0.160296,-0.0719156,0.197537,0.0133851,0.0452877,-0.237851,-0.395151,0.375295,0.130148,0.970879,0.234178,-0.122484,-0.267595,0.0354516,-0.13878,-0.792597,-0.572765,0.30063,0.22417,0.217103,-0.551315,0.177544,-0.66751,-0.117572,0.667911,-0.975211,-0.47426,0.304384,-0.790141,-0.0857585,-0.245593,0.274765,0.534696,-0.270839,0.762217,0.503458,0.335985,-1.11292,0.126988,0.140003,-0.532027,0.231069,0.225401,0.0254536,0.259112,-0.0180678,0.0338112,-0.0863011,0.271292,-0.431518,-0.499522,-0.42502,0.334925,0.200744,0.492492,0.931488,-0.715083,-1.09239,0.344678,-0.0193166,0.354847,0.0863843,0.159121,-0.463993,-0.49368,0.643201,0.589485,-0.132993,0.293209,0.380058,0.353952,-0.142676,-0.0701655,0.246987,0.401146,0.209253,0.109948,-0.110765,-0.326983,-0.0617622,-0.173744,-0.15227,0.0204155,-0.215435,0.418612,0.511761,0.0688646,-0.0279436,0.139671,-0.371202,-0.80705,-0.880571,0.263024,0.43197,0.203925,0.175268,-0.304783,-0.792747,0.00808901,0.0445445,0.531198,-0.00413535,0.0885256,-0.061687,0.652206,-0.161392,-0.206118,0.544455,0.172603,0.168388,-0.224796,-0.22199,-0.0763343,-0.282976,-0.143454,-0.302021,0.163682,-0.5771,0.251023,0.0366424,-0.0107595,-0.356811,0.19876,-0.152812,0.13,-0.234386,-0.489155,0.328355,-0.110679,-0.361463,0.137972,-0.266008,0.240505,-0.856613,-0.410313,-0.0131573,-0.166156,-1.37784,0.229211,-0.0365588,-0.0273377,0.456763,0.137951,0.10153,-0.194885,-0.0513208,0.32659,0.152373,0.371433,0.354247,-0.10787,-0.32154,-0.0615629,0.0138305,0.345082,0.0282344,0.354131,-0.230422,0.0882963,0.524326,0.331928,0.060312,0.019895,0.14045,0.164797,0.434014,0.00181714,-0.23007,0.25109,-0.325678,-0.325738,-0.19642,0.0328714,0.750549,0.0974782,-0.721066,0.0240971,-0.0839033,-0.58819,-0.180379,-0.269755,0.02743,0.50457,-0.187697,-0.115889,0.137664,-0.211207,-0.0609859,0.365928,0.304123,-0.0847053,-0.212003,-0.506978,-0.452864,-0.112246,-0.208951,-0.170175,0.0301304,0.100049,-0.222569,0.0554256,1.02722,0.556314,-0.466392,-0.229774,-0.346678,0.3654,0.4097,0.41484,0.325819,0.0114733,0.164964,0.807129,-0.544605,-0.100332,-0.908147,-0.385383,0.621607,-0.525737,0.594038,-0.232201,-0.349784,-0.199601,0.263885,0.0126349,0.178034,0.207256,0.342604,0.565737,0.466247,-0.297137,-0.347036,0.376958,-0.149154,0.140763,-0.407227,0.0151624,-0.200477,0.0074014,0.193429,0.0925047,0.372046,-0.0109605,0.021275,-0.555366,-1.20288,0.334747,-0.815265,0.902115,0.0170731,-0.253855,0.000614465,0.039109,0.114167,0.152528,0.189242,0.239994,0.454822,0.0118067,-0.0481835,-0.120101,0.240286,-0.157895,0.0578261,0.121812,0.385601,-0.418108,0.0603334,0.369158,-0.342453,0.251423,0.259875,0.747696,0.395614,-0.292299,0.210989,-0.392474,-0.598259,0.126552,-0.279647,-0.478362,-0.143168,0.371696,-0.640914,0.128254,-0.21417,-0.0338894,-0.0427264,-0.84037,0.068115,-0.200059,0.400587,0.080123,-0.243728,0.0317796,0.131919,0.206135,0.363207,0.454021,-0.113632 +3427.22,0.420403,0.0848144,4,1.62805,0.769194,-1.64076,0.593998,0.590109,-0.163992,-0.275246,-0.0800527,-0.0915183,0.10668,-0.0620257,-0.603115,-0.550423,0.182811,-0.509043,0.706361,-0.232204,-0.0354941,-0.607401,0.228618,-0.497875,-0.595858,-0.625325,0.337222,-0.427924,-0.00887487,-0.535604,0.157986,-0.196602,-0.296499,0.57657,-0.76725,-0.33423,-0.274539,-0.273977,-0.362008,0.0112178,1.01307,0.549074,-0.0492883,1.23629,0.111662,0.472126,-0.559291,-0.00857954,0.121967,-0.346055,0.57617,0.5156,0.0998534,0.268752,0.012386,-0.0889558,-0.116363,0.517627,0.128398,-0.255774,-0.582554,0.394577,-0.381162,0.427208,0.719962,-0.925508,-1.07522,0.180519,0.267958,-0.183811,-0.0933795,0.227307,-0.331029,-0.145936,0.580781,0.447343,-0.00925972,0.431189,0.669814,0.296985,0.319598,-0.824918,0.0451337,0.0706873,-0.732874,0.0858157,-0.642197,-0.393141,0.262243,-0.203771,-0.019399,0.408309,-0.337984,0.247665,0.338014,-0.108789,-0.278182,0.0539331,-0.398875,0.0517831,-0.595886,-0.419587,0.0230847,0.585757,0.330688,-0.111505,-0.421928,0.225939,-0.57203,-0.177978,-0.246783,-0.0502086,0.883103,-0.265607,0.128094,0.0356388,0.353551,0.188397,-0.0928556,-0.422599,0.188904,0.00996783,-0.914863,-0.775302,0.235232,-0.00678863,0.0858315,-0.469955,0.0808733,0.670181,-0.0944148,0.383345,-0.114366,0.209412,-0.0273706,0.22926,0.352034,-0.14911,0.0215954,-0.0885124,-0.271706,0.585085,-0.270791,-0.8242,-0.0711735,0.11267,-0.174336,0.292833,-0.0533907,-0.0497987,0.63076,-0.170557,0.0189227,0.418859,0.303289,0.00472665,-0.443678,-0.01196,0.434787,0.25781,0.318993,0.13826,0.585739,0.213171,-0.0395794,0.379879,0.454994,0.076544,-0.15095,-0.213212,-0.536871,-0.238989,-0.615645,0.317713,-0.0694362,-0.0353053,-0.217197,0.0941222,-0.555825,-0.218725,-0.168542,0.309332,0.806276,0.471664,-0.0285681,-0.0476537,-0.0145493,0.536518,-0.237626,-0.0940072,-0.564665,0.302677,-0.47694,-0.0536535,-0.113979,-0.170902,-0.705624,-0.26666,0.453611,-0.123396,-0.38077,-0.851075,0.356671,-0.157513,-0.781512,-0.0306511,-0.00264801,-0.0214954,0.262853,-0.522935,0.949118,-0.342921,1.02292,0.466535,0.104933,-0.0137145,-0.518308,-0.370548,0.311709,-0.244151,-0.144399,0.398959,-0.208078,0.335199,-0.49714,0.776148,-0.328108,-0.580171,0.423,-0.314602,-0.881675,0.457251,-0.187671,-0.390804,-0.122867,-0.643341,-0.330805,-0.679,0.209539,0.124677,0.401397,0.850124,-0.486755,0.190228,0.188707,0.0770707,0.27526,0.717966,0.0949696,0.656486,0.102081,-0.0896202,-0.436473,0.633847,-0.28569,0.678505,-0.256531,-1.08354,0.0377256,-0.0256143,-0.0123883,-0.437772,-0.049048,-0.0612896,-0.324964,0.441144,-0.216845,0.346667,0.150139,0.223855,-0.0408632,-0.0226352,-0.155658,-0.221968,-0.482836,-0.221861,-0.0546929,-0.597552,0.124237,-0.273881,0.288646,-0.339348,-0.167656,-0.0237766,-0.770364,-0.589491,-0.0382385,0.175799,0.665702,0.0147301,0.487005,0.194647,0.315154,-0.0180663,0.4105,0.588297,-0.028469,0.365488,-0.954433,0.00460031,-0.346135,-0.199561,0.0311493,0.31294,0.157283,0.279547,0.396589,0.528722,-1.35113 +3421.46,0.785763,0.0848144,5,1.62276,0.824377,-1.41746,0.561101,0.778753,-0.165281,-0.211933,0.0778711,-0.118489,0.142444,-0.00644949,-0.577161,-0.552161,0.225831,-0.418115,0.69099,-0.370017,0.0365735,-0.583738,0.199025,-0.478229,-0.422379,-0.599261,0.22656,-0.427967,-0.0882165,-0.281653,0.506665,-0.294636,-0.24456,0.650594,-0.7791,-0.418176,-0.183965,-0.1346,-0.230362,-0.160526,1.00707,0.667854,-0.269767,1.07199,0.120824,0.202095,-0.561274,0.0275179,0.0668529,-0.45817,0.54918,0.334855,0.0533213,0.173913,0.183179,-0.0668114,0.152229,0.554847,0.138181,-0.370145,-0.64186,0.277107,-0.298394,0.414229,0.726402,-0.736463,-1.05459,0.0496798,0.398527,-0.256623,-0.0763534,0.207653,-0.323958,-0.100848,0.809747,0.39772,-0.0187728,0.332594,0.713601,0.524838,0.382802,-0.74408,0.0106617,0.0908627,-0.667946,0.19037,-0.639777,-0.239501,0.304557,-0.339251,-0.0428997,0.513208,-0.288839,0.199291,0.338235,-0.284711,-0.323476,0.0604226,-0.476874,0.253071,-0.775919,-0.376988,-0.0623363,0.93287,0.327613,-0.107062,-0.482498,0.29836,-0.691185,-0.056044,-0.170456,-0.0648072,0.755045,-0.26166,0.258295,0.175735,0.235028,0.170016,0.043247,-0.225373,0.19364,0.01164,-0.767631,-0.658924,0.18455,0.200531,0.236764,-0.6434,0.213358,0.441828,-0.127638,0.341815,-0.0288776,0.338995,-0.0805184,0.00831217,0.361547,-0.0524328,-0.026749,-0.154506,-0.451465,0.745905,-0.317148,-0.757342,0.0217335,-0.174624,-0.172409,0.358861,0.0155233,0.00830563,0.547439,-0.0643089,-0.0702138,0.362631,0.287133,0.0574735,-0.537913,0.0110463,0.41878,0.0504422,0.475614,0.118104,0.324861,0.325182,0.0167424,0.3701,0.173025,0.12033,-0.241957,-0.143619,-0.493638,-0.335803,-0.722559,0.182627,-0.141666,-0.133994,-0.219491,0.17239,-0.615757,-0.301681,-0.10329,0.401864,0.7914,0.291208,0.10822,0.204914,-0.105127,0.465379,0.101801,-0.0108108,-0.349966,0.234242,-0.692135,0.102594,0.038563,-0.151023,-0.665977,-0.0944406,0.307875,0.000502332,-0.489642,-0.757485,0.563966,-0.14164,-0.630629,-0.055833,0.340823,0.0982569,-0.0583917,-0.667749,1.02565,-0.411818,1.01318,0.514733,0.244161,-0.0500765,-0.290254,-0.259447,0.41103,-0.246439,-0.161062,0.585641,-0.160588,0.18866,-0.384474,0.602853,-0.363387,-0.430656,0.571559,-0.351924,-0.879759,0.382255,-0.12799,-0.496613,-0.141023,-0.701717,-0.528436,-0.671787,0.338618,0.310516,0.389829,0.786494,-0.431598,0.125715,0.194114,0.00264966,0.168885,0.551648,0.326902,0.666396,0.0713571,0.0757038,-0.497115,0.74419,-0.26541,0.66136,-0.279333,-0.885771,-0.0570167,0.0027275,0.0625179,-0.34004,0.0623855,0.249373,-0.337182,0.583309,-0.264557,0.391909,0.186471,0.27782,-0.114132,-0.127117,-0.117813,-0.35042,-0.464775,-0.192267,-0.124516,-0.578061,0.0475085,-0.291922,0.238892,-0.548395,-0.20592,-0.0640329,-0.673077,-0.587749,-0.0939265,-0.04491,0.443661,0.0709853,0.393504,0.0649554,0.443512,0.129055,0.499915,0.544545,-0.161194,0.257383,-1.00079,-0.164694,-0.158475,-0.32103,0.0318364,0.5243,0.154584,0.260067,0.393172,0.509968,-2.16604 +3417.83,0.993603,0.0848144,4,1.58462,0.844441,-1.42155,0.549463,0.706935,-0.163636,-0.246845,0.0760942,-0.283921,0.174786,-0.159994,-0.515978,-0.392668,0.212477,-0.367794,0.457415,-0.495728,0.0667364,-0.494686,0.265545,-0.457363,-0.487389,-0.640568,0.133361,-0.522135,-0.17995,-0.125008,0.596854,-0.289778,-0.22868,0.555757,-0.75381,-0.335841,-0.129606,-0.212613,-0.259049,-0.258286,0.950943,0.789181,-0.208502,1.1021,0.0459146,0.144546,-0.595013,-0.0159453,0.0215862,-0.689717,0.327305,0.305378,0.0826244,0.151325,0.200497,-0.130736,-0.0415553,0.531329,0.169963,-0.318385,-0.654543,0.363421,-0.134512,0.448858,0.937429,-0.576627,-1.0192,0.000538713,0.542859,-0.0589951,0.0323448,0.362811,-0.25161,-0.108653,0.911139,0.43355,-0.117903,0.452179,0.615406,0.575899,0.447691,-0.678042,0.113617,0.135609,-0.629963,0.198619,-0.570626,-0.493569,0.155025,-0.210517,-0.0527627,0.543682,-0.205879,0.321567,0.469899,-0.297533,-0.317499,0.216479,-0.340535,0.106041,-0.647566,-0.248745,-0.0580132,0.859618,0.328573,-0.157719,-0.43914,0.234813,-0.738377,-0.293256,-0.0896854,-0.00431298,0.772293,-0.105217,0.176019,0.220553,0.221726,0.186175,0.165369,-0.0539642,0.279537,0.0700712,-0.601381,-0.541073,0.312264,0.325876,0.0727466,-0.55148,0.229505,0.502196,-0.0166519,0.361908,-0.117009,0.367713,-0.00273922,0.04373,0.379745,0.00222272,-0.133295,-0.0601665,-0.457028,0.786694,-0.331623,-0.79658,0.092919,-0.341038,-0.346822,0.375738,0.036506,-0.0761202,0.629659,0.0407295,-0.0637818,0.403307,0.161468,0.052782,-0.464886,-0.100657,0.421765,-0.113548,0.427294,0.244268,0.313962,0.223982,0.0415793,0.452859,0.362987,0.0308016,-0.194941,-0.14423,-0.450428,-0.368254,-0.676908,0.201872,-0.300542,-0.140861,-0.240716,0.215628,-0.606791,-0.393523,-0.230291,0.420534,0.724355,0.175096,0.178681,0.282978,-0.125029,0.367267,-0.0107724,0.133808,-0.377723,0.111943,-0.66192,0.030103,-0.0406874,-0.221758,-0.826334,-0.186195,0.156136,-0.0706873,-0.661609,-0.547712,0.50844,-0.15255,-0.688998,-0.108266,0.264882,0.195691,-0.0876006,-0.616589,1.15133,-0.251136,0.956605,0.583081,0.280483,-0.0888583,-0.38486,-0.0997365,0.59221,-0.0881625,-0.105916,0.518866,-0.147829,0.231339,-0.481587,0.531641,-0.247683,-0.377201,0.679164,-0.304433,-0.886889,0.164636,-0.073109,-0.708288,-0.123975,-0.541364,-0.462048,-0.677884,0.394308,0.284832,0.471409,0.639155,-0.225987,0.140566,0.230571,0.0410095,0.096353,0.277322,0.323023,0.611542,0.160223,-0.0106015,-0.410314,0.664607,-0.319158,0.611707,-0.343842,-0.844725,-0.180766,-0.124679,-0.0633245,-0.337449,0.0552678,0.0598477,-0.644367,0.640932,-0.0636232,0.425715,0.18657,0.234208,-0.0167994,-0.184862,0.0398493,-0.378841,-0.339662,-0.234585,-0.0170349,-0.442304,0.0942004,-0.205255,0.170942,-0.483513,-0.110506,-0.0995,-0.576641,-0.550301,0.0474593,0.0505689,0.382928,0.120875,0.441037,-0.0147589,0.456344,0.113885,0.620899,0.509973,-0.163074,0.166558,-1.06645,-0.0176751,0.0223256,-0.320491,-0.00407638,0.450498,0.15691,0.262768,0.396118,0.512609,-1.98846 +3425.42,0.971653,0.0848144,4,1.60332,0.677971,-1.75946,0.719272,0.809435,-0.0533932,-0.509805,-0.1485,-0.00993811,-0.258368,-0.164748,0.0243539,-0.472966,0.323332,-0.706668,1.07264,-0.0776383,0.195188,0.207755,0.110691,-0.357599,-0.866504,-0.759979,0.285546,-0.219098,0.317124,-0.478891,-0.121021,-0.47252,-0.0910445,0.800952,-0.350221,-0.055743,0.499142,-0.146612,-0.0631978,-0.0701256,0.576497,0.710204,-0.28618,0.943863,0.411502,0.288699,-0.634411,-0.0410525,-0.134494,-0.379086,0.47389,0.0405123,-0.0128692,-0.00557188,0.370207,0.344109,-0.182629,0.396767,-0.192487,-0.131015,-0.0807029,0.277614,-0.224703,0.228782,0.776982,-0.819356,-0.41237,-0.120429,0.0299915,-0.207452,-0.249608,-0.556619,-0.241082,-0.147994,0.188095,0.2898,-0.517798,0.0530115,0.717376,-0.124873,-0.154413,-0.499461,-0.295481,0.446125,-0.979381,0.0996111,-0.407208,-0.154854,0.126048,-0.261173,0.376041,0.289028,-0.279491,0.134821,-0.286756,0.0421795,-0.024992,-0.328879,0.549294,0.0336615,-0.224576,0.504084,0.304168,-0.193609,-0.104945,-0.0554316,-0.00649623,0.198701,-0.471369,-0.594553,-0.329545,0.631065,0.345341,-0.171817,-0.173088,0.210752,0.375889,-0.074201,0.190673,-0.812472,0.18623,-0.402083,-0.514373,-0.653094,0.0267807,0.225533,-0.327077,0.178463,0.328694,0.148253,-0.0326538,0.497274,0.0776073,0.434682,-0.188832,0.103636,0.157504,0.370934,-0.658034,0.00481917,-0.490448,0.646884,-0.188351,-1.23426,0.0522094,0.073749,-0.559396,0.212972,-0.0926188,-0.277469,0.297296,-0.245903,-0.183105,-0.124337,0.1526,-0.197745,0.120138,0.899714,0.717089,0.343715,0.635578,-0.182102,0.803295,0.076892,-0.0689206,0.804809,0.404656,-0.39265,0.360578,0.187577,-0.0893917,-0.48089,-0.360214,-0.0165253,0.364607,-0.0397485,0.0310104,0.136362,-0.191412,-0.0542092,0.165724,0.29307,1.00502,0.0997387,-0.457658,-0.0348215,0.459049,-0.401467,0.0971464,-0.128248,0.132153,0.438811,-0.280324,-0.0406679,0.161142,-0.202423,-0.59117,-0.266243,-0.132036,-0.397731,0.584882,-0.805746,-0.19827,0.241462,-0.792446,0.348716,-0.118214,0.215277,0.0265369,-0.528602,1.04476,-0.115614,-0.07948,-0.00957222,-0.486852,0.688411,0.685251,0.0266877,0.256053,-0.245182,-0.0404438,0.327969,-0.342566,-0.545729,-0.0796324,0.267355,0.384411,-0.678725,0.591203,-0.500166,-0.323299,0.719647,0.229054,-0.649617,0.04938,0.226378,-0.26823,-0.434113,0.541375,-0.289873,0.198219,0.675854,-0.140573,0.262929,0.0197047,0.783593,-0.0680404,0.795791,0.261477,0.376594,-0.377691,0.0192348,-0.575063,0.11777,-0.638289,0.465919,-0.329364,-0.352755,0.0814309,-0.0191394,-0.335031,-0.0574399,0.150465,0.186744,0.475955,-0.138334,0.188309,-0.0849936,0.285552,0.140851,-0.191734,-0.264894,-0.247372,-0.29221,-0.193515,-0.710211,-0.307885,-0.00819851,0.194057,0.349801,0.117602,0.518381,-0.0892085,-0.187213,0.189205,-1.19879,-0.0891001,0.14208,0.0381653,-0.0137955,-0.0494176,0.196209,0.12091,-0.121806,-0.135406,-0.241112,0.174876,-0.0206511,-0.361356,0.260535,0.0228101,0.141671,0.444267,0.12329,0.164101,0.144356,0.405093,0.379942,-2.02678 +3400.85,0.741582,0.0848144,4,1.55001,0.817101,-1.7389,0.753886,1.198,-0.121471,-0.453769,-0.244801,-0.0192135,-0.180103,0.222106,-0.375367,-0.365368,0.458015,-0.0567314,0.765634,-0.0703057,0.242166,0.260713,0.106949,-0.24192,-0.404285,-1.0484,0.0142306,0.10068,-0.33361,0.170885,0.421652,-0.661415,0.0104288,0.751132,-0.40323,-0.582224,0.646332,-0.0101542,-0.50049,-0.670813,0.37772,0.722407,-0.178933,0.888089,0.246144,0.140368,-0.257755,-0.0558239,0.156471,-0.367128,0.238317,0.242947,0.128207,-0.078928,0.180733,-0.011746,-0.434888,0.226206,-0.0222009,-0.319615,-0.317468,0.128556,-0.492319,0.0526258,0.794871,-0.54633,-0.532799,-0.266391,0.414487,-0.186476,0.104022,-0.262889,-0.285228,0.519251,0.232748,0.231817,-0.295317,0.504117,0.65508,0.206181,0.307213,-0.733494,0.17548,0.572444,-0.438858,-0.0434451,-0.051096,-0.00776057,0.0920523,-0.703011,0.086994,0.525308,-0.761296,0.184806,0.253636,-0.155345,-0.158896,-0.0472997,0.418091,-0.222125,-0.307187,-0.164082,0.32343,0.247663,-0.333875,-0.30905,-0.0629783,0.410156,-0.391981,0.163304,-0.0525267,0.911675,0.262759,0.0469126,-0.337951,0.0121841,0.500781,-0.524025,0.508381,-0.719269,0.198867,0.238872,-0.537346,-0.316661,0.0306201,0.270733,-0.0314409,-0.244163,0.504798,-0.406951,0.321783,0.172515,-0.154993,0.295193,-0.5928,0.114454,0.295507,-0.560215,-0.00653425,-0.116537,-0.198111,0.772481,-0.363516,-0.699017,0.253283,-0.69525,-0.223618,0.259606,0.0284828,-0.480136,0.779857,-0.12789,0.183058,-0.317713,-0.107863,-0.292524,-0.00798216,0.537505,0.818399,0.681276,0.359635,-0.472164,1.07448,-0.0526553,-0.436063,0.545011,-0.356075,-0.626705,0.0174618,0.168626,0.259257,-0.889474,-0.587974,0.00636652,0.355335,-0.115434,0.0804362,-0.0184246,-0.267367,0.000338399,0.157679,0.334396,1.19117,0.446638,-0.303243,-0.187256,0.799124,-0.395658,-0.346584,0.533093,-0.254766,0.22197,-0.326987,0.00608139,0.220723,-0.142494,-0.748272,-0.166668,0.189746,-0.302124,0.25755,-0.715171,-0.299531,0.0837679,-0.779544,0.154174,-0.208029,-0.588786,-0.12864,-0.466149,0.74491,-0.274114,0.657212,-0.137764,-0.480675,0.230453,0.832615,0.157157,0.556079,0.0425279,-0.0990163,0.0262759,-0.115542,-0.328538,-0.392865,0.188962,0.622246,-0.454483,0.161448,-0.760464,-0.0911477,0.484114,0.136369,0.0784826,0.17555,0.238859,0.00667141,-0.372967,0.645947,-0.241562,0.635249,0.343505,0.104062,0.0683961,0.181928,0.911596,-0.259205,0.779863,0.129614,0.735094,-0.0400877,0.264816,-0.841666,0.388145,-0.924514,0.34073,-0.333221,-0.0893004,0.281168,-0.157524,-0.292376,-0.193496,0.236743,-0.260125,0.0940159,-0.290341,0.352712,0.134105,0.319917,-0.1884,-0.843502,-0.0527744,-0.445994,-0.113943,-0.462632,-0.439851,-0.287519,-0.00236185,0.117425,0.0302354,0.164372,0.779027,-0.0601713,-0.00805464,0.0964883,-0.532043,-0.33454,-0.0534521,0.299684,0.0977534,0.117959,-0.282791,-0.467423,0.0770468,-0.15625,0.120159,-0.380789,0.370706,-0.707571,0.539438,-0.150423,0.45006,-0.0616433,0.538346,0.151169,0.132827,0.388804,0.364455,-3.64264 +3411.28,0.938905,0.0848144,5,1.55176,1.12565,-0.611077,0.133615,0.638065,-0.0698974,0.00842167,0.340594,0.431672,0.443628,-0.0640432,0.0610646,0.143156,0.285566,-0.407388,0.717455,0.0540678,0.247523,-0.348036,-0.296875,-0.295696,-0.729969,-0.0920735,-0.00719656,-0.577812,0.060084,-0.237271,0.305657,-0.133432,0.0690819,0.465386,-0.415564,0.782778,0.298797,-0.0711601,-0.020644,0.0867257,0.259478,0.229692,-0.320939,0.816576,0.477222,0.382887,-0.669382,-0.19827,0.115788,-0.311208,-0.131694,0.26892,-0.30532,-0.0910131,0.767985,0.552853,-0.0046376,0.526564,-0.267633,-0.203992,-0.628404,0.508836,-0.22482,0.343142,0.893924,-0.379982,-1.13365,0.0864474,0.313714,0.210401,0.155576,0.393622,-0.168975,-0.61437,0.242857,0.551086,0.228396,0.605237,0.223085,-0.105492,-0.118645,0.25247,0.239498,-0.0736384,-0.525749,0.145607,-0.082327,0.14835,0.0130631,0.613228,0.0873167,-0.0875544,0.01848,-0.0711823,0.0436862,-0.205429,-0.113693,0.176978,-0.433835,0.540112,-0.0201549,0.519427,0.124793,-0.221229,0.0167883,-5.45712e-05,-0.244777,-0.563076,-0.00034678,0.276183,-0.138656,-0.10552,0.714229,-0.0655522,-0.308913,-0.244899,0.280942,0.285346,-0.343311,-0.451754,0.14184,-0.018182,0.206287,-0.798893,-0.584399,-0.468937,-0.48215,0.478381,0.220495,1.02939,-0.0284793,0.49659,-1.11706,0.131131,0.131952,-0.230342,0.903933,0.0218035,-0.514105,0.108251,-0.144536,0.234534,-0.578363,-0.406944,-0.43403,0.308635,-0.821738,0.152551,0.345489,0.202922,0.256349,-0.103621,-0.483516,-0.0204996,-0.0960473,0.319323,-0.17123,-0.00678577,0.245299,0.209908,-0.336946,0.318459,-0.635673,-0.243233,0.430488,1.08073,0.266172,0.397026,0.390248,-0.0312075,0.120387,0.114872,-0.166685,0.205528,0.305458,0.189905,-0.384948,0.160359,-0.218629,-0.297967,-0.362043,-0.357283,0.296677,-0.0836226,0.141555,0.940594,-0.243514,-0.0238047,0.0274495,-1.13309,0.0443717,0.231399,-0.59334,-0.420842,-0.327296,0.185481,-0.493188,-0.105588,0.346678,0.514299,-0.458725,-0.0983774,-0.0462315,-0.335932,-0.0137486,0.807654,-0.129612,0.684287,0.347207,-0.725387,0.987308,0.100694,0.209995,-0.233231,-0.618164,0.0950819,0.0690004,-0.639587,0.367804,-0.342505,0.323732,0.373848,-0.250511,0.273032,-0.759266,0.058974,-0.38284,-0.305643,0.930599,-0.314281,-0.595028,-0.0873063,-0.268925,-0.697382,0.0311644,-0.558934,0.129139,-0.775825,0.410283,0.116445,-0.952578,0.813592,-0.36623,0.085901,0.131189,-0.252136,0.0432505,0.152635,0.255761,0.274247,0.330099,-0.316023,-0.147485,-0.513085,-0.465334,0.294369,-0.250218,-0.0278,0.213236,-0.145589,-0.0366238,0.205461,-0.382494,0.63603,0.554668,0.588491,0.0903834,0.341805,0.0761489,0.0561523,0.490143,-0.189854,-0.0986063,-0.610085,0.0834203,-0.346593,0.814244,-0.329243,-0.312576,-0.0152937,0.151454,0.0867983,-0.0990954,-0.116129,-0.835737,-0.401839,0.544056,0.346395,0.28446,-0.380797,0.191595,-0.0642199,-0.278585,-0.0265103,0.337479,0.425859,0.34284,-0.737003,-0.208247,-0.638271,0.0542147,-0.499269,-0.146845,-0.164828,0.147304,0.235,0.383803,0.484768,-2.34475 +3396.89,0.931454,0.0848144,4,1.53135,0.874164,-1.16677,0.459102,0.951532,0.100053,-0.0286426,-0.0463811,0.231058,0.277108,0.155082,-0.297086,-0.180907,0.0809819,0.184533,0.737005,0.659594,0.00108656,0.195599,-0.0803961,-0.134841,-0.67012,-0.718452,0.11593,-0.221997,-0.415115,0.231054,0.216831,-0.496605,0.0764116,0.392673,-0.636856,-0.342281,-0.0253454,0.0924227,-0.298805,-0.311258,0.313085,0.880793,-0.145365,0.716651,0.695189,0.0546733,-0.599878,0.122197,0.142337,-0.450557,0.16381,0.080955,0.767346,-0.0953035,0.0758753,-0.178915,-0.323946,0.623786,-0.168763,-0.212673,-0.382661,0.795643,-0.268559,0.358854,1.26448,-0.40087,-0.812038,0.113806,-0.154025,-0.619892,-0.721731,-0.0221427,-0.767963,0.0498738,0.245124,0.766673,0.0946523,0.73505,0.25335,0.342084,0.528607,-0.651556,-0.43632,0.721457,-0.821626,-0.180311,-0.163164,0.0861975,-0.504346,-0.290478,0.0173789,0.276575,-0.196,0.137042,-0.281436,0.318994,0.0841143,0.379467,-0.28975,0.43714,-0.516129,0.0660201,0.515736,-0.0362235,0.278963,-0.071498,-0.0451652,0.191103,-0.929041,0.399781,-0.174167,0.392128,1.01255,-0.131284,-0.00546483,-0.242618,0.305644,0.106226,0.635883,-0.306931,-0.418173,-0.134079,-0.0760503,-0.434008,-0.0798886,0.13253,-0.304919,0.258735,0.121521,-0.532957,0.272213,0.264119,-0.406096,0.279989,0.0965499,-0.369213,0.477236,-0.395977,0.269405,-0.634893,0.203654,0.665105,-0.443727,-0.0231549,-0.0568324,0.483367,0.273425,0.381616,-0.0532681,-0.357893,0.439997,0.261889,0.013207,-0.146671,0.365706,0.161001,0.258273,0.634442,0.738323,-0.328275,0.38561,-0.252148,0.193924,0.300563,-0.00443241,0.428041,-0.0240972,0.113665,0.518858,0.689184,-0.71444,0.0150224,0.319926,0.175598,0.117141,-0.234975,-0.0457335,0.0487007,0.12008,-0.643483,-0.0287549,0.500698,0.464771,0.225417,-0.19103,-0.421922,0.44571,-0.147829,0.116797,-0.0281634,-0.197936,0.33627,-0.34716,0.382664,0.0989278,0.287948,-0.435206,-0.0711886,0.299962,-0.394126,0.0656116,-1.11304,-0.219099,-0.0515488,-0.422509,0.134975,0.461117,-0.331405,0.0727719,-0.487353,1.29402,0.0119849,0.48818,0.295553,0.132597,0.0464566,0.0298391,0.0351128,0.344663,-0.50591,0.327414,0.49227,-0.394735,0.108252,-0.711962,-0.748356,0.428404,-0.73986,0.445375,-0.0773989,0.575391,-0.146186,0.24356,0.277687,0.139493,-0.0973117,0.100579,-0.0949617,0.152955,-0.157602,0.206957,0.080856,-0.651935,-1.05275,0.64182,0.356592,-0.000152895,0.519865,-1.06842,-0.00108558,-0.090513,-0.42599,-0.427665,0.0126675,-0.720221,-0.275641,-0.634084,-0.376388,0.366397,-0.58128,-0.0598014,-0.199208,-0.0557857,-0.152771,-0.217274,-0.0419863,0.658973,-0.159804,0.259763,0.142087,-0.564808,-0.0786448,0.15736,-0.0971819,-0.267392,0.0279086,-0.399159,0.57149,0.259233,-0.0375661,-0.172512,0.50838,0.0976448,0.067013,0.567885,-0.0133816,-0.0717197,0.288725,-0.490446,-0.0781825,-0.27156,0.0701372,-0.0586321,-0.151649,0.443095,-0.286253,-0.203043,-0.0125311,-0.119869,-0.128293,-0.112569,-0.404546,-0.105875,0.155094,0.141029,0.197091,0.375538,0.443949,-3.02037 +3395.15,0.997854,0.0848144,4,1.51271,0.890597,-1.32567,0.478302,0.999152,0.105434,-0.412503,-0.632125,-0.0459228,0.667404,0.120135,-0.252766,-0.612443,-0.0636098,-0.307018,0.419898,-0.372812,0.0972622,-0.182,-0.0624696,-0.255873,-1.01487,-0.806946,0.301147,0.135616,-0.116332,-0.0166023,0.410556,0.0117829,0.0859203,0.330545,-0.208996,-0.130729,0.280647,-0.202804,-0.310638,0.106615,0.576267,0.559139,-0.155214,1.15267,0.292169,0.317277,-0.346657,0.116722,0.856959,-0.263631,0.121991,0.0607871,0.361281,-0.418784,0.209047,-0.0414114,0.0590515,0.648135,-0.381745,-0.318395,-0.851496,0.718033,-0.185551,0.382766,1.07073,-0.145758,-0.602446,-0.0260571,0.157448,-0.22097,-1.37487,-0.349265,-0.152056,-0.0791132,0.297177,0.827627,0.133907,0.988625,0.552375,0.486778,0.263479,-0.463248,0.041628,0.698707,0.231652,0.340627,-0.381799,0.202104,-0.714235,0.241787,-0.314289,-0.0680322,0.0948665,-0.309503,-0.0607951,0.000102843,0.0465155,0.456122,0.255117,0.136687,-0.639231,-0.0168961,0.385679,0.321902,-0.0231074,-0.218105,0.119037,0.484005,-0.870368,0.486248,-0.183025,-0.00859615,0.422215,-0.473468,-0.00509142,-0.702963,0.394991,0.173724,0.146538,-0.317756,0.00465884,0.301459,-0.0607109,-0.278249,0.0862513,-0.0380347,-0.935612,0.655164,0.28961,0.0783584,-0.115032,0.17006,-0.742389,0.797245,0.106072,-0.274017,1.1156,-0.173181,0.00407461,0.0560769,0.0226154,0.412451,-0.349369,-0.241164,-0.327553,0.012631,-0.270445,0.322591,0.566365,-0.342127,0.71653,0.202452,0.714687,-0.531733,0.399058,-0.339868,0.115847,0.415721,0.639814,-0.0509684,0.44078,-0.248717,-0.178881,0.121953,-0.182354,0.695843,-0.289897,0.156511,0.215591,0.57979,-0.119731,-0.244246,0.213002,0.130116,0.377093,0.080469,-0.319137,0.36218,0.497479,-0.372995,0.124593,-0.0898337,0.72729,-0.0475109,-0.0775839,-0.645851,0.384029,-0.291866,0.108556,-0.318182,-0.00231788,0.0284145,-0.0787157,-0.0764661,-0.413384,0.343936,-0.888544,0.197002,0.475067,-0.0134056,-0.402301,-0.31122,-0.657056,-0.0529616,-0.165223,0.00815345,-0.106929,-0.558168,-0.251574,-0.391646,1.24197,-0.401953,0.604664,0.207622,0.0127736,-0.082607,0.218187,0.487503,0.243941,-0.323214,0.297213,0.47855,0.210065,0.202195,-0.280795,-0.623072,0.291123,-0.657994,0.540424,-0.222983,0.413826,0.266313,0.480289,0.0363637,0.134339,0.199672,0.323596,-0.16382,0.075823,0.196424,0.150343,0.562822,-0.550824,-1.03372,-0.0786995,0.197691,-0.0548587,0.611164,-0.670222,0.0641428,-0.229525,-0.0717485,-0.253168,-0.650047,-0.710512,-0.184315,-0.47039,-0.105326,0.180029,-0.197539,-0.382219,-0.45583,-0.0627451,-0.264381,-0.204305,-0.185521,0.214347,0.0385188,0.219466,0.125048,-1.18587,0.362471,0.187039,-0.434279,-0.284504,-0.0233464,-0.289548,0.122115,0.0722065,0.185785,-0.132478,0.233094,-0.26148,0.27768,-0.0356143,0.375939,-0.044411,0.0399632,-0.272612,-0.494021,0.46166,0.491927,-0.196888,-0.08168,0.0589611,-0.123199,0.0947245,-0.102711,-0.111221,0.0928588,-0.403964,-0.0722242,-0.895479,0.233986,0.171864,0.180591,0.414565,0.42496,-3.16223 +3403.39,0.923334,0.0848144,4,1.61142,0.650669,-1.5016,0.591427,0.766426,0.0149891,-0.350247,-0.156071,-0.0443846,0.237579,0.0837428,-0.00704441,-0.301967,0.427532,-0.188294,-0.223672,0.535259,0.0186608,-0.574368,-0.130016,0.132049,-0.472438,-0.489964,0.291814,0.0475714,-0.348629,-0.0197843,0.156621,-0.328045,-0.365723,0.390434,-0.362147,0.00187212,0.380826,0.395155,-0.469774,-0.28627,0.404062,0.679882,-0.702631,0.797972,0.456213,0.384904,-0.215752,-0.268403,-0.00588591,-0.117263,0.369691,0.125359,0.377993,-0.160245,-0.0977963,0.161497,-0.0675945,0.520199,-0.217762,-0.243195,-0.923194,0.734108,-0.680229,0.014512,1.12209,-0.25583,-0.222799,0.296735,-0.0620808,-0.390816,-1.55526,-0.477167,-0.0848031,-0.0608354,0.975106,0.504098,0.00976377,0.897482,0.539093,0.667509,0.316609,-0.309582,0.115836,0.537962,-0.294468,0.148142,-0.243281,0.16762,-0.54724,0.083287,-0.0157871,0.0608728,-0.298376,-0.783017,-0.0968294,-0.0794673,-0.235445,0.601976,-0.00426012,-0.218198,-0.625755,0.248023,0.0903705,0.520833,0.0780121,-0.216138,-0.0660521,-0.0911103,-0.714691,0.352996,-0.0161514,-0.0841989,0.782875,-0.327601,0.0220336,0.0215485,0.583731,-0.123983,0.217205,-0.100339,0.126206,0.104577,0.131864,-0.473448,0.284607,-0.100455,-0.495845,0.669581,0.40401,0.491325,-0.581946,0.303539,-0.824568,0.636396,-0.0312404,-0.298148,1.08542,-0.501383,-0.144502,0.206033,-0.275865,0.372079,-0.110155,-0.686524,-0.0818543,-0.275865,-0.724723,0.412708,0.154546,-0.16526,0.569229,0.362548,-0.598345,-0.345374,-0.0149439,-0.097091,0.322181,0.458429,0.54256,0.0069728,0.262397,-0.00743199,0.137744,0.565421,-0.206616,0.934128,-0.0220092,0.0251422,0.180703,0.235895,-0.571158,0.0155858,0.352008,0.316113,0.103197,0.0456518,0.154631,0.223656,0.318106,-0.436819,0.204551,-0.184046,0.733585,-0.13331,-0.642909,-0.0869801,0.245207,-0.533517,-0.0996232,-0.431696,-0.0889205,0.122793,-0.398194,0.0227053,0.141085,0.621765,-0.81464,0.49385,0.34441,0.202152,-0.426098,-0.534363,-0.519336,0.0222372,-1.02254,0.0169561,-0.580183,-0.312863,-0.888212,-0.170733,1.36677,0.503687,0.553135,0.120814,-0.439294,0.122752,0.0974399,0.424948,0.320825,-0.116053,0.0173564,0.226652,-0.400729,-0.552857,-0.710839,0.0288584,0.386117,-0.955972,0.786398,0.0189946,0.275958,0.18881,-0.0564163,0.0144432,0.103708,-0.310564,0.14073,-0.257507,0.262322,-0.288908,0.123328,0.391344,-0.182979,-0.404492,-0.817744,0.308791,-0.171504,0.670648,-0.15708,0.468679,0.195505,-0.0866718,-0.558468,0.0227487,-0.854474,0.309771,-0.543712,-0.49037,-0.128681,-0.293279,-0.639991,0.295505,-0.0411403,-0.239571,0.167413,0.560089,-0.302966,0.463725,0.381878,0.55784,-0.877584,0.149695,0.204562,-0.0992561,-0.303888,0.022395,-0.953073,0.165824,-0.266515,0.0219805,0.548248,0.21379,-0.472524,0.267934,-0.153597,-0.127378,0.429489,0.0867187,-0.0270035,0.570329,0.460279,0.169997,-0.0199626,-0.205787,-0.0231098,-0.0875877,0.871921,-0.478922,-0.316127,0.344039,-0.673377,-0.128514,-0.560372,0.218042,0.187023,0.170351,0.432461,0.412735,-1.85897 +3409.17,0.948807,0.0848144,4,1.6045,0.805328,-1.49095,0.616738,0.832681,-0.141509,-0.524926,0.289601,0.150344,0.00949835,0.5025,-0.211677,-1.23868,0.403103,-0.373041,0.798483,0.288314,-0.0644125,0.24645,-0.158581,-0.0967546,-0.862001,-0.771355,0.0912311,-0.268019,0.0321217,-0.268632,0.287207,-0.419875,0.147892,0.38232,-0.733615,0.0897528,0.221879,-0.391601,-0.259869,-0.226766,0.12584,0.66615,0.160441,0.84864,0.0623396,0.233152,-0.400573,-0.186386,-0.290484,-0.978305,-0.235745,0.172003,-0.0677434,-0.297643,0.346197,-0.241256,-0.497402,0.414433,-0.23922,-0.42438,-1.05683,0.491456,-0.0199977,0.218866,0.651308,-0.742427,-1.31153,-0.0399855,0.148482,0.103411,-0.735743,-0.0283733,-1.34048,-0.277289,0.680093,0.415873,-0.311253,0.590339,0.3491,-0.01004,-0.0816697,-0.242391,-0.0400747,0.348746,-0.191423,0.250419,-0.607529,-0.0290566,-0.171392,-0.256971,0.156611,-0.0637097,0.374103,-0.588246,-0.669435,0.388392,-0.100421,-0.150175,-0.00677707,-0.139708,-0.316941,0.51718,0.305593,-0.127024,0.0979088,-0.303632,-0.238011,0.245635,-0.247513,-0.0388852,0.180285,0.515404,0.622207,0.025236,0.609035,0.401719,0.130136,-0.200973,0.420131,-0.0285937,0.0774817,0.134737,-0.0312281,-0.765495,-0.706298,-0.530367,-0.238744,0.417824,-0.178239,0.182996,0.584244,0.189259,-0.263024,0.193788,-0.26959,-0.0143534,0.526085,-0.0826696,-0.135213,0.0904312,0.477851,0.149777,-0.988689,0.0185072,0.179891,0.0283892,-0.629871,-0.391781,0.289348,-0.26506,0.729018,0.188043,-0.228289,-0.460428,0.133417,0.0172512,0.202768,0.444816,0.820132,-0.0725251,-0.180313,-0.06005,0.460072,0.049567,-0.165625,1.08937,-0.393134,-0.268787,0.218438,-0.294174,0.00998798,0.0532593,-0.655047,-0.37369,0.277612,-0.189556,-0.124143,-0.12226,0.0691577,-0.452897,-0.726771,0.591668,0.7272,0.712504,-0.196834,0.213646,0.172753,-0.426093,-0.589449,-0.150287,-0.299236,0.260382,-0.0818983,-0.0918292,0.0712109,0.136182,-0.666003,-0.356195,0.282188,0.08569,-0.152668,-0.715762,0.347689,-0.431692,0.253896,0.565682,-0.0919228,0.100498,0.144797,-0.334863,1.36173,0.106171,-0.211892,0.151304,-0.156646,0.169777,0.184549,-0.964603,0.339933,-0.237355,-0.107135,0.41659,-0.652764,-0.26668,-1.48179,0.0904022,1.09276,0.0335056,0.721732,-0.844246,-0.536355,-0.034061,0.273939,-0.588523,-0.105321,0.0520615,0.198778,-0.421157,0.234755,0.100008,0.21691,0.651994,-0.441422,-0.00374415,0.305473,-0.484998,-0.159272,0.556867,-0.718274,0.249807,-0.305061,0.0723394,-0.45493,0.00315959,-0.977803,0.169738,0.375589,-0.05625,0.27967,-0.257695,0.164686,-0.0636271,0.145634,0.100365,0.208158,0.312874,0.499871,0.114366,0.175517,0.318648,0.441664,-0.470497,0.250156,-0.33005,0.17282,-0.72618,0.656189,-0.485435,0.187526,0.17537,0.164244,0.973367,-0.326039,-0.0784229,-0.0147397,0.0846107,0.00621645,0.128836,0.445738,0.0688688,0.194497,0.313929,-0.592718,0.104184,0.218486,0.26456,0.314009,-0.115563,-0.488212,0.158003,0.697896,-0.418432,-0.474675,-0.160886,0.18252,0.233751,0.427224,0.483478,-2.34974 +3387.59,0.955684,0.0848144,4,1.64778,0.737664,-1.5522,0.637537,1.54156,-0.18874,-0.577419,0.117806,0.000498663,-0.552104,0.346532,-0.0817276,-0.458115,0.0860419,-0.612921,0.468622,-0.132502,-0.193189,0.134295,-0.206312,-0.0735003,-0.590143,-0.642269,0.130619,-0.272884,0.0300518,0.0154152,0.289187,-0.528752,0.110381,0.460802,-0.89644,0.607929,0.0938627,0.0021967,-0.520544,-0.301944,0.577691,0.659844,-0.611767,0.869022,0.146579,0.475724,-0.641019,-0.316013,-0.504425,-0.512143,0.0126334,-0.110399,0.126459,-0.136222,0.823383,-0.221222,-0.265911,0.662577,-0.796534,-0.175639,-0.731774,0.508112,-1.23752,0.524992,0.931123,-0.668349,-1.02098,0.0742054,0.483941,-1.17161,0.257319,0.764589,-0.328529,0.102368,1.0574,0.336603,-0.623912,0.223068,0.394457,1.13091,-0.205131,-0.753131,0.225104,0.465321,-0.198321,0.191966,-0.366332,-0.144816,0.367842,0.605769,-0.0622419,-0.00277389,-0.232764,-0.000153449,-0.36069,-0.11125,0.0422743,0.346009,0.186867,0.0940262,0.193486,0.209039,0.372384,-0.406457,0.621,-0.2012,-0.0264901,-0.152625,-0.471827,0.268843,-0.579351,0.00861224,0.453239,-0.081648,-0.0274259,0.414283,0.389766,0.856118,-0.181379,-0.200766,0.131723,0.547268,-0.15091,-0.617482,-0.408367,-0.213996,-0.343721,-0.304489,0.136361,0.715574,0.069728,-0.255056,-0.91633,-0.0300666,-0.331327,0.371143,0.506821,-0.295736,0.201996,-0.556471,-0.414692,0.451361,-0.786522,-0.100319,-0.311346,-0.142108,-1.1604,0.322019,-0.412193,-0.224986,0.13384,0.378653,-0.534978,-0.413237,0.746893,0.695959,-0.23367,0.665747,0.467103,-0.356819,-0.275504,-0.250668,0.526998,0.172028,-0.107327,0.617409,-0.394858,-0.865721,-0.409503,-0.324127,0.337975,-0.368653,0.358039,0.034421,-0.124598,-0.220535,0.0955236,0.322341,0.0258578,-0.786603,-0.22131,-0.327862,0.784514,0.645238,0.511207,-0.181021,0.00454595,-0.508328,-0.296993,-0.721834,-0.250751,-0.0797413,-0.378773,-0.141179,0.174675,0.271264,-0.881669,0.425556,-0.178357,-0.314546,-0.278176,-0.797034,0.145733,0.234516,-0.192777,0.413524,-0.354211,0.0972782,0.152376,-0.564513,1.32161,0.107246,-0.0429998,0.350783,-0.204173,0.0361709,0.362084,-0.479872,0.799086,0.0285982,-0.0108732,0.887236,-0.6073,0.13431,-0.575491,0.492245,0.269962,-0.25832,0.475241,-0.370519,0.0337186,-0.0583596,0.185418,-0.771697,0.0158267,-0.312261,-0.155349,-0.207534,0.602618,0.539957,-0.676008,0.804887,-0.158941,-0.22473,0.569034,-0.1108,-0.316894,0.602804,0.0289688,0.311083,0.087608,0.500834,-0.210485,0.443172,-1.32538,0.267796,-0.339159,-0.00847274,0.124865,-0.0167474,0.268196,-0.406106,0.323949,-0.424948,-0.148686,0.543694,0.253279,-0.0338066,-0.424137,-0.0691811,0.0347429,-0.371097,0.570043,0.0137453,-0.00294038,-0.895069,0.421362,0.39528,-0.326384,0.12338,0.620698,-0.146048,0.400519,0.322713,0.864507,-0.496558,-0.0637311,0.195458,0.525799,-0.0638448,-0.202134,0.683467,0.348246,-0.171411,-0.0760716,0.325857,0.0967806,-0.280953,-0.474414,0.413075,-0.238261,0.588192,-0.485144,0.290329,0.191189,0.284904,0.437252,0.533764,-4.51591 +3385.61,0.884872,0.0848144,4,1.6191,0.712079,-1.305,0.564669,0.876727,-0.136589,0.27904,0.00986733,-0.0831315,-0.344089,0.303185,-0.851849,-0.560265,0.321432,-0.172193,0.657426,-0.0899358,0.0242738,0.24773,0.271468,-0.383756,-0.768926,-1.0916,-0.0545204,-0.127779,-0.214782,-0.807171,0.32204,-0.479512,0.196475,0.799803,-0.991379,0.236081,0.544346,-0.244605,-0.146514,-0.106079,0.335034,0.445323,0.390801,1.07745,0.233586,0.0722866,-0.717333,0.408571,-0.54004,-0.395361,0.071605,0.49583,0.22786,-0.431485,0.4594,0.222146,-0.272851,0.609257,-0.16175,-0.193284,-1.28736,0.563789,-0.735042,0.524546,0.826989,-0.230428,-0.406323,-0.423945,-0.106977,-0.0657961,-0.795912,-0.206087,-0.611611,-0.0643814,-0.346833,0.522024,0.0131763,0.790233,0.406282,-0.106967,-0.470525,-0.484935,0.150785,0.506919,-0.287925,0.539242,-0.297934,-0.0195197,-0.288207,-0.586452,-0.437255,0.232879,-0.00547429,0.0140353,0.0310191,0.205733,-0.144685,-0.0241147,-0.169779,-0.15432,0.0597025,-0.638846,-0.267749,0.609817,-0.0273642,-0.427872,-0.477073,0.6394,-0.0694082,-0.0220323,-0.268802,0.490581,0.856968,0.295009,-0.0425514,-0.109927,0.0778497,-0.501736,-0.186598,-0.50655,-0.241495,0.717407,-0.458055,-0.845896,-0.480556,0.120619,0.467092,-0.102858,0.00516563,0.391951,0.586609,0.515532,0.159055,0.337048,0.0100069,-0.859482,0.496344,-0.0627833,-0.504218,0.0503885,-0.429604,0.482106,-0.680544,-0.0760655,0.612774,0.0475198,-0.912144,0.132657,0.621921,0.462169,0.470706,-0.125049,0.0368199,-0.57649,-0.375498,-0.616143,-0.0753465,-0.0293205,0.651701,0.0548178,0.179718,-0.488169,-0.159996,0.547168,-0.0447312,0.371811,0.158232,0.543437,0.256606,-0.192807,-0.592371,-0.249188,-0.675139,0.346819,0.000229103,-0.0457259,-0.0520033,-0.383631,0.316918,-0.202935,0.530104,-0.66247,0.885215,-0.120687,-0.869227,0.42629,-0.262496,0.310285,-0.174496,-0.143369,-0.493484,0.808522,-0.122863,-0.104171,-0.203711,-0.127415,-0.342879,0.156318,0.114042,-0.277214,0.113611,-1.0451,0.293306,0.0352962,-0.778992,-0.0249112,0.362173,-0.313046,-0.445176,-0.505858,1.00258,-0.114246,0.0764593,-0.137746,0.279614,0.018267,0.149246,0.0133066,0.410884,-0.811535,-0.0460789,0.11981,-1.37087,-0.251241,-0.19429,-0.389864,0.151887,-0.798034,-0.206846,-0.0927822,-0.190113,-0.0460534,-0.108297,0.775087,-0.0415148,0.156449,-0.3178,-0.397087,0.0412937,-0.0668854,0.107371,0.31247,-0.138407,-0.285695,-0.0101887,0.011601,-0.229916,0.112305,0.683299,0.572413,0.68213,-0.488363,-0.517078,-0.282698,-0.207405,0.379509,-0.559628,-0.33938,-0.154404,-0.265022,0.0307097,0.201709,0.217431,0.166121,1.08734,-0.0655227,0.0923524,0.149627,0.395902,0.152791,0.474486,-0.350559,-0.16755,0.139632,-0.215553,0.0322299,-0.167249,0.0863991,0.508271,-0.107995,-0.308971,0.808608,-0.768413,-0.219792,-0.671985,-0.283405,0.175617,-0.598959,-0.117482,0.281013,0.744815,-0.424177,-0.394047,0.0813987,0.224115,0.14742,0.0827131,0.00854536,-0.18728,-0.874098,0.553847,-0.421768,-0.26971,-0.0667974,0.153494,0.25505,0.391783,0.505025,-2.36606 +3398.46,0.96235,0.0848144,4,1.65308,0.784541,-1.88169,0.785593,0.795667,-0.150973,0.200227,-0.186065,0.299449,-0.304567,-0.0563687,-0.915363,0.00108182,0.341338,0.0925211,0.334438,0.0904937,0.143189,0.101833,0.0821486,-0.197857,-0.598772,-1.0404,0.0570263,-0.135888,-0.448577,-0.690103,0.316064,-0.204926,0.240153,0.66719,-0.672718,0.575627,0.587168,-0.589044,-0.502479,-0.334824,0.186387,0.394918,-0.789022,1.30944,0.342112,0.178574,-0.164286,-0.00287977,-0.320443,-0.982013,0.202721,0.366393,0.253939,-0.0288494,0.442384,0.284316,-0.372462,0.100387,0.167624,-0.215257,-0.795296,0.330203,-0.645591,0.213308,0.495922,0.10719,-0.382897,0.0159529,0.206897,-0.2071,-0.215481,0.150287,-0.639761,0.136923,-0.0628754,0.35806,-0.309043,0.514199,0.507292,0.213507,-0.346517,-0.778086,0.171404,0.233292,-0.443586,0.298034,-0.194122,0.0458126,-0.194978,-0.273723,-0.928057,-0.122702,-0.278899,-0.425095,-0.152,-0.364516,-0.305872,0.267009,-0.303024,0.155727,0.192986,0.0607247,-0.0963865,0.308834,-0.0230624,-0.593459,-0.125692,0.535904,-0.452305,0.357421,-0.555174,-0.153216,0.738937,0.425221,0.182432,0.141118,0.509541,-0.0724984,0.0143871,-0.47055,-0.161181,0.404923,-0.365864,-0.647782,-0.645602,0.0196414,0.42566,-0.492775,-0.591797,0.23622,-0.0950322,0.294105,0.0533332,-0.107088,-0.0817998,-0.667378,0.516694,0.0866587,-0.286248,-0.288509,-0.170334,0.577498,-0.667968,-0.563648,0.321572,-0.092522,-0.46481,0.561752,0.0654343,0.252141,0.162765,-0.0311219,0.159797,-0.910956,-0.245961,0.137362,0.232718,-0.118562,0.974386,-0.0413654,0.268155,-0.064793,-0.197407,0.291815,0.0182405,0.34316,-0.399905,0.599964,0.0245892,-0.385989,-0.34175,0.0441038,-0.553528,-0.211441,0.446482,-0.0960279,-0.144124,-0.326926,0.279619,-0.224429,0.0860301,0.177815,1.13324,0.329001,-0.491079,1.20503,-0.112743,0.300448,-0.39492,0.106271,-0.197829,0.900085,-0.314943,-0.180169,-0.354137,0.0947978,-0.384866,-0.0553463,-0.192119,-0.375017,0.263926,-1.15454,-0.223955,-0.256764,-0.474834,0.055734,0.407772,-0.267134,0.108782,-0.632921,0.836959,-0.472858,-0.651379,0.197254,0.0789825,0.428019,0.414492,-0.0354248,-0.13541,-0.741331,-0.289315,0.160069,-0.950273,-0.481968,-1.21549,-0.339752,0.180591,-0.678368,0.275968,-0.399347,-0.128695,-0.303485,-0.327557,-0.175527,0.0146089,-0.080116,-0.251265,-0.0684757,0.368499,-0.572246,0.216924,0.894948,-0.305323,0.0446208,0.373084,-0.404427,-0.0180474,-0.178027,0.751712,0.428797,1.05635,0.02973,-0.702501,-0.342416,0.0519957,0.130329,-0.470504,-0.0079642,0.0183996,-0.340008,-0.205467,0.211169,0.7002,0.421903,0.122012,0.295486,0.239176,0.525613,-0.290209,-0.0999014,0.737838,-0.92014,-0.305178,-0.115277,0.184965,-0.217836,-0.211417,0.145463,0.0100869,-0.30856,-0.415811,0.641364,0.0240278,-0.52792,-0.379989,-0.334507,0.0018506,-0.302974,0.269955,-0.28904,0.640744,-0.288708,-0.270611,-0.253645,0.336354,0.132577,0.539843,0.0989476,-0.677562,0.294188,0.339231,0.0721735,-0.376522,0.012286,0.190319,0.218522,0.436256,0.467463,-2.09401 +3392.56,0.863203,0.0848144,5,1.60608,0.774394,-1.79228,0.816654,0.52429,-0.0859679,-0.636385,-0.321918,0.0475058,-0.546395,0.448234,-0.704884,-0.377227,0.789086,0.0130884,0.552868,-0.227183,0.280079,0.178542,0.1919,-0.327119,-0.756996,-0.843041,0.408135,-0.623096,-0.295907,-0.491368,0.382142,-0.211225,-0.0370371,0.964807,-0.703384,0.105764,0.130605,-0.405114,-0.418093,-0.153262,0.545234,0.604658,-0.675421,1.072,0.937046,0.386757,-1.07983,0.12532,0.446666,-0.478836,0.581297,0.451766,0.0481435,-0.153649,-0.272339,0.116959,-0.193577,0.210494,-0.298035,-0.313546,-0.601902,0.0177369,-0.23625,0.759305,0.692382,-0.697753,-0.59576,-0.00355077,0.724729,0.18065,-0.242516,0.3268,-0.52723,0.127597,0.782981,0.355861,0.041537,0.537759,0.783591,-0.126378,-0.523406,-0.642085,0.237006,0.676937,0.172796,0.321244,-0.431665,0.42901,0.550622,-0.526712,-0.0882586,-0.0757116,-0.625937,0.252916,-0.317194,0.357253,0.00171465,0.112463,-0.362924,0.874747,0.063114,0.0595391,-0.291161,0.20233,0.154085,-0.941439,-0.299629,0.39343,-0.838655,0.230234,-0.0691656,0.279729,0.253111,0.382838,-0.486047,0.533208,0.0118571,0.0758561,-0.0219575,-0.5558,-0.0393388,0.198174,-0.0237562,-0.166612,0.205413,-0.458178,0.518888,-0.0138031,0.184567,0.53676,1.32283,0.144175,-0.70641,0.336084,-0.682511,0.0789319,0.328003,-0.0425963,-0.228928,-0.417624,-0.053271,0.648487,-1.23819,-0.189687,-0.0944226,0.366215,-0.333533,0.447324,-0.0659757,-0.0995675,0.425438,-0.608113,0.0880779,-0.506106,0.0021786,0.13099,-0.173972,0.514504,0.62489,0.000679778,0.711643,-0.0543729,0.113641,0.528708,-0.383564,0.299472,-0.325722,0.321115,-0.585973,-0.459649,-0.282766,-0.261202,0.499171,0.448486,0.0200227,-0.274932,-0.373252,0.51056,-0.24577,-0.319418,0.172586,-0.585412,0.674118,0.122834,-0.611748,0.188013,-0.126722,0.162838,-0.293273,-0.0961062,-0.497653,0.524974,-0.58139,-0.0624584,-1.03878,0.515113,-0.00781918,-0.329051,-0.550599,-0.35052,-0.122457,-0.382144,-0.560273,0.194509,-0.251566,0.551809,0.72371,-0.57966,-0.223874,-1.03982,0.799113,0.0672774,0.065166,-0.459903,-0.47918,0.230352,-0.214152,0.183326,0.603162,-0.8304,-0.0108273,0.232102,-0.465064,-0.189987,-0.436213,0.176867,1.12534,-0.752182,0.0129734,-0.283484,-0.180438,0.145244,-0.278906,-0.00390758,-0.214684,0.0801254,-0.418159,-0.803908,0.697106,0.222341,-0.545878,1.05834,-0.288012,-0.407331,0.699723,-0.407059,-0.0142029,-0.442424,0.432637,0.120054,0.732774,0.143084,-0.572427,-0.0385621,-0.533642,0.149281,-0.647687,-0.235315,0.25159,-0.190728,0.176038,0.425359,-0.0619089,0.222933,0.322426,-0.119476,0.00304294,-0.0688411,0.427954,0.107982,-0.177752,-0.229556,0.0531217,-0.508199,0.0108731,-0.258424,0.312405,-0.0461416,0.419443,-0.533858,0.067006,0.320636,-0.26875,-0.235692,-0.279984,-0.181908,-0.0508165,-0.0716803,-0.0208409,-0.34758,-0.245948,0.0657614,-0.320124,0.0640775,-0.0652039,0.0165024,0.316917,-0.184971,-0.261338,-0.305559,0.403948,-0.234864,0.280296,0.0483283,0.178942,0.21664,0.423015,0.465446,-1.31485 +3384.97,0.974061,0.0848144,4,1.62941,0.944618,-1.7197,0.663044,0.612457,-0.238399,-0.572304,-0.0579317,-0.131647,-0.661684,-0.022052,-0.284136,-0.329215,0.322634,0.198638,0.825553,0.0805917,0.137531,0.0935988,0.0728133,-0.179827,-0.61046,-1.31656,0.046768,-0.358367,-0.266775,-0.53012,0.226691,-0.182944,0.264424,0.961173,-0.756137,0.266866,0.0426403,-0.522309,-0.54011,-0.1717,0.519289,0.318419,-0.348859,0.93719,0.355283,0.536007,-0.361259,0.412285,0.118473,-0.677557,-0.0601864,0.188267,-0.046984,0.206795,0.584142,-0.364548,-0.137944,-0.0605101,0.00903915,-0.344247,-0.491185,0.122686,-0.85515,0.556022,0.877037,-0.414282,-1.75384,0.349864,0.66942,-0.0254617,-0.0530438,1.22077,-0.492013,-0.317524,0.190407,0.33414,-0.278123,0.443524,0.395158,0.193646,-0.376659,-0.654636,-0.0379077,0.0676454,0.302667,-0.0744381,-0.265888,0.117217,0.21664,0.568178,-0.121645,-0.311209,-0.603747,0.279699,-0.0979169,0.102532,-0.0411944,0.30893,-0.0957694,0.672241,-0.390717,0.162681,0.395753,-0.178254,-0.198765,-0.365361,-0.567602,0.457326,0.226308,0.566378,-0.713704,0.479805,0.675774,0.207741,-0.360301,0.267236,0.414488,-0.137128,-0.484315,-0.434207,0.519099,0.354607,0.208188,-0.724102,0.0765292,-0.4704,-0.0890336,-0.197169,-0.0270403,0.124207,0.591761,-0.177223,-1.50474,0.366921,-0.276336,-0.640353,0.220247,-0.116572,-0.501488,0.223848,-0.536207,0.0616162,-1.22412,-0.0302602,0.199901,-0.0446102,-1.00108,0.139832,0.517077,-0.0684229,0.109582,-0.60014,0.0954931,-0.232073,0.378792,-0.199913,0.244176,0.514874,0.245404,-0.254075,0.41274,0.0502322,0.426631,0.199273,-0.186921,-0.0426445,0.124074,-0.402056,0.223477,-0.433679,-0.150132,-0.262253,0.184048,0.166556,0.463017,-0.118422,-0.321653,-0.99922,-0.12375,-0.881778,0.110946,0.342353,1.03519,-0.282986,-0.100993,-0.593455,0.023672,0.362948,-0.254563,0.20669,-0.528322,0.68726,-0.144176,-0.313786,-0.746781,-0.0864871,-0.645686,-0.200555,0.173497,-0.294277,-0.131991,-0.379185,0.149416,-0.33931,0.13549,0.19976,-0.248701,0.108747,-0.033327,-0.74554,0.406179,-0.729717,-0.400577,0.100967,0.225273,0.426182,-0.472294,-0.319688,0.336964,-0.246661,0.00709761,0.506525,-0.362717,-0.161749,-0.925687,-0.496166,0.2111,-0.564311,0.586944,-0.123748,-0.721288,0.114745,0.200013,0.000552233,-0.0288324,0.223444,-0.0303789,-0.576892,0.496539,1.03728,0.110701,0.374797,-0.423132,0.0960321,0.15324,-0.518089,0.105738,0.0187943,0.0420242,0.599038,-0.00777022,-0.235861,-0.510202,-0.0203971,-0.679088,0.901168,0.127395,-0.350902,0.0628361,-0.381355,0.110909,0.209836,-0.123011,0.122072,0.424239,0.319563,0.182468,0.0194927,0.101671,-0.847056,-0.164487,-0.211137,0.547804,-0.00138336,-0.0283123,0.0108359,-0.245899,-0.0910214,0.445233,0.440858,0.128505,0.0582288,-0.0449911,-0.943903,0.643722,-0.35634,0.371904,-0.193833,0.0599022,-0.132722,0.191822,0.115516,-0.724573,-0.0774703,0.297882,0.461209,0.593127,0.0147125,-0.867717,0.126703,-0.208944,-0.385134,-0.101423,0.31507,0.178612,0.377763,0.422626,0.614624,-1.7395 +3381.26,0.945586,0.0848144,4,1.65226,0.633444,-1.9048,0.808944,0.37294,-0.0483003,0.0268482,0.0450637,0.392911,-0.313691,0.30125,-0.320127,-0.323917,0.281662,-0.265688,0.39769,0.115753,-0.00480477,-0.556664,0.321666,0.212229,-0.753572,-0.450175,0.163827,-4.2896e-05,-0.166955,-0.122422,0.198423,-0.642808,0.285143,0.925883,-0.125611,-0.114567,-0.104188,-0.649756,-0.506404,-0.158816,0.557899,1.11116,-0.248093,0.741856,1.00231,0.557276,-1.00244,0.310414,0.057299,-0.306839,0.35393,0.277396,-0.447642,-0.0828537,0.50869,0.205695,-0.0522636,0.212206,-0.369752,-0.54162,-0.841264,0.181784,-0.813285,-0.248288,0.866266,-0.627789,-0.915817,0.498418,0.18122,-1.01873,-0.412412,-0.0602482,-0.760161,0.116534,0.52385,0.849102,0.0114163,0.171199,0.346932,0.157838,-0.296474,-0.1187,-0.528221,0.87355,-0.513867,0.666187,-0.106961,-0.816408,-0.0216153,-0.573805,-0.0788438,-0.228613,-0.558577,-0.450563,-0.231689,-0.0746172,0.0730331,0.327245,-0.633503,-0.721743,-0.87739,0.280929,-0.194921,0.338915,-0.212107,-0.580323,-1.85281,-0.0966017,-0.351369,0.461942,0.120776,0.257136,0.0866175,0.309258,-0.297761,-0.149217,0.149702,-0.412189,0.495362,-0.770729,0.0959215,0.664682,-0.0390594,-1.05679,-0.176511,-0.289266,-0.798575,0.0424877,0.0624172,0.419825,0.201234,0.488095,-0.437042,0.0683957,0.00465273,-0.0921931,0.778054,0.0456257,-0.017065,0.177026,-0.250481,0.327171,-1.49548,-0.248457,0.100187,-0.136722,-0.678133,0.202155,-0.0766494,0.468978,-0.103396,-0.323614,-0.389329,-0.181914,0.557899,0.4622,0.422679,-0.324265,0.636288,-0.0192209,0.0523733,0.17113,-0.328793,0.265321,-0.0263543,0.434342,-0.187058,-0.299193,0.2367,0.124831,0.254647,-0.576456,0.330762,0.147643,-0.285518,-0.114654,-0.0213784,0.62795,0.101828,0.480684,0.336289,0.155525,0.565911,-0.221236,-0.396889,0.235825,-0.276032,-0.0748573,-0.37986,-1.08257,-0.286218,-0.259597,-0.0784017,0.540877,-0.291277,0.171969,-0.252885,-0.0475396,-0.10865,-0.218313,-0.446256,-0.985902,0.332923,0.106597,-0.410644,0.225246,-0.551468,-0.342365,-0.458154,-0.740081,0.745649,-0.669582,0.10285,0.49955,-0.460052,-0.0631899,0.425375,0.271763,-0.0704677,-0.0715293,0.552164,0.115547,-0.0788578,-0.30443,-0.820823,-0.172244,0.115651,-0.725177,0.302483,-0.0609263,-0.56569,0.748935,0.1604,0.287684,-0.0283923,0.142919,0.37251,-0.539326,0.15011,-0.18356,0.284347,0.637781,0.506913,-0.295298,-0.311596,0.594108,0.0323802,0.640381,0.287055,0.248409,0.258791,-0.141376,-0.143582,-0.110914,-0.436563,0.0417297,-0.645209,0.431183,-0.149736,-0.464304,-0.0540265,0.214059,0.64846,-0.175259,0.189069,-0.0828777,-0.396539,0.567552,0.0709706,0.0484528,-0.577304,0.169663,0.279517,0.138922,0.257097,-0.297339,0.369397,-0.42014,-0.201624,-0.226105,-0.0358634,0.770364,-0.45326,-0.112814,-0.0223792,-0.345245,0.0804002,0.285469,0.827637,0.0529036,0.692854,0.230233,0.0927298,-0.0685318,0.250944,0.207096,0.126962,0.00576538,0.377304,0.0363493,0.5752,-0.0714064,0.137422,0.0116634,0.193472,0.187984,0.439855,0.433572,-0.460003 +3420.53,0.926148,0.0848144,4,1.64488,0.717615,-1.61342,0.629523,0.369401,-0.112611,-0.178696,-0.192994,-0.308941,0.294258,0.173482,-0.116463,-0.617462,0.232849,-0.435388,0.117413,0.214894,-0.21231,-0.10579,0.180803,0.149094,-0.850531,-0.584447,0.115344,0.248108,-0.446823,-0.151535,0.10261,-0.556368,0.173023,0.988123,-0.197775,-0.147555,-0.0355894,-0.42144,-0.329662,-0.498122,0.592216,0.595517,-0.262369,0.932693,0.391991,0.5117,-0.471142,-0.0316099,-0.372574,-0.484741,0.00354753,0.0432238,-0.0729802,0.435072,0.298589,0.144744,-0.0777738,0.442642,-0.191639,-0.377764,-1.05732,0.239604,-0.308008,-0.151019,0.987963,-1.06905,-0.749659,0.654119,0.196547,-0.350063,0.296606,0.182816,-0.856575,-0.154943,0.758264,0.610401,-0.0495501,0.336944,0.643038,0.305212,-0.174451,-0.0540518,-0.432137,0.391262,-0.519378,0.457524,0.130998,-0.498397,-0.39988,-0.460312,-0.0338144,0.317323,-0.294867,-0.36297,0.0978982,0.274796,0.22384,0.631736,-0.443481,-0.53795,-0.452665,0.154072,-0.11281,0.58249,-0.109993,-0.376605,-1.12319,-0.00954255,-0.127744,0.377627,-0.0338799,0.463193,0.568962,-0.210289,-0.587859,-0.138349,0.374904,-0.235835,0.121269,-0.427165,0.0225914,0.0891598,0.232134,-1.06885,-0.134058,-0.0323527,-0.846892,0.0833691,0.699458,0.32547,-0.0573358,-0.175282,-0.0273571,-0.0176317,0.0574906,0.0292673,0.992707,-0.274394,0.0887795,0.0779081,-0.323964,0.370972,-0.802147,-0.205447,0.0170181,0.0946169,-0.769894,0.085316,0.109194,0.541928,-0.181249,-0.138347,-0.14675,-0.311604,0.339159,0.37554,0.444248,-0.255863,0.971329,-0.268117,0.391165,0.131391,0.0313191,0.158667,0.0621958,0.337223,-0.435293,-0.162784,0.6228,-0.0779232,0.0278882,-0.411097,0.713562,0.183254,-0.119839,-0.259504,-0.072437,0.222208,-0.182506,0.135041,0.00184441,0.485133,0.54073,-0.267517,-0.196324,-0.491572,-0.450631,-0.224988,-0.585974,-1.05211,-0.427311,-0.172836,-0.42517,0.17186,0.0773966,0.378483,-0.421001,0.213923,0.151563,-0.302864,-0.275982,-0.989044,-0.044273,0.166208,-0.545095,0.251655,0.0661178,0.0142454,-0.796765,-0.406306,0.84977,-0.588271,-0.0454985,-0.00706458,-0.0916592,0.145211,0.105861,0.551914,-0.207055,-0.382198,0.386759,0.00231044,-0.528174,-0.527379,-0.551448,-0.117145,-0.215793,-0.458671,0.227459,-0.478452,-0.441382,0.528347,-0.0714819,0.409353,-0.164625,0.00570817,-0.0681282,-0.737694,0.252348,-0.144035,0.400937,0.234735,0.109952,-0.147878,-0.587816,-0.297586,-0.171329,0.287128,0.616198,0.0852352,0.242947,0.0157189,-0.259045,-0.391149,-0.258003,0.392709,-0.394699,0.130918,-0.510887,-0.465494,0.163574,-0.0801786,0.363279,-0.453311,0.253525,-0.527383,-0.146508,0.377002,-0.234112,-0.106642,-0.0118679,0.0459847,0.305422,-0.281853,0.22646,-0.165679,0.26379,-0.0515338,0.465942,0.155953,-0.226187,0.506627,-0.217857,-0.198224,-0.339593,-0.301394,0.238175,0.174837,0.721491,0.0152739,0.837844,-0.137705,0.30052,-0.0791443,0.0483989,-0.05062,0.102825,-0.266257,-0.700932,0.0829135,-0.104895,-0.268677,-0.31407,-0.506776,0.146184,0.306639,0.382341,0.55375,-0.571301 +3412.7,0.858029,0.0848144,4,1.71888,0.714918,-1.65537,0.588638,0.239659,-0.102269,-0.24716,-0.164245,-0.373666,-0.274486,0.21704,-0.231591,-0.631265,0.327665,-0.344347,0.206275,0.0783676,-0.0959505,-0.208952,0.000646935,-0.0342004,-1.13792,-0.573274,0.251858,-0.263486,-0.309706,-0.376321,0.251895,-0.48783,0.0664325,0.705976,-0.436955,-0.157083,-0.327457,-0.842483,-0.490598,-1.0753,-0.0124013,1.01406,-0.141456,1.11022,0.536259,0.473259,-0.668532,-0.010011,0.285493,-0.688499,-0.0212982,0.41705,-0.233147,0.292448,0.0384647,0.095796,-0.320068,0.473784,0.0658073,-0.752042,-0.999242,0.272759,-0.370635,0.135039,0.917935,-0.315697,-1.03057,0.369974,0.453678,-1.09035,0.316082,0.435981,-0.518608,-0.391623,0.571527,0.661954,0.105982,0.868187,0.305701,0.456816,-0.392438,-0.354215,-0.468008,0.762505,0.0887352,0.317899,-0.54474,-0.122598,-0.276354,-0.330781,-0.0450402,-0.158499,-0.60846,-0.267249,0.197766,0.437144,0.139236,0.240376,-0.604236,0.089576,-0.609895,0.318061,-0.199621,0.186017,-0.0603551,-0.511366,-0.658494,0.278965,0.0172014,0.138657,0.244926,0.222591,-0.0269548,0.160255,-0.65715,0.18118,0.0468502,-0.125809,0.221818,0.103923,0.218058,0.32572,-0.0172179,-1.16408,0.25959,-0.0350748,-0.725933,-0.172834,0.3495,-0.00191444,0.235794,0.114465,-0.22352,0.221843,-0.261006,0.310139,0.486166,0.0597988,-0.21212,-0.364807,-0.524416,0.2928,-0.688642,-0.138755,0.0456558,0.0349167,-0.79643,0.191082,0.182467,-0.072936,-0.334845,-0.207579,-0.849779,0.114396,0.430031,0.655063,0.202315,0.474618,0.654516,-0.160437,0.454451,-0.397858,0.13386,-0.305731,-0.502635,0.0994519,0.193162,0.158124,0.699419,-0.0622401,0.033644,-0.488997,0.144781,0.0451183,-0.57881,0.141011,0.22295,0.140333,-0.463823,0.00596502,-0.161793,0.178412,0.724196,0.329718,-0.253464,-0.399181,-0.298387,0.0726735,-0.113541,-0.27817,-0.586821,-0.261807,-0.312645,0.290547,-0.543775,0.574041,-0.730453,0.198684,0.282467,-0.0722004,-0.329013,-0.895097,-0.0851904,-0.199776,-0.617725,0.542451,0.30388,-0.347269,-0.557435,-0.438046,0.59519,-0.538704,-0.0564012,0.475142,0.208899,0.0388914,0.635933,0.465306,-0.29679,-0.397444,0.351766,-0.170861,-0.645684,-0.565943,-0.596336,0.311442,-0.174279,-0.586047,0.480232,-0.778702,-0.396228,0.000107429,0.16701,-0.191915,-0.0683704,0.0809974,0.0182132,-0.233129,0.37246,-0.110625,0.215095,0.765031,-0.57469,0.213377,-0.13734,0.235543,-0.71394,0.523728,0.15893,0.305377,-0.0816015,0.195951,-0.185712,-0.039658,-0.968757,0.0979212,-0.316075,-0.0242597,-0.0100334,-0.897011,0.6011,-0.195828,0.109555,-0.372782,0.306765,-0.0908055,0.0715626,0.770102,-0.516622,0.114527,0.132655,-0.127529,0.283638,0.191972,0.0799162,0.163566,0.0717615,0.238733,-0.136974,-0.0292952,-0.225498,0.470718,0.0576644,-0.279844,-0.250491,-0.727827,0.496317,-0.207793,0.0756915,-0.0915192,0.286378,-0.285652,-0.206805,-0.0703551,-0.00325749,0.61652,0.146324,-0.467298,-0.525093,-0.110255,0.160664,0.0773313,-0.267364,0.195634,0.158875,0.267105,0.398591,0.516822,-0.00359799 +3401.44,0.916286,0.0848144,4,1.70444,0.677628,-1.71402,0.657144,0.406725,-0.174428,-0.171971,-0.296893,0.0332675,-0.525929,0.226142,-0.0295584,-0.485024,0.084805,-0.420689,0.129055,0.121138,-0.64731,-0.0395341,0.313762,0.0271574,-1.16348,-0.745042,0.315672,-0.266569,-0.747799,-0.657408,0.0122096,-0.581606,0.390588,0.984878,0.0137202,-0.498426,-0.114261,-0.556118,-0.345845,-0.715385,0.0372821,0.413359,-0.307863,1.23458,0.697764,0.134865,-0.492538,-0.0409923,0.0204149,-0.601001,-0.0840391,0.0935998,0.0977019,0.284018,0.183967,0.221101,-0.317213,0.592817,-0.295789,-0.6116,-0.800747,0.0131094,-0.182665,-0.15712,0.640667,-0.703013,-1.11599,0.120812,0.482157,-0.557527,0.469233,0.40544,-0.57264,-0.44999,0.618765,0.736857,-0.105925,1.21605,0.50187,0.437383,-0.305578,-0.534812,-0.44601,0.917464,-0.419166,0.118788,-0.458711,-0.264186,-0.326468,-0.24009,0.38166,-0.803353,-0.557891,-0.388789,0.049912,0.43411,-0.0539934,0.0477354,-0.161993,0.520183,-0.526578,-0.261393,-0.140324,0.0793061,0.0819202,-0.852051,-0.604726,-0.246822,0.397118,0.439977,0.088239,0.365046,0.182519,0.397593,-0.233688,0.700206,0.360026,0.449664,0.28921,0.482628,0.165902,0.0530044,0.0263712,-0.266512,0.089083,0.00690456,-0.618885,0.00652802,0.207746,-0.147037,0.326901,-0.175387,-0.167967,0.271211,-0.076707,0.718571,-0.0616028,-0.252552,0.0427105,-0.160153,-0.210281,0.256349,0.0489316,-0.584368,-0.102033,-0.114787,-0.942271,-0.19336,-0.266173,-0.566114,-0.252418,-0.353736,-0.933795,-0.233206,0.0554104,-0.0132805,0.234499,0.462398,1.07623,-0.246255,0.0969942,-0.232306,-0.135973,0.0190115,-0.335355,0.232173,0.516805,0.0617837,0.262305,0.105443,0.0116421,-0.675329,0.33503,0.408836,-0.0957474,-0.448729,0.0943842,0.270418,-0.0893269,-0.238065,-0.19667,0.147098,0.764091,-0.217988,-0.651846,-0.261648,-0.579063,-0.230384,-0.539801,-0.377243,-1.13933,-0.280185,-0.840127,0.0996377,-0.179864,0.240105,-0.429545,0.559697,-0.474278,-0.222868,-0.720152,-0.648816,-0.208297,-0.32485,-0.745924,0.312756,0.264114,0.00925266,0.0559109,-1.01453,0.688805,-0.143343,-0.0540381,0.172358,0.239662,0.0889665,0.573476,0.549865,0.133335,0.207065,-0.178597,-0.176064,-1.00174,-0.307246,-0.106814,-0.159621,0.155386,-0.848462,-0.0570764,-0.965984,-0.23579,-0.0533566,0.0148234,-0.159489,-0.105958,-0.615714,0.120927,-0.24118,0.708732,-0.384262,0.334002,0.762937,0.107289,0.427621,-0.232737,0.233763,-0.693485,0.0732077,0.36209,0.125306,-0.443742,0.141706,0.0790778,-0.381826,-0.681883,0.495947,-0.643167,-0.335452,0.037456,-0.393826,0.956589,-0.0172843,-0.0693075,-0.0389599,0.315412,-0.160397,0.249784,-0.129162,-0.13127,-0.146517,0.0420374,0.439994,0.355914,0.395038,0.126353,-0.20145,0.373265,-0.125653,-0.10572,-0.245953,0.0938236,0.328362,0.141806,-0.360389,-0.229011,-0.400986,-0.18507,0.172811,0.225909,-0.0749032,0.236881,-0.0850461,-0.955064,-0.187383,-0.173922,0.359317,-0.0386314,0.01188,-0.324825,-0.645074,0.199574,-0.415813,-0.030817,0.376933,0.169563,0.199453,0.41178,0.446601,-0.522844 +3396.14,0.822328,0.0848144,4,1.71692,0.637804,-1.69624,0.639415,0.163933,-0.18858,0.102184,0.0659319,0.274183,-0.421025,0.22121,-0.192903,-0.492073,0.370893,-0.545309,0.144358,-0.158989,-0.364412,0.0791884,0.26738,0.109888,-1.08278,-0.925168,0.401911,-0.147691,-0.390995,-0.464838,-0.169183,-0.788454,0.0146872,0.630712,-0.478667,-0.590501,-0.0933526,-0.569722,-0.197325,-0.346526,0.312043,0.362401,-0.286818,1.27564,0.921179,0.17142,-0.376787,-0.153244,-0.359572,-0.224293,0.228107,0.441917,-0.298803,0.263087,0.553305,-0.222832,-0.511381,0.452593,0.0434393,-0.35031,-0.681729,0.120735,-0.547971,0.267375,0.799129,-0.425266,-0.730876,0.514152,0.00868811,-0.474232,0.470336,0.640285,-0.418748,-0.419074,0.249855,0.580087,-0.525855,1.3351,0.658817,0.922223,-0.129241,-0.68973,-0.336518,0.697133,-0.355499,0.0948139,-0.411952,-0.306474,-0.529274,-0.225674,-0.00700598,-0.656568,-0.362272,-0.861347,0.0172051,0.452551,-0.0747308,-0.199332,-0.467674,0.164245,-0.17379,0.241571,-0.18455,0.168139,0.282505,-1.11956,-0.757858,0.349662,0.336018,0.345119,-0.347419,0.29603,0.387491,0.247195,-0.0915035,0.59891,0.345365,0.294429,0.886212,0.188909,-0.0266276,-0.320481,0.106175,-0.264067,-0.17508,0.355207,-0.622791,0.332742,0.230897,-0.441208,0.344492,-0.202021,-0.371766,-0.086116,-0.0520105,0.638281,0.276562,-0.0266561,-0.087047,-0.322543,-0.470825,0.252699,0.153958,-0.749583,0.0619779,-0.0312798,-0.604642,-0.136562,-0.000204737,-0.55332,-0.0291014,-0.272122,-1.04401,0.201633,0.138762,0.201317,0.45388,0.322708,0.322507,-0.223297,0.305855,-0.444132,-0.110715,0.40138,-0.242466,-0.0429553,0.619142,0.0833812,0.309495,-0.0126467,0.0381734,-1.11622,0.229198,0.418034,-0.143473,-0.0579846,-0.164186,0.193687,0.237674,0.25186,-0.234517,0.362909,0.622803,0.184466,-0.88821,0.123409,-0.431415,-0.0805709,-0.301262,-0.425588,-0.670219,-0.356632,-0.68692,-0.0138571,-0.00442817,0.105964,-0.365727,0.174824,-0.818604,-0.349522,-0.150232,-0.954682,-0.655502,-0.149611,-0.955818,0.375735,-0.0203446,0.000782678,0.393476,-0.546854,0.95455,-0.0336769,-0.0723279,0.0245207,0.20303,0.201717,0.465062,0.56863,-0.144024,0.0364767,-0.247916,-0.137902,-1.04481,-0.0397795,0.0270718,0.234296,0.185549,-0.636226,0.0414938,-0.923169,-0.298842,0.371927,0.14574,-0.170621,0.00393575,-0.755745,0.0818632,-0.587595,0.770123,0.183993,0.0218305,0.756408,0.0432096,-0.0844698,-0.116299,0.321636,-0.62616,0.643502,0.798141,0.186872,-0.226701,-0.0316806,-0.0434414,-0.276655,-0.247227,0.680482,-0.326294,-0.197869,0.0709952,-0.139946,0.586212,-0.230744,0.337934,0.0891714,0.429702,0.061584,0.526897,0.232954,-0.191235,0.240938,0.109048,0.0087401,0.303964,0.125673,0.0239685,-0.341392,-0.123251,0.025011,0.423833,-0.290451,-0.326527,0.499593,0.140447,-0.359321,-0.154658,-0.220744,0.329609,0.26183,0.302525,0.0479326,0.502353,-0.0773456,-0.48115,-0.213478,-0.0764729,0.472955,0.276918,0.111628,0.0554967,-0.0036065,0.215503,-0.0279301,0.577988,0.51957,0.178534,0.227164,0.422532,0.476618,0.377077 +3408.34,0.845168,0.0848144,5,1.52068,0.979252,-0.880619,0.388446,0.00819981,-0.227069,-0.321135,-0.0841502,0.241308,0.657963,-0.115651,-0.58926,-0.0104247,0.572271,0.19796,1.0843,0.083639,0.250616,-0.266896,-0.278727,-0.368878,-0.750769,-0.773184,0.3959,-0.0217399,0.0968152,-0.0376364,0.461144,0.257719,-0.0421252,0.682774,-0.289751,0.180745,0.358549,-0.659588,0.286225,-0.375387,0.512082,-0.0906023,-0.475705,0.959665,0.651121,0.381959,-0.613707,-0.373541,0.421276,-0.469711,0.263756,0.521185,-0.213396,0.0274427,0.3002,0.172289,-0.188873,0.299104,-0.34667,-0.192654,-0.47409,0.0427114,-0.0956031,0.00483676,1.24931,-0.560133,-1.0345,0.282762,0.272076,0.395201,-0.474455,-0.0592423,-0.78892,0.145811,0.401619,0.726602,0.0642679,0.0729571,0.519724,0.0205787,0.00262086,0.318004,0.313179,0.440411,-0.495144,-0.180678,-0.246303,-0.2099,0.733366,0.146851,-0.511454,0.407626,-0.145068,0.676383,0.356932,-0.815278,0.0144579,0.166888,0.0284554,0.0943745,-0.0521118,0.219539,0.147861,-0.288713,-0.176428,-0.0463084,0.0340393,-0.0310225,-0.832672,0.29953,-0.343088,0.131355,0.452062,-0.233396,-0.272856,-0.283098,0.229244,-0.356791,-0.657507,-0.648136,0.556138,0.697112,-0.107241,-1.35584,-0.150748,-0.80866,0.164533,-0.489258,0.0334244,0.586676,0.0340366,0.212294,-0.395916,0.390672,0.161074,-0.621957,0.889669,0.065352,0.107983,0.225163,0.325163,0.500828,-0.895269,-0.118732,-0.35395,-0.194845,-0.382222,0.538479,0.12009,0.297435,0.305285,0.229985,0.805653,-0.447727,-0.0634287,0.0312001,-0.634277,0.0130251,0.467692,0.608042,0.0264784,0.0181226,-0.144908,0.148484,-0.281048,0.880679,-0.505492,-0.345383,0.18538,-0.381605,-0.326596,0.604421,-0.510156,-0.304673,-0.0250376,-0.32697,-0.0378279,-0.168784,-0.5759,-0.410781,0.116831,0.17343,0.485098,-0.211356,0.660974,0.314233,0.369044,-0.0391696,-0.254464,-0.151262,-0.399517,0.495502,0.170513,0.160595,-0.0555804,0.217157,-0.340412,0.102002,0.945673,0.495236,-0.432253,0.119263,0.342971,-0.138996,0.239856,-0.529534,0.263715,-0.0131792,-0.65445,-0.511993,0.962647,0.117108,0.54295,-0.10012,-0.497087,-0.0399958,-0.385053,-0.925594,0.772723,-0.342318,-0.0254375,0.425716,0.566996,-0.495129,-0.990691,-0.135159,-0.119009,0.0697264,0.353729,0.210238,-0.239247,-0.299585,-0.274579,-0.148274,0.0390542,0.33878,-0.224343,0.137716,0.424253,-0.0768633,0.230603,0.0917312,-0.921391,-0.227651,-0.132811,-0.242444,0.420759,-0.0837901,-0.243553,0.23093,0.426332,0.276884,-0.218769,0.301866,-0.522405,0.542254,0.164856,-0.0578445,0.675723,-0.226813,-0.239822,0.168217,-0.224574,-0.230992,-0.0663418,0.0752438,-0.245373,0.0184214,0.255501,0.203252,-0.179754,0.167823,-0.222402,-0.191253,-0.462743,0.0417996,0.476383,0.260455,-0.153279,0.0627435,0.342486,0.287827,-0.418463,0.0614479,0.0566928,-0.509649,0.0457959,-0.222579,0.210594,-0.167221,0.0650042,0.218353,0.320889,0.0178728,0.289379,-0.132095,0.0275806,0.283407,-0.619104,0.417132,-0.273256,-0.36008,-0.875204,-0.672315,0.175442,0.169929,0.418859,0.412225,-0.0867392 +3412.26,0.309216,0.0848144,4,1.66485,0.859235,-1.38928,0.503707,0.405937,-0.143795,0.726016,0.475771,0.407562,-0.482842,-0.0984575,-0.636762,-0.579713,0.0620232,-0.403323,0.508567,-0.132411,-0.380234,-0.458068,-0.517879,-0.193376,-0.618994,-0.635164,0.195641,-0.578989,-0.0344945,0.233332,0.21713,-0.472295,-0.0855784,0.673174,-0.719887,-0.560297,0.201579,-0.364513,-0.390156,-0.236261,0.616576,0.122536,-0.492401,1.1064,0.495681,0.163988,-0.554655,-0.410971,0.279633,-0.647944,0.164179,0.105265,-0.0950528,-0.108175,0.0341575,-0.327881,-0.306699,0.374684,-0.25184,-0.0577066,-0.743662,0.351814,-0.585733,0.0406853,0.692553,-0.674051,-0.468964,0.0345964,-0.767443,-0.582426,-0.194379,0.861272,-0.0270899,0.464656,-0.00889357,0.756833,0.230496,1.00059,0.580253,0.330836,0.563452,-0.13164,-0.496079,0.0337058,-0.0750595,0.0879579,0.607802,-0.114873,-0.781487,-0.224213,-0.354549,-0.198587,-0.365829,0.269647,0.0398118,0.479576,-0.199978,-0.0444859,-0.308461,0.385874,-0.403276,0.194463,0.00588462,-0.21854,-0.31407,-0.656019,-0.241472,0.0144548,0.254901,0.0531131,0.220459,0.191765,0.451966,0.222128,-0.170524,0.650336,0.379871,0.464246,0.216308,0.472535,-0.662918,0.0138405,0.38414,-0.321036,-0.0733146,0.0845496,0.0321034,-0.333646,0.206954,0.00318232,0.0851086,0.374631,-0.355889,0.0408369,0.10747,0.284653,-0.235973,-0.0990933,-0.0902101,0.15441,0.0328218,-0.0759137,-0.193474,-0.0919178,-0.0823301,0.207358,-0.587512,-0.536939,-0.36453,-0.376805,-0.0403989,-0.407675,-0.490186,0.0206275,0.108154,-0.120411,-0.000317601,0.300938,0.245945,0.104713,0.55135,-0.125359,-0.134563,-0.0861842,-0.270735,0.888189,0.390058,0.367242,0.473693,0.451454,0.385876,-0.722925,0.328963,0.603452,0.182093,0.0304223,-0.432233,-0.290775,-0.0935372,-0.528018,-0.177542,0.395579,0.536728,0.503579,-0.116896,0.0750056,-0.283293,-0.560547,-0.660728,-0.247898,-0.56905,0.601213,-0.658015,0.320978,0.187028,-0.255594,-0.219808,-0.357834,-0.524406,0.241095,-0.548762,-0.944001,-0.0810154,-0.369186,-0.262963,-0.237134,-0.424425,-0.0535685,-0.418671,-0.24467,0.965217,-0.121335,0.0168966,-0.169897,-0.175126,0.229178,-0.0067193,0.361758,0.239978,0.334209,0.0425937,0.0468234,-0.708872,0.0563235,-0.289739,0.187901,0.42847,-0.815687,0.372957,-0.670115,-0.0507799,0.510959,0.0386132,-0.575509,-0.0422638,-0.0168001,-0.162375,-0.76515,0.324339,-0.0335816,-0.245539,0.611818,-0.0866577,0.0543793,0.357219,0.309214,-0.43885,0.767451,0.786854,0.482648,0.624406,0.0187011,0.0552613,-0.324527,-0.444334,0.57763,-0.521811,0.101515,0.783706,-0.172466,-0.115998,0.119426,-0.0616781,0.141495,0.359611,-0.307948,0.0244901,0.507519,0.291808,0.0433543,0.329556,-0.0813865,0.0209237,-0.0809385,-0.168459,-0.464214,-0.729046,0.128128,-0.383405,0.178636,0.0236422,0.483721,-0.336157,-0.190376,-0.0970791,0.386681,0.153604,0.435929,-0.27881,0.173805,0.632106,0.468932,-0.478569,0.0414267,0.147066,-0.0495321,0.340962,-0.371628,0.333136,0.649258,0.011918,0.239299,0.451407,-0.0877116,0.158192,0.246822,0.397733,0.496812,-0.913659 +3417.06,0.998143,0.0848144,4,1.66073,0.757781,-1.6255,0.589506,0.291248,-0.139057,0.411818,-0.0544221,0.0139954,-0.665807,-0.387219,-0.612126,0.187649,0.0955019,-0.144174,0.519969,-0.312807,-0.123731,-0.477813,-0.48249,0.128827,-0.777891,-0.959623,0.242761,-0.606932,-0.0320451,0.151267,0.505277,0.121745,0.531553,0.566352,-0.420574,-0.0567986,-0.0605382,-0.267848,-0.110796,-0.41213,0.345745,0.31478,-0.597792,0.934718,0.608319,0.300296,-0.63257,-0.544991,0.0117811,-0.557977,0.259732,-0.221004,-0.0132382,0.155703,0.275125,-0.253929,0.152333,0.465626,0.114205,0.0104425,-0.677614,0.0703498,-0.561153,0.0490335,0.875973,-0.804103,-0.997005,0.0503029,-0.841003,-0.0559537,0.00286264,0.710223,-0.296969,0.422103,-0.194675,0.943765,-0.0503888,0.44398,0.907525,-0.00444222,-0.0803112,-0.142461,0.0622569,0.456285,-0.349285,0.0641657,0.0816946,-0.439456,-0.530682,0.0632372,-0.328839,-0.341715,-0.181342,0.262619,-0.705952,-0.336992,-0.244569,0.155667,0.14363,0.0647317,-0.539394,0.481731,-0.0942121,-0.228219,-0.0246168,-0.325092,0.160246,0.103913,0.483054,0.319121,0.381282,0.384358,0.437935,0.140268,0.217304,0.1125,0.202415,0.60271,0.0882377,-0.157808,0.639139,0.220197,0.213275,-0.0401762,-0.230808,0.391268,-0.406609,-0.412218,-0.0788267,0.225429,-0.156396,0.473278,-0.628008,-0.244924,0.0170218,-0.25023,0.471356,0.102788,-0.123914,0.0259964,0.0293514,-0.0243921,-0.637265,0.113806,-0.0981769,-0.163267,-0.616241,-0.219607,-0.48883,0.222911,0.0423758,-0.0382758,-0.705379,-0.512265,0.05253,-0.210858,0.0291742,-0.0589295,0.721505,0.0695672,0.771805,-0.135472,0.500019,-0.0532655,-0.116667,0.647969,-0.0348691,0.269684,0.450412,0.0576527,-0.0977459,-0.521965,0.50694,0.648904,-0.184679,-0.254665,-0.157434,-0.0946172,0.604343,-0.325485,0.30798,0.330142,1.02418,0.626041,-0.375971,0.192545,-0.140484,-0.564643,-1.14891,0.261537,-0.354467,0.276492,-0.272576,0.139454,-0.127062,-0.169566,-0.646291,-0.380694,0.152174,-0.0369884,-0.422838,-0.790258,-0.37989,-0.0736391,-0.23229,-0.210297,-0.424377,-0.232655,-0.274892,-0.803313,0.890986,-0.0395401,-0.07657,0.156598,-0.290671,0.0569919,-0.328888,0.130371,0.344517,-0.387965,0.43829,0.241854,0.0752239,-0.109248,-0.302133,0.147908,-0.107167,-0.603732,0.865053,-0.196164,-0.126842,0.453034,0.369678,-0.196587,0.0534151,-0.135174,-0.426234,-0.149134,0.888726,-0.0966291,0.225266,0.583676,-0.497344,-0.114568,0.337944,-0.790794,-0.344436,-0.130509,0.569013,0.203874,0.354696,0.213639,-0.138638,0.392197,0.127743,0.697132,0.0581333,0.121168,1.05336,-0.80573,-0.395051,-0.19355,-0.203237,-0.066255,-0.0922767,0.356437,-0.216973,0.0250255,-0.1321,0.115895,-0.0120057,0.294976,-0.121991,-0.249812,-0.291192,0.0632406,0.178051,-0.166694,-0.498207,-0.0900824,-0.411269,0.312646,-0.103023,0.0547318,-0.187863,-0.169484,-0.523457,0.677883,0.201012,0.200008,0.261612,0.345212,-0.163628,0.137089,0.331612,-0.00730016,0.610767,-0.34617,-0.0591921,0.418211,0.0609552,0.0192177,-0.223985,0.11395,0.129796,0.174234,0.360272,0.417414,-0.316105 +3409.21,0.686839,0.0848144,4,1.60353,0.704598,-1.60596,0.63344,0.332223,-0.183455,0.151546,-0.222162,0.323818,-0.228654,0.203225,-0.843476,-0.626634,0.231481,-0.284906,0.173473,-0.0402028,-0.100276,0.0964697,-0.143032,-0.0527515,-0.781061,-0.433771,0.541322,-0.445048,-0.0305367,0.0524827,0.0580769,-0.487854,0.0586031,0.567344,-0.567618,-0.0675515,0.415014,-0.262198,-0.106826,-0.606841,0.683391,0.526847,-0.583805,1.02651,0.418068,-0.246005,-0.778508,-0.00126538,0.197697,-0.500068,0.153856,0.152216,-0.00316178,0.0551846,0.063695,-0.310285,-0.00580077,0.396014,-0.471265,-0.0423967,-1.27367,0.250995,-0.117881,-0.343206,0.727937,-0.491645,-0.445391,0.363916,-0.230492,-0.211528,0.277537,0.192152,-0.36781,0.905826,0.447706,0.551831,0.161883,0.693077,0.694467,0.334806,0.194902,-0.169628,-0.377728,0.233306,0.211443,-0.105469,-0.469997,-0.512728,-0.309677,-0.598062,0.153972,-0.531751,-0.351078,-0.124229,0.0516725,0.101514,0.111044,-0.132098,-0.166424,0.815571,-0.479224,0.471897,0.326577,-0.0326547,-0.143531,0.104379,-0.0541843,0.559937,0.0500686,-0.0421435,0.0125046,0.0710975,0.414636,-0.0726112,0.318993,-0.133244,0.408351,0.403748,-0.0759424,0.367692,-0.0853186,0.337779,0.00325925,-0.758974,-0.30948,0.160556,-0.337189,-0.192358,0.345332,0.160095,0.255125,0.0966975,-0.1148,0.448927,0.396881,-0.31111,0.627728,-0.365072,-0.095149,-0.0839465,-0.406225,0.231005,-0.428217,-1.03766,-0.282398,0.57771,-0.857319,-0.183414,0.265046,-0.0162356,0.0815883,-0.197087,-0.519025,0.541532,-0.0201958,-0.135796,-0.00759367,0.101241,0.486573,0.399848,0.18268,-0.108599,-0.0986967,0.119109,0.0535523,0.00234166,0.0252429,0.0952574,-0.403514,0.356912,-0.196959,-0.345553,0.277474,0.101119,-0.275168,0.139136,-0.346316,-0.252813,0.213155,-0.157675,-0.351655,0.451009,0.480512,0.393027,0.303242,0.505835,-0.45003,-0.481313,-0.616143,-0.263983,0.141696,0.503735,-0.689927,0.135614,0.547276,-0.0727303,0.0657463,0.333071,0.0562185,0.0671878,-0.819255,-0.363424,-0.175054,-0.240987,-0.105692,0.0696806,-0.215289,-0.396113,-0.247386,-0.330531,1.30411,-0.242838,-0.388793,-0.199469,-0.379813,-0.367933,0.090947,-0.361479,-0.306831,-0.0780829,0.149687,0.258963,0.643783,-0.0535479,0.23155,0.137916,0.589364,0.206079,0.349741,-0.391753,-0.30578,0.67876,0.282294,-0.517367,-0.0307874,0.213997,-0.35647,-0.208943,0.17227,0.40017,0.819906,0.597078,-0.264647,-0.259832,0.511616,-0.0104842,-0.207106,0.415729,0.251206,0.528502,0.148973,-0.711695,-0.150739,-0.0856708,-0.0202914,0.72072,-0.41779,-0.488175,0.624623,-0.128119,0.255453,0.114897,-0.138901,0.41567,0.213402,0.173217,-0.323947,0.263889,-0.320938,0.364942,-0.120681,0.344979,0.39456,-0.216824,-0.370239,-0.356687,0.573447,0.79974,0.150244,0.111012,0.225041,0.0959097,0.154898,-0.282332,-0.713453,0.551016,-0.344105,0.487754,-0.0775145,0.339494,0.689004,0.226849,0.241211,-0.270566,0.412764,-0.0690124,0.0262125,0.26449,-0.21896,0.364875,0.43949,-0.37373,0.267425,0.385178,0.135666,0.209487,0.368328,0.457698,-0.456148 +3408.94,0.849885,0.0848144,4,1.58834,0.776667,-1.72483,0.755408,0.418824,-0.231626,0.267642,0.0418757,0.24938,-0.352026,0.0250945,-0.707144,-0.793221,0.187589,-0.133482,0.216036,-0.0281349,-0.0415113,0.303294,-0.0377156,0.167865,-0.835008,-0.0766858,0.759353,-0.236823,0.140162,-0.0112895,0.0558792,-0.428649,0.066964,0.533179,-0.626635,-0.0928155,0.197891,-0.342426,-0.0461226,-0.422047,0.540615,0.447881,-0.324815,0.839506,0.630078,0.0140118,-0.905408,0.0760584,-0.0167204,-0.370376,0.542765,0.194325,0.276009,0.0531126,0.249594,-0.244781,0.13241,0.228059,-0.39054,0.16403,-1.26614,0.369961,-0.156965,-0.156917,0.690251,-0.35998,-0.44604,0.370841,-0.246825,-0.102687,0.366711,0.177505,-0.182369,0.662907,0.7746,0.401141,0.211695,1.00301,0.802713,0.299798,0.320239,-0.195213,-0.404946,0.13529,-0.0744566,-0.0569881,-0.617535,-0.408231,-0.61288,-0.686027,0.462918,-0.489192,-0.601993,-0.0963348,0.0126309,-0.00711818,-0.144575,-0.214228,-0.244514,0.973214,-0.35591,0.453479,0.190615,-0.0986698,-0.0622337,-0.0455318,0.0124361,0.29533,0.131609,0.273797,-0.122397,-0.0712537,0.215054,0.15799,0.0875562,0.0483466,0.313124,0.361953,-0.169913,0.469354,-0.0390715,0.357014,-0.0690249,-0.378905,-0.269142,0.216854,-0.0839612,-0.174621,0.236444,0.255387,0.546683,0.153066,-0.289082,0.0499031,0.382969,-0.324784,0.587006,-0.188042,0.0699989,-0.132768,-0.154662,0.202712,-0.385398,-1.25274,-0.289383,0.727728,-0.948044,-0.180228,0.141947,0.00962564,0.183025,0.0139301,-0.148761,0.323011,0.0654135,-0.177729,-0.00816868,0.182821,0.44359,0.198246,0.148628,-0.107579,-0.249049,0.324588,-0.0608836,-0.0207209,0.0968276,0.300109,-0.331199,0.434129,-0.143976,-0.377207,0.0680787,0.267065,0.0726488,-0.0532471,-0.152823,-0.253074,-0.186364,-0.247029,-0.20227,0.370437,0.588328,0.623487,0.605719,0.456004,-0.275707,-0.632727,-0.46163,-0.454153,-0.0664935,0.718021,-0.577982,0.0211771,0.398832,-0.0616242,0.0978574,0.162603,-0.316846,0.111907,-0.725544,-0.550229,0.0731837,-0.273904,0.184838,0.448149,-0.0170425,-0.27331,-0.0324847,-0.463809,1.33586,-0.211357,-0.391655,0.0211583,-0.305177,-0.359086,0.14635,-0.121248,-0.296044,0.0405562,-0.0984956,0.136672,0.732535,0.078663,0.111961,0.175378,0.214512,0.48994,0.437673,-0.567909,-0.158404,0.499056,0.320397,-0.467892,-0.206962,-0.0632188,-0.402259,-0.450592,0.378646,0.107,0.793089,0.530338,-0.258407,-0.0464512,0.268722,-0.362315,-0.0164184,0.358317,0.0581571,0.512424,0.275025,-0.700106,0.13123,0.060801,-0.165471,0.818002,-0.132739,-0.165402,0.35085,-0.218296,0.475349,-0.229272,-0.251927,0.398571,0.225356,0.120852,-0.0693445,0.226853,-0.460318,0.585834,0.00290658,0.113433,0.235741,-0.365442,-0.374235,-0.393173,0.616292,0.321085,0.35079,0.0629091,0.327356,0.275703,0.222849,-0.671861,-0.611287,0.251287,-0.343123,0.368544,-0.0433887,0.0344311,0.625951,0.205292,0.498218,-0.179642,0.208937,0.0719713,0.337105,-0.159489,-0.320171,0.435613,0.333113,-0.177912,0.0827888,0.567181,0.133447,0.209568,0.365303,0.457786,-0.927414 +3411.53,1,0.0848144,5,1.56541,0.747741,-1.85033,0.729462,0.560863,-0.158828,-0.113364,0.00892126,0.185203,0.131523,0.153295,-0.497788,-0.608174,0.419223,-0.0377606,0.135503,-0.0130954,0.113201,-0.136056,-0.196918,0.0962288,-0.623151,-0.360626,0.432659,-0.608204,0.225258,-0.0422267,0.0458571,-0.626139,0.104974,0.484902,-0.383723,-0.347748,0.263006,-0.370411,-0.372059,-0.471289,0.585293,0.701869,-0.672665,1.02465,0.804035,0.0408131,-0.923419,-0.220959,-0.117919,-0.429502,-0.110141,-0.0598829,0.287322,0.312196,-0.0831901,-0.181044,-0.210082,0.563651,-0.26778,0.0449913,-0.751393,0.184121,-0.22971,-0.241542,0.842019,-0.51252,-0.635676,0.2597,0.168606,-0.0276791,-0.516029,0.150575,-0.458689,0.254262,0.856025,0.609789,-0.111714,1.42101,0.663375,0.261292,-0.134826,-0.181389,-0.191089,-0.0480136,0.0892927,0.136551,-0.755357,0.202039,-0.0678576,-0.996204,0.339312,-0.183195,-0.522514,-0.296092,-0.0105327,0.0606385,-0.01905,-0.125036,0.0934534,0.885265,-0.519754,0.50818,0.319964,0.422423,-0.326372,-0.113071,-0.272864,0.52124,-0.0667373,0.475514,-0.278419,0.138013,0.48471,-0.152198,-0.0490133,0.0603462,-0.0828366,0.29947,-0.115502,0.183315,-0.054057,0.422928,-0.121704,-0.730778,0.136143,0.0130095,-0.283516,-0.0417025,0.260506,-0.186665,0.300713,0.289764,-0.053137,0.166237,-0.0449387,-0.109507,0.909003,-0.31555,0.333716,-0.0205838,-0.0150755,-0.0366398,-0.641238,-0.36697,-0.512854,0.220819,-1.06853,-0.159503,0.191029,-0.514844,0.302679,0.00753164,-0.0369068,0.532427,0.203531,0.0624272,0.149856,-0.0709625,0.173444,0.0345857,-0.0108498,0.115527,0.177501,0.369461,-0.0394368,0.568742,-0.361223,0.279123,-0.324144,0.26649,-0.410578,-0.670827,0.206214,0.224862,0.182,-0.439977,-0.747112,-0.0540942,-0.416766,-0.112102,-0.358178,0.0837441,0.581445,0.348323,0.712179,0.803318,-0.247766,-0.00299737,0.0249996,-0.107024,-0.301804,0.443073,-0.496831,-0.174783,0.341732,-0.132513,-0.50523,-0.0502318,-0.0343817,-0.158876,-0.148552,-0.687199,0.099673,-0.556794,0.334706,0.0335402,-0.0785565,0.114361,0.283736,-0.639882,1.29913,-0.154566,-0.00203212,-0.0572068,0.00616575,-0.339485,0.140025,-0.0493669,0.261189,0.254483,0.0125973,0.54482,0.429053,0.3249,-0.890145,0.238319,0.679903,0.349302,0.526863,-0.732315,-0.225505,0.570053,0.740649,0.259146,-0.00588274,-0.481795,-0.989706,-0.199471,0.384833,-0.424145,0.557554,0.899446,-0.390194,-0.0545326,0.126396,-0.367691,0.489895,0.818052,0.198546,0.462697,-0.349474,-0.292888,-0.0897608,-0.393599,-0.0180734,0.375802,-0.338896,-0.3617,0.752569,-0.0786421,0.181466,0.373042,0.033164,0.308267,0.308472,0.0936554,-0.19776,0.246777,-0.104565,0.333788,0.218667,0.247285,0.354806,-0.369215,-0.30926,-0.189284,0.492272,-0.257224,0.297603,0.0778206,0.357608,0.267345,0.230224,-0.627485,-0.778567,0.45687,-0.454402,0.417276,-0.120589,-0.122049,0.293713,0.174854,0.0136085,-0.0720625,0.145244,0.0902499,0.298001,-0.0295591,-0.146222,0.255864,0.0972103,-0.423128,0.159952,0.334189,0.16355,0.176797,0.404413,0.420473,-1.2984 +3427.47,0.795261,0.0848144,4,1.65014,0.698065,-1.6185,0.747453,0.467895,-0.106113,-0.26745,-0.398328,0.163146,-0.270153,0.146957,-0.166496,-0.833292,0.234464,-0.179118,-0.041676,0.361252,-0.249536,0.277162,-0.047457,0.0245279,-0.650788,-0.82853,0.411391,-0.196089,-0.3097,0.205458,0.323061,-0.338607,0.0475335,0.976331,-0.393822,0.321905,0.108536,-0.490597,-0.300468,-0.416719,0.28336,0.3432,-0.628397,0.732125,0.448629,0.294373,-0.836657,-0.230321,0.185218,-0.560843,-0.0196505,-0.0373128,0.100041,0.0356085,0.0475277,-0.263859,-0.584297,0.162047,-0.595505,-0.095144,-0.856552,0.0529707,-0.316382,0.0897965,0.374084,-0.354648,-0.78092,-0.0753752,0.130605,-0.508785,-0.529195,0.558576,-0.190924,0.386643,0.727047,0.860376,-0.140269,1.60792,0.547155,0.683813,-0.254087,-0.429139,-0.0309408,0.232122,-0.533169,0.197864,-0.293951,-0.266341,-0.185633,-0.661934,0.216195,0.321715,-0.336933,-0.613936,-0.0103952,-0.121806,-0.156645,0.0192327,-0.171403,0.239528,-0.486665,-0.0843867,0.314614,0.0584517,-0.0224309,-0.0285437,-0.187255,0.775114,0.0733685,0.464019,0.0231148,0.269196,0.457781,-0.19962,-0.0744897,-0.240078,0.250256,0.0578699,-0.21219,0.0475238,0.287166,0.414259,-0.489841,-0.648998,-0.345858,-0.0304173,-0.878185,-0.41429,0.649707,-0.0841626,0.0771701,0.139431,0.251501,0.0119693,0.106915,-0.18141,0.411491,-0.348142,0.59458,-0.0637467,0.109863,0.377711,-0.565188,-0.887781,0.000122237,0.11684,-0.433679,0.133209,-0.0286133,-0.389827,0.309654,-0.180844,-0.0442803,0.299833,0.438407,0.0176368,0.0940896,0.118724,0.12159,0.258696,0.177921,-0.0472024,0.304531,-0.083064,0.00856319,0.661107,0.328005,0.567179,-0.0509181,0.227023,-0.412692,-0.622772,0.307984,0.36598,0.865068,-0.260431,0.197039,-0.732616,0.366548,0.0330774,0.0685464,0.220764,0.991792,0.315779,0.627367,0.2744,0.045529,-0.032589,-0.350827,-0.241769,-0.483898,0.53297,-0.211028,-0.044499,0.343926,0.263786,-0.457483,0.170282,-0.0994452,-0.0889509,-0.120765,-0.667571,-0.0249664,0.2238,0.296705,-0.479912,-0.0747052,-0.0873618,0.31451,-0.852984,0.854816,0.252105,0.46291,-0.352609,-0.355538,-0.132401,-0.14957,-0.109091,0.576892,-0.151169,0.279508,0.633701,-0.0226571,-0.135284,-0.196684,-0.0738633,0.336623,0.314288,0.61213,-0.969778,-0.415928,-0.103107,0.348271,0.0974802,-0.305069,-0.592512,-0.513641,0.0284208,0.45374,-0.369384,0.730364,0.992829,-0.225029,-0.171661,0.241513,0.377316,0.00524642,0.146911,0.353107,0.294317,0.283847,0.151855,-0.243254,-0.328529,-0.136918,0.059805,-0.561517,-0.62337,0.23713,-0.633866,0.130831,0.38695,0.0207521,0.170993,0.670208,-0.300467,0.372022,-0.335176,0.422038,0.0990527,-0.44848,-0.12199,0.428154,-0.535365,-0.172208,-0.466321,0.320381,-0.527806,0.190744,-0.088956,0.526513,-0.0991702,0.487162,-0.439427,-0.217067,-0.466065,0.186043,0.325673,0.0330153,-0.196665,0.485743,0.317078,0.0416256,-0.233711,0.68649,-0.0337381,0.0837446,0.0499864,-0.421355,0.047625,0.351626,-0.1251,0.447648,0.143994,0.150655,0.16731,0.388144,0.409035,-0.969258 +3402.24,0.968841,0.0848144,4,1.66811,0.792666,-1.14411,0.607237,0.391533,-0.0774073,0.243466,0.216865,0.208754,-0.28337,0.0777243,-0.522347,-0.273819,0.46149,-0.17299,0.258146,0.31159,-0.0741576,-0.00439215,0.176546,0.11666,-0.917882,-0.21501,0.318554,-0.211543,0.30888,-0.354583,0.538569,-0.335684,0.18287,0.788539,-0.498077,-0.75478,0.548106,-0.499564,-0.366783,0.0737768,0.674547,0.0414515,0.074789,0.649819,0.139558,0.41786,-1.40604,-0.296291,-0.210289,-0.687118,0.461562,-0.129448,-0.26265,-0.00625695,0.55822,-0.211681,-0.714808,0.0621273,-0.57071,-0.149787,-0.80014,-0.241596,-0.506011,0.509226,0.517371,-0.752269,-1.83277,0.225304,-0.672928,-0.372097,-0.00381892,0.290605,-0.294867,0.0801243,0.486699,0.507345,0.176365,1.02118,0.442782,0.207094,-0.270744,-0.573084,-0.0715244,0.528719,-0.750954,0.394551,-0.807545,0.208567,0.107695,-0.726702,0.172148,0.13134,-0.416093,0.0339531,-0.223786,0.0237639,0.083899,0.305921,-0.386809,-0.559201,0.00555536,-0.133079,0.488118,0.344045,-0.0732375,-0.0347288,-0.240939,0.52592,-0.12083,-0.206279,-0.123611,0.273668,0.515842,-0.949317,0.293678,0.102924,0.301466,0.0509635,-0.275646,-0.59905,-0.0590818,0.5541,-0.0555616,-0.470177,0.0355459,-0.623595,-0.712529,-0.206825,-0.20928,0.355635,0.0432508,0.392248,-0.0864777,0.758364,0.114548,-0.373233,0.750379,-0.0350374,-0.504806,0.0334102,-0.312016,0.0530234,-0.444986,-0.47491,-0.013828,0.280585,-0.656674,0.058901,-0.381764,-0.144607,0.360322,-0.406102,0.170261,0.208347,-0.197225,0.146767,0.134379,-0.606982,0.849384,0.286445,-0.260702,0.0469367,0.281866,0.382199,0.5582,0.742763,0.514499,-0.481321,0.274594,-0.0533544,-0.60705,-0.0432288,0.139811,0.122378,0.0650887,-0.0323972,0.42104,-0.161715,-0.299859,-0.205443,-0.113276,0.367209,1.21872,-0.6227,-0.210587,0.26733,-0.130543,-0.390913,-0.517396,0.100749,-0.692876,-0.104413,-0.202372,0.0559816,-0.210238,-0.0101656,-0.632438,0.199909,-0.72016,0.34669,-0.120388,-0.230985,-0.0453405,-0.42132,-0.0459252,-0.179318,0.372454,0.058877,-0.43236,-0.83024,1.09276,-0.402835,0.335326,0.111977,-0.219259,0.158191,0.0316068,0.394874,0.133253,-0.553529,0.248276,0.187489,-0.285963,-0.00563756,-0.996931,-0.249478,0.118116,-0.621156,0.890542,-0.460634,-0.380844,-0.647848,-0.270872,-0.409751,0.242843,-0.748591,0.194445,-0.481854,0.805754,-0.112579,-0.319424,0.523054,-0.588546,0.483597,-0.206028,0.499538,0.0460928,0.810095,0.840089,0.711981,0.442637,0.449355,0.164004,-0.037447,0.0540994,0.248972,0.320264,-0.0376219,0.264169,-0.179942,-0.315573,-0.313327,-0.113481,0.242047,-0.0101349,-0.108509,-0.0978628,0.85321,-0.349513,-0.07073,-0.0314796,-0.332825,-0.166083,-0.183503,-0.18255,-0.953744,-0.0617787,0.714457,0.295583,0.282338,-0.0909531,0.470443,0.129403,-0.0892824,0.326371,-0.464012,-0.336091,0.244184,0.143578,-0.347566,0.814882,0.136304,-0.0847386,-0.0369847,0.312964,-0.278067,0.110446,0.295053,-0.392248,-0.89364,0.294784,0.524646,0.0730085,-0.160536,0.183172,0.28581,0.427986,0.534612,-0.988492 +3411.53,0.989142,0.0848144,5,1.67737,0.962425,-0.223252,0.113831,-0.177476,-0.235511,0.101498,-0.0801553,-0.132833,0.735835,-0.0362562,0.0248909,0.0930572,0.460587,-0.00952008,0.511944,0.247563,-0.160111,-0.272905,0.176392,-0.204062,-0.906367,-1.08617,0.385406,0.209871,-0.660631,0.265114,0.0055083,-0.369612,0.315116,0.735241,-0.118131,-0.0895548,0.125639,-0.83636,-0.110061,-1.20285,-0.273131,0.162727,-0.737013,0.923896,0.190951,-0.0769459,-0.933878,-0.0380296,-0.249523,-0.255834,-0.207081,0.304244,0.170118,-0.190997,0.107452,-0.299456,-0.0382563,0.36306,-0.227609,-0.660286,-0.852944,-0.0407953,-0.601641,-0.00833869,0.856754,-0.464547,-0.265669,-0.0171785,0.353868,0.000227999,-0.62593,-0.199111,-0.354175,0.017374,0.0208337,0.727402,-0.585073,0.628359,0.425667,0.566455,-0.146992,0.0863252,-0.00884787,0.404582,-0.128712,-0.340403,0.251422,-0.54823,0.0363728,0.0854431,-0.102226,-0.574389,-0.293441,-0.170582,0.347706,-0.141448,0.0542318,0.198576,0.127097,0.734026,-0.264627,0.192247,-0.0657807,0.0606719,-0.206452,-0.298071,-0.511441,-0.28976,-0.7026,0.372403,-0.240002,-0.157993,0.503413,0.245772,-0.518516,-0.0244272,0.608108,0.390709,0.539912,-0.0837714,0.320708,-0.230403,-0.136354,-0.81464,-0.520904,0.0823675,0.381721,0.16374,0.592213,0.0766652,-0.00990531,0.216145,-0.508142,-0.783254,-0.0849538,0.529788,0.703393,-0.336659,0.260214,-0.368879,0.165127,0.524054,-0.464642,-0.350537,-0.376148,-0.135937,0.277848,0.315798,0.220993,0.33899,0.166269,0.0985537,-0.358695,-0.503114,0.2721,0.332827,0.193458,1.06649,0.273237,0.264841,-0.0823052,-0.0939806,-0.0931668,0.090638,-0.529405,0.229478,-0.277212,0.0876224,-0.159743,0.104212,-0.199852,-0.224551,-0.779791,0.0729255,-0.31989,0.0912822,-0.206212,0.18158,0.0856042,-0.13206,-0.107362,-0.330221,0.22157,0.167169,0.131806,0.201847,-0.367512,0.192872,0.445116,-0.503193,0.196009,0.459625,-0.446359,0.150782,0.276813,0.0860517,-0.545058,0.109767,0.775046,-0.143354,-0.571191,-0.723474,0.145075,-0.0567578,-0.493225,0.491722,-0.524431,-0.468685,0.197632,-0.0912294,0.763671,0.125759,0.639181,-0.260051,0.16903,0.0356566,0.193655,-1.28807,0.13442,-0.127236,-0.00162413,0.343427,-0.442999,0.173579,-0.965176,-0.301725,-0.384125,-0.189713,0.0495983,-0.553882,-0.0575624,0.328965,0.287302,-0.407625,0.116008,-0.0976468,-0.358982,0.161701,0.185769,0.0647974,-0.0561024,0.513921,-0.00114291,-0.480795,-0.14539,-0.395183,0.145712,0.0244323,-0.46884,0.438887,-0.0977889,-0.226676,-0.486417,-0.0897443,-0.553549,0.608732,-0.549457,-0.321235,0.308181,-0.400908,0.306513,0.415368,-0.0627708,-0.273414,0.400705,0.106832,0.132037,-0.131053,0.417492,0.113524,-0.500009,0.460647,0.0909193,-0.0424716,-0.0421468,0.239698,0.67754,-0.595761,-0.603527,-0.0522981,0.434,-0.158429,0.410862,-0.347119,-0.31133,-0.276047,0.0457038,0.191978,-0.378544,0.147453,-0.20124,-0.112365,-0.0785104,0.404138,0.04488,0.318398,0.411504,-0.230732,-0.704053,0.187623,-0.141559,-1.00219,0.178978,-0.20814,0.146946,0.225663,0.383335,0.47504,0.633251 +3414.46,0.818237,0.0848144,4,1.65622,0.9894,-0.287951,0.0263413,0.122505,-0.170357,0.567454,-0.0504392,0.0740361,0.394693,-0.460846,-0.348335,0.420332,0.203923,-0.0708789,0.688069,0.0149463,-0.604198,-0.089169,-0.0339237,-0.381143,-1.09874,-0.910252,-0.0798798,-0.287195,0.130215,0.493655,0.353641,-0.111276,-0.141388,0.703927,0.274492,-0.334348,0.0854837,-0.533713,-0.341915,-0.828921,-0.257957,0.0165232,-0.804587,0.901853,0.0432315,0.00256351,-1.13215,0.278795,-0.215373,-0.1865,-0.500275,0.262572,0.230582,0.41058,0.436995,0.126978,-0.477261,0.629218,-0.426664,-0.389697,-0.357519,0.0798487,-0.614552,0.244528,1.12446,-0.985663,-1.08093,0.0869583,-0.158975,-0.3446,-0.327294,-0.118006,-0.44045,0.214722,0.265088,0.552037,0.0302507,0.680388,0.270511,0.583664,0.0605794,-0.544196,0.053882,0.370917,-0.742343,0.391219,0.0794869,-0.103049,-0.298434,0.299393,0.237132,-0.299773,-0.271365,-0.324164,0.366348,-0.216055,0.0328148,-0.0959984,0.0412174,0.159998,0.231148,0.0659794,0.252044,-0.503408,0.244061,-0.562396,-0.329708,-0.185388,-0.639062,0.954735,-0.0247537,-0.197888,0.193585,0.103992,-0.302276,0.2113,0.462019,-0.179881,0.298973,0.194399,0.516265,0.284739,-0.283373,-1.19629,-0.0909235,-0.475743,-0.0189989,-0.179933,0.211354,0.0879998,0.0810083,-0.00989471,-0.312596,0.0936306,0.273828,0.0215109,0.5919,-0.151555,0.252875,-0.385455,-0.354099,0.264205,-0.257128,0.200716,-0.0438779,-0.258311,-0.130622,0.144246,0.206084,0.232536,0.553651,-0.225837,-0.250416,-0.197336,0.311213,0.367309,0.261568,0.481694,0.506219,0.223695,-0.112328,-0.492236,0.0166677,-0.232502,-0.0113804,0.294755,0.0564723,-0.371728,0.008191,-0.0784648,-0.204299,-0.333355,-0.565607,0.0392591,-0.305355,0.0664946,-0.298659,0.303769,-0.52856,0.15346,0.302337,0.145216,-0.246487,0.281972,0.14993,-0.162727,-0.0869052,0.853822,-0.0131308,-0.527273,-0.00988091,0.429335,-0.074459,0.388726,0.232015,0.192162,-0.424253,0.247258,0.00785946,-0.200236,-0.452013,-0.912115,0.520608,0.0640493,0.288322,0.546961,0.0713632,-0.0502828,0.226025,-0.682345,0.847482,0.404697,0.251851,-0.166228,0.256906,-0.357845,-0.0823724,-0.295068,-0.0491805,-0.291095,0.0103937,0.206249,-0.592162,-0.00275544,-1.00521,-0.286856,-0.249084,-0.207501,0.291994,-1.05579,-0.336974,-0.277092,0.37076,0.184074,0.272653,-0.404249,-0.78863,-0.200399,0.702068,0.140013,-0.0140022,0.127746,-0.25532,-0.433676,0.382737,-0.38227,0.138926,0.535554,-0.734653,0.607109,0.257722,-0.0601887,-0.622364,0.0981716,-0.649064,0.571529,0.0437067,0.100448,0.443609,-0.54856,0.304799,0.119336,-0.0546737,-0.504215,0.119422,0.0441021,0.112246,0.2689,0.742923,0.0427949,-0.250807,0.0231652,0.14022,-0.0808505,-0.620481,-0.196326,0.707374,-0.562015,0.492702,0.20937,0.664251,0.617962,0.330472,-0.403609,-0.160485,-0.367625,0.195898,0.11661,-0.53162,0.00838445,0.116471,0.203314,0.0376646,0.24479,-0.49944,0.435982,-0.127732,-0.301506,-0.481268,0.311696,-0.0306683,-0.471052,0.586646,0.489735,0.142388,0.222687,0.377343,0.471897,-0.330779 +3411.93,0.961374,0.0848144,4,1.67716,1.09593,-0.110702,-0.0137128,0.0968574,-0.182209,0.739176,0.124234,0.12591,0.499954,-0.331002,-0.234661,0.273622,0.312988,-0.14732,0.717128,0.121983,-0.386929,-0.137439,0.00675067,-0.377359,-1.10337,-0.965299,-0.119505,-0.241249,0.0872681,0.297234,0.317596,-0.350606,-0.319584,0.711945,0.26118,-0.432059,0.0206323,-0.448359,-0.410086,-0.533134,-0.237917,0.242692,-0.833739,0.776913,0.113344,-0.0562621,-1.11799,0.312403,0.140058,-0.455631,-0.309736,0.401833,0.236077,0.237886,0.564581,-0.00788451,-0.102735,0.432572,-0.251743,-0.463221,-0.297802,0.0607185,-0.43618,0.149671,0.987079,-0.764339,-0.72254,-0.159391,-0.0320243,-0.327179,-0.546791,-0.227325,-0.48753,-0.0177566,0.344093,0.690942,0.00950241,0.534145,0.416583,0.440629,0.218824,-0.739075,-0.0622634,0.265722,-0.576103,0.527193,0.217738,-0.5207,-0.232075,0.364997,0.130408,-0.162549,-0.279157,-0.567011,0.243142,-0.316705,0.0437234,0.126075,-0.161751,0.102651,0.196872,0.406613,0.308912,-0.388051,0.197668,-0.633809,-0.149807,0.0797277,-0.588744,0.936883,0.0406872,-0.0285898,0.359307,0.0196117,-0.365557,0.542576,0.309667,-0.123262,0.39552,0.209437,0.211685,0.23201,-0.0317557,-1.05945,-0.0875459,-0.335145,-0.135418,0.0338717,0.406555,0.0231943,0.136657,0.268682,-0.283926,0.0351567,0.13892,0.0413611,0.559835,-0.284122,0.277223,-0.321326,-0.356917,0.291154,-0.177544,0.0443744,-0.135963,-0.205246,-0.232996,0.126733,0.359168,0.310192,0.875561,-0.231202,-0.182306,-0.128388,0.330579,0.285504,0.0595238,0.486085,0.358827,0.277959,-0.114021,-0.492075,0.109461,-0.208684,-0.00236663,0.470286,-0.252709,-0.420414,-0.156746,0.0328685,-0.0523411,-0.251769,-0.298586,0.154277,-0.342932,0.18798,-0.00618634,0.280442,-0.136889,0.113317,0.162018,0.250785,-0.259491,0.211614,0.253431,-0.163515,0.201519,0.715258,0.300375,-0.502341,-0.00708085,0.302537,-0.533231,0.315914,0.183819,0.386854,-0.419643,0.326001,-0.0797353,-0.109041,-0.357606,-0.753486,0.644553,0.127638,0.26025,0.240683,0.124791,-0.288066,0.269,-0.657559,0.603763,0.320147,0.21687,-0.302518,0.415548,-0.107896,-0.128427,-0.101424,-0.0561052,-0.127455,-0.142635,0.28392,-0.787357,-0.454875,-0.920733,-0.250798,-0.103438,-0.0134536,0.479716,-0.927642,-0.304734,-0.0402452,0.393743,-0.220769,0.243014,-0.348213,-0.826277,-0.536105,0.712492,0.133475,-0.205212,0.0610654,-0.178145,-0.570354,0.09816,-0.413581,-0.0666693,0.770094,-0.728645,0.450913,0.336204,-0.242342,-0.56663,-0.00691457,-0.577098,0.451119,0.269646,-0.00963027,0.618276,-0.271492,0.0837757,0.0958934,0.00964569,-0.590517,0.0557116,0.0893733,-0.0373373,0.194407,0.840611,-0.0246347,-0.153954,-0.124771,0.28215,-0.189997,-0.673381,0.00227243,0.475342,-0.383359,0.0737484,0.183337,0.797,0.606504,0.123516,-0.334732,-0.156588,-0.389881,0.361896,0.0877214,-0.61661,0.108634,0.222472,0.288756,0.184625,0.258996,-0.562336,0.104949,-0.252214,-0.16497,-0.250474,0.281694,0.117577,-0.525594,0.44456,0.528534,0.12701,0.191473,0.356385,0.437576,-0.465219 +3423.56,0.824472,0.0848144,4,1.67432,1.08898,-0.146696,-0.0159343,-0.0578804,-0.165396,0.304229,0.0188538,0.493668,0.61988,-0.382188,-0.150816,0.0857838,0.0271719,0.163706,0.796124,0.093645,-0.0582661,0.0437382,-0.139472,-0.565256,-1.17518,-1.43625,-0.192739,-0.0387816,0.262248,0.143322,-0.120401,-0.250255,-0.61454,0.76833,0.214659,-0.40351,0.159227,-0.716821,-0.276718,-0.316484,0.0361507,-0.0819554,-0.595933,0.752614,-0.0643664,-0.442185,-0.650856,-0.144555,0.286157,-0.74863,-0.312965,0.045322,-0.143049,-0.315871,0.319241,0.286919,-0.246523,0.486936,-0.130232,-0.255012,-0.327805,0.067368,-0.431174,0.0116435,1.05082,-0.808795,-0.647441,-0.105958,0.198221,-0.382638,-0.784917,0.308276,0.0780636,-0.0059423,0.164493,0.65117,0.340785,0.730866,0.266778,0.103545,-0.0881503,-0.28793,-0.00373493,0.405755,-0.483139,0.231739,0.22576,-0.45996,-0.165065,0.196929,-0.126594,0.135032,-0.217145,-0.147474,0.200266,-0.493209,-0.340486,0.139821,-0.0613402,-0.0813989,-0.122709,0.192247,0.216257,-0.350283,0.119824,-0.490004,-0.256979,0.222886,-0.1104,0.761769,0.0275342,0.0344106,0.765108,0.0665069,-0.120295,0.0104723,0.659135,0.141555,0.351923,-0.531631,0.263029,0.180691,-0.398702,-0.876927,-0.269753,-0.71101,0.089129,0.00150014,0.34453,0.164542,0.161503,0.154171,-0.376642,-0.234218,0.218334,0.13191,0.238334,-0.283044,0.30714,0.1808,-0.157362,0.357148,-0.455241,-0.293425,-0.0230991,0.120438,-0.212963,0.118091,0.392238,0.123643,0.923655,-0.525616,-0.0159996,-0.362572,0.120343,0.147868,-0.0154668,0.102156,0.246994,0.845084,0.0193854,-0.292951,0.222072,0.508731,-0.238436,0.797985,0.0481044,-0.56844,-0.344747,0.279993,-0.225822,-0.0903191,-0.43288,-0.129584,0.0377003,0.121913,0.174102,-0.0463714,0.726702,-0.251885,0.50219,-0.240442,-0.368795,-0.228931,0.383636,-0.311866,0.162407,0.420909,-0.225792,-0.558258,-0.167911,0.138849,-0.637408,0.247045,-0.232736,0.530354,-0.691446,0.169412,-0.167326,0.207783,-0.37593,-0.722929,0.328185,0.221663,0.176211,0.147346,-0.000878897,-0.538173,0.176514,-0.117022,0.866091,0.215911,0.0615486,-0.188804,0.357991,0.12199,0.29798,0.0287192,0.0394272,-0.580187,0.274842,0.294171,-0.625228,0.204657,-0.629424,-0.405364,-0.354127,0.0157873,0.587362,-0.947909,-0.228186,-0.00127364,-0.282607,-0.0293562,0.203953,-0.216304,-0.163002,-0.597653,0.699575,0.236106,-0.388148,-0.0943796,-0.353474,-0.0958989,0.145385,-0.187152,0.466434,0.419753,0.290401,0.387183,-0.0992267,0.00929556,-0.156343,0.0405994,-0.665569,0.649117,-0.195709,-0.357127,0.854896,-0.0921941,0.360737,0.353484,-0.153178,-0.127086,-0.0286638,0.174918,0.0664451,0.461773,0.254715,-0.0553071,-0.188122,-0.557684,0.173779,0.0534824,0.0217078,-0.00800123,0.593897,-0.599042,0.169789,0.3997,0.401019,0.472656,0.160638,-0.536751,-0.212194,-0.109072,0.474163,0.254018,0.0502074,0.359371,-0.118804,0.170949,0.075024,0.181843,-0.444536,-0.0298404,-0.188341,-0.0999746,-0.0292371,0.348638,0.00916092,-0.134214,0.54268,0.202346,0.147809,0.186255,0.384459,0.431573,0.0747455 +3413.58,0.679451,0.0848144,5,1.73872,1.07771,0.00146786,-0.0776328,0.0464543,-0.128317,0.135178,0.326195,0.643317,0.308937,-0.348537,-0.071199,-0.159456,0.171643,-0.054532,0.715434,-0.0628472,-0.368471,0.026829,-0.127304,-0.54502,-0.883405,-1.02939,-0.259467,0.0737703,0.325584,0.2848,-0.236164,-0.303156,-0.422761,0.617294,-0.271752,-0.567268,0.0110821,-0.619908,-0.483543,-0.706588,-0.0100098,-0.107815,-0.366922,0.590614,-0.125717,-0.524099,-0.608565,-0.0869722,0.339361,-0.683024,-0.421169,0.289255,0.0488935,0.11972,0.0129011,0.244421,-0.621011,0.337454,-0.230975,-0.227957,-0.254865,0.0417582,-0.708084,0.419644,1.32179,-0.532935,-0.830278,-0.0122042,0.567686,-0.423319,-0.588024,0.288142,-0.233368,0.167883,0.302555,0.76599,0.453882,0.781488,0.308237,0.14495,-0.23036,-0.480727,-0.116445,0.365461,-0.360515,0.38302,0.052751,-0.414632,-0.545549,-0.165416,-0.196961,0.0195611,-0.277404,-0.0787678,0.454027,-0.499513,-0.279372,0.394194,-0.216388,0.141797,-0.21397,0.317091,0.149419,-0.116634,-0.098037,-0.658276,-0.314361,-0.0255493,-0.0866687,0.720614,-0.271018,-0.2695,0.664312,-0.112501,-0.367293,-0.0571423,0.697143,-0.335563,0.212263,-1.05991,0.23254,0.265219,-0.470581,-0.618489,-0.415683,-0.751162,0.21074,0.00215545,0.319089,-0.0457097,-0.0332791,0.51973,-0.184682,0.0820869,0.0745831,0.182648,0.68154,-0.0571491,-0.112015,0.158903,-0.113161,0.24005,-0.179568,-0.224312,0.163743,-0.0548287,-0.116723,-0.0257286,0.228636,0.258801,0.582468,-0.459266,-0.144408,-0.175525,0.214042,0.455442,-0.00469938,-0.29736,0.00897144,0.867401,-0.145439,0.161153,0.066964,0.567665,-0.602423,0.479444,-0.125835,-0.497186,-0.174693,0.163632,-0.332234,-0.0324605,-0.0211913,0.347314,-0.0436782,0.473208,0.389856,0.0494746,0.377408,-0.295915,0.219556,-0.460211,-0.207972,0.0118193,0.246737,0.00462454,-0.100119,0.431149,-0.358229,-0.071175,-0.0526974,0.173981,-0.591328,0.153077,-0.547401,0.0344261,-0.479555,0.177198,-0.0345239,-0.00669057,-0.0748773,-0.850381,0.107137,0.50237,0.0625101,-0.215702,0.246687,-0.231685,0.172258,-0.408815,0.720785,0.631525,0.285978,-0.0263361,-0.169245,0.27846,0.258251,0.342308,0.316033,-0.706799,0.355373,-0.114791,-0.476931,0.216451,-0.638421,-0.0620313,-0.339287,0.133028,0.286577,-0.820928,-0.295987,-0.00751973,-0.0808813,-0.33545,0.183959,-0.441834,-0.108525,-0.525057,0.623288,0.165488,-0.384186,-0.122084,-0.547304,-0.240882,0.239424,-0.0641158,0.419,0.521756,0.182922,0.312153,0.0174585,0.323139,-0.0592009,-0.155459,-0.477277,0.885223,0.0629503,-0.368176,0.800738,-0.0847659,0.136294,0.471943,0.282653,0.000365751,-0.083854,0.271419,0.503503,0.900432,0.185544,0.167888,-0.0652526,-0.849145,0.222148,0.0204778,-0.109345,-0.147902,0.430563,-0.0938661,0.55933,0.0893787,0.172703,0.117759,0.249196,-0.357914,-0.249696,-0.152744,0.00588035,0.147271,0.00281752,0.0650613,-0.328654,0.686535,-0.00480029,0.395171,-0.471009,-0.311071,0.152128,0.0496509,0.0175171,0.198389,0.172189,-0.168277,0.444481,0.0530262,0.137103,0.259144,0.370275,0.509062,-0.215907 +3402.47,0.453762,0.0848144,4,1.65603,0.887486,-0.20567,-0.0273137,0.250413,-0.130375,0.18047,-0.481523,0.146522,0.346789,0.402974,-0.44788,-0.169812,0.284449,-0.161859,0.698912,0.0436893,-0.151291,0.0358564,-0.077322,-0.150484,-0.824021,-0.358617,0.211009,-0.496137,-0.410224,0.0747374,0.0944378,-0.42938,0.259733,0.726323,-0.138962,0.410867,-0.152287,-0.358933,0.0681148,-0.0306913,-0.167708,0.063605,-0.787224,0.993061,0.632082,0.275514,-0.312599,-0.0530946,-0.558399,-0.256083,0.2565,0.523486,0.109109,0.118164,-0.0297501,-0.268513,-0.223501,0.78758,-0.239246,-0.483947,-1.32169,0.0313049,-0.233714,-0.264237,0.686325,-0.952007,-0.847526,-0.0619169,-0.21552,0.608068,0.215727,-0.116365,-0.899186,0.0872129,0.365124,0.638561,-0.495217,0.686749,0.781924,0.734001,0.0291281,-0.0816274,0.177936,0.395191,-0.184551,0.144814,-0.186047,-0.128895,0.198345,0.259313,0.0262513,0.105171,-0.620933,-0.0113,-0.510226,0.598171,0.359147,-0.27569,-1.11875,0.230765,-0.187549,-0.32052,0.204834,0.16662,0.0322141,-0.456206,-0.183596,0.00369119,-0.593001,-0.427024,-0.298639,0.397446,0.483876,0.2929,-0.0939949,-0.222387,0.673936,0.362457,0.214373,0.812311,0.298722,0.126659,0.340014,-0.70451,0.332658,-0.206269,-0.633826,-0.159976,0.20281,0.461962,0.116763,-0.278107,-0.447164,0.235846,0.210093,-0.157385,0.329186,-0.291505,0.0635536,-0.501217,0.0517629,0.327769,-0.5713,-0.211337,0.0458204,0.103862,-0.758306,-0.279992,0.354637,-0.145015,0.0341545,-0.0443984,-0.286304,0.122278,-0.0714872,0.104929,0.0641573,0.450529,0.855281,-0.438902,0.213671,-0.262158,-0.683614,-0.295665,0.149806,0.802511,-0.0206648,0.274351,0.30722,-0.0449156,-0.347819,-0.313358,-0.106345,-0.257916,-0.606434,0.0923062,-0.800374,-0.166399,-0.668294,0.287387,-0.0584382,0.4036,1.00938,-0.00308157,-0.230257,0.175365,-0.213242,-0.487969,-0.330049,-0.669281,-0.470964,-0.0572813,0.0109951,0.227715,0.375104,-0.38278,-0.334013,0.155088,0.0760773,0.11253,-0.405803,-0.586365,0.205979,-0.476236,-0.368715,0.0366343,-0.306874,0.220083,0.0952819,-0.337568,0.723261,-0.564768,-0.0522769,0.139033,0.0444969,-0.106201,-0.293006,-0.116235,0.28287,0.767433,-0.247993,0.585092,0.264232,-0.607391,-0.420268,0.0310995,0.0253577,-0.484855,0.638835,0.347402,0.085276,-0.226635,0.509133,-0.021239,0.392517,0.24055,-0.00725623,0.344267,0.549175,0.0752636,0.0625055,0.736019,0.106116,0.0240077,-0.233123,-0.112164,0.0229499,-0.0807914,-0.0563926,0.331217,0.513206,-0.65533,-0.152372,0.16467,-0.320271,0.205476,-0.0811111,-0.130622,-0.358262,-0.533492,0.204555,-0.219864,0.192486,0.139653,0.495475,-0.253699,0.815845,-0.623811,0.340216,-0.225359,-0.350774,0.775285,-0.0380811,0.254215,-0.469218,-0.435962,-0.286259,0.185737,-0.208338,0.0177457,0.245029,0.410282,-0.322263,0.078888,-0.422518,-0.420267,0.104417,0.177706,0.0302399,-0.139743,0.218134,-0.398385,-0.0694958,0.44177,0.371684,0.445727,0.448746,0.24517,-0.571299,0.0280035,-0.586587,0.168297,-0.648536,-0.163033,0.167489,0.144678,0.409254,0.380366,-0.577759 +3413.03,0.956745,0.0848144,4,1.66923,0.890708,-0.240997,0.0178288,0.261853,-0.203926,0.124922,-0.322899,0.137159,0.122441,0.0954656,-0.417149,0.00067646,0.278166,-0.0199448,0.752711,0.14536,-0.143611,-0.0485882,-0.018519,-0.227452,-0.764317,-0.270126,0.207161,-0.454133,-0.28782,0.137117,0.12546,-0.366622,0.240564,0.80965,-0.264393,0.167392,0.00815971,-0.436451,0.0835265,-0.289574,-0.0166848,0.230199,-0.667405,0.984803,0.318245,0.379362,-0.372062,-0.397003,-0.676593,-0.497764,0.0970717,0.36205,0.0532168,0.00610462,0.121478,-0.0552654,-0.0689616,0.706669,-0.0794433,-0.422496,-1.22174,0.320231,-0.160266,0.162851,0.330877,-0.83889,-0.898809,-0.226845,-0.156673,0.682914,-0.0190839,-0.189071,-0.616282,0.0921151,0.438392,0.841695,-0.608039,0.251296,0.452939,0.467108,-0.0367134,-0.227386,0.204714,0.219957,-0.398641,0.090778,-0.0207045,-0.157605,-0.104206,-0.0131043,0.269082,-0.0200409,-0.37338,0.130098,-0.500582,0.407835,0.374614,-0.0529935,-1.06019,0.172113,-0.035449,0.0270949,0.284024,0.186553,-0.0341559,-0.405787,-0.411377,-0.367297,-0.568013,-0.743863,-0.460292,0.501547,0.441514,0.318906,-0.303196,-0.336505,0.462457,0.252698,0.301565,0.587178,0.460136,0.0319825,0.178643,-0.870966,0.232686,-0.169889,-0.69989,-0.0235652,0.296851,0.401478,0.28735,-0.217684,-0.406542,0.413088,0.0991288,-0.0278813,0.188996,-0.465541,0.000347955,-0.107738,0.116533,0.122492,-0.64907,-0.298883,-0.13931,-0.0838741,-0.633027,-0.245871,0.282277,0.302689,-0.0325152,-0.150965,-0.445517,-0.127931,-0.037944,0.0443664,0.414655,0.198552,0.85445,-0.438012,0.0503829,-0.297969,-0.324222,-0.342723,0.285879,0.560703,-0.144602,0.335511,0.276295,-0.0268891,-0.200073,-0.279058,-0.0575262,-0.345056,-0.627908,0.306932,-0.928178,-0.0788418,-0.296279,0.295959,-0.371116,0.398802,0.794684,0.311112,0.00326584,0.568246,-0.146605,-0.16628,-0.610206,-0.888454,-0.577793,0.12631,-0.157568,0.0189444,0.204514,-0.303883,-0.504777,0.0924207,0.332549,0.0252059,-0.541327,-0.659789,0.181441,-0.282486,-0.192751,-0.131169,-0.318939,0.297472,0.205763,-0.505806,0.629494,-0.477011,0.213773,0.285112,-0.0670197,-0.247974,-0.153667,-0.2007,0.02269,0.405294,-0.152219,0.626212,0.339372,-0.43396,-0.549118,-0.090638,0.0292513,-0.447298,0.425945,0.179166,0.00660009,-0.104974,0.745567,-0.0476217,0.301547,0.258577,-0.110604,-0.0316901,0.729444,-0.118524,-0.149666,0.620224,0.185761,-0.23624,0.0496078,-0.0683419,-0.0862859,-0.17199,0.00215145,0.177005,0.567563,-0.781538,-0.101819,0.172057,-0.624892,-0.0212382,0.0756302,-0.100743,-0.346134,-0.350853,0.191358,-0.383864,0.0716087,-0.033388,0.699589,-0.10444,0.645838,-0.611793,0.125395,-0.131214,-0.391487,0.809905,-0.0018312,0.239892,-0.62325,-0.848415,-0.497314,0.210885,-0.144275,0.124821,0.221596,0.399981,-0.199331,0.221308,-0.27481,-0.123372,0.0438703,0.413233,0.0742635,-0.232679,0.170193,-0.0306814,0.0447412,0.436243,0.369664,0.462677,0.521706,0.578714,-0.627203,-0.1059,-0.658568,-0.0696603,-0.748376,-0.106823,0.160581,0.155108,0.400726,0.393838,-0.614095 +3423.08,0.968479,0.0848144,4,1.60717,0.9553,-0.541751,0.131413,0.820255,-0.12641,-0.0935693,0.0118522,0.177448,0.235566,0.448872,-0.135018,0.251911,-0.0368706,-0.233761,1.02234,0.224536,-0.0287341,-0.0444956,-0.121062,-0.296429,-0.638222,-0.671223,0.432268,0.0842106,0.0420319,0.401969,0.488192,-0.421716,0.0911901,0.626254,-0.714647,-0.0148744,0.0889815,0.0860244,0.161469,-0.064721,0.447692,0.413937,-0.446354,0.924441,0.0428379,-0.112584,-0.0505248,0.0179664,0.442538,-0.600956,0.0620471,0.458609,0.0507554,0.161262,-0.105638,-0.138928,-0.850612,0.716734,-0.288172,-0.113002,-0.719828,-0.120319,-0.517079,0.100635,0.964015,-0.60832,-0.262619,0.142548,0.130577,0.317886,-0.0861054,0.0328034,-0.750403,-0.138356,-0.725651,0.53094,-0.168699,0.716972,-0.203658,0.523877,0.354547,0.0200914,0.231188,0.546792,0.00887482,-0.166584,-0.0855788,-0.3934,-0.050769,-0.415998,-0.059203,-0.297918,-0.614902,-0.428705,-0.207062,0.102374,0.0950935,-0.309784,-0.732425,0.192006,-0.120158,-0.0837911,-0.113516,0.415283,0.250627,-0.954917,-0.424515,0.299959,0.108982,-0.0636495,-0.47824,0.0316026,0.51656,0.418466,0.171571,-0.652738,0.636036,-0.499817,-0.304846,-0.169464,0.34588,0.353742,-0.0563844,-0.0154925,-0.0316639,-0.282278,-0.186261,0.143633,0.359739,0.238603,0.286291,-0.070872,-0.500506,-0.214172,-0.258629,0.000884492,0.522747,-0.414167,-0.338719,-0.23517,-0.285522,0.525368,-0.312032,-0.582895,-0.334793,-0.344131,-0.208681,-0.448197,-0.41828,-0.259028,0.379725,-0.47791,0.120866,0.108595,0.0573078,0.0511966,-0.470719,-0.164844,0.0671326,0.273369,-0.226184,0.284103,0.215366,0.366197,-0.34853,0.521652,-0.163389,-0.117474,0.363211,0.112651,-0.621251,0.0155174,0.735984,0.639115,-0.892333,0.0190117,-0.381263,0.290523,0.570197,0.0919383,-0.0519026,-0.295909,0.979703,0.132542,-0.166563,0.368324,0.0703627,-0.228215,0.193505,-0.470031,-0.714799,0.0867751,-0.683994,0.125449,-0.307036,-0.340642,-0.595123,-0.365562,0.398295,-0.0735808,-0.558557,-1.07021,-0.165641,-0.293719,0.0149161,0.622956,-0.172405,-0.492517,0.254249,-0.581466,0.949201,-0.403177,-0.0918527,0.0297537,-0.275,-0.180744,0.25555,0.0982231,0.64197,-0.390316,0.465211,-0.056671,-0.132994,-0.224636,-0.560116,0.174544,0.534742,-0.549079,0.129783,-0.419213,-0.216084,0.0782411,0.390892,-0.398017,0.122507,-0.191403,-0.0193076,-0.329321,0.855119,0.364699,-0.0159299,0.600227,-0.452538,-0.114576,-0.276452,-0.4704,0.175265,-0.197356,0.414107,0.0419691,0.364729,-0.296084,-0.127329,-0.558659,-0.552612,0.329356,-0.240564,-0.0937239,0.145274,-0.33362,0.0291421,-0.482263,-0.320973,-0.321891,0.354092,-0.0377884,-0.241563,-0.0587982,0.0915961,0.161392,-0.832305,-0.0353702,0.417252,0.047522,-0.546833,-0.231221,0.357189,-0.0505474,-0.185802,-0.0417639,0.123962,0.333381,0.119102,0.780319,-0.101849,0.05187,-0.150535,-0.165414,0.483173,-0.373675,0.332853,0.0157883,0.0894774,0.126343,-0.39688,0.11762,0.163352,0.510613,-0.828041,-0.640945,-0.39545,-0.342151,-0.130549,0.223485,0.117517,0.188979,0.342807,0.434717,-2.6132 +3430.78,0.99927,0.0848144,4,1.5996,1.0763,-0.691208,0.142524,0.63179,-0.181184,0.247276,0.127563,0.022729,0.490733,-0.121312,-0.147842,0.299532,0.161024,-0.0900303,0.780001,0.219224,0.0426793,-0.371587,-0.450261,-0.625943,-1.07994,-0.529409,-0.0110773,-0.351823,0.00413729,0.25883,0.630742,-0.70516,0.217931,0.510202,-0.224372,0.148264,-0.0557224,-0.0815744,0.336318,0.599488,0.212787,0.373629,-0.295755,0.798066,0.36748,0.296186,-0.247247,0.122751,0.30134,-0.263864,0.0343578,0.453226,0.0270164,0.105681,-0.113314,0.20175,-0.292396,0.496426,-0.172246,-0.427095,-0.740485,0.124868,-0.399544,0.709879,0.653841,-0.717761,-0.342857,0.0846045,0.355734,0.33826,-0.193921,-0.0124758,-0.661301,0.119544,-0.357965,0.436261,-0.325983,0.695446,-0.0847195,0.479972,0.159559,-0.327684,-0.0414627,0.349169,-0.215079,-0.39132,-0.166494,-0.53015,-0.049228,0.284974,0.155071,-0.424517,-0.377207,-0.589646,-0.126115,-0.0752644,0.292988,-0.443707,-0.794587,0.1559,-0.527084,-0.388129,-0.248929,0.00982742,0.105745,-0.774848,-0.0651723,0.0666047,-0.225823,0.0583751,-0.484253,0.2987,0.721745,0.71577,0.34118,-0.285149,0.400942,0.000167759,-0.347686,0.01509,0.680324,0.355589,0.0311262,-0.418806,-0.217915,0.139067,0.17196,0.1984,0.624104,0.470132,0.272293,-0.106485,-0.459742,-0.13641,-0.0537282,0.0848427,0.0903976,-0.286869,-0.176842,-0.100368,-0.207103,0.541239,-0.133018,-0.365787,-0.328122,-0.349926,-0.165187,-0.0463835,-0.0798046,-0.056425,0.358099,-0.398348,-0.114675,-0.338573,0.269712,-0.00472282,-0.287813,-0.293381,0.221242,0.707357,-0.476035,0.0783965,0.348758,0.207229,-0.541957,0.426269,-0.0373158,0.24302,0.57417,-0.0308739,-0.522335,-0.155009,1.11511,0.0325965,-0.774207,0.196651,-0.546138,0.152724,0.107405,-0.107818,0.0709502,-0.114936,0.686342,0.296867,-0.313155,0.683331,0.0145507,-0.317869,-0.0226127,-0.22793,-0.513896,0.188196,-0.586653,-0.0407253,0.00219516,-0.482037,-0.876579,-0.437009,0.0839228,0.284117,-0.0201556,-0.583899,-0.0763052,-0.270813,0.0545444,0.410623,-0.133645,0.0679139,0.0635887,-0.393562,0.916487,-0.576718,0.39944,-0.348202,-0.337387,-0.226012,0.00699056,0.435385,0.310291,-0.683996,0.394256,0.129871,-0.482477,-0.161304,-0.73438,0.173329,0.311243,-0.669895,0.247728,-0.481787,-0.31402,-0.0283186,0.101239,-0.436032,0.31626,-0.468272,0.0310507,-0.331646,1.05102,0.447496,-0.358566,0.802988,-0.166542,-0.36662,0.05954,-0.238705,-0.23256,0.271918,0.493259,0.339253,-0.0590604,-0.347687,0.0152353,-0.334262,-0.182638,0.0710593,-0.359493,-0.306745,0.0846713,-0.113269,0.302027,-0.108942,-0.323675,-0.197255,0.415285,-0.0236102,0.201272,-0.066825,0.422405,-0.19691,-0.68284,-0.166181,0.490879,0.189875,-0.378324,-0.924184,0.39261,-0.134381,-0.0891997,0.0821692,0.0256982,0.304405,-0.195448,0.0754925,-0.158055,-0.353565,0.220484,-0.232388,0.248944,-0.337945,0.35092,0.202161,-0.204446,0.162584,-0.309777,-0.0520931,0.44139,0.441342,-0.71062,-0.306987,-0.322339,-0.25208,-0.332934,-0.082024,0.170068,0.142983,0.412393,0.378131,-2.12736 +3431.39,0.995766,0.0848144,4,1.55487,1.16562,-0.201878,-0.122063,0.638436,0.0164922,0.0187566,-0.148927,0.575719,-0.108151,-0.099116,-0.334523,0.373807,-0.110508,-0.0734387,0.955277,-0.325725,-0.356214,0.153496,-0.193813,-1.00227,-0.642611,-0.753431,0.0922093,-0.144442,-0.036493,-0.193388,0.148395,-0.339211,-0.253863,0.357141,0.0489187,0.0191231,-0.298965,-0.254497,0.00467236,-0.274157,0.14973,0.340642,-0.0742072,1.05046,0.466179,0.29214,-0.405304,0.0641713,0.211465,-0.228269,-0.26747,0.456141,0.021011,-0.122396,0.453423,-0.155701,-0.474573,0.917151,-0.0951165,0.543693,-1.05992,0.0490643,-0.506197,0.322706,0.689633,-0.499979,-0.923721,-0.0526241,0.291407,-0.111852,-0.511908,0.474472,-0.510379,0.202774,-0.0218947,0.658019,-0.562721,0.735193,0.365673,0.211722,-0.118803,0.0110356,0.53,0.241224,-0.204025,-0.0361444,0.192469,-0.621921,0.00764153,0.118794,0.25539,0.0369168,-0.266772,-0.424309,0.318999,0.181123,0.488194,-0.562039,-0.3554,0.191984,-0.0826507,-0.231954,0.148672,-0.156451,0.0439581,-0.236516,-0.20229,0.0495812,-0.47417,0.392834,0.0311748,0.277362,0.896428,-0.225404,-0.0285362,0.0101278,0.623203,-0.430147,-0.0398492,-0.360834,0.296317,0.453594,0.0133671,0.0514972,0.490864,-0.514986,-0.263166,-0.512708,0.768566,0.0176878,-0.102018,0.250477,-0.278432,-0.435041,0.0662005,-0.369822,0.338655,0.199602,0.0040421,-0.1208,-0.206454,0.444293,-0.501289,-0.0568675,-0.512911,0.689681,-0.146609,-0.0781912,0.533061,0.0680745,0.454056,0.0791965,-0.147991,0.295013,0.356805,0.118709,0.0507747,0.494935,-0.12497,0.371091,-0.270294,-0.0873035,0.60282,0.00235485,0.24247,0.611483,-0.0306014,-0.00769157,0.67227,-0.0855421,0.254933,0.0860903,-0.165675,0.18218,-0.105633,0.0153752,0.210363,-0.178924,0.706554,0.108126,0.0506444,-0.245052,0.95407,-0.32631,-0.102182,0.681204,0.0286484,0.544623,0.0197497,-0.524021,-0.459013,-0.0209865,-1.04197,0.0222008,0.379072,-0.549969,-0.307084,0.100271,0.00735313,-0.162987,-0.273727,-1.14512,0.218474,-0.399429,0.00303259,0.433497,-0.149304,-0.0741818,0.593338,-0.29677,1.07621,-0.063239,0.134272,0.368416,-0.32428,0.171875,0.372312,0.00623291,-0.0927926,-0.537168,0.385213,0.270479,-0.275812,0.0643894,-0.393408,-0.0779775,0.269806,-0.0971836,0.43981,-0.108886,-0.125378,-0.0799699,0.373461,-0.160729,0.0336572,-0.28176,-0.450823,0.341529,1.00087,0.479291,-0.71069,0.800261,-0.357489,-0.457604,-0.296774,0.0505013,0.446039,0.843185,0.550112,-0.0586752,0.119269,0.00613447,-0.694643,-0.166738,-0.783547,0.459977,0.00152817,-0.459415,0.525352,-0.0555589,-0.133184,-0.139484,-0.305704,-0.171493,-0.23961,0.21201,0.0927726,0.129541,-0.196049,0.245896,-0.642255,-0.015647,0.335613,-0.347928,-0.203901,-0.202584,-0.00398362,0.140986,-0.0638756,0.209888,-0.234162,0.308335,0.259724,-0.233499,-0.21904,-0.12156,0.00770207,0.159586,0.691367,-0.364387,0.797447,0.0362235,-0.331332,0.102717,0.388141,0.165016,0.45334,0.306733,-1.17514,-0.348102,0.0609383,0.0662588,-0.553531,-0.404418,0.142468,0.192449,0.37745,0.438691,-2.40765 +3420.56,0.797115,0.0848144,5,1.63065,0.933268,-0.455205,0.103191,0.528233,-0.171429,0.198757,0.0467174,0.614422,0.380529,0.0937513,-0.263164,-0.272987,0.159404,-0.369413,1.14762,-0.203291,-0.086532,-0.105911,0.088852,-0.666788,-1.01804,-1.04501,0.342102,-0.756327,-0.214731,0.298308,0.321069,-0.48107,0.457553,0.593322,-0.256028,0.253935,0.245257,0.240865,0.188937,-0.524989,0.459246,0.000734059,-0.452645,0.443192,0.157529,-0.139888,-0.805954,0.0421929,-0.564788,-1.22995,0.0744664,0.420095,-0.0610566,-0.218954,-0.376935,0.231666,-0.661755,0.987965,-0.328109,-0.453163,-0.447324,0.262668,-0.688598,0.644604,0.266605,-0.831429,-0.947785,-0.0433074,-0.110688,-0.394964,-0.195019,0.0414511,-0.470931,-0.128908,0.459204,0.279919,0.0435533,0.0782993,0.765384,0.371417,0.312737,-0.405431,0.0306731,0.526058,-0.370258,-0.118175,0.262062,0.0679488,-0.280427,-0.0398723,-0.80694,-0.198057,-0.15109,-0.349455,-0.394025,-0.147106,-0.353698,0.077948,0.123925,-0.249673,-0.381826,-0.00771378,0.670745,0.10566,-0.633348,0.124892,-0.171744,0.595408,-0.293698,0.254514,-0.646281,0.337602,0.655535,-0.152236,0.137338,0.600773,0.0985454,0.396669,-0.0990446,-0.33928,0.429972,0.403469,-0.805706,-0.849786,-0.209709,-0.14035,-0.10005,0.38554,-0.0799842,-0.0204719,0.10679,-0.346599,-0.247635,0.405614,-0.288089,-0.349001,0.339516,-0.478304,-0.298622,-0.132295,-0.174792,0.712974,-0.371996,-0.44634,-0.0403131,-0.0788728,-0.986174,0.20372,0.21663,0.222228,-0.420722,-0.0373632,-0.263541,-0.385116,0.199463,-0.0811411,-0.408074,-0.207682,0.776107,0.292987,0.0104448,0.705715,-0.406462,0.121035,-0.112037,0.451835,-0.359046,0.138165,-0.322642,0.0946093,-0.615729,0.0474603,-0.10131,0.165554,-0.052291,-0.0954559,-0.053069,-0.389792,-0.828158,0.111763,0.178383,0.060561,1.08549,0.383734,0.0372436,-0.322061,0.153785,-0.178198,-0.49387,0.232357,-0.506275,0.395519,-0.121573,-0.148966,0.0120089,0.0863432,-0.442773,-0.00860349,0.076945,-0.123642,0.101487,-0.538752,0.447643,-0.188336,-0.0640526,-0.0370302,-0.0965807,0.332425,-0.435145,-0.595112,1.05811,-0.126699,0.180346,0.0324057,-0.403629,-0.100087,0.16112,-0.594931,0.81124,-0.00422147,0.563944,0.236313,0.101749,0.146604,-1.12155,0.332453,0.639009,-0.698663,0.560999,-0.625941,0.024909,0.115055,-0.195084,0.120082,0.00579042,-0.647005,-0.374027,-0.905351,0.514233,0.149523,-0.196626,0.818886,-0.611413,-0.154971,0.569871,-0.397848,-0.0504229,-0.431599,-0.0342554,0.281362,0.0669006,-0.342307,0.0361052,0.262571,-0.22474,0.505319,-0.156874,-0.554967,-0.32275,-0.0415355,-0.197519,0.897039,-0.105655,-0.0990934,0.889679,0.254197,-0.126347,0.362558,0.13559,0.0150429,0.119969,-0.318264,-0.101548,-0.129101,-0.107826,-0.832961,0.102164,0.147729,0.377893,0.388382,0.194707,-0.0319483,-0.398601,-0.0824117,-0.266885,-0.432806,0.131811,0.0372124,-0.0752219,0.563352,0.090003,0.225458,0.0228416,-0.0908708,-0.213573,-0.401567,0.34891,0.0700054,0.0501944,-0.567505,-0.116111,0.0737573,0.542894,-0.16093,0.14895,0.23977,0.38594,0.489664,-1.58878 +3383.94,0.955467,0.0848144,4,1.63751,1.0732,-0.263007,0.0152146,0.253362,-0.177427,-0.057503,0.186335,0.843179,0.350516,-0.0356235,0.00690077,-0.108571,0.203175,-0.20927,0.683472,-0.0444656,0.0499891,-0.181748,-0.121317,-0.519386,-0.676449,-0.618587,0.0590054,-0.186882,-0.0832197,0.143107,0.437675,0.0710912,-0.0737007,0.528385,-0.952547,0.357166,0.136767,-0.521136,-0.261568,-0.345165,0.236641,0.073389,-0.624644,0.662099,0.630819,-0.289874,-0.579651,-0.0554569,-0.543846,-1.20933,0.156357,0.285058,0.177278,0.145264,-0.0310204,-0.107979,-1.30529,0.75101,-0.235841,0.136151,-0.511408,0.344164,-0.51165,-0.164155,0.428328,-0.178346,-1.30259,-0.19971,-0.35791,-0.149902,-1.07735,0.02532,-0.681415,0.0863266,0.0815135,0.55233,0.209168,0.906355,0.26907,0.0200455,-0.250883,0.0274733,0.28744,0.30941,-0.707886,-0.238434,0.337995,-0.274349,-0.445418,0.332035,-0.020091,-0.190549,-0.165554,0.160907,0.181508,-0.0371288,-0.172914,-0.245021,0.118118,-0.401438,0.0437475,-0.10844,0.299645,0.51927,0.174275,-0.402559,0.0230391,-0.142986,-0.337306,-0.166898,-0.507105,0.0624738,0.440224,0.574915,-0.0438462,0.186985,0.455542,-0.377538,0.038067,-0.668293,-0.262264,-0.0438399,0.191307,-1.48993,-0.448728,0.412875,-0.57948,0.0850205,0.309095,0.0163432,0.088396,0.218223,-0.756752,-0.188494,-0.0253905,-0.125365,0.060509,0.462754,0.0306244,-0.259369,0.147111,0.34785,-0.725778,0.343168,-0.335629,0.349023,-0.772614,-0.332661,0.419244,-0.0437964,0.0579864,0.113868,0.0645069,0.114488,-0.0719842,0.243203,-0.0845888,0.373089,0.792431,0.48493,0.0644887,0.426262,-0.581911,1.10895,0.343445,0.382857,-0.226307,-0.0473773,0.271108,0.00156377,-0.453954,-0.124866,0.0331256,0.173285,-0.217785,-0.206356,0.494762,-0.0177689,0.278773,-0.552202,-0.0699484,0.223615,1.10522,0.320257,0.0860215,0.22823,-0.322677,-0.350762,0.0198541,-0.853118,-0.274247,-0.4731,-0.421938,0.191214,0.222361,-0.162171,-0.722895,-0.160627,-0.263538,-0.304559,-0.265713,-0.907836,-0.304782,-0.218654,-0.143024,0.333071,-0.111318,-0.244266,-0.820548,-0.613544,0.882652,0.0280885,0.0234346,-0.341401,-0.0467636,0.255524,-0.464194,-0.79975,0.508253,-0.341803,-0.211675,-0.113572,0.144379,0.219348,-1.55151,-0.624975,0.847176,-0.800252,0.216853,-0.230118,-0.227664,0.0583459,-0.424783,0.0271343,-0.0598372,-0.285716,0.162007,-0.708751,0.43955,-0.598718,-0.427351,1.17451,-0.767014,-0.690334,0.545602,0.473583,0.65775,-0.266004,0.0010405,0.238265,-0.0901635,-0.506569,-0.146677,0.556108,-0.364741,0.294812,-0.515973,0.0243698,-0.09861,0.24217,-0.0993902,0.143246,0.0266451,0.200347,-0.266135,-0.0697716,0.13,0.0400974,0.0917741,0.235458,-0.00642625,0.444393,0.216248,-0.190264,-0.413865,-0.378595,0.451714,0.0620496,0.85417,0.464328,-0.0615356,0.323867,0.399076,-0.490033,-0.357306,-0.469069,0.617844,0.0527082,0.642577,-0.652769,0.418042,-0.141889,0.237426,-0.00286291,0.26191,-0.0850539,0.0972738,0.174007,0.282779,-0.419595,0.908407,-0.875362,0.124344,0.443064,0.190415,0.313105,0.436366,0.559558,-0.932841 +3375.39,0.94667,0.0848144,4,1.72201,0.948079,-0.381307,0.0842522,0.471293,-0.145559,-0.201842,0.28401,0.513365,0.635024,0.04894,0.328823,-0.302804,0.263157,-0.220885,0.598144,-0.00803762,-0.155022,-0.0847025,-0.353038,-0.520928,-0.546396,-0.552189,0.209461,-0.203844,-0.217317,-0.123914,0.636926,0.0119334,-0.0638976,0.337666,-0.771425,0.484275,0.263596,0.0245863,0.0743564,-0.503979,0.15775,-0.0676505,-0.952952,0.563569,0.641274,-0.468698,-0.826046,0.280315,-0.106666,-1.27127,-0.0703091,0.429633,0.1252,-0.0116783,0.113846,-0.184718,-1.3443,0.774518,-0.531365,-0.0224523,-0.407467,0.361274,-0.258625,-0.313571,-0.0172967,-0.502472,-0.941547,-0.440248,-0.341838,-0.0994922,-0.778939,0.0881448,-0.608044,-0.0341192,0.172915,0.640981,-0.106587,1.15692,0.483085,0.0833572,0.0499389,0.250724,0.0153201,0.264807,-0.525797,-0.0324307,0.488446,-0.347383,-0.639507,0.113933,0.113654,0.0661848,0.0596814,0.0277009,0.0658386,-0.115767,-0.0897687,0.0488737,0.0402249,-0.546919,-0.100812,0.132816,0.363744,0.00374801,0.204398,-0.604365,-0.280054,-0.233947,-0.501615,-0.196003,0.157048,0.00038521,0.797849,0.241486,0.113912,0.405417,0.207315,-0.277244,-0.361217,-0.60895,0.00149788,0.113521,0.165589,-0.988887,-0.769738,0.524106,-0.0572148,-0.0580195,0.215614,-0.0279802,0.151673,-0.107575,-0.879764,-0.25348,-0.14873,0.087023,0.337705,0.250881,-0.222378,-0.165923,0.387739,0.384048,-0.521906,0.476406,-0.461169,0.503299,-0.757074,-0.11972,-0.300358,0.0666487,0.0920805,-0.15408,-0.215521,-0.0951212,-0.162878,0.265166,-0.18244,0.28414,0.646678,0.160396,0.511754,0.127129,-0.22851,1.36245,0.604886,0.363758,-0.160612,-0.133847,-0.0731861,-0.10117,-0.773785,-0.058504,0.010989,0.0651107,-0.591487,-0.181825,0.432457,-0.10675,-0.0410408,-0.244696,-0.172666,0.0797924,0.788332,0.106848,0.313304,0.409503,-0.180095,-0.643314,0.0942622,-1.19212,-0.118023,-0.298862,-0.640926,0.0216297,0.153922,-0.102976,-0.533379,0.0193392,-0.118447,-0.182139,-0.25757,-1.22438,-0.388881,-0.370054,-0.0888165,-0.285439,-0.135387,-0.18648,-0.450024,-0.378967,1.02786,-0.161587,0.453273,-0.212357,-0.392917,0.214567,0.140481,-0.758358,0.762434,-0.0144005,0.168711,0.0390652,0.404124,-0.163659,-0.948058,-0.169672,0.809749,-1.0961,0.331522,-0.267858,-0.171407,0.62477,-0.57307,0.280889,0.335812,0.0702325,-0.166863,-0.871386,0.388042,0.0290917,-0.287402,1.14764,-0.872923,-0.103567,0.515763,0.692923,0.79913,-0.256067,-0.375908,0.210355,-0.323142,-0.637703,-0.342353,0.294661,0.00854789,-0.0840387,-0.798718,0.230971,-0.0690197,-0.0158601,-0.13365,0.127525,0.196393,-0.390936,0.304111,-0.0977338,0.021735,0.264948,0.487213,0.428016,-0.0938896,0.332936,-0.262146,-0.307958,-0.324373,-0.180724,0.286529,-0.0111983,0.580956,0.707995,0.110285,-0.167271,0.312974,0.105722,-0.485354,-0.461626,-0.114981,0.0939698,0.513016,-0.758796,0.577545,-0.0824847,-0.143196,-0.0141968,0.349523,0.251366,0.024913,0.106942,-0.0624079,-0.144091,0.869056,-0.69693,0.0328759,-0.171176,0.162631,0.23703,0.403275,0.486857,-1.36191 +3408.87,0.995552,0.0848144,5,1.4444,1.11603,-0.279959,0.125447,0.936791,-0.102156,0.615652,-0.290517,0.722018,0.457832,-0.0774527,0.113745,0.599695,0.053292,-0.0972081,1.56442,-0.153611,0.346432,0.00122673,-0.0927344,-0.263769,-0.9708,-0.69477,0.209037,0.188294,0.492453,0.749622,0.286683,-0.363708,0.597243,0.956581,0.104473,-0.153479,0.232375,0.288098,-0.396869,-0.131234,0.421822,0.540687,-0.407092,0.811367,0.208959,0.309603,-0.155476,-0.294408,-0.0296234,-0.19583,0.17634,0.438186,-0.0747867,-0.1061,-0.273945,0.306798,0.343687,0.83854,-0.17066,0.0211537,-1.56801,0.545626,-0.760289,0.36943,0.893527,-0.184181,-1.31074,-0.0330198,0.110627,0.307548,0.160865,-0.195128,-0.199267,-0.469757,0.1306,0.633829,-0.0635869,-0.100164,0.44369,0.239798,0.0679765,-0.763873,0.0580328,0.793366,-0.223096,0.106815,-0.630128,0.310119,0.0809946,0.375635,-0.47186,-0.168434,-0.634548,0.223829,0.0841904,0.243045,-0.181502,0.0686724,-0.752272,0.495531,-0.211819,0.476211,0.266347,0.0900538,-0.0976149,-0.0100259,-0.405793,-0.0119746,0.0236284,0.352842,-0.735624,0.313136,0.179443,0.028808,-0.791619,-0.342536,0.0754726,0.458095,0.247998,0.380451,0.0860033,0.592054,-0.32624,-0.479621,-0.0721207,-0.134656,-0.26686,0.0660124,0.813065,0.418793,-0.223501,0.487266,-0.472786,0.0573627,0.219027,0.351289,0.61129,-0.497224,-0.0895933,-0.13708,-0.692674,0.347256,-0.0155313,-0.955721,-0.116884,-0.555101,-0.166839,0.263323,0.0353654,-0.475355,0.40841,0.0225659,-0.414578,-0.36642,0.486853,-0.263764,0.0472647,0.073655,0.222766,0.163962,0.0577442,0.137269,-0.0803738,-0.331755,-0.561878,1.01592,0.28212,0.182747,0.226006,-0.0188362,0.434043,-0.229654,-0.169285,-0.196558,0.33753,-0.0364516,-0.31376,-0.305294,-0.089805,-0.288721,0.195139,0.237742,0.725503,-0.211981,-0.399181,-0.0503448,0.153483,0.0598099,-0.494409,0.0437458,-0.514838,0.179921,-0.495711,0.148589,-0.0418411,0.154297,-0.417348,0.0388512,0.49724,0.235946,-0.204636,-0.313851,0.224834,-0.0938356,-0.722049,0.36876,-0.349023,0.624935,0.132667,-0.522511,0.82927,0.071566,0.216729,0.312856,-0.16703,-0.150567,0.114589,0.25826,-0.190361,-0.513227,0.263439,0.0685191,-0.6618,0.22976,0.134986,-0.289915,-0.000680441,-0.173517,0.405188,-0.165116,-0.273562,0.0215735,0.0953812,-0.18133,-0.239773,-0.221833,-0.431631,0.741434,0.477892,0.0137174,0.101345,0.143921,-0.231781,-0.312603,0.221809,-0.181138,-0.607772,1.03225,0.196941,0.642113,0.231755,0.290617,-0.0719149,0.0186244,-1.08088,0.835183,0.225868,-0.484889,0.575866,-0.4716,-0.0723606,0.230234,-0.410588,0.553946,0.391786,-0.134823,0.585839,0.136944,-0.404961,-0.284477,-0.0564703,-0.258928,0.428541,-0.26814,-0.139232,-0.371984,0.08532,0.23622,0.263163,-0.37414,0.243504,0.614381,-0.410397,-0.215395,0.181614,-0.475754,0.164533,-0.096289,-0.253776,0.515855,0.237598,-0.0830039,-0.126904,-0.0345732,-0.415714,-0.394763,0.837548,-0.375905,-0.480522,0.0611625,-0.586097,0.00614171,-0.581823,0.0884101,0.131624,0.351182,0.362801,0.592606,-3.58496 +3422.81,0.832423,0.0848144,5,1.55469,0.906747,-0.638695,0.204891,0.97648,-0.039721,-0.268801,0.241607,0.812222,0.221167,0.0683482,-0.362864,-0.0669842,0.260302,-0.126077,0.669826,0.316946,0.0811103,0.512392,-0.310706,-0.351095,-0.797427,-0.634776,0.130847,0.0466938,-0.109022,-0.00288551,0.529202,0.130273,0.450559,0.94628,-0.90539,0.543564,0.3523,0.0196752,-0.52132,0.358866,0.28659,0.712949,-0.525989,0.891858,0.0317318,-0.0781347,-0.0393608,0.0140304,-0.289788,-1.02805,-0.303193,0.450727,0.166191,-0.0493575,0.591858,0.34521,-0.342829,0.804525,-0.461086,-0.0533499,-0.756272,0.853902,-0.45892,-0.539848,1.12656,-0.554737,-0.597524,-0.216915,-0.0727669,-0.0833701,-0.287303,0.445728,-0.306857,0.185886,0.130123,0.53401,0.00638833,0.793582,0.364866,0.156404,-0.281017,0.159247,0.0365734,0.211227,0.0853011,0.117988,-0.379548,-0.519919,-0.120564,0.157178,-0.114604,0.025244,-0.299681,-0.236421,0.576961,0.189011,0.462489,0.573189,-0.437254,-0.279433,-0.0628549,0.143103,0.315375,0.343233,0.348129,-0.895747,0.0128596,0.0420409,-0.322822,-0.21202,0.0647372,0.71687,0.539533,-0.11883,0.136445,-0.171467,0.505804,-0.462092,-0.0867648,-0.160444,-0.0900731,-0.321418,0.502443,-0.670963,0.0661428,-0.0365407,-0.00302243,-0.321779,-0.402132,-0.363034,0.251921,0.0745868,-0.19625,-0.274945,-0.120412,-0.271031,0.243624,-0.238618,-0.309596,-0.149967,0.334251,0.680729,-0.145377,0.0790379,-0.196277,0.202997,-0.241433,-0.131493,0.645227,-0.166617,-0.190747,-0.396402,0.177974,-0.459243,0.020934,0.13096,0.125165,0.114125,-0.000161006,0.312413,0.167755,-0.0188369,0.633848,0.639237,-0.0790724,0.723301,0.499064,-0.45696,-0.147631,-0.315166,-0.433185,0.26119,0.0350999,0.0592422,-0.231297,-0.0962726,0.17598,-0.304648,0.381775,-0.660646,-0.257756,0.274857,0.305519,0.193782,-0.0114166,0.500306,0.293386,0.141463,0.0252843,-0.692526,0.0380636,0.1007,-0.462134,-0.174747,0.0186826,0.0219927,-0.321711,-0.0719689,0.0156973,-0.0763712,0.067251,-0.340756,0.353599,-0.0277428,0.174306,-0.0847753,0.0773792,-0.193241,0.120152,-0.804325,0.751897,-0.329582,0.308602,-0.108584,0.217474,0.880246,-0.267679,-0.532201,0.368904,0.377419,0.00151162,0.447525,0.128486,-0.475522,-0.842869,0.336733,0.237728,-0.22094,0.148076,-0.374497,0.121265,-0.3289,-0.442877,-0.355149,0.348553,0.248238,-0.348853,-0.694745,0.103484,0.296741,0.269901,0.39789,-0.314005,-0.178504,0.0085213,0.242405,0.667555,-0.515264,-0.0076678,0.294646,0.140851,-0.624747,-0.45945,-0.415115,-0.140287,0.0320696,-0.502274,-0.00637572,0.159793,-0.0225144,-0.0238354,0.219074,0.495389,-0.408235,0.16605,-0.151413,-0.273218,-0.182493,0.0597953,-0.0509717,-0.407812,0.272995,-0.501152,-0.0450286,0.175086,-0.267617,-0.118766,-0.0830303,-0.0539301,0.221247,0.235921,0.216774,-0.336543,0.488787,-0.613956,-0.0589773,-0.0756574,-0.168824,0.404062,-0.787639,-0.206326,-0.0470109,-0.846241,0.0355419,0.491751,0.722875,0.0145561,-0.226868,-0.218202,-0.052675,0.321721,-0.159739,0.326285,-0.390164,0.107402,0.210624,0.327722,0.458937,-3.1389 +3469.99,0.909059,0.0848144,4,1.62034,0.868358,-0.635257,0.223691,1.01559,-0.136424,-0.0481253,0.126117,0.43544,0.433406,0.0285123,-0.240975,0.380562,0.437772,0.0808878,0.597289,0.170748,0.000495981,0.385025,-0.2522,-0.164946,-0.525942,-0.741748,0.201939,-0.169988,0.101254,-0.0706298,0.524808,-0.437395,0.39172,0.89663,-0.830381,0.136973,0.35982,0.152933,-0.642078,0.253749,0.469597,0.642377,-0.301687,0.827857,0.190839,-0.079232,-0.470456,-0.300193,-0.58395,-0.586532,-0.254212,0.387038,0.0607286,-0.317362,0.615905,0.077685,0.0495515,0.889851,-0.570324,-0.0246985,-0.741016,0.776901,-0.0327332,-0.095326,0.848251,-0.766951,-0.649102,-0.486682,-0.0442142,-0.169361,0.112295,0.0763224,-0.395088,-0.0206273,-0.00780304,0.3481,-0.0925808,0.534729,0.306592,0.155764,-0.0639572,-0.0287664,0.0545665,0.225623,-0.208002,0.284122,-0.570404,-0.248681,-0.185537,-0.232427,0.164262,-0.147209,-0.239247,-0.177868,0.509069,-0.132664,0.250645,0.34018,-0.419637,-0.126656,0.117293,0.146913,-0.043187,0.352232,0.173731,-0.894056,-0.0113442,0.4139,-0.139065,-0.00536349,0.0260452,0.131034,0.664992,0.0540824,-0.138445,-0.0232381,0.449938,-0.276605,0.145152,-0.511497,-0.136465,-0.187794,0.13399,-0.676762,0.120362,-0.466073,0.166309,0.241186,-0.0572887,-0.0395252,-0.258107,0.369786,-0.158669,-0.050135,-0.227728,-0.483711,0.522811,-0.307277,-0.00215992,-0.173948,-0.208575,0.471492,-0.380684,-0.338564,-0.303634,0.0625741,0.158685,0.101824,0.180066,0.258228,0.151719,-0.330769,0.151527,-0.233229,-0.0829693,0.284787,0.0656958,-0.0896254,0.113537,0.362097,0.102144,0.0384412,0.384295,0.688469,-0.345619,0.621638,0.322529,0.158981,0.229484,-0.255714,-0.351936,0.064795,-0.101224,0.238118,-0.0347963,-0.203325,0.182414,-0.0793377,0.487524,-0.506562,0.107101,0.380752,0.349214,-0.0238157,0.210972,0.502738,0.268323,0.224565,-0.0622768,-0.826883,-0.174307,-0.0564665,-0.269786,-0.19605,-0.172658,0.181239,-0.731075,0.365092,-0.278635,0.265586,0.0795357,-0.342919,0.286181,-0.0789709,0.238957,0.220196,0.0223919,-0.0435332,-0.0949189,-0.888662,0.759953,-0.417524,0.247078,-0.266801,0.142953,0.587593,-0.171164,-0.31359,0.358139,0.119067,-0.317443,0.308075,-0.123867,-0.0980056,-0.465771,0.331426,0.227434,-0.48753,-0.0110654,-0.193031,0.0878596,-0.15231,-0.0865809,-0.387333,0.0857984,-0.168308,0.166896,-0.541659,-0.0717965,0.179392,0.269215,0.334053,-0.334649,0.0296949,0.145633,0.204928,0.23169,-0.390674,-0.447628,0.403003,0.356809,-0.341936,-0.746,-0.179364,-0.61009,-0.0120555,-0.367717,-0.299823,-0.115504,-0.110589,0.218614,-0.111541,0.164548,-0.0166893,0.182307,0.144022,0.27822,0.175402,0.184863,-0.0154961,-0.55398,-0.210305,-0.221089,-0.59321,0.23183,-0.0634044,0.50751,-0.090956,0.43433,-0.023015,0.300128,0.408969,-0.329405,0.222845,-0.0944763,-0.227794,-0.0524914,-0.493269,0.355653,-0.316763,0.158038,-0.0898701,-0.504246,0.013752,0.161091,0.340282,-0.128405,-0.248626,0.0707597,-0.183086,0.0976719,0.0431863,0.0584565,0.119557,0.0931852,0.193698,0.305263,0.440111,-3.13069 +3455.42,0.975369,0.0848144,4,1.61795,0.83197,-0.702566,0.286685,1.01061,-0.118961,-0.0386814,0.0295726,0.19391,0.263659,0.164682,-0.208743,0.389129,0.562425,0.168976,0.459606,0.223092,0.00779104,0.404136,-0.262977,-0.342877,-0.487565,-0.894312,0.235322,-0.351043,0.0756149,-0.208458,0.362976,-0.551446,0.256201,1.04996,-0.757212,0.277051,0.300472,0.0793657,-0.592012,0.466198,0.277128,0.653321,-0.381854,0.909896,0.143803,-0.234362,-0.544362,-0.419582,-0.710351,-0.687442,-0.346404,0.4093,-0.0246541,-0.259865,0.459169,0.190694,-0.160163,0.813219,-0.53399,-0.108373,-0.693648,0.695176,-0.272,0.0618052,0.832869,-0.825754,-0.7236,-0.427048,0.063014,-0.208319,0.287638,0.33334,-0.344506,0.0302393,-0.11358,0.416189,-0.159475,0.671732,0.370504,0.117098,-0.0700224,-0.0143542,-0.0671752,0.382522,-0.259815,0.340477,-0.723173,-0.113642,-0.0723458,-0.420203,0.0901685,-0.205217,-0.380303,-0.037522,0.365284,0.054853,0.191892,0.221925,-0.458767,-0.187098,0.0694593,0.079354,-0.110558,0.0972197,0.291119,-0.794838,0.038341,0.552379,-0.331403,0.0511724,0.0906106,0.132784,0.733345,0.153072,-0.129767,-0.0497561,0.403694,-0.264591,0.152577,-0.542913,-0.164253,-0.172305,0.0220345,-0.786598,-0.0449495,-0.379914,0.0709513,0.236009,-0.204281,0.103607,-0.228569,0.32998,-0.390714,0.00541675,-0.251275,-0.397541,0.164149,-0.347576,0.0106529,-0.216806,-0.275918,0.522025,-0.443922,-0.173821,-0.129483,0.175657,0.0323572,0.257248,0.199224,0.246964,0.341272,-0.202363,0.342748,-0.203013,-0.00857084,0.436259,0.130854,-0.176943,0.000486222,0.380914,0.0659,0.189792,0.400802,0.554338,-0.28296,0.907176,0.208264,0.00664894,0.168666,-0.129985,-0.263524,0.277663,0.116006,0.262314,0.107866,-0.223084,0.0787196,-0.0688026,0.612225,-0.537655,0.0181575,0.300268,0.391,-0.26182,0.260957,0.535539,0.116489,0.13805,-0.262124,-0.600232,-0.0504846,-0.0787046,-0.331323,-0.138066,-0.327564,0.251126,-0.700248,0.323713,-0.0702509,0.277853,0.141991,-0.574925,0.257026,-0.233954,0.216649,0.224156,0.129219,0.0977932,-0.136371,-0.755846,0.732962,-0.134986,0.25123,-0.198536,0.00610819,0.695024,0.0903489,-0.144013,0.400334,-0.0695602,-0.239497,0.2698,-0.400603,-0.131979,-0.423869,0.270424,0.433757,-0.431429,-0.0117781,-0.106053,-0.0711259,-0.0209474,-0.161791,0.0991549,-0.0587367,0.0555713,0.258938,-0.422209,-0.246696,0.00868049,0.166585,0.400763,-0.288889,0.111077,0.213803,-0.16653,0.377143,-0.502819,-0.605516,0.410966,0.429473,-0.220196,-0.758623,-0.135184,-0.558087,-0.0763868,-0.213519,-0.257692,-0.0558818,-0.140306,-0.154283,-0.186296,-0.00632871,-0.00787244,0.324735,-0.0344547,0.197856,0.0258177,0.306351,0.0644018,-0.794445,-0.349055,-0.350039,-0.63565,0.322056,-0.282605,0.410569,0.0316309,0.446203,0.00299239,0.145386,0.73754,-0.133529,0.0175743,0.146472,-0.353009,-0.0633041,-0.552951,0.547161,-0.266707,0.046416,-0.101727,-0.603627,0.114165,0.139225,0.112003,-0.0988144,-0.318155,0.0848405,-0.173003,0.0698277,0.0188355,-0.0821031,0.0111491,0.096225,0.197077,0.310201,0.443933,-3.08094 +3442.46,0.892143,0.0848144,4,1.60866,0.82222,-0.815558,0.324657,0.948391,-0.15073,-0.218824,0.0856071,0.195852,0.279178,0.054692,0.0127473,0.383039,0.162812,0.0604431,0.522294,0.32983,-0.200437,0.181532,-0.139381,-0.207944,-0.556052,-0.723278,0.257539,-0.184587,-0.205411,-0.251647,0.672561,-0.657469,0.342101,0.826791,-0.425316,0.338072,0.394919,-0.181179,-0.450875,0.716093,0.649002,0.343578,-0.450957,0.755378,0.192737,-0.136497,-0.51427,-0.450385,-0.341384,-0.738903,-0.282587,0.297318,0.0131315,-0.313277,-0.0395695,0.107609,-0.207769,0.743511,-0.112639,-0.111012,-1.01892,0.816773,-0.331456,-0.193313,0.796344,-0.367857,-0.696454,-0.0684603,0.0366363,0.165228,0.136385,-0.217825,-0.444677,0.212637,-0.0906543,0.43029,0.118261,0.672715,0.148055,0.27911,0.0785723,-0.255801,0.0388486,0.551934,-0.0920961,0.211751,-0.584693,0.122597,-0.059098,-0.399892,0.322803,0.0961411,-0.30892,0.210973,0.364317,0.0282285,-0.0510383,-0.0415531,-0.318947,-0.0926689,0.332783,0.0126499,-0.121194,0.0239184,0.353029,-0.815765,-0.220127,0.330754,-0.0636615,-0.0172432,-0.157713,0.412533,0.753952,0.060917,0.161733,0.173871,0.350587,-0.191453,0.19345,-0.842776,0.0448793,-0.194431,0.261641,-0.648925,-0.215416,-0.513448,0.026135,0.108047,-0.299399,-0.164781,-0.600896,0.291926,-0.616236,-0.07785,-0.448255,-0.20816,0.105765,-0.539853,0.0591145,-0.284947,-0.169154,0.26034,-0.378288,-0.61382,-0.0261175,0.127721,-0.176404,0.0589154,0.237668,0.28726,0.490189,-0.323402,0.259429,-0.295366,-0.089914,0.331719,-0.158215,-0.191024,-0.0409098,-0.0234683,-0.100748,0.372444,0.469494,0.498358,-0.491347,1.445,0.0784691,0.0676976,0.332729,-0.175781,-0.310102,-0.109487,0.0317908,0.0884529,0.150144,-0.0623468,0.0322935,-0.239656,0.265892,-0.563586,-0.105085,0.231065,0.555575,-0.165606,0.935418,0.757221,0.0686427,0.157241,-0.210346,-0.786827,-0.194255,0.102695,-0.493915,-0.102624,-0.0741834,-0.00324031,-0.854159,0.249361,-0.283205,0.28098,0.257974,-0.458891,0.348382,-0.0123213,-0.050854,0.361497,-0.215305,0.0466279,-0.121876,-0.538787,0.678218,0.135602,0.117706,-0.291424,0.00215509,0.796779,0.125551,-0.252101,0.253633,0.0390283,-0.142558,0.042527,-0.487627,-0.226914,-0.27191,0.0797261,0.328493,-0.483861,0.264249,-0.118462,-0.0491063,0.251692,-0.129327,0.208078,0.0937234,-0.19308,-0.0396749,-0.208325,0.224497,-0.337104,0.705245,0.399976,-0.552694,-0.0934144,0.295712,-0.113405,0.388045,-0.210535,-0.60147,0.474266,0.536386,-0.110067,-0.708713,-0.327126,-0.773975,0.0184449,0.1024,-0.283738,-0.0417772,-0.140203,-0.168513,-0.151608,-0.137365,-0.221585,0.476509,-0.0626257,-0.379265,0.218236,0.0404486,0.0576207,-0.199698,-0.1849,-0.323018,-0.553098,0.198199,-0.132474,0.28069,-0.144816,0.135284,0.21051,-0.00808027,0.836102,-0.0192571,0.19204,0.0906303,-0.1864,-0.10252,-0.334364,0.440716,-0.283443,-0.0670419,0.0438038,-0.636462,-0.0851788,0.0513353,-0.0561444,-0.258565,-0.147995,0.0875129,-0.474268,-0.0137849,0.28569,-0.221878,0.0269066,0.111529,0.183153,0.333959,0.427964,-2.83514 +3437.97,0.839648,0.0848144,4,1.5683,0.975878,-0.463053,0.150714,0.0549699,0.0781286,0.493129,-0.567204,0.295244,0.669146,-0.503491,-0.603201,-0.255129,0.425169,-0.365071,1.25433,0.41055,0.0486725,-0.15004,-0.0463578,-0.152058,-1.18552,-0.594347,0.495409,0.163656,0.337406,0.163674,0.110957,0.0924892,-0.428383,0.810862,-0.227961,-0.456572,0.373546,-0.0883814,0.0835025,-0.902839,0.217916,0.132419,-0.238169,0.801687,0.260593,0.034311,-0.41005,-0.104266,-0.271091,-1.11232,0.093512,0.372575,0.257401,-0.0895374,-0.122389,0.252096,-0.871074,0.822074,-0.313636,-0.230137,-0.486117,0.447557,-0.399395,0.340667,1.19669,-0.796678,-0.948199,-0.237713,0.184534,0.165088,0.0910588,-0.127355,0.198923,-0.23504,0.136787,0.481189,-0.395881,0.270627,0.103211,0.513831,0.143592,-0.19454,0.263795,0.594867,-0.609683,0.00478325,-0.159831,-0.378009,-0.317334,0.423781,-0.608195,0.00358132,-0.290548,0.0320075,0.138665,-0.336036,-0.189381,0.42922,-0.591232,-0.211613,-0.211274,0.370375,0.645489,0.376216,0.242368,-0.118197,-0.101229,-0.0744371,-0.45558,0.495717,-0.121575,-0.0981515,0.845992,0.459194,-0.508666,0.142717,0.313597,0.0647997,0.20723,0.164568,0.0220035,0.0867236,0.043482,-0.678624,-0.0886145,-0.378651,0.0815685,-0.138273,0.607117,0.0930408,0.440619,0.308869,0.0133648,-0.130979,0.196796,0.317482,0.516198,-0.22917,-0.0595886,0.190767,0.0506103,0.668279,-0.479968,0.285715,-0.0982316,-0.210075,-0.754089,0.461639,-0.3756,-0.11356,0.525705,0.0732169,-0.233095,0.0744219,-0.0111249,0.105525,0.0764063,0.185901,0.24416,0.363137,0.0189525,-0.0255959,-0.0953525,-0.222392,0.135512,0.144512,0.257332,-0.0458214,0.495939,0.2336,-0.195263,0.094508,-0.0541926,0.0514928,0.0562985,-0.109831,0.0956702,0.213576,-0.0177294,-0.147504,-0.199769,0.543227,0.589045,-0.112463,-1.03692,-0.0873789,-0.401449,-0.0931912,-0.106351,-0.0743168,0.195788,0.334727,-0.412398,0.118068,0.311379,-0.078994,-0.581153,-0.176852,0.0696343,-0.147241,-0.311508,-0.259355,0.339399,-0.111443,-0.464176,-0.237925,0.240671,0.0862099,-0.0235793,0.0510635,1.03641,-0.37338,0.286085,-0.0974262,-0.435851,-0.367221,-0.315269,0.170952,0.430779,-0.573744,0.343993,0.697568,0.0458494,0.226157,0.132139,0.0417112,0.139448,0.00487897,0.205263,-0.64723,-0.0097647,-0.122975,-0.204907,0.267833,-0.0798742,-0.502859,-0.290979,-0.0421599,0.337567,0.515093,-0.645065,0.263374,0.174782,-0.0104215,-0.268907,0.212782,-0.361346,0.674303,-0.246787,0.612202,0.00303892,0.116924,-0.0404584,0.0735598,-0.356872,-0.0192,-0.356545,0.0740374,0.7607,-0.209611,-0.00171314,0.0976604,-0.12607,0.221567,-0.168718,0.221216,0.108399,0.0774494,0.0575953,-0.355016,-0.0387189,-0.0635164,-0.223596,-0.112218,-0.743151,-0.393439,-0.167389,0.0522187,0.201842,0.166106,0.139927,-0.10162,0.00778259,-0.305951,-0.249521,0.54995,0.184913,0.225599,-0.355872,0.597613,0.371382,-0.152977,0.342355,-0.124705,0.0692293,-0.201453,0.219448,-0.3023,-0.478229,-0.849707,-0.383037,-0.310758,0.132827,-0.308568,0.096576,0.30161,0.310767,0.54919,-0.258666 +3429.75,0.998842,0.0848144,4,1.61768,0.943436,-0.217578,0.0585368,-0.106003,0.0387742,0.29954,-0.0790819,0.215977,0.487007,-0.208366,-0.334672,-0.0863164,0.458299,0.0989262,1.05616,0.13139,0.258294,-0.161625,-0.22008,-0.564552,-1.04461,-0.726499,0.0752596,0.122334,0.48617,-0.571496,0.3744,0.122469,0.0312745,0.88574,-0.169991,-0.0921747,0.324676,-0.308902,0.261188,-0.666058,0.362833,-0.0460591,-0.293303,1.04255,0.214394,-0.0739257,-0.686606,0.0255707,0.693535,-0.641861,0.0690008,0.427618,-0.0233333,0.0171694,-0.0326007,0.242181,-0.484154,0.900637,0.108513,-0.36776,-1.49984,0.591048,-0.213027,0.249212,0.747094,-1.16673,-1.57938,0.283217,0.203865,0.140345,-0.559746,0.423794,0.0703695,0.50045,0.425172,0.782205,-0.356236,0.542349,0.461668,0.351552,-0.384242,-0.0476949,-0.0427989,0.515565,-0.714433,0.0935331,-0.124688,-0.410415,-0.38966,0.224734,-0.499993,-0.0366703,-0.179544,-0.113163,-0.138241,0.0467571,-0.263006,0.0085227,-0.158762,0.119443,-0.0373315,-0.0857767,0.248623,0.058699,-0.39153,-0.378092,-0.184798,-0.335048,-0.132641,0.31036,0.178637,0.320314,0.412923,0.0796291,-0.511019,0.113663,0.320324,-0.259268,0.358942,-0.0492133,0.187034,0.0519496,0.207625,-0.578873,-0.427155,-0.445265,-0.481257,0.410753,0.689895,0.301692,0.130921,0.279232,0.0639156,-0.425131,-0.00515792,0.859059,0.236669,-0.142729,-0.152435,-0.122642,-0.221756,0.392195,-0.185084,-0.0314139,-0.0686884,0.0955155,-0.590345,0.385155,-0.364952,-0.26671,0.719937,-0.336416,-0.41083,-0.0782578,-0.258019,0.161401,0.122986,0.232425,0.234038,-0.00435774,-0.106334,-0.180415,-0.111836,-0.589216,-0.0238389,0.562576,-0.315328,-0.2248,0.484282,0.170098,-0.37107,-0.454836,0.146679,-0.120842,-0.0961838,-0.0897908,-0.141243,0.415841,0.468046,-0.412436,-0.511032,-0.00158446,0.439488,-0.0879839,-0.609042,0.121485,-0.165352,0.429405,0.102066,-0.44526,-0.182457,0.109071,-0.535636,0.505294,0.310868,-0.280838,-0.181855,0.10501,0.1196,-0.122653,0.0777771,-0.483818,0.3662,0.0175652,-0.1342,-0.0298682,0.525738,0.416955,0.0380391,-0.225348,0.886884,-0.0415934,0.301096,-0.0973982,-0.254374,0.156333,0.25659,0.00959985,0.415758,-0.558684,0.12297,0.141498,0.078276,-0.33715,-0.112738,-0.0956665,0.425847,-0.00285561,0.518265,-0.685245,0.0999093,-0.768625,-0.0297979,-0.383471,0.0939102,-0.698732,-0.41508,-0.390218,0.148704,0.159128,-0.118568,0.654103,-0.178821,0.103109,-0.584593,0.193979,-0.123456,0.458028,-0.0120071,0.368281,0.33328,0.250639,-0.309393,0.362144,-0.770866,0.389058,-0.78576,-0.0770071,0.606254,-0.179831,0.23985,0.0190905,0.180867,-0.0995879,0.119209,0.0628148,0.434067,0.131389,0.482454,-0.356695,-0.492413,-0.497989,-0.510444,-0.56172,-0.273158,-0.187626,0.41084,0.268652,0.536375,0.0665653,-0.00464049,0.114171,-0.371893,0.0185193,0.172927,0.041069,0.0545761,-0.0668875,-0.478663,0.283187,0.185963,0.289675,0.163452,-0.303993,-0.0530154,-0.608866,0.308534,-0.320992,0.0449301,-0.638095,-0.302032,-0.420713,-0.0856745,-0.194472,0.134733,0.349474,0.367059,0.591163,0.350751 +3423.81,0.967235,0.0848144,4,1.50905,1.00483,-0.191113,0.104358,-0.328381,-0.0702125,-0.050182,-0.0401834,0.382005,0.732201,-0.232163,-0.106402,-0.00113039,0.453808,0.00305757,1.06187,0.214937,0.155915,-0.182873,0.160343,-0.464349,-0.80947,-0.378431,0.459166,0.166545,0.198299,-0.512048,0.723462,0.10439,-0.273908,0.995176,0.0869728,-0.0787038,0.192817,-0.345395,-0.0411712,-0.805199,0.37936,-0.0604458,-0.536805,1.14175,-0.0206722,0.17761,-0.877071,-0.320953,0.47088,-0.710384,-0.238875,0.338876,0.184583,0.220053,0.105519,0.290105,-0.814987,0.630926,0.183235,-0.341163,-1.53812,0.53965,0.0227493,0.547889,0.953381,-0.496418,-1.28739,0.300181,0.187931,0.245125,-0.231915,0.0380592,0.0955464,0.613492,0.579405,0.800772,-0.398673,0.362165,0.539453,0.106254,-0.239143,-0.495572,0.0760049,0.568612,-0.610931,-0.0770971,0.01179,-0.456077,-0.204238,-0.0219459,-0.568396,-0.237713,-0.383598,0.00297906,0.0862289,0.130672,-0.351048,-0.0318552,-0.0710249,0.0417375,-0.101242,-0.127785,0.277096,0.11544,-0.466932,-0.0556576,-0.272788,-0.225673,-0.519808,0.436685,0.109788,0.40983,0.285692,-0.226654,-0.777611,0.0158099,0.353102,-0.0644633,0.442411,0.19968,-0.210012,-0.026482,0.0197684,-0.457711,-0.275963,-0.319054,-0.344707,0.362666,0.807706,0.530618,0.205469,0.166165,-0.397769,-0.445676,0.115797,1.0195,0.360693,-0.0641292,-0.273664,-0.163582,-0.221418,0.52982,-0.245248,0.274978,-0.329931,0.213846,-0.678813,0.406448,-0.26931,-0.190845,0.278732,-0.430857,-0.600151,-0.0423018,-0.388928,0.0168658,-0.11617,0.435203,0.109468,0.336881,-0.0755412,-0.17402,-0.0138877,-0.558785,-0.167448,0.519277,-0.326946,-0.115862,0.233295,0.173043,-0.513249,-0.423519,-0.0294791,0.312061,0.17161,-0.00168199,-0.164002,0.0730251,0.479396,-0.491801,-0.402968,-0.0782969,0.476112,-0.232561,-0.632102,-0.0458447,-0.378269,0.620836,-0.289213,-0.292323,0.171529,0.0823793,-0.45331,0.668422,0.632074,-0.437477,-0.0899169,-0.0150397,0.230244,0.0846903,0.310954,-0.450567,0.356553,0.068419,-0.467855,-0.345193,0.531553,0.459154,-0.189539,-0.353617,0.876309,0.112295,0.350189,-0.0277106,-0.200435,0.164243,0.598587,0.281671,0.244767,-0.725531,0.0199713,0.251908,0.0819038,-0.236201,-0.279967,-0.143837,0.695607,-0.322996,0.724418,-0.742497,-0.195366,-0.431322,0.0167672,-0.0609507,-0.00771633,-0.880647,-0.408755,-0.327486,0.318245,-0.0669652,-0.197425,0.426645,-0.290956,0.0874175,-0.351389,0.2863,-0.103015,-0.0957345,-0.182758,0.333663,0.53988,0.0708901,-0.252766,0.116163,-0.59266,0.445906,-0.936483,0.00729041,0.50466,0.133465,-0.0560264,-0.0933565,0.203462,0.000176914,-0.0143827,0.300248,0.236229,-0.0903711,0.581018,-0.437167,0.0132044,-0.2084,-0.264699,-0.424098,-0.248117,-0.269371,0.320309,0.198706,0.449736,-0.0135212,0.147049,0.137152,-0.044482,0.0841302,-0.132868,-0.179759,0.591893,0.0836522,-0.686752,-0.0780208,0.413911,0.219503,-0.308247,-0.250395,0.24744,-0.377705,0.431352,-0.208705,-0.453646,-0.451047,-0.0727012,-0.312958,0.0653226,-0.11033,0.127379,0.310773,0.356902,0.55747,0.841704 +3418.93,0.98315,0.0848144,4,1.55237,0.929189,-0.381311,0.0961763,-0.441363,-0.024473,-0.0718241,0.160916,0.362802,0.734222,-0.284825,-0.190802,0.115875,0.561149,-0.211297,0.945165,0.0416714,0.210734,-0.377996,0.283604,-0.485671,-0.979714,-0.652813,0.229142,0.0961202,0.153145,-0.389144,0.499377,-0.0230447,-0.1346,1.13275,-0.108028,0.10398,0.421767,-0.0950958,-0.13137,-0.806546,0.299774,0.0422119,-0.236256,1.29369,0.356104,0.280568,-1.16582,-0.325659,0.38852,-0.645799,-0.0620969,0.486516,0.263212,0.27895,-0.20284,0.199745,-0.783624,0.741274,0.128903,-0.228799,-1.57951,0.367524,0.11846,0.474878,0.784851,-0.19571,-0.958824,0.191353,0.0247912,0.36579,0.136245,0.0545147,0.068613,-0.0137941,0.920239,0.605893,-0.621712,0.690245,0.744368,0.0424628,0.0366273,-0.514226,0.124998,0.785027,-0.950965,0.179841,-0.115474,-0.224679,-0.0279651,-0.360779,-0.516533,-0.161756,-0.43316,-0.0491419,0.17145,0.132643,-0.301266,-0.0471332,0.0809122,0.1562,-0.360093,-0.517626,0.103988,0.34811,-0.346555,-0.0656936,-0.29484,-0.178191,-0.612441,0.575585,0.0142833,0.158965,0.506247,-0.216772,-0.613686,0.0326183,0.367216,-0.188202,0.26442,0.274627,-0.116633,0.436267,0.171226,-0.128692,-0.245914,-0.162995,0.0850854,0.311571,0.831445,0.446462,0.0312549,0.155657,-0.63291,-0.564753,0.317929,0.728802,0.312993,0.114165,-0.437756,-0.00589341,-0.258307,0.523078,-0.0344047,0.345258,-0.197334,0.556356,-0.828523,0.158542,-0.0805555,-0.0916307,0.249012,-0.326581,-0.769328,0.106852,-0.159894,-0.0913578,-0.00828642,0.500131,0.00401104,0.197222,-0.255908,-0.302419,0.272022,-0.339983,0.243476,0.706909,-0.19806,-0.130821,0.156974,0.28298,-0.580792,-0.404247,-0.0848866,0.357922,0.159873,-0.12472,-0.12372,-0.0793623,0.26456,-0.620279,-0.602928,-0.057679,0.531339,-0.430157,-0.18381,-0.14705,-0.0216278,0.64285,-0.249887,-0.234404,-0.110408,0.351488,-0.615332,0.825311,0.669862,-0.246631,-0.169484,0.0791927,0.0585202,0.382583,0.416304,-0.436472,0.367417,-0.00558731,-0.0443737,-0.194634,0.366573,0.279958,-0.380911,-0.279811,0.722839,-0.0233136,0.150411,0.163714,-0.281635,0.160011,0.416821,0.467802,0.100281,-0.63195,0.0620196,0.107638,-0.186623,-0.260143,-0.5749,0.0784176,0.73446,-0.338227,0.526839,-0.627589,-0.12227,-0.185252,0.0417357,-0.265588,-0.0300891,-0.573085,-0.26909,-0.70815,0.238632,0.120861,0.24298,0.23171,-0.37647,0.573618,-0.418004,0.119685,-0.00971495,0.0580562,-0.117131,0.572692,0.615332,-0.0269156,-0.475614,-0.127161,-0.494117,0.683608,-0.790111,-0.0545316,0.59634,0.211924,-0.0996744,-0.244849,0.144835,0.0922099,0.247531,0.175693,0.330539,0.104571,0.506292,-0.482311,0.0557138,-0.46346,-0.410615,-0.411827,-0.0516515,-0.176203,0.450709,0.193691,0.219816,-0.11389,0.256952,-0.137821,-0.112389,0.099471,-0.209234,-0.0885552,0.431992,-0.0128288,-0.673055,-0.0859501,0.542649,-0.245899,-0.154308,-0.180884,0.202139,-0.37759,0.298314,-0.558897,-0.550703,-0.178479,0.118462,-0.482481,-0.184107,-0.13466,0.108899,0.310139,0.329998,0.556901,1.49009 +3425.05,0.934034,0.0848144,4,1.61693,0.953017,-0.238009,0.0856653,-0.482954,-0.0332921,-0.0887831,0.104114,0.40543,0.655035,-0.0202161,-0.318369,0.158458,0.634372,-0.250002,0.777608,0.118121,0.0884596,-0.386797,0.343554,-0.503431,-0.797344,-0.434053,0.385713,0.0255476,0.196128,-0.422585,0.288755,-0.289484,-0.184379,1.08746,-0.452365,-0.105935,0.422304,-0.409825,-0.0894936,-0.52884,0.268487,-0.269018,-0.250146,1.28502,0.293857,0.595996,-0.955104,-0.342017,0.552157,-0.593367,0.125614,0.332444,0.205471,0.217337,-0.397901,0.123663,-0.881904,0.756093,0.0446434,-0.200849,-1.41222,0.390123,-0.301614,0.467093,0.840639,-0.179245,-0.972447,0.0395665,0.109047,0.222125,0.1409,-0.0869703,-0.170872,-0.196518,0.609659,0.830636,-0.554668,0.363689,0.631459,0.262309,0.296772,-0.556009,0.0448981,0.550561,-0.917136,0.157942,-0.0424172,-0.063143,0.309784,-0.659275,-0.636299,0.224717,-0.100365,0.0307121,0.126286,-0.569276,-0.286423,0.0796536,-0.116289,0.192953,-0.430537,-0.57208,-0.00294588,0.0548574,-0.359116,-0.244796,-0.518651,-0.302671,-0.684023,0.407269,-0.0355147,-0.0466986,0.5846,-0.30089,-0.487313,-0.297856,0.235988,-0.201959,0.127394,-0.014402,-0.280728,0.218506,0.289307,-0.391919,-0.51169,0.00690188,-0.531945,0.380248,0.766272,0.209292,0.141015,0.294446,-0.178836,-0.410771,0.172599,0.547065,0.359781,-0.0643638,-0.612991,0.249228,-0.552866,0.483306,-0.144206,-0.199037,-0.181424,0.52981,-0.31107,0.0219326,-0.279668,-0.450257,0.592636,-0.549449,-0.473863,-0.111258,-0.152576,-0.134751,0.147538,0.290148,0.130398,0.442189,0.0833987,-0.13387,-0.131656,0.0436906,0.200756,0.468745,-0.210829,-0.165573,0.100158,0.310782,-0.485321,-0.28486,-0.0568785,0.513514,-0.058643,-0.134286,0.0243865,0.198721,0.726155,-0.523178,-0.611288,0.157613,0.493311,-0.418456,-0.213688,-0.16119,-0.0174049,0.552917,-0.134656,0.135963,-0.457968,0.173395,-0.656122,0.289564,0.638278,-0.172227,-0.401986,0.0657996,-0.00837302,0.150299,0.0416234,-0.611829,0.349893,-0.0156394,-0.18005,-0.204038,0.175362,0.284914,-0.111891,-0.337911,0.725065,-0.125925,0.105904,0.200476,-0.505103,-0.0924979,0.261632,0.405146,0.141607,-0.356404,-0.0469909,-0.228547,-0.241269,-0.221677,-0.450945,0.0671697,0.399214,-0.233759,0.437669,-0.686883,-0.00629781,-0.0837346,-0.373633,-0.161406,-0.126002,-0.00669365,-0.209092,-0.456876,0.2228,0.143237,0.196491,-0.0905275,-0.283674,0.982642,-0.34037,-0.19013,-0.166138,0.150183,-0.0135978,0.468562,0.511268,-0.0178273,-0.148529,-0.00125272,-0.414754,0.452533,-0.696878,-0.0464473,0.547543,0.0696643,-0.134113,-0.246877,0.125113,0.142179,0.242001,0.319953,-0.128534,0.152573,0.440595,-0.501926,0.676454,-0.143568,-0.301324,-0.384105,-0.176169,-0.151004,0.835789,0.606762,0.123937,-0.00873063,0.320073,-0.234549,0.0307823,0.0196835,-0.197755,-0.4495,0.062182,0.0130402,-0.284056,0.0435628,0.404508,-0.0507378,-0.0664018,-0.386424,0.196447,-0.472765,0.108283,-0.762019,-0.367413,-0.207175,0.26679,-0.268902,-0.480025,0.168082,0.133285,0.33316,0.365082,0.5772,1.58748 +3420.37,0.786116,0.0848144,4,1.65934,0.956979,-0.394983,0.0653144,-0.62845,-0.118678,-0.196037,0.0407946,0.208495,0.789299,-0.24908,-0.545773,0.131912,0.535279,-0.252314,0.722349,0.324568,-0.0450044,-0.437843,0.17263,-0.592263,-0.794073,-0.532819,0.145301,-0.371352,-0.146526,-0.332464,0.137979,-0.206011,-0.242481,0.859508,-0.0513477,-0.0480951,0.337216,-0.094869,0.125457,-0.663051,-0.142438,-0.294002,-0.113189,1.16141,0.420222,0.693869,-1.08044,-0.503631,0.59901,-0.569948,0.384796,0.546076,-0.316019,0.192779,-0.341439,0.108841,-0.797386,0.900344,0.190009,-0.14942,-1.2033,0.379053,-0.733522,0.172925,0.785642,-0.00521574,-0.842859,0.0956306,-0.213962,0.262451,-0.0612317,0.0835367,-0.449063,-0.0436715,0.137706,0.775888,-0.314509,0.715359,0.574746,0.104717,0.310266,-0.337655,-0.0123704,0.164238,-1.00892,0.133026,0.074802,-0.250734,0.169203,-0.395486,-0.338786,0.16069,-0.230385,-0.310042,0.439068,-0.259758,-0.362983,0.105641,-0.420197,0.410511,-0.591106,-0.214459,-0.0371862,0.111528,0.192828,-0.0916837,-0.149739,-0.327555,-0.621887,0.276169,-0.0337749,-0.00924399,0.693299,-0.167617,-0.309761,-0.276587,0.0891333,-0.31496,0.162382,-0.0669764,0.0608532,-0.354269,0.56785,-0.707166,-0.49049,-0.0266141,-0.12882,0.293273,0.408725,0.0235565,-0.266249,0.314027,-0.193925,-0.00720865,0.274143,0.374337,0.0619736,-0.275912,-0.582591,0.110758,-0.360312,0.546668,-0.599343,-0.451168,0.00124997,0.568395,-0.165119,0.159758,0.0143377,-0.734626,0.281771,-0.285184,-0.737012,-0.0390945,-0.0863929,-0.0987425,0.29114,0.0153882,0.23985,0.0877311,0.1498,-0.208713,-0.0280058,0.0400147,0.177614,0.415605,-0.130685,0.189343,0.117294,0.185433,-0.754506,-0.173157,0.0530246,0.0489943,-0.0388669,-0.162115,-0.0802959,0.273568,0.698799,-0.665903,-0.433449,-0.190258,0.672633,-0.400209,-0.00122416,-0.118939,0.515732,0.5588,0.0251777,0.19036,-0.122184,-0.101014,-0.675386,0.144527,0.642069,0.080968,-0.194528,-0.104182,0.229975,0.163672,0.227408,-0.56395,0.291258,0.0370722,-0.0610679,-0.445493,0.138744,0.309972,-0.220181,-0.252251,0.835651,-0.270142,-0.0624242,-0.409303,-0.538375,0.118117,-0.220366,0.283494,-0.0155552,-0.190731,0.0656002,-0.342752,-0.614181,-0.104603,-0.153792,0.204526,0.260553,-0.0955633,0.131228,-0.85166,-0.169972,0.678694,-0.463045,0.0361291,-0.281817,-0.212416,-0.0425268,-0.310088,0.269309,-0.0596506,-0.0432167,0.0522941,-0.418298,0.678895,-0.341581,0.295451,-0.135558,0.0232953,0.323941,0.176077,0.427174,-0.0244534,-0.11833,-0.238553,-0.307142,0.749437,-0.868579,0.0225455,0.212837,0.227015,-0.101673,-0.377689,-0.00465097,0.370194,-0.0137676,0.191031,0.0854036,-0.061902,0.536686,-0.416654,0.585058,-0.267497,-0.099147,-0.61048,0.0282621,0.234436,0.306726,0.5906,-0.243117,-0.295821,0.580152,-0.253004,0.248103,-0.159017,0.0127718,0.222997,0.00782593,-0.228019,-0.208022,0.0191292,0.311105,0.0996683,0.109647,-0.282799,-0.0908683,-0.549734,0.145837,-0.630037,-0.390244,0.0160517,0.22881,-0.316086,-0.467449,0.196966,0.109227,0.245604,0.330495,0.495585,2.22903 +3422.09,0.919365,0.0848144,5,1.65281,1.01983,-0.255904,0.111692,0.140769,0.105549,0.0515342,0.00105977,0.733885,0.136254,-0.0036917,0.161705,0.394063,0.49506,0.0958124,1.07151,-0.0361785,-0.00113566,-0.0803338,0.154713,-0.565688,-0.727379,-0.631227,0.160888,-0.235943,-0.276704,0.275756,0.523041,-0.0658504,-0.0950394,0.704741,-0.256775,-0.11035,0.169904,-0.567561,-0.634836,-0.250096,-0.116988,0.0896903,-0.647479,0.915265,0.422164,-0.144409,-0.570865,-0.21446,-0.113543,-0.652656,0.19209,0.323095,0.658526,-0.091706,-0.551265,-0.20432,-0.746227,0.792482,-0.440867,-0.272327,-0.806648,0.571755,0.0436093,-0.111732,0.516976,-1.15017,-0.617227,-0.111614,0.276602,-0.50206,-0.595202,0.107345,-0.0590966,0.173635,0.637968,0.630816,0.154597,0.270813,0.525831,0.303798,0.689624,0.209775,0.19051,0.64744,-0.150378,0.21361,-0.217564,-0.13139,0.384497,0.295372,-0.201095,0.250742,-0.219771,0.201188,-0.119005,0.188261,-0.133899,0.413115,-0.0696963,0.159999,-0.0165827,-0.312354,-0.0624366,0.464468,-0.549548,-0.430934,-0.228964,0.0681453,-0.706242,0.278742,-0.679274,-0.19963,0.638288,0.15302,-0.00835883,0.259501,0.135255,0.103398,-0.552104,0.027787,-0.398932,0.331932,-0.50031,-0.250417,-0.059226,-0.365208,-0.052603,0.566747,0.373399,-0.135844,0.550673,-0.0449041,-0.536291,-0.293745,0.126479,0.0768704,0.721018,-0.0778604,0.5613,0.0911301,0.067099,0.686882,-0.574342,0.468181,-0.0314696,0.305684,-0.442583,0.367435,-0.270185,0.0450056,0.409661,-0.0165604,0.532011,-0.238976,0.0012833,-0.250181,-0.253158,-0.260354,0.636136,-0.175085,0.088895,0.162415,0.155668,0.402902,-0.425167,0.735282,0.283665,-0.0508319,-0.375607,-0.150595,-0.270356,-0.18094,-0.200034,0.0714993,-0.178129,-0.43706,-0.00875561,-0.34289,0.265145,-0.212538,-0.430994,0.303238,0.64019,-0.231915,-0.604512,0.0707001,-0.2301,0.11486,-0.0659707,-0.0378941,-0.641516,0.602372,-0.0985659,-0.205121,-0.377459,0.559662,-0.582736,0.124969,-0.176378,-0.302876,0.00725118,-0.288576,0.430185,-0.333193,-0.0524687,0.252297,-0.286613,-0.414944,-0.121854,-0.0769832,0.891495,0.165168,0.119921,-0.246058,-0.0854158,0.109942,0.109626,0.332651,0.502785,-0.055294,0.127456,-0.124811,-0.229882,0.263653,-0.586034,-0.160877,-0.00375865,-0.297875,0.407317,-0.80113,-0.267759,-0.137419,0.482528,-0.248117,-0.140601,0.134799,0.125784,-0.930059,0.186387,0.33375,0.400619,0.874231,-0.0469163,-0.272885,-0.0246532,-0.149899,0.204928,0.464832,-0.297073,0.438753,0.00790189,-0.636432,-0.562137,0.290183,-0.72792,0.0327448,-0.0593727,-0.773089,-0.1407,-0.229692,-0.241912,0.031153,-0.224994,-0.207235,0.640221,0.532123,0.282393,0.275707,0.381016,0.0117248,-0.12134,-0.509762,-0.155183,-0.0496344,-0.207082,-0.643548,-0.0457995,-0.285862,0.136797,-0.018903,-0.416458,0.410741,-0.573887,-0.0171053,-0.187311,-0.655161,-0.425678,0.0435723,-0.447565,-0.169753,0.408326,0.123056,0.313109,-0.370375,-0.363794,-0.459836,0.0210373,-0.26961,0.213762,0.229057,0.0430408,-0.526031,-0.245075,-0.596106,0.11627,0.245151,0.340984,0.495128,-0.615389 +3414.1,0.906006,0.0848144,4,1.69765,1.05243,-0.254035,0.0538122,-0.122651,0.0744059,0.725377,0.670523,0.373285,0.515586,-0.0897454,-0.217617,0.55954,0.648113,-0.0568916,0.885566,0.161492,-0.511732,-0.0647047,-0.175911,-0.438817,-1.43667,-0.579402,-0.103627,0.0751244,0.0397391,0.203974,0.236214,-0.230577,-0.315188,0.525021,-0.438073,0.389986,0.18478,-0.126121,-0.118741,-0.802488,0.438454,-0.109381,-0.484846,0.84983,0.203227,0.058867,-0.557713,-0.571013,-0.0310473,-0.546584,0.388863,0.192153,0.0116926,0.0868591,-0.617948,-0.14499,-0.49535,0.794804,0.161961,0.118019,-0.603914,-0.0599996,-0.497927,-0.0713732,0.598783,-0.798549,-0.397838,-0.383551,-0.0750914,0.0460993,-0.274043,-0.245414,-0.906286,-0.54154,-0.383419,0.453487,-0.0169053,0.459603,0.349789,0.6017,-0.00856741,0.0987562,0.518518,0.931534,-0.264021,0.0747006,-0.28039,0.0382475,0.237621,0.0027019,-0.325244,0.58363,-0.413695,-0.036285,0.0148657,-0.359128,-0.0220642,0.132539,0.242952,-0.0180886,-0.588089,0.265166,0.220963,-0.187179,0.107183,-0.507115,0.0514454,0.164887,-0.181658,0.0660094,-0.243551,-0.176434,0.44086,-0.223643,-0.206381,0.305932,0.092354,-0.230794,-0.0935797,-0.205198,0.117573,-0.196134,-0.0922309,-0.688671,-0.428417,-0.347704,0.105482,-0.318364,0.295355,-0.503877,-0.298686,0.355074,0.00813905,-0.284475,0.290604,-0.254812,0.527712,-0.0077444,-0.0256136,0.406195,-0.171393,0.385436,-0.309811,-0.750671,0.181007,0.225993,-0.759572,-0.313631,0.100289,-0.307561,0.107655,0.163352,-0.572629,-0.302767,0.238544,-0.00988626,0.169064,0.43379,0.64782,0.105226,-0.19398,-0.211695,-0.663515,0.492683,-0.264106,0.497017,0.285446,-0.107249,-0.515857,0.0908109,-0.674173,0.225842,0.826134,0.527376,-0.366453,-0.204285,0.178994,-0.728519,-0.19643,-0.298019,-0.554069,-0.106766,0.479457,0.0141594,-0.140839,0.434966,-0.00711393,-0.666194,-0.224226,0.495085,-0.263352,-0.128331,-0.765536,0.051626,-0.209561,-0.712748,-0.39182,0.0551803,-0.18872,0.246584,0.0649765,0.124538,-0.265612,0.120545,-0.513512,-0.059443,-0.0391837,-0.0100423,-0.606831,-0.231444,1.18387,-0.244721,0.379985,0.440618,-0.384009,0.69546,0.15036,-0.513145,0.247522,0.188851,-0.124686,0.317852,-0.356589,-0.157023,-0.149658,0.110771,-0.209491,-0.344895,0.735423,-0.801516,-0.0870526,0.320689,0.0752274,0.385527,-0.266376,-0.451772,-0.409161,-0.421577,0.680213,0.00782163,0.100342,0.732286,-0.275527,0.440349,-0.203542,-0.338379,-0.225242,0.235186,-0.0748933,-0.171909,-0.0635461,-0.656388,-0.722615,-0.266226,-1.08603,0.241306,0.247503,-0.551607,-0.0753435,-0.612616,-0.269795,0.31233,-0.119775,0.131131,0.0827086,-0.1204,-0.486702,-0.0701247,0.200814,-0.0550332,0.00308651,-0.261502,-0.340301,-0.554679,0.00108851,0.210674,0.546563,0.023757,-0.292577,-0.158762,0.224586,0.323981,-0.226429,-0.0155242,-0.0463069,0.0477265,-0.174061,0.105563,-0.499187,-0.368176,0.359209,-0.570712,-0.715872,-0.470298,-0.0367347,-0.387501,0.336286,-0.353003,-0.941805,-0.158684,-0.166788,-0.0951069,-0.45589,-0.203092,0.135884,0.195444,0.368625,0.442091,0.308024 +3400.96,0.908933,0.0848144,5,1.67264,1.05234,-0.114187,0.00571138,-0.159005,0.088746,0.671038,0.680567,0.475932,0.527304,-0.00114321,-0.28098,0.442308,0.616435,-0.114391,1.0103,0.148414,-0.556097,-0.10406,-0.0859973,-0.628367,-1.42039,-0.72754,0.0163058,0.207261,0.00508652,0.183819,0.154798,-0.369641,-0.311707,0.585645,-0.34251,0.138754,0.151736,-0.163475,0.0292412,-1.01562,0.636676,-0.00607544,-0.571866,0.918111,0.126635,-0.0955714,-0.508495,-0.518193,0.00772071,-0.429406,0.427076,0.131043,-0.018779,-0.0245016,-0.158088,-0.188712,-0.227594,0.849227,-0.0106532,-0.0591003,-0.501804,0.234873,-0.544017,-0.0805384,0.529612,-0.611571,-0.741381,-0.545506,-0.134731,-0.242464,-0.33126,-0.297853,-0.672965,-0.783344,-0.358031,0.300989,-0.0353355,0.438304,0.393936,0.612841,-0.0309308,-0.116623,0.365684,0.865822,-0.262531,0.0121554,-0.207602,0.0941084,0.329305,-0.0344074,-0.34516,0.565641,-0.136004,-0.0380884,-0.28635,-0.349704,-0.0642994,-0.0687353,0.137988,-0.227007,-0.582736,0.499329,0.297478,-0.307211,-0.13309,-0.618094,0.375232,0.151888,-0.216119,0.00882959,-0.066711,-0.403286,0.405299,-0.280875,-0.411766,0.401144,0.0356887,-0.0876437,-0.152141,-0.236292,0.0675422,-0.216424,-0.138523,-0.538558,-0.327104,-0.21696,0.21477,-0.367751,0.20377,-0.264814,-0.140381,0.244444,-0.0997918,-0.213326,0.322235,-0.228891,0.382625,-0.0552346,0.115551,0.40085,-0.195595,0.342062,-0.458074,-0.464256,0.128475,0.416659,-0.613631,-0.309403,0.0632564,-0.268616,0.0736594,0.0749215,-0.479014,-0.179279,0.268709,-0.00866667,0.119191,0.509694,0.666669,0.0727784,-0.225424,-0.103329,-0.604859,0.417926,-0.0930963,0.458583,0.392766,-0.258598,-0.0388487,-0.0845685,-0.553928,0.164655,0.927922,0.297185,-0.240227,-0.130848,0.379896,-0.397474,-0.30354,-0.212265,-0.618655,-0.00458065,0.555526,0.0286625,-0.546387,0.446579,0.333372,-0.699516,-0.164313,0.464422,-0.397114,-0.0650722,-0.787158,0.203338,-0.0730473,-0.618526,-0.408353,0.0920489,-0.229645,0.144479,8.27474e-05,0.075949,-0.000289059,0.230008,-0.373076,-0.141967,0.0781644,0.267646,-0.600055,-0.519681,1.01481,-0.0217154,0.344335,0.0412379,-0.606499,0.389837,0.455811,-0.343162,0.287565,0.33232,-0.193852,0.29588,-0.417946,-0.0332843,-0.277751,0.0235658,-0.172107,-0.59432,0.82251,-0.706766,-0.074331,0.335005,-0.037733,0.592123,-0.0638461,-0.452112,-0.570661,-0.566494,0.516444,-0.155178,0.190611,0.826419,-0.0478227,0.259292,0.091172,-0.248882,-0.256934,0.594086,-0.275474,-0.218538,0.0274724,-0.972033,-0.84667,-0.381947,-1.01272,0.259612,0.556815,-0.653142,0.0843613,-0.64948,-0.417072,0.64475,-0.131293,0.171048,0.0678214,-0.152902,-0.592295,-0.305145,0.232746,-0.143414,-0.0280681,-0.104526,-0.439315,-0.461732,-0.118886,0.00638773,0.80386,-0.0142117,-0.541594,-0.136961,-0.0310657,0.308865,-0.138727,-0.178776,-0.192938,0.176943,-0.129114,0.147168,-0.51147,-0.34366,0.00651619,-0.534508,-0.912351,-0.404418,-0.173808,-0.534703,0.356818,-0.458344,-0.718554,-0.296939,-0.315761,-0.296215,-0.574786,-0.485028,0.147786,0.268885,0.38443,0.518541,0.372408 +3380.96,0.906413,0.0848144,4,1.67156,0.99515,-0.457885,0.132308,0.308421,0.102135,0.642483,0.386121,0.349587,0.393853,0.253952,-0.250056,0.541218,0.317979,-0.427577,1.03813,0.131151,-0.526222,-0.0614178,0.024189,-0.478116,-1.21981,-0.798766,-0.201769,-0.0451813,-0.0662252,0.354453,0.178677,-0.470549,-0.160183,0.36273,-0.458459,0.477899,0.42002,-0.13851,-0.00516875,-0.396471,0.359976,-0.0669603,-0.111129,0.962399,0.305787,0.20653,-0.658724,-0.107393,0.0016757,-0.544744,0.436583,0.276125,0.0459583,-0.156249,-0.418137,0.372183,-0.388776,0.793966,-0.206269,-0.105233,-0.810489,0.253561,-0.00403066,0.192659,0.344969,-0.817337,-0.618192,-0.587755,-0.314529,-0.140051,-0.391092,-0.18786,-0.755686,-0.620233,-0.210746,0.445469,0.249894,0.296356,0.374741,0.823778,-0.163978,-0.267465,0.212388,0.800491,-0.0413345,-0.13081,-0.350465,-0.0835413,0.515001,-0.392492,-0.393624,0.339089,-0.217397,-0.287132,-0.123831,-0.243261,-0.0563279,-0.066471,0.163587,0.171004,-0.525684,0.846818,0.523437,-0.0696902,0.0899181,-0.402207,0.202364,0.142491,-0.318188,-0.114325,0.117835,0.208355,0.617639,-0.491092,-0.339177,0.0661329,0.148713,-0.0314912,0.00259766,0.118017,0.00623426,0.368992,-0.254881,0.0412437,-0.442724,-0.640582,0.192218,-0.208152,0.380274,0.00452794,-0.212409,0.0798456,-0.0382047,0.133536,0.188599,-0.298928,0.356834,0.00406155,-0.140066,0.378387,-0.122229,0.611674,-0.278928,-0.271935,-0.234069,0.159121,-0.863914,-0.110609,0.468335,0.0568736,0.383887,0.0316196,-0.566815,-0.0594837,-0.0871065,-0.0640605,-0.0455051,0.732564,0.560681,-0.0287512,0.164685,0.0165006,-0.517031,0.236147,-0.342011,0.425745,0.665534,-0.329844,-0.234962,-0.140339,-0.119282,-0.0762009,1.0071,0.280748,-0.635457,-0.100248,0.413847,0.00662688,-0.489005,-0.131318,-0.19129,0.037318,0.751642,-0.0332426,-0.965161,0.42109,0.278925,-0.41573,-0.5269,0.455544,-0.421226,-0.21511,-0.872919,-0.0506379,0.405251,-0.280379,-0.501344,0.469531,0.136315,-0.0652406,-0.0674161,-0.0729921,0.115978,0.184325,-0.340549,-0.226287,-0.34269,0.212708,-0.784795,-0.529305,1.30531,-0.203518,0.497506,0.119312,-0.718761,0.0849737,0.534802,-0.246649,0.0701432,-0.126479,0.0456517,0.569795,-0.317823,-0.134461,-0.0951435,0.272219,-0.188472,-0.702972,0.793043,-0.158679,0.0655377,0.216788,0.0138301,0.552313,-0.0337452,-0.417867,-0.524038,-0.854498,0.79388,0.107781,0.623014,1.15231,-0.378407,-0.0381197,-0.419088,0.173895,-0.104127,0.607098,-0.0690557,-0.202339,0.314073,-0.848165,-0.613064,-0.306113,-0.960351,0.205083,0.559962,-0.530938,-0.0747093,-0.591786,-0.153573,1.06433,0.244851,-0.0182978,-0.199171,-0.104099,-0.286345,-0.202951,0.504934,-0.449521,0.453393,-0.259969,-0.324687,-0.328049,0.16451,-0.194216,0.730954,0.576793,-0.666402,-0.00165211,-0.00861221,-0.0500877,-0.0958263,0.0622987,0.180097,0.415925,0.236643,0.0105853,-0.668032,-0.542852,0.289051,-0.560041,-0.777953,-0.252981,0.0886288,-0.618904,0.250268,-0.267685,-0.786178,-0.440739,-0.478939,-0.257354,-0.419658,-0.0327503,0.159072,0.339123,0.398838,0.582343,-1.02214 +3395.36,0.927718,0.0848144,4,1.62081,0.999782,-0.496857,0.109003,0.468834,0.078779,0.676919,0.426992,0.477618,0.310561,0.268971,-0.185672,0.449256,0.314719,-0.444439,1.00724,-0.0437744,-0.55242,-0.173116,0.0876296,-0.488441,-1.14106,-0.824407,-0.14215,-0.0296071,0.107643,0.331975,0.214763,-0.512479,-0.135171,0.409593,-0.531149,0.453619,0.466402,-0.0321281,-0.0930134,-0.448811,0.466854,-0.0462643,-0.249532,0.918265,0.380477,0.159741,-0.595478,-0.136674,-0.0381459,-0.470801,0.316674,0.285871,-0.101429,-0.163749,-0.477431,0.334945,-0.322263,0.825319,-0.214312,-0.129977,-0.842109,0.237408,-0.0652064,0.158041,0.359932,-0.654222,-0.919805,-0.497656,-0.335661,-0.069773,-0.233728,-0.110116,-0.838833,-0.524981,-0.318951,0.565436,0.173141,0.282555,0.373086,0.726959,-0.00677713,-0.299533,0.200696,0.917935,-0.0377376,-0.000794319,-0.43099,-0.0177877,0.448973,-0.581688,-0.466074,0.413833,-0.23972,-0.183711,-0.112227,-0.233364,0.0013265,-0.0179322,0.0558264,0.115345,-0.729733,0.720074,0.483242,-0.0482586,0.0552769,-0.299699,0.159572,0.159622,-0.355638,-0.134437,0.0327465,0.107268,0.602432,-0.519867,-0.408046,-0.0519568,0.185992,-0.0657663,-0.0397337,0.228871,-0.00197653,0.44647,-0.268853,0.0138969,-0.3269,-0.572869,0.237108,-0.147723,0.259501,-0.045719,-0.195604,0.236682,-0.0448945,0.0751227,0.146039,-0.284522,0.315572,-0.0920726,-0.10288,0.386068,-0.0124085,0.640624,-0.254248,-0.148761,-0.302916,0.183233,-0.815993,-0.179461,0.46828,0.127945,0.400123,-0.0325338,-0.610053,-0.137453,-0.054887,-0.0656393,-0.0433148,0.71764,0.401023,-0.014423,0.206081,-0.112342,-0.562442,0.232134,-0.251121,0.409089,0.697999,-0.25261,-0.313287,-0.00741206,-0.169762,-0.0390494,0.914979,0.250886,-0.490935,-0.0815584,0.434857,-0.0545708,-0.561566,-0.110723,-0.24992,0.0393779,0.74205,-0.0564861,-0.78678,0.430162,0.316589,-0.343811,-0.394915,0.309451,-0.287784,-0.116322,-0.951144,-0.115379,0.349668,-0.420062,-0.563498,0.393347,0.181523,-0.0895077,-0.022149,-0.131424,0.134464,0.172612,-0.239233,-0.165878,-0.226811,0.126894,-0.63009,-0.487835,1.29951,-0.13775,0.555345,0.0136017,-0.724736,0.11855,0.690794,-0.28004,0.0959972,-0.0979014,-0.0102109,0.60318,-0.354341,-0.178885,-0.0379755,0.330538,-0.161121,-0.694093,0.846148,-0.267632,0.0441215,0.17129,-0.0684317,0.44322,0.021348,-0.443544,-0.483911,-0.839243,0.736216,0.162788,0.629545,1.16533,-0.37042,-0.189328,-0.498254,0.150814,-0.022475,0.5753,-0.0141916,-0.145853,0.298165,-0.7895,-0.6082,-0.272198,-0.993134,0.302548,0.433057,-0.48705,0.00226643,-0.549275,-0.0415706,1.05296,0.285204,-0.132535,-0.21179,-0.0413515,-0.443067,-0.16907,0.485591,-0.470236,0.476944,-0.326286,-0.342459,-0.37074,0.0962601,-0.15347,0.591017,0.524853,-0.637945,0.0357923,-0.00311606,-0.162521,-0.142139,0.219584,0.175672,0.254269,0.365448,0.0331993,-0.619442,-0.399287,0.392594,-0.318257,-0.729954,-0.210757,0.011971,-0.573374,0.0310919,-0.195455,-0.779227,-0.467052,-0.411584,-0.190409,-0.454002,-0.0559429,0.174401,0.325352,0.417613,0.570396,-1.56519 +3397.22,0.719254,0.0848144,4,1.62198,1.03937,-0.495936,0.125973,0.481247,0.0747359,0.641012,0.336261,0.432363,0.259483,0.294173,-0.181768,0.45519,0.288979,-0.363003,1.02284,-0.0461069,-0.551835,-0.117904,0.126054,-0.516608,-1.15273,-0.827453,-0.178482,-0.0974202,0.17708,0.204101,0.276691,-0.398571,-0.0379137,0.426371,-0.485906,0.525946,0.433011,-0.0483257,-0.0557462,-0.482795,0.485417,-0.0525866,-0.213767,0.954483,0.461631,0.191644,-0.608064,-0.186033,-0.0580384,-0.490191,0.328356,0.383112,-0.0938628,-0.189302,-0.404812,0.261232,-0.349025,0.85073,-0.246061,-0.0895575,-0.820423,0.223315,-0.0798289,0.166843,0.398706,-0.577975,-1.03132,-0.498176,-0.326351,-0.120549,-0.20333,-0.149772,-0.842366,-0.525833,-0.263077,0.574727,0.161418,0.347942,0.397623,0.74806,-0.0180649,-0.213945,0.232268,0.841047,-0.0208431,-0.0150131,-0.458905,-0.0820488,0.484857,-0.540881,-0.395396,0.411969,-0.243832,-0.195923,-0.138315,-0.236468,-0.0538796,-0.0456581,0.109733,0.0309257,-0.766827,0.684237,0.491619,-0.0685162,0.168538,-0.354163,0.0795389,0.161737,-0.438454,-0.0788133,0.0219677,0.187046,0.554607,-0.582896,-0.325643,0.0117562,0.221198,-0.0630527,-0.098574,0.302209,-0.00530985,0.323508,-0.341602,-0.0124358,-0.401797,-0.510746,0.22417,-0.179807,0.227111,-0.000227517,-0.201363,0.190422,0.00219103,0.149811,0.177741,-0.23708,0.300147,-0.0640954,-0.0206546,0.335288,-0.0488975,0.650818,-0.313839,-0.172348,-0.306262,0.1027,-0.841804,-0.19459,0.433577,0.0503197,0.396388,-0.0501041,-0.525513,-0.12199,-0.0773303,-0.0276124,-0.0543582,0.630931,0.331899,-0.0192315,0.194905,-0.0592339,-0.539856,0.236982,-0.14252,0.416338,0.703409,-0.322285,-0.269373,-0.0321405,-0.217089,-0.0101805,0.970393,0.231467,-0.44793,-0.119312,0.430474,-0.0564805,-0.566696,-0.141701,-0.279175,0.0210035,0.813333,-0.121939,-0.69118,0.414871,0.257505,-0.248656,-0.40182,0.362883,-0.299842,-0.251809,-0.91959,-0.158673,0.341354,-0.403469,-0.554458,0.35807,0.109723,-0.0694736,-0.0498158,-0.140751,0.0683595,0.166514,-0.256381,-0.157852,-0.186289,0.136023,-0.593776,-0.442117,1.32023,-0.0180207,0.53695,0.0609427,-0.696097,0.0683464,0.631203,-0.301928,0.116967,-0.211743,-0.0587196,0.513601,-0.303391,-0.252031,0.0104811,0.370592,-0.143461,-0.727596,0.864656,-0.277063,-0.0180042,0.151304,-0.0566076,0.460852,-0.00668513,-0.513767,-0.451651,-0.847625,0.749686,0.123334,0.667842,1.15049,-0.376107,-0.146585,-0.52865,0.223623,-0.0202223,0.606145,-0.0520429,-0.166648,0.27808,-0.787498,-0.582936,-0.272452,-1.02579,0.310072,0.433734,-0.436186,-0.0115793,-0.62403,0.00228633,1.09526,0.278581,-0.198859,-0.180113,-0.110289,-0.439363,-0.198076,0.474953,-0.439298,0.562602,-0.24959,-0.269081,-0.338168,0.199029,-0.199511,0.595081,0.500157,-0.598848,-0.016204,0.0312819,-0.130077,-0.209267,0.25381,0.224893,0.352863,0.459394,0.0846119,-0.548067,-0.381714,0.355599,-0.268196,-0.784954,-0.192451,-0.0701173,-0.606078,0.0388718,-0.242625,-0.89832,-0.450203,-0.405627,-0.195563,-0.37794,-0.0574214,0.172343,0.332451,0.415142,0.576585,-1.69079 +3382.73,0.491648,0.0848144,4,1.54309,0.890949,-1.08637,0.409848,-0.14885,-0.0728678,-0.379641,-0.0583044,0.0542441,0.449361,0.126613,-0.209141,0.04962,0.365184,0.122483,0.691761,0.503331,-0.261557,-0.072179,0.286366,-0.383736,-0.7926,-0.676118,0.17842,-0.315509,-0.513066,-0.479256,0.20321,-0.233879,0.15802,1.09629,-0.0358968,-0.532768,0.535518,-0.82846,-0.505821,-0.71338,0.18947,0.388576,-0.261481,0.800006,0.897862,0.123568,-0.735019,0.119114,-0.796697,-0.367351,0.602682,0.801701,-0.0722411,0.0729257,0.707827,-0.265298,-0.332297,0.425844,-0.177151,-0.329179,-0.726702,0.466893,-0.157155,0.396654,0.755127,-0.616827,-0.934517,0.167484,0.331435,-0.199043,0.0697329,0.41955,-0.3017,0.372003,0.00761512,0.704318,-0.50497,0.628922,0.199157,0.422311,0.234106,-0.269856,0.121203,0.275395,-0.695835,0.413369,0.224635,-0.104866,-0.199939,0.84609,0.295465,-0.0840887,-0.651363,-0.0124317,0.329368,0.0101143,0.0108241,0.642123,-0.671455,0.593335,0.479092,-0.48,0.200143,0.170936,0.447269,-0.448895,-0.619318,0.491519,-0.288132,0.216145,-0.211764,0.171986,0.650525,0.0543632,0.0467065,0.352556,0.394706,0.268125,-0.00475406,-0.931383,0.0378203,0.103992,0.0328347,-0.997875,0.224835,-0.330531,-0.261928,0.105206,-0.0619848,0.243421,0.131577,-0.161542,-0.643593,-0.796647,-0.073724,0.476793,0.543803,-0.830493,0.37175,-0.39657,-0.355696,0.380871,-0.450958,-0.0744999,0.28448,0.0668615,-0.841614,0.784059,-0.393036,-0.387128,0.442571,-0.46774,-0.219428,-0.564244,-0.000588905,0.166017,0.313064,0.495396,0.680727,0.0628469,0.123888,0.362152,0.51301,-0.306608,0.104222,0.891393,-0.0159333,0.130067,0.0597833,0.00357655,-0.0563722,-0.232897,-1.03524,0.0472011,0.337917,0.0627838,-0.139719,-0.365014,0.428991,-0.484194,0.164162,0.244294,0.866821,0.285959,0.198466,0.887762,-0.271741,0.0676875,0.00470315,-1.13018,-0.668213,0.698645,-0.369533,0.281164,-0.213276,0.010466,-0.698678,0.246476,0.193282,0.25471,-0.225091,-0.733781,-0.0814788,-0.212649,0.179253,0.466337,0.232706,0.10864,-0.173915,-0.413653,0.4966,0.0757082,-0.278002,-0.276677,0.396975,0.487567,0.114902,0.154234,0.842252,-0.608238,0.581808,0.0894934,0.0106503,0.0668166,-1.27105,-0.49203,0.238297,-0.245066,0.237117,-0.361696,-0.243874,0.173333,0.0837742,-0.818067,0.157287,-0.33005,-0.372729,0.0044954,-0.0483235,0.0669183,-0.600392,0.204075,-0.263395,0.352377,0.99291,-0.420921,-0.400978,-0.370318,0.123851,0.373377,-0.255507,-0.123399,-0.101487,-0.0173135,-0.0658119,-0.105558,-0.635213,-0.19267,0.193235,0.0927937,0.12879,-1.1369,-0.361984,0.474932,0.584782,0.240802,0.462281,0.752867,-0.201973,-0.109877,-1.06339,-0.025436,-0.270133,-0.198778,-0.496634,-0.404267,-0.473842,-0.333856,0.090589,0.200273,-0.135399,0.926912,0.183011,-0.784973,-0.117275,-0.921002,-0.807253,0.0743075,0.440225,0.0514854,0.77925,0.277068,0.450952,0.171612,0.34803,0.318926,0.484311,-0.330523,-0.298398,0.0182998,0.395975,-0.0283522,-0.125753,0.541672,0.202037,0.210644,0.449486,0.458959,0.662409 +3391.83,0.723033,0.0848144,4,1.5631,0.908562,-1.07289,0.364249,-0.0920706,-0.0819831,0.357777,0.584655,0.569716,0.273782,-0.0620962,-0.178177,-0.206921,0.2918,-0.242234,1.01571,0.648782,-0.230779,-0.0635252,-0.0627893,-0.313051,-0.312147,-0.668298,0.335941,-0.455046,-0.504171,-0.10507,-0.120008,-0.643032,0.124674,0.800649,-0.184536,-0.437181,0.276482,-0.372018,0.155873,-0.825519,0.106024,0.143954,-0.282611,0.941968,0.544176,0.0321694,-0.715057,-0.0501241,0.0510601,-0.701807,0.0849924,0.113008,0.00161679,0.102122,-0.331527,-0.410297,0.0732394,0.131843,0.0763696,-0.308661,-0.320168,0.543382,-0.490022,0.754829,0.865465,-0.912068,-0.174327,0.196258,0.258404,-0.549494,0.334524,0.337345,-0.595617,0.356024,0.19567,0.818837,-0.231458,0.665829,0.129551,0.498643,-0.24208,-0.342863,-0.313714,0.039843,0.0813788,-0.0603986,0.0122082,-0.330062,0.365467,0.987314,-0.11663,0.161587,-0.481814,0.755337,0.0947648,-0.280563,0.192615,0.107415,-0.174915,0.163111,-0.299543,0.345355,0.279158,0.685396,0.495423,-0.535723,-0.298882,1.09208,-0.630764,0.372152,-0.222607,0.198853,0.832752,-0.190967,0.448038,-0.335085,0.773262,0.269432,0.17317,-1.03569,-0.230903,0.561142,-0.0762424,-0.69457,0.97234,-0.515399,0.124261,-0.137505,0.457746,0.0737234,0.139191,0.22391,-0.96569,-0.920914,0.282593,-0.251328,-0.0778046,-0.446461,0.0784762,-0.433635,0.21271,0.685222,-0.495942,0.0259305,-0.1564,0.307112,-0.499503,0.591496,-0.139951,0.574949,0.382872,-0.394901,-0.489346,-0.388359,-0.136525,0.523805,0.0832337,0.546841,0.875352,-0.173756,0.461873,-0.0843971,0.0649507,0.0264338,0.102075,0.0857928,0.400156,-0.719139,0.448745,-0.00802684,-0.206292,0.229956,-0.694793,0.648894,-0.156355,0.421041,-0.0941696,0.34433,-0.12027,-0.667153,-0.304169,-0.290646,0.691472,-0.1809,0.0325661,0.369455,-0.551039,0.143586,0.228051,-0.400672,-0.146879,0.211223,-0.696189,0.455222,0.0831401,0.0903132,-0.817307,0.497819,-0.00155525,-0.0127644,-0.0363763,-0.514206,0.111386,-0.209445,0.0783804,0.619321,0.000343148,0.0595064,-0.227248,-0.960968,1.0645,0.266357,-0.258459,-0.304513,-0.123589,0.0310838,0.456506,-0.0545894,0.29452,0.283595,0.349318,-0.0462757,-0.356049,-0.265483,-0.384606,0.0416652,-0.105649,-0.735107,0.264037,0.0321047,-0.129995,0.414808,0.200189,-1.1314,0.28029,-0.354983,-0.677791,0.0617218,0.411375,0.255619,-0.423473,0.886254,-0.218493,0.352034,0.639286,0.0163669,-0.410465,0.421733,0.438184,0.30878,-0.47453,-0.732541,-0.0151056,0.235786,-0.738649,-0.169286,-0.0311798,0.0474999,0.380039,-0.369372,-0.554783,-0.581343,0.111075,0.382205,0.43828,0.407082,0.383441,0.47784,0.214,0.0550836,-0.761146,0.339875,-0.237126,0.0661116,-0.314586,0.0667048,-0.00336646,-0.0723518,-0.300472,0.15133,-0.293225,0.599641,-0.222731,-0.490667,0.050447,-0.274279,-0.884725,0.253885,-0.323693,-0.203901,1.03929,0.32757,-0.0158881,0.255543,0.216115,0.617251,0.0229918,0.0518436,-0.373099,0.0764568,0.46041,0.140906,0.17992,0.290919,0.200215,0.216859,0.447454,0.465682,0.501228 +3396.99,0.927919,0.0848144,4,1.53799,0.896505,-1.02977,0.378726,-0.0474897,-0.0964186,0.420955,0.493693,0.530339,0.254101,-0.0293814,-0.188669,-0.223179,0.291237,-0.135754,1.06973,0.658838,-0.242405,-0.0172859,-0.0851518,-0.234668,-0.269925,-0.621428,0.362196,-0.432083,-0.508904,-0.107325,-0.0988274,-0.631146,0.141807,0.817071,-0.180044,-0.390838,0.284943,-0.425437,0.0757396,-0.801048,0.0751868,0.177933,-0.262548,0.934695,0.603559,0.0442339,-0.720756,-0.0994326,0.0805972,-0.765057,0.0619927,0.173176,-0.0261551,0.1266,-0.411159,-0.404493,0.039667,0.116025,0.0710818,-0.354268,-0.222884,0.529517,-0.454254,0.731838,0.910334,-0.876444,-0.184684,0.267293,0.264056,-0.573327,0.27553,0.37797,-0.641695,0.310874,0.238177,0.846731,-0.262653,0.696702,0.0631759,0.497228,-0.200716,-0.333068,-0.286104,-0.000529922,0.04213,-0.0474694,-0.0140652,-0.362341,0.299128,0.908569,-0.13469,0.148947,-0.503865,0.725546,0.0722362,-0.267332,0.20897,0.162232,-0.104321,0.231146,-0.298031,0.337833,0.238907,0.689192,0.459702,-0.486443,-0.281191,1.11184,-0.676822,0.342907,-0.168675,0.14063,0.767939,-0.194017,0.367095,-0.31455,0.770385,0.272918,0.237278,-0.942643,-0.277638,0.515499,-0.0897807,-0.762639,0.946313,-0.472317,0.107531,-0.0794495,0.409865,0.0920633,0.180981,0.164983,-0.95207,-0.962056,0.217936,-0.334629,-0.0606921,-0.506381,0.0496922,-0.346494,0.183345,0.679764,-0.590165,0.107126,-0.130886,0.351261,-0.417395,0.618993,-0.0938159,0.61073,0.412387,-0.406171,-0.566788,-0.34617,-0.175761,0.521767,0.114033,0.562383,0.856699,-0.170061,0.435726,-0.135673,0.107189,0.123932,0.190877,0.130098,0.381761,-0.70578,0.401284,-0.0174736,-0.141457,0.257495,-0.720401,0.608745,-0.15032,0.387782,-0.0330442,0.395412,0.0407924,-0.699743,-0.254575,-0.272181,0.743793,-0.162895,0.0133575,0.334535,-0.570536,0.00350982,0.230665,-0.353657,-0.117661,0.243207,-0.755062,0.452656,0.0545596,0.0429213,-0.745431,0.414634,-0.035353,0.0590768,-0.0554877,-0.455778,0.043876,-0.251665,0.176363,0.737805,-0.0522594,0.0437156,-0.224086,-1.00939,1.08828,0.131619,-0.318145,-0.268285,-0.12957,-0.029984,0.445042,-0.0815988,0.319875,0.27343,0.330472,0.00422314,-0.366649,-0.22233,-0.252487,0.0142594,0.0743414,-0.794152,0.294488,0.000292955,-0.101017,0.3522,0.132223,-1.05786,0.309524,-0.311244,-0.762175,0.0915251,0.329853,0.288293,-0.449512,0.899919,-0.279276,0.467726,0.594642,-0.0594101,-0.365799,0.406453,0.519835,0.285845,-0.427737,-0.697751,0.0220633,0.265196,-0.737892,-0.170762,-0.0870666,0.0376947,0.263026,-0.420605,-0.57416,-0.603119,0.0795313,0.400476,0.444161,0.409282,0.40207,0.487609,0.271715,0.0292408,-0.71,0.25112,-0.187058,0.0125787,-0.252487,0.0713485,-0.0746593,-0.154236,-0.281419,0.154225,-0.303949,0.526321,-0.204258,-0.528268,0.127168,-0.354174,-0.778808,0.28136,-0.352001,-0.2149,1.09674,0.289259,-0.0317933,0.252548,0.165914,0.690022,0.0309208,0.0203676,-0.412546,0.0976101,0.39845,0.179529,0.278084,0.256263,0.188517,0.221809,0.434185,0.470966,0.316654 +3418.1,0.673532,0.0848144,4,1.49913,0.947461,-0.997496,0.408034,-0.0224831,-0.051747,0.575931,0.275428,0.369516,0.248402,-0.255698,-0.0727745,-0.119051,0.0538797,0.161532,1.17405,0.519113,-0.132117,0.32453,-0.0426981,-0.23256,-0.370741,-0.848571,0.33791,-0.215722,-0.268079,0.10409,0.136915,-0.149717,0.0525102,0.700876,-0.171569,0.205103,0.525152,-0.679406,0.117092,-0.286856,0.221032,0.255983,-0.0105103,0.858209,0.675179,0.479957,-0.86996,0.084546,-0.024671,-0.556993,0.388507,0.467011,-0.0624226,-0.266981,-0.266093,0.0330133,-0.2466,0.142347,-0.00267186,-0.473719,0.0880562,0.329152,-0.133164,0.478464,0.821593,-1.09044,-0.834244,0.113236,0.634612,-0.767611,0.215368,0.047463,-0.654709,-0.0682515,-0.0914405,0.958117,-0.38205,0.151914,0.255682,0.191784,-0.0103823,-0.0876168,-0.0924784,0.167013,-0.273481,0.0822513,0.298269,-0.266111,0.349813,0.544262,-0.00199973,0.343073,-0.223033,0.120616,-0.256972,-0.381616,-0.302548,0.0249022,-0.395437,0.497922,-0.186052,0.169762,0.334966,0.511084,0.308844,-0.556383,-0.521509,1.15446,-0.435294,0.731533,-0.429946,0.0414861,0.739588,0.203904,0.272056,0.00178574,0.72214,0.383385,0.037329,-1.25167,-0.237417,-0.0760088,-0.0860782,-0.544035,0.956451,-0.635122,0.112885,-0.577079,0.200802,-0.0432566,-0.0425955,0.0836357,-1.22508,-0.59374,0.420645,-0.160214,-0.0336001,-0.279435,0.042557,-0.478328,0.127325,0.313724,-0.743552,0.186092,-0.0987922,0.396445,-0.224345,-0.118912,0.249413,0.395721,0.42106,0.00679838,-0.415216,-0.346544,-0.103042,0.297083,-0.0500361,0.18349,1.08499,0.133108,0.111404,0.0332091,0.345005,0.311447,-0.0128121,0.168918,0.264857,-0.00417668,0.233148,0.164321,-0.203339,0.231765,-0.633217,0.268934,-0.313915,0.206791,-0.380645,-0.189035,-0.622951,-0.621648,-0.287709,0.0121853,0.532857,0.0274383,0.429093,0.317301,-0.468323,-0.345506,0.22753,-0.107542,0.378563,-0.0747011,-0.402323,0.643107,-0.0298888,-0.22309,-1.03009,0.219675,-0.2478,0.359408,-0.17508,-0.629229,0.305346,-0.239372,0.331116,0.199538,0.3946,0.0165057,-0.176674,-0.729019,0.875466,-0.110373,-0.192463,-0.293343,0.281917,0.146183,0.190736,-0.449913,0.504111,0.0671682,0.558634,0.371661,-0.643297,-0.0791258,-0.231181,-0.0185145,0.404449,-0.588986,0.51181,-0.3786,-0.152984,0.139222,0.457191,-0.841241,0.312103,-0.229929,-0.352834,0.0132638,0.413868,-0.117168,-0.00394813,0.563883,-0.425641,0.227224,0.430857,0.350946,-0.654711,0.0262784,0.822542,0.325745,-0.246322,-0.90164,0.361856,0.221851,-0.432065,0.0942311,0.0588108,-0.478084,0.372935,-0.238764,-0.137814,-0.24973,-0.0228864,0.48777,0.472739,0.152397,0.32552,0.152033,0.343327,0.331904,-0.533713,0.180144,0.18802,-0.0193861,-0.130968,-0.266722,-0.0796934,0.0572687,0.0996035,0.085485,-0.0366771,-0.0338428,0.0327714,-0.483997,-0.185241,-0.422992,0.0067349,0.268828,-0.0803687,-0.10383,0.871542,0.151193,-0.265787,0.220905,0.474992,0.495551,-0.189752,-0.178524,-0.381224,0.0416018,0.213345,0.695025,-0.0669864,-0.232949,0.170687,0.132044,0.413143,0.363379,0.0487783 +3378.06,0.972345,0.0848144,4,1.54781,0.638796,-1.42194,0.714195,0.659316,-0.145247,-0.0504779,0.487974,-0.20547,-0.259301,0.0946034,0.19046,0.201705,0.215788,-0.0229543,0.902577,0.236355,0.0454441,0.34084,-0.0448541,-0.285026,-0.7636,-0.399735,0.867933,-0.289898,-0.386904,0.105681,-0.0359576,-0.439138,-0.0204811,0.742352,-0.464782,0.102063,0.511427,-0.451798,-0.442285,-0.196069,0.424349,0.0947339,-0.161436,0.807346,0.0191,0.340679,-0.617186,-0.117756,0.968697,-1.14899,-0.30866,0.104266,0.282817,0.0518226,0.404867,-0.064663,0.134256,0.01141,-0.332631,-0.229405,-1.03329,-0.0800353,-0.480616,-0.0817772,0.477876,-1.27377,-0.466065,0.210374,0.0375123,0.0680283,0.294078,0.448791,-0.364363,0.0757743,-0.28029,1.1417,-0.0384331,0.238248,0.568632,0.576737,-0.685194,-0.0651524,0.132725,0.727714,-0.450337,0.102002,-0.642955,0.28555,-0.367959,-0.444262,0.193423,0.395661,0.0738593,-0.310902,-0.0229884,0.0338588,0.249508,0.0343223,-0.53347,0.252616,-0.366118,-0.141906,0.168305,0.246533,-0.414779,-0.0600176,0.249704,-0.810594,-0.652889,0.310714,0.0892993,0.0397621,0.692014,0.208787,-0.200063,0.164201,0.6994,-0.101251,0.421197,-1.14944,0.50772,0.201488,0.153524,0.0740499,-0.0902993,-0.0746108,-0.488224,-0.49875,0.291404,-0.32244,-0.136817,0.605917,-0.801755,0.2068,0.143334,-0.236717,0.149133,-0.152332,-0.0944401,0.0238613,-0.0454018,0.529012,0.0402511,-0.0892131,-0.0525477,0.308516,-0.392926,-1.01557,0.502352,0.2381,0.309183,0.0882255,0.207,-0.32459,-0.210344,0.0982075,0.178336,0.120923,-0.0533025,0.172225,-0.206263,0.00594532,0.0668105,-0.23957,0.0226591,0.436459,0.368752,0.738414,0.931214,0.0148088,-0.484706,-0.561284,-0.548623,-0.00361373,-0.518374,0.358038,0.0215861,0.439568,-0.108451,-0.276186,0.324501,0.0525869,1.12174,0.467221,0.0539934,0.478981,-0.442922,-0.95337,0.189069,-0.583187,0.0010312,0.377489,-0.520373,-0.0334533,-0.102598,-0.0239705,-0.721413,-0.222388,0.161975,0.0432549,0.00379812,-0.722983,-0.681879,-0.238481,0.172413,0.39336,0.0324198,0.653558,-0.345904,-0.921404,1.38828,-0.585222,0.815838,0.251461,-0.303732,0.139552,0.209026,-0.692974,0.64629,-0.625564,0.0217793,0.7948,-0.248455,0.0316897,-0.897293,-0.489525,0.220706,-0.301193,0.289299,-0.404115,-0.136054,0.858202,-0.419298,-0.212476,0.439114,-0.705769,-0.0820915,0.12796,0.585267,0.186903,-0.245492,0.882079,0.885704,-0.461778,-0.266891,-0.435614,-0.00863981,0.495649,0.128124,0.792477,0.212983,-0.106792,0.104081,-0.228391,-0.336477,0.372278,0.151766,-1.01211,0.23976,0.363202,-0.436345,0.449798,-0.00545244,-0.1385,0.945511,0.0568722,0.393322,0.359783,0.0479473,0.0343359,0.0466342,-0.449415,-0.389871,0.0290734,-0.698736,-0.299534,0.401501,-0.427493,-1.34466,0.225127,-0.0889728,0.306503,-0.305222,0.122906,-0.1539,-0.10546,0.0295198,-0.172521,0.177812,0.113132,0.353987,0.00102153,-0.446936,0.442514,0.288562,-0.212278,-0.219812,-0.168419,-0.850936,-0.489897,0.219177,-0.49013,0.356386,0.776201,0.219533,0.329534,0.468543,0.574051,-1.66424 +3372.96,0.954122,0.0848144,4,1.592,0.836184,-1.15372,0.48927,0.577461,-0.0803051,0.149251,-0.00697301,-0.0299491,0.19909,-0.23105,0.0801241,-0.1562,0.129182,0.178467,0.912941,0.0945435,-0.000636161,0.157437,0.0118762,-0.203264,-0.919104,-1.37044,0.619176,-0.421648,0.209508,0.0787013,-0.0583114,-0.441526,0.138836,0.452598,-0.564974,-0.333871,0.473051,-0.650714,-0.226548,-0.355525,0.494733,0.255745,-0.142985,0.727114,0.762609,0.52404,-0.839483,-0.190514,0.418349,-1.20903,-0.0513418,0.20191,0.0211532,-0.135221,0.103258,0.164297,-0.3284,0.0509019,-0.197044,-0.591996,-0.874953,0.129846,-0.454607,0.599688,0.503083,-0.90525,-1.58734,0.378272,0.265444,0.0985569,-0.294174,0.360531,0.668524,-0.1718,-0.272984,0.844038,-0.238685,0.413558,0.560999,0.540558,-0.775864,-0.204928,0.442878,0.857445,0.0111074,-0.623139,-0.942976,0.157601,-0.154728,0.591983,-0.371727,-0.620702,0.0465699,0.164084,0.0953313,0.135284,0.139101,0.298339,-0.673439,0.403457,-0.600028,0.200914,0.482672,0.488996,-0.0745385,-1.45818,-0.325821,-0.37922,-0.294468,0.23552,0.0102708,-0.0367333,0.416323,-0.264189,-0.41655,0.960207,0.724919,-0.370913,0.111444,-1.11681,0.365407,0.15202,-0.053445,-0.51354,-0.186511,0.316025,0.297956,0.456481,0.373083,-0.337501,-0.150639,0.398854,-0.649089,-0.356422,0.218938,-0.577212,0.338013,-0.218494,-0.139362,-0.538665,-0.0457981,0.564911,-0.0424146,-0.235896,-0.183121,0.66691,-0.634513,-0.0633721,-0.0917179,-0.00106721,0.446372,0.363906,-0.356078,0.184505,-0.0335703,0.707781,0.0773403,0.297298,0.62565,0.899089,0.28625,-0.171412,0.148435,0.421191,-0.175119,1.06461,-0.217333,-0.105418,0.730222,-0.0962455,-0.270596,0.0240125,-0.151485,-0.0519562,0.101458,0.25335,-0.519883,0.0590367,0.134132,-0.2808,-0.165913,0.543933,0.966511,-0.116799,-0.721567,0.242471,-0.106833,-0.28218,-0.0327994,-0.235852,0.0795574,-0.312006,-0.800963,-0.0871443,0.109725,-0.0825604,-0.592918,-0.825913,0.563557,-0.151606,0.0844159,-0.939221,-0.016481,-0.258045,0.34767,0.402964,-0.0279865,0.335541,-0.463388,-1.06134,1.05365,-0.343778,0.847648,-0.0180193,0.0328196,0.450481,-0.650518,0.100572,0.997883,-0.375788,0.0191787,0.561231,-0.410389,0.291714,-0.715105,-0.672946,0.955317,0.249186,0.591255,-0.360358,-0.460459,0.0657954,-0.033721,-0.817158,0.378008,0.553369,0.289904,-0.242618,0.762299,-0.165105,-0.476021,0.683626,0.292842,-0.581338,-0.358193,0.532901,-0.0302904,0.619483,-0.0257599,0.307696,-0.0805456,0.15114,-0.365411,-0.688083,-1.00257,0.438746,-0.217332,-0.644742,0.667555,-0.13463,-0.498441,0.478469,-0.196025,0.268361,0.0617873,0.420251,0.362948,0.102864,0.21111,0.534787,0.602249,-0.538141,-0.116046,-0.0764638,-0.348621,-0.264185,0.0600864,0.069201,-0.9242,0.675119,-0.383386,0.812701,0.744832,-0.307223,0.00279234,-0.56999,-0.345942,-0.080387,0.109109,-0.0187389,0.229475,0.310244,-0.567818,0.45695,-0.235716,-0.148567,0.076079,-0.151125,-0.420232,-0.190833,0.374638,-0.531049,-0.304048,-0.228267,0.203636,0.194251,0.451261,0.440739,-1.64112 +3387.22,0.853872,0.0848144,4,1.47639,0.920717,-1.54247,0.584232,0.108557,-0.0122009,-0.911054,-0.247784,0.752813,0.0338274,-0.340974,0.0551275,0.37801,0.670985,0.262828,0.76494,0.188466,0.200414,0.203504,-0.00816826,-0.0303235,-0.940845,-0.00891136,0.549575,0.0657811,-0.168595,-0.151204,0.189321,-0.389012,0.339308,0.166183,0.236965,0.188105,0.30921,-0.653941,-0.296907,0.108405,0.197583,-0.00460436,-0.343537,0.920992,0.544125,0.337859,-0.963429,-0.305583,0.328453,0.132953,0.344189,0.282508,0.0211233,0.133125,0.277353,0.0550187,-0.401564,0.192076,-0.0368701,-0.167273,-0.185578,-0.202191,0.322577,0.177081,0.675922,-0.268083,-0.446109,-0.0211238,0.827327,-0.114495,-0.246247,0.210968,-0.768315,-0.123709,0.587528,0.142167,-0.473325,0.694396,0.271005,0.0802801,0.0435729,-0.264837,-0.252169,0.712875,-0.766425,0.204566,0.0651581,-0.581021,-0.297173,0.375279,0.177014,-0.0964089,0.0715145,-0.297275,0.0604657,-0.110883,0.239457,0.313533,-0.55889,0.450692,0.0809955,-0.0362476,0.60852,0.101103,-0.351546,-0.10532,0.13443,0.346099,-0.398613,0.878697,0.223726,0.467215,0.803223,-0.701286,-0.209653,-0.0012387,0.374589,-0.053682,0.36215,-0.342593,0.534459,-0.306424,0.131451,-0.619132,-0.321042,-0.35883,0.394598,0.399534,0.79274,0.610629,0.521,0.491353,-0.463112,0.107614,-0.385386,-0.186316,0.408421,-0.0583,-0.0338064,-0.0219768,-0.33042,0.305022,-0.653778,-0.00385947,-0.591966,-0.276486,-0.382028,-0.0751901,0.134329,0.342569,0.0317239,0.230454,-0.569049,0.0472269,0.0655883,-0.179072,-0.196566,0.538387,0.931532,0.433167,0.360372,0.375936,-0.0292332,0.362054,0.562627,0.484809,-0.192279,0.297049,0.136406,0.472254,-0.372423,-0.203418,0.0948529,0.339817,0.382099,-0.00135845,0.122891,0.0916445,-0.6062,0.116057,-0.245045,0.117731,1.13312,0.722006,-0.359309,0.418245,0.586496,-0.235083,-0.403678,-0.173568,-0.332818,-0.0994456,-0.445057,-0.093669,-0.0639185,0.196342,-0.094045,0.263663,-0.643623,0.369551,-0.74753,-0.290521,0.104072,-0.49475,-0.443163,-0.619685,-0.262176,-0.586174,0.254283,-0.272086,1.5977,0.03766,-0.157009,0.0350763,0.118508,0.477497,-0.425466,-0.331055,0.0806836,-0.503588,0.541667,-0.0288002,-0.00522196,-0.661531,-0.128456,-0.821479,0.0527421,0.0666998,0.831138,-0.453919,0.302083,0.618185,0.381213,0.0809609,0.0844689,-0.471354,-0.463057,-0.22006,0.915373,-0.228563,0.163216,0.830029,-0.119738,-0.476134,0.234549,0.658432,0.326087,0.152062,0.379106,1.04245,0.192355,-0.516257,-0.514335,-0.56347,-0.39936,0.410404,-0.745375,-0.120855,-0.033855,-0.246991,0.219096,0.0624973,-0.432684,-0.382468,0.29021,0.120686,0.190711,0.741911,0.0880635,0.118736,-0.434534,-0.0410131,-0.174236,-0.0069269,-0.0786803,0.122039,0.207515,0.0551399,0.560821,-0.366618,-0.221185,-0.633498,-0.131841,0.184881,-0.113876,-0.12763,-0.560378,0.534667,0.440799,-0.311086,0.39707,-0.367381,0.24563,-0.120929,0.857375,0.633971,0.0561472,0.422163,-0.578126,-0.695602,0.0944768,-0.72993,0.116003,0.145007,0.17651,0.234702,0.420131,0.48446,-0.252352 +3397.74,0.917593,0.0848144,5,1.59033,0.754688,-1.18661,0.419041,0.134755,-0.199727,0.308058,0.340615,-0.312988,0.222984,-0.357542,0.0290889,-0.294076,0.681878,-0.715807,0.497597,0.0807162,0.175349,-0.177768,-0.203716,-0.328792,-0.529819,-1.32446,0.327707,-0.418124,-0.832672,-0.380774,0.141824,-0.189875,-0.442224,0.676285,-0.888507,-0.52872,0.0734196,-0.173073,0.117399,-0.254385,0.446882,0.528598,-0.510259,1.02683,0.3643,-0.236842,-0.438376,-0.375141,-0.000764883,-1.01592,0.169149,0.615424,0.106524,0.279998,0.322076,0.0811838,0.134088,0.505468,0.0150596,0.0634442,-0.893445,0.809845,-0.518413,-0.323508,0.539605,-0.577259,-0.743745,-0.395998,-0.215791,-0.0211827,0.2303,0.375427,0.250071,-0.158895,0.332331,0.66049,0.304769,0.66539,0.713923,0.411285,-0.267678,-0.0983642,-0.0443572,0.329098,0.202245,0.140507,-0.367057,0.238766,0.1198,-0.187093,-0.223545,0.454222,-0.078345,0.0510284,-0.177705,-0.0860256,-0.322292,-0.443526,-0.0890939,-0.413766,-0.56391,0.293304,0.265167,0.161042,0.0610102,-0.59333,-0.43994,-0.0101638,-0.135851,-0.256721,-0.31776,-0.154498,0.524763,0.297755,-0.302613,0.359767,0.504686,0.243312,0.167015,-0.287518,-0.70528,0.541637,-0.0899624,-0.276417,0.216965,-0.265019,-0.705786,-0.320806,-0.249281,-0.193347,0.0972863,0.376109,-0.341476,0.406001,-0.358902,0.127904,0.813476,-0.196949,-0.375396,-0.183757,0.185671,0.569313,-0.383817,-0.656714,0.0812193,0.375032,-0.638616,0.119871,0.295664,-0.240709,0.892613,-0.334364,0.20314,-0.64809,0.332328,0.493275,-0.17948,0.176376,-0.234576,-0.143176,-0.276305,0.177026,0.102492,0.261414,-0.554845,0.90253,-0.0215774,-0.365465,0.279135,-0.0998196,-0.00807914,-0.137633,0.152763,-0.0569645,-0.431208,-0.028541,-0.0442749,0.0199746,0.36573,-0.565758,-0.0839972,0.442829,0.541758,-0.67011,0.101204,0.0306129,-0.429887,0.208009,-0.0929751,-0.0248848,0.172134,0.294345,-0.123219,-0.222036,-0.0161418,-0.0706678,-0.839713,-0.329043,0.74444,-0.141807,-0.2358,-0.846612,-0.0125139,-0.211981,-0.0523577,0.802815,0.0877832,0.602509,-0.193939,-0.494338,1.33935,-0.147141,0.284061,-0.0107024,-0.539145,-0.500691,0.759593,-0.0645989,0.392898,0.0408384,-0.0557235,0.682033,-0.428057,0.459041,-0.545577,0.667513,0.415301,-0.672901,0.549043,-0.27607,-0.633361,-0.308262,-0.456082,-0.252017,0.136042,0.176813,0.36165,-0.445729,0.116644,0.0523263,0.0194955,1.06256,-0.747815,0.232777,0.0136,-0.537276,-0.25376,0.611653,0.411746,0.230725,0.0440129,0.458452,-0.819376,0.410654,-0.619311,0.551512,0.0795113,-0.447341,0.634662,-0.413462,-0.0771307,0.154907,-0.104456,0.516111,0.172272,0.0451535,0.252055,-0.181226,0.201698,0.187179,0.101464,-0.282361,0.30528,-0.406347,-0.581399,-0.701178,-0.10137,-0.103378,-0.531589,0.8178,0.296326,1.16999,-0.00532474,-0.23229,-0.144099,-0.403054,0.550105,0.0667637,-0.373251,-0.0784475,0.184097,0.234844,-0.427932,0.367565,-0.597499,-0.214567,0.132911,-0.556748,-0.345176,0.806746,0.305483,0.304199,-0.362015,-0.204581,0.154058,0.294818,0.392503,0.542972,0.0847094 +3388.18,0.975641,0.0848144,4,1.59454,0.752942,-1.14393,0.379408,0.330943,-0.202941,0.286449,-0.0283902,0.0833338,-0.105046,-0.335687,-0.119069,-0.278037,0.66184,-0.512289,0.489456,0.0252178,0.202197,-0.084074,-0.207038,-0.250801,-0.656532,-1.54313,0.328627,-0.639511,-0.877536,-0.470136,0.329582,0.0227857,-0.291305,0.474128,-0.980955,0.105888,0.192488,-0.115273,0.266564,-0.131147,0.881357,0.189816,-0.399468,0.793652,0.399373,-0.30357,-0.200565,-0.441821,0.442195,-0.852051,0.307164,0.427819,-0.153772,0.384683,0.344558,-0.0966476,0.229938,0.575104,0.0687753,0.26918,-0.939255,0.948853,-0.56254,-0.071457,0.886424,-0.368751,-0.839489,0.177902,0.0172039,-0.156061,0.617457,-0.077614,0.185059,-0.124696,-0.113648,0.240835,0.430004,0.527486,0.715948,0.518039,-0.351966,0.100615,-0.190199,0.160165,0.288671,0.396192,-0.912625,0.476421,0.540388,-0.116191,-0.0908983,0.540083,-0.256726,-0.273448,-0.137959,-0.0945944,-0.328092,-0.399509,-0.286508,0.0260332,-0.252264,0.545232,0.542164,-0.00838586,0.0136422,-0.718096,-0.601004,-0.286143,0.133303,-0.321223,-0.365841,0.0654235,0.662811,0.142525,-0.210325,-0.0782518,0.489976,0.194369,0.0293582,-0.565918,-0.300398,0.357107,-0.0160301,-0.499478,-0.207959,-0.218921,-0.646133,-0.355512,-0.286718,0.165611,0.313365,0.929796,0.213336,0.565162,-0.285537,0.371684,0.784293,-0.0514139,-0.531998,-0.0961457,-0.0962614,0.58475,-0.28923,-0.902263,0.30355,0.656652,-0.841726,-0.232144,0.322537,0.0458693,0.702427,-0.167677,-0.248952,-0.452042,0.0812955,0.395868,-0.309863,0.264515,0.120222,-0.112047,-0.332501,0.358459,0.0891774,0.180675,-0.741363,1.28485,0.253268,0.375872,0.34647,0.00894762,0.0244834,-0.272661,-0.214027,0.236501,-0.254104,0.090571,0.0600615,0.0753563,0.375316,-0.541813,-0.0352377,0.345377,0.543737,-0.707179,0.0279959,-0.0479483,-0.0549232,0.404493,-0.0800686,-0.104776,0.175527,0.151946,0.130344,-0.316019,0.131696,0.116452,-0.561323,-0.129046,0.501417,-0.155587,-0.484183,-1.20919,-0.138577,-0.180626,-0.155135,0.977766,-0.167198,-0.161011,-0.293668,-0.0609827,1.05315,-0.17718,0.468395,0.00873929,-0.59214,-0.520319,0.636611,-0.0113409,0.57253,0.0408548,0.195284,0.465012,0.160566,0.287975,-0.419573,0.69545,0.954339,-0.775151,0.614489,-0.221414,-0.735109,-0.302861,-0.569389,-0.0944258,0.26605,0.0362027,0.077127,-0.551509,0.0563192,-0.126561,0.174711,1.08948,-0.378266,0.327134,0.0429222,-0.074864,-0.138208,0.758449,0.634463,0.427046,0.116239,0.00905403,-0.597603,0.117553,-0.551565,0.421983,0.0374401,-0.459393,0.52655,-0.605796,0.00927316,0.255579,-0.155869,-0.0391256,0.302457,0.0444579,0.296497,-0.311954,0.0852912,0.322084,-0.103152,-0.44423,0.273906,-0.382248,-0.513534,-0.883141,-0.211988,-0.140774,-0.76045,0.572518,0.410557,0.971368,-0.109605,0.0608033,0.135788,-0.332404,0.157729,-0.00410976,-0.411264,-0.309194,-0.0141241,0.263919,-0.432442,0.501304,-0.201902,-0.0109698,0.520056,-0.648202,0.0987198,0.594212,0.364031,0.221019,-0.705049,-0.471974,0.192716,0.248183,0.438995,0.49818,-0.543328 +3396.54,0.998443,0.0848144,4,1.63839,0.730687,-0.709847,0.141719,0.0942309,-0.119157,0.0653865,-0.358243,-0.566099,-0.251975,-0.289788,-0.283052,-0.220168,0.538193,-0.585612,0.426067,0.0880153,-0.168798,-0.521582,-0.0887318,-0.205917,-0.855241,-0.835444,0.355348,-0.246672,-0.573915,-0.201049,-0.114344,0.0730485,-0.30266,0.525133,-0.672914,-0.514006,0.141924,-0.0542292,0.365093,-0.759958,0.370618,0.452287,-0.97523,0.842096,0.0422156,-0.0928843,-0.454543,-0.2451,-0.159078,-1.18166,0.520239,0.823581,0.389585,0.0672734,0.193078,0.281696,-0.251236,0.760286,-0.0249893,0.0224259,-0.972174,0.789352,-0.326701,0.111919,0.65116,-0.538307,-0.652631,-0.297561,0.4567,-0.614713,-0.268668,0.379996,-0.167134,-0.410358,-0.105143,0.513815,0.550691,0.730837,0.533777,0.00628419,-0.283383,-0.027905,0.265518,0.780178,-0.414257,0.00969056,-0.420332,0.277041,-0.280868,-0.513774,-0.213637,0.184449,-0.261901,0.225502,0.163963,0.470457,-0.266059,0.0733431,-0.362579,-0.494801,-0.131757,0.853259,0.360135,0.137001,0.227525,-0.952009,-0.290934,0.183874,-0.319594,-0.190347,-0.773741,0.311759,0.76221,0.118825,0.295918,-0.10354,0.831364,-0.64931,-0.450713,-0.356624,-0.138498,0.101668,-0.248015,-0.790325,0.305891,0.212246,-0.0849129,0.178413,0.197994,0.231605,-0.268232,0.30142,-0.00371068,0.470804,-0.328325,0.277776,0.622474,0.131373,-0.0243901,-0.131246,-0.0358207,0.530057,-1.11038,0.581667,-0.0930795,0.224252,-0.378486,0.0582769,0.109128,-0.587137,0.521253,0.100143,0.0276242,-0.379767,-0.363206,0.168468,-0.0662848,-0.190869,0.283041,0.275991,-0.200723,0.271247,0.392158,0.789289,0.117929,0.971828,-0.86007,0.734781,0.201985,-0.125937,-0.782429,0.00931653,-0.110702,0.249478,-0.239558,0.405149,-0.337897,-0.317377,-0.37279,-0.920528,-0.104322,0.73798,0.575477,-0.219599,0.434687,0.615308,-0.493658,0.305072,-0.0359182,0.143961,0.0165468,0.123985,-0.688392,-0.100924,0.0583581,0.300559,-0.536012,0.189894,0.943229,0.141562,-0.135787,-0.393021,0.931874,0.03066,-0.200007,0.777494,-0.771983,0.0629365,-0.572814,-0.684977,1.04194,-0.475622,0.880295,0.0494684,0.190961,-0.223409,0.324412,-0.425086,0.543081,-0.334531,0.30261,0.706998,-0.824562,-0.303029,-0.358537,0.13556,0.374553,-0.717551,0.163802,-0.617981,-0.344501,0.277253,-0.101173,-0.647654,0.419876,-0.275358,-0.366245,-0.585457,0.241496,0.665817,-0.275092,0.595392,-0.217943,-0.536982,-0.45053,-0.174061,0.141535,0.406233,0.139985,0.561161,0.268861,-0.759853,-0.057022,0.185917,-0.771864,0.675046,-0.233462,-0.174059,0.680646,-0.0440202,0.239429,-0.132021,0.436754,0.326915,0.511677,0.153195,0.264094,-0.443426,0.0968246,0.0787719,0.362174,0.165605,-0.0512828,0.000544965,0.123108,-0.418265,-0.316481,-0.186755,-0.421415,0.318061,0.134159,0.459124,0.545857,0.506545,-0.420206,0.203541,-0.789455,0.163708,0.73242,0.0469278,0.746465,0.524096,-0.358098,0.23488,-0.52325,0.209677,0.511019,0.118924,0.164167,0.444468,0.132651,0.0208221,-0.136224,0.494428,0.171269,0.286412,0.413846,0.535174,0.302097 +3393.76,0.42235,0.0848144,5,1.52522,0.779015,-1.02433,0.256344,-0.225073,-0.286493,0.233365,0.430731,0.336338,0.0995801,-0.514118,-0.176775,-0.0852284,0.721906,0.273106,-0.0616871,-0.206229,-0.0213647,0.160412,-0.199415,-0.344459,-0.785232,-1.18481,0.4986,-0.276755,-0.485071,-0.0664578,-0.0670021,-0.150502,0.195726,0.614549,-0.334859,-0.0658154,0.201862,0.107521,-0.136969,-0.371624,0.828352,0.136783,0.0526938,1.07534,0.656354,-0.405921,-0.56534,0.0851848,0.294065,-0.493144,0.0892153,0.760317,-0.307161,0.390378,0.299961,0.0251162,-0.212946,0.576906,0.0812944,0.191298,-0.174591,0.575369,0.0973644,-0.0663234,0.678822,-0.641416,-1.60511,0.647512,-0.227775,-0.014313,0.0258591,0.295944,-0.0997902,0.332051,0.268029,0.492833,-0.585473,0.934467,0.89697,0.567052,-0.666198,-0.0640413,0.28289,0.211134,-0.485314,0.25666,-0.019667,0.0781451,-0.519737,0.0967338,-0.0689195,-0.0182641,-0.167713,0.0646245,-0.217733,-0.31038,0.134203,-0.0882787,-0.433821,0.0680916,-0.36371,0.107345,0.198781,0.602215,0.542429,0.121281,-0.185542,-0.366507,-0.267164,0.133852,0.14069,0.133274,0.567487,-0.877389,-0.775593,-0.178937,0.612404,-0.10122,-0.0226197,-0.492881,-0.117098,0.0824546,0.863295,-0.167797,0.0847739,0.409917,-0.00658281,-0.419649,-0.113576,0.228672,0.532912,0.841276,-0.359109,0.00190986,0.128178,0.0831462,0.609268,-0.00174153,-0.276943,0.439709,0.0589421,0.615799,-0.403065,-0.388321,-0.00829586,-0.533999,0.084213,-0.0107587,0.445361,-0.345252,0.221069,-0.230133,0.150527,0.249054,0.29195,-0.109957,0.300885,0.43566,0.012773,-0.239837,0.30434,0.0862866,-0.277265,0.438939,0.0631997,0.632501,0.190988,-0.471983,-0.0461754,-0.163311,0.248658,-0.230242,-0.00774305,0.484834,-0.246997,0.193938,0.48626,-0.0557298,0.286325,-0.155266,-0.250638,-0.144224,1.18582,-0.136047,0.169065,-0.109604,-0.194501,-0.377409,-0.291434,-1.09929,-0.303311,0.0115026,-0.200395,-0.226424,-0.134299,0.0612162,-0.7812,-0.0953668,-0.786691,0.475033,-0.0619979,-0.465814,-0.365687,-0.215843,-0.10527,0.161866,-0.000307625,0.016184,-0.394619,-0.245647,0.948601,-0.123444,-0.380891,-0.332343,-0.490929,0.207557,0.340695,-0.394486,0.0661383,-0.185241,0.23755,0.119693,-0.352387,0.513762,-0.204828,-0.383758,0.899979,-0.621932,0.107491,-0.00590747,-0.138316,-0.208164,0.194006,-0.0700121,0.362762,-0.407614,-0.0897594,0.495504,0.369945,-0.432802,0.459275,1.02965,-0.0723004,0.263289,0.268537,-0.81107,-0.070759,0.698767,0.554076,1.25756,-0.103752,-0.109789,-0.36931,-0.239625,0.132679,0.715971,-0.392925,-0.604237,0.671755,-0.0496091,0.0979336,0.498387,-0.265749,0.368994,-0.00076156,0.204767,0.231378,0.128045,0.038565,0.33846,-0.457843,-0.90342,0.214933,-0.198526,-0.318931,-0.127206,0.306484,0.0347963,0.34142,0.357337,0.0203199,1.03601,-0.268021,-0.220651,-0.332038,-0.782525,0.367075,0.140232,0.0962989,0.141262,-0.0223792,-0.519462,-0.777833,0.689734,0.630652,0.1637,0.464552,-0.427761,-0.59378,-0.362211,0.590073,0.0610838,-0.259036,-0.837778,0.144818,0.197252,0.38055,0.44413,1.26187 +3408.98,0.957341,0.0848144,4,1.53843,0.776078,-0.956392,0.241016,0.118558,-0.182849,0.118156,0.491877,-0.170475,-0.157151,-0.423546,-0.20313,-0.441112,0.276199,-0.136046,0.672822,0.00691666,-0.0245044,-0.0704552,-0.0387684,-0.596847,-0.841601,-1.14878,0.273534,-0.0162351,-0.296041,-0.291511,0.220035,-0.237803,0.0610059,0.80829,-0.311231,0.398398,0.417586,0.114392,0.161385,-0.78707,0.639173,0.00216289,-0.068127,1.13022,0.453713,0.364988,-0.383381,-0.0795639,-0.175291,-0.491081,0.509365,0.788201,0.0219043,0.58126,0.192545,0.478447,-0.458232,0.764598,-0.0943151,-0.0583958,-0.363057,0.847494,0.176999,0.103275,0.241558,-0.512866,-1.33325,0.254054,-0.290767,0.15506,0.399564,0.504849,0.0501015,-0.184581,0.367032,0.669575,-0.604179,0.731135,0.823328,0.080525,-0.40912,-0.00646491,0.0954401,0.608979,-0.728858,0.037513,-0.224454,0.447972,-0.579527,0.21689,-0.287851,-0.0299122,-0.514982,-0.0768596,-0.461457,-0.291716,-0.044396,-0.35476,-0.566979,-0.0920762,-0.158136,0.44876,0.094186,0.274092,0.404981,-0.913277,-0.0897455,-0.175694,-0.105086,0.103846,-0.204676,0.459461,0.424833,-0.31043,-0.350268,-0.240376,0.64483,0.0199757,-0.197411,-0.00892682,0.0369604,-0.083176,0.114918,-0.65396,-0.270489,0.255419,-0.175719,-0.0983417,-0.0317018,-0.0195851,0.650129,0.474784,-0.471325,-0.0777588,0.00722041,-0.0396229,0.807154,-0.0558153,-0.14083,0.135314,-0.301196,0.742475,0.061633,-0.0923736,0.139102,-0.197944,-0.112348,-0.0189322,0.603525,-0.879366,-0.208272,-0.311134,-0.525831,-0.0679274,-0.172455,-0.323689,0.0709762,0.125752,-0.155661,0.322755,-0.0624153,0.0420777,-0.0621908,-0.246678,0.473479,0.454648,0.452291,-0.223618,0.0456558,-0.192143,-0.203156,-0.238866,0.0892769,0.245394,-0.0219666,0.279938,-0.0167462,-0.354445,0.448497,-0.618551,0.126105,-0.377271,1.14749,0.122632,0.447112,-0.273581,-0.232695,-0.225194,-0.352501,-1.14047,-0.450482,0.0983116,-0.258698,0.154635,-0.0226597,-0.145878,-0.681688,0.0420684,-0.499631,0.414307,0.509847,-0.419311,-0.355014,-0.0523057,-0.465777,0.162359,0.172706,-0.213535,-0.789254,-0.432566,1.03337,0.165141,-0.480214,-0.178045,-0.124605,0.426304,0.148965,-0.590287,0.798725,-0.428252,0.103744,0.398767,-0.13208,-0.043094,-0.736481,-0.507728,0.335271,-0.447943,0.0914532,-0.108799,-0.0139616,0.00721191,-0.110275,-0.546231,0.410062,-0.660204,-0.606501,0.37924,0.0914331,0.151206,0.516576,1.29606,0.0443738,0.448267,0.187733,-0.841774,-0.239506,0.694172,-0.115008,0.763479,0.177989,-0.381206,-0.0288735,-0.162448,0.271582,1.09833,-0.434061,-0.648108,0.371558,0.0139655,0.0404975,0.514261,-0.0574274,0.239277,0.239389,0.480802,0.0883826,0.294515,-0.183048,0.273813,-0.500329,-0.219057,-0.030253,-0.853869,-0.0338789,-0.849728,0.196851,0.353341,-0.0303291,0.187999,-0.239556,0.475297,-0.151424,-0.0226181,-0.170409,0.182761,0.0244972,-0.0572719,0.204425,-0.27426,-0.0984056,-0.172247,-0.725007,0.167104,0.396066,0.00586924,0.466248,-0.52163,-0.642513,-0.0592885,-0.0110409,0.328694,0.140631,-0.452118,0.195349,0.266259,0.441983,0.516003,0.0924246 +3414.78,0.979815,0.0848144,5,1.49747,0.803533,-0.645817,0.129387,0.00808638,-0.129455,0.113405,0.545124,-0.124525,0.0524197,-0.20433,-0.245627,-0.340855,0.532813,0.0541386,0.512526,0.0997214,0.167345,0.101796,-0.0548378,-0.387568,-0.940433,-0.852783,0.380447,0.0332341,-0.250388,-0.18114,0.104916,0.170137,0.0253049,0.844155,-0.274409,-0.0489775,0.488372,0.265912,0.0340562,-0.183276,0.811088,-0.0317897,0.0644764,0.89552,0.435783,0.336415,-0.423528,0.0107359,0.0937231,-0.538381,0.505675,0.897136,0.185806,0.686299,0.366037,0.356339,-0.500543,0.84738,0.0168477,0.299174,-0.445296,1.01764,0.0956837,0.0562222,0.483342,-0.499835,-1.26766,0.10954,-0.0127663,0.176913,0.422111,0.422269,0.0838631,-0.147686,0.492462,0.522372,-0.717817,0.587622,0.8265,0.0758581,-0.230487,-0.129798,-0.118347,0.604452,-0.292314,0.0450991,0.102989,0.0609508,-0.739851,0.121578,-0.511031,-0.251367,-0.237645,-0.197129,-0.494125,-0.236365,-0.132636,-0.160269,-0.587935,-0.0611777,-0.0266094,0.351879,0.549555,0.52363,0.594492,-0.749382,-0.016747,0.193179,0.0556428,0.360628,-0.359112,0.746542,0.431509,-0.757994,-0.2218,0.0656299,0.631869,-0.0610309,-0.171048,-0.23765,0.181115,-0.0804442,0.0725379,-0.683138,-0.381268,0.273436,0.167974,-0.208147,0.166643,0.25322,0.781421,0.571627,-0.49734,0.0705877,0.0538303,-0.145193,0.849346,0.080504,-0.32461,0.00492544,-0.27716,0.598169,-0.064102,-0.259309,0.0246179,-0.289447,-0.0438597,0.423295,0.74995,-0.58751,0.00400835,-0.503602,-0.355271,-0.377109,-0.306412,-0.197578,0.164824,0.296985,-0.50636,-0.0650228,-0.0158907,-0.0309581,-0.0718701,-0.140881,0.439823,0.558373,0.346211,-0.314984,0.0872724,0.109185,-0.0710301,-0.177717,-0.0916749,0.0535883,-0.107681,0.293373,0.169035,-0.20716,0.218427,-0.353078,-0.115203,-0.036229,1.14577,0.157928,0.211767,0.0882057,-0.326307,-0.50366,-0.43068,-1.11082,-0.511147,0.303378,-0.35618,-0.0161501,0.0308663,-0.360304,-0.827212,-0.0530824,-0.374623,0.0856337,0.60836,-0.233451,-0.245282,-0.00694037,-0.394693,0.120104,0.241132,-0.0277593,-0.654726,-0.31119,1.00156,-0.0538929,-0.175445,-0.0130687,-0.235221,0.247319,-0.00891476,-0.579734,0.920379,-0.652295,-0.161029,0.528173,-0.374297,-0.124298,-0.756082,-0.388223,0.389134,-0.628769,0.0697014,-0.00833802,0.10431,0.0446974,-0.180653,-0.502449,0.195797,-0.561117,-0.482636,0.356707,-0.0425423,0.112881,0.510019,0.986437,-0.0301194,0.430063,-0.117479,-0.442289,-0.366154,0.456186,-0.0105148,0.843238,0.211804,-0.481325,0.0713107,-0.196343,0.502175,0.838463,-0.584958,-0.638265,0.323212,0.176189,0.102788,0.564028,5.82543e-05,0.463013,0.156286,0.249582,0.105047,0.000332091,-0.135242,0.177113,-0.375807,-0.105754,0.00123672,-0.664028,-0.301553,-0.99352,0.00719504,0.175817,0.244072,0.0169048,-0.241231,0.607808,-0.334903,-0.0913604,0.242756,0.130109,0.0891955,-0.0381277,0.516785,-0.255489,0.118056,-0.307074,-0.354895,0.381619,0.484435,0.242349,0.125711,-0.434504,-0.705721,-0.135327,-0.0415458,0.304508,0.303267,-0.196347,0.162845,0.29562,0.40354,0.543709,0.299002 +3404.23,0.98869,0.0848144,4,1.54559,0.664311,-0.998454,0.2269,0.330843,-0.0151757,0.0978825,0.265494,-0.268652,-0.08942,-0.210982,-0.348784,-0.396855,0.573826,-0.0760109,0.41165,-0.266057,0.12737,0.0652803,0.171379,-0.305523,-1.12607,-1.5081,0.446173,-0.171675,-0.503456,-0.315824,-0.171956,-0.109409,0.00346367,0.813008,-0.221712,0.120099,0.742438,0.358774,-0.0374043,0.0312444,0.737721,-0.124345,-0.256908,1.26479,0.340836,-0.0730504,-0.276176,-0.106399,-0.350013,-0.515446,0.229022,0.95324,0.0293624,0.432333,0.319023,0.338701,-0.482517,1.13456,-0.177141,0.218135,-0.583762,0.899616,0.0470655,0.467737,0.719965,-0.304255,-1.2073,0.346713,-0.135938,0.166586,0.63941,-0.0695275,0.071994,-0.230069,0.616926,0.511513,-0.791359,0.209223,1.04819,0.457087,-0.0749582,-0.244748,0.087109,0.477843,-0.23651,0.256061,-0.322569,0.341202,-0.6142,-0.00344673,-0.238007,-0.199229,-0.120599,-0.263798,-0.237694,-0.461022,-0.054067,0.600694,-0.607295,0.0818932,-0.570247,0.218357,0.374712,0.202818,0.462459,-0.726796,-0.360446,0.342359,-0.145725,0.169754,-0.186028,0.749482,0.131107,-0.872888,0.170894,0.136013,0.514961,-0.168259,-0.148122,-0.232446,0.11281,-0.0536906,0.306801,-0.52473,-0.611377,0.164956,0.177155,-0.307105,0.205113,-0.163532,0.653833,0.168093,-0.331712,-0.123974,-0.186629,-0.149694,0.661649,-0.0898294,-0.301775,0.40632,-0.672413,0.693129,-0.054553,-0.75269,-0.147706,-0.421739,0.0614646,0.457355,0.701753,-0.437994,0.177603,-0.423914,-0.357004,-0.543457,-0.413412,0.10546,0.0553995,0.0430149,-0.251472,-0.322407,0.11624,0.209248,-0.286268,0.0116506,-0.337556,0.834336,0.76548,-0.254222,0.0987715,-0.0999767,-0.20653,0.0340924,-0.00631842,0.381661,-0.507111,0.153757,-0.171737,-0.160598,0.474675,-0.120899,-0.0272057,0.0396165,1.03198,0.115412,0.103223,0.107479,-0.279946,-0.273099,-0.659116,-0.533002,-0.686431,0.674105,-0.378758,-0.0447449,-0.281899,-0.0513174,0.0206788,0.228466,-0.436298,0.144218,0.101089,-0.282523,-0.217661,0.0412088,-0.0904548,0.349584,0.292725,-0.171332,-0.99312,-0.0215559,0.931215,-0.21899,-0.243688,-0.272531,0.0885792,0.325404,0.503068,-0.633861,1.0078,-0.562996,-0.148234,0.79815,-0.233803,0.229262,-0.932599,-0.612677,0.0841847,-0.563993,0.170251,0.0417321,0.0850087,0.254799,-0.00481717,-0.536714,0.235838,-0.626492,-0.63673,0.636202,0.184424,0.305043,0.00187129,1.03334,-0.177273,0.577598,0.447376,-0.231566,-0.30449,0.633784,-0.343394,0.347351,0.0790175,-0.308055,-0.394121,-0.0933412,0.225879,0.592913,-0.276064,-0.349189,-0.122205,-0.387585,0.328657,0.858824,-0.0415294,0.410065,0.690505,0.00417548,0.53081,-0.291744,0.460898,0.0626132,-0.758027,-0.317511,-0.665524,-0.630537,-0.263654,-0.176291,-0.424485,-0.064789,-0.113035,0.0996922,0.0357974,0.475842,-0.000714307,-0.315062,0.456948,0.175217,0.133269,-0.442996,0.249091,-0.108987,0.0241633,-0.159726,-0.659423,0.342594,0.208669,0.132929,0.345521,-0.326212,-0.509512,-0.124004,-0.0232502,-0.0388455,0.222434,-0.13753,0.156989,0.257927,0.396219,0.507865,-0.413991 +3399.56,0.712102,0.0848144,4,1.54404,0.764031,-1.0006,0.302239,0.594397,-0.0107664,-0.178639,-0.111755,-0.0954069,-0.121139,0.317212,-0.510882,-0.514748,0.461024,-0.128613,0.628282,0.194017,-0.452772,-0.346088,0.367357,-0.259602,-0.52476,-0.647241,0.380954,-0.15127,-0.380337,-0.195871,-0.00469636,-0.218374,-0.144683,0.779444,0.0423846,0.51398,0.408964,0.0743645,0.0565036,-0.561601,1.32477,0.394909,-0.232531,0.901547,0.634663,-0.0697087,-0.315842,0.335904,-0.0117357,0.091875,0.270613,0.680097,-0.110879,0.132694,-0.435044,0.17537,-0.560119,0.720143,-0.494052,0.2158,-0.855158,0.61525,-0.0383857,0.146262,0.732523,-0.861532,-1.93948,-0.135578,0.384673,-0.166125,-0.400134,-0.0652036,-0.361389,-0.0217618,0.0142848,0.587933,-0.109457,0.55845,0.487531,0.426713,-0.320941,-0.666206,0.0647589,0.258991,-0.166269,0.208665,0.0795291,0.118994,0.115589,-0.190782,-0.0356712,0.486382,-0.424544,-0.613334,-0.0929621,-0.127155,-0.163675,0.309793,-0.987611,-0.891612,-0.235056,0.431985,0.445589,-0.413731,0.316451,-0.0524483,0.0576455,0.160262,0.0347672,0.40841,-0.477861,0.407643,0.922857,-0.603196,-0.00371294,0.354286,0.691062,-0.848269,0.208,-0.193643,0.161038,0.0301612,-0.234509,-0.740117,0.00751073,0.259606,-0.397916,0.763004,-0.166461,0.772295,-0.255753,-0.0250892,-0.508801,0.595579,0.0638866,0.358273,0.178233,-0.41791,-0.343631,0.499011,-0.524848,0.529544,-0.00548359,-0.990262,0.00383978,0.0679775,-0.51672,0.489159,0.360135,-0.429029,0.374994,-0.275193,0.118251,-0.304118,0.159948,-0.00708156,0.137531,0.132816,0.386934,0.50002,-0.0600177,-0.269097,0.0316178,0.388699,0.543284,0.821219,0.0519298,-0.210189,0.311675,-0.281235,-0.222005,-0.332114,0.875743,0.0985874,-0.049731,0.137857,-0.561802,-0.251459,0.28705,-0.357371,-0.54499,0.0673207,1.08857,0.0676094,-0.750813,0.377225,0.115329,0.0313293,-0.433798,-0.764482,0.045545,0.482554,-0.632445,-0.0789354,0.048069,-0.398914,-0.332874,0.142496,0.331502,-0.559688,-0.200859,-1.07867,0.0716127,-0.149711,-0.332942,0.0879742,-0.0617461,0.206425,-0.170176,-0.0649183,1.11428,-0.491199,-0.0171467,-0.161057,-0.313386,-0.445584,-0.27698,-0.445272,0.380059,-0.479837,-0.00424425,0.455363,-0.686208,-0.225751,-0.431412,0.0696707,0.165609,-0.80202,0.373738,-0.14482,-0.217416,-0.164695,0.149994,-0.88867,0.361826,0.0491243,-0.22706,0.0797831,0.494056,-0.277481,0.431292,0.635029,-0.205006,-0.33338,-0.340075,-0.347692,-0.468065,0.0970084,0.0846824,0.550117,-0.297409,0.660002,-0.513423,-0.41918,-0.0484598,0.166161,-0.0523368,-0.0535343,0.030252,0.160059,0.427346,0.67592,-0.22954,-0.145229,0.00501087,-0.159907,0.281476,0.468606,-0.0912399,-0.135691,-0.908151,-0.830355,-0.238582,-0.40189,-0.214506,-0.616969,-0.604813,0.300326,-0.0968111,0.328905,-0.146662,-0.204421,0.00315822,-0.192379,0.297903,-0.668081,0.170576,-0.426498,-0.418905,-0.237209,0.637345,0.435761,0.363303,0.0146207,0.502574,-0.0196026,0.90398,-0.406153,-0.975603,-0.410859,-0.265911,-0.222034,-0.135572,0.0118784,0.163798,0.269233,0.40472,0.518877,-1.53821 +3399.21,0.70916,0.0848144,5,1.64233,0.698599,-1.2508,0.539895,-0.446137,-0.173932,-0.310782,0.481679,0.0219678,0.230479,0.283191,0.296842,0.000896848,0.451579,-0.332911,0.61128,0.624528,-0.352814,-0.346092,0.254112,0.00314811,-1.35329,-0.811882,0.223776,-0.212169,-0.428142,-0.0977141,0.0855186,-0.658567,-0.250407,0.713496,-0.665685,-0.677184,0.101654,-0.593158,-0.0219605,-0.444762,-0.228573,0.120688,-0.1863,0.802694,0.35045,0.529023,-0.860549,-0.307053,-0.397635,-1.03002,0.140783,0.47913,0.145218,0.431068,0.623017,-0.279667,-0.217009,-0.0518731,-0.0619079,-0.743384,-0.597702,0.336751,-0.156692,0.0548813,0.722888,-0.855877,0.278091,0.278273,0.569319,-0.302959,0.183665,0.0853636,-0.576005,-0.341943,0.529555,0.966807,0.246576,0.38937,0.151647,0.319,0.586348,-0.374582,0.15933,1.10715,-0.553693,0.287294,-0.491323,-0.0165119,-0.103539,0.291985,-0.501014,0.0290454,-0.268783,-0.256048,0.155799,0.191653,-0.208155,-0.158881,0.252126,0.157568,-0.184998,-0.212918,0.04577,0.64857,-0.348936,-0.713055,-0.406723,0.539386,-0.0324693,-0.325955,-0.195889,0.0733407,0.348766,0.0471468,-0.00379068,0.151017,0.596889,0.307752,0.241574,0.0053925,-0.25707,0.100371,-0.295138,-0.568502,0.0609693,-0.593465,0.360186,-0.758124,0.0480488,-0.653791,0.533612,0.553555,-0.322213,-0.329413,0.27313,-0.0946368,0.460818,-0.138299,0.121392,-0.0387216,-0.113936,0.292287,-0.748984,0.119467,0.0923904,-0.439931,-0.462102,-0.490395,-0.000560854,0.675669,0.643525,0.1985,-0.0747391,-0.412036,0.109563,-0.181559,-0.0404814,0.706599,0.203842,-0.289175,-0.764276,0.245982,0.0327123,-0.154182,-0.478169,0.435845,0.393784,-0.441562,0.0343772,-0.123462,-0.131522,-0.0741457,-0.305984,0.563086,0.107646,0.262437,-0.449812,0.217688,-0.0078509,-0.554387,0.162532,0.455963,0.397833,0.224175,0.492601,-0.151079,-0.146788,-0.893877,-0.00318969,-0.105844,-0.14396,-0.156179,-0.097948,0.479198,0.475916,-0.42044,-1.17894,0.175007,0.176117,0.218163,-0.141921,-0.19619,-0.442928,0.18105,-0.517258,0.624877,-0.483041,-0.349257,0.38419,-0.790512,1.07022,-0.0216116,-0.250411,0.141407,-0.385163,-0.0464483,0.574313,-0.303968,0.235025,-0.244886,0.238395,0.0576951,-0.568779,0.143409,-0.798199,0.0418446,-0.320672,0.049225,0.151247,-0.66737,-0.0512901,0.363162,0.143622,-0.0734916,0.260147,0.160944,0.281367,-0.588411,0.160844,0.318542,-0.454879,0.502304,-0.100526,-0.00485256,-0.236072,0.28129,-0.207666,0.652746,0.254315,0.586298,0.0325986,-0.925851,0.255783,0.221872,-1.21147,0.326724,-0.276418,-0.0886422,0.045082,-1.12296,0.417523,-0.378004,0.446055,0.098056,0.624552,0.249391,-0.223532,-0.199942,0.590906,0.323241,0.114619,0.308463,0.122957,-0.317245,-0.103883,0.060165,0.383205,-0.293082,-0.441417,-0.209186,0.105465,0.416705,-0.00292899,0.221965,-0.49623,-0.099841,0.236652,0.255048,0.403072,0.0387003,-0.400573,0.151907,-0.621512,0.26052,0.16958,0.279304,-0.0373566,0.0262164,-0.425123,0.194916,0.188748,0.24377,-0.138307,0.101884,0.12816,0.242055,0.357994,0.491991,2.07697 +3396.07,0.997925,0.0848144,5,1.65254,0.551223,-1.48505,0.637225,0.107927,-0.21459,-0.0121277,-0.216337,0.0868005,-0.0709866,-0.312586,0.252208,-0.477489,0.327425,-0.35142,0.780143,0.403541,0.019394,-0.357886,0.524024,0.254474,-1.46526,-0.690195,0.549174,-0.0809182,-0.280494,-0.408472,0.240613,-0.686492,-0.277437,0.958871,-0.616359,-0.555761,0.219391,-0.203677,-0.00862074,-1.11335,0.0120782,-0.00960266,0.421455,1.08183,0.543107,0.473201,-0.841847,0.158275,-0.292755,0.0762079,0.127367,0.279296,-0.365431,-0.0253457,-0.0351419,-0.261792,-0.58996,0.338714,0.106305,-0.480194,-0.532998,0.396737,-0.271469,-0.014621,0.756893,-0.74583,-0.916062,-0.0526942,0.471366,-0.551079,-0.402659,0.428961,-0.520067,-0.373065,0.00818581,0.914287,0.292611,0.156129,0.568476,0.715747,0.195444,-0.453791,0.00674931,1.19159,0.0430845,0.196668,-0.440619,0.0503625,-0.0860265,-0.430136,-0.556099,0.273132,-0.35528,0.400293,0.200794,0.318092,0.264345,0.102425,-0.160666,0.168444,-0.203345,-0.00765181,0.226232,-0.130392,-0.491417,-0.356976,-0.332199,0.520513,-0.346847,-0.250404,0.148066,0.410031,0.419276,-0.163109,0.366557,0.392604,0.650584,0.0588624,0.832475,-0.136349,-0.0968408,-0.0151351,0.168896,-0.75742,0.378971,0.0445547,0.109468,-0.780817,0.14981,-0.374717,0.233538,0.0878543,-0.497949,-0.0954104,-0.172744,0.33386,0.675785,0.1014,-0.274287,0.390549,-0.346739,0.249713,-0.532441,0.313878,0.0668658,-0.559714,-0.26309,0.10786,0.202867,0.293194,0.566258,-0.108922,-0.318523,-0.84131,-0.321104,0.358364,-0.298089,0.554321,0.601173,-0.443081,-0.505264,-0.357532,-0.304546,-0.030794,-0.0538236,0.350037,-0.304534,0.129262,-0.228659,-0.181558,-0.364359,-0.456361,-0.352809,0.0125927,0.407995,0.111767,0.0480336,0.142566,-0.147926,-0.102215,0.0131243,0.157321,1.09584,-0.386256,-0.1143,-0.0206034,0.0983373,-0.711041,-0.135785,0.150654,-0.177992,0.0349478,-0.381752,0.160387,0.233721,-0.192799,-0.855673,-0.364472,0.0440712,-0.238258,-0.194549,-0.111405,-0.750805,0.0589225,-0.530621,0.676081,-0.538249,-0.250352,0.302375,-0.949998,1.02581,-0.0862783,0.318373,0.123017,-0.740519,-0.474753,0.770938,0.00443073,0.255271,-0.14984,0.201837,0.262624,-0.252552,-0.266021,-0.662018,0.0322096,-0.291524,0.098871,0.380378,-0.0827849,-0.444695,0.263457,-0.0277225,-0.650015,0.347395,-0.796111,-0.222305,-0.567496,0.260395,0.200751,0.0496663,0.646471,0.0491703,-0.0788691,-0.177071,0.53085,-0.127207,0.428111,-0.13746,0.763833,0.207781,0.0688912,0.0227916,0.387364,-1.44748,0.107912,-0.465016,-0.00825935,-0.335824,-0.189781,0.561451,0.00527988,0.417586,0.260936,0.346324,0.312183,-0.122595,0.0614614,0.648196,0.149838,-0.0111291,-0.416114,0.407776,-0.178882,-0.315112,0.790494,0.188826,0.049032,-0.32927,0.127356,0.754751,0.639903,-0.0595445,-0.286824,0.159597,-0.374497,-0.114438,0.0968106,0.433362,0.0407957,-0.0315096,0.38089,-0.529467,0.406099,0.875272,-0.153013,0.319604,-0.270246,-0.164562,0.547418,0.0517958,-0.0475857,-0.195721,-0.298693,0.20375,0.22092,0.451386,0.470022,0.549303 +3395.03,0.669982,0.0848144,4,1.71442,0.49364,-1.60191,0.722153,-0.0181099,-0.176887,-0.515208,-0.521063,-0.487702,-0.380705,0.25589,-0.0507148,-0.590763,0.55371,-0.4764,0.557665,0.409145,0.276166,-0.20488,0.23941,-0.0629974,-0.932154,-0.540908,0.755171,0.0141154,-0.642579,-0.202085,-0.0502873,-0.470166,-0.238688,0.980797,-0.61107,-0.0331213,0.0825131,-0.673827,0.209189,-1.15145,0.225432,-0.0776882,-0.0636477,0.827376,0.332497,0.0513236,-0.601739,0.0918812,-0.102292,-0.708285,0.251249,0.250087,-0.36574,0.309772,0.00937322,-0.384364,-0.452236,0.0867343,-0.596939,-0.533668,-0.359288,0.35839,0.0649295,0.0329257,0.46288,-0.292944,-1.20641,-0.0137499,-0.0776673,-0.496949,-0.173189,0.123647,0.130823,-0.157987,-0.0264469,0.780147,-0.190203,0.490249,0.308898,0.000667065,0.0614426,-0.231352,0.230233,0.973473,-0.446602,0.017432,-0.584869,0.0545905,-0.548256,-0.164625,-0.416509,-0.166294,-0.413804,0.115966,-0.248754,-0.096272,-0.00431559,-0.333558,-0.291326,0.807627,-0.235955,0.0225853,0.138929,0.308675,-0.853888,-0.0734117,-0.28828,0.365531,-0.333738,-0.0592696,-0.175553,0.181605,0.83855,-0.307108,-0.187286,-0.460914,0.533501,-0.872939,0.418845,-1.01396,-0.290452,-0.100156,-0.243078,-0.462952,0.294585,-0.561802,-0.159799,0.140476,0.112722,-0.21417,0.519087,0.176591,-0.784779,-0.52101,0.171171,0.0960802,-0.179653,-0.0233641,-0.431408,0.467258,-0.305751,0.653013,-0.691232,-0.794552,0.107943,0.0331649,-0.379149,-0.106716,0.367273,-0.249776,0.875756,-0.0122873,-0.496794,-0.864857,0.354617,-0.0304095,-0.403868,0.375939,0.380034,-0.23188,-0.648992,3.18279e-05,0.418665,-0.710912,-0.169824,0.0781964,-0.328128,-0.270072,0.163834,-0.133401,0.0234243,-0.078758,-0.248623,0.491469,-0.225714,0.141799,-0.354967,-0.0585239,-0.476256,-0.309418,0.0150104,0.252104,0.938837,-0.313067,0.0850031,0.266658,-0.142012,-0.108141,0.14585,-0.669256,0.296149,-0.629515,-0.364286,0.225415,-0.290327,-0.554477,-0.266605,0.000949392,-0.420652,0.11452,-0.539581,-0.2396,-0.302183,-0.130963,-0.505639,0.278272,-0.475677,-0.253557,0.158001,-0.740969,0.863412,0.123704,0.119967,0.365149,-0.353114,-0.57325,1.10972,-0.00264416,0.733971,-0.660652,0.123475,0.0745229,-0.0116865,-0.218503,-0.163294,0.162049,-0.0694395,-0.0521298,0.808667,-0.0938673,-0.791871,0.466858,-0.00255817,-0.65387,0.242489,-0.130056,-0.742048,-0.640525,0.298753,0.229434,-0.0979796,0.475191,0.194535,-0.607965,-0.204557,0.127846,-0.16131,0.687457,0.488574,0.436403,0.110518,0.21992,-0.0963104,-0.295986,-0.73574,0.294818,-0.620569,0.12943,0.151272,-0.615939,0.232006,-0.311971,0.215505,-0.402732,0.305394,-0.105338,-0.114357,0.00124559,0.790146,0.16835,0.140473,-0.584186,0.332126,-0.247779,-0.729529,0.132437,0.185251,0.24425,-0.228294,0.298672,0.252445,0.418274,-0.398862,0.0115656,0.101214,-0.0940688,-0.000434951,0.23534,0.833034,-0.217424,0.334953,0.0269346,-1.27864,0.391765,0.0197324,0.254299,-0.0418544,-0.106929,-0.093719,0.598208,0.351796,-0.440714,0.32166,-0.407112,0.139828,0.275531,0.373936,0.524911,1.10284 +3418.27,0.956626,0.0848144,4,1.76778,0.517158,-1.40601,0.625225,-0.0981562,-0.234974,-0.252628,-0.389484,-0.056332,-0.377204,-0.294667,0.135222,-0.552732,0.561073,-0.326067,0.741654,0.554666,0.261542,-0.341319,0.357349,-0.0039552,-0.929569,-0.376795,0.671939,-0.318662,-0.664632,0.108123,-0.0597976,-0.286948,-0.459123,0.771794,-0.806711,-0.0602572,0.0223535,-0.716588,0.229289,-0.752224,0.33278,0.222717,-0.0208613,0.733716,0.539701,-0.118145,-0.87794,-0.232763,0.258322,-0.316582,-0.0271073,0.0491142,-0.305722,0.0210437,0.00594183,-0.35108,0.00117746,0.250558,-0.190027,-0.319523,-0.251207,0.201846,-0.122553,0.000456594,0.59345,-0.631155,-0.86978,-0.391842,0.00977172,-0.339141,0.153363,0.424793,-0.283852,-0.166046,0.00289177,0.630924,-0.0491208,0.123445,0.31786,-0.146012,0.0815351,-0.440419,-0.0455794,0.730447,-1.0726,-0.0740721,-0.377228,0.614706,-0.395046,-0.0053882,-0.0433357,0.223409,-0.283957,0.375908,-0.0551357,0.0168957,0.166655,-0.202354,-0.807659,0.455155,-0.297412,-0.684588,0.450977,0.37609,-0.0871087,-0.630063,-0.405974,0.453981,-0.37997,0.131016,0.126495,0.221245,0.181984,0.256949,-0.103504,-0.347886,0.525678,-0.76344,0.0636884,-0.572051,-0.287583,0.410922,-0.92452,-0.372187,0.1994,-0.48149,-0.438703,-0.197045,-0.0143973,0.148838,0.666426,-0.197152,-1.01816,-0.498366,0.136405,0.280387,0.0695486,-0.4884,-0.318963,-0.0380805,0.0313642,0.671621,-0.8771,-0.854333,-0.262429,0.297648,-0.400011,-0.0494611,0.456135,-0.378483,0.301721,-0.130784,-0.365652,-0.953698,0.110772,0.17392,-0.371624,0.109312,0.486293,0.0968246,-0.0809347,0.213032,0.0438792,-0.211344,-0.130224,0.200293,-0.701052,0.308121,-0.127516,0.0391775,0.0128704,-0.374436,-0.786588,0.519035,-0.389795,0.230128,0.391873,-0.131666,-0.662614,-0.307329,0.0876044,0.448575,0.744641,0.00208244,0.0834554,0.66838,-0.125374,-0.0973252,-0.219985,-0.355389,0.359051,-0.0520433,-0.13084,0.28909,-0.0547148,-0.249136,-0.498523,-0.27854,-0.239129,0.0438574,-0.437591,-0.662985,-0.54054,0.0665184,-0.582574,0.407746,-0.387611,-0.09941,0.167204,-0.604795,1.10762,-0.145861,-0.148253,0.128944,-0.301965,-0.713098,0.722937,-0.59536,0.631143,-0.735633,0.17709,0.270878,-0.294985,-0.198192,-0.445708,-0.148449,-0.181021,-0.11342,0.377705,-0.299391,-1.02837,0.616697,0.242256,0.0086605,0.185028,-0.258618,0.0412577,-0.559515,0.423769,0.310843,0.195113,0.656306,0.0438335,-0.41903,-0.0366015,0.291301,0.335067,0.817606,0.112997,0.491289,0.291949,0.200924,-0.140259,0.358448,-0.636105,0.192748,-0.189486,-0.217576,0.229863,-0.646105,0.0400256,-0.236033,0.25094,-0.46994,0.560769,0.252475,0.337715,-0.00260142,0.468492,0.298057,-0.134904,-0.304525,0.133547,-0.270415,-0.564916,-0.220679,0.189688,0.0265606,-0.104312,-0.0039168,0.553427,0.468134,-0.124881,-0.125259,-0.0669722,-0.377451,0.628661,0.257808,0.467475,-0.0685215,0.0176318,0.231406,-0.597722,0.352938,0.273193,0.275233,0.337747,-0.0314228,0.167961,0.375679,-0.153985,-0.208806,0.370034,-0.24042,0.195877,0.164519,0.44258,0.405609,1.38387 +3413.31,0.993432,0.0848144,4,1.67715,0.69048,-1.34413,0.602397,-0.00960886,-0.290397,0.110655,-0.450015,-0.346067,-0.394519,-0.146202,0.343102,-0.383272,0.543109,-0.324496,0.794808,0.158878,-0.00080404,-0.456949,0.0068169,0.0567107,-1.10294,-0.397335,0.734956,-0.348486,-0.712138,-0.043599,-0.256975,-0.415373,-0.533614,0.717893,-0.792706,0.347729,0.380311,-0.456931,0.0876783,-0.510423,0.118613,-0.243234,-0.0338104,0.654758,0.207537,-0.292871,-0.771414,-0.163702,0.129001,-0.550269,0.390855,0.306967,-0.195891,0.438738,-0.0402142,-0.0939945,-0.106811,-0.0187481,-0.161291,-0.469897,-0.325408,0.116081,-0.0947775,0.288684,0.680683,-0.477364,-0.7822,-0.26866,0.216442,-0.625921,-0.237873,0.138397,-0.315595,-0.0396162,0.461456,0.493426,0.0419255,0.293315,0.437721,0.0365358,0.208646,-0.505307,0.171262,0.706015,-1.04012,-0.15455,-0.0733146,0.529834,-0.394753,0.059075,-0.145771,0.57694,-0.361687,0.316441,-0.210897,-0.110144,0.122284,-0.0698539,-0.779828,0.461705,-0.0543556,-0.452353,0.366896,0.224022,0.015017,-0.565986,-0.400276,0.139507,-0.468231,-0.0446332,-0.179516,0.178439,-0.07236,0.1435,-0.0763446,0.063078,0.583326,-0.779974,-0.0018114,-0.466214,-0.360975,0.101385,-0.721665,-0.548572,0.0751509,-0.202281,-0.368564,-0.165073,-0.0762849,0.837139,0.266348,0.167903,-1.09313,-0.225557,0.120806,0.281019,0.496864,-0.32793,-0.121864,-0.251573,0.286532,0.496998,-1.04563,-0.907545,-0.052544,0.420595,-0.783983,-0.161271,-0.16729,-0.370872,0.781812,-0.219737,-0.53823,-1.06877,-0.23309,0.195001,-0.0866862,0.254812,0.417716,0.177582,-0.0511246,-0.0936809,0.121786,-0.238477,-0.372883,0.341831,-0.0763203,-0.0829144,-0.0894789,-0.147458,-0.249535,-0.601117,-0.588865,0.515183,-0.507782,0.200308,0.184036,0.0310201,-0.522945,-0.215834,0.222366,0.325285,0.495716,-0.213752,-0.125207,0.164863,-0.56202,-0.163245,-0.247355,-0.00479723,0.285678,-0.536114,-0.370875,0.20376,-0.0301422,-0.149633,-0.517888,-0.332984,-0.0398289,0.0445351,-0.453275,-1.20795,-0.016303,-0.342017,-0.273776,0.651625,-0.228333,-0.375568,0.51151,-0.51997,1.06505,0.111566,-0.297621,0.310958,-0.410893,-0.536575,0.951552,-0.208953,0.726848,-0.547108,0.197463,0.182975,-0.050477,-0.072618,-0.49845,-0.178395,0.071621,-0.743995,0.497448,-0.581668,-0.421744,0.68858,0.166951,-0.178577,0.208839,-0.236617,0.0490694,-0.201937,0.6291,0.0611455,0.0344026,0.749838,0.167398,-0.607267,-0.535765,0.441138,0.574728,0.84967,0.368865,0.492834,0.188225,0.506689,-0.0245041,0.252803,-0.608228,0.324313,-0.324798,-0.0201075,0.294315,-0.573953,-0.160569,-0.132359,-0.214875,0.1327,0.140502,0.350585,0.317457,0.0245176,0.549589,0.242464,-0.277751,-0.057146,0.31741,-0.334702,-0.707421,-0.283136,0.48921,0.00175347,-0.190954,0.0620659,0.10927,0.183985,-0.369069,-0.0554304,-0.265113,-0.302787,0.820312,0.17794,0.58315,-0.302242,0.286467,0.118696,-0.499453,0.2833,0.159741,0.0329111,0.867137,-0.20531,0.127053,0.322722,-0.0292729,-0.0977092,0.252151,-0.269763,0.140989,0.150664,0.375485,0.388154,0.695847 +3404.93,0.744265,0.0848144,5,1.71925,0.746078,-1.11599,0.433298,0.00164136,-0.324137,0.190625,-0.171324,-0.613217,-0.595077,-0.173375,0.272179,-0.242313,0.34627,-0.485433,0.852094,0.36298,0.171845,-0.528951,-0.0620579,-0.19936,-0.696932,-0.844447,0.460335,-0.773037,-0.653437,-0.305345,0.0352638,-0.395452,-0.193466,0.733762,-0.872694,-0.244531,-0.115909,-0.669517,-0.0948115,-0.155312,0.155966,-0.0540701,-0.00322089,0.672684,0.457218,0.125882,-0.546935,-0.0719054,-0.0654442,-0.798583,0.198789,0.380782,-0.226246,0.398909,0.115784,-0.162413,0.100239,0.289455,0.0847747,-0.216753,-0.286948,-0.00588225,-0.205103,0.101016,0.65424,-0.532501,-0.573054,0.232702,0.161485,-0.63656,-0.486158,0.265726,-0.374227,-0.375006,0.477122,0.21393,-0.250063,-0.137451,0.390458,0.198579,-0.42795,-0.36475,0.019143,0.795671,-0.856351,-0.0794624,-0.330363,0.142038,-0.240525,-0.129556,0.580132,0.680612,-0.136732,0.390478,0.163733,0.167098,0.152633,-0.193587,-0.579753,0.107006,0.168176,-0.375855,0.385673,0.21939,-0.00201832,-0.371086,-0.533842,0.0893027,-0.391455,-0.180298,-0.247272,0.139956,0.223853,0.4375,-0.293083,0.0205786,0.455983,-0.659471,0.28126,-0.993561,-0.191385,0.0278414,-0.257822,-0.443664,0.0684339,-0.365605,-0.425574,-0.189637,-0.166944,0.392628,0.518518,0.113697,-1.13016,-0.0258096,-0.0274634,0.459919,0.336679,-0.114781,-0.267834,-0.351988,-0.00248571,0.304961,-0.690064,-1.03615,-0.368554,0.815195,-0.222231,-0.0770783,-0.00230508,-0.160506,0.842873,-0.154788,-0.183287,-1.02058,-0.334169,0.196399,0.143267,0.315648,0.457839,-0.105897,0.242301,0.240114,0.130308,-0.356663,-0.309221,0.465423,0.3681,-0.205207,-0.065987,-0.128383,-0.211117,-0.677747,-0.37714,0.0665802,-0.519302,0.0650595,0.342055,-0.131936,-0.401718,-0.326961,-0.255992,0.402911,0.369241,-0.0981635,-0.176385,0.17986,-0.524901,-0.338689,0.00880062,-0.207424,0.302759,-0.321373,-0.412632,0.355642,-0.198895,-0.233552,-0.622597,-0.2794,-0.072546,-0.140525,-0.573337,-0.738945,0.350201,-0.436589,-0.148335,0.520427,-0.0553907,-0.351363,0.137228,-0.50825,0.938896,0.198369,-0.69365,0.224218,-0.670577,-0.549609,0.57766,0.16308,0.415461,-0.666566,0.13424,0.178529,-0.308719,-0.0721271,-0.184842,-0.0664057,0.0112225,-0.711137,0.524687,-0.262454,-1.09986,0.546094,0.374254,-0.481784,0.218269,-0.16698,0.0723782,-0.250849,0.201974,0.166502,0.16875,0.182629,0.162214,-0.0969141,-0.440224,0.519163,0.438291,0.559386,0.121713,0.437976,-0.211994,0.357974,-0.128019,0.0535171,-0.897926,0.465918,-0.438563,-0.30369,0.127413,-0.577671,-0.337278,-0.190593,-0.0862097,0.564542,0.394365,0.0841824,0.260214,0.0540573,0.279342,0.31555,-0.232961,0.302766,-0.000890834,-0.0085949,-0.32859,-0.302859,0.253674,-0.219926,-0.21107,-0.0606077,0.25568,0.245598,-0.207566,0.1424,-0.381113,-0.665761,0.436247,0.137167,0.586189,-0.218675,-0.360681,0.0328997,-0.0665688,0.181244,0.111657,0.475847,0.330505,-0.0462264,-0.0455304,0.164273,0.255846,-0.0204752,0.286818,0.0226545,0.187859,0.11025,0.433427,0.332039,0.651237 +3385.21,0.603528,0.0848144,4,1.73762,0.660036,-1.20922,0.471427,-0.262955,-0.298331,0.360447,0.125986,-0.514367,-0.345685,-0.362177,0.018859,-0.591606,0.88124,-0.223652,0.477803,0.244632,-0.420321,-0.00591034,-0.241814,-0.135642,-0.926443,-0.538797,0.761678,-0.609742,-0.419528,-0.464533,-0.0501692,-0.205005,-0.380195,0.717206,-0.825064,-0.503841,-0.10501,-0.330975,-0.331609,-0.521497,0.134193,0.290116,-0.473622,0.781619,0.415273,0.154403,-0.837174,-0.134497,0.258118,-0.137321,0.344798,0.174335,-0.282278,0.567962,0.339698,-0.108479,0.46773,0.22847,-0.0726652,-0.287203,-0.424956,0.416058,-0.280013,0.332041,0.874918,-0.797804,-0.558742,0.344733,0.246341,-0.575175,-0.454044,-0.0503747,-0.324367,-0.512569,0.343117,0.44188,-0.278646,0.106191,0.315077,-0.103298,-0.0718933,-0.0598739,0.240015,1.16866,-0.917438,-0.0288467,-0.449112,0.493993,0.191752,0.148011,0.300009,0.249008,-0.442434,0.0563552,-0.174208,0.373339,0.22571,-0.284201,-0.688179,0.0382792,0.0238578,-0.448193,0.213212,0.40061,-0.204937,-0.520963,-0.651056,-0.289271,-0.594979,0.205413,-0.417947,0.10656,0.314107,0.224431,-0.777768,0.121666,0.645854,-0.437513,0.074941,-0.753078,-0.246709,0.0186567,-0.344445,-0.378539,0.0287399,-0.564215,-0.452029,-0.0661904,-0.971225,0.54965,0.434683,0.104149,-0.697629,0.00566451,-0.211397,0.138123,0.467893,-0.0621848,0.251187,-0.532827,0.431266,0.250396,-0.610332,-1.38134,-0.336794,0.837286,-0.703929,0.0980934,-0.40124,-0.153136,0.594579,-0.22778,-0.249165,-0.886851,-0.122371,0.0763649,-0.0734738,0.416999,0.258848,-0.0576417,0.286859,0.149714,-0.327826,-0.682013,-0.0217064,0.682483,0.34031,0.146729,-0.0576136,-0.131866,-0.174259,-1.2103,-0.364293,0.503431,-0.303043,0.0925384,0.243298,-0.174577,-0.251999,-0.164049,-0.389125,0.49099,0.277347,-0.018841,0.183134,0.114762,-0.482212,-0.19913,-0.177368,-0.404481,-0.00821202,-0.204584,-0.273576,-0.192127,0.124509,-0.133101,-0.874367,-0.306319,0.11051,0.246073,-0.551853,-0.331655,0.256245,-0.358385,-0.387341,0.740803,-0.28084,-0.36047,0.0243803,-0.70418,0.9703,0.120812,-0.542812,-0.13577,-0.910154,-0.502778,0.355845,0.307409,0.270295,-1.15741,0.108882,-0.265292,-0.249728,-0.364224,-0.052632,-0.030707,0.0955919,-0.797742,0.506163,-0.273944,-0.955326,0.45277,0.19799,-0.818028,0.322439,-0.387496,-0.16225,-0.427427,0.425256,0.419804,-0.0290374,0.211309,-0.00946552,0.325068,-0.479936,0.205193,-0.341223,0.386386,0.540346,0.388522,0.0554273,0.422894,-0.348304,0.159645,-0.538906,0.636336,-0.298772,-0.0763806,0.196499,-0.475755,-0.347895,-0.428964,-0.0441704,0.174695,0.309095,0.244831,-0.206248,-0.449495,0.292668,0.363153,-0.0736911,0.450161,-0.142965,0.00303531,-0.658918,-0.360238,0.0255878,-0.276249,-0.374282,0.0959873,0.268562,0.385317,-0.279346,-0.19088,-0.773026,-0.45612,0.645646,0.0223927,0.486155,-0.204262,-0.084664,0.492389,-0.0428801,0.277413,0.343506,0.632994,0.392496,-0.155356,-0.162137,0.0396142,-0.185421,0.0735488,0.187568,-0.0477242,0.14592,0.192127,0.381995,0.438323,1.7065 +3388.07,0.990437,0.0848144,4,1.6407,0.675717,-1.54192,0.528488,-0.155482,-0.104712,0.010315,0.131098,-0.434433,-0.0328222,-0.285923,0.0348483,-0.470697,0.582946,-0.159661,0.465853,0.315372,0.000344337,-0.676868,-0.0780885,-0.211568,-0.89146,-0.282984,0.258914,-0.493429,-0.960724,-0.570054,0.322148,-0.274259,-0.485228,0.824555,-0.369729,-0.408148,-0.0429228,-0.27023,0.0963093,-0.031724,0.00774855,0.316102,-0.0100225,1.0806,0.560794,0.414966,-0.560686,-0.339873,0.623829,-0.629084,0.573613,0.842616,-0.275769,0.563902,0.268195,0.366807,0.109961,0.376557,-0.516052,-0.449233,-0.369146,0.316058,0.0989451,-0.317289,0.930846,-0.502184,-0.596507,0.328165,0.254841,-1.00021,-0.700214,-0.346536,-0.629242,-0.663463,0.493533,0.23477,-0.267389,0.268519,0.480159,-0.078404,-0.209651,-0.323825,0.252481,0.693161,-0.633671,0.118986,0.062314,-0.102147,0.771187,-0.327697,-0.112139,0.121787,-0.530127,-0.391298,0.20259,0.531764,-0.323974,-0.446725,-0.774827,-0.00429578,-0.325217,-0.0946234,0.350543,0.718113,-0.143031,-0.380281,0.138065,0.265934,-0.764262,0.0981169,-0.134208,-0.0192036,0.282702,0.110751,-0.469839,-0.253643,0.633728,0.655338,0.337486,-0.00687752,-0.116962,-0.174476,0.0632266,-0.749784,-0.43235,-0.802014,0.069241,-0.882726,-0.730006,0.64884,-0.130147,0.521542,-0.669035,-0.105347,-0.0471003,0.355867,0.490071,-0.24784,0.300462,-0.485662,0.132212,0.524125,-0.583345,-1.13009,-0.142796,0.192939,-0.872567,0.29038,0.0376207,0.413512,0.493265,-0.175158,-0.521178,-0.871631,0.0228596,0.307628,0.213152,-0.272396,0.042431,-0.115084,-0.535136,0.417112,-0.0237973,-0.117824,0.459936,0.673005,0.324513,0.562626,-0.361152,-0.123835,0.175862,-0.664866,-0.501717,-0.0944454,0.0857809,0.224142,0.747157,0.0518449,-0.264544,-0.578327,-0.262216,0.446437,0.628027,0.269745,-0.296745,0.0320473,-0.816495,-0.0573394,-0.250562,-0.0336666,0.181195,-0.227252,-0.490964,0.0308183,-0.0046027,-0.104733,-0.2027,0.138969,0.446564,0.00781997,-0.392069,-0.911072,-0.457695,0.0470522,-0.844485,0.663384,-0.051616,0.30208,-0.202357,-0.826731,0.940233,0.0742623,-0.289066,0.299155,-0.610107,0.0240091,-0.408644,0.835035,0.0573759,-0.958772,0.054086,-0.10287,-0.261202,-0.106339,-0.0714771,0.111382,0.146212,-0.774413,0.230086,-0.601517,-0.581717,-0.00336238,-0.200265,-0.204905,0.201319,-0.282941,-0.170127,-0.0270899,0.398735,0.564797,0.287561,0.811516,0.113242,0.356269,0.339805,-0.448076,-0.282891,0.679731,0.261,0.877325,-0.381408,0.683474,-0.0352177,0.0339732,0.356523,0.384749,0.127166,-0.00485698,0.0910769,-0.21597,0.459397,-0.482485,0.294356,0.103514,0.0310066,0.18167,0.288973,-0.20403,0.273671,0.170241,0.254776,-0.154715,-0.268514,-0.81821,0.107472,-0.656058,0.0640423,0.276616,0.114643,0.158372,-0.0845627,-0.0811646,0.0382008,0.289877,-0.436231,-0.0942273,0.340797,0.256165,0.368085,-0.438929,0.441754,0.348611,0.270766,0.297212,0.191367,0.511569,0.468887,-0.095129,-0.782359,0.511086,-0.116732,-0.236918,-0.384213,0.185292,0.20923,0.231829,0.457416,0.481486,1.29736 +3397.19,0.626424,0.0848144,4,1.63714,0.710413,-1.45541,0.47004,-0.0747041,-0.283735,0.366808,-0.448134,-0.39286,-0.00244298,-0.627017,-0.262348,-0.308777,0.738955,-0.314117,0.403345,-0.0600829,-0.788797,-0.174703,0.318832,-0.229038,-0.632539,-1.41497,0.0541408,-0.256934,-0.188048,-0.708009,-0.624661,-0.496867,0.0465374,0.76608,-1.1159,0.0510865,-0.154782,-0.228923,0.00487966,-0.505536,0.399834,0.57286,0.038878,1.01663,0.186656,0.283456,-0.813942,-0.089839,-0.0824971,-1.07918,0.498516,0.55995,0.109291,1.0906,0.42151,0.139412,-0.268352,0.73611,-0.245984,-0.102494,-0.675313,0.419638,-0.00288007,0.337675,0.76198,-0.53166,-0.589655,0.39377,-0.240197,-0.187719,0.444091,0.275504,-0.636507,-0.701348,0.59117,0.443624,-0.536509,0.22265,0.691002,0.43704,0.301334,-0.322286,0.103816,0.175705,-0.411549,0.473394,-0.360981,-0.147394,-0.163079,-0.208954,-0.255095,0.177257,-0.187229,0.867878,-0.0150522,-0.0785103,0.0788266,0.0467091,0.0124143,0.510154,-0.365076,0.491895,0.634707,0.744381,0.798168,-0.284023,-0.498586,-0.150717,-0.64712,0.513183,-0.431634,0.413758,-0.293001,-0.932248,-0.101063,0.184974,0.298439,-0.155206,-0.0342274,-0.494706,0.192761,0.256419,-0.470181,-1.13945,-0.324951,-0.130553,0.0694302,-0.363494,-0.38668,0.558952,0.718433,0.487758,-0.107776,0.462486,-0.680911,-0.0274793,0.306447,-0.0684134,0.110969,0.162929,-0.0976697,0.470852,-0.603345,-0.45649,0.356211,0.526732,-0.629938,0.362384,-0.30563,0.211365,0.311509,-0.0852213,0.403493,-0.851342,0.251817,0.0665561,0.0661852,0.114945,0.622934,0.353938,-0.373312,-0.186023,-0.451252,-0.114679,0.050988,0.776991,0.256809,-0.104072,0.27196,0.00153602,0.289616,-0.595273,-0.00317717,0.111068,-0.207816,-0.074674,0.243754,0.27975,-0.486193,-0.321296,-0.19373,0.224378,0.698673,0.46688,-0.346937,-0.0444853,-0.539042,-0.511027,0.0158497,-0.0151666,-0.0568714,0.29389,-0.601804,-0.330775,-0.109154,0.297341,-0.169633,0.316558,0.127837,-0.410743,0.00906861,-0.673654,0.0576453,0.180184,-0.416702,0.271785,-0.0897107,-0.617679,-0.437952,-0.563141,0.926327,-0.132922,-0.501518,-0.0368001,-0.354566,-0.241787,-0.0133229,0.15072,0.381408,-0.0789738,0.0221916,0.443305,-0.325964,0.0631839,-0.0821506,0.327241,0.756611,-0.989483,0.266672,-0.33976,-0.60101,-0.00780548,0.279514,-0.574082,0.0486762,-0.591865,-0.389187,0.0922824,0.374218,0.261034,0.731171,0.809266,-0.61157,-0.331373,0.405796,-0.0828394,-0.267718,0.475009,-0.195051,0.69939,0.444045,0.044939,-0.504065,0.0801202,-0.16988,0.516386,-0.302212,0.0252134,0.313744,-0.189165,-0.0941211,0.370448,0.123336,-0.140257,0.88368,0.322915,0.0403312,0.694905,0.19702,0.0542759,0.342834,-0.153692,0.472429,-0.364582,0.166179,-0.242132,0.307185,-0.663836,-0.438845,0.0181872,0.858067,0.317064,-0.663781,-0.197415,-0.290266,0.398954,0.683009,-0.26662,0.06954,-0.49939,0.139485,0.119184,-0.398117,0.086038,0.118608,0.531666,0.785157,0.030445,-0.84009,0.481218,0.458169,0.00253865,0.0990312,-0.433614,0.16372,0.244578,0.404623,0.494549,1.01903 +3400.92,0.778656,0.0848144,5,1.48362,0.936578,-0.467395,0.200916,0.803,-0.110235,-0.207993,0.286579,0.643968,0.391816,-0.031115,-0.380056,0.11343,0.301581,-0.11971,0.582011,0.276893,0.9749,-0.118759,-0.0665186,-0.0814854,-0.524304,-0.0243013,0.435645,0.0196356,-0.440949,0.47269,0.876942,-0.479132,-0.410611,0.560444,0.116383,0.0910797,0.380695,-0.249324,-0.0753112,-0.244126,0.0973319,0.328109,-0.519476,0.635593,0.30094,-0.224548,-0.599044,0.101584,0.0692497,-0.0400246,-1.00389e-05,0.254245,-0.360748,0.234658,0.102419,0.259536,-0.454564,1.00849,0.0720775,0.0244252,-0.738341,0.662782,-0.567991,-0.325177,0.671893,-0.67052,-1.08194,-0.445041,0.414194,0.269628,-0.337668,-0.292737,0.000468009,1.08085,-0.0991171,0.457337,0.0624805,1.37038,0.331892,0.113553,-0.232131,-0.00838368,0.370005,0.486872,-0.0625598,0.272736,-0.0186783,-0.158121,0.0726109,-0.121325,0.382405,0.229706,-0.179676,-0.600376,-0.281196,0.291576,0.0669311,-0.14169,-0.472432,-0.396792,0.0502896,-0.235279,0.137252,-0.0912424,-0.687668,-0.0644385,0.0333483,0.298003,-0.341172,-0.0572782,-0.149615,0.530323,0.712753,0.485045,-0.154191,-0.158412,0.316679,0.146796,0.0922087,0.0316787,-0.079169,0.192677,0.564751,0.157809,0.243888,-0.201007,-0.521822,0.12682,0.714349,0.195924,-0.486765,0.0897527,-0.160406,-0.395789,0.43266,-0.321897,1.14334,-0.108681,-0.293028,0.0324909,-0.203271,0.661282,-0.697601,-0.0156626,-0.16221,-0.43997,-0.352255,0.0171594,0.167399,-0.0724028,0.748898,0.17835,-0.785932,0.396771,0.172614,0.335183,-0.327776,0.386031,0.342373,-0.00379073,0.313125,0.451754,0.513417,0.698156,0.28014,0.760209,0.00487292,-0.176358,-0.403428,-0.261017,-0.0947304,-0.257973,0.140071,0.127777,0.269566,-0.186218,-0.189306,-0.564116,0.428133,-0.178254,-0.0404419,0.514362,0.993324,-0.233732,-0.055548,0.496274,0.430806,0.463274,-0.75406,-0.400516,-0.233489,0.606325,-0.10054,0.21508,-0.0557693,-0.0322876,-0.808957,-0.239913,0.454734,0.689924,-0.167885,-0.595612,0.119084,0.0121236,-0.765573,0.533889,0.32067,0.319571,0.735382,0.0618102,1.34492,0.334061,0.391119,0.276034,0.111671,0.167714,0.36572,-0.121259,0.129003,-0.764363,0.492119,0.395458,0.223198,0.386757,-0.638581,-0.333292,-0.0894046,-0.183386,0.267879,0.303836,-0.447565,0.429628,-0.335843,-0.176925,-0.0855645,0.135875,-0.0709511,-0.640412,0.4198,-0.245402,-0.371246,0.614843,0.166464,0.0649445,-0.0720564,-0.0585017,0.301811,0.441756,0.417466,0.33491,0.166824,-0.602958,-0.175082,-0.138607,-0.470204,0.371151,-0.176965,-0.388786,0.361174,0.0305555,0.218422,-0.12168,0.256802,0.293379,0.015842,-0.0437157,0.0498726,0.143032,0.510446,0.270861,-0.340441,-0.099759,-0.11744,0.142124,-0.85532,9.2905e-05,0.148444,0.618076,0.173492,0.394749,0.0525275,0.670919,0.908812,0.174453,-0.0874368,-0.478197,-0.601007,0.194529,0.392994,-0.154564,0.180355,-0.022824,0.352331,-0.154181,-0.0865185,-0.496045,-0.314394,-0.124303,-0.0622879,0.113749,-0.151981,-0.0977193,-0.468758,0.499505,0.168597,0.179619,0.410606,0.423815,-2.7554 +3407.17,0.98694,0.0848144,5,1.46264,0.952105,-0.188561,0.10704,0.788893,-0.0668557,-0.236463,0.22058,0.823089,0.458693,0.0737377,-0.530776,0.0751577,0.309552,0.179174,0.626519,0.400069,0.814438,0.1772,-0.0825539,-0.248739,-0.40019,-0.0930111,0.349959,-0.0595428,-0.215962,0.303895,0.916841,0.0386721,-0.357332,0.566897,-0.0535097,0.354715,0.341883,-0.329935,-0.078854,0.0328374,0.273219,0.463064,-0.309389,0.56024,-0.108482,-0.324434,-0.458331,-0.0954091,-0.211814,-0.061678,-0.0117748,0.55068,-0.456534,-0.0701503,0.205766,0.0921425,-0.282982,1.01428,0.0582092,0.268855,-0.592579,0.640902,-0.454601,-0.254599,0.73957,-0.663483,-0.803033,-0.488976,0.71148,0.0165205,-0.391367,-0.0447512,-0.0567904,0.915768,-0.210816,0.390075,0.497614,1.17528,0.253996,-0.0514915,-0.296495,-0.089424,0.201241,0.211458,-0.0612376,0.238936,-0.0607427,-0.0854961,-0.0458375,0.107514,0.376735,0.209303,-0.0266391,-0.366409,0.0165001,0.0648119,0.0250669,-0.0215884,-0.599003,-0.582512,0.0420932,-0.0444217,0.235626,-0.342925,-0.731373,-0.0141945,0.00653575,0.187451,-0.511393,-0.120055,-0.34012,0.516265,0.457191,0.354266,-0.191505,-0.203435,0.428319,0.0719313,0.0989108,0.0199095,-0.2812,0.286572,0.0609887,-0.231223,0.0753448,-0.135841,-0.223172,0.236467,0.74039,0.172914,-0.82172,0.142727,-0.311763,-0.309098,0.28121,-0.197269,1.28795,-0.183062,-0.352211,-0.122018,-0.246165,0.36121,-0.452605,0.258765,-0.10511,-0.430518,-0.222028,0.0821261,0.0607506,-0.014976,0.910631,0.33129,-0.574078,0.273831,0.141124,0.326464,-0.369123,0.169862,0.709696,0.0291939,0.248047,0.660603,0.284681,0.370221,-0.0242234,0.850485,0.366761,-0.481949,-0.608676,-0.177336,-0.176809,0.0610064,0.159847,-0.0953447,0.217747,-0.274594,-0.210336,-0.624729,0.0600708,-0.0502282,0.034328,0.688374,0.972249,-0.251321,0.200511,0.537903,0.227102,0.706478,-0.574773,-0.221246,0.0913368,0.179946,-0.0899157,0.236584,-0.0438702,0.115957,-0.765162,-0.242331,0.490438,0.409046,-0.37406,-0.72804,0.210414,-0.142057,-0.723606,0.629071,0.205508,0.128877,0.511454,0.221055,1.16551,0.395374,0.58956,0.0992773,0.0573979,0.259702,0.319164,-0.222324,0.172701,-0.674008,0.698721,0.478778,-0.214826,0.443454,-0.676953,-0.418492,-0.0344627,-0.00726714,0.159522,0.32044,-0.273888,0.327091,-0.395065,-0.0665311,-0.130953,0.105397,-0.540082,-0.968974,0.383456,-0.157074,-0.180168,0.781933,-0.215345,0.174852,0.0198376,0.164367,0.326485,0.424368,0.433098,0.490575,0.0844582,-0.644312,-0.328266,-0.249314,-0.520907,0.584175,-0.379281,-0.471531,0.219254,0.265339,0.228655,0.0184805,0.172803,-0.0112824,0.213787,0.121866,0.0771928,0.1364,0.294399,0.259667,-0.480232,-0.441616,-0.112317,0.0144536,-0.738021,-0.0729462,0.130533,0.280702,0.398543,0.334234,0.33992,0.50267,0.820793,0.449453,-0.195674,-0.446395,-0.239338,0.208973,0.217741,-0.0979311,0.319043,0.164103,0.45358,-0.102582,-0.136307,-0.583244,-0.0908013,-0.31023,-0.360756,0.0881438,0.0580424,-0.483216,-0.404773,0.614906,0.169527,0.218957,0.411737,0.467929,-2.82532 +3418.06,0.964544,0.0848144,5,1.56076,0.753317,-1.16514,0.40053,-0.274396,-0.104329,-0.0127864,-0.186366,-0.31418,-0.425059,0.036903,0.0132494,-0.174786,0.433858,0.0365609,0.687626,0.24982,-0.342076,0.133753,0.263692,-0.23364,-0.492177,-0.701915,0.186196,-0.113744,0.122093,-0.219625,-0.237497,-0.460313,0.0877985,0.857365,-0.697449,-0.110032,0.00880222,-0.0366058,-0.369809,-0.715962,0.372285,-0.048234,-0.420411,0.905613,0.804198,0.63391,-0.232744,-0.0189757,0.049034,-0.709902,0.128773,0.483086,-0.393976,0.092569,0.00767962,0.467253,-0.78957,0.589624,-0.275987,-0.562424,-0.448504,0.250632,0.236505,0.452639,0.827204,-0.374922,-0.582252,0.425821,-0.111951,-0.0907286,0.412428,0.310831,-0.474402,-0.780319,0.689449,0.952686,-0.612749,0.599256,0.752149,0.702838,0.375354,-0.408495,0.0577637,0.616688,-0.271874,0.361681,-0.082965,-0.0826706,-0.0798781,-0.070179,-0.413576,0.123232,-0.164812,0.212252,0.148864,0.02225,-0.275175,0.0310226,-0.0216001,0.765101,-0.334237,0.0289345,0.797533,0.55698,0.222581,-0.44514,-0.254964,0.130036,-0.24297,0.744341,-0.122729,0.301167,0.604183,-0.452408,-0.643129,0.417976,0.426775,-0.0163854,0.248995,-0.522494,0.448165,0.247289,-0.0170369,-0.643349,0.00056032,-0.0714028,0.0183901,0.0494886,0.0619442,0.241736,1.13997,0.571029,-0.166238,0.515242,-0.118359,0.364067,0.279406,0.0558059,0.230264,0.0425383,0.0283497,0.504788,-0.475163,-0.563041,0.33446,0.590932,-0.492832,0.061727,0.398037,0.00337704,0.00268714,-0.0807388,0.467649,-0.4602,0.232819,-0.228446,0.254316,-0.0708636,-0.0297186,0.572306,-0.350266,-0.129228,-0.132984,-0.219705,0.20749,0.775291,-0.434404,0.345854,0.835022,0.0267565,0.17678,-0.334244,-0.19406,0.0880608,-0.346163,0.218839,0.0100667,0.664703,0.0474896,-0.502269,0.0726867,-0.497764,0.93473,0.235732,-0.405334,-0.0630398,-0.00855031,-0.321907,0.20623,-0.107564,-0.354389,0.335178,-0.746749,0.108642,0.133689,0.551443,-0.0703096,0.376667,0.00154267,-0.305369,-0.0422924,-0.488712,0.00558247,0.253597,0.169034,-0.159326,-0.180565,-0.132723,-0.537017,-0.842866,1.02892,-0.0525849,0.0823864,0.0342474,-0.473917,-0.0947467,-0.29533,-0.0522769,0.532529,0.0494463,0.0259337,0.345981,-0.767537,-0.284695,-0.296741,0.287824,0.438815,-0.462043,0.628111,-0.521428,-0.176377,0.0678501,0.108682,-0.160484,0.0368747,-0.54914,0.453774,0.357901,0.411893,-0.00761447,0.273481,0.732245,-0.51234,-0.443684,-0.0134412,0.215068,0.0621476,0.354725,-0.235495,0.522537,0.342228,0.661071,-0.0215604,0.159625,-0.270899,0.301379,-0.0669333,-0.0434405,0.150857,-0.650767,-0.137202,0.443904,0.150657,0.218877,0.418955,0.344702,0.224234,0.151178,0.147442,0.178123,0.564294,0.482328,0.267187,-0.558954,0.227514,-0.492887,-0.265916,-0.0435247,-0.756838,0.233171,-0.0997541,-0.197586,-0.678546,-0.566825,0.0168176,-0.113786,0.307027,-0.189916,0.531872,-0.0912401,0.328105,-0.274187,-0.619201,0.217618,0.129442,0.804674,0.610031,0.138901,-0.174263,0.0198456,0.262376,0.309439,-0.00760288,-0.496157,0.133371,0.202146,0.3652,0.449607,1.39829 +3413.63,0.99291,0.0848144,4,1.65361,0.826741,-0.667592,0.242848,0.237467,-0.149211,0.323286,0.0832609,1.0782,0.52404,-0.22465,-0.150649,-0.391939,0.0974304,-0.0940617,0.399321,0.0401344,-0.042293,-0.198158,0.220573,-0.292979,-0.450596,-0.385889,0.0326958,-0.224522,-0.689915,-0.0211295,0.482164,0.18039,0.0880123,0.371603,-0.410392,-0.0507886,-0.107588,-0.216376,0.134245,0.107873,0.315475,0.235024,-0.00149249,0.885326,0.246709,0.0288682,-0.618334,-0.219968,-0.107829,-0.550033,0.341771,0.424216,0.033989,0.835446,0.258872,0.176874,-0.508125,0.537459,0.156921,-0.374965,-0.738485,0.488132,-0.305836,0.351764,0.566738,-0.70325,-0.810349,-0.199137,0.166383,-0.365286,-0.702856,-0.385881,0.250542,0.141292,0.318093,0.608206,-0.107568,0.646803,0.521981,0.0526399,-0.626399,-0.358327,0.247544,-0.454023,0.0260592,0.325974,-1.10645,0.0502775,0.0289111,-0.156313,-0.297137,-0.0216827,-0.0839094,0.385246,0.159044,0.311653,-0.504168,0.14699,-0.60387,-0.323149,0.328848,-0.0629461,0.0718821,-0.068937,0.106678,-0.871759,-0.037928,-0.462888,-0.600827,-0.11307,-0.348606,0.311295,0.155685,0.237575,-0.0265481,-0.0251339,0.595572,0.310363,-0.0318041,-0.320506,-0.158297,-0.164388,-0.391359,-0.281586,0.144538,-0.0801047,-0.293459,-0.256174,0.415326,-0.323705,-0.593692,0.252832,-0.30492,-0.117056,0.360527,-0.222964,0.816046,-0.083276,-0.0456503,-0.563615,-0.544851,0.567933,-1.01139,-0.515915,-0.171933,-0.160616,-0.49286,0.155506,-0.344113,0.0486485,0.627338,0.34994,-0.189165,-0.57209,0.378287,0.0154248,-0.337861,0.533734,0.784674,-0.0846721,0.191746,0.485635,0.215258,0.364884,-0.437944,0.776266,0.441619,0.227735,-0.517202,-0.610037,0.00230574,-0.417061,-0.0498755,-0.140664,0.543421,-0.121618,-0.111201,-0.255958,-0.32677,-0.0886342,-0.296888,-0.366939,0.842362,-0.241631,0.358253,0.0887135,-0.290341,0.623243,-0.802172,-0.0503491,-0.17047,-0.131504,0.139627,0.457307,0.328018,-0.146662,-0.462977,0.00849596,-0.0453233,0.332705,-0.114692,-0.595899,-0.437657,0.0382077,-0.125399,0.448176,-0.100639,0.0693378,-0.203015,-0.287858,1.3747,0.254667,-0.102544,0.439276,-0.511325,0.696208,0.00648028,0.226256,-0.024567,-0.292128,0.23972,-0.291662,-0.220285,-0.213857,-0.89096,0.36283,0.441618,-0.301489,0.403868,-0.14182,-0.625654,-0.0357658,-0.291402,-0.501756,0.14572,0.0427777,-0.0710867,-0.20991,0.41728,-0.125235,-0.236589,0.492844,-0.390813,0.184562,0.28069,-0.0109456,0.174883,-0.157487,0.860851,0.618676,-0.0692443,-0.697554,0.0511188,-0.436066,-0.304259,0.726268,-0.0999644,-0.0853958,0.340529,0.230707,-0.137832,-0.111863,0.39415,0.0865178,0.286906,0.162737,0.00211846,0.265188,0.110958,0.465184,-0.0494469,-0.357825,0.442942,-0.0659278,-0.258977,-0.30802,0.539741,0.121595,0.23051,0.291816,0.169394,0.322354,0.43384,-0.0337354,-0.457886,-0.194779,-0.392997,0.132382,0.336666,-0.540426,0.590238,-0.201435,0.553163,0.120314,-0.369881,0.263793,0.213729,-0.187302,-0.630592,-0.000680999,0.0359288,-0.51203,-0.361167,0.49624,0.125293,0.153486,0.353968,0.391773,-0.438605 +3413.38,0.742821,0.0848144,4,1.56718,0.861615,-0.881019,0.310327,0.418289,-0.124664,0.214072,0.077052,0.932118,0.230341,-0.249656,0.0560182,-0.336185,0.163769,-0.204365,0.507014,-0.10755,0.0894684,-0.138516,0.0301092,-0.625331,-0.566055,-0.860661,-0.104157,-0.223087,-0.54664,0.16473,0.359588,-0.0344572,0.000445138,0.187787,-0.632682,0.250785,0.0472367,-0.00156831,-0.451907,0.00943396,0.0953472,0.188219,0.129798,0.848665,0.223377,-0.153381,-0.555888,-0.214978,0.0462979,0.216029,0.471155,0.400761,0.228174,0.606563,-0.114666,-0.00993127,-0.268651,0.643803,0.00549392,-0.273322,-0.453042,0.476806,-0.400237,0.53231,0.510396,-0.702976,-1.20067,-0.0711665,0.141256,-0.158414,-0.764149,-0.33145,0.0702082,-0.0701783,0.549283,0.749219,0.492522,0.578383,0.647743,-0.204072,-0.911832,-0.490709,0.311537,0.0577003,-0.0774786,0.606905,-1.07425,-0.180261,-0.145876,-0.234184,-0.096058,0.0138853,0.144305,0.541042,0.0874911,0.152396,-0.389316,0.32499,-0.363158,-0.23123,0.0828468,0.142317,0.237297,0.0867464,0.216721,-1.07126,-0.0458613,-0.545157,-0.866777,-0.0378145,-0.544915,0.0288287,0.00498653,-0.137905,-0.155024,0.22966,0.506578,0.490395,-0.39919,-0.470567,0.155557,-0.0146475,-0.416216,-0.423612,-0.218937,0.0616779,-0.552857,-0.0836903,0.180117,-0.15275,-0.218389,0.399149,0.0347013,-0.294887,0.299063,-0.358458,0.507947,-0.048089,-0.246909,-0.385803,-0.575111,0.413631,-0.705101,-0.679499,0.177425,-0.156817,-0.218012,0.00710644,-0.700475,-0.121447,0.677257,0.267975,-0.197804,-0.437361,0.414375,-0.110213,-0.334318,0.53947,0.785634,-0.0323175,0.0833834,-0.137915,0.279881,0.510916,-0.401274,0.750548,0.627272,0.254685,-0.0652206,-0.404054,0.170923,-0.540015,0.0466659,0.181786,0.571397,0.0301963,-0.177986,0.00739655,-0.47194,-0.280283,-0.33322,-0.234493,1.11629,0.026814,0.171871,0.0135144,-0.223913,0.660333,-0.322164,-0.0808861,0.110831,0.310408,0.0465237,0.056267,0.271109,0.292093,-0.69884,0.283319,0.577965,0.00674802,0.367902,-0.613487,-0.719502,0.135553,-0.23533,0.638311,-0.275263,-0.278112,-0.426248,-0.399522,1.45096,-0.264476,0.0799526,-0.133571,-0.335834,0.662614,0.360691,-0.104809,0.137373,-0.416055,0.229484,-0.177972,0.0542804,-0.0011108,-0.569789,0.125235,0.347772,-0.40118,0.639094,-0.0965438,-0.623734,0.013379,-0.203817,-0.809358,-0.0109864,0.0186365,-0.040712,-0.139267,0.402057,-0.269586,-0.402023,0.556201,-0.349943,-0.144882,0.416893,-0.27978,-0.0538975,-0.14575,0.46308,0.810017,-0.186619,-0.430839,0.175274,-0.250641,-0.357889,0.689753,0.179896,-0.307059,0.25642,0.00544656,-0.331545,-0.288327,0.276619,-0.0869693,0.0891182,-0.0879723,-0.207434,0.290484,-0.2184,0.219078,-0.0344781,-0.568573,0.530081,-0.0148189,-0.117762,-0.0250603,0.369386,0.359277,0.0538727,0.486363,0.46777,0.557608,0.168164,-0.0458701,-0.808155,-0.24305,-0.249864,0.271682,0.369118,-0.333937,0.371331,0.0346403,0.401542,0.163245,-0.425322,-0.017965,0.178094,-0.39451,-0.595581,-0.143017,-0.0629968,-0.610644,-0.106574,0.463571,0.182321,0.191321,0.426991,0.437402,-1.14497 +3409.92,0.988284,0.0848144,4,1.61744,0.836664,-0.722097,0.216246,0.162623,-0.0717412,0.0812596,0.0389997,0.569501,0.179117,-0.622478,-0.189291,-0.255683,0.235559,-0.246765,0.558693,-0.172577,0.031653,0.0967837,-0.0175562,-0.560751,-0.344585,-0.748725,0.0223584,0.145889,-0.294238,0.158463,0.691944,-0.21881,-0.0458916,0.335627,-0.0346505,-0.155394,-0.222787,0.340771,-0.613342,-0.0309531,0.476074,0.137771,-0.491373,0.713169,0.383472,-0.17182,-0.0759069,-0.485052,-0.26285,-0.30729,0.16878,0.453158,0.00030302,0.506678,-0.122327,0.205078,-0.555854,0.702679,-0.0258892,-0.000480722,-0.810549,0.581384,0.15877,0.53865,0.672704,-0.550133,-1.01004,0.46715,0.486889,-0.0911248,-0.514412,0.115694,0.0305307,-0.151736,0.720845,0.895407,0.0414238,0.596693,0.758123,0.144429,-0.857851,-0.378651,0.309187,0.182084,-0.596225,0.257149,-0.400117,0.0460097,-0.16776,-0.233007,0.365721,-0.0402887,0.210229,-0.0413359,-0.363211,0.196776,-0.460678,0.571281,-0.340758,-0.159451,-0.078925,0.0747196,0.445059,0.251478,0.311625,-0.848122,-0.0507005,0.0878423,-0.893038,0.201588,0.044028,0.477048,0.215347,-0.421974,0.0377792,0.232999,0.42508,0.228446,-0.125592,-0.246538,-0.0891807,-0.0752349,-0.677186,-0.156624,-0.209479,0.0840577,-0.280036,-0.303865,0.411974,-0.00793607,-0.306614,0.650517,-0.608415,0.539471,0.198393,-0.46278,0.80688,-0.169311,-0.292906,-0.306002,-0.447517,0.813673,-0.684475,-0.456568,0.296731,-0.707137,-0.521677,-0.125679,-0.567622,0.30912,0.678836,0.593785,0.503834,-0.314833,0.236358,-0.277496,-0.648772,-0.00357641,0.443069,-0.20301,0.231996,-0.298122,0.2879,0.714967,-0.359763,0.871384,0.262884,0.430539,0.16075,-0.0593453,0.0628415,-0.306596,-0.00305716,0.221825,-0.00267286,0.132061,0.190469,-0.236446,-0.472786,-0.214276,-0.314174,-0.375605,0.887766,0.218361,0.0505104,-0.0434591,-0.271086,0.287987,-0.484708,0.116906,0.2558,-0.10158,-0.0784503,0.0543317,0.535548,0.0913758,-0.401316,-0.567984,0.495761,0.461403,0.110534,-0.663745,-0.254306,0.217368,-0.156885,0.670856,-0.188452,-0.174378,-0.258107,-0.657959,1.27185,-0.225847,0.00526278,0.190708,-0.680842,0.422988,0.0499974,0.229343,0.0729057,-0.926526,0.274948,-0.10143,0.114832,-0.434163,-0.673148,0.352621,0.590235,-0.113754,0.411361,-0.0335433,-0.152041,0.326174,-0.452533,-0.889507,-0.0340024,-0.114053,0.015916,0.458389,0.63521,-0.259349,-0.532401,0.548457,-0.562779,0.106716,0.398035,-0.369155,-0.164945,-0.0774983,0.447704,0.636482,-0.168026,0.0739109,0.191836,-0.146938,-0.301298,0.399792,-0.203586,-0.475603,0.270976,-0.0118534,-0.268153,-0.341464,0.249749,-0.416713,0.0394587,-0.487053,0.0645436,0.735527,0.145287,0.476351,-0.0887853,-0.234334,0.284694,-0.0808016,-0.16255,-0.516909,0.821676,0.273011,-0.245771,0.362817,0.585729,0.267588,-0.06229,0.0313459,0.0110464,-0.411534,0.0865452,0.154996,0.451321,-0.135037,-0.00102745,0.166351,0.0547707,0.0475881,-0.732942,-0.0588652,0.214568,-0.185868,-0.790413,0.0167415,-0.249634,-0.399872,0.0900992,0.648321,0.126299,0.15251,0.355385,0.390525,-0.209358 +3408.24,0.908384,0.0848144,4,1.60957,0.788098,-0.988454,0.338669,0.289995,-0.115512,-0.0910298,0.133399,0.493822,0.00616104,-0.540317,-0.347705,-0.120254,0.0246914,-0.425771,0.63753,-0.044172,0.177215,0.100341,0.0668985,-0.358669,-0.277032,-0.671972,-0.0336159,0.0464064,-0.336068,0.000116722,0.673462,-0.190182,0.100035,0.299348,-0.050032,-0.300415,-0.288977,-0.0412336,-0.542616,-0.142884,0.568413,0.331879,-0.653255,0.752058,0.434986,-0.255275,-0.0856483,-0.558241,-0.262673,-0.440671,-0.00267092,0.477908,0.170598,0.514286,0.023814,0.181975,-0.622114,0.693711,-0.215964,-0.0821245,-0.836929,0.483121,0.173773,0.27285,0.768883,-0.337256,-1.11412,0.261034,0.37303,-0.0419163,-0.46276,0.39422,0.248126,0.100821,0.590052,0.877897,0.0576537,0.646162,0.817942,0.47884,-0.840385,-0.330354,0.267385,0.144946,-0.35954,0.219605,-0.500102,0.0761491,-0.0443158,-0.241155,0.261918,0.0266915,0.239316,0.130436,-0.570451,0.436394,-0.422569,0.420464,-0.331312,-0.535183,-0.0861488,0.0801697,0.351505,0.143254,0.14463,-0.859751,0.12586,0.250512,-0.98796,0.0509479,-0.012485,0.214931,0.113878,-0.484323,-0.0780088,0.106605,0.42021,0.0520718,-0.231937,-0.202123,-0.133735,0.00955519,-0.718535,-0.187974,-0.176511,0.193137,-0.340721,-0.164667,0.453117,-0.139265,-0.255204,0.44311,-0.686368,0.348043,0.226306,-0.282817,0.856328,-0.0256568,-0.165579,-0.44934,-0.462411,0.786756,-0.987036,-0.366739,0.328679,-0.922945,-0.591931,-0.126587,-0.375142,0.102591,0.743598,0.497698,0.351915,-0.278769,0.2773,-0.284009,-0.738588,-0.194893,0.35082,-0.0773584,0.233364,-0.216574,0.260361,0.650673,-0.177634,0.945862,0.422791,0.536283,0.165978,-0.150343,0.0340579,-0.403429,0.16443,-0.0220062,-0.247043,0.218302,0.102347,-0.25789,-0.230934,-0.17608,-0.480586,-0.387221,0.799125,0.132298,-0.0409189,-0.0797521,-0.498687,0.299582,-0.319017,-0.0159269,0.384735,-0.233483,-0.127091,0.00247006,0.628469,0.133849,-0.205842,-0.522421,0.716421,0.336092,0.112851,-0.466912,-0.279296,0.305052,0.070517,0.654861,-0.197111,-0.0107237,-0.251921,-0.570845,1.39153,-0.0685565,0.195436,0.309662,-0.739784,0.567517,0.348927,0.184048,0.136448,-0.68672,0.183513,0.0605154,-0.126281,-0.458692,-0.703394,-0.0378992,0.607428,-0.259976,0.447541,-0.255926,-0.504655,0.31939,-0.484596,-0.582821,0.0661135,-0.126494,-0.107569,0.258372,0.628794,-0.252025,-0.427579,0.558765,-0.449023,0.236834,0.427677,-0.588204,-0.124871,0.243156,0.430912,0.627226,-0.297292,0.106735,0.101351,-0.252793,-0.281604,0.405009,-0.0833277,-0.390687,0.284667,-0.104045,-0.409168,-0.168689,0.141062,-0.50966,0.288772,-0.159232,-0.0445945,0.648874,0.229363,0.319329,-0.0900627,-0.303351,0.448287,-0.230304,-0.491766,-0.430731,0.490247,0.0750026,-0.265732,0.386003,0.4799,0.190875,-0.236093,0.0965344,0.0475279,-0.637753,0.210103,0.114217,0.58634,-0.116558,0.0436571,0.254082,0.355353,0.151252,-0.147007,-0.122992,0.236929,-0.13151,-0.71007,0.00275573,-0.156399,-0.509126,0.199766,0.789927,0.189969,0.134406,0.435854,0.366614,-0.519424 +3421.05,0.438759,0.0848144,4,1.58705,0.898928,-0.569567,0.149832,0.613766,-0.0728925,0.326706,-0.370704,0.674058,-0.0485164,-0.593427,0.00312971,-0.447312,0.12141,-0.23376,0.202598,-0.131273,-0.127194,-0.146557,-0.176533,-0.488415,-0.503846,-0.397034,-0.376615,-0.0568889,0.167915,0.275674,0.454637,-0.326156,-0.0295688,0.480638,-0.226826,0.441287,0.234436,0.165469,0.130599,-0.170022,0.274671,0.202076,-0.0622952,0.740633,0.224001,0.139489,-0.368852,0.223695,0.145965,-0.109361,0.0163579,0.231776,-0.155276,0.127672,0.341849,0.213074,-0.101981,0.641121,-0.033972,0.156658,-0.517156,0.871582,-0.549285,0.111085,0.6141,-0.553173,-0.955618,-0.310313,0.256279,0.0268747,-0.0603004,0.63527,0.0893456,0.438823,0.246771,0.708191,0.250036,0.838492,0.444132,0.215812,0.261659,0.186025,0.124103,-0.0425263,-0.400825,0.639255,0.15794,-0.56014,-0.0607467,-0.676787,-0.961338,-0.0483783,-0.0941782,-0.175962,0.467557,0.0847761,-0.257945,-0.13332,0.0979975,0.124792,0.320126,0.223061,0.260962,-0.074734,0.246982,-1.02038,-0.0744837,-0.327505,-0.460086,-0.0268272,-0.445951,0.304085,0.220849,-0.369053,0.0375663,0.190127,0.662671,-0.414304,0.230449,-0.2106,-0.196694,0.27166,0.0644267,-0.102932,-0.324398,0.229881,0.0365616,-0.0782273,0.243184,-0.105039,-0.262601,0.864003,-0.750249,0.82999,0.110026,0.481638,1.05073,0.382129,-0.103377,-0.121006,-0.0418215,0.572503,-0.293646,-0.437272,0.051831,0.243805,-0.338095,0.123703,-0.152665,-0.348918,0.175458,0.0786194,-0.811118,0.0772588,0.338251,-0.0265659,0.527097,0.307966,0.189621,0.134708,0.0304574,0.431783,0.266529,0.0491582,-0.163603,0.487188,-0.167149,-0.589258,0.662626,0.224093,-0.361594,-0.414281,0.108405,-0.0578852,-0.0357385,0.0542865,0.00803876,-0.331249,0.302399,-0.39273,0.28958,0.152536,0.920335,0.258997,-0.360591,0.288883,-0.0340641,0.246645,-0.363776,-0.0219363,0.494779,0.563392,-0.353473,0.150969,-0.0351258,0.455361,-0.373658,0.017379,-0.131209,-0.0321133,-0.248211,-0.849859,0.119133,0.0427403,-0.559401,0.232722,-0.157318,-0.321272,0.485914,-0.219565,1.16727,-0.448436,0.387735,-0.228703,0.07137,0.208174,-0.407304,-0.019951,0.183494,-0.383772,0.500835,0.377231,-0.054663,-0.263862,-0.0798288,-0.508381,-0.367397,-0.249892,0.549699,-0.0456825,-0.736862,-0.450148,0.16481,0.129435,0.412773,-0.0748349,-0.489097,-0.601239,-0.0211979,-0.0916958,0.0654247,0.62029,0.00341708,-0.454108,0.172994,0.377952,0.54382,-0.249572,0.329714,0.879245,-0.0263539,-0.627032,-0.354431,-0.225992,-0.0485812,0.601318,-0.375299,-0.0575274,0.196293,-0.346567,-0.578219,0.463114,0.654973,0.467545,0.0184436,-0.280848,-0.204297,-0.505654,-0.126786,0.25688,-0.483719,0.191618,0.364613,-0.323426,-0.0544436,-0.29393,-0.229699,-0.262284,-0.510886,0.127437,0.0348953,0.244853,-0.148463,-0.184427,-0.0116936,-0.244114,0.156359,0.246774,-0.405219,-0.37987,-0.118044,-0.118083,0.126649,0.287183,0.493094,0.020235,-0.238521,-0.310351,-0.650656,0.368445,-0.559345,-0.0123312,-0.0990228,-0.413162,0.169477,0.181116,0.411675,0.425578,-1.86439 +3419.61,0.817175,0.0848144,4,1.61433,0.845907,-0.911414,0.427545,0.874943,-0.137232,-0.0473949,-0.29938,0.222685,-0.202422,-0.237319,-0.178775,-0.0743053,0.266527,-0.176793,0.633542,-0.286854,0.167638,-0.188735,-0.270122,-0.253402,-0.964267,-0.84999,-0.0542514,-0.201135,0.211516,-0.0170625,0.686901,0.330687,0.261019,0.476474,-0.281179,-0.175683,0.109582,0.0078074,-0.488296,-0.193416,-0.369659,0.506083,-0.116267,0.571117,0.0414323,0.376137,-0.436469,-0.156478,0.140733,-0.2609,-0.066704,0.143221,0.147685,0.165753,0.203933,-0.127297,-0.930732,0.346954,-0.184598,-0.393046,-0.562732,0.328429,-0.737645,-0.242205,0.617317,-0.314314,-0.594586,0.242935,-0.0831878,-0.181416,0.0217476,0.356932,-0.0366694,-0.0923375,0.678681,0.501564,-0.451698,0.731815,0.568122,0.622545,0.0922815,-0.0207548,0.573685,0.485835,-0.661667,0.56523,0.260087,-0.209158,0.065564,-0.227866,-0.0216665,-0.000551496,-0.00464706,0.0215311,-0.697127,0.365523,-0.106823,0.206397,-0.406312,0.0345917,0.0724655,0.0129443,0.56515,-0.0312092,-0.206646,-0.461568,-0.163468,0.84688,-0.180726,0.258533,-0.222355,0.277355,0.0969278,-0.904347,0.27023,-0.019937,0.550664,0.0106749,0.230344,-0.222368,0.0842267,0.57924,-0.172672,-0.569964,-0.30035,0.536349,0.449323,-0.90316,0.469942,0.334211,0.0374666,0.707073,-0.278089,0.273631,-0.0149962,-0.372887,0.746998,0.0463928,0.0799539,0.309676,-0.0755829,0.708201,-0.30739,-0.219405,0.574668,0.316086,-0.580677,0.00755285,-0.464966,-0.350435,0.656222,0.244801,-0.21304,-0.0614913,0.10751,-0.393065,-0.207223,0.0458763,0.531606,-0.442361,-0.249456,0.286423,0.233169,0.202227,0.1381,0.463242,-0.482401,-0.287238,-0.330415,0.376259,-0.0848023,-0.0268133,-0.0919771,0.0519126,-0.311861,0.327034,-0.48765,-0.0980636,0.0216306,-0.0418472,0.184352,-0.136814,1.22665,0.111257,0.0048736,-0.302334,-0.059943,0.587812,-0.368141,0.0675666,0.458809,0.0484406,0.00726627,0.003336,-0.0814544,-0.142416,0.0401393,-0.158717,0.0634275,-0.189009,-0.0744932,-0.796936,0.449913,0.374153,-0.573141,-0.274451,0.0588268,0.0766253,0.00561792,-0.390568,1.03552,-0.307297,0.31193,-0.032438,-0.478004,0.0335114,0.352241,-0.246637,0.497596,-0.517321,0.067079,0.0933432,-0.630825,0.272705,-0.197941,-0.903253,0.12314,-0.17566,0.247856,0.0437078,-0.423533,0.77798,-0.0355158,0.0809673,0.111533,-0.537747,-0.0295518,-0.595193,0.379813,0.0194776,0.353891,0.303076,-0.00444702,-0.492286,0.049203,-0.531819,-0.152994,0.54652,0.590864,0.673246,0.344224,-0.424137,-0.135653,-0.0493334,-0.319996,0.872118,-0.113358,0.0963613,0.672144,-0.221953,0.525182,-0.37672,0.608774,-0.131306,-0.189393,-0.311989,0.174255,-0.619386,0.299046,0.419858,-0.103185,-0.136127,0.0898785,-0.622633,-0.0830263,-0.392368,0.0632615,0.612674,-0.352916,0.144951,-0.027481,0.22496,0.330618,-0.390473,0.160644,-0.303918,0.273601,-0.0581075,-0.13681,-0.127203,0.292675,-0.0508318,0.333449,0.355727,0.246102,-0.174907,-0.175389,-0.0913981,-0.168206,-0.177111,0.164928,0.0391643,-0.836213,-0.118263,0.108977,0.112704,0.330117,0.335714,-2.6781 +3414.55,0.977435,0.0848144,4,1.58784,0.746048,-1.2586,0.537651,0.918732,-0.161201,0.115921,-0.429078,0.309308,0.0207212,0.00767525,-0.48631,-0.281572,0.387837,-0.155976,0.645921,-0.235737,0.0666371,-0.0293761,-0.186649,-0.406415,-0.425657,-0.294633,-0.302512,-0.00483859,0.632032,0.0455857,0.0737135,-0.210333,0.0467706,0.623495,-0.436602,-0.177472,0.234878,0.0863462,0.0144864,-0.534444,0.61745,0.407344,-0.0470961,0.778905,0.479034,0.344504,-0.47747,-0.0518531,0.109407,-0.409432,-0.20268,0.140328,-0.230312,-0.158485,0.254336,-0.0963419,0.136153,0.495545,0.356785,-0.102528,-0.138637,0.234836,-0.188903,-0.238513,0.675114,-0.548865,-0.0774299,0.142263,-0.0862544,-0.502299,0.400632,0.250343,-0.208708,-0.389015,0.0654038,0.417952,-0.071936,0.509798,0.675374,0.0766684,-0.102033,-0.0891814,0.338324,0.359883,-0.212892,0.572881,-0.0127312,-0.274244,0.322803,0.117835,-0.512152,-0.121416,-0.0142752,0.534297,-0.3709,0.309481,0.144593,0.44063,0.116826,-0.3095,-0.160423,-0.145236,0.618947,0.31646,-0.162331,-0.096059,0.542106,0.0936276,0.245138,0.501684,-0.203235,0.155239,0.219963,-0.491005,0.164541,0.0445059,0.380216,-0.181459,0.129982,-0.401449,0.290624,0.226902,-0.118366,-0.863094,-0.0156313,0.11888,-0.460576,-0.257609,0.124533,-0.329378,0.288129,0.227462,-0.38268,0.155214,-0.349231,-0.126931,0.287276,0.432236,-0.0392117,0.479593,-0.424492,0.618025,-0.813121,0.388128,0.57437,0.0427079,-0.409245,-0.181758,-0.0988282,-0.265467,0.430782,-0.0833537,-0.195961,0.000774669,0.138401,-0.114252,-0.576796,0.382018,0.506658,-0.533722,0.576344,-0.165224,0.41745,-0.0557724,-0.308896,0.398997,0.161622,0.0783665,0.224806,0.0811892,-0.0539795,0.0383147,-0.0985923,0.490955,-0.0952523,-0.238529,-0.778819,-0.501133,-0.574445,-0.103448,-0.0698851,-0.259235,0.871219,0.630296,-0.191325,-0.0874365,-0.128248,0.127798,-0.80518,0.243903,-0.127563,-0.110171,-0.198529,-0.0953355,0.0426516,-0.231137,0.0880671,0.138969,0.225673,-0.0572935,-0.231882,-0.209382,0.149408,0.346741,-0.407602,-0.271159,0.117717,0.441718,-0.233112,-0.807745,1.20145,-0.366604,0.658352,0.0755639,-0.868359,-0.165033,0.840465,0.0847998,0.354261,-0.0899033,-0.140969,0.241668,-0.687775,-0.043349,0.061272,-0.36849,0.0852964,-0.61955,0.468459,0.345004,-0.382441,0.166417,0.0542159,-0.406266,0.317879,-0.483437,0.408184,-0.763276,0.495322,-0.442017,0.0306687,0.101899,-0.193932,-0.786022,-0.336899,-0.211516,-0.237063,0.543103,-0.00313275,0.705123,0.28268,-0.0124627,-0.398975,0.0717877,-0.339776,0.721132,-0.0592045,0.298949,0.237168,0.01233,0.530072,-0.187734,0.583503,-0.013233,0.13325,0.0269052,0.180328,-0.452353,0.226968,0.367877,-0.103197,-0.0650703,0.501867,-0.35502,-0.352142,-0.676005,-0.152947,0.0580005,-0.143719,0.259365,0.20151,0.444431,0.0247447,-0.215983,-0.275531,-0.887456,0.136142,-0.0272373,-0.0231446,0.233187,1.19976,-0.0950458,-0.366546,0.0356944,-0.31928,-0.372478,-0.202212,0.142299,0.127537,-0.278626,0.304058,-0.458295,-0.144518,0.322586,0.180953,0.119511,0.425386,0.345703,-2.58943 +3417.05,0.990003,0.0848144,4,1.56414,0.776555,-1.33533,0.567339,0.76708,-0.184991,0.208917,-0.317994,0.712794,0.255953,0.0631879,-0.315998,-0.36853,0.402655,-0.0127169,0.775687,-0.240727,-0.19701,-0.0447768,-0.389995,-0.337547,-0.356368,-0.279819,-0.0386124,0.0264346,0.167987,-0.0447574,-0.00126934,-0.290717,0.112011,0.50153,-0.421696,-0.0799321,0.363902,-0.0148448,-0.239752,-0.557578,0.75466,0.575039,-0.166665,0.980971,0.212978,0.341787,-0.464113,-0.158159,-0.0475548,-0.309313,-0.206405,0.160423,-0.0676815,-0.0824382,0.304347,-0.0651947,0.0365442,0.461886,0.449206,-0.0680855,-0.107615,0.192874,-0.159805,0.133272,0.861546,-0.455035,-0.126034,-0.0698949,-0.210531,-0.691767,0.0145939,0.688515,0.0821625,-0.113798,0.238479,0.426252,-0.128972,0.702079,0.568339,0.0116548,-0.267468,-0.0091857,0.469014,0.257089,0.0141481,0.801529,-0.11022,-0.340111,0.524802,0.279442,-0.821718,-0.122614,0.0733649,0.259131,-0.223023,0.153407,0.0842627,0.449786,0.0290429,-0.124999,-0.0881551,-0.0215134,0.669448,0.320269,-0.223582,-0.00130306,0.309966,0.338319,-0.129622,0.421041,-0.14265,0.238924,0.402563,-0.83139,0.108178,0.284763,0.348435,-0.319034,-0.0454261,-0.253311,0.290613,-0.0314002,-0.205945,-0.680715,-0.117106,0.137238,-0.52805,-0.128807,0.305666,-0.535102,0.21957,0.424929,-0.35724,0.195034,-0.322405,-0.196829,0.227785,0.119729,0.0865383,0.307202,-0.349144,0.758691,-0.994687,0.462538,0.493931,-0.170337,-0.326647,-0.312255,-0.0164139,-0.405508,0.19384,-0.199153,0.209101,0.126144,0.125185,-0.0852281,-0.491786,0.313944,0.432085,-0.296259,0.337374,-0.266494,0.544554,-0.247034,0.175886,0.710258,0.244044,-0.0819325,0.39171,0.085994,-0.235355,0.0813206,-0.376569,0.209311,-0.0861612,-0.152327,-0.750581,-0.0670665,-0.452365,0.116777,-0.392607,-0.172257,0.892239,0.282491,0.206104,-0.267621,-0.419383,0.108053,-0.707762,-0.118309,-0.151424,-0.244532,-0.185623,-0.0500674,-0.0734622,-0.0915064,-0.0470029,0.133981,0.141583,-0.0902014,-0.410342,-0.291419,0.248662,0.313705,-0.225145,-0.277179,-0.0484521,0.409408,-0.258792,-1.05655,1.27656,-0.495393,0.770503,0.139579,-0.703077,-0.072845,0.772045,-0.23629,0.192779,-0.0135728,-0.212671,0.430594,-0.403076,-0.18941,-0.087649,-0.441975,0.252611,-0.53518,0.541514,0.337649,-0.398064,0.00119639,-0.226691,-0.43279,0.285107,-0.528017,0.173973,-0.591139,0.523244,-0.412984,-0.0126707,0.242308,-0.240048,-0.486804,0.281721,-0.29268,-0.472028,0.28359,-0.188559,0.68364,0.397007,0.0264994,-0.390361,0.222281,-0.172375,0.871118,-0.113725,0.440497,0.543201,0.084049,0.0917606,-0.189108,0.635902,0.0978517,0.265321,-0.0606736,0.133141,-0.691565,0.281332,0.426627,0.148753,-0.329332,0.212437,-0.384117,-0.417213,-0.812042,-0.110541,-0.185809,-0.109535,-0.0255477,0.311669,0.507032,-0.0191563,-0.283176,-0.482672,-1.42499,0.136156,0.0500116,0.0549816,-0.016469,0.865916,-0.0390068,-0.549051,0.116682,-0.372645,-0.372104,-0.344924,-0.0990928,-0.0640632,-0.0900831,0.473778,-0.370702,-0.167571,0.502991,0.131399,0.109973,0.36249,0.331622,-2.1455 +3413.97,0.992309,0.0848144,4,1.58269,0.723345,-1.27134,0.534642,0.731195,-0.217244,-0.0269071,-0.0787006,0.208145,-0.207698,-0.135039,-0.249837,-0.496636,0.460659,-0.050612,0.593671,-0.0664527,0.20806,-0.0869245,-0.064073,-0.250933,-0.418803,-0.63889,-0.0835468,-0.00693442,0.176937,0.381206,-0.00094962,-0.164156,0.325194,0.67469,-0.317403,-0.452719,0.370212,-0.00964293,-0.191754,-0.424193,0.218947,0.457231,-0.0581758,0.71769,0.333921,0.341589,-0.714501,-0.08834,0.182491,-0.294773,0.0487189,0.151446,0.449256,-0.165576,0.104002,-0.139664,-0.169324,0.532796,0.372415,0.145913,-0.0358474,0.282829,-0.185574,0.129361,0.90544,-0.501444,-0.332012,-0.391839,0.109887,-0.300451,0.0972112,0.284375,-0.0582297,-0.536383,0.600586,0.375505,0.144727,0.700732,0.521023,0.178411,-0.427119,0.0150363,0.499885,0.0558768,-0.878909,0.637994,-0.685613,0.216296,0.213877,0.411709,-0.966014,0.106522,0.270436,-0.128986,0.202417,-0.0632173,0.0219767,0.164504,-0.277346,0.05857,-0.23435,-0.0532457,0.39147,-0.240779,0.00104129,-0.222996,-0.0337575,0.0279215,-0.350155,0.177659,0.0482407,0.121148,0.790226,-1.02686,-0.127992,0.652014,0.313815,-0.215463,-0.0596632,-0.0323906,0.191413,0.201605,-0.0778683,-0.632111,-0.394956,-0.19615,-0.743331,-0.0145743,-0.240525,-0.624327,-0.352802,0.776314,-0.680756,-0.284511,0.176498,0.0790037,-0.0764068,0.0763257,-0.290542,0.290313,-0.088903,0.15149,-0.229689,-0.321234,0.371602,0.104466,-0.900196,-0.764644,0.295789,-0.375233,-0.0458031,-0.124084,0.23291,-0.315097,0.576011,-0.133409,-0.277035,0.291886,0.334471,-0.190822,-0.192048,-0.0489857,0.121311,0.103205,0.117341,0.226943,0.0464306,-0.230739,0.446728,-0.160028,-0.65482,0.154774,-0.507568,0.420211,-0.782941,-0.00813542,-0.458666,-0.169944,-0.718381,-0.0501539,-0.416275,0.202873,0.680605,0.306596,0.153118,-0.103248,-0.548662,-0.0674935,-0.46479,0.087031,0.288984,0.213533,0.0113075,-0.0892218,-0.306453,-0.275498,-0.174987,0.150106,-0.164962,0.0562956,0.0561477,-0.598086,-0.0328215,0.376497,-0.276578,-0.261521,0.166468,0.396133,0.0642332,-0.855753,1.00487,-0.303915,0.360229,-0.279498,-0.562641,0.234679,0.890283,-0.170547,0.21701,0.0272067,0.203403,0.240025,-0.243862,-0.0821786,-0.337622,-0.197853,0.364146,-0.340705,0.906209,0.185901,-0.100465,0.327654,-0.265018,-1.02964,0.0262705,-0.60698,0.229242,-0.254851,0.405394,-0.173544,-0.285018,0.245184,-0.186689,-0.464748,0.397755,0.0959076,-0.707429,0.378414,0.0249712,0.656453,-0.0334603,0.00665833,-0.337867,-0.0397753,-0.427851,0.956964,-0.725835,0.186472,0.660937,0.480257,0.373376,0.188604,0.240531,0.566206,0.647236,0.190375,0.614847,-0.832143,0.111477,0.270003,-0.422156,-0.34108,0.418006,-0.362307,-0.241914,-0.320615,-0.166025,0.178296,-0.318385,0.288922,0.185184,0.459039,-0.00880671,-0.274504,-0.115641,-0.736627,0.0633899,-0.130838,0.0708351,0.399549,0.268866,0.141526,-0.0661507,0.317103,0.27774,-0.0192076,-0.361076,-0.0441519,-0.0208916,-0.0900463,0.0179174,-0.594111,-0.0678696,0.128868,0.172433,0.11896,0.41525,0.344905,-1.9083 +3414.61,0.830435,0.0848144,4,1.56298,0.815721,-0.828831,0.431034,0.671077,-0.265098,-0.117769,0.718704,0.111157,-0.185691,-0.0823706,0.000701711,-0.211592,0.602118,-0.0393064,1.20409,0.378016,0.0915927,0.0875194,-0.166868,0.130658,-0.47732,-0.592541,0.265389,0.0772154,0.0816719,-0.218471,0.284782,-0.0834318,0.138004,0.674485,-0.100222,0.182626,0.549335,-0.116789,-0.456646,-0.433089,0.79381,-0.131051,0.162983,0.626605,0.575407,0.185608,-0.302776,-0.252086,0.233222,-0.443726,0.0979711,0.328267,0.0110479,-0.102783,0.178829,0.195356,-0.48166,0.404807,-0.115183,-0.578065,-0.667093,0.25629,-0.427143,0.326815,0.814671,-0.586212,-1.07608,0.00682205,0.255852,-0.125459,0.169489,0.294285,-0.527637,0.286937,0.61729,0.664123,-0.160111,0.370494,0.33598,0.379319,0.258626,-0.108738,-0.148328,-0.0177056,0.418868,0.0986006,-0.438765,0.148239,0.157412,-0.160319,-0.254775,0.203795,-0.40146,-0.282331,0.101629,-0.280721,-0.189301,-0.289049,-0.0941848,-0.0533508,-0.0504525,-0.426221,0.444132,0.0681377,0.169333,-1.12246,0.233933,-0.367312,-0.61907,0.13097,-0.168017,-0.167947,0.586013,-0.10484,-0.0840576,0.55364,0.501109,-0.306656,0.0260024,-0.46615,-0.09107,0.323653,-0.310031,-0.308596,-0.0187118,-0.648929,-0.00593286,-0.211468,-0.181333,-0.389684,0.570074,0.458544,-0.0241152,0.121642,0.116827,-0.491534,0.183706,-0.0513502,0.104595,0.0151227,0.283767,0.76666,-0.666884,0.0939143,-0.0304121,-0.310698,-0.687941,-0.511768,-0.351807,-0.439704,0.459767,-0.153716,-0.933533,-0.283389,-0.204374,-0.124175,-0.202645,0.486148,0.192933,-0.208239,-0.252524,0.221898,-0.779485,0.336912,-0.502951,1.10052,-0.288879,0.0622272,0.290524,-0.417924,-0.233068,-0.381969,-0.054041,0.228125,0.194415,0.0135399,0.0770308,0.0818275,-0.904982,0.0811832,-0.2292,0.392524,0.811291,0.277194,0.0392779,0.112964,0.0884059,-0.124799,-0.24224,0.198065,0.114216,0.683523,-0.232867,-0.271492,-0.262281,-0.242459,-0.779901,-0.385489,-0.010811,0.138048,-0.955966,-0.58718,-0.230475,-0.0485638,-0.600892,0.191098,0.303134,-0.025035,0.231506,-0.692016,1.17108,-0.171075,-0.0673521,-0.127244,-0.29509,0.37202,0.361145,-0.541067,0.823136,-0.496579,0.29892,-0.100731,0.116154,-0.0975295,-0.188359,0.360407,-0.264109,-0.467355,0.210537,-0.847313,-0.794989,0.146629,0.454874,-0.41464,0.240051,-0.182915,-0.0874401,-0.0331478,0.640397,-0.153474,0.0683106,0.24375,0.160282,-0.368666,0.892408,-0.125207,0.140873,1.06462,0.471651,0.891485,-0.07994,0.190149,0.0499681,0.501666,-0.761815,0.278161,0.0368467,0.256027,0.518047,-0.0793666,0.183634,-0.412657,0.47553,0.177562,-0.147133,1.03596,0.885067,-0.0791141,0.0563702,0.442511,0.429491,-0.413649,0.0118434,-0.112188,-0.00426703,-0.410814,0.141902,0.203854,-0.541827,0.475608,-0.479112,0.417296,0.206987,-0.672588,0.202852,-0.210577,0.0605439,0.332139,-0.0969456,0.115458,0.137109,-0.226632,-0.439055,0.0983193,-0.285426,0.225757,-0.642804,-0.123158,-0.279798,0.0215511,-0.296093,-0.658255,-0.0578367,0.330871,0.15271,0.201348,0.390782,0.448719,-2.01403 +3412.74,0.936362,0.0848144,5,1.55955,0.796223,-0.839531,0.430322,0.662216,-0.272531,-0.137852,0.728273,0.175691,-0.150705,-0.0833721,-0.00743924,-0.253806,0.631979,-0.0392942,1.17968,0.335311,0.099272,0.0367056,-0.198762,0.116952,-0.488819,-0.63754,0.218904,0.099339,0.0538347,-0.203123,0.283143,-0.0921657,0.123757,0.672416,-0.0969508,0.179474,0.545254,-0.0909447,-0.445372,-0.428655,0.816022,-0.106253,0.170563,0.60824,0.601633,0.128725,-0.309039,-0.252609,0.178656,-0.385939,0.0705624,0.326154,0.0157034,-0.112413,0.130264,0.215482,-0.509018,0.40231,-0.130469,-0.579086,-0.670899,0.292244,-0.413884,0.330113,0.780274,-0.650516,-1.09738,-0.0371128,0.21222,-0.17257,0.102106,0.289936,-0.569975,0.287329,0.644503,0.686787,-0.137926,0.37697,0.323118,0.405838,0.277509,-0.132296,-0.163934,-0.0135361,0.422052,0.093521,-0.465008,0.125004,0.200134,-0.131896,-0.229869,0.241982,-0.384148,-0.287136,0.0904909,-0.242419,-0.191598,-0.312342,-0.127649,-0.0848826,-0.0160926,-0.400376,0.447705,0.0675918,0.163149,-1.1319,0.204116,-0.358733,-0.648053,0.0858302,-0.167416,-0.166198,0.639944,-0.112698,-0.112672,0.525811,0.507977,-0.316908,0.0416282,-0.483878,-0.0815467,0.326487,-0.312509,-0.343898,-0.00255492,-0.649936,0.0127493,-0.2859,-0.163312,-0.404461,0.556137,0.468933,-0.00202137,0.0881352,0.131352,-0.483623,0.182914,-0.0691213,0.0997538,-0.0505187,0.263017,0.78209,-0.646148,0.0741214,-0.0179333,-0.289844,-0.68971,-0.531337,-0.381767,-0.428639,0.465126,-0.154571,-0.897153,-0.331818,-0.211319,-0.132262,-0.189753,0.504711,0.197922,-0.203843,-0.254475,0.263061,-0.801541,0.369814,-0.482753,1.09036,-0.308835,0.0298534,0.323567,-0.367998,-0.247677,-0.391222,-0.0694722,0.211607,0.193153,0.00450323,0.0888687,0.0168111,-0.920439,0.053466,-0.264156,0.379444,0.820435,0.255212,0.0752614,0.0884698,0.131221,-0.169319,-0.272433,0.145903,0.0981451,0.659214,-0.225097,-0.231262,-0.236136,-0.269724,-0.800304,-0.383241,-0.0158421,0.174764,-0.942319,-0.620245,-0.26434,-0.0216439,-0.569561,0.165273,0.297385,-0.0126953,0.25251,-0.695231,1.15615,-0.083998,-0.0606263,-0.134568,-0.293602,0.375454,0.410099,-0.5462,0.8529,-0.515674,0.290227,-0.0797653,0.154043,-0.14356,-0.175967,0.326737,-0.235479,-0.453792,0.220884,-0.845561,-0.791948,0.169364,0.424183,-0.395243,0.238345,-0.205503,-0.0618892,-0.0371569,0.64547,-0.14404,0.0730685,0.219745,0.134182,-0.38662,0.882932,-0.152533,0.094379,1.10294,0.449941,0.881177,-0.115408,0.168264,0.0813142,0.51929,-0.768012,0.254056,-0.0257228,0.277795,0.53148,-0.0518619,0.164938,-0.40943,0.487106,0.200657,-0.139386,1.02514,0.875699,-0.0239763,0.070548,0.433832,0.430257,-0.404473,0.00548465,-0.112535,-0.0192288,-0.392004,0.0717498,0.173855,-0.54898,0.481813,-0.50441,0.41426,0.185086,-0.632503,0.231268,-0.206615,0.0649346,0.293355,-0.0713973,0.109441,0.127776,-0.224364,-0.460869,0.0835972,-0.319091,0.209654,-0.658709,-0.140575,-0.24804,0.0406164,-0.335996,-0.718538,-0.0325346,0.315983,0.152059,0.19922,0.389947,0.44634,-1.94541 +3415.47,0.920274,0.0848144,4,1.56986,0.840336,-0.725332,0.372662,0.515772,-0.140181,0.42311,0.0153299,0.359795,0.0742192,0.0873737,-0.419152,0.0470439,0.6064,0.363453,0.542248,0.442329,0.192458,0.344113,0.268601,-0.00455561,-0.418368,-0.778523,0.459964,0.286256,0.0730909,0.177643,0.468811,-0.342867,0.108067,0.997517,-0.129391,0.552674,0.603161,-0.451458,0.0655096,-0.657755,0.440066,0.745816,-0.159781,0.890793,0.903621,0.394728,-0.637515,-0.409674,0.659736,-0.428291,0.086218,0.171862,-0.0627902,0.158242,0.504283,0.0947381,-0.354079,0.252285,-0.549364,-0.298445,-0.350642,0.221971,-0.136539,-0.149937,1.05711,-0.70479,-1.08193,-0.145368,0.245065,-0.229711,0.30411,0.795125,-0.37274,0.119509,0.839578,0.554777,0.107261,0.828111,0.41666,0.141447,-0.408662,-0.198195,-0.168306,0.335022,-0.483443,0.206683,-0.589597,-0.47342,-0.183441,0.0840644,-0.335925,0.153464,-0.217353,0.149504,-0.212701,-0.0130215,0.0240494,0.287847,-0.336581,0.174854,-0.0954974,-0.0850608,0.432679,-0.131572,-0.0114581,-0.607237,-0.490369,0.198834,-0.597036,0.0187409,-0.0501346,0.367866,0.668395,-0.6903,-0.550918,-0.232569,0.640433,-0.0663164,0.37341,-0.0437557,0.156033,-0.118681,0.282377,-0.813487,-0.371776,-0.543198,-0.808097,0.370952,-0.176101,0.626268,0.0206891,0.308692,0.172844,0.000927279,-0.252433,-0.109485,1.11569,-0.1864,-0.0475241,-0.821974,-0.0491244,-0.133566,-0.332564,0.456323,-0.127248,0.0479583,-0.259438,-0.791593,0.44547,0.0484106,0.617834,-0.246673,0.0337662,-0.447277,0.21867,0.281314,-0.27361,0.307916,0.197983,-0.0837197,-0.164536,-0.00892434,-0.617163,-0.413697,-0.322524,0.688038,-0.429543,0.161201,0.481251,0.0403625,0.179817,-0.631761,-0.161582,0.0144771,0.28991,0.307802,0.128896,-0.013517,0.167325,-0.539317,0.0615845,0.47478,0.438896,0.638262,-0.0139282,-0.198291,0.0448508,-0.0764858,-0.577747,-0.178493,-0.127467,-0.129605,-0.722479,0.336368,-0.362519,-0.316983,-0.410846,0.407521,-0.199856,0.145187,-0.0761996,-0.945113,-0.0494934,-0.21471,-0.494157,0.56245,0.0843308,0.462499,-0.477103,-0.205622,0.632963,-0.950182,0.473963,-0.133273,-0.32972,0.124817,-0.122753,-0.489727,-0.240689,0.229775,0.00472092,-0.115877,-0.646617,-0.148417,-0.544686,-0.544228,-0.265082,-0.534523,0.643922,-0.699581,-0.426491,0.131888,-0.422531,-0.381253,0.265625,-0.485571,0.19569,-0.178975,0.371844,0.0877999,0.140934,0.231817,-0.84974,-0.133497,-0.0594652,-0.846019,0.309307,0.478773,0.174295,0.681471,0.68097,-1.08637,-0.382663,0.00573151,-0.780639,0.36827,-0.209102,-0.533349,0.180781,-0.289375,-0.203435,-0.228428,-0.0395031,-0.170998,0.590539,0.442389,0.0526453,0.524067,0.55666,-0.230575,-0.448059,-0.26689,-0.0597495,-0.134879,-0.675641,0.326549,0.292506,0.13071,-0.324831,-0.0360156,0.324706,-0.338442,0.109162,0.295162,0.0911804,-0.0953522,-0.0349809,-0.0759185,0.0881837,-0.115325,0.290345,0.17764,0.0583,0.473447,-0.337815,0.558003,-0.484582,0.10508,-0.0148945,0.695565,-0.310588,-0.374843,0.531718,-0.135555,0.174108,0.21128,0.417263,0.459652,-1.56534 +3417.67,0.937131,0.0848144,4,1.52869,0.747552,-1.08125,0.51843,0.732334,-0.0198208,0.080686,0.0660516,0.209814,0.493182,0.485938,-0.679328,-0.0430439,0.622083,0.0273549,0.574781,-0.0224155,0.0956588,0.242379,0.170064,0.238765,-0.471525,-0.322372,0.442038,-0.0231077,-0.123719,0.299791,0.250333,0.0198957,0.0947564,0.945217,-0.0799397,-0.0063872,0.268107,-0.102542,-0.323016,0.258584,0.447663,0.276716,0.00367685,0.686417,0.0130668,0.0162807,-0.441297,-0.0289275,-0.0636868,-0.263374,0.130005,0.289288,-0.123035,-0.0750315,0.717406,0.619821,0.142456,0.0742977,-0.163549,-0.358091,-0.890326,0.624156,-0.993683,-0.0477953,0.826132,-0.79293,-0.817329,0.543298,-0.025084,-0.10455,-0.602894,0.0229597,-0.324988,0.33109,-0.0267908,0.368685,-0.083631,0.974534,0.479339,0.358174,0.185887,-0.220672,-0.0534424,0.406165,-0.309447,0.193451,-0.320782,-0.144757,0.0648756,-0.412985,-0.0874876,0.09958,-0.139365,0.0806736,-0.412357,-0.070233,-0.0654383,-0.308333,-0.899675,0.150026,-0.32517,0.00766786,0.285792,-0.421585,0.641122,0.00548509,0.0704255,-0.33005,-0.666345,-0.0600609,-0.517486,0.444112,0.418437,-0.537491,-0.156714,-0.111604,0.848345,0.198772,0.322275,0.0473823,-0.0481264,0.0807284,0.222738,-0.865005,0.133452,-0.313362,-0.334241,-0.142403,0.666043,-0.0556415,0.177042,-0.0724631,0.199421,-0.173633,-0.387443,-0.0504515,0.398844,0.17823,-0.29404,0.312291,-0.644532,0.53527,-0.509404,-0.191983,-0.153323,-0.160214,-0.416996,0.328997,-0.0896637,0.412065,0.453464,0.0212482,0.00283069,0.231836,0.289125,0.0427623,-0.130108,0.132232,0.457043,0.652511,-0.671901,0.508136,0.145469,0.853115,-0.0712,0.667945,0.156513,-0.465739,0.0980191,-0.00135896,-0.105588,-0.131926,-0.014907,-0.435901,-0.492584,0.391653,0.107931,-0.548888,-0.0528448,-0.361772,0.636736,0.408714,0.770583,0.622777,-0.197756,-0.407752,-0.0127333,-0.275848,-0.228554,0.10996,-0.549252,0.572462,-0.202848,-0.0562471,-0.0284558,0.0706511,0.153479,0.00651828,0.073267,-0.46934,0.0274414,-0.0219531,0.109637,-0.121071,-0.681002,-0.0407901,-0.112897,-0.275167,0.212879,0.195499,1.09783,-0.356373,0.270498,0.458832,-0.330599,0.41112,0.0173831,-0.594476,0.555852,0.117544,0.225653,-0.160303,0.0957121,0.0512237,-0.280894,-0.69624,0.203913,-0.159427,0.382182,-0.257323,-0.3932,-0.415205,-0.240167,-0.202057,0.680845,-0.453691,-0.318457,-0.2764,0.161065,-0.0943357,-0.281937,0.421189,-0.243246,0.940695,0.261024,-0.611755,0.0264232,0.195804,0.0715574,0.0878507,0.533985,-0.13195,-0.327869,-0.523785,-0.756909,0.431779,-0.434252,0.226898,0.420924,-0.447577,-0.109708,0.428436,-0.0351561,0.120396,-0.0139223,0.433136,0.030999,0.190407,-0.638811,-0.137144,-0.640689,-0.409923,-0.205463,-0.245161,-0.0950961,0.114017,0.0145954,0.172439,-0.0207407,0.0619792,-0.454565,-0.12312,-0.345628,0.15022,-0.582142,-1.08581,-0.276411,0.091461,-0.0286175,-0.0651867,0.417529,-0.178935,-0.690916,0.271541,-0.177771,0.233578,-0.152313,-0.0245874,-0.718258,0.0810704,0.0319065,0.443001,0.769902,0.118725,0.129185,0.174834,0.359423,0.418131,-2.14273 +3411.33,0.738739,0.0848144,4,1.61174,0.698902,-1.23956,0.585471,0.956117,-0.095346,-0.180353,-0.0454972,0.221173,-0.255687,0.58453,-0.370732,0.199871,0.385184,-0.399268,0.316408,-0.0220936,0.234797,-0.580869,-0.195581,-0.0560263,-0.564972,-0.431838,0.0969253,-0.779165,0.52003,-0.325643,0.590122,-0.466896,-0.0250045,0.900797,-0.623725,0.0133828,0.795479,-0.411403,-0.142804,-0.529556,0.0207182,0.397666,-0.0377256,0.749574,0.777838,-0.281608,-0.525035,-0.426043,0.606687,-0.640221,-0.00220711,0.056906,0.322973,-0.100467,0.315733,0.0983025,-0.0443955,0.0947652,-0.184323,-0.312585,-0.767268,0.196013,-0.609835,0.205175,0.636605,-0.340314,-1.8823,-0.317946,0.318742,-0.0083473,0.0209189,-0.242424,-0.732928,-0.26294,0.222283,0.368221,0.33706,0.689396,0.536795,0.0139332,-0.112865,-0.110492,0.049947,0.309672,-0.502384,0.104642,0.107738,0.0643848,-0.236166,0.403609,-0.156593,0.568019,-0.184251,-0.517938,0.254453,-0.193283,-0.326094,0.291066,-0.300355,0.0420723,0.152619,-0.26441,0.573315,0.153547,-0.0823136,-0.574775,-0.0610061,0.0345877,-0.147454,0.612633,-0.1354,0.0251273,0.680374,-0.0667759,0.0193858,-0.202155,0.805327,0.149862,0.246692,0.0788648,0.254407,0.145305,0.397653,-0.146383,0.387551,0.627427,-0.322398,0.0236724,0.265053,0.247943,-0.53728,-0.0325242,0.29989,-0.380428,0.224459,-0.208645,0.846452,-0.0129222,0.138891,-0.101787,0.21083,-0.106676,-0.179164,-0.74094,0.133243,0.569411,-0.52752,0.159291,-0.139361,-0.461972,0.580496,-0.179187,-0.556711,-0.517755,0.0138432,0.446622,-0.326938,0.469728,0.411439,0.13767,0.0510922,-0.0199758,0.290585,0.386197,-0.127124,1.05216,-0.241332,0.0532462,-0.0306648,-0.036983,-0.105041,-0.316994,-0.174992,0.180348,0.509241,0.480121,-0.357656,-0.487318,0.131266,-0.22724,0.447958,0.134571,0.935741,0.259287,0.658945,0.0845551,0.311932,-0.228323,-0.161064,-0.933389,-0.126433,0.744385,-0.78658,-0.118857,0.161967,0.469091,-0.333583,-0.0204311,-0.176087,0.53113,0.229177,-0.391886,-0.2746,0.170729,-0.299904,0.000533171,-0.134271,-0.355924,-0.569498,-0.300581,1.01227,0.461332,0.514041,-0.450308,0.44548,-0.179557,0.480676,-0.557826,0.285868,-0.616331,-0.0890276,0.154743,0.0915449,-0.0269886,-0.882055,-0.239154,0.356287,-0.226146,0.320664,-0.082348,-0.287015,0.0571499,-0.446396,-0.61555,0.288038,0.123725,0.415385,0.30969,0.773526,0.070818,-0.0173399,0.834417,-0.902613,-0.234626,-0.213535,-0.456267,-0.00684652,-0.482964,0.565202,0.235407,0.526045,-0.0705346,-0.653354,-0.27177,-0.448488,0.509588,-0.00202973,-0.162673,0.115772,-0.381915,0.026272,-0.0800381,0.337567,0.106541,0.0979081,0.209524,-0.544608,0.140966,-0.159673,0.245058,0.17203,0.0714948,0.0366933,-0.00535603,0.100906,-0.00347483,0.36318,0.0175973,-0.174228,0.046861,0.130023,0.284343,0.0388132,-0.537783,0.269631,-0.0955971,0.392741,0.289399,0.0280284,-0.228857,0.398799,-0.517914,0.140514,0.597925,-0.0142858,0.13465,0.445358,-0.150087,-0.754621,0.0809853,-0.0232701,-0.214576,-0.132521,0.139721,0.18187,0.19638,0.426463,0.443148,-2.6781 +3407.3,1,0.0848144,4,1.57964,0.781884,-0.952185,0.449149,0.751922,-0.0185316,-0.253051,-0.0813806,0.253747,0.373268,0.292288,0.0894453,-0.1936,0.695886,-0.220536,0.995948,0.294255,-0.200102,0.511033,-0.283385,-0.441035,-0.585233,-0.10432,0.00701372,0.207054,-0.42521,-0.126895,-0.170576,-0.34373,-0.0215174,0.969785,-0.279038,-0.0950223,0.0568415,-0.0151623,-0.296473,-0.0676999,0.898209,0.213833,-0.254912,0.683987,-0.0229526,0.402923,-0.767353,0.150893,-0.935037,-0.282617,-0.0901315,0.279198,-0.0495876,-0.298316,0.489865,0.0581148,-0.650353,0.378101,-0.266189,0.15673,-0.998751,0.379092,-0.652605,-0.283842,0.938204,-0.810161,-0.142365,0.281101,0.240135,-0.15661,-0.125706,0.170196,-0.162298,0.224765,0.117016,0.383308,-0.664795,0.359241,0.374273,0.676087,0.115721,0.130133,0.224307,0.654084,-0.414489,0.82134,-0.196619,-0.5705,0.326605,-0.270336,-0.189071,-0.331731,-0.342487,0.184206,-0.0746901,0.364289,0.27664,-0.331394,-0.684899,-0.0393871,-0.38256,0.381821,0.024539,0.0675597,0.459485,-0.212966,-0.408303,0.0627637,-0.344513,-0.236148,-0.260298,0.521437,0.487142,0.0898247,-0.204537,0.387643,0.615997,0.0449864,-0.332269,-0.210721,0.0756096,0.399413,-0.0212293,-1.03415,-0.05072,-0.705264,0.0751768,0.29738,-0.0144681,-0.0503152,0.49455,0.433036,-0.62615,0.119838,-0.699235,0.164818,0.197257,-0.130848,-0.261255,-0.0365742,0.0612829,0.937636,-0.630215,-0.598111,0.417889,-0.191094,-0.547965,0.430424,0.485042,0.333915,0.153422,0.014713,-0.0598233,0.28056,0.372612,0.196541,0.289778,0.248725,0.422704,0.431766,0.0213273,0.206507,-0.564357,0.295845,-0.0129959,0.13635,0.818351,-0.191333,0.40248,-0.0340254,-0.27287,0.0649692,0.0370405,0.137076,-0.815228,0.080758,0.229653,0.0575933,-0.595116,-0.217425,-0.581544,-0.00198359,0.660476,-0.174159,-0.869253,0.187313,0.158733,0.2952,-0.423278,0.00321829,-0.429097,-0.499148,-0.440622,-0.231809,-0.137002,-0.457339,-0.667756,0.15793,0.410414,-0.0454109,-0.751151,-0.505097,-0.296993,0.320257,0.0193618,0.253312,0.205113,0.176158,0.25486,-0.528108,0.790027,-0.622572,-0.31759,0.568507,-0.442419,0.331548,-0.121206,-0.142219,0.506079,-0.487651,0.502452,0.285809,-0.452327,-0.145763,-0.170014,0.432787,-0.0974725,-0.396254,0.422973,-0.455183,0.0441992,-0.0968924,0.470571,0.329121,0.253503,-0.480201,-1.06359,-0.583219,0.237462,0.175028,0.143695,0.419347,0.48513,0.151757,0.373531,0.259177,0.223216,0.957694,-0.311853,0.518445,-0.184875,-0.250359,-0.305959,0.348333,-0.707276,0.215952,-0.381741,-0.482042,0.867843,-0.0533359,-0.224772,-0.454572,0.285027,-0.201583,0.192035,0.105827,0.786351,0.311934,0.511454,-0.176904,-0.297916,0.398402,0.186555,-0.240145,-0.770556,-0.44429,-0.244331,0.186403,-0.0165045,0.222133,-0.155343,0.422529,-0.0498571,0.171959,-0.299048,-0.298739,0.1166,-0.388324,-0.249984,-0.0321146,0.0652656,0.578521,-0.532103,-0.011197,-0.02924,-0.256427,-0.00618778,0.0738607,0.102556,0.307397,0.121372,-0.308129,-0.00589383,-0.045352,0.196866,0.17873,0.443695,0.422764,-2.21994 +3413.72,0.998615,0.0848144,4,1.57602,0.727352,-0.69219,0.297733,0.645957,-0.0778296,-0.369882,0.0689348,0.137868,-0.0423154,0.41727,-0.216195,-0.131609,0.724088,-0.0654593,0.905691,0.472357,-0.206927,0.338635,-0.231206,-0.140018,-0.795554,-0.10933,0.0934605,-0.00235369,-0.026882,-0.320012,0.00113445,-0.431512,0.0139828,0.940771,-0.212898,0.0218931,-0.0748464,-0.114475,-0.0944508,-0.142045,0.457671,0.424263,-0.366627,0.757586,-0.232612,0.235529,-0.540434,-0.154459,-0.98717,-0.166021,-0.0344261,0.468136,-0.316302,-0.135514,0.414037,0.106452,-0.521787,0.859539,-0.113798,0.20712,-0.673983,0.824772,-0.869132,-0.105216,1.05425,-0.692946,-0.545988,0.442747,0.103928,0.0833033,0.136188,0.139664,-0.244727,0.182346,0.365239,0.447156,-0.506907,0.756511,0.344855,0.873195,-0.216241,-0.179223,0.157008,0.782377,-0.363401,0.442953,-0.182768,-0.573077,0.705531,-0.298134,-0.0480793,0.0304333,-0.301009,-0.107892,-0.0504755,0.519818,-0.127319,-0.154821,-0.485569,0.400251,-0.39985,0.487979,0.131959,0.097996,0.174172,-0.652618,-0.265041,-0.0251858,-0.49965,-0.34952,-0.368415,0.640046,0.699076,0.199009,-0.00942178,0.495699,0.600836,0.2882,-0.630363,-0.37633,-0.0808743,0.479938,0.0120279,-1.18067,-0.288322,-0.390692,0.0969746,0.377662,0.123766,-0.212035,0.28642,-0.0725268,-0.811008,-0.317992,-0.49278,0.23001,0.0589059,-0.0555675,-0.20955,0.342346,0.0871362,0.968441,-0.608258,-0.353815,0.572528,0.123284,-0.283246,0.57772,0.14831,0.106835,0.334629,-0.013184,-0.068537,0.125823,0.507769,-0.0975511,0.0513063,-0.0681788,0.130342,0.35815,0.280387,0.341604,-0.311776,0.0876217,0.128127,0.44475,0.866371,-0.0751998,0.181851,0.0702121,0.0924615,-0.184346,0.101268,-0.120237,-0.762898,0.162579,-0.120848,-0.0916248,-0.409704,-0.291029,-0.462039,0.105257,0.420529,0.270551,-0.645661,0.0715491,0.0220798,0.216715,-0.327313,-0.00723285,-0.340032,-0.478011,-0.358772,-0.249086,-0.171568,-0.391386,-0.83751,0.165505,0.264176,0.0993893,-0.524026,-0.782594,-0.564331,0.57888,0.0545884,0.0206137,0.0683832,0.121712,0.353387,-0.672202,0.938704,-0.755795,-0.481039,0.636384,-0.749476,0.246062,-0.181802,-0.524036,0.251956,-0.28543,0.413989,0.347954,-0.747492,-0.264501,-0.227958,0.275544,-0.335502,-0.684785,0.395246,-0.515735,0.0602081,0.0909792,0.348787,0.0746007,-0.0296127,-0.338058,-0.917758,-0.702258,0.212955,0.1428,-0.0782785,0.495719,0.412693,-0.0879774,-0.10762,-0.080173,-0.370529,0.610195,-0.00963226,0.491364,-0.0288568,-0.456196,-0.382845,0.678017,-0.660966,0.167125,-0.349067,-0.611227,0.683216,-0.18143,-0.111887,-0.351516,0.0699305,-0.527378,0.507265,-0.0131884,0.586369,0.296817,0.652282,-0.248716,-0.319502,0.21816,0.197854,-0.246829,-0.428481,-0.715518,-0.211095,0.34973,0.0291767,0.261229,-0.129138,0.29504,0.510589,0.17723,-0.242689,-0.4854,-0.165867,-0.401739,-0.018439,-0.519714,0.132763,0.425536,-0.378127,-0.140741,0.229566,-0.147457,-0.152397,-0.0773329,-0.139991,-0.00359931,-0.222267,-0.104697,-0.528728,-0.117242,0.127178,0.203324,0.356621,0.450915,-1.75355 +3385.97,0.858154,0.0848144,4,1.53686,0.702337,-1.21138,0.502649,0.789619,-0.0903259,0.28994,-0.460748,0.298309,-0.42457,0.281725,0.0499378,0.0676101,0.644885,0.00114936,0.505702,0.143932,-0.024418,0.0786736,0.172296,-0.145509,-0.769164,-0.360441,0.269617,0.144784,-0.134108,-0.00973606,0.282101,-0.561242,-0.145702,0.831992,-0.527594,-0.0362587,0.0767177,0.200302,-0.22319,-0.0143466,0.481693,0.813016,-0.466707,0.582967,0.437751,0.114761,-0.920337,-0.0646299,-0.356139,-0.0903006,-0.284582,0.154022,-0.0154845,0.141273,0.0160575,0.124688,-0.222091,0.679541,-0.282882,0.439769,-0.249428,0.3589,-0.190291,0.514455,0.629966,-0.724382,-0.961373,0.0344191,0.0675859,-0.423284,0.137088,-0.253545,-0.668917,0.111961,0.23062,0.150982,-0.204718,0.408177,-0.152719,0.233669,0.437114,-0.414203,0.263161,0.655341,-0.0351146,0.596268,0.0814199,0.311509,0.319254,0.278029,0.104574,0.584255,-0.490243,0.00404028,-0.0246891,0.383478,0.0689833,0.364862,-0.0112567,-0.162124,-0.49877,0.749263,0.473558,0.132765,0.67834,-0.14893,-0.0284995,-0.631337,0.19454,0.274169,0.294819,0.402691,0.476942,-0.0370364,0.0559501,-0.0527173,0.379089,-0.0848253,-0.0186568,-0.845846,0.0720163,0.149003,0.298636,-0.695827,0.273977,0.469126,-0.392283,0.0930034,0.788169,0.400649,0.619644,0.286498,-0.0268266,-0.179695,-0.0971381,-0.0260825,0.306707,-0.306805,0.402666,0.00669001,-0.0851863,0.195643,-0.336602,-0.692963,-0.0104819,-0.236027,-1.11741,0.446137,0.317159,-0.346132,0.459102,0.210808,-0.357673,0.219213,0.526781,0.197282,-0.214518,0.353554,-0.555743,0.120835,0.43108,0.564316,0.171917,0.213314,0.364704,0.711557,0.216801,-0.569761,0.564213,-0.00153837,0.266238,0.101796,-0.538887,0.259429,0.75613,0.00818569,-0.138299,-0.6106,-0.307729,-0.81976,-0.466984,0.296463,1.01366,-0.427794,-0.14283,-0.807955,-0.378079,0.179785,-0.208778,0.0598397,-0.383523,0.0304634,-0.937064,-0.272693,-0.444104,-0.0972578,-0.268978,0.153309,-0.417937,-0.252314,-0.0432512,-0.126929,-0.0135352,-0.285979,-0.423215,0.432269,-0.00297938,-0.306826,0.230069,-0.256514,0.911897,-0.44417,0.368063,0.133696,-0.342727,0.19006,0.512585,0.252129,0.453831,-0.937892,0.251226,0.829994,-0.53997,-0.0962932,-0.224348,0.279692,-0.308171,-0.238848,0.200172,-0.0322196,-0.137069,0.281889,-0.044336,0.0430596,0.312462,-0.562254,-0.782127,-0.460216,0.485306,-0.731358,-0.120468,0.28437,0.597993,-0.29529,0.0359233,0.188844,-0.602736,0.254131,-0.190324,0.248774,0.430357,-0.174768,-0.77083,-0.0844331,-0.438757,0.467506,-0.304519,-0.0381433,0.240567,0.254462,0.345962,-0.58596,0.512381,0.0997478,0.348387,-0.137846,0.372195,0.837938,0.0372267,-0.100387,-0.527268,-0.0125809,0.896893,-0.1347,-0.0270313,-0.592432,0.381,-0.561084,0.10082,0.246727,0.140677,0.463944,0.792417,0.458467,0.907581,-0.868349,-0.128209,0.402721,-0.0950282,-0.199231,0.829741,-0.329565,0.21299,0.176567,-0.0368438,-0.647907,-0.64229,-0.0461832,-0.267411,-0.0515596,0.640283,0.126483,-0.157944,-0.49745,0.165248,0.240609,0.406507,0.490519,-2.14384 +3392.96,0.769731,0.0848144,4,1.50297,0.795247,-1.39671,0.48416,0.200375,-0.191132,-0.580005,0.463468,-0.125702,0.289584,0.12214,-0.118641,-0.252412,0.786632,-0.188663,0.84616,0.26917,-0.203166,0.0779187,-0.135343,-0.538188,-0.702674,-0.726086,0.241205,-0.532761,-0.261265,-0.187859,0.0381492,-0.462166,-0.140288,0.615813,-0.180174,-0.161085,-0.0508083,-0.547266,0.0245312,-0.49783,0.892698,0.276291,-0.167282,0.48759,0.0484983,0.49052,-0.956338,-0.384685,0.753716,-0.455983,0.458084,0.177668,0.0111365,-0.129282,0.472365,0.427297,-1.04571,0.757466,0.185216,-0.0415031,-0.628267,0.369807,0.2883,-0.0857509,0.979062,-0.48693,-0.638621,0.323806,-0.186438,-0.365471,-0.0730271,0.144927,-0.456862,-0.871884,0.408979,0.497166,0.25138,0.345449,0.482834,0.867929,-0.434628,-0.467299,0.432287,0.40072,-0.460164,0.133099,-1.07016,-0.243376,-0.227674,-0.10804,0.22926,0.271894,-0.102099,-0.0369815,0.715308,0.425716,0.172085,0.083484,-0.412238,-0.0182171,0.115773,-0.404467,0.902795,0.494974,-0.130096,0.195086,0.0964913,0.652105,-0.348102,0.0768532,-0.123257,0.373959,1.12656,-0.242155,-0.270595,-0.141779,0.330396,0.410781,-0.248821,-0.0210509,-0.168419,-0.574669,-0.140693,-0.564257,0.418155,-0.764503,0.0047445,-0.261828,-0.235034,-0.0289899,-0.162623,0.304905,-0.728703,-0.247921,-0.392244,-0.164882,0.419378,-0.357128,0.120051,-0.29974,0.143144,0.972253,-0.431991,-0.714919,0.302556,0.132688,-0.807713,-0.0959715,-0.0294103,-0.0864412,0.175958,-0.235067,-0.170902,-0.299001,0.483368,0.116615,0.00903977,0.190333,0.512809,0.192731,0.0640604,0.572914,0.336195,0.548168,0.299512,1.14869,0.0098298,-0.434769,0.442671,0.315865,-0.0761087,-0.0229812,0.234177,0.126315,-0.0892267,-0.165157,0.522765,-0.0353829,-0.146333,-0.114037,-0.083565,0.393921,0.648662,0.557396,0.199405,0.810431,0.200367,0.0111133,0.0131263,-0.0372373,0.0672829,-0.0896121,-0.183179,-0.29075,0.302469,0.203319,-1.06506,-0.155808,-0.00352356,0.124609,0.132758,-0.684576,-0.238034,0.466982,-0.707816,0.478736,-0.083623,0.0636452,-0.0279089,-0.125619,1.11949,0.390418,-0.348415,0.301898,0.208471,0.282776,-0.575113,-0.728892,0.408691,0.742165,0.468194,0.599677,-0.132846,0.262665,-0.188648,-0.451196,0.19341,-0.171104,1.02563,-0.582443,0.0974184,0.115024,-0.0910327,0.420215,-0.259487,-0.894802,-0.472525,-0.427518,0.227806,-0.423354,-0.0737801,0.916522,-0.692016,0.507202,-0.685548,0.431947,0.305202,0.738978,0.529462,0.660517,-0.0527428,0.067381,-0.491561,-0.171167,-0.464543,-0.14692,-0.601774,-0.441371,0.396777,-0.284933,-0.329333,0.0738551,0.033862,0.662114,0.330654,0.631933,0.23938,0.218983,0.34534,0.318724,-0.122518,-0.159243,0.560414,-0.0687851,-0.429369,0.26303,0.0881977,-0.435953,0.322803,0.875905,0.729818,-0.162523,0.055158,-0.72719,-1.0929,-0.435156,0.429894,0.238553,0.481438,-0.0472104,0.243019,-0.19833,0.242276,-0.0846937,-0.0252949,0.374922,0.493489,-0.0215168,-0.705305,-0.513548,0.0970386,0.33266,-0.848372,0.543474,0.170988,0.205726,0.413507,0.45357,-0.245712 +3395.07,0.733678,0.0848144,4,1.50962,0.757539,-1.44477,0.559199,0.01922,-0.178178,-0.582076,0.40931,-0.140624,0.351545,-0.0873881,0.0439156,-0.210127,0.806565,-0.290698,0.931798,0.34767,-0.205405,0.0813274,-0.0826461,-0.321594,-0.703418,-0.636221,0.295163,-0.555615,-0.383563,-0.225516,-0.0096276,-0.336497,-0.0683094,0.603912,-0.259905,-0.22133,-0.0141225,-0.640896,0.079512,-0.383237,0.956753,0.253429,0.0205064,0.523011,-0.145931,0.384245,-1.02315,-0.297848,0.645996,-0.295729,0.491548,0.264637,0.00681918,-0.142783,0.488791,0.38804,-1.06276,0.627563,0.0972266,-0.0582086,-0.631099,0.465539,0.160294,-0.231151,0.877963,-0.487622,-0.834522,0.266813,-0.194136,-0.413881,-0.0709223,0.310598,-0.439811,-0.998302,0.281307,0.525828,0.247889,0.370833,0.373455,0.830931,-0.522519,-0.483626,0.482596,0.453596,-0.426821,0.102322,-1.00576,-0.266189,-0.157745,-0.316568,0.139913,0.250491,-0.0292531,-0.118701,0.678195,0.448579,0.257586,0.0723748,-0.484721,-0.14079,0.0524066,-0.271535,0.878279,0.671507,-0.13761,0.180103,0.387668,0.596184,-0.334326,-0.0680345,-0.125183,0.430088,1.17102,-0.038716,-0.406675,-0.0989197,0.196934,0.374296,-0.171523,-0.0670822,-0.185845,-0.690381,-0.288309,-0.565652,0.383935,-0.743254,-0.06488,-0.408083,-0.211866,-0.143999,0.0445225,0.292199,-0.486262,-0.264813,-0.392119,0.0376024,0.479734,-0.249082,0.0619526,-0.33164,0.166955,0.906412,-0.298935,-0.782485,0.312211,0.163121,-0.773046,-0.313721,-0.12544,-0.0798237,0.237364,-0.175777,-0.170537,-0.376249,0.548129,0.104808,0.138887,0.339033,0.488742,0.162407,0.0196465,0.684226,0.4584,0.556515,0.111974,1.07958,0.0496113,-0.503416,0.51773,0.345849,-0.0896191,0.0740124,0.217843,0.0772333,-0.229211,-0.19773,0.503021,-0.161171,-0.342503,-0.149746,-0.0774714,0.473771,0.762453,0.240847,0.247824,0.659845,0.270049,0.0588412,0.0110607,-0.126513,0.00485899,-0.16476,-0.0629676,-0.380886,0.240538,0.0840921,-1.01542,-0.0323619,0.0134573,0.128458,0.0355168,-0.834796,-0.194925,0.433514,-0.499738,0.514668,-0.113323,0.000313909,0.097957,-0.0702274,1.23339,0.195971,-0.200233,0.311413,0.0629811,0.242511,-0.668667,-0.752419,0.342171,0.761618,0.539434,0.670047,-0.341831,0.360669,-0.131814,-0.359092,0.143151,-0.200809,0.981598,-0.63765,0.0175224,0.143098,-0.196694,0.255127,-0.230162,-0.674354,-0.388299,-0.478864,0.0191336,-0.425042,0.152363,0.847275,-0.70201,0.420308,-0.590812,0.291045,0.174562,0.716971,0.597324,0.556707,0.0536084,0.0175241,-0.659168,-0.189465,-0.27531,-0.159964,-0.53459,-0.40471,0.268216,-0.401381,-0.251117,0.159982,0.0884185,0.515371,0.375769,0.453395,0.163754,0.169882,0.0814286,0.231525,0.191069,-0.269799,0.593562,-0.110345,-0.271627,0.292136,-0.0477901,-0.41759,0.239778,0.795942,0.7695,-0.210826,-0.0169311,-0.664466,-0.99218,-0.429422,0.445699,0.233606,0.310089,-0.0104905,0.274255,-0.148712,0.313737,-0.149645,-0.176363,0.361427,0.454641,0.0702936,-1.04149,-0.474923,0.0433038,0.323374,-0.874078,0.545387,0.177714,0.208409,0.421562,0.456519,0.37985 +3378.75,0.952558,0.0848144,4,1.5507,0.692971,-1.09269,0.497066,-0.0809045,-0.0997111,-0.324217,-0.35248,-0.260013,-0.332437,-0.0374178,0.332308,-0.0444448,0.88438,0.0750297,0.411538,0.670548,-0.101192,0.324903,0.264924,-0.450807,-0.638586,-0.430757,0.570845,0.15683,-0.0181196,0.000309759,0.474266,-0.259667,-0.107477,0.835572,-0.389094,-0.0956156,0.0512991,-0.210865,-0.34645,-0.547598,0.127791,0.545459,-0.187447,0.413432,0.134055,0.320324,-0.573088,-0.677313,0.946968,-0.291576,-0.181825,0.301613,0.273703,0.0293937,0.260088,0.300906,-0.158178,0.486386,0.0765236,-0.104427,-0.675473,0.441235,0.229263,0.496483,1.21414,-0.858376,-1.56539,-0.384374,0.204431,0.254646,-0.115187,0.25591,-0.20048,0.0569627,0.0313147,0.471873,-0.315069,0.775165,0.176762,0.3808,-0.441632,0.157702,0.190047,0.176179,-0.179355,0.533406,-0.129217,-0.013684,0.412007,-0.595108,0.0456081,-0.127122,-0.23015,-0.355798,-0.43731,0.193372,0.354851,0.257245,-0.808809,0.164212,-0.408645,-0.109544,0.829905,0.818134,-0.386565,-0.191946,0.285749,-0.828919,-0.109839,0.417541,-0.320916,0.0380033,0.893752,-0.0563408,-0.678541,0.769044,0.321535,0.0163004,0.160473,0.0746837,-0.254856,0.572325,0.447747,-1.29314,-0.204436,0.821889,-0.0131609,-0.571192,0.556879,0.0216403,-0.177529,0.123485,-0.464039,-0.458369,-0.286678,0.273723,0.242651,-0.497638,-0.418685,-0.574185,-0.593887,0.885315,-0.445923,-0.342457,0.0297291,0.0786116,-0.124469,0.668454,-0.0206268,0.318962,1.03717,0.392492,-0.327446,-0.419771,0.32747,0.0949728,0.272827,0.200803,0.15337,-0.102461,-0.466327,0.526138,0.50449,0.360714,0.110626,1.06482,-1.08613,-0.156339,0.547209,-0.116148,-0.357366,0.0455211,0.340815,0.219998,-0.16073,-0.167546,-0.551922,0.0158584,-0.116908,-0.496973,-0.479411,0.159791,0.429954,0.257695,-0.420181,0.625098,-0.177517,-0.242738,0.209297,0.000403761,0.128498,0.0307966,0.0631209,0.318083,0.347629,-0.254315,-0.519574,0.038269,0.105299,0.539398,-0.240076,-0.753667,-0.417439,-0.219984,0.239494,0.143369,-0.303876,-0.0917948,-0.396507,-0.718418,1.09646,-0.661957,0.249902,0.311876,-0.199929,0.103389,0.491434,-0.629977,-0.0948036,-0.930817,0.704809,1.19353,0.0452569,-0.447873,-0.6289,-0.207569,-0.101934,-0.200326,0.205229,-0.680152,-0.60795,0.218867,-0.135511,-0.620821,0.077962,-0.314917,-0.16965,-0.585677,0.477896,-0.510342,0.0657739,0.151081,-1.23929,-0.181783,-0.156493,0.171997,-0.0270125,1.10569,0.0236065,0.915968,-0.214245,-0.0977626,-0.541291,-0.250456,-0.431691,0.604658,0.321807,-0.26903,0.175609,0.462709,-0.264178,0.514939,0.437819,0.299376,0.110779,0.682818,0.0113906,0.0970752,-0.00528288,0.162333,-0.264051,-0.0732271,-0.335747,-0.3012,0.0908907,-0.0101585,0.0486793,0.0451639,-0.136208,0.346044,0.0434784,0.0068818,-0.187788,0.674188,0.485394,-0.165011,0.407951,0.10474,-0.321532,-0.208749,0.274135,-0.397315,-0.598869,-0.0171657,0.270076,-0.00929017,0.592516,-0.0611304,0.0257196,-1.0513,-0.352956,-0.0516376,0.0490136,-0.139037,0.200493,0.318586,0.447764,0.564434,0.721786 +3382.85,0.979003,0.0848144,5,1.54762,0.656494,-1.34963,0.548275,0.11681,-0.109554,-0.0859832,-0.221281,-0.121346,0.192113,-0.156705,0.18354,-0.555646,0.75829,-0.0269175,0.75704,0.554826,-0.239019,0.127388,0.140416,-0.33462,-0.984802,-0.598228,0.460944,-0.066265,-0.0610572,-0.0603269,0.38754,-0.172391,-0.107986,0.777266,0.0399701,-0.278545,0.155437,-0.3941,-0.380478,-0.358314,0.159764,0.470077,-0.24422,0.495919,-0.156664,-0.0662864,-0.836274,-0.562329,0.588848,-0.396771,-0.162638,0.609435,0.427692,0.115142,0.352553,0.501956,-0.174893,0.672713,-0.204744,0.0988232,-0.720423,0.542655,0.258654,0.307651,1.0335,-0.473701,-1.26234,0.0927166,0.261194,0.165966,0.525196,0.347248,-0.0678098,-0.377424,-0.0654324,0.650144,-0.380121,0.905322,0.14234,0.435028,-0.845929,-0.209942,-0.0300764,0.302445,-0.399877,0.173148,-0.13774,-0.0550991,0.0101523,-0.188868,0.343546,0.17187,-0.0618265,-0.618148,-0.236126,-0.0583426,-0.272345,0.367364,0.00299357,0.589921,-0.110966,0.232196,0.971745,0.420686,-0.270481,-0.574689,0.190271,-0.979527,-0.351671,0.120874,-0.632888,-0.0750048,0.68219,-0.437387,-1.02464,1.19614,0.332599,-0.452558,-0.131915,-0.193785,-0.0839235,0.24402,0.34231,-0.957673,0.0717405,0.90362,-0.298894,-0.451862,0.860375,-0.270829,0.157792,0.103779,-0.305051,0.00038785,-0.200515,-0.027416,0.226369,-0.501139,-0.326333,-0.257929,-0.622506,0.71396,-0.150514,-0.443327,0.388563,-0.274703,-0.23954,0.324538,-0.127591,0.36089,0.459767,-0.110159,-0.809818,-0.552376,0.498926,0.211278,0.0329715,0.172214,0.409348,-0.355931,0.00811535,0.176114,0.082389,0.623413,0.313317,1.23251,-0.549014,0.478067,0.825292,-0.332063,-0.250634,0.210294,0.470324,-0.170633,0.0878953,-0.145206,-0.672223,0.144881,0.330663,-0.45135,-0.206167,-0.115972,0.581393,-0.0220185,-0.0439304,0.545931,-0.139691,-0.105497,0.0765416,-0.0134091,0.0651461,-0.194384,-0.332792,-0.0620828,0.0693189,-0.310144,-0.477937,-0.0715259,-0.329027,0.462773,-0.40082,-0.375695,-0.0837603,-0.41297,0.253986,-0.00510315,-0.0241811,-0.424695,-0.278292,-0.320054,1.15357,-0.97362,0.796793,0.00197851,-0.536393,0.233971,0.366296,-0.732592,-0.24624,-0.537634,0.595166,1.15546,0.329144,-0.333526,-0.8545,0.329325,-0.175611,0.175555,0.470378,-0.538399,-0.481128,0.582715,-0.29693,-0.788579,0.0727487,-0.952357,-0.327176,-0.51109,0.32721,-0.228738,-0.202153,0.137248,-1.00193,-0.246055,0.146098,0.135712,-0.105482,0.859846,0.144596,0.988881,0.166706,-0.342488,-0.541388,-0.0795695,-0.198689,0.48348,0.323489,-0.067497,0.324612,0.574885,-0.00602389,0.168254,0.128319,0.238677,-0.0988132,0.530132,-0.10349,0.64149,0.0121138,0.385724,-0.257259,-0.0764984,0.0688525,-0.534068,0.153569,-0.390062,0.279175,0.166646,-0.194044,0.655667,0.0301687,-0.542352,-0.211657,0.227322,-0.356451,-0.358622,0.391424,0.172393,0.253917,0.0606446,0.157791,-0.0592453,-0.614441,0.113526,-0.589745,-0.0651282,0.767761,-0.0399641,-0.410192,-0.745607,-0.320641,-0.131907,0.276863,-0.688648,0.22632,0.205704,0.475731,0.453546,0.215722 +3393.04,0.987284,0.0848144,4,1.5475,0.673094,-1.02115,0.337588,0.375751,-0.298632,0.129962,-0.78004,0.186995,0.136529,-0.0514374,0.113135,-0.183842,0.644934,-0.302576,0.332562,0.482367,-0.27746,0.200259,0.166092,-0.127181,-0.776481,-0.90657,0.346141,-0.470183,-0.137534,-0.222745,-0.182696,-0.331689,0.0595434,0.820384,0.280647,0.00771147,0.217415,0.124386,-0.262899,-0.226661,0.0501917,0.857162,0.146519,0.470876,0.145774,0.0218079,-0.38874,-0.168427,0.393477,-0.512882,-0.352526,0.650257,-0.0285249,0.276625,0.288208,0.461479,-0.915817,1.18477,0.493329,-0.288042,-0.752042,0.296317,-0.227428,0.00407742,0.965176,-0.524334,-0.709815,0.599181,-0.331049,0.068496,-0.368747,0.108244,0.0387905,-0.481802,0.477318,0.445189,0.00439413,0.34999,0.308565,0.647691,-0.667014,-0.306624,0.741232,0.394624,-0.455649,0.398732,-0.0401325,-0.121504,0.176871,-0.396494,-0.0150752,-0.16053,-0.129702,-0.70849,0.247907,-0.322855,0.0303708,0.668083,-0.797232,0.0734195,0.0541376,0.479879,0.897999,0.159388,0.131017,-0.129935,-0.288892,-0.543049,-0.498254,0.723046,-0.352405,0.195263,0.350951,-0.592462,-0.4273,0.0279697,0.31686,-0.55527,-0.421035,0.124893,0.136991,-0.065756,0.0637545,-1.01436,-0.117086,0.54313,-0.785066,-0.0303844,0.328801,-0.025138,-0.0428869,0.696691,-0.587557,0.303996,-0.273205,0.429982,0.7006,-0.694152,0.404811,-0.113404,-0.310943,0.461243,0.220901,-0.437662,-0.118534,0.0653999,-0.414195,0.413589,0.509532,-0.204786,0.401182,0.106431,-0.520093,-0.307621,0.213607,0.0743801,-0.0354303,0.467519,0.265093,-0.265794,0.138765,0.374894,0.164292,-0.260533,-0.100667,1.17112,-0.486275,-0.181566,0.9773,-0.383603,-0.237332,-0.0594054,0.278361,-0.149445,0.0312456,-0.105519,-0.343582,0.140329,0.19396,-0.183112,-0.2068,0.906877,0.618306,-0.0240873,0.181374,0.0793039,-0.192692,0.732764,-0.193187,-0.275821,-0.180529,0.222895,-0.495725,-0.145944,-0.0632569,0.0504402,-0.66696,0.297953,0.203647,-0.321998,-0.0356622,0.201989,0.386092,0.177454,-0.315823,0.37222,0.153349,-0.589815,0.167688,-0.641794,0.884986,-0.226511,0.0670841,0.488846,-0.323578,-0.144417,0.284585,0.0172936,-0.599742,-0.274996,0.416412,0.679004,-0.287526,0.106356,-0.940253,-0.399603,0.556503,-0.0540595,0.133887,-0.777865,-0.369731,0.286234,-0.235782,-0.388279,-0.0488459,0.0228137,-0.554083,-0.477584,0.543295,0.0259261,0.0364069,0.308076,-0.543252,-0.793849,0.164315,0.241477,-0.43848,0.540511,-0.126305,0.546659,-0.180692,0.349055,-0.658045,0.308249,-0.376413,0.0171817,0.079297,-0.434839,0.513595,-0.248406,0.285804,0.184368,0.353717,0.494492,1.13658,0.354577,0.0331938,0.258336,0.0861248,0.255636,-0.492902,-1.30331,0.298309,0.0687119,0.383998,0.174035,0.604082,-0.659896,0.471146,0.749678,0.0495435,0.0323587,0.381352,0.256046,-0.672077,0.0171704,0.481598,-0.0571215,0.396528,-0.125604,-0.0351543,0.267746,0.0813742,-0.149384,0.153731,0.187056,0.547489,-0.306021,-0.715805,-0.209092,0.397023,0.667436,-0.899772,-0.140886,0.136803,0.19996,0.36987,0.447168,-0.598871 +3399.65,0.585841,0.0848144,5,1.4919,0.724009,-1.08169,0.430842,0.412689,-0.16428,0.264865,-0.104666,0.673958,0.328458,-0.194095,0.0385514,-0.0891059,0.768362,-0.214398,0.407399,0.81545,-0.0738016,0.384315,0.260135,0.0425699,-0.729704,-0.682039,0.455522,-0.452715,-0.0561989,-0.346748,0.14965,-0.210522,-0.115761,0.808875,0.258408,0.145053,0.561517,0.0204042,-0.326695,-0.331771,0.477048,0.507649,-0.409721,0.66488,0.379897,0.301516,-0.805656,-0.0909268,0.213768,-1.16527,-0.616234,0.807776,0.11132,0.103058,0.482869,0.29658,-0.55088,0.750781,-0.0492524,-0.0437653,-0.304542,0.551203,0.238328,-0.0907874,0.716473,-0.704778,-1.10899,0.0349438,-0.185059,-0.0663033,-0.276501,0.348848,0.0687014,-0.711773,0.815597,0.26568,-0.502062,0.808242,-0.0917504,0.449723,-0.506538,-0.65453,0.00182997,0.641296,-0.545677,0.360659,-0.0735936,-0.336829,-0.303134,-0.117672,-0.505846,0.420981,-0.322667,-0.257821,0.607217,0.00401442,0.0391683,0.399807,-0.907484,0.35287,0.211848,-0.0265738,0.616201,0.374142,0.119119,0.076782,-0.134109,-1.08711,-0.519303,0.054239,-0.754551,0.342503,0.562728,-0.620724,-0.391014,-0.0443167,0.419343,-0.6902,0.305816,0.122494,0.204252,0.010069,-0.168901,-0.72106,0.134649,0.706116,-0.541109,-0.092898,0.572419,-0.00610567,0.1133,0.338966,-0.0294547,0.263572,0.0158285,0.239005,0.85077,-0.622239,-0.0357786,-0.567951,-0.153448,0.466046,-0.373415,-0.474218,-0.313257,0.277867,-0.402929,0.315964,0.398986,-0.270542,0.490773,-0.127709,-0.905853,0.311801,0.288731,0.000865986,0.0392289,0.220551,0.427797,0.530238,0.190209,0.443599,-0.0423292,-0.12348,0.257751,0.83083,-0.0496419,0.262233,0.762967,-0.168483,-0.517164,-0.218538,0.420788,-0.402477,-0.00274362,-0.0755099,-0.516253,-0.18955,0.27296,0.0216196,-0.330529,0.427395,0.745879,-0.00515089,-0.120557,0.37857,-0.340784,0.764949,-0.206023,-0.129464,-0.0314677,0.355133,-0.641317,0.124747,-0.543215,-0.178541,-1.07921,0.563817,-0.10106,0.080625,-0.353617,-0.155787,0.223187,0.240206,0.0715026,0.33181,0.0110765,-0.707825,0.178661,-0.402384,1.15328,-0.148712,0.62644,0.0210302,-0.773232,0.00129087,0.371715,-0.00940718,-0.128351,-1.11519,0.619787,0.72549,-0.607797,0.524603,-0.927989,-0.106975,0.446679,-0.228347,0.288498,0.185198,0.0730564,-0.0714449,0.172746,-0.275611,-0.0254649,-0.103547,-0.276518,-0.362921,0.685749,-0.119963,-0.263374,0.75631,-0.747256,-0.697007,-0.00418243,-0.151543,0.0317272,0.326774,-0.302818,0.726943,0.181418,0.529528,-0.712954,0.607405,-0.659982,0.325634,-0.0369762,-0.334716,0.0331941,-0.24762,0.524523,-0.0800015,0.412833,0.444873,0.348951,0.6,0.10899,-0.153829,0.212633,0.355692,-0.491198,-0.866014,0.335451,0.0627535,0.50321,-0.213398,0.717943,-0.5402,-0.204919,0.472106,-0.230836,0.590341,0.30113,0.338133,-0.0667874,-0.629593,0.389255,-0.238824,0.664341,-0.00105479,-0.212541,0.165269,-0.091124,0.147012,0.167283,0.158835,0.260538,-0.113306,-0.227944,-0.029155,0.412913,0.501152,-0.54474,-0.310262,0.251756,0.214482,0.501753,0.463122,-0.957346 +3401.32,0.675987,0.0848144,4,1.39247,0.826507,-1.0657,0.256809,0.280639,-0.00262759,0.0668092,-0.295076,-0.139676,-0.0731111,-0.249479,-0.336326,-0.289093,0.74531,0.0392062,0.975895,0.62451,0.0247471,0.357799,0.141831,0.0490656,-0.83049,-0.251662,0.621121,0.0599241,0.314311,0.540782,0.409237,-0.281577,-0.100552,0.620625,-0.796535,-0.0980049,0.301428,-0.178246,0.115711,0.00570889,0.344969,0.532783,0.176374,0.946712,0.277698,-0.0717369,-0.0850331,0.149752,0.332483,0.140713,0.316102,0.636911,0.241352,0.385354,0.0797229,0.509098,-0.233726,1.19426,0.311396,-0.285876,-0.413073,0.866404,-0.204877,0.578155,0.923501,-0.126538,-0.428434,0.505328,-0.222275,0.65107,-0.0756388,-0.44263,-0.552153,0.626758,0.166266,0.584686,0.121514,0.731272,0.28105,0.494623,-0.600175,-0.138144,-0.0109851,0.665183,-0.0827866,-0.126392,-0.396642,-0.578953,-0.0715616,-0.018527,0.375619,0.155651,0.0468721,0.0503439,-0.543384,0.122203,0.0154866,0.329028,-0.227406,-0.0604571,-0.823967,0.0770491,0.376847,-0.286685,0.378643,0.00226642,-0.471723,0.723473,-0.0448979,0.985004,0.0213318,0.0572982,0.440733,0.757281,-0.748017,0.348819,0.215853,-0.0839049,0.35263,-0.616528,0.20641,-0.217356,-0.226306,-0.812485,-0.0253279,0.112479,0.153639,-0.0231081,0.130159,0.418301,0.0771467,0.483242,-0.579915,-0.181437,-0.370284,0.120656,0.721003,-0.498287,-0.239517,-0.554984,-0.356117,0.195716,-0.841911,-0.983621,-0.0078453,0.0195102,-0.705353,-0.151125,-0.194459,0.558821,0.542874,0.251829,0.0328985,-0.409552,0.0684712,0.467067,0.253374,0.396073,0.423271,-0.196764,-0.0387477,0.278919,0.726,0.590045,0.0867029,0.995762,-0.608889,0.134713,0.67335,0.0044604,0.285884,0.12898,-0.399809,0.589475,-0.158641,-0.16766,0.0104297,0.61999,-0.438327,-0.24067,-0.0758342,0.137276,1.04659,0.158176,-0.623722,-0.547268,0.224618,-0.212266,-0.0230647,-0.242937,-0.261036,0.0688256,0.143792,-0.372275,0.414314,0.191867,-0.527202,0.160168,0.100999,-0.26229,-0.174959,-0.447394,-0.0292132,-0.455065,-0.169613,-0.168067,-0.0590826,0.785731,-0.668825,-0.278892,1.13295,0.208561,-0.253851,0.0224745,0.338106,0.366586,-0.178822,-0.321579,0.697467,-0.0211001,0.387251,0.613451,0.241872,-0.197159,-0.101319,0.28253,0.276542,-0.356375,0.527611,0.0629909,-0.726493,0.0770798,-0.0926239,-0.159064,-0.112122,-0.257202,-0.185033,-0.485858,0.350648,-0.31506,0.320947,0.69816,-0.292086,0.24136,0.182341,0.270711,0.138198,-0.0678528,0.57551,0.688273,0.0482509,-0.743371,-0.272494,-0.370966,-0.331829,-0.182232,-0.156114,-0.555011,0.1806,-0.199941,0.148772,-0.0332732,-0.260808,0.0846372,0.210866,-0.598993,0.322247,0.334192,0.343922,0.114534,-0.090633,0.333944,-0.15452,-0.33804,-0.278804,-0.10285,-0.193855,0.532146,0.263934,0.258416,-0.0384326,0.462801,-0.00522335,0.00222708,-0.677499,0.0363822,-0.304382,0.422843,-0.161218,-0.208057,-0.522811,0.0649582,0.678901,-0.102497,0.0308815,0.866465,-0.246124,-0.16725,-0.519483,-0.00153191,-0.37738,-0.698955,0.255517,-0.120399,0.225872,0.209628,0.47526,0.457852,-0.68337 +3443.02,0.955136,0.0848144,4,1.50927,0.740208,-0.955983,0.271075,0.366877,-0.219309,0.621814,0.0480905,0.0109475,0.434186,0.133821,-0.27436,-0.00741611,0.487996,0.201728,0.241303,0.262714,0.0266525,0.192925,0.362021,0.197811,-0.543295,-0.596628,0.333242,-0.103686,-0.293862,-0.0661549,-0.498185,-0.0755456,0.167256,0.91187,-0.429936,-0.000290595,0.699458,0.0441207,-0.0749722,-0.688754,0.828678,0.578843,-0.054223,0.942645,0.999073,0.220897,-0.570223,-0.349056,0.0212594,-0.528332,-0.297679,0.673509,0.618343,0.602013,0.55649,0.388216,-0.71838,1.09964,0.161083,-0.0104488,-0.55078,0.946601,-0.0687372,0.0876285,1.13028,-0.809463,-0.52739,0.203556,0.0269616,0.291594,-0.225367,0.289883,-0.388344,0.0422218,0.114231,0.398094,-0.323074,0.361765,0.27856,0.126297,0.0842049,-0.376351,-0.343908,-0.119732,-0.687784,0.451153,0.383512,-0.21602,-0.248825,-0.00387594,-0.346874,0.184712,-0.351919,-0.210857,0.536801,-0.120006,-0.231329,0.0215258,0.00919533,-0.19755,0.000808939,-0.009727,0.326966,0.201176,0.0604648,-0.310726,0.244893,0.103383,-0.228941,0.26924,-0.536011,0.0145791,0.0797595,-0.20689,0.169833,0.220255,0.330468,0.0762975,0.0871691,-0.143006,-0.303251,0.363792,0.0584074,-0.2301,0.0259349,-0.220777,-0.420501,-0.906512,-0.298765,0.275773,0.426055,0.295826,-0.0939189,0.0740853,0.305216,-0.362271,0.480155,-0.0406196,-0.0849048,-0.06373,-0.476541,0.190853,0.12403,-0.225831,-0.0217481,-0.123696,-0.0175719,-0.00234627,-0.0396293,-0.692797,0.451268,-0.199583,0.589467,-0.329912,-0.0259826,0.227608,-0.230844,0.0933432,0.320226,-0.0898241,-0.250636,0.0397813,-0.563118,0.356867,0.10859,0.745153,0.0138461,-0.0230788,-0.279953,-0.0675763,-0.46972,-0.461531,0.575844,-0.435337,-0.549575,-0.114008,-0.18228,-0.303119,-0.135959,-0.348008,-0.185872,-0.205046,0.503828,-0.0215115,-0.2942,-0.311385,-0.327711,-0.159858,-0.0565529,-0.489083,0.0575016,0.305842,-0.0373668,0.0610976,-0.64592,0.0117661,-0.589413,-0.227281,-0.0106498,-0.099452,-0.600796,-0.313674,0.42647,0.146107,-0.478712,-0.0654344,-0.133262,-0.274659,0.0191398,-0.425939,0.877837,-0.131984,0.296573,-0.227453,-0.00898734,0.317999,0.244012,-0.566313,-0.0226521,-0.680746,0.0716949,-0.0502926,-0.446824,0.0908315,0.315427,-0.504854,0.0350727,0.158969,0.245596,-0.791085,0.0468029,0.0377076,0.0645339,0.700066,0.00453166,-0.190801,-0.71948,0.217811,0.0963343,0.107856,0.03644,0.415393,-0.105003,-0.163901,0.256373,-0.423877,-0.275417,0.868933,-0.233602,0.48598,0.240655,-0.0285574,-0.275244,-0.001217,-0.0898546,0.39977,0.217752,-0.39258,0.14602,-0.440254,0.401646,0.0294165,0.070717,-0.588621,0.31623,0.0600675,0.580875,-0.190243,-0.199545,0.0164962,-0.45112,-0.114357,-0.167857,0.0840357,-0.0191531,0.0114876,0.134055,0.0268377,0.0194029,0.14169,0.143354,0.286027,0.212675,-0.0808681,0.353161,-0.843977,0.344911,-0.164125,0.101757,0.20862,0.500594,0.0866401,-0.484273,-0.00152006,-0.0386542,0.0907833,0.935753,0.0536881,0.0273516,-0.464898,0.311329,0.168308,-0.35679,-0.33758,0.110491,0.246132,0.332402,0.496117,-0.71729 +3430.66,0.950142,0.0848144,5,1.58054,0.946048,-1.03401,0.456845,0.493215,-0.0522562,-0.643064,0.184728,0.296906,0.140531,0.21606,-0.349481,-0.0241181,0.388935,-0.300333,0.874934,0.188471,-0.0372761,-0.378386,0.00691417,-0.61872,-1.16246,-0.886646,0.13312,-0.355232,-0.260402,0.171416,0.695563,-0.704666,0.082903,0.993991,-0.371457,-0.173472,0.12124,-0.68904,0.0985134,0.104736,0.0615409,0.401543,-0.521742,0.932449,0.0068629,0.1507,-0.447097,-0.288182,-0.130088,-0.524518,0.708408,0.125187,-0.469085,0.146022,0.0800823,-0.207369,-0.0349611,0.309903,-0.269311,-0.108539,-0.709404,-0.0401682,-0.335973,0.567289,0.93703,-0.277848,-1.12125,0.0379215,0.143513,-0.379891,0.379606,-0.20447,-0.359465,0.0815329,0.225315,0.646367,0.134935,0.241542,0.284399,0.303837,0.0650146,-0.132651,0.43952,0.957501,0.204598,0.158998,-0.372206,0.0682547,-0.0839511,-0.10498,-0.0511928,-0.0558631,-0.233481,0.299988,-0.425666,0.357801,0.449388,0.0675808,-0.228584,0.470722,-0.366602,0.0848501,-0.0447573,-0.0669309,-0.202129,-0.55589,-0.441001,0.0916083,-0.024677,-0.0728317,-0.0452557,0.199495,0.875156,0.208294,-0.493025,-0.158214,0.460293,-0.0414355,-0.299035,-0.181483,0.651922,-0.0755207,-0.132689,-0.732639,-0.0653055,-0.142645,0.174501,0.840076,0.521602,0.193992,-0.351571,0.103075,-0.229163,-0.0409424,-0.42466,0.300865,0.0752433,-0.408819,-0.217418,0.229601,0.0801656,0.450092,-0.814744,-0.201614,0.117856,0.400344,-0.553562,-0.0926101,-0.0346549,0.450139,0.136449,-0.102133,-0.7891,0.147964,0.334192,0.223688,0.18884,0.223303,0.265044,0.257441,0.207537,-0.180911,0.535771,-0.123022,-0.443346,0.75008,0.0040288,0.019145,0.296151,-0.343501,0.229651,0.241943,-0.671829,0.652329,0.4889,-0.17868,0.106248,0.0167816,0.161664,0.123599,0.041213,0.385097,0.683432,0.0960837,0.00943958,0.554874,0.206494,0.0785362,-0.265376,0.160852,-0.601674,0.206422,-0.558849,-0.103132,0.573965,-0.200365,-0.437336,-0.0312304,0.472707,0.138843,0.202254,-0.340602,-0.400066,0.0290993,0.271652,0.401173,-0.115572,-0.0229997,-0.286497,-0.191106,0.664029,0.133698,0.021913,0.39945,-0.0662665,-0.0820725,-0.0911736,0.494927,0.403303,0.294098,-3.76941e-05,0.673216,0.0356782,-0.419326,-0.697059,0.553324,0.281314,-0.695299,0.385845,0.267873,-0.395634,0.120643,-0.125848,-1.00753,-0.131372,-0.0688992,0.137773,-0.551913,0.695894,-0.106383,0.134966,0.611487,-0.402407,-0.182184,-0.137733,0.41024,0.219427,-0.156524,0.391902,0.164924,0.209053,-0.226833,-0.233197,-0.0419733,-0.813404,0.138964,-0.632495,0.30204,0.255843,0.0215204,-0.200499,0.0772427,0.0299077,0.928519,0.249413,-0.0566302,-0.596261,0.319879,0.433123,-0.0402881,0.338145,0.143292,0.394298,-0.12555,-0.253192,-0.307472,0.122957,-0.0454588,-0.0163646,-0.205627,0.0320054,-0.00423744,-0.404969,0.200932,-0.516289,0.533843,-0.375339,0.136621,0.0799639,-0.290941,-0.126881,-0.0625063,0.244073,0.156676,0.160887,-0.214599,-0.543867,0.0327616,-0.562523,0.430973,-0.298174,-0.380769,0.0574882,0.310401,0.116363,0.191353,0.34112,0.437439,-1.6063 +3441.08,0.975796,0.0848144,4,1.6268,0.72754,-1.2006,0.453715,0.254591,-0.200934,-0.049425,-0.213381,0.151982,0.443079,0.219064,-0.486408,0.14566,0.68175,-0.191958,0.763797,0.102052,0.0391411,-0.19274,0.0767615,-0.16727,-1.08417,-0.172999,0.436334,-0.557224,-0.39296,-0.114797,0.26416,-0.191733,0.219608,0.905695,-0.676276,-0.0195967,-0.0589729,-0.426129,-0.297989,-0.251904,0.21933,-0.104544,-0.129914,1.0704,0.301174,0.203179,-0.472206,-0.155667,-0.0110471,-0.207017,-0.0406138,0.472584,0.152608,-0.322964,0.0730299,0.120388,-0.278372,0.554293,-0.540617,-0.0498385,-0.832747,0.105062,-0.570926,0.000606569,1.12981,-0.444902,-0.920542,-0.0346902,-0.054569,0.306722,0.0120477,-0.247519,-0.421637,0.268422,0.244636,0.276211,-0.0438423,0.564773,0.651552,0.214319,-0.0348957,-0.254265,0.381929,0.805888,-0.0146076,0.200333,0.0642477,-0.160187,-0.195885,-0.143287,-0.066512,-0.7158,-0.815196,-0.0228026,-0.298004,0.0354287,0.463009,0.126551,-0.142996,0.712571,-0.625997,0.321404,0.324372,0.34508,0.165721,-0.345637,-0.0896143,0.276611,-0.423253,-0.312741,-0.323751,0.240652,0.630131,-0.497474,-0.556763,-0.0737979,0.20245,0.0802271,0.0564271,-0.666172,0.314504,-0.217539,-0.226544,-1.03138,0.215801,0.585844,-0.277989,-0.0161217,0.206356,-0.290272,-0.215913,-0.24893,0.0173012,0.366989,-0.37088,0.134255,0.437333,-0.141104,-0.562153,0.373197,-0.135838,0.32833,-0.139625,-0.866285,-0.00303323,-0.146977,-0.2216,-0.471624,0.281567,0.613509,0.225064,-0.339597,-0.147526,-0.0470045,0.471033,0.374336,-0.263815,-0.159981,0.161992,-0.285363,-0.21611,0.134383,0.5662,-0.123704,-0.353191,0.422881,0.117875,0.25644,0.154997,-0.372329,-0.428878,-0.159079,-0.0654875,0.525808,0.057724,-0.0536313,0.234523,-0.376828,0.166774,0.0306196,-0.631384,-0.0218186,0.26375,0.1662,-0.0322276,0.413987,-0.310319,-0.739695,-0.63661,-0.240029,-0.221955,0.238082,-0.359441,-0.0266255,0.228738,-0.276255,-0.43549,0.177698,0.411496,-0.511907,0.136969,-0.304502,-0.183189,-0.498313,0.104973,0.270218,0.295786,-0.130451,0.416436,-0.398079,0.714221,0.118736,0.172184,0.119496,-0.307208,0.380712,0.188384,0.0378239,0.598325,0.345685,-0.116616,0.762411,0.153705,-0.523321,-0.350493,0.103247,-0.255132,-0.691442,0.544836,-0.0895896,0.138941,0.482524,-0.209439,0.088657,0.0785664,0.557719,-0.0824879,-0.568961,0.463011,-0.277137,-0.362688,0.335913,-0.283829,-0.0835533,-0.127684,0.155539,0.464336,-0.00966119,-0.157548,0.256373,0.258149,-0.0837077,-0.546464,-0.169105,-0.51526,0.660145,0.0581565,0.102879,-0.12035,-0.401249,0.540379,0.0128749,0.0522117,0.657197,0.678169,0.175562,-0.307312,0.00517432,0.246865,-0.192075,-0.0811855,-0.0919608,0.0698135,-0.445585,-0.0904771,-0.454671,0.0997076,0.137991,-0.320794,0.023118,-0.00417291,0.376509,-0.137859,0.0690638,-0.137921,-0.0184824,-0.0671832,-0.00960691,0.227297,-0.124629,0.369983,-0.0203678,-0.226348,0.106467,-0.0798164,0.119613,0.430805,-0.117571,-0.390755,-0.0867314,-0.0300376,-0.535846,0.160591,-0.372771,0.126857,0.18811,0.356169,0.433716,-0.253878 +3444.42,0.9244,0.0848144,4,1.58355,0.823094,-0.907936,0.41302,0.203237,-0.105953,-0.0104872,0.278428,-0.0763146,0.0728107,0.322741,-0.340704,-0.226486,0.865167,-0.0103088,0.68547,-0.0367781,0.171566,-0.148352,0.24887,-0.315697,-0.852578,-0.243562,0.278908,-0.0183195,-0.388214,0.0401033,0.416469,-0.405768,0.119963,1.1505,-0.0955123,-0.321929,-0.0189438,-0.307763,-0.285708,-0.093314,0.251245,0.239295,-0.195681,0.97898,0.0305023,0.0421074,-0.619581,-0.152781,0.0930403,-0.514188,-0.120608,0.443624,-0.479345,0.271497,0.502671,0.0784337,-0.210576,0.561466,-0.355947,-0.0520221,-0.591309,0.368634,-0.334664,0.131964,1.20778,-0.448384,-1.28757,0.135724,0.0986307,0.427867,0.129541,-0.107317,-0.440275,0.37533,0.350813,0.0489289,0.00703773,0.837351,0.639263,0.0450146,-0.200595,-0.279759,0.109826,0.460575,-0.383187,0.27746,-0.0879265,0.0674787,-0.255084,-0.413357,-0.00690266,-0.124609,-0.484504,0.26887,-0.282289,0.262315,0.0687977,0.402051,-0.400526,0.562092,-0.515589,-0.042341,0.189421,-0.054999,-0.0558895,-0.337053,-0.498221,-0.0992744,-1.1631,-0.0158251,-0.382454,0.518768,0.883603,-0.331487,-0.520319,-0.0869902,0.384729,-0.0925788,0.0753055,-0.382135,0.136383,0.334155,-0.806215,-0.764162,0.327271,0.530992,-0.156291,0.307337,-0.103002,-0.125651,-0.25687,0.133603,-0.282401,0.110469,-0.0860607,0.162557,0.470718,-0.131022,-0.404848,0.0204988,-0.214349,0.245504,0.0774277,-0.764405,-0.0470243,0.200815,-0.344068,-0.50849,-0.0411638,0.441563,0.144025,-0.567298,0.0597511,-0.0844029,0.0338668,0.141811,0.0921167,0.239946,0.296337,-0.087012,0.0615248,0.0298471,0.332618,-0.205881,-0.292972,0.836857,0.283571,0.116356,-0.473013,-0.00281557,-0.233021,-0.20668,-0.526923,0.00107725,0.0856532,-0.199539,-0.136657,-0.372293,-0.0323747,-0.148138,-0.392184,0.393779,0.52785,-0.0725845,-0.107904,0.485179,-0.132767,-0.715529,-0.407021,-0.0921893,-0.367209,0.152606,-0.197822,-0.191609,0.205768,-0.534604,-0.508092,0.0289566,0.306883,-0.296698,0.218243,-0.0297153,-0.099384,-0.250887,-0.185222,0.22202,0.122769,-0.208829,-0.194011,-0.506675,0.731116,0.19999,0.608414,-0.0173783,-0.3681,-0.152457,-0.186463,0.47068,0.0591788,-0.23674,-0.10342,1.24482,-0.607418,-0.307076,-0.105501,0.0871597,-0.134077,-0.176525,0.139908,0.251856,-0.0453231,0.251229,-0.243485,0.31847,-0.0576202,-0.0120942,-0.165424,-0.601576,0.479099,0.0254274,0.0947892,0.454736,-0.156487,-0.294757,-0.234818,0.603208,-0.267913,0.165832,-0.565119,0.0993702,0.165699,0.109577,-0.343084,-0.171519,-0.622071,0.842135,0.0662154,-0.00951422,0.241383,0.0463212,0.396357,0.0920225,0.367453,0.603471,0.0927172,0.282883,-0.0523424,0.345672,0.185718,-0.0514598,0.123365,-0.115783,0.204996,-0.585389,-0.174331,-0.32895,0.429457,-0.356333,-0.0469896,-0.0876007,-0.300876,-0.0621773,-0.608887,0.00342878,0.0207782,-0.21927,0.220417,0.149654,0.299137,-0.0480426,0.0704412,0.0883152,-0.08941,-0.13428,0.244023,0.326209,0.980237,0.0261961,-0.342594,-0.229894,0.0653672,-0.42681,0.0680523,0.142611,0.105837,0.200214,0.325326,0.447453,-0.434506 +3460.2,0.889376,0.0848144,5,1.56125,0.799786,-0.934268,0.301815,0.367096,-0.142618,0.0770891,0.18058,0.269658,0.151,0.136518,-0.367408,0.345333,0.615804,-0.0730055,0.552629,0.263051,0.0102729,-0.197519,0.263849,-0.00522289,-0.946539,-0.889419,0.370868,-0.352163,-0.162432,0.0383351,-0.181579,-0.0161332,0.314498,0.786186,-0.600299,-0.340525,0.266704,0.00375225,-0.349011,-0.336603,0.130428,0.368376,-0.0369695,1.11392,0.267836,0.638646,-0.402025,0.0273083,0.527772,-0.397415,0.19937,0.293338,0.173176,-0.00300225,0.266119,0.250589,-0.470553,0.839359,-0.460906,0.0113472,-0.486895,0.172752,-0.239433,0.150783,0.85919,-0.43201,-0.760969,-0.0293472,-0.002097,-0.135324,-0.204196,0.193184,-0.622455,-0.122869,0.100782,0.555431,0.16031,0.736945,0.362012,0.0254299,-0.162851,-0.0947289,0.0754124,0.751737,-0.190127,0.278935,-0.38261,0.146992,0.0295529,0.39155,-0.243499,0.370182,-0.271487,-0.0165132,0.314132,-0.147133,0.167071,0.703453,-0.399963,0.114507,-0.0508131,0.220357,-0.175271,0.653759,-0.237386,-0.368545,-0.529316,0.116634,-0.292556,0.254843,-0.107714,0.630311,0.581018,0.157458,-0.14271,-0.0555667,0.31437,0.421704,-0.00665038,-0.507643,0.076499,0.118001,-0.723929,-0.766717,0.298919,-0.135677,-0.151403,0.247068,0.0795681,0.508926,0.0151113,0.0985327,-0.276401,-0.561347,-0.278325,-0.0989204,0.907993,-0.19886,-0.307238,0.00603366,-0.0893393,0.50027,-0.616729,-0.335714,0.0502122,0.672322,0.0350424,-0.156638,0.311532,0.433318,0.197667,-0.167199,0.443069,0.157181,0.260761,-0.107257,0.209379,0.861863,0.20794,0.163114,-0.0494653,0.205952,0.41658,-0.761991,-0.230193,0.597464,0.366304,0.297751,0.0627969,0.158068,-0.0483455,-0.237041,-0.182725,0.229918,0.117573,0.0354597,0.00266105,0.0221597,-0.0921965,0.0618211,-0.239089,-0.313066,0.330597,0.104418,0.414635,0.397083,-0.621797,-0.210051,-0.376581,-0.385908,-0.466788,0.39775,-0.0703928,-0.270704,0.43315,-0.0176888,-0.567521,-0.0902379,0.649277,-0.129736,-0.267273,-0.11212,0.265619,-0.147016,-0.59956,0.418498,0.0444666,-0.446723,0.0102676,-0.346778,0.75721,-0.63313,0.380715,0.0399208,-0.0381886,0.397728,-0.567929,0.18763,0.102674,-0.0519656,0.0987209,0.185178,-0.0770231,-0.177384,-0.618368,-0.155863,-0.00331245,-0.855525,0.673208,-0.432478,-0.0115214,-0.0420952,-0.104773,0.356161,0.0791935,0.230049,0.114423,-0.537995,0.766092,0.18989,0.0879348,0.34902,-0.549867,-0.299,-0.0148074,0.320513,-0.479252,0.297104,0.0102691,-0.0947417,0.151457,-0.12634,-0.740494,-0.189048,-0.660067,0.43588,-0.269275,-0.0241297,0.0833601,-0.251718,-0.0410899,-0.183119,-0.0352814,-0.201522,-0.00195403,0.0238622,0.572624,0.131005,-0.0422884,0.121981,-0.129935,-0.132077,0.472243,-0.0772398,-0.142456,-0.326045,0.240474,-0.585754,-0.0566398,0.183396,0.0781723,-0.00916053,0.135153,-0.321186,-0.12224,-0.0502089,0.0855919,0.157386,0.258171,-0.441492,0.315257,0.413682,0.0727679,-0.00353315,0.316382,0.0231992,0.304731,0.104312,-0.389329,0.22327,0.0816534,0.140435,-0.369075,0.702779,0.131174,0.136565,0.362179,0.369547,-0.831112 +3450.65,0.618648,0.0848144,4,1.57235,0.786097,-0.876713,0.278572,0.385867,-0.192683,0.0112913,-0.011198,-0.0341307,0.294766,0.0806876,-0.457736,0.165454,0.517896,-0.0241747,0.521495,0.246119,0.0173529,-0.280257,0.0527679,-0.0686078,-1.04322,-0.777226,0.273851,-0.331346,-0.0899355,-0.136953,-0.274611,0.0716347,0.15755,0.831562,-0.855033,-0.183969,0.182415,-0.1894,-0.428206,-0.350347,-0.107471,0.280374,-0.159891,1.01266,0.140341,0.799636,-0.209725,-0.130371,0.48832,-0.266097,0.44021,0.220987,0.15905,0.197554,0.22875,0.396456,-0.76513,0.758254,-0.683659,0.097738,-0.611315,0.414697,-0.353562,0.124235,0.836125,-0.490612,-0.667536,-0.121143,-0.0754104,-0.207507,-0.332495,0.365414,-0.400267,0.0142311,0.366596,0.626139,0.0349927,0.671207,0.479945,0.137423,-0.133351,-0.342935,0.145666,0.640146,-0.486493,0.412793,-0.376451,-0.140994,0.140665,0.323283,-0.364216,0.189494,-0.276688,0.220457,0.312024,-0.129017,0.373336,0.828648,-0.3538,0.117633,-0.0349884,0.339219,-0.0428311,0.336806,-0.427668,-0.458709,-0.580347,0.257147,-0.329966,0.0639278,-0.151569,0.722663,0.814389,0.606888,-0.12873,0.160579,0.380853,0.307841,0.188681,-0.759934,-0.100598,0.164387,-0.700577,-0.810904,0.153581,-0.529149,0.205358,0.144733,0.115846,0.360657,0.0331847,0.281505,-0.327269,-0.780937,-0.239728,-0.102089,0.826702,-0.352842,-0.293078,0.0867589,-0.199117,0.455568,-0.487368,-0.277693,0.160311,0.29036,-0.36052,-0.0620605,0.251306,0.141279,0.10914,-0.299359,0.420706,0.310793,0.308052,0.0615075,0.104083,0.792709,0.141006,0.057565,-0.0131081,0.278023,0.506833,-0.542886,-0.0443812,0.811314,0.244008,0.367117,0.150997,0.15407,-0.434684,-0.26496,-0.117262,0.104576,-0.2151,0.091764,-0.385172,-0.165534,0.150042,0.0765771,-0.0772593,-0.0609028,0.486267,0.167605,0.112729,0.234999,-0.606738,-0.253656,-0.410269,-0.433358,-0.202324,0.593095,-0.313426,-0.211718,0.262254,0.006689,-0.636976,-0.073617,0.571708,0.0401532,-0.150384,-0.0997423,0.421218,-0.250631,-0.508071,0.161971,0.0713015,-0.234172,-0.140314,-0.557746,0.830627,-0.442178,0.0515229,0.0683744,-0.0330893,0.257586,-0.697678,0.455346,0.023828,-0.29445,0.168832,0.439127,-0.270204,-0.0744547,-0.421285,-0.401994,-0.0295091,-0.726573,0.468472,-0.623231,0.150105,0.0360991,-0.106532,0.401549,0.0468269,0.276697,0.124933,-0.412476,0.726852,0.185803,0.0707409,0.226588,-0.569227,-0.222975,0.0560929,0.0384497,-0.350342,0.289904,-0.0727082,-0.0494403,0.309822,-0.181701,-0.642877,-0.0206748,-0.714622,0.31477,-0.241099,0.030896,0.102702,0.0579793,0.261855,0.0930762,0.00158471,-0.0266779,-0.227247,0.230385,0.596162,0.215428,0.103699,-0.0571687,-0.138068,-0.0407416,0.572804,0.162837,-0.107636,-0.320116,0.214104,-0.351395,0.0849744,0.4455,-0.173009,-0.472559,0.243167,0.123272,0.16907,-0.19024,0.0600018,-0.116335,0.0414453,-0.326406,0.365746,0.453382,0.197837,-0.0177621,0.173172,0.098326,0.47763,0.0184325,-0.384938,0.122727,0.228531,-0.031756,-0.503184,0.514271,0.118828,0.16274,0.344714,0.403411,-0.853806 +3444.14,0.741489,0.0848144,4,1.58445,0.778021,-0.857935,0.306387,0.185963,-0.153799,-0.0917601,-0.287024,0.0175139,0.379604,0.126046,-0.452278,0.238548,0.596354,0.221699,0.64845,0.489315,-0.00103474,-0.252999,0.0599879,-0.12384,-0.933617,-0.450006,0.354021,-0.269597,-0.181883,-0.290743,-0.41767,-0.0552105,0.0697504,0.922661,-0.596785,-0.185742,0.107759,-0.440506,-0.467766,-0.209849,-0.0223838,0.330383,-0.306402,0.920452,0.128978,0.585089,-0.325787,-0.0644086,0.215345,-0.214537,0.400341,0.346342,0.138618,0.0727549,0.154828,0.383015,-0.932602,0.857377,-0.502163,0.172482,-0.505975,0.149166,-0.2601,0.385233,1.06812,-0.684959,-0.988337,-0.393249,-0.033602,-0.0245086,-0.0623472,0.109921,-0.482514,0.024686,0.369455,0.690971,-0.101002,0.545655,0.448539,0.276236,-0.229138,-0.16192,0.131236,0.773994,-0.244809,0.154737,-0.452596,-0.093419,0.0383148,0.0838634,-0.205827,0.180344,-0.349725,0.205942,0.166539,0.0344899,0.328351,0.931494,-0.404156,-0.0563585,-0.220858,0.494429,-0.121231,0.336188,-0.439173,-0.373785,-0.208306,0.435215,-0.464042,0.0183116,-0.228993,0.707765,0.690335,0.742085,-0.208613,0.0798008,0.385328,0.236073,0.199871,-0.707597,-0.071985,0.160656,-0.243847,-0.680408,-0.0824864,-0.734555,0.0592295,0.290102,0.20687,0.149716,0.0338965,0.120256,-0.322686,-0.737665,-0.203304,-0.156629,0.849146,-0.352824,-0.211675,0.193213,-0.280032,0.295042,-0.42976,-0.233477,0.0620599,0.392534,-0.418969,-0.124089,0.296199,0.222895,0.214204,-0.284794,0.129968,0.449474,0.438266,-0.0528833,0.204239,0.784044,0.0586707,0.0928501,-0.0601056,0.191901,0.599114,-0.191184,-0.116177,0.790906,0.165077,0.341283,-0.0117047,0.147126,-0.417832,-0.41233,0.0079713,0.27246,0.108157,0.0994074,-0.209609,0.00543804,0.425585,0.119431,-0.120242,0.129333,0.465094,0.207468,-0.0121007,0.187542,-0.240536,-0.461102,-0.259083,-0.267993,-0.241567,0.173018,-0.644785,-0.0180904,0.388141,-0.00341675,-0.619327,-0.0716377,0.645384,0.192622,-0.119298,-0.296376,0.499935,-0.207719,-0.583652,0.00814748,0.30392,-0.0104343,-0.0673978,-0.70783,0.887621,-0.364055,0.152983,-0.157057,0.13609,0.208446,-0.688668,0.368392,0.0979478,-0.325935,-0.0581619,0.352504,-0.093047,-0.200827,-0.62516,-0.48118,0.234516,-0.714473,0.533373,-0.735615,0.0822921,0.299545,-0.222008,0.172295,-0.101769,0.410557,0.0804923,-0.14216,0.708902,0.333002,0.0455093,0.365571,-0.784692,-0.478759,0.127101,-0.154293,-0.18962,0.440237,0.164506,-0.0697066,0.113359,-0.104612,-0.405137,-0.155571,-0.813916,0.172489,-0.10377,0.0420264,0.0210545,0.125287,0.3325,0.323384,-0.045557,-0.0623088,-0.160094,0.237366,0.525024,-0.0419029,0.00893589,-0.148176,-0.110948,-0.0419262,0.408024,0.191953,-0.0858228,-0.458648,0.452566,-0.233669,0.0937716,0.564229,-0.123288,-0.539428,0.313116,0.105053,0.201489,-0.479222,0.191039,-0.208695,0.0222754,-0.277311,0.0363325,0.354252,0.10359,0.251976,0.320804,0.0558504,0.557797,0.00471843,-0.432845,-0.109886,0.155443,0.240499,-0.441251,0.558688,0.124619,0.150946,0.353014,0.388518,-0.209759 +3446.56,0.998422,0.0848144,4,1.53594,0.78684,-1.50807,0.516797,0.305684,-0.101864,-0.338579,-0.519705,0.606499,0.214984,0.129584,-0.54527,-0.00349875,0.343218,-0.240973,0.463459,-0.0526007,0.0301454,-0.384362,0.176511,-0.445976,-1.03934,-1.06742,0.393146,-0.113456,-0.0144706,-0.0143115,0.486847,-0.288644,-0.122243,0.848983,-0.688124,-0.195294,0.108163,-0.12683,-0.291603,-0.211715,0.552693,0.441834,0.288527,0.903318,0.602885,0.616419,-0.609125,-0.186206,0.537694,-0.428269,0.365985,0.592413,0.0305098,0.154619,-0.434965,0.104939,-0.382616,0.549891,0.158041,-0.117059,-0.630827,0.446857,-0.403616,0.34611,1.04,-0.532675,-0.611255,0.417582,0.154737,0.356743,-0.490846,-0.539253,-0.231664,-0.459254,0.329251,0.304655,-0.300769,0.409626,0.415253,0.251273,-0.0577408,-0.40198,0.268194,0.549088,-0.931557,-0.0416847,-0.133098,-0.135322,-0.289587,-0.149952,-0.0157727,-0.28727,-0.299515,0.149008,0.157265,-0.0248259,0.250126,0.829382,-0.2281,-0.226061,-0.079748,0.0516046,0.258027,0.0152317,-0.706768,-0.241265,0.0648745,0.406969,-0.0692812,0.191592,-0.469231,0.0400555,0.721279,0.20153,-0.00290012,0.280555,0.369232,0.0312793,-0.105573,-0.319896,-0.146909,0.174409,0.218879,-0.38208,-0.106371,-0.715889,0.59577,-0.0758271,0.657686,-0.233907,-0.0241146,0.242983,-0.245962,-0.248287,0.075918,0.13814,0.526132,0.0931297,0.113505,0.418491,-0.0558078,0.662373,-0.114501,-0.220243,-0.101168,0.0920053,-0.400888,0.0518947,0.511589,-0.127818,0.745926,-0.0934346,-0.0668662,0.173248,0.0661337,-0.0191889,0.0753403,0.419975,0.183143,0.133737,-0.318976,0.0390341,0.337434,-0.161018,-0.156238,0.876059,0.0509642,0.404863,0.00371943,-0.248534,-0.207223,0.0290548,-0.255752,0.245582,-0.123983,0.0240579,-0.095769,-0.452872,-0.0411852,-0.0176998,-0.0159657,-0.517276,0.209888,0.386284,-0.0199417,0.3515,0.196539,-0.988149,-0.0594294,0.0450456,-0.0962543,0.220963,-0.571678,0.00351458,0.412266,-0.0808687,-0.307586,-0.265097,0.22189,-0.249445,-0.0289045,-0.130704,-0.2247,-0.091885,0.0140178,0.223707,-0.798273,0.42794,-0.257156,-0.183375,0.698669,0.180361,-0.236625,0.462143,-0.132338,-0.234981,0.109179,0.304569,0.502014,-0.334839,0.100043,0.118153,-0.251192,0.126487,-0.118475,-0.283181,0.445198,-0.618559,0.668535,0.0606786,-0.331102,0.124078,0.23113,0.316677,0.0527212,-0.0573808,-0.43186,-0.481885,0.765305,0.20531,0.130403,0.742872,-0.393137,0.567215,0.0031977,0.0280446,-0.114387,0.129573,0.147674,-0.106733,0.473074,0.184102,-0.25905,-0.241828,-0.660475,-0.0122589,-0.0974164,-0.304532,0.25677,-0.0669044,0.381001,-0.130427,0.0166132,0.410698,-0.0759805,0.589568,0.411484,0.0858996,-0.147897,-0.141985,0.338255,-0.06379,-0.0212863,-0.107639,-0.00744777,-0.356551,0.476627,-0.164084,0.177158,0.576359,0.289572,-0.388433,-0.0446503,0.112946,-0.0712914,-0.20281,0.169586,0.0263095,-0.129978,-0.330069,0.782338,0.020014,-0.0990114,0.0907115,0.203797,-0.189627,0.14059,-0.0214722,0.0348635,-0.511225,-0.271416,-0.163471,-0.145251,-0.336184,0.105669,0.245194,0.325067,0.495171,-0.542245 +3440.58,0.808342,0.0848144,4,1.55543,0.797738,-1.47037,0.461662,0.523233,-0.152336,-0.557198,-0.4432,0.373271,0.259445,0.0627758,-0.446337,-0.0891324,0.404215,-0.123163,0.477381,-0.048149,0.098593,-0.492904,0.0655547,-0.51696,-0.997876,-1.192,0.225642,-0.0653817,0.0388054,0.039498,0.199956,-0.502466,-0.16887,0.824877,-0.750334,-0.144449,0.14195,-0.225289,-0.212183,-0.509771,0.648786,0.382893,0.166137,0.922687,0.478537,0.831628,-0.542372,-0.0946228,0.429169,-0.0861095,0.497002,0.504524,-0.110374,0.321781,-0.235258,0.411707,-0.488374,0.598866,0.2387,-0.234079,-0.664016,0.299523,-0.336105,0.404449,1.28754,-0.70936,-1.02097,0.543086,0.167864,0.135803,-0.758573,-0.614451,-0.0780459,-0.447833,0.224072,0.36039,-0.284929,0.315684,0.334191,0.411698,-0.20541,-0.117891,0.265751,0.265076,-1.09132,-0.055784,-0.208958,-0.125679,-0.546645,-0.0505154,-0.0725404,0.123913,-0.440017,0.0447395,-0.0222836,-0.0348113,0.402725,0.671525,-0.358924,-0.198203,-0.097555,0.0690626,0.122981,-0.247079,-0.515722,-0.543236,0.0995564,0.202557,-0.330265,0.142166,-0.385223,0.140289,0.661434,0.0625554,0.0751685,0.318964,0.468609,0.190878,-0.0927817,-0.25211,-0.123338,0.290016,0.0888297,-0.452767,-0.212795,-0.479141,0.389021,-0.194367,0.612963,-0.253502,0.302621,0.225058,-0.00287974,-0.286289,-0.0706573,0.240988,0.599515,0.101129,0.197893,0.175499,-0.116375,0.391393,0.0465769,-0.178629,-0.044694,-0.224561,-0.384713,-0.0174556,0.33213,0.0984925,0.710556,-0.25801,-0.267138,0.0725473,0.204214,-0.00903543,0.232977,0.388056,0.220822,0.2284,-0.0474404,0.176488,0.593165,-0.0919356,-0.0662077,0.979798,0.0903829,0.463403,0.234526,-0.260093,-0.182305,0.165939,-0.233331,0.299277,0.131699,0.0838711,0.00943797,-0.337886,0.331075,-0.0112643,-0.121659,-0.327171,0.399437,0.265583,-0.121654,0.18219,0.0692037,-0.621089,-0.281132,-0.316291,-0.150109,0.499281,-0.519136,0.143581,0.215944,-0.0467992,-0.473256,-0.312228,0.223218,-0.120637,-0.0516982,-0.0700551,-0.245418,-0.182385,0.137442,0.189668,-0.759715,0.559427,-0.402302,-0.206097,0.847374,0.178318,-0.157369,0.474472,-0.0971584,-0.222538,0.26738,0.238052,0.265778,-0.153955,0.101437,0.198221,-0.053023,0.121722,0.0858929,0.0283499,0.168753,-0.606844,0.640132,-0.139635,-0.144081,0.228788,0.311955,0.173446,0.0069571,-0.105444,-0.388933,-0.518583,0.752039,0.141998,0.238992,0.68829,-0.168495,0.60998,-0.01516,0.0303338,-0.0245466,0.337882,-0.0818494,-0.0105786,0.422968,0.252275,-0.276089,-0.309111,-0.440975,-0.200052,-0.303186,-0.172541,0.481531,-0.0925636,0.464567,0.184627,0.153872,0.519137,-0.068278,0.669875,0.37351,0.23014,-0.126748,0.00423728,0.490553,0.10885,-0.0371421,-0.0119694,0.160836,-0.175016,0.433783,-0.197673,0.104952,0.449841,0.297819,-0.0272729,0.0257191,0.116931,-0.335284,-0.362838,0.248151,0.0353121,0.113239,-0.386368,1.01762,0.12119,-0.200042,0.22071,0.521148,0.0951564,0.147485,0.253242,-0.0147124,-0.453706,-0.2822,-0.0396478,-0.0284118,-0.137264,0.0954643,0.202801,0.308973,0.450334,-1.21914 +3444.3,0.967488,0.0848144,4,1.48397,0.882737,-1.51257,0.499897,0.537673,-0.209568,-0.587604,-0.532448,0.265288,0.220252,0.123775,-0.29052,-0.179472,0.394241,-0.179136,0.609064,-0.125258,-0.0523877,-0.475475,-0.0136613,-0.235435,-0.987276,-0.994284,0.114328,-0.179696,-0.0739445,-0.0309741,0.0163554,-0.508099,-0.126516,0.851518,-0.791195,-0.263971,0.107809,-0.206591,-0.299051,-0.511584,0.78348,0.388847,0.0278345,0.84802,0.381483,0.673878,-0.425083,-0.127853,0.435398,-0.132765,0.222416,0.468042,0.0175494,0.0978053,-0.0675242,0.425985,-0.47344,0.43476,0.267034,-0.0879216,-0.421674,0.249277,-0.224004,0.52733,1.26814,-0.695339,-0.955044,0.483301,0.215987,-0.0817867,-0.674607,-0.694914,-0.0681051,-0.470912,0.334504,0.219567,0.0283407,0.273536,0.395207,0.515934,-0.391985,-0.186199,0.264013,0.248999,-1.11658,0.0290367,-0.244782,-0.274086,-0.38612,-0.0852689,0.134971,0.0503925,-0.433311,0.035518,-0.182727,0.0611111,0.530766,0.711889,-0.289742,-0.224582,-0.00474397,0.0978611,0.312991,-0.183482,-0.361798,-0.614088,-0.0175568,0.0107959,-0.283809,0.10702,-0.459652,-0.115305,0.622772,0.0201882,0.211823,0.437719,0.546825,0.0782305,-0.0925906,-0.202513,0.00861194,0.461292,0.137668,-0.42249,-0.232936,-0.566737,0.448168,-0.200993,0.691028,-0.156144,0.207828,0.103043,-0.193413,-0.225529,-0.152306,0.0884534,0.602726,0.148776,0.0971742,0.171002,-0.232541,0.34908,0.0707138,-0.0796662,0.0482531,-0.021867,-0.32861,-0.18913,0.242025,0.0516696,0.750208,-0.38391,-0.2213,0.148016,0.111268,0.0641595,0.17216,0.279918,0.216603,0.210216,-0.0319167,0.115,0.652537,-0.0460052,0.00815915,1.07583,0.174684,0.163826,0.451345,-0.129995,-0.431284,0.117494,-0.123179,0.285895,0.00720938,0.122699,-0.00989421,-0.34387,0.0732188,-0.0754278,-0.0119961,-0.160728,0.475377,0.201662,-0.0948023,0.329073,0.234599,-0.455428,-0.377562,-0.302104,-0.054924,0.546635,-0.564318,-0.0774909,0.291931,-0.132317,-0.370899,-0.314406,0.205893,-0.0202146,-0.246306,-0.335505,-0.217977,-0.259759,0.0968407,0.348235,-0.641798,0.726044,-0.33223,-0.102678,0.777611,0.144954,-0.0957884,0.454607,-0.0485181,-0.0137244,0.0608801,0.246234,0.198388,0.00962402,0.265569,0.112748,0.0604015,0.248445,-0.0251865,0.166493,0.293485,-0.359991,0.511682,-0.259891,-0.230626,0.352372,0.506469,0.150997,-0.0690317,-0.197504,-0.442062,-0.386632,0.8323,0.29476,0.269933,0.618336,0.0790596,0.414588,0.0094701,-0.102854,-0.100724,0.367581,0.147202,-0.0254579,0.503125,0.0684703,-0.20047,-0.33603,-0.254531,0.0236293,0.00457351,-0.154462,0.558558,0.0448815,0.290901,0.289117,0.240274,0.649875,0.00868083,0.681719,0.388107,0.316388,-0.098399,-0.291078,0.423523,0.221189,0.163023,-0.0102125,0.157976,-0.374473,0.458783,-0.20808,0.0885867,0.490127,0.410576,-0.0445505,-0.0422622,-0.0795455,-0.144807,-0.218825,0.0370272,0.0705777,0.0513971,-0.425039,0.848263,0.0139641,-0.108492,0.133408,0.526779,0.0693682,0.198082,0.414048,-0.0446171,-0.313353,-0.230439,0.0781271,0.00296811,0.102246,0.102489,0.227086,0.320139,0.476535,-1.48858 +3423.37,0.915889,0.0848144,4,1.55435,0.890521,-1.52243,0.504069,0.752165,-0.0398139,-0.337148,0.57627,0.429564,0.0567364,-0.106094,-0.545079,-0.186699,0.0968516,-0.455318,0.624146,-0.345237,-0.176527,0.448149,-0.527455,-0.489294,-1.06879,-0.360946,0.0150094,-0.44246,-0.124655,-0.0100737,0.292831,-1.12321,-0.0617375,0.786549,-0.558127,0.236368,0.071943,-0.454393,-0.308283,-0.0567339,0.671685,0.700914,-0.147632,0.756518,0.765229,0.466443,-0.410077,-0.262608,0.41047,-0.850396,0.231692,0.553227,0.401423,0.266148,0.024067,-0.246708,-0.55669,0.640869,-0.0162364,-0.116926,-0.393342,0.263137,-0.384276,0.345259,1.1319,-0.228642,-0.825227,0.367167,-0.119263,0.160004,-0.0710904,-0.142736,-0.43643,0.459239,0.302004,0.567444,-0.0651442,0.203276,0.770686,0.0531379,-0.313239,-0.406382,-0.157621,0.662151,-0.465076,0.363467,-0.160289,0.257684,0.0298621,-0.311724,0.0401464,0.179107,-0.618285,-0.137899,-0.121718,0.219748,0.430473,0.481207,0.197112,0.63519,-0.152501,-0.323173,0.744931,-0.0203087,-0.283436,-0.421131,-0.649137,0.316648,-0.211113,0.167938,-0.52509,0.0498279,0.151514,-0.649564,-0.0247235,0.147044,0.320238,-0.0353545,0.481085,-0.346933,0.230608,-0.0913808,0.633322,-0.56847,0.13571,-0.0533307,0.208595,0.177633,-0.434499,0.556974,-0.0440009,-0.0268343,-0.354468,-0.0904054,-0.247337,0.0654863,0.746486,0.163019,-0.0447773,0.0420524,-0.317818,0.27091,0.132448,-0.107973,-0.121745,0.131521,-0.15928,0.0462981,-0.191839,0.626718,0.22484,-0.322295,0.288915,-0.120089,0.188013,0.228722,-0.0889621,0.597741,-0.0486447,0.106023,0.405189,0.0711264,0.415616,-0.41182,0.32886,0.505511,0.125965,-0.258491,0.345842,0.00680805,0.127523,-0.258928,0.0220025,0.374767,0.514224,-0.23612,-0.404517,-0.296603,-0.32373,-0.181381,0.245002,0.428474,0.64518,0.125102,-0.40639,-0.00846138,0.0382812,-0.488159,-0.151404,0.076156,-0.0848474,-0.0589519,-0.663839,0.030996,0.389099,-0.0804759,-0.280583,-0.236517,0.599724,0.337907,-0.107401,-0.254136,-0.382059,0.350748,-0.04572,0.299912,-0.191603,-0.182683,-0.111313,-0.755178,0.663196,0.317273,-0.122867,-0.0980313,-0.00705148,0.54053,0.664374,-0.0150293,0.94792,-0.488737,0.412323,0.0669457,-0.631056,-0.066973,-0.694068,0.713348,0.290236,-0.113548,0.14897,-0.261956,-0.0285168,-0.684557,0.209,-0.0176507,0.0187226,-0.148804,-0.361745,-0.321732,0.656877,0.076332,-0.184187,0.388066,-0.074853,-0.239796,0.419273,-0.0727622,-0.0495245,-0.00416931,-0.144496,0.15153,0.526095,0.00894847,-0.286009,-0.243719,-0.163213,0.705842,-0.142916,-0.370121,0.0900269,0.126789,0.237519,0.0442574,-0.207608,-0.00224056,0.338687,0.0358677,0.581206,0.0153527,-0.251521,-0.285946,0.331215,0.6732,0.0881321,-0.103382,0.0898166,-0.341852,0.426438,0.646427,0.225506,0.401274,0.338019,0.206532,-0.38302,0.640529,-0.429831,-0.272788,0.0338724,-0.292883,0.450401,-0.402081,0.269083,-0.136785,0.259562,-0.0422966,0.0201566,0.0484889,0.146046,0.357246,-0.164325,-0.712979,-0.280003,-0.140833,-1.03074,-0.157425,0.133229,0.305628,0.365005,0.552836,-2.18525 +3441.76,0.838407,0.0848144,4,1.55194,0.956254,-0.839352,0.286109,0.696737,-0.0836418,0.0359472,-0.142156,0.647149,-0.149446,0.16795,-0.48365,0.0901166,0.140993,-0.249979,0.828308,-0.0499291,-0.0241421,0.117279,-0.0557402,-0.399948,-0.989142,-0.747119,-0.0906453,0.121568,0.0899697,0.176377,0.0506274,-0.822015,-0.0901065,0.785987,0.0853045,0.464358,0.171268,-0.611668,-0.272144,-0.212096,0.459795,0.38719,-0.0623979,0.717312,0.525844,0.795431,-0.811278,-0.0452879,0.364434,-0.726301,0.0856112,0.436347,0.20125,0.271035,0.406074,-0.0174942,-0.581969,0.684044,0.0221506,-0.110954,-0.420844,0.323532,-0.422931,0.265441,0.872826,-0.397202,-0.888114,-0.139811,-0.230979,-0.0578959,-0.184457,0.405714,-0.761349,-0.141488,0.14637,0.593414,0.236812,0.427762,0.105822,0.142059,-0.685997,-0.222162,-0.00293803,0.907603,-0.733673,0.148341,-0.324293,0.369807,-0.443825,-0.110628,0.303683,0.446458,-0.424377,-0.127312,-0.430965,0.139911,0.360609,-0.0907359,-0.413256,0.370812,-0.161916,-0.119527,0.585797,0.0130714,-0.119166,-0.0133877,-0.0107018,0.103923,-0.0584645,0.314411,-0.371269,-0.113126,0.0372994,-0.401548,0.353247,0.578372,0.286942,-0.18832,0.304977,-0.331053,-0.0491575,-0.108883,0.331828,-0.630658,-0.348616,0.240067,0.256138,0.0673008,-0.0634922,0.224734,0.285199,0.0864465,-0.105612,0.0241298,-0.019019,-0.0651206,0.468441,0.260516,0.329523,0.106487,-0.195126,0.499434,-0.123226,0.242505,0.02239,0.198907,-0.616904,-0.269229,-0.43121,0.634449,0.46637,-0.378607,-0.256014,-0.390459,0.0544552,0.232565,-0.130826,0.109667,0.482199,-0.00838355,0.144926,0.00365591,0.340149,-0.114481,0.416328,0.584442,0.113402,-0.234738,0.272377,-0.357855,0.208051,-0.267073,-0.148761,-0.41483,0.558225,-0.216659,-0.132691,-0.344387,-0.429564,-0.120187,0.531819,0.330591,0.665488,-0.00290557,-0.694072,0.17125,0.358072,-0.417448,-0.17876,-0.140662,-0.167038,0.268941,-0.184419,0.0215999,0.138516,-0.0382604,-0.0455979,-0.256886,0.383493,0.255745,0.213825,-0.271683,0.10042,0.0987352,0.227351,-0.070148,-0.406557,-0.239576,0.0919109,-0.356589,0.907307,-0.117788,0.187915,-0.122212,0.134164,0.235637,-0.00714482,0.460396,0.592802,-0.636276,0.503696,0.362259,-0.525707,0.20083,-0.519045,0.399017,0.314865,-0.314061,0.435499,-0.259279,0.222719,-0.2045,0.364796,-0.0115408,-0.0941283,0.283165,-0.142199,-0.510396,0.386493,-0.34872,0.192454,0.39493,-0.0121948,-0.279041,0.696688,-0.511782,-0.0587806,0.137264,-0.157975,0.546571,0.175872,0.226448,-0.612264,-0.0223278,-0.549331,0.0909119,0.136135,-0.537488,0.361165,-0.00807971,0.12293,0.491175,0.020003,-0.0897387,0.275917,0.481918,0.0377518,0.206009,-0.293943,-0.281774,0.0252498,0.380116,0.216778,0.772702,0.30448,-0.255373,0.0694827,-0.00348939,-0.308481,0.403976,0.171664,0.497723,-0.16597,0.547168,0.0850521,0.170733,-0.086601,-0.256041,-0.0436325,0.00833694,0.122319,0.358985,-0.240704,-0.115671,0.0733163,-0.131406,-0.156461,0.520896,-0.862545,-0.113218,-0.0309781,-0.0354245,-0.0263377,-0.027358,0.102751,0.171668,0.320548,0.414328,-2.26111 +3427.65,0.939435,0.0848144,4,1.53869,0.973,-0.857049,0.30363,0.444589,-0.140776,0.23316,-0.152259,0.508491,-0.307532,-0.241174,-0.201783,-0.134061,0.213154,-0.347299,0.989375,-0.011943,0.0701244,-0.0983427,-0.00300421,-0.378688,-1.13346,-0.7369,0.0345579,-0.211864,-0.409927,0.00151492,0.353287,-0.730758,0.427167,0.765328,-0.113989,0.536963,0.0927369,-0.769019,-0.510921,0.166098,0.185661,0.0979302,0.0523802,0.606907,0.657042,0.448679,-0.714262,-0.145408,0.461168,-0.500173,0.304719,0.304631,0.273949,0.246354,0.608564,-0.132912,-0.624468,0.646235,-0.0519188,-0.442458,-0.310214,0.430966,-0.145751,0.320722,0.947239,-0.527599,-1.39405,0.00809947,-0.167485,-0.319534,-0.474956,0.390008,-0.623372,-0.152245,0.575566,0.683382,0.0491497,0.536221,0.39148,0.0523571,-0.452899,-0.3893,0.093632,0.913125,-0.651038,0.233565,-0.103795,0.253401,-0.577519,0.0866686,-0.0115881,0.281701,-0.282814,-0.00332226,-0.171851,0.114113,0.169985,0.326812,-0.508233,0.390932,-0.318497,0.184597,0.8517,0.109498,-0.381519,-0.190241,-0.197227,-0.285767,-0.132191,0.480491,-0.176835,-0.157625,0.100517,-0.77188,0.0223776,0.170857,0.215159,-0.279553,0.525499,-0.356003,-0.0396501,-0.0629168,0.188984,-0.274793,-0.403512,-0.0357972,0.0249483,-0.280644,-0.25189,0.257336,0.106051,0.0885598,-0.130405,-0.592695,0.0147342,0.126419,-0.0721403,0.0575325,-0.117275,0.0602722,0.200229,0.441033,-0.221222,0.0650342,-0.0556816,0.599092,-0.0835564,-0.503575,-0.167081,0.169174,0.609994,-0.200286,-0.309234,-0.168785,0.157893,0.0128908,-0.283338,0.232746,0.313542,0.207433,0.361768,0.282192,0.555321,-0.0554285,0.0367679,0.414752,0.0601528,-0.240793,0.125378,-0.196385,0.175264,-0.143175,-0.0729322,-0.463395,0.302024,-0.224529,-0.258899,-0.191383,-0.00859839,-0.208056,-0.0459233,0.131801,0.433651,-0.0551535,-0.750579,0.607336,0.431426,-0.542057,0.117397,-0.518133,-0.242387,0.20382,-0.0337446,0.0953807,0.0417027,0.00938669,-0.0803912,-0.0691399,0.358442,0.277062,0.0534856,-0.40788,0.0552168,0.223053,0.0835117,-0.0436569,-0.513568,-0.139503,0.221997,-0.114172,0.848151,0.0850998,-0.0193536,-0.172973,0.301188,0.26769,0.205212,0.581937,0.773623,0.00274254,0.397535,0.2974,-0.605315,0.246295,-0.399188,0.680731,0.54017,-0.0869643,0.217086,-0.255562,-0.0517442,0.401094,0.460291,0.18263,-0.15186,0.179001,-0.398729,0.0362503,0.432413,-0.147547,-0.00704291,0.169857,0.230786,0.0425956,0.722822,-0.545796,0.162226,0.152297,-0.180911,0.448062,0.262406,-0.242624,-0.515832,-0.0753872,-0.316032,-0.0398353,0.0572991,-0.492917,0.297175,-0.60685,0.049241,0.355116,-0.0317678,-0.0758566,0.359316,0.571446,0.0775026,0.0352193,-0.205907,-0.079839,-0.236922,0.613597,0.0800562,0.663119,0.157813,-0.140534,0.00728358,-0.340548,0.208551,0.445216,-0.156953,0.567793,-0.442861,0.293789,-0.108061,0.137206,0.0386734,-0.0243759,-0.246541,-0.0869186,0.281159,0.153438,-0.385777,-0.281519,0.37149,-0.0704831,-0.402965,-0.025139,-0.797792,-0.0888308,-0.168422,-0.00552969,-0.176074,0.0297619,0.116222,0.204393,0.340914,0.452098,-1.45992 +3432.68,0.987788,0.0848144,4,1.55174,0.894722,-1.01158,0.408315,0.491115,-0.16106,0.409065,-0.00491811,0.444055,-0.130483,0.0529997,-0.286309,-0.142455,0.439319,-0.250469,0.94558,0.256399,-0.045703,-0.334228,-0.0887516,-0.119571,-1.09125,-0.620585,0.0144874,-0.140597,-0.0191798,0.046961,0.346615,-0.583988,0.291636,0.745028,-0.391016,0.572306,0.0371524,-0.62935,-0.623807,-0.280452,-0.0647811,0.156292,0.0632247,0.51023,0.58658,0.303971,-0.559965,0.0759607,0.290145,-0.27236,0.042257,0.24271,0.162124,0.071002,0.419711,-0.26136,-0.86458,0.546916,-0.23454,-0.406931,-0.276995,0.293967,0.0975142,0.275027,1.08358,-0.139621,-1.16141,-0.0195716,-0.0960116,-0.0227951,-0.31273,0.332843,-0.624327,-0.218063,0.558504,0.571907,-0.371428,0.584996,0.457164,0.141642,-0.553496,-0.52473,0.0952548,0.928131,-0.177713,0.389988,-0.084812,-0.168322,-0.525112,0.0141051,-0.0202225,0.0344267,-0.356689,0.267706,-0.00557097,0.116352,0.116411,0.306356,-0.929691,0.754874,-0.61856,0.0451957,0.727222,0.12201,-0.33952,-0.395123,-0.247017,-0.519899,0.0618272,0.326964,-0.126433,-0.18725,0.327654,-0.347705,0.0644351,0.219374,0.263072,-0.338702,0.341013,-0.45062,0.169266,-0.134837,-0.0439777,-0.294165,-0.419638,-0.0919967,0.0761376,-0.0561654,-0.164866,-0.335365,0.547013,0.231289,-0.30814,-0.50557,-0.106454,-0.0495671,-0.186295,-0.0594629,-0.252067,0.542705,0.0407952,0.445714,-0.236177,0.403867,-0.207948,0.234382,0.131318,-0.52268,-0.0758443,-0.238166,0.365262,-0.130517,-0.246507,-0.594786,0.481999,0.232015,0.0110838,0.873777,0.687696,-0.173568,0.231307,0.537092,0.132263,0.0675095,-0.287876,0.305425,0.337724,-0.0863199,0.237724,-0.00186511,-0.194949,0.182219,-0.101691,0.144348,0.376017,-0.0980708,0.427678,-0.0358725,-0.0518197,-0.435803,-0.0754343,0.205344,0.588422,-0.582347,-0.166959,0.10324,0.233707,-0.210052,0.222869,-0.0777953,-0.366331,0.206128,0.160906,0.0923093,-0.104775,0.148225,-0.357985,-0.302434,0.337225,0.49878,-0.0542043,-0.45101,-0.0225855,0.218124,0.185115,0.364629,-0.460655,0.187544,0.145241,-0.208612,0.895106,0.396865,-0.0495469,-0.0919428,0.289349,-0.0280829,0.321139,0.613728,0.659199,0.0960677,0.123067,0.126698,-0.604365,0.174581,-0.119266,0.438602,0.129624,-0.299814,-0.00344539,-0.271615,-0.176565,0.0292529,0.0412773,-0.326928,-0.135439,-0.372198,-0.341256,-0.0739705,0.218632,0.134231,0.26799,0.610273,0.0249826,0.139285,0.853826,-0.306539,-0.126079,0.344598,-0.0220703,0.529065,0.260408,-0.0758885,-0.594299,-0.0958673,-0.465344,0.226208,-0.181846,-0.412381,0.388241,-0.713858,0.00461107,0.108192,-0.151362,0.14315,0.441762,0.464643,-0.190457,0.181299,-0.0110592,0.0837414,-0.418025,0.358382,0.0803153,0.467314,-0.1592,-0.390463,-0.0763256,-0.301758,0.0100153,0.303746,-0.367842,0.489111,-0.199374,0.412632,0.419367,0.153456,0.628431,-0.0672633,-0.117954,-0.0756559,0.363516,0.190387,-0.273316,-0.201864,-0.14048,-0.0278325,-0.218387,0.261915,-0.706739,-0.228394,0.0417572,-0.105282,-0.049135,-0.348383,0.0950549,0.220585,0.30831,0.469665,-1.47594 +3424.01,0.843744,0.0848144,4,1.53185,0.811289,-1.33304,0.524743,0.368929,0.0614101,0.4012,-0.384146,0.653611,0.206381,0.0878981,-0.167938,0.101621,0.566871,0.0483915,0.894702,0.226061,0.474945,0.00529664,-0.086646,-0.29749,-0.900709,-0.842,0.287529,-0.708536,-0.194834,-0.157017,0.294846,-0.0289952,0.284679,0.851445,-0.183732,0.178724,0.022247,-0.568096,-0.199779,-0.708251,0.0314857,0.431609,-0.0407062,0.799504,0.308998,0.199398,-0.675555,-0.040966,-0.154592,-0.503966,0.171462,0.625359,0.332697,0.154395,0.747395,-0.241518,-0.455754,0.639719,-0.148431,-0.146178,-0.611732,0.14477,-0.349147,1.02601,0.65094,-0.492751,-1.30607,0.246843,0.520199,-0.214651,0.0088395,0.220662,-0.130896,-0.358912,0.347154,0.284889,-0.342124,0.0950547,0.251532,0.0732705,-0.117997,-0.0368238,0.0966336,0.669475,-0.05739,0.322922,0.0266773,-0.321083,-0.572151,0.201169,0.337202,-0.0238592,-0.342145,-0.0454197,-0.582485,0.286706,0.321347,-0.0216353,-0.647527,0.523556,-0.544339,-0.267882,0.327072,0.198959,0.356109,-0.251895,-0.295683,-0.100192,0.494991,-0.10662,-0.0123686,0.394671,0.549479,-0.564378,0.2983,-0.493824,0.278264,0.0453762,0.167218,-0.29042,0.179965,-0.328609,-0.238522,-0.46405,-0.350507,-0.406918,-0.37825,-0.0601975,-0.0501384,0.586386,0.235664,0.115112,-0.383556,-0.774077,-0.144768,0.102466,0.501479,-0.296244,-0.13707,0.00890737,0.218009,0.397546,-0.284574,-0.669477,0.305783,0.361746,-0.0869435,-0.224857,-0.033335,-0.366473,0.209318,0.0415719,-0.00715098,-0.50218,0.39984,-0.123106,-0.207393,0.623131,-0.283525,-0.00417574,-0.244705,0.296759,-0.0415071,0.0255462,0.0844473,0.262799,0.0391135,-0.0598471,0.422642,-0.195583,-0.501039,-0.379241,0.346648,0.0336177,-0.00113507,-0.0487554,0.453188,0.110785,0.155714,-0.187115,-0.0205178,0.330876,0.565613,-0.00866483,-0.0646515,0.781681,0.0717686,0.582609,0.00728523,0.124858,-0.106473,0.0677599,-0.0474738,-0.0203515,0.00782412,0.0584799,-0.294593,0.136212,0.235198,0.330392,-0.0603989,-0.685909,-0.232314,0.155539,0.159851,0.0956969,0.58039,0.44763,-0.166228,-0.98797,0.917237,-0.33922,-0.0500491,0.227325,-0.047731,-0.0624887,-0.425324,-0.255698,0.489293,-0.310321,0.375945,0.872709,-0.127112,0.039819,-0.652793,-0.41718,0.0127249,-0.0302194,-0.012298,-0.618864,-0.211351,0.206385,0.361464,-0.368962,-0.00684998,-0.385233,-0.269915,0.2155,0.479988,0.0409357,-0.511064,0.413314,-0.361873,0.180866,0.673385,-0.140953,0.0375865,-0.165397,0.00860764,0.144448,0.0443784,-0.245689,-0.322126,0.436711,-0.95493,-0.0999622,-0.577771,-0.258255,-0.156143,-0.198586,0.539072,-0.340029,-0.0955235,0.72268,0.163764,0.496395,-0.250339,-0.0675772,-0.351365,-0.0502019,-0.135348,-0.0788691,-0.0822901,0.031899,0.082556,-0.0973674,0.0659366,-0.0148038,-0.468211,0.454609,-0.222811,-0.104958,-0.00600235,0.210584,-0.0393133,-0.803543,0.177614,0.00928478,-0.0756708,-0.282432,0.140885,0.879675,-0.653732,-0.202879,-0.211229,0.251145,-0.161456,0.215187,-0.169426,-0.566574,-0.704375,-0.305703,-0.186554,0.0400417,0.136047,0.207666,0.368846,0.455703,-0.939832 +3417.96,0.592389,0.0848144,5,1.54494,0.799935,-0.423269,0.228381,0.629831,-0.275471,-0.0547187,0.245922,-0.0141307,0.0651056,0.305112,-0.031042,-0.0392745,0.551914,0.0313866,0.796541,-0.0288571,-0.436427,0.188301,0.504587,0.0198261,-0.662545,-0.267286,0.413589,0.0919476,0.380464,0.233579,0.21519,-0.184143,0.456933,0.842356,-0.688579,0.131304,0.698457,-0.289036,-0.586433,-0.0757343,0.31733,0.581992,-0.659799,1.12887,0.474446,0.498241,-0.60933,0.0147846,-0.123159,-0.732197,-0.10187,0.645234,0.252575,-0.161037,-0.237972,0.111499,-0.281282,0.797917,-0.340833,-0.358072,-0.95183,0.635814,-0.523138,-0.481727,0.527492,-1.14834,-0.711367,-0.339471,-0.368555,0.578876,0.072995,0.304605,-0.496468,0.320664,0.0771305,0.625546,0.178792,0.590379,0.504731,0.532284,0.0254069,-0.560031,-0.025085,0.253961,-0.629901,0.308763,0.0733744,-0.0356672,0.49738,-0.0850533,-0.67922,0.153733,-0.0515396,0.0940324,0.502693,-0.181465,-0.132057,-0.0363023,-0.00455504,-0.0783804,0.0372856,0.23633,0.264063,0.0821819,-0.532767,-0.23953,-0.503294,0.324658,-0.882948,0.454989,-0.257083,-0.362709,0.59702,0.415073,-0.1272,0.410892,0.471617,0.0930488,0.275936,0.0152769,-0.0157783,0.555338,-0.419195,-0.55454,0.341029,0.424916,0.119676,0.0370399,0.49555,-0.314159,0.00116664,0.255968,-0.0243792,0.848012,0.0315241,0.0130647,0.114926,0.0770118,0.0695656,0.0881512,-0.58025,0.154708,-0.396543,0.0191755,-0.0490513,0.162869,-0.6333,0.384986,0.180606,0.233075,0.424504,-0.00143107,-0.0671827,0.00164014,-0.0862784,0.553704,0.00486927,-0.324406,1.02686,0.144392,0.281504,-0.260437,0.0152836,0.0957522,-0.114791,0.535186,0.0209916,0.150078,-0.00765879,-0.00976162,-0.105874,0.159012,-0.372451,0.502916,-0.124334,0.0385486,-0.784273,0.0814325,-0.0946083,-0.236597,-0.00691879,-0.00560856,0.469582,0.5277,-0.20687,-0.351189,-0.276955,-0.32536,-0.526048,-0.469483,-0.309739,0.323505,-0.36598,-0.0631792,-0.0120012,-0.150281,-0.594659,-0.0084499,0.0542901,-0.421292,-0.439703,0.196833,0.121233,0.0569042,-0.149636,0.12767,-0.50163,-0.26352,0.0181167,-0.00604141,1.18836,0.661599,0.29126,-0.133924,-0.132734,0.277163,0.529717,0.209333,-0.224163,0.0574295,0.0710514,-0.398766,-0.440417,-0.12314,-0.140777,0.456738,0.167126,-0.564708,0.778161,-0.120522,0.0390607,-0.00484213,-0.173968,0.126788,0.159508,0.123348,-0.01393,-0.568442,0.384233,-0.108279,0.505972,0.387992,-0.0869582,-0.295653,-0.582525,0.180199,-0.00244197,0.528011,0.362157,0.54703,0.25548,-0.243323,-0.311659,-0.546307,-0.231002,0.687562,0.265195,-0.130216,0.290818,-0.351587,-0.0779237,0.50839,0.413165,-0.447443,0.32186,-0.237834,0.644399,0.215644,0.307278,0.142998,-0.0216014,0.0616217,0.0878219,-0.18808,-0.66416,-0.129984,-0.122362,-0.215369,0.305887,-0.3228,0.249783,0.106557,-0.00598694,-0.766339,-0.19757,0.521559,0.0563972,0.149412,-0.0386777,0.23174,0.182632,-0.580977,0.400396,0.148198,0.333632,-0.0617874,0.511258,-0.380425,-0.345604,0.0734637,0.542427,0.217142,0.0346753,-0.000848007,0.13888,0.225709,0.372667,0.475089,-1.88554 +3448.4,0.590785,0.0848144,4,1.50029,0.805574,-0.707579,0.205564,0.429287,-0.161199,0.482009,0.0454111,0.567707,0.0537036,0.403689,-0.235951,0.0779348,0.413536,0.0820937,1.17354,0.318252,0.310641,0.187235,-0.050767,-0.0822241,-0.571126,-0.987801,0.447903,-0.563304,-0.224081,0.333652,0.730463,-0.348881,0.296246,1.31038,-0.0880395,0.133203,0.267596,-0.0895604,-0.20836,-0.767224,0.195464,0.564887,-0.316448,0.652777,0.404492,-0.0319189,-0.577263,0.342805,-0.512753,-0.659708,-0.00217296,0.568278,-0.101216,0.173435,0.378515,0.136369,-0.676807,1.08867,-0.52638,-0.182148,-0.760685,0.903011,-0.571136,0.633632,0.973118,-0.16784,-1.20782,0.105348,0.234088,-0.490105,-0.0456079,0.0338439,-0.125598,-0.34628,0.208321,0.476189,-0.410107,0.0654773,0.207358,0.147976,-0.00976944,0.0646798,-0.0430463,0.52881,0.208443,0.222592,-0.0479939,0.0670524,-0.621621,0.0286914,0.291113,-0.0815823,-0.698644,-0.00238027,-0.312928,0.148636,-0.0396624,0.179038,-0.343892,-0.0598257,-0.407064,0.0576467,0.209453,-0.107661,0.317198,-0.26668,-0.230893,0.0207006,0.310328,-0.015864,0.227777,0.604558,0.456522,-0.263742,-0.108175,-0.131309,0.323534,0.25113,0.205093,-0.339328,-0.167328,-0.0597666,0.219674,-0.544348,-0.279222,-0.620326,-0.330625,-0.277064,-0.439569,0.583501,0.189432,0.124373,-0.397971,-0.740169,-0.127668,-0.375013,0.442654,-0.369054,-0.0854642,-0.0776604,0.280135,0.355127,-0.259511,-0.306563,0.166904,-0.0191643,0.184968,-0.544753,-0.0855325,-0.16564,0.0914859,-0.404743,-0.169739,-0.116724,0.206267,-0.407365,0.0268434,0.708802,-0.55369,0.00375816,0.000683034,0.422281,-0.163638,0.0179654,0.0839836,0.17042,0.0275428,-0.0371134,-0.121806,0.0615944,-0.0499041,-0.231985,0.207533,-0.0857825,0.0728944,-0.0620799,0.607362,0.0988813,0.0513624,-0.451782,0.0150184,0.24963,0.692097,-0.396847,0.121269,0.608647,0.0578631,0.330268,0.155088,0.303502,-0.135868,0.132887,-0.168156,0.140223,-0.211069,-0.0345655,-0.272786,0.276957,0.109726,0.397087,-0.123857,-0.787804,-0.241135,0.00499875,-0.248046,0.132498,0.296583,0.237918,0.158091,-0.688852,0.491763,-0.68292,0.0526204,0.0973787,-0.068015,0.154249,-0.328432,-0.210441,0.413255,-0.203079,0.0494584,0.547849,-0.116319,0.0647168,-0.687218,-0.374613,0.40111,0.169131,0.211369,-0.358158,-0.389574,0.183768,0.329264,-0.421385,-0.0315358,-0.317408,0.114688,0.20252,0.113873,0.335534,-0.409642,0.496031,-0.109588,0.0749489,0.671321,-0.314354,-0.0296964,0.0679891,0.130018,0.173695,0.118365,-0.049785,-0.116799,0.110261,-0.852963,-0.125276,-0.380592,-0.30676,0.0245093,-0.317916,0.148876,-0.231412,-0.176298,0.64435,0.160289,0.0326345,-0.353175,0.10336,0.0563053,-0.418236,-0.176857,-0.151923,-0.114712,-0.087751,0.199816,-0.0829969,0.344215,0.0858053,0.0233822,0.492043,-0.384914,0.133917,0.0792213,0.220017,0.0188561,-0.725731,0.176393,0.182915,0.388064,-0.228889,0.204832,0.689648,-0.549538,-0.127146,0.0903861,0.378061,-0.122179,-0.0367036,-0.0961217,-0.343224,-0.505172,-0.220514,-0.271038,-0.0255447,0.0887998,0.370155,0.297993,0.608404,-1.13194 +3437.99,0.655223,0.0848144,4,1.43055,0.813196,-0.386002,0.119556,0.863613,-0.109011,-0.283585,0.323606,0.450527,0.0946938,0.382504,0.167738,0.198725,0.380833,-0.0847043,0.897182,0.654624,0.306794,0.0905197,-0.298417,0.36652,-0.630569,-0.940915,0.328455,-0.396133,0.0939968,0.559317,0.581822,-0.112805,0.580871,1.17518,-0.323762,0.507829,0.499423,0.289534,-0.24641,-0.623451,0.378625,0.235248,-0.725543,1.11144,0.0563605,0.312453,-0.145281,0.273512,-0.29244,-0.628963,-0.0978531,0.091051,0.000325624,0.238659,0.673822,-0.075542,-0.778261,1.20636,-0.251647,-0.36491,-1.00913,0.688896,-0.189098,0.178308,1.23283,-0.779108,-0.77207,-0.229629,0.27611,-0.324445,0.530703,0.46561,-0.164098,-0.213803,0.410525,0.715354,-0.292981,0.606365,-0.0624047,-0.00856126,0.150899,-0.305492,-0.128156,0.137695,-0.192991,0.249855,0.376645,-0.258173,-0.358942,0.00800797,0.147005,-0.376162,-0.615495,-0.129342,-0.110641,0.274473,-0.0759408,0.241649,-0.155567,-0.172407,-0.163094,0.156365,0.238585,0.0799468,-0.309153,-0.0452178,-0.291324,-0.551567,0.261168,-0.242128,-0.0641494,0.520171,0.483225,0.068717,0.0437221,0.276382,0.436507,-0.287935,-0.070211,-0.297708,0.238352,0.172103,-0.140856,-0.478337,-0.453986,-0.658169,-0.142923,-0.226967,0.313596,-0.0500325,0.203116,-0.095827,-0.417404,-0.165122,-0.0033633,-0.648397,0.380703,-0.557881,0.266948,0.282651,-0.00996217,0.286987,-0.114351,0.0379253,0.0432599,0.472511,-0.240188,-0.0984179,-0.168502,0.202338,0.399144,-0.261677,-0.127139,0.0345127,0.0215969,0.491288,0.260196,0.597593,-0.244449,-0.165448,-0.443073,-0.00122197,-0.322629,0.226561,0.0951108,0.396606,-0.340348,-0.0629099,0.303112,0.288989,0.276611,-0.333997,0.0306206,0.141146,-0.015079,0.136842,0.343435,-0.168159,-0.0554412,-0.310862,-0.898671,0.160208,0.307581,0.297945,-0.108519,0.251395,0.102391,-0.500174,0.123301,0.213344,-0.382541,0.329492,-0.288507,0.00928481,0.204424,0.322893,-0.314664,-0.284493,0.083214,0.518476,-0.29397,-0.105372,0.012154,0.0581385,0.381123,0.054258,-0.443228,0.0592199,-0.413789,-0.676788,0.606641,-0.0555677,0.394357,0.381437,0.130011,0.0390607,-0.104909,-0.215011,0.335435,0.112172,0.403121,0.0284703,-0.0944667,-0.111432,-0.912558,-0.129747,-0.0260506,0.241073,0.238184,-0.196446,-0.180585,0.224071,0.221215,0.07628,-0.053512,0.380234,0.0223308,-0.0418115,0.330822,-0.133429,-0.180217,0.187794,0.172208,-0.352362,-0.0217635,0.379035,0.312319,0.833822,-0.383433,0.25053,-0.0919815,0.507705,-0.306451,-0.086972,-0.402106,0.456691,-0.034169,0.188881,0.595064,-0.414057,-0.174902,0.18008,0.117008,0.458403,0.557627,0.359645,0.0916294,0.575576,-0.0605618,0.125169,0.015223,-0.285572,0.0940149,0.179777,0.00591094,-0.470419,-0.168641,0.244858,0.387697,0.0519384,0.00607927,0.74355,0.391119,-0.0311957,-0.767585,-0.366477,0.0302893,0.127445,0.759692,-0.337165,-0.227622,0.369172,-0.00686674,-0.0468197,0.191587,-0.234424,-0.233415,-0.412959,0.0877501,-0.174063,-0.18599,-0.170614,0.267537,-0.408399,0.0961797,0.336593,0.310128,0.580167,-2.75747 +3443.06,0.934247,0.0848144,4,1.52146,0.997503,-0.410879,0.140945,0.580912,-0.151306,0.3804,0.663812,0.629575,0.934952,-0.144898,0.00561046,-0.290348,0.595452,-0.366866,1.18778,0.628413,0.0200744,0.337888,0.214897,0.0382956,-0.834806,-0.20616,0.178723,0.0521521,0.194254,-0.541234,0.543667,-0.184657,0.207744,1.05917,-0.275194,0.23944,0.14668,-0.174629,0.00790455,-0.531296,0.0599298,0.621177,0.0987038,1.24401,0.841352,-0.220646,-0.82195,-0.18981,0.249414,-0.57069,-0.0691298,0.400112,-0.0481321,-0.0590016,-0.33767,0.0577121,-0.088268,0.82831,-0.49848,-0.0196148,-0.450626,0.422225,-0.972124,-0.0448352,1.25996,-0.041466,-1.27256,-0.17698,-0.0278959,0.191509,-0.591909,-0.53131,-0.462564,0.0197316,0.0714101,0.154818,0.307517,0.113772,0.320883,0.510549,-0.00496851,0.0214884,-0.257203,0.564563,-0.219182,0.152487,-0.280007,0.153695,0.296876,-0.107932,-0.182615,0.432842,-0.386975,0.196259,0.112912,-0.0243559,0.0692689,-0.20739,0.420819,0.490183,-0.0836664,0.0395929,-0.122445,-0.244907,0.166863,-0.180888,-0.0271022,0.490204,-0.19136,0.421787,-0.365217,0.0617201,0.333647,0.013983,0.027319,-0.141172,0.0896927,0.262145,0.317258,-0.132041,-0.246649,0.24617,0.000544335,-0.765738,0.22615,0.246933,-0.0165818,0.477113,-0.473637,0.384121,-0.256216,0.393242,-0.400662,0.27465,-0.15879,0.469923,0.348644,-0.108752,-0.332392,-0.413459,0.0865758,0.0549892,-0.554284,-0.471148,0.000123865,-0.195744,-0.0481293,0.18822,0.421029,-0.339105,0.0304438,-0.396106,0.0276491,-0.442765,0.47409,-0.230865,-0.368399,-0.129663,0.668114,0.176398,0.104028,-0.100118,0.0933138,0.0575001,-0.0620338,0.647098,0.170736,-0.047366,-0.0793362,-0.310446,-0.141959,0.0893996,-0.0214263,0.265822,-0.220908,-0.352579,-0.127976,0.353536,-0.132762,-0.237168,0.696894,-0.0508961,0.37765,-0.328848,-0.0404991,-0.341281,-0.0646483,0.0531606,-0.625083,-0.695729,-0.108521,-0.248035,0.100244,-0.0857986,0.385992,-0.293694,-0.900592,0.255713,0.211511,-0.431004,-0.23896,-0.351857,0.368625,-0.0475858,-0.642959,0.0181982,0.838416,0.0418161,0.27156,-0.0342208,0.544711,0.0829849,-0.165326,-0.100744,-0.00203015,-0.0820224,0.483095,-0.0833553,0.116151,-0.290084,-0.387823,-0.162776,-0.440271,0.174118,0.175982,-0.0476972,-0.0317071,-0.894187,0.405203,-0.0889249,-0.248223,-0.0379106,0.0631275,-0.184445,-0.00390818,-0.572062,-0.11524,-0.367669,0.30289,0.197435,0.155473,0.181338,-0.665999,0.0889363,0.313014,-0.108889,-0.329231,-0.158996,0.251389,0.595018,0.299371,-0.334517,-0.319566,0.239051,-0.350029,-0.129054,-0.229596,-0.401559,0.190818,-0.0981383,0.535188,0.0507962,0.272841,0.0171406,-0.0043497,0.224418,0.256969,-0.0949409,0.345775,-0.452767,-0.329191,0.338423,0.181478,-0.0579929,-0.387269,0.297054,0.257892,-0.126387,-0.362591,-0.050186,-0.159921,-0.208252,-0.126253,-0.176422,0.471889,0.188979,-0.184693,0.0880231,-0.263914,0.308982,0.420303,-0.0632672,-0.110488,0.162934,-0.0712618,0.436708,0.336396,0.311087,-0.515235,0.398268,-0.328487,-0.280153,-0.400372,0.267329,0.0917907,0.258223,0.30297,0.508156,-2.05054 +3458.57,0.960556,0.0848144,4,1.51979,0.912521,-0.855154,0.315756,0.502526,-0.252439,0.284947,0.435117,0.636779,0.179973,0.117899,-0.0819411,-0.051449,0.711224,0.00729746,0.825726,-0.0181162,0.138073,0.18187,0.0581536,0.115681,-1.03954,-0.944122,0.213415,-0.298212,-0.264677,-0.107825,0.388039,0.0431875,-0.259263,0.867566,-0.193783,0.482445,0.140656,-0.238863,0.136562,-0.797371,0.766625,0.257547,-0.0845802,1.34519,0.951665,0.841297,-0.466966,0.00710189,-0.000238225,-0.149901,0.59192,0.740944,0.342428,0.0499538,0.353507,0.0612444,0.169903,0.708664,-0.55858,-0.57017,-0.850203,0.512591,-0.407997,0.358611,1.32005,-0.485316,-0.938249,0.105266,0.199099,0.0303561,0.308665,-0.500091,0.0320639,0.00202704,-0.174736,0.471686,-0.0838156,0.380305,0.448052,0.300947,0.0053697,-0.315838,-0.314607,0.351651,-0.0862125,0.152911,-0.362695,-0.1309,0.139649,0.102836,-0.552842,-0.072277,-0.241682,0.320899,-0.478896,0.149453,-0.237547,0.230411,-0.585589,-0.0873522,0.0487611,0.212427,0.187001,-0.389987,-0.515909,-0.328417,0.0993179,-0.599078,0.128355,-0.0395821,-0.376509,-0.0594228,0.906327,0.0540822,-0.0515623,0.121228,0.431481,0.264634,0.0435259,-0.384126,0.16487,0.805988,-0.775335,-0.616323,-0.185674,-0.33102,-0.22703,0.056035,0.0424322,0.0757508,0.0706598,0.021329,-0.242576,-0.0582454,-0.0381471,0.134995,0.4619,-0.0899797,-0.266823,-0.0806779,-0.139925,0.0333669,-0.206845,-0.202248,-0.0442622,0.761699,0.00792451,-0.171586,0.268637,-0.191123,0.137597,-0.199768,-0.295668,-0.423296,0.144332,0.373837,-0.185589,-0.071825,0.208172,-0.108021,-0.204676,-0.511979,-0.257123,0.229152,-0.245437,0.251356,0.0160461,0.0250232,-0.0129388,-0.0504764,-0.0158525,-0.0640115,-0.0663251,-0.245939,-0.056819,0.0437388,-0.0429326,0.116058,-0.521906,-0.0959347,0.067146,-0.0702209,0.176898,0.0738339,-0.21947,0.252184,-0.0380113,-0.122614,-0.39708,-0.0479992,-0.130952,0.0162976,-0.132734,-0.302004,-0.209589,-0.131819,-0.459531,0.0165713,0.073834,-0.0406237,-0.519822,0.00824118,0.257537,-0.0589209,-0.358817,0.0198189,-0.204286,-0.0606336,-0.267255,-0.525648,0.946526,-0.0894632,-0.14664,0.0881188,0.209194,-0.125729,-0.190125,0.18735,0.323755,0.138508,-0.0779973,0.0574433,-0.299552,0.13724,-0.205908,-0.0540932,-0.388536,-0.0505088,0.019522,-0.444147,-0.680711,-0.0124214,0.309221,0.0497272,-0.131115,-0.375001,0.405636,-0.233281,0.36366,-0.0854572,0.0269794,0.155465,0.246621,0.0256744,0.29446,0.320875,0.325424,0.030205,0.377994,0.372687,0.113291,-0.595824,-0.1722,0.319239,-0.144298,0.545411,0.0140775,0.0559209,0.380211,-0.227653,-0.147197,0.308164,-0.05393,0.252031,0.378915,0.644733,0.046088,-0.474098,0.306602,-0.0948295,-0.294741,-0.55142,0.310034,-0.186373,-0.0130323,0.0344581,-0.292795,-0.313957,-0.0328513,-0.146474,-0.0387782,-0.298448,-0.28708,0.265564,-0.0899978,-0.202729,0.0516181,0.286929,0.526357,0.0714534,0.725557,0.439501,-0.231468,-0.130499,-0.384565,0.150198,0.264795,0.00374555,-0.557801,-0.321929,-0.0659213,0.0652951,0.0437138,0.483052,0.104097,0.336574,0.322641,0.58015,-1.54881 +3478.22,0.9915,0.0848144,4,1.47316,1.01185,-0.380627,0.0641935,0.735668,-0.171167,0.228522,0.0238768,0.0441948,0.318745,0.0157895,-0.193525,0.548604,0.464247,-0.0276239,1.34876,0.208684,0.261686,-0.15934,0.267392,-0.173835,-0.716895,-0.335858,0.185182,-0.434945,-0.0069217,-0.0455275,0.525331,-0.571313,0.401755,0.688047,-0.657281,0.520964,0.319628,-0.0286528,0.155784,-0.434972,0.522951,0.555441,0.071562,1.32816,0.715037,0.281701,-0.314122,-0.0172215,0.306689,-0.872914,-0.171854,0.52551,0.40596,0.419017,0.128323,0.0920386,-1.12374,0.92121,-0.0963538,0.193083,-0.916074,0.645246,-0.505223,0.594855,1.29811,-0.294281,-1.14971,0.26713,-0.0744059,-0.170032,-0.288655,0.194606,-0.687499,0.0820514,0.0207608,0.400052,-0.273313,0.261114,0.227743,-0.044837,-0.11584,-0.370091,0.146862,0.385476,-0.261644,0.0364098,-0.211113,0.233187,0.074991,0.247239,0.0890399,0.232143,0.0335283,-0.46169,0.0256291,0.219824,-0.0606779,-0.232026,-0.0828858,-0.316076,-0.114965,-0.445722,0.0896001,-0.184356,0.314156,0.00414952,-0.147561,0.51854,-0.388838,0.108965,-0.185654,0.232461,0.0857503,-0.251591,0.108775,0.265002,0.174463,0.0254588,0.141042,-0.254608,0.0204795,-0.0491946,-0.0873241,-1.02269,-0.524324,0.464095,-0.27713,-0.185312,0.34195,0.387693,-0.0832113,0.146756,0.244511,-0.0540358,0.0645611,-0.0457763,0.141383,-0.10924,-0.185656,-0.0532091,-0.148518,0.288765,-0.00373991,-0.340981,-0.102875,-0.152107,-0.386354,0.59311,0.043473,0.160796,0.323389,0.0930078,0.157726,-0.137139,0.0104462,0.294493,-0.0537908,0.0282203,0.0266743,-0.0412409,0.0875839,-0.0290101,0.000472954,0.0672443,0.475506,0.777965,0.0234057,0.0708229,0.688934,-0.101928,-0.526493,-0.455068,-0.0588649,0.49395,-0.320284,-0.225828,0.301372,-0.0369373,-0.00131567,-0.362571,0.0206784,0.00929386,0.374502,-0.00701121,-0.0255324,0.124286,0.0985997,0.122616,0.0398423,-0.300935,-0.0651908,0.366936,-0.235437,0.035753,0.0721969,-0.262155,-0.247693,-0.0106328,0.21206,-0.388173,-0.376457,-0.543506,-0.355384,-0.178981,0.117642,0.477438,0.10655,0.0589154,0.606672,0.0133111,0.962573,0.525588,0.272676,0.185754,-0.099092,0.102478,0.352144,0.131429,0.225881,-0.448938,0.032791,-0.054703,-0.472993,-0.375854,-0.366218,-0.0969108,0.349373,-0.59407,0.38299,-0.340072,0.00524463,0.0773094,0.372892,-0.0922232,0.135273,0.199489,-0.165966,0.144533,0.255202,-0.361846,0.0190708,0.237914,-0.139315,-0.45179,0.328268,0.0857041,-0.202213,0.0325651,0.030327,0.556479,0.0935084,0.381863,-0.172835,-0.0978206,-0.340815,0.178276,-0.340594,0.193354,0.0384948,-0.283392,0.395439,-0.0623032,0.17291,0.530981,0.510919,-0.13181,0.341573,0.487635,0.34493,0.308982,-0.0597998,0.0382425,0.039293,0.140137,-0.433359,-0.314665,0.0674824,0.156797,0.138171,0.0338577,-0.0544894,0.408421,-0.278101,-0.00366264,-0.138126,-0.323947,0.0406618,-0.239415,-0.292865,0.0604369,0.120201,0.119733,0.0864716,0.248774,0.714644,0.305371,0.632078,0.154701,0.274482,0.12785,-0.0736848,-0.0973987,-0.00917216,-0.314888,0.0817383,0.261796,0.285899,0.51166,-2.5761 +3470.94,0.931683,0.0848144,5,1.56747,1.04018,-0.782263,0.173021,0.172806,-0.0273293,0.184255,0.0607742,1.1064,0.475697,-0.31408,-0.237168,-0.597037,0.355473,-0.0703461,0.663257,-0.0729594,-0.891882,-0.12264,-0.239908,-0.479281,-1.17771,-1.0119,-0.157605,-0.0190184,0.111937,0.337578,0.685678,0.0644458,0.00774104,0.606226,-0.345115,0.192155,0.471198,-0.155338,-0.161848,-0.146673,0.337671,0.575296,-0.4916,1.01703,0.728985,0.454687,-0.832982,0.0998497,-0.238515,0.0697292,0.179795,0.33549,0.0816807,0.166927,0.68089,0.0667093,-0.522981,0.685059,-0.139374,-0.174565,-0.467699,0.243375,-0.0616014,0.167374,1.06105,-0.98373,-1.51843,-0.135546,0.296757,0.133795,-0.0528183,-0.123038,0.0515061,-0.00916431,0.446672,0.539831,0.166686,0.500221,0.15444,0.497407,-0.181697,-0.364908,-0.14577,0.366281,-0.0288145,0.178844,0.135978,-0.494208,-0.16595,-0.16775,-0.344681,-0.0952903,-0.394371,0.582266,-0.0955731,-0.274468,0.00299793,0.0711988,-0.284308,0.480667,-0.231155,0.479752,0.395889,0.0577018,-0.414608,-0.372829,-0.205219,-0.382667,-0.0142197,0.252086,-0.188898,0.0338809,0.769144,0.0271663,-0.0331889,-0.0531122,0.293809,0.124244,-0.0599352,-0.0128823,0.0659541,0.112723,0.0714589,0.0384725,0.599551,-0.528868,0.110376,0.20577,-0.206483,-0.110835,0.131226,0.126154,-0.55152,0.329678,-0.199135,0.0365962,0.600786,-0.474805,0.103262,-0.296122,-0.3119,-0.00364407,-0.649345,0.152982,-0.132203,0.377782,-0.195125,-0.539376,0.162749,-0.463999,0.0740283,-0.221877,-0.146779,-0.205931,-0.203842,0.0325596,-0.137282,0.195254,0.48038,0.326005,-0.395395,0.128892,-0.341051,0.179049,-0.383486,0.322361,0.000249288,-0.166031,-0.453887,-0.0977101,0.228559,0.130368,-0.0614471,-0.0355306,0.39354,-0.229975,-0.326344,-0.0239997,0.0281469,-0.0465623,-0.205534,0.156975,0.544129,0.327295,-0.0747037,-0.0580761,-0.0937113,-0.154909,-0.429095,0.00130857,-0.415468,0.012289,0.0293644,-0.130612,-0.127966,0.273142,-0.606112,0.0676032,-0.0764324,0.299892,-0.0977406,-0.0516961,0.495421,0.0893844,-0.277089,-0.399449,-0.250729,0.134408,-0.69996,-0.582465,0.659977,-0.42688,-0.195797,-0.528846,-0.0539321,-0.109583,-0.256834,-0.27685,0.266067,-0.0442186,0.19769,0.0981615,0.129421,0.37171,-0.253615,-0.0754458,-0.185824,0.0576027,0.0318381,-0.131033,-0.283665,-0.231213,-0.0809909,0.0166626,0.089317,-0.398513,0.112427,-0.390595,0.562779,0.222684,0.0730192,0.410877,-0.0922676,0.353133,-0.309157,-0.0165095,0.256419,0.395047,0.135512,0.216681,0.372854,-0.403397,-0.441975,0.136182,-0.26069,0.415804,0.0786996,-0.491372,0.193599,-0.0368853,-0.262523,0.286828,0.0665383,-0.183603,0.107438,0.284361,-0.0366618,-0.251177,-0.0573475,-0.252393,0.000578269,-0.0205811,-0.120889,-0.204515,0.176168,-0.252742,0.212234,-0.0611868,-0.275596,0.137758,-0.0932726,-0.129365,0.444659,-0.255337,-0.190115,0.00628562,0.147034,0.365369,0.483462,-0.142988,0.135714,0.331777,-0.277307,-0.0908045,-0.518781,-0.0597384,-0.31167,-0.0683491,-0.760579,-0.0715754,-0.114963,0.136212,-0.0473641,0.180637,0.080169,0.269833,0.283141,0.519454,-0.591437 +3449.81,0.835884,0.0848144,4,1.65627,1.06962,-0.69076,0.222305,0.311327,-0.0433808,0.0176106,0.335676,-0.0995712,-0.192728,-0.452872,-0.360027,-0.404264,0.119067,-0.326806,0.753442,-0.0399161,0.00776789,0.161892,-0.380553,-0.426539,-1.0191,-1.20335,-0.474092,-0.45603,-0.463396,0.235171,0.581763,-0.193622,0.164153,0.902248,-0.462584,0.300428,0.0820883,-0.559521,-0.0757544,-0.572567,0.559864,0.55454,-0.536792,0.640354,0.795226,0.467661,-0.950864,0.210355,0.199671,-1.15155,-0.129973,0.446663,-0.457015,-0.0355126,0.587477,-0.110491,-0.50809,0.344583,0.113485,-0.45717,-1.07503,0.164731,-0.0900189,-0.187104,0.835331,-1.13624,-1.55912,0.336623,-0.175834,-0.0628281,0.03859,0.213014,-0.408749,-0.166415,0.459286,0.042423,-0.168757,0.523816,0.48825,-0.220456,-0.192303,-0.172951,-0.286864,0.0424921,-0.0742527,0.490322,-0.15695,0.132682,-0.656151,0.00219797,-0.00895697,0.153407,-0.424889,-0.200477,-0.055649,-0.250765,0.107652,0.218551,-0.00757898,0.162661,-0.0814299,-0.347356,0.37096,0.183182,0.278499,-0.0785891,-0.513316,0.165624,-0.116815,0.138967,-0.21149,0.406238,0.287866,-0.0256877,0.022128,-0.00670909,0.455959,-0.254485,0.358843,-0.307063,0.246556,-0.499392,-0.00781908,-0.839719,-0.109609,0.361368,0.108108,-0.251847,0.0485834,0.318922,0.476099,0.328425,-0.032202,0.206645,-0.0915475,-0.00142799,0.524881,-0.291197,-0.0791771,-0.0806095,0.0754279,0.450957,-0.289752,-0.455666,0.278556,0.16939,-0.84513,-0.126611,-0.389997,0.181387,0.167507,-0.437021,-0.256821,-0.0543572,0.0809397,0.129385,0.020394,0.149295,0.136067,-0.232736,-0.128122,0.0599771,0.395074,-0.0739513,0.080056,0.00145357,0.132073,0.52121,-0.407973,-0.176957,0.0370036,0.0503638,-0.352301,0.178517,-0.231237,0.190145,0.457429,-0.208002,-0.0608753,-0.137404,-0.186431,0.288342,0.193716,0.420283,0.646184,0.452187,0.10109,-0.524989,-0.156071,0.278221,0.286516,-0.0222484,-0.192709,0.359215,0.0272396,0.26056,-0.216335,0.589352,0.47208,0.341571,-0.156795,-0.439147,0.645963,-0.0442317,0.0820259,0.400163,-0.666133,-0.105465,0.126263,-0.347439,0.640691,-0.128882,0.263907,0.175678,0.0586172,-0.138663,0.237232,0.160967,-0.258177,-0.136676,0.40805,-0.105232,-0.407204,0.435004,-0.314822,0.383431,0.429896,0.300925,0.347503,-0.413382,-0.364475,0.310377,0.620781,0.191945,-0.0307987,-0.0378123,-0.00438691,0.4746,0.500579,-0.318051,0.179911,0.715242,0.101615,-0.288593,-0.405483,0.310385,-0.114306,0.40345,0.315397,0.559321,-0.0744233,-0.45211,-0.120316,-0.0724242,-0.412497,0.0764857,0.286644,0.116189,0.244246,-0.556831,0.253386,0.12812,0.0743624,0.525288,0.0149578,-0.0261337,-0.356665,0.162727,-0.0437343,-0.210394,0.228257,-0.304478,-0.474364,-0.265301,-0.28032,0.0902828,-0.00638616,0.0564985,-0.0119352,-0.064524,-0.0759819,0.171161,-0.210659,-0.436098,-0.547527,-0.226251,0.154908,-0.0484135,0.292554,-0.302786,-0.17235,0.226482,-0.0972276,-0.0336777,-0.559853,-0.132235,0.138821,-0.280697,-0.226093,0.25673,0.0197378,-0.190474,-0.0171568,0.0967341,0.0980555,0.323335,0.313138,0.568625,-1.10535 +3469.28,0.991728,0.0848144,4,1.60316,0.980481,-0.539236,0.125623,0.364498,-0.0740518,0.215965,0.569516,0.501793,0.409729,-0.426883,-0.28784,-0.785624,0.525766,-0.334447,0.834031,0.0230392,-0.134789,-0.24167,-0.331044,-0.545938,-0.50068,-0.970712,0.0135262,-0.398138,-0.395266,0.538197,0.9045,-0.242786,0.158021,0.810326,-0.179468,-0.146054,0.19695,-0.163424,-0.204993,-0.447232,0.76392,0.4093,0.208401,0.950883,0.364529,0.308725,-1.13493,0.156603,-0.179855,-0.500814,-0.253369,0.291204,0.0345149,0.395309,0.409217,-0.357642,-0.604156,0.723513,-0.396127,0.0356727,-0.850075,0.611972,-0.33912,-0.0522986,0.932268,-0.697005,-0.72494,-0.159372,-0.138657,-0.269778,-0.0462894,-0.14937,-0.530697,0.22851,0.11023,0.464889,0.117837,0.0786038,0.35872,0.1484,0.151563,-0.0205437,0.00388462,0.273791,-0.302958,0.211747,-0.301518,-0.0835569,-0.429658,0.148647,-0.578764,-0.242564,-0.427324,0.726086,0.430678,0.512108,0.0112315,0.336589,-0.230477,0.031901,0.0804925,-0.0290563,0.202102,0.09597,-0.359388,-0.0289205,-0.122928,0.308266,-0.352078,0.164228,-0.0239444,-0.183228,0.316225,0.0929312,-0.0323645,-0.136046,0.389067,0.0645779,-0.0598792,-0.195298,-0.260057,0.278161,-0.155147,-0.972555,-0.302654,0.340783,-0.217593,0.250355,0.241559,0.0563513,0.437789,0.431954,0.00851765,0.29998,-0.11841,0.508743,0.249099,-0.0678664,-0.424828,-0.185426,0.0477889,0.466301,-0.477201,0.0955687,0.120972,0.345092,-0.288162,-0.191064,0.326834,0.299709,0.0643675,-0.22491,-0.393285,-0.174159,0.00479231,0.248641,-0.437006,-0.118744,0.198271,0.00203941,-0.0518425,0.209611,-0.323924,0.0989124,0.181807,0.286183,-0.160981,-0.106551,-0.015664,-0.120969,-0.398912,-0.206201,-0.206286,0.235951,-0.156886,-0.180998,-0.0861436,0.0559981,-0.128985,-0.163966,0.0448498,-0.0745895,0.553803,-0.0993661,0.00394581,0.131526,0.069773,0.0864087,-0.520797,0.0800203,0.196926,0.181034,-0.109101,0.0767698,0.193428,0.287734,-0.545628,-0.119245,0.18765,0.558693,0.140879,-0.231416,-0.188923,0.111728,-0.0718893,0.659968,-0.610217,-0.907206,-0.373635,-0.171134,0.670097,0.0251626,0.378712,-0.244791,-0.240814,0.0962516,0.0798548,0.0250454,0.296611,-0.369093,0.279307,0.414764,-0.0619558,-0.0671253,0.0980744,0.15256,0.486295,0.123213,0.460533,-0.477467,-0.26549,0.192939,0.265522,0.0669622,0.140385,-0.18674,0.300483,-0.207547,0.166072,-0.242607,0.178359,0.316023,0.167643,0.255498,-0.114759,-0.269796,0.120254,0.351301,0.212116,0.482629,0.257475,0.300806,-0.146025,0.0559965,-0.63814,0.670901,-0.283394,-0.188818,0.596272,-0.0236253,-0.179365,-0.0723061,0.244851,0.46753,0.418674,0.0793983,-0.108367,0.0834687,0.0613792,-0.359911,-0.00699707,-0.267628,-0.131278,-0.33933,0.137591,-0.192496,0.298148,0.202303,0.546387,0.272797,-0.0996386,0.154554,0.426604,-0.300295,-0.435947,-0.590984,0.0498109,-0.094602,0.140252,-0.264413,0.318344,0.0442045,0.416279,0.206661,-0.256249,0.00515711,0.376449,-0.139775,-0.372921,0.319197,-0.0309125,-0.474973,0.161467,0.206976,0.0831528,0.239687,0.288362,0.489579,-1.15764 +3439.87,0.990803,0.0848144,4,1.531,1.0525,-0.776488,0.256882,0.394614,-0.255034,0.248949,0.101016,0.508004,0.352269,-0.303797,-0.137713,0.792636,0.320756,-0.312142,1.20285,0.251038,0.0231724,-0.233155,-0.0964735,-0.485958,-0.543889,-0.490134,-0.0903624,0.136813,-0.485224,0.375391,0.0912143,0.234942,0.303005,0.605437,-0.622949,0.405748,0.0207967,-0.328532,-0.414271,0.237344,0.30478,0.312744,-0.869136,1.07626,0.441145,-0.178233,-0.582878,-0.293469,0.239114,-0.283417,0.342641,0.588139,-0.0195618,-0.0496488,-0.0544424,0.385954,-0.0833681,0.659001,0.350977,-0.290209,-0.732778,0.469166,-0.375317,0.0467027,0.94568,-0.842834,-0.826079,-0.345624,0.512073,-0.0160288,-0.235789,-0.101701,0.237349,0.143307,0.307537,0.600422,0.453686,0.170235,0.222792,-0.165041,0.236377,0.00708229,0.0619099,-0.130874,0.238742,0.37256,0.312396,-0.117978,-0.00508424,-0.396503,-0.460005,-0.0395153,-0.053577,-0.451308,-0.0820687,-0.316071,-0.118469,0.366381,-0.157267,-0.697027,-0.130915,0.239635,-0.0647644,0.358368,0.0333511,-0.389737,-0.197257,0.384884,-0.0903624,0.267463,-0.336112,0.558163,0.561332,-0.392734,-0.357416,0.533377,0.204008,0.138504,-0.0772233,0.509905,0.156599,-0.128576,-0.362481,-0.107031,-0.185072,0.417754,0.206999,-0.4296,0.0373583,0.252108,0.0272241,0.238484,-0.550078,-0.391886,0.190101,0.388594,0.161307,-0.137666,-0.288674,0.157751,-0.228521,0.388676,-0.534528,-0.459293,0.030624,0.227697,-0.341408,-0.174384,0.145487,-0.103634,0.217408,-0.308364,-0.1453,-0.0682721,0.275192,-0.0372122,0.160405,-0.27635,0.26472,0.334126,0.4521,-0.0297647,0.611847,0.0101079,-0.043739,0.668312,0.356563,0.0972174,0.377963,-0.310624,0.0376295,-0.204508,0.238076,0.382202,0.0575615,-0.0523391,-0.268595,-0.318527,0.15666,-0.469736,0.250144,-0.0863593,0.623359,-0.0467607,-0.194039,-0.00555218,-0.194275,-0.180993,-0.133637,-0.268241,-0.156767,0.205824,-0.531795,0.0876767,0.155235,-0.337591,-0.174997,0.506368,0.615047,0.0424672,-0.279263,-0.804881,0.307616,0.0368084,-0.619416,0.205809,0.192222,0.244066,-0.111728,-0.548465,0.785652,-0.378475,-0.40984,0.0539668,-0.180805,0.664046,0.059887,-0.128632,-0.0647088,-0.365789,-0.171224,0.18764,-0.120223,0.254026,-0.440597,0.0974048,0.233308,-0.109288,0.167863,0.0811877,-0.167368,0.535849,-0.105925,0.183987,-0.172652,-0.320223,-0.538224,0.0762538,0.233182,0.629103,-0.0534511,0.366277,-0.439595,-0.0637497,0.00917328,0.145072,0.174193,0.671491,0.0424291,0.293599,0.174167,0.311927,-0.355528,-0.52352,0.177619,0.169615,0.460263,-0.0282168,0.0255057,0.128843,-0.0518991,0.250097,-0.10081,-0.48345,0.345129,0.110982,-0.103514,-0.094457,0.191196,0.20353,0.0784203,-0.149631,0.369191,-0.23192,0.041696,0.0181911,-0.113054,-0.354688,-0.334034,0.0197472,0.138417,-0.148919,0.0890581,-0.342862,-0.0436352,0.0323517,0.132291,0.0166329,0.340305,0.17478,0.0685234,0.270536,-0.493503,-0.1137,0.770639,0.0633349,-0.162942,-0.410443,-0.545978,0.293893,0.0703403,0.0587592,-0.213671,0.208951,0.0899288,0.203939,0.299881,0.451596,-1.41167 +3448.4,0.923815,0.0848144,4,1.54391,0.952757,-0.920098,0.395339,-0.0795844,-0.115395,-0.00964394,0.228851,0.426647,0.378173,0.0591469,-0.172293,-0.456151,0.29042,0.174601,1.19034,0.0197232,0.255725,-0.0657727,0.448452,0.0138725,-0.686148,-0.791114,0.136087,0.0746954,0.236662,0.690315,0.626236,0.0545133,0.323262,0.73589,-0.709372,-0.151641,0.128643,-0.328545,-0.552338,-0.273785,0.766705,0.584031,-0.155615,1.16723,0.680932,0.19627,-0.754369,-0.209792,-0.0504917,-0.766882,0.177012,0.46235,-0.291869,0.0703447,0.318267,-0.00875981,-0.733535,0.43549,-0.582414,0.291771,-0.623135,0.316338,-0.146413,0.27337,0.57001,-0.534793,-0.445252,0.318595,-0.234757,0.433362,0.0895973,0.427512,-0.6855,-0.0946853,0.00698042,0.883645,-0.0302036,0.363854,0.736793,0.3802,-0.0583344,-0.402512,-0.279873,0.145203,-0.496395,0.168596,-0.0522972,-0.636487,-0.217645,0.547957,-0.301683,-0.389892,-0.306242,0.301842,0.550936,0.177007,-0.406305,0.49043,-0.130674,-0.0248978,-0.104166,0.275767,0.0514846,-0.0925523,-0.389967,-0.493993,-0.000304266,0.657785,-0.196163,0.36879,-0.488041,0.333176,0.461072,-0.356409,-0.60927,0.187027,0.258082,-0.241577,-0.00210065,-0.382684,-0.229372,0.407426,0.118689,-0.622465,-0.124097,0.471131,-0.317551,-0.100402,-0.375179,0.265463,0.438623,0.176674,-0.762025,-0.0351584,-0.0458235,0.0675175,0.387434,-0.381353,-0.489376,0.141308,-0.208147,-0.300122,-0.229347,-0.623208,0.371941,-0.539199,-0.24145,-0.400312,0.119403,-0.247957,0.180807,0.11932,0.693769,-0.17416,0.214869,-0.249381,-0.103993,0.184068,0.355668,0.180724,-0.0632378,-0.0828993,0.00729661,0.276421,-0.0122204,0.728295,-0.172985,-0.138013,0.360084,-0.242778,-0.313003,-0.394264,0.14212,-0.0917447,0.032949,-0.368928,-0.128121,-0.576117,0.0718864,-0.536991,0.0565404,-0.20222,0.650815,-0.0646848,-0.555953,0.377062,0.0405338,-0.408946,0.102336,-0.209815,-0.161841,0.373572,-0.145227,0.423827,-0.0667277,-0.250564,-0.157562,-0.376935,0.0326483,0.1196,-0.399438,-0.145192,0.193509,-0.0114433,-0.105352,0.391205,-0.273111,-0.183316,-0.049903,-0.281344,1.06055,-0.133909,0.157901,0.193155,-0.317036,0.436147,-0.419446,0.0457583,0.014122,-0.279487,-0.120616,0.739115,-0.510095,-0.403569,-0.3359,0.243241,-0.287541,-0.16643,0.277852,-0.740181,0.276391,-0.1755,0.0855064,-0.151517,-0.00328146,0.00145322,-0.0174802,-0.6467,0.31631,0.188438,0.228111,0.874503,-0.425394,-0.28675,0.166525,0.0270919,0.290942,0.0226831,0.557636,0.545954,0.0630448,-0.194732,-0.0345446,-0.150857,-0.819468,0.561852,-0.243118,0.123272,-0.244489,-0.0527674,-0.2157,0.438773,0.223418,0.0151077,0.0233722,0.214734,0.170164,-0.210299,0.0161645,0.0763813,0.38142,-0.498968,0.188102,-0.125846,0.593759,-0.383042,0.108851,-0.128468,-0.226046,0.0287727,-0.261036,0.668074,-0.0284533,0.270761,0.346988,0.074818,-0.324237,-0.121936,0.28832,0.191155,0.0290384,-0.318923,-0.598358,-0.00646381,-0.244083,-0.176072,0.0569592,0.133375,-0.233939,-0.0130707,0.404131,-0.290602,0.0939471,-0.117751,0.113679,0.19846,0.337163,0.445488,0.261045 +3451.64,0.99902,0.0848144,4,1.60306,0.878586,-1.09804,0.498466,0.0640722,-0.304707,-0.086044,-0.0319575,0.419951,0.143555,-0.262857,-0.0923146,-0.307977,0.499436,-0.000402061,0.771864,0.312323,-0.246529,-0.252488,0.128569,-0.00877414,-1.09019,-0.758671,0.246608,-0.0541858,-0.215167,0.0354136,-0.410907,-0.0625595,0.190316,0.738076,-0.601606,0.0874892,0.0123334,-0.348079,-0.505941,-0.663945,0.148938,0.351703,-0.500995,1.04041,0.788498,-0.000135737,-0.878993,-0.677906,0.0685136,-0.737643,0.492124,0.186093,-0.0812364,-0.0196039,0.305659,0.0939004,-0.176658,0.103281,-0.83308,0.0330023,-0.612073,0.243453,-0.575989,0.251553,0.758028,-0.223,-0.374947,0.473039,-0.0923133,0.244497,0.0666822,-0.198282,-0.475895,-0.159624,0.472194,0.536799,0.278945,0.636076,-0.0150321,0.374602,0.161202,-0.733443,0.0678837,0.0150707,-0.337101,0.239628,-0.0936387,-0.666826,-0.249029,0.375614,-0.271255,0.198268,-0.189233,0.0248753,0.207592,-0.0328546,-0.343086,0.375797,0.288828,-0.000884111,-0.0803692,-0.434237,0.0179521,-0.642331,-0.336354,-0.303561,-0.374855,0.323186,0.311433,0.719311,-0.0957606,0.376447,0.549527,-0.343554,-0.579129,0.306638,0.367132,-0.0217965,-0.34951,-0.122294,-0.403704,0.311047,0.231692,-1.06493,-0.61036,-0.120937,-0.167266,0.386729,-0.481042,0.024864,-0.0669294,0.300062,0.130195,0.37038,0.000215679,0.321607,0.64767,-0.184548,-0.278962,0.0672898,0.0511142,0.183479,-0.26008,-0.188766,-0.0996768,0.075796,-0.436091,-0.0215291,-0.492286,-0.0274123,-0.0511704,0.0327004,0.150446,-0.293205,0.182299,-0.309754,0.266831,0.333768,0.830044,0.0231505,-0.272653,-0.0610598,-0.0443516,0.412187,-0.330742,0.434798,-0.0894347,-0.794164,0.217751,0.0276614,-0.391766,-0.120741,0.0237863,0.19462,0.167573,-0.052463,-0.157874,-0.527453,-0.164715,-0.467055,-0.341258,-0.121695,0.71989,-0.222057,-0.24523,0.271848,0.226785,-0.0912072,0.179771,-0.597364,-0.309282,0.124638,-0.468291,0.144459,0.131996,-0.492975,-0.234197,0.3166,0.162308,-0.166372,-0.731774,-0.500247,0.554221,-0.208007,-0.511412,0.0712764,0.202403,-0.488145,-0.424232,-0.447462,0.921591,0.246232,0.315619,0.365359,-0.416477,0.358565,-0.68945,0.195612,0.0738841,-0.718127,-0.354564,0.17216,-0.525356,-0.097943,-0.031579,0.212869,0.0859888,0.120325,0.395031,0.00698122,-0.136835,-0.244915,-0.0723337,-0.481279,-0.111724,-0.151996,-0.429335,-1.07448,0.279722,0.310226,-0.336441,0.354046,-0.405631,-0.4971,0.346896,0.431301,-0.1635,0.217774,0.199634,0.665068,0.344331,0.0443101,-0.0848449,-0.0297915,-0.274523,0.676535,0.0568641,-0.13326,0.47243,-0.19436,-0.129201,0.0554451,0.290136,0.497387,0.0885306,0.144926,0.376172,-0.0536399,0.271608,0.133579,0.289811,0.167743,0.0743961,-0.23287,0.37651,-0.123624,0.0738951,0.124156,0.355824,-0.156842,0.0652822,0.298475,-0.0674752,0.264066,-0.321001,-0.324938,-0.106036,0.499987,-0.0968803,0.0332778,0.0293624,0.0516939,-0.130408,-0.0224034,0.227993,-0.299362,0.166218,-0.217989,-0.428072,0.0256006,0.185559,0.0123204,-0.139566,0.0245669,0.121234,0.26267,0.348187,0.512513,0.0174285 +3447.69,0.731338,0.0848144,4,1.58422,0.874014,-0.978177,0.395659,0.0738702,-0.178446,0.0126294,0.14377,0.302511,0.0159796,-0.18212,0.157097,-0.0145232,0.604845,-0.278376,0.891389,0.372603,0.0416944,-0.315586,0.107758,-0.15025,-0.824302,-0.970194,0.0372587,0.0366629,-0.251356,0.139332,-0.363908,0.124152,0.173436,0.75926,-0.470617,-0.090281,0.133822,-0.532435,-0.428651,-0.391546,-0.189275,0.54138,-0.46519,0.95848,0.747208,-0.0314308,-1.08695,-0.368035,0.126759,-0.712594,0.179035,0.243577,-0.124076,-0.145942,0.410513,0.0080894,-0.459416,0.467032,-0.594739,0.179435,-0.44155,0.381853,-0.155943,0.0194246,0.575495,-0.0477998,-0.310956,0.485814,-0.116039,0.0523373,-0.423282,0.109268,-0.261398,-0.24539,0.358835,0.519344,0.161416,0.404555,0.396955,0.596873,0.36323,-0.230281,-0.0747064,0.444903,-0.692718,0.371483,-0.281134,-0.708975,-0.0646077,0.0300415,-0.211877,0.0432196,0.011843,0.165821,0.134302,-0.295491,-0.200943,0.358026,0.497112,0.0479716,-0.301756,-0.825124,0.0193042,-0.501993,-0.0612056,-0.20975,-0.357396,0.323423,0.246408,0.586032,-0.234017,0.243923,0.52724,-0.258328,-0.572502,0.274593,0.228603,0.488562,-0.103137,-0.112426,-0.270541,0.289724,-0.133077,-0.576225,-0.590483,-0.0248834,-0.258123,0.10165,-0.290239,0.0348615,-0.101417,0.415625,-0.134931,0.62057,-0.108447,0.316361,0.183191,0.0347725,0.0568701,-0.277762,-0.17087,0.00768075,-0.258039,-0.451389,0.164256,0.140553,-0.464597,-0.0300612,-0.0961388,-0.0212375,0.0762347,0.319683,0.377019,-0.161028,0.0777246,-0.308958,-0.0672111,0.498466,0.96555,-0.0747988,-0.157602,-0.059377,-0.00508411,0.393668,-0.440204,0.270683,-0.00124854,-0.393646,0.0592971,-0.127392,-0.0112722,-0.114846,0.469115,0.349101,0.19287,-0.136489,-0.160368,-0.550022,0.00297869,-0.182205,-0.19924,-0.0738632,0.768494,-0.2728,-0.203036,0.210175,0.177326,-0.106193,0.172374,-0.107438,-0.273245,-0.029318,-0.171261,0.129078,0.180173,0.0420035,-0.513149,0.551313,0.0423013,-0.0926111,-0.662595,-0.689014,0.0600039,-0.133557,-0.553867,0.423214,0.172755,-0.521877,-0.260794,-0.461219,1.04728,0.926053,0.556736,0.411399,-0.246255,0.60959,-0.52928,-0.303286,0.392368,-0.697334,-0.137699,0.0906513,-0.198684,-0.114798,-0.0102938,0.272003,0.192645,0.0659532,0.530483,0.148259,0.122536,-0.291706,0.045873,-0.507024,-0.0749391,0.179243,-0.488187,-0.865984,0.364158,-0.0950961,0.0103693,0.402232,-0.333379,-0.482662,0.143479,0.525445,0.027155,0.605652,0.120505,0.694993,0.0510842,0.033614,-0.26695,-0.0027127,-0.460706,0.488011,-0.22779,-0.0392011,0.311745,-0.477001,-0.167598,0.305469,0.28014,0.541073,0.238164,0.274264,0.516663,0.0991252,0.153768,0.0494299,0.0366783,-0.011699,0.0511502,-0.471439,0.0570986,-0.244183,0.187357,0.111855,-0.169854,-0.0665143,-0.100076,0.00810305,-0.173121,0.495807,-0.184609,-0.112548,0.134105,0.36696,-0.0521467,0.010824,-0.174761,0.149221,-0.143685,-0.0669547,-0.0743836,-0.509422,0.0367605,-0.350149,-0.241823,-0.0634676,0.455603,-0.217502,-0.100173,0.245513,0.0994755,0.242967,0.315397,0.492917,-0.0228961 +3413.74,0.681958,0.0848144,5,1.62292,0.802057,-0.70461,0.354957,0.0805413,-0.102266,0.0217789,0.0673582,0.517393,-0.0238002,-0.28372,-0.587394,-0.260857,0.489361,0.190504,0.859208,0.488761,-0.333667,-0.326637,0.457731,0.178323,-0.741901,-1.21918,0.439265,0.101414,-0.0750583,0.186412,0.232235,-0.200625,0.00774388,0.618538,0.0304421,0.0951179,0.238164,-0.103693,-0.367677,-1.2191,0.625993,0.269993,0.214214,0.983475,0.326282,0.250159,-0.580472,-0.383645,0.252653,-0.260081,-0.0562138,0.115728,-0.362069,-0.0342116,0.171717,-0.0686096,-0.255902,0.624296,-0.157309,-0.0947513,-0.536585,0.0499805,-0.622108,0.250842,0.60442,-0.429877,-0.952062,0.535105,0.760021,0.165566,0.297192,0.0135366,0.285968,-0.451361,0.289302,0.59207,0.50602,0.562625,0.0897564,0.173538,0.0180439,-0.534988,0.0450567,0.713448,0.126977,0.25266,-0.194268,0.00559878,-0.0814843,-0.165057,-0.697636,0.344525,-0.153964,0.558452,-0.45656,0.20878,-0.321911,0.298993,0.451967,0.0283268,-1.00711,-0.625334,0.144382,0.0799265,-0.236126,-0.142729,0.000123912,-0.0417515,-0.00987853,-0.452191,0.201999,0.304225,0.352174,0.0448618,-0.185215,-0.0917755,0.105068,0.1025,-0.236635,-0.134045,-0.239109,0.1971,0.429312,-0.306558,-0.234505,0.0435122,-0.631508,-0.0068809,0.133211,0.45909,0.106137,0.660199,-0.296408,-0.741016,0.0605929,0.270113,0.690017,-0.0781225,-0.382817,-0.47856,-0.109448,0.306343,-0.592056,-0.139862,0.0178191,0.133463,-0.0637424,-0.0625672,0.411721,0.1968,0.327886,0.0392651,-0.0709532,0.100294,0.374151,-0.00712226,-0.218292,0.164633,0.482534,-0.357753,-0.318343,-0.240609,-0.614761,0.539419,0.383532,0.801942,-0.116078,-0.943665,-0.101422,-0.133102,-0.0321206,-0.200278,-0.0801254,-0.0554471,-0.41042,-0.212806,-0.139503,-0.362864,-0.0379717,-0.373451,-0.221253,-0.121763,0.916937,-0.537492,-0.484246,-0.273741,-0.0620423,-0.00395399,0.345788,0.472262,-0.11518,0.0792984,0.0232635,0.310077,-0.0295954,-0.119943,-0.619101,-0.0355458,-0.0827191,-0.0692221,-0.232442,-0.190694,-0.246215,-0.0428508,0.0153728,-0.0155602,0.14794,0.547298,-0.344971,-0.252555,1.08909,-0.0979682,0.58976,-0.0719141,-0.875416,0.170084,0.450681,0.0422717,-0.0461169,0.22995,0.0870273,0.105377,0.132409,-0.534022,-0.376822,0.372512,0.535198,-0.192891,0.387323,-0.253531,-0.210192,-1.11576,0.152541,-0.362836,-0.224209,0.278169,-0.26658,-0.448737,0.373721,0.00742677,0.339984,0.289568,-0.935369,-0.550133,-0.323037,0.14705,0.233603,0.344605,-0.0585747,0.501084,0.528206,-0.154314,-0.0713966,-0.265321,-0.238261,-0.175968,0.206863,0.300973,0.0107425,-0.171877,-0.030992,0.341477,0.346718,0.417296,0.0881641,0.317493,0.22173,0.227682,0.0832698,0.12409,-0.238633,-0.186075,0.258326,-0.240234,-0.101963,-0.269515,-0.355056,-0.353989,-0.28641,0.00691541,0.331216,0.544084,0.204703,-0.191763,0.164896,-0.421768,0.518247,-0.00765205,0.061752,0.169803,0.24848,-0.271713,-0.202195,-0.191471,0.0151368,-0.609556,0.25985,-0.0528415,0.108976,-0.119017,-0.255052,-0.703586,-0.74489,-0.197237,0.135208,0.205732,0.367707,0.453576,-0.00330489 +3419.59,0.842892,0.0848144,4,1.51276,0.812791,-0.895316,0.336051,0.277936,-0.114407,0.0985334,0.175276,0.266953,0.00427752,-0.103782,-0.531145,0.0339719,0.385364,-0.113415,0.535122,0.640546,0.0182172,-0.376278,0.198553,0.0569132,-0.775994,-0.48628,0.0534984,0.152456,-0.0165239,0.125472,-0.0699968,0.0683615,-7.02141e-05,0.856794,-0.160376,-0.252997,0.157452,-0.046894,-0.352435,-0.713123,0.496461,0.786012,-0.309636,1.06524,0.429694,0.120795,-0.532643,-0.198956,0.498386,-0.440601,0.310596,0.242612,-0.0521628,0.28073,0.241319,0.0477129,0.0321565,0.720979,0.0431881,0.319196,-0.598847,0.675469,-0.266347,0.0667164,0.86766,0.0301189,-0.928938,0.550784,0.642074,0.242216,0.393829,-0.231249,0.106695,-0.452178,0.254951,0.589277,0.577557,0.535466,0.174443,0.394385,-0.193637,-0.62106,-0.156892,0.469004,0.0075162,0.517025,-0.618918,-0.191337,0.329202,-0.163974,-0.333253,0.255097,0.107797,0.360066,-0.596643,0.610107,-0.180734,0.42927,0.0745169,0.110271,-0.905524,0.282749,0.302701,0.235592,-0.423556,-0.576435,-0.181646,-0.439971,-0.331658,-0.130035,0.25009,0.188593,0.293947,-0.0789828,-0.0455493,0.0946593,0.232999,0.762153,-0.138566,0.129517,0.168254,0.415637,0.107866,-0.425897,-0.150834,-0.288615,-0.361562,0.476404,-0.0388436,0.373088,0.084429,0.746406,-0.219315,-0.801892,0.0372701,-0.0420373,0.6737,0.0539733,-0.28531,-0.206429,0.012183,-0.0933772,-0.463003,-0.163245,0.0681289,-0.225029,-0.318955,0.0649442,0.664307,0.0341876,0.541211,0.0946162,-0.227697,-0.20667,-0.263942,0.32392,0.0118009,0.119267,0.0274712,-0.299104,-0.15804,-0.0501338,-0.698494,0.00785008,0.396734,0.601406,-0.200641,-0.710391,0.124497,-0.0827298,0.0779589,0.217514,0.152172,-0.255969,-0.132156,-0.122032,-0.189735,-0.11787,-0.127381,-0.27376,0.0082412,-0.193237,1.02325,-0.245499,0.00300284,-0.0454198,0.279299,-0.0977149,-0.00550604,0.447444,0.103034,0.0907557,0.192197,0.154805,0.357193,-0.250026,-0.682022,0.187225,0.110984,0.073756,-0.709028,-0.230116,-0.345448,0.140605,-0.375833,0.173301,0.0641313,0.0798304,-0.205075,-0.159799,1.06777,-0.269388,0.59407,0.200531,-0.587292,-0.309001,0.334462,-0.100103,-0.442756,-0.536437,0.0644845,0.452796,0.301462,-0.525299,-0.335523,0.0530104,0.41044,-0.417329,0.581275,-0.168547,-0.233797,-0.892848,-0.227906,-0.134835,0.0267752,0.296594,-0.683236,-0.360048,0.221745,-0.296313,-0.0652234,0.53462,-0.839488,-0.552253,0.00335499,0.292146,-0.0611004,-0.169739,-0.355021,0.462726,0.460076,0.295401,0.21147,-0.144668,-0.320317,0.0741398,-0.155013,0.581225,0.215453,-0.279173,-0.103713,0.188535,0.173744,0.539912,-0.151689,0.00119273,0.104795,0.192427,0.134355,-0.130913,0.0860053,0.221923,0.0831583,-0.639967,0.219847,-0.219631,-0.672351,-0.0996394,-0.255044,-0.410276,0.400515,0.610889,-0.13898,-0.29092,0.25872,-0.289571,0.541686,0.283035,-0.153315,-0.0546053,0.0455691,0.0410961,-0.171411,0.0906695,-0.0253562,-0.384364,0.308607,-0.0822564,-0.21504,-0.300402,-0.170608,-0.628522,-0.213046,-0.128822,0.121106,0.199619,0.348003,0.446787,-0.666586 +3419.05,0.965699,0.0848144,4,1.65754,0.944081,-0.550371,0.20751,0.272232,-0.100429,-0.350256,0.209853,0.0946849,-0.0223252,-0.29102,-0.391088,-0.154977,0.136988,-0.164472,1.10619,0.196349,-0.185384,0.154099,0.0454567,0.0643238,-0.539256,-0.670381,-0.225193,-0.0745468,0.0389731,-0.0523716,-0.0696595,-0.0681789,0.342603,0.425773,-0.258442,0.205653,0.0106614,0.0496756,-0.18232,-0.387593,0.699176,0.209405,-0.382154,1.09603,0.38303,0.105978,-0.679112,-0.298737,-0.340834,-0.818614,0.208588,-0.0397483,0.0627666,-0.0815041,-0.0266334,0.35748,-0.59327,0.504986,-0.714828,0.205071,-0.671137,0.310276,-0.279956,0.352132,0.327492,-0.146091,-0.932165,0.435469,0.665059,-0.138067,0.248285,0.238322,-0.600042,0.00775486,-0.00335406,0.735837,0.321102,0.415245,0.00137052,0.510907,0.0753012,-0.0619713,-0.147729,0.510631,-0.228429,0.567513,-0.147366,-0.11395,0.0272277,0.575073,-0.346519,-0.0962925,0.218982,0.202035,-0.322765,-0.0492639,-0.029827,0.653413,0.426285,0.493926,-0.251465,0.484164,-0.323548,-0.380228,-0.580095,0.349646,-0.594939,0.0474854,-0.388576,0.103477,-0.196738,0.150422,0.722532,0.10197,-0.228438,0.594124,0.483347,0.188579,-0.0137292,0.00305178,-0.195974,0.438767,0.0142054,-0.375609,-0.286963,-0.175722,-0.557766,0.244958,0.479782,0.763414,0.175922,0.350108,0.51779,0.137717,0.188718,0.0245968,0.619826,-0.287881,0.164279,-0.501617,-0.312094,0.325944,-0.774387,-0.555802,0.381783,0.151565,0.185869,0.252326,0.254302,-0.476452,0.275674,0.298061,0.0439718,0.125047,0.30121,-0.450983,-0.320357,0.155051,-0.201415,-0.0689171,-0.337604,-0.462957,0.0360428,0.0462056,-0.236501,1.06733,0.243874,-0.374562,0.0181174,0.427275,0.0395226,-0.47529,-0.171997,0.0768534,0.59976,0.141543,-0.627075,-0.431727,0.0358761,-0.0296123,0.131499,-0.0734864,0.844397,-0.44612,0.166056,-0.51512,0.107324,-0.182999,0.559949,-0.397696,-0.197667,0.290351,-0.357784,0.368312,0.253659,-0.576932,-0.574267,0.107037,0.0480442,-0.0401651,-0.378098,-0.848848,0.454724,0.22148,-0.488972,-0.0476048,-0.290226,-0.320338,0.291731,-0.580863,1.13935,-0.094761,-0.0223701,0.367581,-0.131994,-0.391059,-0.116635,-0.147202,0.100463,0.0406064,0.138335,0.532141,-0.687515,-0.101178,-0.213456,0.591062,0.461462,-0.837115,0.582004,-0.48321,-0.414919,-0.960497,-0.199559,-0.684262,0.215413,0.120201,-0.6126,-0.464427,0.157041,0.0342681,0.0530991,0.830717,-0.515851,-0.426085,-0.0940626,-0.126255,-0.120211,0.629044,0.337329,0.695691,0.692271,-0.0618607,0.106385,0.490711,-0.454684,-0.0433507,0.00176657,-0.41156,0.237532,-0.293731,0.251479,0.591512,0.487135,-0.126034,0.621071,0.110798,0.0605432,-0.30284,0.0412498,0.336379,0.0961849,-0.262624,0.187305,-0.792403,-0.332765,-0.514818,-0.469828,-0.0557116,-0.581788,0.0860166,0.166762,0.558526,0.232873,0.287538,-0.644855,-0.430528,-0.217385,0.568217,0.261041,-0.235073,0.292313,0.129852,-0.169074,0.107838,0.00555948,-0.0540441,0.196906,-0.56773,-0.902945,-0.387289,0.294986,-0.405954,-0.515789,-0.635031,0.155483,0.155318,0.394313,0.394104,-0.797815 +3406.91,0.990813,0.0848144,4,1.57056,0.919975,-0.583026,0.223502,0.391827,-0.141357,-0.61034,0.406083,0.165574,-0.000914235,-0.0542707,-0.534243,-0.0165987,-0.0201368,-0.236483,0.809251,0.301614,-0.215559,0.285953,-0.0255262,0.0382554,-0.511153,-0.787702,-0.214796,0.131288,-0.128597,-0.117562,0.0805445,-0.309424,0.307484,0.340212,-0.473927,0.0269498,0.120763,-0.158837,-0.279971,-0.322179,0.612379,0.253729,-0.451635,1.11567,0.247746,-0.0112562,-0.850589,-0.389259,-0.567106,-0.536123,0.17163,-0.0480857,0.208095,-0.26385,0.118096,0.283959,-0.827638,0.505867,-0.600537,0.279663,-0.444797,0.344714,-0.305121,0.48234,0.310707,-0.0157767,-0.880722,0.375062,0.455547,-0.108261,0.247165,0.189362,-0.526849,0.17913,-0.00608138,0.647195,0.386238,0.354672,-0.0997055,0.47776,0.138243,-0.115,-0.153113,0.493617,-0.114586,0.592159,0.0832228,0.203703,-0.0217952,0.553292,-0.346877,-0.117255,0.188192,0.284283,-0.299357,0.137065,-0.125518,0.910477,0.372623,0.320635,0.190468,0.115386,-0.385038,-0.513597,-0.403861,0.275413,-0.681478,-0.00819804,-0.257109,0.279948,-0.252117,0.0731468,0.799421,-0.0501798,-0.0237308,0.683738,0.415006,0.151326,-0.00658285,0.110839,-0.0153379,0.0397285,-0.104648,-0.257772,-0.388361,-0.346996,-0.538993,0.358258,0.244601,0.649121,0.281454,0.211494,0.487603,0.299911,0.194911,0.0283686,0.64772,-0.353816,0.205735,-0.618595,-0.306579,0.274953,-0.791137,-0.33453,0.372154,0.339924,0.197214,0.035497,0.32385,-0.357385,0.250275,0.458329,-0.0779332,-0.00174614,0.161239,-0.39377,-0.401774,0.0910468,-0.394062,-0.0720808,-0.196027,-0.476693,0.0800174,-0.00789279,-0.428637,0.95121,0.340211,-0.671518,-0.0310255,0.159839,0.0865578,-0.288653,-0.18252,-0.220174,0.192106,0.18207,-0.535889,-0.276413,0.172693,0.0311974,0.00197364,-0.110845,0.67585,-0.161818,0.178654,-0.293214,-0.0370729,-0.0199509,0.216926,-0.423943,-0.349007,0.169141,-0.313504,0.312528,0.387084,-0.482266,-0.457376,0.145316,-0.0249655,-0.173951,-0.559543,-0.94191,0.286217,0.222062,-0.514429,0.0154158,-0.392784,-0.064842,0.386027,-0.430583,1.24116,-0.0310837,-0.0718669,0.368012,-0.135756,-0.291008,-0.231419,-0.309633,0.140579,-0.0633066,0.0252432,0.454153,-0.714951,-0.110021,-0.23321,0.553897,0.59547,-0.774707,0.634532,-0.3729,-0.438712,-0.652394,-0.0317572,-0.762605,0.123231,0.186512,-0.426337,-0.39745,0.0710138,-0.0662906,0.19084,0.777078,-0.278948,-0.2392,-0.134631,0.0283694,-0.229734,0.866906,0.295915,0.622634,0.640276,-0.00488546,0.0874223,0.37986,-0.604395,0.00558283,-0.0759298,-0.414685,0.270773,-0.298137,0.231733,0.421363,0.556093,-0.0872403,0.40344,-0.142724,0.120603,-0.196849,0.0386211,0.0647226,0.403784,-0.228094,0.10074,-0.716834,-0.265691,-0.12866,-0.569529,-0.117514,-0.447131,0.180496,0.175994,0.826389,0.427365,0.0148422,-0.688798,-0.607278,-0.253219,0.638665,0.441532,-0.309879,0.0943713,0.325007,-0.25589,0.120087,0.0713115,-0.303133,0.156321,-0.569309,-0.999534,-0.605245,0.352446,-0.436556,-0.171405,-0.326654,0.16997,0.157042,0.412275,0.396285,-1.22698 +3410.52,0.996061,0.0848144,4,1.63628,0.901927,-0.419801,0.154592,0.530232,-0.115613,-0.370112,0.216751,0.0352026,-0.548385,0.055344,-0.395037,-0.339787,0.0639535,-0.244683,0.618342,0.375356,-0.315515,0.566763,0.193917,-0.156818,-0.716167,-0.975783,-0.416991,0.172489,-0.263257,0.0806924,0.4675,-0.457258,0.102785,0.376371,-0.35827,-0.0345255,-0.104764,0.159907,-0.165659,-0.565204,0.537458,0.372398,-0.221385,1.25111,0.471823,-0.218175,-0.632833,-0.0452035,-0.121753,-0.419665,0.0422708,0.0851003,0.175205,0.00338698,-0.0741533,0.000637224,-0.716414,0.663427,-0.477922,-0.0451301,-0.858492,0.589949,-0.0661943,-0.0362378,0.785559,-0.384047,-0.621193,0.508265,0.557621,-0.103498,0.219901,0.372959,-0.0990966,0.495738,0.0194763,0.945423,0.207277,0.256208,0.419609,0.233101,-0.00875917,-0.132478,-0.0629622,0.474418,-0.236501,0.70662,-0.223696,0.381028,0.212861,0.138492,-0.669763,-0.433267,0.182288,0.113084,0.268954,0.293094,-0.0992886,0.162275,-0.0160783,-0.187156,-0.189635,-0.221881,-0.238915,-0.356971,-0.621304,0.0652834,-0.701622,0.196544,-0.515993,0.0526317,-0.0227074,0.158053,0.788617,0.0978932,-0.294748,1.16952,0.386823,0.324863,0.0394261,-0.0993006,0.157279,0.0914814,0.221028,-0.753317,-0.35298,-0.367223,-0.572106,0.546468,0.46056,0.918884,0.551311,-0.088725,0.499336,0.62973,0.554391,0.0681472,0.257235,-0.450823,0.0436521,-0.126093,-0.1409,-0.0791723,-0.802519,-0.3449,0.29598,0.560962,-0.0235213,0.268557,0.664958,-0.161308,0.206598,0.40663,-0.312934,0.0229696,0.34453,-0.112358,-0.441575,0.645135,0.00605003,-0.023552,-0.375588,-0.352291,0.00287923,0.0492809,-0.335176,0.551938,0.153014,-0.487364,-0.538276,0.131709,0.0104443,-0.0454547,-0.537405,-0.119976,0.0823119,0.0558834,-0.0458035,0.0618926,0.11245,-0.101769,-0.393651,-0.330928,0.247411,-0.132665,-0.340811,0.184864,0.0261375,-0.130626,0.122598,-0.149502,-0.156987,-0.159324,0.249946,0.344851,0.463719,-0.0297614,-0.411416,0.0614252,-0.0331662,0.0215475,-0.393639,-0.874513,0.152476,0.50026,-0.509161,0.344228,-0.0962194,-0.130228,0.682674,-0.328412,1.21646,-0.193571,0.568251,0.289537,-0.200204,-0.251682,0.012059,0.176769,0.449641,0.313198,-0.137257,0.340839,-0.217823,0.101951,-0.635211,-0.220053,0.189869,-0.0445768,0.686455,-0.233646,-0.248182,-0.10531,0.394509,-1.15432,0.0892092,0.201342,-0.237464,-0.480206,0.195492,-0.484105,0.210484,0.824428,-0.392893,-0.391718,0.0822749,-0.0635165,-0.574527,0.888693,0.304641,0.207281,0.403254,0.499028,0.0208531,0.560907,-0.239224,-0.185477,-0.181367,-0.389149,-0.0281768,-0.00590383,-0.157299,0.519076,0.55744,0.243042,0.342013,-0.122328,-0.230051,0.0806424,0.645933,0.393964,0.225548,-0.497524,0.576148,-0.316955,0.0348855,-0.123832,-0.405219,-0.091273,0.232001,0.0611696,0.0797065,0.539526,0.128708,0.214911,0.0514713,-0.749933,-0.233221,0.543759,0.109281,-0.0820361,0.285648,0.28416,-0.496143,0.248397,0.0172203,-0.316688,-0.253809,-0.616544,-0.895531,-0.285749,0.0925545,-0.704038,0.368406,-0.48466,0.14021,0.175689,0.374446,0.419153,-1.61567 +3406.56,0.953691,0.0848144,4,1.49333,0.917258,-0.165943,0.131102,0.772812,-0.122843,0.072702,0.227259,0.414444,0.531728,0.66086,-0.109945,-0.424622,0.150817,-0.594168,0.867099,0.263996,0.317765,0.15512,0.248198,-0.0135599,-0.763977,-0.522007,0.0222107,-0.310296,0.222815,0.525342,0.162912,-0.378671,0.00157531,0.858367,0.0939927,0.341559,0.343161,-0.401465,0.0163195,-0.584438,0.216365,0.395081,-0.220519,1.02561,0.127446,0.450248,-0.479795,0.0175851,-0.0525307,0.0649088,0.387742,0.302947,-0.239401,-0.0890238,0.451783,0.174961,-0.917196,0.742017,-0.36843,-0.00130211,-0.424669,0.519219,-0.515937,0.257432,0.657884,-0.673897,-0.695154,0.0463734,0.415323,0.517803,0.278888,0.627539,-1.04431,0.408821,0.737658,0.838679,0.236892,0.984566,0.331634,0.273511,-0.542577,-0.0683089,0.0492094,0.234229,-0.489136,0.566059,-0.0014234,0.43684,0.0678869,-0.255767,0.0182679,0.356615,-0.262967,-0.408054,0.148849,-0.0477505,0.138249,0.294016,-0.0942252,-0.36103,-0.763374,-0.56207,0.000225623,0.228771,0.042992,-0.190708,-0.11928,-0.112235,-1.14951,0.0448377,-0.00505314,0.308511,0.556948,-0.0177716,-0.055268,-0.248846,0.616138,0.182965,-0.0534805,-0.249139,-0.00302745,0.64831,-0.242511,-0.451494,0.266968,-0.149424,-0.769038,-0.0797193,0.419872,0.505668,0.73708,-0.352346,-0.352915,0.311653,0.178273,0.59703,1.05939,-0.18793,0.245205,-0.651902,-0.368031,0.525659,0.106566,-0.363225,0.706748,0.181707,-0.0754541,-0.477871,0.402578,-0.0521524,0.480238,0.0368348,0.0696888,-0.614426,0.363576,0.130368,-0.144268,0.109476,0.491937,0.0659324,0.48946,0.294462,-0.316637,-0.353205,-0.248068,0.536281,0.652486,-0.575234,-0.744795,0.363036,0.212374,-0.220809,-0.408123,0.271762,0.0712864,0.137598,0.264034,-0.572679,0.0861008,-0.137469,-0.152202,-0.179836,1.0969,0.625461,-0.279095,-0.197002,-0.0323433,-0.0850205,-0.333298,-0.549497,-0.549148,0.220808,-0.552106,-0.0819782,-0.0532634,0.340928,-0.233524,-0.10796,-0.174382,-0.514941,-0.725709,-0.808741,-0.0219348,0.0807123,-0.259907,-0.13099,-0.210158,-0.175928,0.220072,-0.312044,1.24194,0.0316891,0.23265,0.107873,-0.224022,-0.00988667,0.632875,0.18784,0.362868,-0.926303,-0.277302,0.226309,-0.913727,-0.0462635,-0.337797,0.0124298,-0.178865,-0.361374,0.603455,-0.435627,0.200023,-0.333044,-0.437719,0.310472,0.146113,-0.336178,-0.129175,-0.723155,0.178889,-0.241918,0.237824,0.473749,-0.194935,-0.336713,-0.144785,-0.105092,0.36792,0.444298,-0.537646,-0.174065,0.0917078,0.0191716,0.0743837,0.108976,-0.512588,0.391185,0.230624,-0.5313,0.0683126,-0.517992,0.492562,-0.139118,0.442557,-0.202934,-0.0357077,0.517116,0.824893,0.629826,0.25913,0.341652,0.208681,-0.291572,-0.0881596,-0.183332,-0.139531,-0.226182,0.128923,0.30275,0.366068,-0.40221,0.151776,0.290613,0.421011,-0.00784675,-0.660527,-0.17385,0.0621598,-0.000332367,0.495441,0.341936,-0.108728,0.0374654,-0.437636,0.0406246,0.142402,0.431776,-0.138166,-0.0934744,0.070165,-0.265507,0.12869,-0.100342,-0.557197,0.225163,0.137007,0.219595,0.370144,0.468609,-2.70035 +3384.22,0.985804,0.0848144,5,1.51556,0.894671,-0.175716,0.00951668,0.50306,-0.00400794,0.252965,0.249137,0.783408,0.192547,0.815496,-0.225929,-0.17635,0.272037,-0.494411,0.437862,0.33187,0.286688,-0.232006,0.271368,0.154016,-0.666684,-0.582564,-0.169147,-0.0203883,0.20169,0.432702,0.00988726,-0.619423,-0.0923036,0.497978,-0.0609899,0.547273,0.418302,-0.104193,0.366121,-0.684776,0.48081,0.569593,-0.101688,1.18372,0.0252636,0.133035,-0.439098,0.120247,-0.232412,-0.224233,0.133739,0.2055,0.00351569,0.224707,0.280323,0.050983,-1.17832,1.02126,-0.582952,-0.147878,-0.496881,0.869724,-0.225515,0.0246093,0.632855,-0.597165,-1.29508,0.191008,-0.0832906,0.562536,-0.236487,0.472347,-1.11606,0.164154,0.516439,0.698325,0.370499,0.847965,0.244506,0.400718,-0.49548,-0.447803,0.177254,0.0689818,-0.310727,0.324669,-0.180411,0.144567,0.286962,-0.662776,-0.233276,0.306855,-0.122975,-0.360752,0.172215,0.053475,0.552192,0.177774,0.0289074,-0.325211,-0.704034,-0.23884,0.155034,-0.117566,-0.216646,-0.0645866,-0.346248,-0.212106,-0.885467,0.0683877,0.287556,0.817594,0.255859,-0.321171,0.207472,-0.097625,0.428988,0.336594,-0.100134,0.28965,-0.190081,0.270193,0.181387,-0.846972,0.331615,-0.252432,-1.10515,-0.339049,0.121893,0.458922,0.521219,-0.28696,-0.0699157,0.118099,0.236577,0.634713,0.859382,-0.164089,0.234109,-0.744803,-0.580388,0.328566,0.0376766,-0.0636389,0.486825,0.0350082,-0.130489,-0.313641,0.59206,0.0298179,0.720297,0.172756,0.223395,-0.740948,0.48057,0.284439,0.0995268,0.210119,0.569469,0.0229949,0.732593,0.130389,-0.267364,-0.107132,-0.05519,0.442664,0.382514,-0.453606,-1.23628,-0.356646,0.0921084,-0.368742,-0.191274,0.561742,0.478233,-0.0366111,0.162423,-0.697456,-0.799342,-0.189492,-0.274128,0.248275,0.717002,0.111403,-0.438669,0.444829,0.068082,-0.0903931,-0.103582,-0.183402,-0.275066,0.588714,-0.421237,0.161571,0.152535,0.386229,-0.283382,0.00260128,-0.204062,-0.441311,-0.843996,-0.805416,-0.451023,0.0892209,-0.534613,-0.397665,0.175303,0.0602742,0.254251,-0.406023,0.958729,0.0350958,0.449301,0.323434,0.260911,-0.172092,1.02067,0.00537666,0.222404,-0.79725,-0.134807,0.117975,-0.863433,-0.0426846,-0.652525,0.0350922,-0.650148,-0.481339,0.569626,-0.394532,0.0194672,-0.481432,-0.120565,0.455475,0.299962,-0.509366,0.179409,-0.428983,0.418665,-0.132121,0.0449673,0.655175,-0.178505,-0.843411,-0.0088909,0.000799258,0.359635,0.117053,0.074951,-0.441927,0.210727,0.00186879,-0.0425099,0.22283,-0.185065,0.380351,0.0137457,-0.287981,0.00882886,-0.498015,0.631627,0.108966,0.307204,-0.120569,-0.275814,0.310566,0.734962,0.706968,0.0282665,0.382143,-0.302095,-0.00432057,-0.0745538,-0.169745,-0.381496,-0.511517,0.0617456,0.319204,0.496949,-0.50082,0.0528073,0.0369961,0.265378,0.0805473,-0.408249,-0.654114,-0.213853,0.082595,0.260962,0.105154,0.301799,0.154642,-0.0247078,0.124452,0.268465,0.199179,0.123607,-0.0736022,-0.100322,0.0176415,0.107288,0.192917,-0.112621,-0.458811,0.193445,0.187559,0.439824,0.433081,-1.65192 +3381.7,0.917163,0.0848144,5,1.51955,0.641051,-1.13876,0.454937,0.871658,-0.035873,-0.0587908,-0.0386009,-0.0212713,-0.340275,-0.0775394,0.0807694,-0.116205,0.548317,-0.20192,1.18956,0.169264,0.320472,0.0302812,-0.334788,-0.463159,-0.986711,-0.982955,0.350818,-0.0599284,-0.479967,-0.507025,0.545983,-0.187628,0.214709,1.10263,-0.745216,-0.0325912,0.485873,0.102895,0.00380818,-0.244717,-0.036009,0.515194,-0.613756,0.764085,0.171758,0.321009,-0.0999239,-0.101926,-0.397519,-0.79521,-0.5192,0.28719,0.140565,0.341236,0.0427817,0.0310357,-0.143721,0.879632,0.0513501,-0.46987,-1.10016,0.596475,-0.346965,0.424539,0.937329,-1.25473,-0.922172,0.00718956,0.357015,-0.601563,0.182307,-0.13715,0.0385347,-0.206544,-0.052417,0.215512,-0.272327,-0.0822088,0.290229,0.253726,0.358904,-0.211946,0.0956295,0.72215,-0.172333,0.411714,-0.0512076,-0.0974777,-0.514067,0.732146,-0.218009,-0.0510188,-0.360899,0.349688,-0.134576,0.12911,-0.465152,0.199988,-0.356683,0.770319,0.386109,0.676175,0.344401,0.195157,0.277029,-0.628693,-0.258998,0.323257,0.20816,0.379181,-0.56965,-0.057092,0.607614,0.0492929,0.00903435,0.418857,0.5084,-0.390613,0.119214,-0.934329,0.273172,-0.0136988,-0.431032,-0.585963,-0.293307,0.18863,0.692081,0.350562,0.258633,-0.0375991,-0.245019,0.444385,-0.521955,-0.115924,-0.516986,-0.393265,-0.180121,-0.39869,-0.438221,0.566041,0.274307,0.921893,-1.23734,-0.35691,0.20566,0.153218,-0.494863,0.345747,-0.0727102,-0.300524,-0.134168,-0.199236,-0.357499,0.280505,0.0332479,0.0713824,0.136198,0.330987,0.47935,0.483675,-0.538783,-0.157973,0.127253,0.446335,-0.157434,0.737585,-0.507871,0.367693,1.38908,0.346891,-0.0954633,-0.176141,-0.192226,0.304106,-0.409483,0.200178,-0.398754,0.526129,0.654108,-0.218915,0.0238061,-0.122382,0.380274,0.0506898,0.172857,-0.0497175,-0.0110765,0.0957359,-0.407692,-0.15128,-0.591418,-0.175917,-0.396358,-0.466455,0.0672705,-0.653721,-0.728078,0.117527,0.234324,0.321231,0.306458,-0.192237,0.647042,0.126331,0.0679508,0.963161,-0.359981,0.121223,-0.515069,-0.538392,0.888422,0.0920191,-0.207296,-0.00212215,-0.454148,0.644684,-0.718074,-0.0540821,0.447719,0.527838,0.428983,0.21803,0.343059,-0.0200867,-0.253488,-0.13576,0.980219,-0.139507,0.108299,0.0264538,-0.894835,0.442053,0.487973,-0.665812,0.271641,0.0417405,-0.518126,-0.115634,0.5212,-0.0919134,-0.0758538,0.408828,-0.162694,0.510009,0.102326,0.0766084,-0.381056,0.597938,0.348081,0.508618,0.154211,-0.299421,-0.777886,-0.0652492,-1.05017,0.278067,-0.416625,-0.0994958,0.360433,0.145172,-0.741385,0.284034,0.373761,0.373778,1.15069,-0.180629,-0.254581,-0.54537,0.146677,-0.0113086,0.213632,-0.0861757,0.277954,-0.00441292,0.0980331,0.116449,0.374063,-0.133871,-0.240873,0.760168,-0.0544112,0.483022,-0.221852,-0.251682,-0.0131687,0.134413,0.333222,0.160622,0.321276,-0.528571,-0.159244,0.452471,-0.185687,0.197089,-0.25738,-0.191548,0.215178,-0.121737,-0.79092,-0.146096,-0.162807,-0.338906,-0.128582,0.444813,0.14292,0.221355,0.378048,0.470484,-2.33167 +3410.13,0.959745,0.0848144,4,1.54414,0.894846,-1.18515,0.385392,0.485709,-0.153969,-0.611994,0.915675,0.515689,0.0406383,0.0338615,-0.243571,0.368909,0.690043,-0.235514,1.21059,0.44826,0.111044,-0.877221,-0.136368,-0.387769,-0.507084,-1.21939,-0.0628968,-0.391472,-0.256995,-0.176548,-0.187536,-0.571635,-0.0564526,0.794783,-0.793487,0.196978,0.436265,-0.248939,-0.122115,0.112477,0.31791,0.459526,-0.0210128,0.516615,0.565487,0.257373,-0.598075,-0.130893,-0.576036,-0.831063,0.0272492,0.580228,0.0451856,0.102534,0.503009,6.69793e-05,-0.306259,0.338432,-0.159929,-0.119006,-1.24914,0.458598,-0.58198,0.397279,1.29573,-0.523966,-0.56358,0.173138,0.394888,-0.861735,0.27178,0.40213,-0.179568,0.207433,-0.422332,0.0762716,0.298659,-0.054863,0.143744,0.334425,-0.0851062,-0.0322456,0.370262,0.686869,0.0215359,0.383589,-0.354068,0.0239523,-0.227411,0.234602,0.165435,0.594618,-0.22603,0.210899,-0.133209,-0.359991,0.25418,0.0456731,-0.436361,0.415555,0.121578,0.051022,0.752186,0.191923,0.260874,-0.317855,0.307322,-0.225084,0.274142,0.66553,-0.219006,-0.233038,0.00673455,-0.385068,-0.142839,-0.0822016,0.656489,-0.359958,0.292643,0.0381263,0.266419,0.0237214,0.154501,-0.879483,-0.171013,0.168478,-0.198126,-0.033635,-0.17651,0.0860143,-0.214876,0.579523,-0.421163,-0.315035,-0.356228,0.223434,-0.199363,-0.317819,-0.706647,-0.322449,0.339653,0.628651,-0.381259,0.240123,-0.129832,-0.342456,-0.09579,0.0749701,0.126353,-0.32605,0.520638,-0.441564,-0.206608,-0.670145,-0.0804325,0.62613,0.0730027,-0.100886,0.426329,0.476612,-0.177133,0.352184,0.207296,0.483573,-0.0876734,0.808802,0.165466,-0.432061,0.483739,-0.131552,-0.387071,-0.446663,-0.167745,-0.0357291,-0.0333391,0.117335,0.179182,0.129139,0.990398,0.039642,0.129435,-0.445096,0.523305,0.340432,-0.318581,0.500396,0.560307,-0.315926,-0.168767,-0.842529,-0.0276893,-0.241541,-0.352103,-0.228726,-0.334814,-0.121186,-1.03529,-0.0712473,0.2601,0.22156,0.178205,-0.199181,0.543191,0.0399948,0.0892086,0.516161,0.0805855,0.250335,-0.426458,-0.0991929,0.857284,0.591936,0.411387,-0.206778,0.0450298,-0.284276,0.159167,-0.354639,0.605041,-0.104314,0.795202,-0.187684,-0.124764,-0.288768,-0.256663,-0.172494,0.534675,-0.448234,0.343699,-0.0586518,-0.235696,0.660201,0.317696,0.349784,0.232741,0.192938,0.214184,-0.417916,0.315777,0.160051,0.176076,0.306742,-0.518304,0.0972422,-0.0331871,0.142623,-0.128158,0.249579,0.610435,0.564114,-0.343567,-0.189608,-0.4072,0.0448151,-0.478054,0.0757473,-0.669901,0.209367,-0.236241,-0.0081723,0.275812,0.494144,0.154091,-0.326551,0.698462,0.00993613,-0.575193,0.0134933,-0.283923,0.0159007,0.0432559,0.138868,0.148303,-0.0012754,-0.422565,-0.139965,0.595851,0.0295145,-0.362982,0.0940368,0.542216,0.0781534,0.259247,-0.0207072,0.12304,-0.137777,0.660578,-0.0387268,0.251709,0.0537084,0.294107,0.359552,0.0527097,0.191236,0.153684,0.0199622,0.50013,-0.126925,-0.354302,0.167018,0.187613,-0.77121,-0.0841204,-0.104535,0.14129,0.323488,0.375886,0.56876,-1.35465 +3419.55,0.993736,0.0848144,4,1.53248,0.899961,-1.39414,0.490863,0.360982,-0.104669,-0.398588,0.567234,0.485575,0.786738,-0.330497,0.00721937,0.153681,0.824976,-0.0668042,1.21092,0.190611,-0.131299,-0.318713,-0.584962,-0.608332,-1.01773,-1.58757,0.23945,-0.364855,-0.626734,-0.193832,-0.221358,-0.809046,-0.431237,1.01712,-0.536806,-0.112552,0.313447,-0.536368,0.0318653,-0.118359,0.25961,0.293724,0.125307,0.706645,1.12002,0.397246,-0.826698,-0.0495204,0.21353,-0.655776,0.241048,0.409804,-0.0281268,0.423926,1.20432,0.00177114,0.206674,0.464307,-0.259902,0.019015,-1.02249,0.25172,-0.414639,0.858413,0.82524,-0.493392,-0.926304,0.442853,0.0611378,-0.557005,0.617651,-0.0469683,0.0316619,0.194072,-0.34861,0.125755,0.388871,-0.117578,0.269574,0.239164,0.283159,-0.0466432,0.39331,0.687662,-0.207535,0.400645,-0.183853,0.0722729,0.0978978,-0.00107943,0.0940858,0.583112,-0.422692,0.319983,-0.430398,-0.274884,-0.063834,-0.190153,-0.256288,0.200758,0.200312,0.33649,0.515016,-0.0800794,-0.237328,-0.471167,0.130798,-0.00420136,-0.3011,0.45031,-0.345933,0.0368868,0.195905,-0.115224,-0.176734,0.281754,0.411592,-0.457858,0.0228652,0.151884,0.0722474,0.223107,0.640736,-0.789317,-0.151708,0.0524959,-0.0774767,0.0694374,-0.167483,-0.0246662,-0.0080036,0.291957,-0.512692,0.0155127,-0.584931,-0.167332,0.184179,-0.239824,-0.605197,-0.390286,0.23611,0.42423,-0.195197,0.278772,-0.145967,-0.045305,-0.00824285,-0.0743776,0.273233,-0.224909,0.275438,-0.333207,-0.185699,-0.959548,0.0202091,0.263337,0.107413,0.160079,0.158255,0.312904,-0.136915,0.361224,-0.305903,0.547227,-0.166225,0.920823,-0.0848513,-0.2503,0.0630353,0.119424,-0.457079,-0.390392,0.13753,0.0213954,-0.331067,0.0367254,0.0754942,-0.234096,0.407246,-0.039384,0.355938,-0.240346,0.718592,0.303608,-0.683195,0.354258,0.369772,-0.502405,-0.368897,-0.618925,0.0691142,-0.38197,-0.302036,-0.250676,-0.368704,0.124259,-1.21268,0.00113768,0.384623,0.164418,-0.363604,-0.167151,0.393599,0.102751,0.0217089,0.0759045,-0.0999583,0.188211,-0.169448,0.147166,0.568552,0.27834,0.272918,-0.204457,-0.0243223,0.279454,-0.428394,-0.51801,0.114386,0.408544,0.682366,0.105758,-0.212738,-0.0298143,-0.00669238,0.0223894,0.138362,-0.846482,0.364467,-0.00575416,-0.138756,0.280383,0.284794,0.238721,0.192268,-0.00331637,-0.0910513,-0.34829,0.462339,-0.305358,0.0441275,0.39341,-0.814398,-0.432104,-0.34164,0.108859,0.0106118,0.0304204,0.45016,0.518896,0.382474,-0.398723,-0.552105,0.185277,-0.925799,0.369581,-0.488985,-0.0946644,0.0630063,-0.104031,0.209655,0.167912,0.0613905,0.222601,0.461057,0.238893,-0.335168,-0.038945,0.088411,-0.0474328,0.406182,0.610556,0.196662,-0.0979728,-0.60336,-0.260779,0.216259,-0.0383878,-0.25091,0.393731,-0.0287145,0.184623,0.114584,0.391614,-0.114641,-0.238529,0.147952,-0.40985,0.386154,0.10582,0.114325,0.0614618,0.185939,0.205002,-0.311119,-0.175913,0.169713,0.0335085,-0.446409,0.269119,-0.0434464,-0.755802,-0.212467,0.0385166,0.110493,0.382241,0.332405,0.618257,-0.963841 +3438.74,1,0.0848144,4,1.66998,0.771847,-1.77906,0.602676,0.123021,-0.172316,-0.344566,0.263134,-0.145206,0.0897572,-0.382463,-0.408678,0.0264343,0.51887,-0.0892187,0.40553,0.368206,0.00876024,-0.825647,-0.181076,-0.422342,-1.5474,-1.21538,-0.220482,-0.296156,-0.691853,-0.300512,-0.156243,-0.725197,-0.223857,1.02544,-0.638606,-0.459594,-0.0150925,-0.297908,-0.250101,0.167958,0.0577409,0.699908,0.36535,0.997855,0.762987,0.00796202,-0.692566,-0.681692,0.59601,-0.60237,0.236705,0.784533,0.105801,-0.0992305,0.378095,0.172712,-0.317748,0.242532,-0.245773,0.0425266,-1.13588,0.291864,-0.0202669,-0.031954,1.15683,-0.40949,-0.863591,0.641153,-0.0427949,-0.704913,0.272706,-0.342162,-0.41521,-0.492193,0.17119,0.225927,-0.0493948,0.111459,0.177594,0.341064,0.582172,0.305864,0.314228,0.440622,-0.13175,0.225298,0.12962,0.123648,0.0118204,-0.0794963,-0.223977,0.242414,-0.60037,0.107006,0.32685,0.0164903,-0.0831939,0.358337,-0.0357006,0.0285306,-0.160842,-0.501856,0.294171,0.336894,0.145322,-0.0501828,-0.384791,-0.282515,-0.138638,0.515697,-0.28561,0.104475,0.616851,0.0481687,-0.107281,-0.110494,0.480563,-0.641511,-0.369177,-0.335446,0.451542,0.0821823,-0.232158,-0.231328,-0.415437,-0.280459,-0.16316,0.00819613,-0.0991311,0.0531655,-0.364576,0.376564,-0.17187,-0.142203,-0.0908808,0.0950197,0.751245,-0.207471,-0.375002,-0.294485,0.0611925,0.670093,-0.169648,-0.372536,0.195583,0.254681,-0.114825,0.436499,-0.337243,-0.18424,0.269871,-0.71279,0.0161159,0.328794,-0.00468121,0.123712,-0.187714,-0.145982,0.181304,0.0497114,-0.274896,0.174347,-0.0680956,0.499633,0.247559,0.773238,0.552236,-0.0861362,0.45899,-0.428581,-0.0810747,-0.197038,-0.114647,0.433608,-0.0556321,-0.0353626,0.261561,-0.251282,0.772834,-0.336651,0.0909668,-0.0389072,0.36695,-0.204589,0.343358,0.600443,0.375961,0.0142028,-0.00683467,0.0835755,0.0497089,-0.0720145,-0.142269,-0.0580085,-0.527159,-0.234001,-1.0168,-0.337772,0.383327,0.0773057,-0.326224,-0.514285,0.407964,0.0637116,-0.267764,0.0267459,-0.0279446,0.549728,-0.102888,-0.30285,0.490013,0.240727,-0.436864,0.302214,-0.194578,0.134051,0.155529,0.0654501,0.114195,-0.547867,-0.191573,0.150224,-0.669765,0.217869,-0.410996,0.165105,0.273447,-0.334739,0.133405,-0.293077,-0.173739,-0.108594,0.0988213,0.0603203,-0.0561684,0.251892,-0.481474,-0.269638,0.00974871,-0.470038,0.243676,0.355408,-0.687565,0.359688,-0.300413,-0.186125,-0.362295,0.331522,-0.443238,0.709712,-0.201449,-0.0504627,-0.374719,0.0122685,-0.601434,0.273876,-0.0610192,-0.295783,0.547306,0.313067,0.256786,0.267063,0.387967,-0.0658704,-0.0155845,0.337119,0.168098,0.139638,-0.23952,-0.491076,-0.59952,0.378599,-0.0592692,-0.417986,-0.232557,-0.0770444,0.0278148,0.0762703,-0.0560717,0.148324,-0.189646,-0.0953651,-0.278891,0.515387,-0.205095,-0.149786,0.0618373,0.00800766,0.0997344,0.281297,0.346726,0.0846185,-0.531152,0.0383403,0.220995,-0.0289062,0.0609935,0.0357459,-0.4355,0.217952,0.196924,0.00158597,-0.0466348,-0.51144,0.106607,0.300346,0.326507,0.548038,0.303266 +3459.53,0.943123,0.0848144,4,1.63265,0.771051,-1.37265,0.514991,0.3328,-0.0766705,0.395013,0.0168512,-0.392513,-0.326397,-0.200838,-0.233821,-0.512354,0.298296,0.0319213,0.833841,0.120359,-0.430868,-0.518968,-0.205122,-0.55576,-0.874537,-0.85783,0.243533,-0.471425,-0.351226,-0.461123,-0.0617066,-0.0943028,0.0683839,1.16342,-0.829028,-0.387127,0.055707,-0.455574,0.183769,-0.696713,0.599403,0.578876,-0.212959,1.16093,0.7328,0.0944701,-0.835491,-0.230775,0.310414,-0.226958,0.13406,0.513468,0.11214,0.177104,0.925295,-0.295919,-0.847965,0.519382,0.0279639,-0.294268,-0.783724,0.371675,-0.0964272,0.140781,0.652443,-0.543277,-1.76692,0.108511,-0.260495,-0.312132,-0.262108,-0.194709,-0.37536,0.268346,0.460637,0.804607,-0.360718,0.243372,0.430445,0.253674,-0.167798,-0.39244,0.268304,0.431777,-0.550777,0.227709,0.116239,-0.304739,-0.377974,-0.28381,-0.122683,-0.0529458,-0.68285,-0.142068,-0.156833,-0.0389383,0.0504856,-0.169596,-0.541746,0.327292,-0.643799,0.0316077,-0.345587,0.099281,0.325985,-0.323335,0.462905,0.407016,0.0628817,0.391188,-0.751801,0.31289,0.500002,-0.117703,0.217619,-0.204179,0.271944,0.479839,0.22813,-0.397936,-0.0493378,-0.0559819,0.0450902,-0.436669,0.352577,0.034123,-0.0194663,-0.422762,-0.149015,0.0224678,0.317334,0.469435,0.0551283,0.231621,-0.00532746,-0.386593,0.0204716,-0.340506,0.268048,0.176289,-0.119732,0.529094,-0.0352809,-0.268376,0.118844,-0.128721,-0.338725,0.0569348,0.356845,-0.0570827,0.385009,-0.346888,0.2717,0.257339,0.574024,0.214421,-0.167543,0.43069,0.620698,0.0321292,-0.301996,-0.244173,0.0877514,0.10421,-0.0952393,0.868265,-0.81773,0.461113,-0.010336,0.102766,-0.220561,0.0644675,-0.0432756,-0.0870121,-0.0362898,0.0187565,0.17517,0.297068,0.331951,0.0187425,-0.377736,0.491634,0.815205,0.242569,0.10887,-0.113716,-0.60493,-0.0293333,0.0396679,-0.551596,0.125452,0.306408,-0.383848,0.14779,-0.240258,0.139985,-0.308539,0.205227,0.530399,-0.484269,0.0736077,0.12632,-0.0213099,-0.0318083,0.26355,0.148369,0.192903,-0.283959,0.105056,-0.426421,0.340684,-0.0283798,0.285419,-0.168302,-0.0760671,-0.179417,0.162724,-0.190701,0.0153001,-0.434967,-0.253435,-0.328489,-0.187928,-0.0832608,-0.290984,0.213938,-0.0937033,-0.352019,0.163498,-0.615682,-0.0580816,0.480117,0.0167411,-0.124924,0.166281,-0.0551684,0.169033,0.2929,0.574691,0.469633,-0.0719026,0.438707,-0.591447,0.176477,0.0520925,0.0244839,-0.235233,0.25077,0.214487,0.479947,0.358378,-0.288504,-0.26708,-0.490497,-0.275543,0.407529,-0.324705,0.319983,0.332466,-0.308934,0.284775,-0.0715733,-0.0886827,0.258014,-0.0327699,-0.052483,0.234091,-0.205739,0.258397,-0.198083,-0.46372,-0.237235,0.058769,-0.0445293,-0.0287662,-0.281008,0.393658,-0.104734,-0.209724,0.0488093,-0.221948,0.285925,0.163167,-0.119791,-0.181972,-0.421073,-0.18272,0.0430109,-0.079263,-0.0694747,-0.578059,0.199965,0.207139,0.0524126,-0.49255,0.246849,0.0239983,0.07401,-0.131264,0.135835,0.140708,-0.239859,-0.228315,0.306739,0.0916248,0.343701,0.302696,0.58626,-0.583365 +3443.68,0.973002,0.0848144,4,1.62787,0.901555,-0.846655,0.323087,-0.247305,-0.0745184,-0.082504,0.0262378,0.35171,0.588058,0.0136579,-0.514764,-0.0581856,0.660164,0.0769335,0.991917,0.287234,-0.189517,-0.141439,-0.140499,-0.566493,-1.11343,-1.18933,-0.122728,0.0403937,-0.592822,0.110791,0.180351,-0.680105,0.0914057,0.613879,-0.266894,-0.317683,0.203348,-0.479261,-0.537479,-0.129767,0.659496,-0.236508,-0.530709,1.12917,0.663908,0.251937,-1.18315,-0.397544,-0.663601,-1.07796,0.122464,0.384188,-0.204901,0.801989,-0.209574,0.328252,-0.212498,0.301466,-0.179993,-0.340051,-0.533781,0.452508,-0.531019,0.2382,1.01988,-1.31604,-0.376212,0.20734,0.277216,0.142372,0.0819625,0.454101,-0.093957,-0.20397,0.0917471,0.331873,-0.145771,0.462406,0.375595,0.181533,0.2302,-0.101739,0.11384,0.549507,0.329059,0.223085,-0.457853,0.0932471,0.285047,0.239751,-0.12159,0.270185,-0.0743714,0.211037,0.352449,0.166758,-0.371291,0.42281,-0.123288,-0.411832,0.111941,-0.0342052,0.30067,-0.309377,-0.240609,-0.285404,-0.68711,-0.193877,-0.706024,-0.0145898,0.250787,-0.138729,0.0446886,-0.235839,-0.55343,0.336768,0.48247,-0.638286,-0.0104859,-0.0624626,0.215461,0.201074,-0.348047,-0.767699,-0.343803,-0.232939,-0.188012,0.0747063,0.212984,0.192701,-0.0730615,0.12323,-0.31274,0.00637939,0.0526542,0.0237974,0.585007,-0.00966097,-0.556693,-0.0445109,-0.111808,0.465289,-0.5073,0.0418321,-0.050909,0.260855,-0.0800246,0.0114768,-0.14371,-0.321983,0.294753,-0.0735064,-0.444245,-0.266813,-0.301363,-0.0463091,0.209178,-0.0773826,-0.0741065,0.186548,0.282842,-0.107979,-0.411361,-0.0145298,0.115792,0.809384,1.12224,-0.525233,0.535891,-0.303781,-0.0965453,-0.535285,0.0379655,0.233274,0.10685,0.12696,-0.222096,-0.267669,-0.436682,-0.506829,0.118311,0.0125584,0.223864,0.014976,-0.205885,0.376183,0.297582,-0.187605,-0.435986,0.156725,-0.312202,0.294375,-0.0278483,-0.0105815,-0.127084,-0.389978,-0.568351,-0.169708,-0.131652,0.424055,-0.225481,-0.600277,0.41592,0.0765781,-0.653611,0.432123,-0.377939,0.169148,-0.246777,-0.35746,1.18963,0.0805761,0.0601526,0.28734,-0.207458,0.404197,0.0571839,-0.279039,0.280508,0.274577,0.0262477,0.221523,-0.0516847,0.148768,0.00814194,-0.0623202,0.45968,-0.0825128,0.460249,-0.00325507,-0.515282,-0.378308,-0.0756814,-0.164331,0.0501736,-0.414423,-0.283377,-0.833278,0.326105,-0.735458,0.24729,0.416827,0.703229,-0.336734,0.0349635,-0.202838,-0.0130558,0.203877,-0.129712,0.443547,0.211453,0.213942,-0.140828,0.0530643,-0.576253,0.175214,-0.0470234,-0.519763,0.0102294,0.130082,-0.134267,0.392254,0.386133,-0.00635789,0.661731,0.0816003,-0.057753,0.317189,-0.267538,0.0222901,0.324693,0.417613,0.0592772,-0.246682,-0.322764,-0.230433,-0.601902,0.0700768,0.292081,-0.324659,-0.0491207,0.247449,-0.0261954,0.0730217,0.031935,-0.174489,0.306882,-0.00682517,0.279716,-0.347567,0.909683,-0.107182,-0.51406,0.15716,0.633204,0.0719267,0.220808,-0.21343,-0.622023,-0.269859,-0.241649,0.0802615,0.0400738,-0.291914,0.0968211,0.268653,0.311161,0.518318,1.01203 +3441.37,0.883957,0.0848144,4,1.65483,0.976903,-0.784583,0.237861,-0.193344,-0.227442,0.29564,0.10063,0.741796,0.58966,-0.617381,-0.271567,0.13745,0.372332,-0.184607,0.614785,0.14149,-0.139647,-0.108991,-0.0422204,-0.294817,-1.11071,-1.25403,0.314059,-0.285212,-0.57409,-0.50691,0.0996076,-0.14429,0.34748,0.614483,-0.211706,-0.00274413,-0.0499382,-0.448063,-0.225478,-0.720355,0.643059,-0.439315,-0.405525,1.1376,0.707593,0.400545,-0.919425,-0.433249,-0.473127,-0.852336,0.108575,0.329514,-0.396879,0.395277,0.3653,0.0255552,-0.711628,0.336815,-0.170092,-0.0713922,-0.209614,0.137161,-0.585782,0.311065,1.01926,-1.07159,-0.86877,0.116962,-0.106954,-0.18466,-0.00690322,-0.188471,-0.354416,0.0242137,0.0284802,0.26467,0.31176,0.279059,0.330568,-0.165156,0.415809,-0.100713,0.156909,0.626886,-0.00179682,0.109965,-0.392644,0.19599,-0.00858339,0.152309,-0.438277,-0.0687157,-0.162502,0.323133,-0.194977,-0.188126,-0.0935845,0.423316,-0.399647,-0.56057,-0.180109,-0.395405,-0.0218346,0.0795717,-0.191131,0.0160362,-0.446275,-0.0962618,-0.698627,0.479087,0.217581,-0.538762,0.195931,-0.814833,0.0809423,0.254615,0.41477,-0.541152,0.20896,0.034234,-0.115018,0.243698,-0.338098,-0.331115,0.0365858,-0.00163912,0.20113,-0.38258,-0.307931,-0.238308,-0.0394368,0.46317,-0.0440326,0.0491102,-0.0359167,0.0869338,0.604474,-0.312914,-0.122028,-0.145851,0.0775305,0.0863315,-0.212574,0.147828,-0.28312,0.215818,0.116293,-0.0184438,0.157317,0.256591,-0.28943,-0.0261924,-0.111089,-0.172662,-0.119,-0.523149,0.210174,0.364889,0.426426,0.40213,0.305833,-0.350977,-0.178785,0.307959,-0.204798,0.471933,0.035723,0.125017,-0.0261326,-0.0793657,-0.275936,-0.346372,-0.0675424,-0.11238,0.375337,0.00985914,-0.186772,-0.405705,-0.321941,-0.185959,0.474834,-0.0961901,0.708019,-0.0298793,-0.452907,0.134907,-0.24325,0.187245,-0.366132,-0.287966,-0.0761457,0.0225555,-0.357381,0.125026,-0.0508817,-0.34445,-0.680975,-0.117215,0.341984,0.145451,-0.273026,-0.573368,0.459262,-0.107897,-0.616801,0.117655,-0.00895978,-0.11132,-0.498537,-0.933686,0.660454,0.437659,0.42769,-0.084559,-0.0347655,0.560342,0.142239,-0.53573,0.644068,-0.275109,0.0785425,0.736679,-0.560204,0.233318,0.039759,-0.071468,0.50316,-0.573201,0.296489,-0.0989591,-0.160211,-0.410053,0.251767,0.00274438,0.325101,-0.337258,-0.285103,-0.26682,0.226003,0.00087322,0.220883,0.570179,0.00333454,0.0524131,-0.630328,-0.370491,-0.190544,0.113814,-0.118982,0.312638,0.551979,0.327035,-0.236445,0.0911279,-0.450115,0.206285,-0.49054,-0.44531,0.386214,-0.122604,-0.160606,0.0458287,-0.194405,0.533706,0.544919,0.499437,-0.0408923,-0.0372368,-0.21859,-0.201193,0.277826,0.57574,-0.187971,0.382644,0.231475,0.00670494,-0.232777,0.379058,-0.124192,-0.284195,-0.252152,0.126784,0.151919,-0.0663456,-0.13301,0.106477,0.562358,0.00108065,0.336392,-0.212056,-0.0989882,0.021821,-0.440518,0.0419522,0.451869,0.202227,-0.076069,0.183347,-0.524655,-0.391304,-0.136556,-0.300331,0.610313,0.0470783,0.115488,0.350637,0.339836,0.592146,0.81309 +3468.06,0.991025,0.0848144,4,1.57495,0.895764,-0.790223,0.342113,-0.037472,-0.0739054,0.0747977,0.678102,0.706561,0.635812,0.0165536,0.00249672,0.0521334,0.887068,-0.127844,0.966204,0.445205,0.268486,-0.242558,-0.385565,-0.271057,-0.738858,-1.28819,0.178256,-0.32891,-0.0528581,-0.20178,-0.0289027,0.0189041,0.321574,0.971603,-0.605003,-0.110566,0.150865,-0.564941,-0.472746,-0.603218,0.396011,-0.026602,-0.163771,1.17175,0.43716,0.441597,-0.994444,0.0446885,-0.441049,-0.540164,0.23441,0.539502,-0.225897,0.158772,1.01525,-0.218467,-0.151208,0.494426,0.372784,-0.386877,-0.351336,0.264136,-0.439526,0.407317,0.629044,-0.952441,-0.737527,0.329224,-0.0309241,-0.0466835,-0.120367,0.0410121,-0.0123537,-0.433481,0.392373,0.306177,0.180555,0.286224,0.453095,0.259009,0.0216378,0.15631,0.0430341,0.605542,-0.393666,0.109664,-0.345824,-0.380597,0.341232,-0.0201671,-0.203077,-0.423589,-0.166011,-0.28482,-0.001474,0.0684137,-0.140627,0.415205,0.0741927,-0.260344,-0.47933,-0.00911666,0.228846,0.189995,0.0630867,-0.0982738,-0.438695,-0.640858,-0.620668,0.632381,-0.0685023,0.573859,0.360692,-0.080005,0.167875,-0.201356,0.240962,-0.417458,0.00388634,-0.136778,0.0910896,0.395251,-0.39525,-0.312819,0.381601,-0.134219,-0.136972,0.092896,-0.106903,0.417453,0.250523,0.0145059,-0.141153,0.236126,-0.443754,-0.130334,0.291508,-0.20466,-0.202445,0.0684025,0.0179791,0.414166,-0.22444,-0.0491074,0.0135664,0.227579,-0.222328,-0.276006,-0.0297497,-0.302624,0.0264515,-0.196972,0.106401,0.0555828,0.357582,0.147566,-0.191142,-0.315615,0.455868,0.00690625,-0.470094,-0.181803,-0.00208006,-0.199141,0.172047,0.539223,0.0193193,-0.660072,0.195396,-0.402101,-0.266706,-0.346076,-0.499472,0.144769,-0.436853,-0.312627,-0.457991,0.0151585,-0.0825048,-0.181292,-0.0110521,0.295862,0.626224,0.362507,-0.0905352,0.416555,0.127934,-0.43738,-0.711427,-0.25075,-0.193156,0.339777,-0.237338,-0.142159,0.19329,0.139864,-0.408901,-0.00196259,0.398547,0.387185,-0.487918,-0.166763,0.229907,0.132438,-0.147572,0.385111,0.430389,0.0350522,-0.231408,-0.524203,0.891176,-0.0288393,0.329278,0.167155,-0.0351917,0.315953,-0.0224105,-0.162296,0.253333,0.154662,-0.0759466,0.201695,0.103734,-0.150677,-0.277281,0.199914,0.49294,0.146575,0.331461,0.0863205,-0.502648,-0.185922,-0.0718296,0.150412,-0.0697043,-0.579391,0.00786743,-0.0971161,0.462542,0.365029,0.419894,0.361366,0.173473,-0.00964302,-0.22159,-0.629776,-0.134485,0.226515,0.425364,0.758379,-0.0758118,-0.189246,-0.0877577,0.112016,0.14299,0.112696,-0.137143,-0.427912,0.709985,-0.352758,-0.221191,0.192722,0.119764,0.0804732,-0.0527927,0.166322,0.107424,-0.472082,-0.0221833,-0.0336388,-0.278768,0.0374418,0.571516,-0.171296,-0.162492,-0.038216,0.445839,0.165064,0.253967,-0.0441221,0.187898,-0.00665967,0.26048,0.0948409,-0.305802,-0.455608,0.0928996,-0.247513,0.399739,-0.120464,0.462518,0.179514,-0.288149,0.13062,0.049244,-0.293247,-0.121994,0.108773,-0.192929,-0.609023,0.0250171,0.0807654,-0.4325,-0.109573,0.0841452,0.324084,0.290078,0.569283,0.224901 +3467.81,0.736694,0.0848144,4,1.54484,0.901906,-0.945811,0.382847,0.103051,-0.0889643,-0.0425328,0.653535,0.563929,0.798429,0.0406618,-0.03323,0.0355392,0.880416,-0.104473,0.843098,0.535998,0.219282,-0.274342,-0.298145,-0.343989,-0.738231,-1.2869,0.0818032,-0.214011,-0.0896568,-0.14777,-0.168024,-0.097556,0.354818,0.799924,-0.516239,0.0596896,0.0841995,-0.401963,-0.435228,-0.582095,0.495475,-0.0242589,-0.0273649,1.14957,0.517263,0.430989,-0.928168,0.000738464,-0.569495,-0.521754,-0.00842836,0.56837,-0.0968265,0.126611,1.15268,-0.230465,-0.244085,0.535298,0.444801,-0.32251,-0.548068,0.329664,-0.349064,0.553277,0.802574,-1.04782,-0.833956,0.314956,0.0334901,-0.160704,-0.139574,-0.0850951,-0.202485,-0.460238,0.356581,0.378726,0.194497,0.530424,0.426571,0.115586,0.0621497,0.194462,0.147874,0.320243,-0.40909,0.178943,-0.268164,-0.204228,0.23719,-0.0911059,-0.402085,-0.401029,-0.0553122,-0.373349,-0.219222,0.0400977,-0.0401302,0.445349,0.131609,0.0138965,-0.561443,0.0422563,0.123144,0.221219,-0.167228,-0.127667,-0.348164,-0.572641,-0.58175,0.399454,-0.298233,0.389281,0.334302,-0.15731,0.086657,-0.128178,0.30279,-0.371487,0.108775,-0.159296,0.084771,0.54523,-0.413764,-0.298087,0.492575,-0.216727,-0.157191,0.154483,-0.0687982,0.43854,0.358585,-0.0392265,-0.135493,0.177476,-0.430906,-0.118001,0.299573,-0.357509,-0.225734,0.0508957,-0.0259774,0.532017,-0.329622,-0.0799928,0.038489,0.218508,-0.253261,-0.276145,0.11051,-0.289475,0.0544725,-0.355296,0.136388,0.0310522,0.292849,0.00372316,-0.00301983,-0.172809,0.516662,0.0597977,-0.414317,-0.0868103,-0.00608267,-0.187647,0.158527,0.46413,-0.0919932,-0.522787,0.132311,-0.292808,-0.315957,-0.345983,-0.320814,0.208785,-0.512884,-0.28973,-0.46924,0.0601682,-0.0436859,-0.26001,0.0304115,0.371695,0.611118,0.674637,-0.113554,0.455118,0.22213,-0.323669,-0.710211,-0.241612,-0.21966,0.340166,-0.235498,-0.166567,0.161011,0.217422,-0.468413,0.0460313,0.302493,0.478043,-0.364748,-0.178356,0.191693,0.204173,-0.113823,0.408215,0.277107,0.0913124,-0.182892,-0.638815,0.999349,0.0706902,0.258001,0.124088,-0.128282,0.316589,0.116745,0.0932823,-0.00702425,0.168635,0.00313544,0.0974059,0.128551,-0.109775,-0.301578,0.16784,0.676937,0.0764987,0.292779,0.120817,-0.395455,-0.156146,-0.00825697,0.0423042,-0.00839338,-0.803618,0.00836215,0.0119187,0.452676,0.476591,0.418056,0.316509,0.262412,0.00414842,-0.192927,-0.552496,-0.0913014,0.276487,0.429173,0.720726,-0.0375192,-0.205297,-0.0373821,-0.171714,0.145485,0.127966,-0.183267,-0.523222,0.647105,-0.389913,-0.30428,0.22578,0.219103,0.118978,-0.0408723,0.068344,0.137682,-0.502767,-0.0898726,-0.0832087,0.0522643,0.0294687,0.443663,-0.176468,-0.229568,-0.0572193,0.374582,0.203871,0.313759,-0.0733373,0.147681,0.0963051,0.202108,0.0986469,-0.374995,-0.419074,0.0501375,-0.292082,0.464503,-0.174862,0.526278,0.152163,-0.254038,0.111413,-0.0556349,-0.137725,-0.11791,0.191658,-0.044686,-0.488964,0.0312539,0.0656897,-0.332602,-0.100418,0.0778689,0.381563,0.27905,0.617708,-0.235683 +3465.84,0.966129,0.0848144,4,1.50367,0.916467,-0.876471,0.283294,-0.0625243,-0.166468,0.0107652,0.667788,0.770637,0.833325,-0.057343,-0.0174708,-0.0183984,0.653185,-0.176193,0.795758,0.204189,0.412304,-0.417098,-0.26333,-0.191643,-0.874944,-0.870068,0.00716874,-0.0609421,-0.235244,0.142108,-0.0471249,0.219271,0.201185,0.946445,-0.802471,-0.23998,-0.160558,-0.702744,0.13787,-0.318164,0.455867,0.203434,-0.548576,1.18073,0.64684,0.133282,-0.664828,-0.401862,-0.792845,-0.680262,0.180001,0.679625,-0.00928476,0.276911,0.738133,0.0493234,-0.890623,0.585118,0.284305,-0.176233,-0.674739,0.369044,-0.382095,0.270331,1.00259,-0.791449,-0.360496,-0.038171,-0.110033,-0.475797,-0.104082,-0.120151,-0.0608758,-0.489149,0.391974,0.31915,-0.118579,0.654584,0.427004,0.147817,0.0785552,0.177942,0.260981,0.37621,-0.380711,0.386484,-0.250178,0.0782064,0.120221,0.140557,-0.273318,-0.329636,-0.235046,-0.223494,-0.214247,0.246247,0.232249,0.371158,-0.395455,-0.222895,-0.281,0.128121,0.288046,-0.0535746,0.121417,-0.594122,-0.261155,-0.322557,-0.558849,0.729175,-0.21562,0.271653,0.498846,-0.160528,0.159506,-0.461479,0.283791,0.16585,0.0987692,-0.06879,0.149323,0.741977,-0.302583,-0.29173,0.468207,0.0581289,0.500396,-0.323638,0.308994,-0.0931697,-0.237038,-0.0616502,-0.389073,0.101081,-0.437267,0.10242,0.415688,-0.256202,-0.189418,0.133966,0.304606,0.402992,-0.0983963,-0.637047,0.280638,0.0697055,-0.126331,0.213605,0.178322,-0.650798,-0.0690441,-0.209709,0.13936,0.0500685,0.531056,0.0259737,0.0118005,0.209763,0.408947,-0.109778,-0.301523,-0.0496778,0.0116151,-0.164767,-0.0904721,0.621979,-0.161835,-0.193119,0.0932786,-0.317688,-0.16144,-0.288149,-0.461554,0.489106,-0.176571,-0.022603,-0.350908,-0.31987,0.291869,-0.0938967,-0.184518,0.239454,0.518522,0.375361,0.224683,0.270555,0.196898,-0.36512,-0.311132,-0.0674601,-0.423022,0.232506,-0.591408,-0.119477,-0.157425,-0.394437,-0.564138,-0.451781,0.296949,0.664485,-0.397036,-0.501375,0.218185,0.248381,-0.501637,0.0168592,0.15149,-0.0344798,-0.296373,-0.255408,0.718476,0.140029,0.261059,-0.0061776,0.0980062,0.38261,-0.191993,0.23513,0.324875,-0.0371564,0.173577,0.51095,-0.127205,-0.292745,-0.24029,0.175275,0.738743,0.102231,0.41986,-0.0708928,-0.435393,-0.240527,0.337699,0.107688,0.0700144,-0.31874,-0.223481,-0.0661614,0.355556,0.297411,-0.107191,0.291856,0.105337,-0.246923,-0.283468,-0.249759,-0.0500304,0.606273,0.304972,0.343354,0.0463342,0.0883376,-0.395454,-0.33158,0.00457074,0.339332,-0.277169,-0.568104,0.567301,-0.140403,-0.199285,0.193215,0.487518,0.253995,0.1225,0.418789,-0.114665,-0.417686,0.267457,-0.0512609,-0.000445596,-0.136344,0.11958,-0.0828236,-0.114001,0.143985,-0.292249,-0.240179,0.188193,-0.285671,0.377654,0.118344,0.0774419,-0.0166477,0.297029,-0.647005,0.344242,-0.335379,0.46693,0.188783,0.251698,-0.0446147,-0.364013,0.126376,0.290754,0.138147,-0.0343122,0.178335,-0.0780756,-0.581758,-0.105217,0.233605,-0.433406,0.00357617,0.112281,0.280595,0.335084,0.529712,0.324436 +3463.12,0.954694,0.0848144,4,1.61014,0.942244,-0.871914,0.3069,-0.334465,-0.172972,0.36526,0.225517,-0.0278456,0.131353,-0.187365,0.0762439,-0.1592,0.739772,-0.467153,0.372633,0.199936,-0.439696,-0.287245,-0.0593317,-0.270557,-1.07439,-0.867162,0.141118,-0.0389583,-0.0220886,-0.232381,0.115999,-0.0187649,0.115428,0.839806,-0.533679,-0.456519,0.0164118,-0.548618,-0.427206,-0.430095,0.734315,-0.0226583,-0.641639,0.921026,0.402751,0.158126,-1.13975,0.0228238,-0.236233,-0.581134,0.524804,0.501035,-0.284317,0.12563,0.347381,-0.0409568,0.0660761,0.198647,-0.249239,-0.248006,-1.0503,-0.354772,-0.488542,0.872194,0.831348,-1.09987,-0.560288,0.25889,0.411046,0.109027,0.0767634,0.126985,-0.136748,-0.118371,-0.377375,0.498963,0.104825,0.422035,0.665515,0.155062,0.118058,-0.162401,-0.0760894,0.179487,0.282263,-0.110896,-0.114941,-0.203707,0.168189,-0.384836,-0.240236,0.403405,-0.390398,0.0223146,-0.27077,0.319908,0.0807156,0.157791,0.14023,0.0299434,-0.25113,0.20142,0.315986,0.141114,-0.309583,-0.511299,-0.0665792,0.0585552,-0.357984,-0.155502,-0.396695,-0.215515,0.503041,-0.0798431,-0.364408,-0.182828,0.618085,-0.257092,0.294881,0.147219,0.438307,0.530734,-0.0538552,-0.669236,0.298335,-0.257515,-0.66239,0.297858,0.0713028,0.407487,0.394847,0.0777636,-0.653104,0.133032,-0.398208,0.545457,0.702388,-0.161414,-0.313326,0.131575,-0.0987636,0.0689509,-0.152898,-0.206543,0.0512981,-0.205016,-0.330847,0.179765,0.313763,0.309768,0.563422,-0.14532,-0.276346,-0.289602,-0.183781,0.152136,-0.209033,-0.151192,0.27297,0.159599,-0.294379,0.206733,0.073254,-0.416519,0.313593,0.0144597,0.313656,0.40359,0.448842,0.143064,0.135142,0.145888,-0.180125,0.00987404,-0.0822629,0.0572756,-0.468892,0.12459,-0.161419,-0.208161,0.265044,-0.0641327,0.845003,-0.110031,-0.153371,0.275018,-0.0344862,0.386215,-0.0772511,-0.371626,-0.0799457,0.339844,-0.201809,0.231066,0.730452,0.0235178,-0.461215,-0.0864833,0.326477,0.0158974,-0.361175,-0.0250437,-0.109613,0.021403,-0.0747263,0.515843,0.305364,0.0116169,0.049895,-0.551103,0.741676,-0.0454388,0.141382,0.294109,0.229713,0.233279,-0.287389,-0.405284,0.331229,-0.0808848,0.0734841,0.330912,-0.256835,-0.180006,-0.113658,0.11634,-0.148438,-0.0709222,0.347405,0.0345884,-0.193242,0.617475,0.245865,0.458597,0.169425,-0.119308,0.186166,-0.0332663,0.927761,0.276555,-0.150702,0.472587,0.0490681,0.0721004,-0.329154,0.308117,-0.072737,0.354904,0.226529,0.24033,-0.133274,-0.0806732,-0.146483,-0.01607,-0.302471,0.412192,0.354184,-0.053293,0.340535,-0.254992,-0.296044,0.402171,0.232289,-0.272215,0.269419,0.413267,0.151761,-0.0660296,-0.252489,-0.157662,0.086599,-0.0478874,0.0676541,-0.00652398,0.369464,-0.178721,0.189153,0.133697,0.142824,0.0249732,0.093495,-0.0318726,0.386442,0.260191,-0.183318,-0.321827,0.0952702,0.154493,-0.105262,0.0345269,0.223758,0.195755,0.234034,0.316499,0.260573,-0.0186402,0.295468,0.410009,-0.31352,0.127583,0.268166,-0.0192109,-0.351821,0.282568,0.0753822,0.314568,0.274558,0.560864,1.26495 +3479.66,0.918059,0.0848144,4,1.71594,0.955002,-1.32557,0.42082,0.23513,-0.180782,-0.390443,-0.660016,0.384536,-0.325488,-0.485854,-0.477378,-0.00441637,0.0853093,-0.562063,0.874785,0.0399702,-0.0289073,-0.49761,-0.211566,-0.513657,-0.970185,-0.835506,-0.0360807,-0.331823,-0.515603,0.00763627,0.0330482,-0.506395,-0.0258004,0.626217,-0.329789,0.106496,-0.0545393,-0.666166,-0.0949367,-0.135125,0.305041,0.373571,0.227645,0.927754,0.335995,0.511931,-0.989245,-0.393946,0.180542,-0.707747,0.0242571,0.23461,-0.00920809,-0.0822562,0.540759,0.165122,-0.370033,0.13049,-0.062265,-0.0235339,-0.548196,0.493048,-0.417913,0.0497306,0.809566,-0.881604,-1.14663,0.370316,0.169708,0.153829,0.214043,0.0892099,-0.37294,-0.283494,0.408441,0.48129,-0.0721004,0.459484,0.0251708,0.316033,0.0590536,0.0943985,-0.062403,0.182728,-0.757404,0.155324,-0.0521758,-0.141937,-0.0130813,-0.0900659,-0.18482,-0.410535,-0.328169,-0.155514,-0.0632864,-0.153926,0.136496,0.0412002,-0.663477,-0.168602,0.00180866,-0.264873,0.0140482,0.0959262,0.308459,0.372781,-0.272246,0.330298,-0.354802,0.14341,-0.0982839,0.20616,0.442789,-0.292676,0.0789445,0.146885,0.374888,0.166759,-0.125144,0.119331,-0.0942845,0.0909727,0.00994108,-0.0219897,-0.406612,0.0843499,0.210279,-0.163188,0.700683,0.16825,-0.0823503,0.391777,0.0575213,0.0369163,0.280936,0.338636,0.211415,-0.260453,-0.151715,-0.0191231,-0.191031,0.32026,-0.203344,-0.211442,-0.398867,0.0583768,-0.412431,-0.0285254,0.111214,-0.355548,-0.485278,-0.101363,0.116967,0.295928,0.0136993,0.077078,0.598666,0.530817,0.308148,-0.292517,-0.0544189,-0.0615057,-0.142354,0.705279,-0.0672168,0.658647,-0.0667074,-0.220204,-0.184945,-0.00227628,-0.370022,-0.178618,0.151593,0.226795,-0.248339,0.11361,0.306538,-0.64312,0.402555,-0.0732958,0.0412601,-0.120035,0.402139,0.132229,-0.0434977,0.0566149,-0.024652,-0.286182,-0.578434,0.185389,-0.236575,-0.1886,-0.223866,-0.242494,-0.532295,0.0503884,-0.640357,-0.0822147,-0.17097,0.183822,-0.206382,-0.0693802,0.270114,-0.188752,0.0892901,-0.340312,-0.291332,0.348857,0.0082429,-0.41552,0.713903,0.0274457,-0.184528,-0.0852376,-0.231868,-0.0248791,0.0820045,-0.0176277,0.185357,-0.478215,-0.0428579,0.31446,-0.628704,0.214799,-0.342624,-0.346335,0.246951,-0.253958,0.388296,0.0296359,0.0620247,-0.232105,-0.485293,-0.270974,0.227593,-0.250261,-0.417748,-0.170225,0.0991598,0.240941,-0.221975,0.275411,-0.193789,-0.0727961,0.280922,-0.161697,0.208648,-0.0254313,0.103257,0.525583,0.382579,-0.0796191,0.0409234,0.481801,-0.428342,0.208864,-0.497967,0.512678,0.0280894,-0.0323403,0.243889,-0.109441,-0.204341,0.210495,0.0250757,-0.102323,0.042249,-0.0486801,0.256488,0.0981528,-0.0908981,-0.467496,-0.0650566,0.0211741,-0.464456,0.0503031,0.300004,0.166708,0.000539859,0.0190668,0.300161,0.186424,-0.0269677,-0.270137,-0.00417375,-0.210811,0.226629,0.162926,0.12854,0.14488,-0.0694465,0.144993,-0.320216,0.195763,0.167214,-0.349883,0.280209,-0.350321,-0.153411,-0.403324,-0.151809,-0.0131548,0.135933,-0.105822,0.0671448,0.179493,0.259123,0.423667,-0.410454 +3477.87,0.964465,0.0848144,4,1.69326,0.953638,-1.14225,0.349976,0.716979,-0.0351352,-0.142895,0.179802,0.0219178,-0.0568672,-0.0982499,-0.328675,-0.235816,0.120191,-0.504094,0.468792,-0.103173,-0.0717503,-0.408262,-0.31325,-0.516065,-0.860483,-0.481472,-0.0850497,-0.390283,-0.199368,-0.133029,0.159866,-0.711612,0.338574,0.622894,0.00226765,-0.0126156,0.325685,-0.271513,-0.269421,-0.418936,0.649889,0.682189,-0.553813,1.04497,0.342273,0.899315,-1.03316,0.338722,-0.315052,-0.907007,0.344585,0.315048,-0.0178437,-0.0827811,0.484197,-0.146513,-0.168912,0.517022,-0.0751117,-0.0531061,-1.46959,0.239381,-0.336497,0.200765,1.22947,-0.72261,-0.355048,0.281555,-0.427533,-0.194846,-0.0559403,0.0773809,-0.0650232,-0.10592,-0.0878864,0.413064,0.361105,0.126964,0.312063,-0.0112421,0.0803311,-0.410456,0.286285,0.572675,-0.223525,-0.0515818,0.109512,0.13163,0.0407383,0.250908,-0.163806,-0.304782,-0.688009,0.0330706,0.455357,-0.052853,-0.155077,0.0201009,-0.393189,-0.0905742,0.0805337,-0.0883655,0.186561,0.394066,-0.128901,-0.290694,-0.457331,-0.059731,0.201495,0.00622924,-0.330484,0.353139,0.51546,-0.549716,0.0611477,-0.167332,0.49468,-0.174381,0.0262364,0.154302,0.103551,0.338279,0.0255526,-0.640423,-0.152725,-0.47259,-0.635506,0.0985736,0.264041,-0.0302352,0.194929,-0.102848,-0.45133,-0.490658,-0.208204,0.0715409,0.531267,0.00272932,-0.236956,0.154907,0.0827281,0.241238,-0.609143,-0.230121,-0.023942,0.019866,-0.17313,-0.311012,0.225944,0.197974,0.195942,-0.253401,-0.297637,-0.0708882,0.0297593,0.33164,-0.158983,-0.600711,0.298428,0.215718,0.0809238,0.0396475,0.163573,-0.590446,0.104338,0.322629,-0.0796512,0.261921,0.141346,0.0808091,-0.134987,-0.0541864,0.0677766,-0.0672819,0.0473981,-0.0442765,0.0712704,0.393989,0.330077,-0.0683249,-0.50288,0.210799,0.244019,-0.0692,0.0885738,0.0279414,0.0268691,-0.0919656,0.0238415,0.123958,-0.289974,0.462916,-0.196256,0.160028,0.112434,0.179853,-0.488859,-0.117703,0.18271,0.0354378,-0.602632,-0.81047,-0.583249,-0.0774889,-0.166084,-0.0781899,-0.391526,0.0236829,-0.0535466,-0.0545204,0.755477,-0.0303103,-0.0170338,-0.0699348,0.255113,-0.0326515,-0.0227743,-0.380698,0.277129,-0.0389378,0.225541,0.154888,0.151444,0.106233,-0.697312,-0.167218,0.109204,-0.592361,0.254457,-0.232105,-0.219121,0.441329,0.271538,-0.239514,0.0197898,-0.290379,-0.133464,-0.123687,0.356852,0.0844758,0.235706,0.25583,0.0440697,0.146647,-0.0041237,0.144167,0.340178,-0.0210156,0.589723,0.394229,-0.157855,-0.176526,-0.290463,-0.367745,-0.364308,0.354055,-0.50167,0.0271232,-0.231047,-0.186812,-0.351973,-0.0283915,-0.0065843,0.237269,0.518746,-0.221729,0.25156,-0.120158,-0.20965,-0.173878,-0.417371,0.761001,-0.250977,-0.205068,-0.313528,0.00141697,0.314363,-0.257028,0.0482177,-0.418159,0.172138,-0.0941955,0.469849,-0.022267,0.146977,-0.518377,-0.241168,-0.0498567,-0.153489,0.11593,0.313609,0.400134,0.226359,-0.0833445,0.121686,0.242148,0.42675,-0.0214587,-0.244738,0.00519917,-0.165281,0.116224,-0.874268,0.080217,0.0942286,0.296486,0.306967,0.544505,-2.09591 +3471.44,0.83813,0.0848144,4,1.64709,0.92931,-0.799147,0.220306,0.329619,-0.062332,0.0166422,-0.0833103,0.274756,0.169339,-0.0888615,-0.316033,0.160166,0.193308,-0.570956,0.751751,0.0953493,-0.204316,-0.358449,-0.119558,-0.291901,-0.922093,-0.987655,0.347356,-0.281408,-0.240066,0.322703,0.0882861,-0.262881,-0.353895,0.700152,-0.576211,-0.379279,-0.011294,-0.0178217,0.0562698,0.0367366,0.31103,0.52834,-0.188154,0.94899,0.404414,0.0422503,-0.787775,0.0741928,-0.0956053,-0.434231,0.714809,0.233533,-0.243119,0.113967,-0.1246,0.241184,-0.825963,0.909367,-0.104288,-0.372911,-0.913287,0.350858,-0.283473,0.320431,0.597141,-0.505176,-1.08142,-0.0355256,0.629421,-0.287138,0.505941,0.298767,-0.439189,-0.119253,-0.252568,0.563104,0.0712252,0.613695,0.577531,0.485544,0.224336,0.187832,-0.253437,0.32735,-0.160877,-0.111459,-0.177965,-0.411771,-0.34328,-0.237195,0.0853783,0.447181,-0.0962482,0.00399001,0.155469,-0.0292576,0.0346731,0.295506,-0.11446,-0.112552,-0.329463,0.262105,0.140354,0.00375512,-0.384317,0.282163,-0.109294,0.378023,0.232058,-0.427328,-0.00991006,0.538429,0.671646,0.229223,-0.268306,-0.00974789,0.0745329,-0.294903,0.250455,-0.632453,0.145871,0.0253212,-0.537288,0.0295237,0.255997,0.572729,0.0778484,-0.0257336,-0.120504,0.372358,-0.573017,0.173149,0.0561375,0.345156,0.0856893,0.706065,0.724302,-0.113888,0.228049,0.0961967,-0.118813,0.463737,-0.595006,0.0731236,-0.224301,-0.175694,-0.151131,0.311052,0.164952,0.178484,0.280286,-0.118965,-0.166549,0.195621,0.205178,-0.215157,-0.0154773,0.219702,-0.279371,-0.215375,-0.0496993,0.0614843,-0.156266,0.429211,0.288606,0.430811,-0.0198285,0.0278224,-0.600008,0.0834953,-0.275189,-0.135162,0.172714,0.226256,-0.392728,-0.143399,-0.292728,-0.269511,-0.0475338,-0.259227,0.187067,-0.091641,0.949596,0.293023,-0.451812,0.317161,-0.547571,0.220089,-0.280335,-0.303821,-0.0118346,-0.394862,-0.116262,0.0266104,0.331286,0.0685423,-0.632825,0.252175,0.124664,0.135787,-0.328187,-0.0708361,0.401154,-0.374149,-0.12365,0.219133,0.26827,-0.151826,0.229829,-0.587738,0.83404,-0.0406417,0.465783,-0.0540119,-0.467521,-0.0078906,0.166456,-0.0901887,-0.0602769,-0.503619,0.0873332,0.250082,-0.49849,0.324563,-0.572894,0.0428817,0.394583,0.00707768,0.463966,0.272509,-0.105113,0.285961,-0.0331293,0.196575,-0.0152741,-0.0669144,0.0493937,0.299617,0.573184,0.157861,0.0525198,0.297695,-0.163049,-0.444483,0.0912901,-0.195577,-0.0300629,0.0270417,-0.0934666,0.154414,0.1951,0.247188,-0.116456,0.0934574,-0.530884,0.176894,-0.174239,-0.56627,0.467954,-0.141189,0.205757,0.52445,-0.265556,0.296352,-0.101984,-0.156726,-0.152565,0.168072,0.216068,0.0513308,0.345157,-0.180806,-0.107796,-0.460826,-0.210827,-0.230816,-0.0119447,-0.0312413,0.0253708,0.148231,0.00450437,-0.1394,-0.115915,-0.651266,-0.124664,0.21674,-0.268154,-0.0109354,0.661769,-0.168287,0.319639,0.113639,-0.0248336,-0.00361055,0.140218,-0.341108,0.195205,-0.124603,-0.414167,0.256391,0.145413,-0.214736,0.375882,-0.11707,0.104635,0.204893,0.323473,0.452651,-0.863612 +3472.66,0.839564,0.0848144,4,1.64674,0.767166,-0.894956,0.310472,0.55462,-0.142865,-0.3998,-0.0858196,0.0892465,0.300703,-0.0346396,-0.0190834,0.121135,0.236879,-0.404982,0.28453,0.13606,-0.0294231,0.0872904,-0.341293,-0.23097,-1.21444,-0.91685,0.478684,-0.0640557,-0.236925,0.122662,0.269626,-0.079172,-0.282105,0.745184,-0.85873,-0.229797,0.509799,-0.385162,-0.374751,-0.774034,0.478992,0.794357,-0.267888,0.860689,0.370245,-0.119777,-0.67738,0.138523,-0.0962804,-0.381523,-0.141272,0.175726,-0.0968485,0.191715,0.212149,0.19378,-0.206488,0.940974,-0.160414,0.0237509,-0.684487,0.434797,-0.326241,-0.265587,0.808031,-0.585515,-1.47548,-0.585814,0.702233,-0.437636,-0.340193,-0.0897145,-0.186593,-0.0676808,-0.212164,0.643351,-0.0203424,0.674813,0.0922651,-0.000986664,-0.201356,-0.157924,0.0146287,0.650289,-0.266277,0.00318989,-0.102727,-0.100831,-0.112029,0.317164,-0.503006,0.364685,-0.311752,0.40553,0.145885,-0.266734,-0.226267,-0.162035,-0.234099,-0.415211,-0.060663,-0.477394,0.130448,0.0667871,0.13801,-0.31178,-0.472132,-0.0399127,-0.558602,-0.117471,-0.122248,-0.20317,0.234342,0.147543,-0.0767926,-0.290093,0.36771,0.0362674,-0.151591,0.112988,-0.141535,0.229094,-0.312676,-0.495754,0.330952,-0.240114,-0.036394,-0.227041,0.298444,-0.0928182,-0.314205,0.188637,-0.190746,-0.345549,0.015228,0.229468,0.398287,-0.324219,-0.135932,-0.0200169,-0.299318,0.213587,-0.176068,-0.376047,-0.279934,0.27225,-0.336001,-0.135815,-0.0828039,-0.167596,0.453947,-0.262469,-0.290192,0.19448,0.0815112,0.0626027,0.011044,-0.111896,0.110961,0.147916,-0.0746101,0.211251,-0.27741,-0.12681,0.172374,0.448318,-0.410506,0.00303195,0.0437406,0.158234,-0.247447,-0.664048,0.0647509,-0.0423422,0.286833,-0.234858,0.0942246,-0.272923,-0.246661,-0.211741,0.168927,0.50828,0.516667,-0.568316,0.100353,-0.126897,-0.206956,-0.215776,-0.11831,0.0711684,-0.16116,-0.213521,-0.074332,0.16106,0.0396066,-0.0402894,-0.31898,0.143176,0.205889,0.414007,-0.125583,0.0169787,-0.111758,-0.257367,-0.0214916,0.14267,-0.273437,0.0896591,-0.280389,-0.178577,0.92326,-0.0495681,0.106736,-0.0444689,0.139234,0.125867,0.2769,-0.0450501,-0.74936,-0.0131638,0.147785,0.130172,-0.207153,-0.259277,-0.228972,0.00697876,0.0864869,0.09996,0.440796,0.126576,-0.453266,-0.0205498,-0.108823,-0.147998,-0.236334,-0.363291,-0.473795,-0.470493,0.164984,-0.00762006,-0.0582739,0.808961,0.175409,-0.257234,-0.243834,0.0606256,0.304652,0.138149,0.0863243,0.610398,-0.566053,-0.388076,-0.0752071,0.118558,-0.259506,0.478068,-0.161346,0.0137706,-0.0898329,-0.102957,0.362216,0.107028,-0.0546741,0.189672,0.0428449,-0.133626,0.625679,-0.272092,-0.0284211,-0.145587,0.174446,0.358198,0.218287,0.0151689,-0.130501,-0.011438,0.686294,-0.335096,0.288661,-0.142733,-0.438374,0.485696,0.487085,-0.506403,0.449667,-0.271031,-0.0301461,0.518514,0.053023,0.00366819,0.569347,-0.0471107,-0.161211,-0.272382,0.00293763,0.3042,-0.167082,0.0535729,-0.685612,0.332274,-0.224369,-0.0465843,0.216479,-0.283653,0.0863755,0.242549,0.293897,0.492493,-1.33929 +3463.22,0.98632,0.0848144,4,1.62663,0.906388,-0.727517,0.14588,0.200566,-0.156441,0.3409,-0.356008,0.355334,-0.582894,0.233966,-0.0837914,-0.219543,0.398382,-0.300896,0.999929,-0.0903114,0.45315,-0.28197,0.237937,-0.297221,-1.46474,-0.829512,-0.0141602,-0.66787,-0.351925,-0.187285,-0.244635,0.0071538,-0.286973,0.739408,-0.232639,0.173691,-0.184396,-0.147068,0.270984,-0.0213526,0.352263,-0.181419,0.0413081,0.625888,0.672806,0.0602653,-0.758745,-0.192194,-0.611345,-0.480541,0.293062,0.434278,-0.0363743,-0.0261394,0.0616831,0.0955202,-0.452869,1.13341,-0.165049,-0.560873,-0.692679,0.243673,-0.481591,0.600502,0.806762,-0.979471,-0.80765,0.188567,-0.497343,0.287442,0.227589,0.635873,-0.532733,-0.252445,0.393906,0.295558,0.0675651,0.0688376,0.485565,-0.253275,0.0119435,-0.215715,-0.087535,0.30174,-0.153208,0.203597,-0.117729,-0.00451828,-0.0299873,-0.311339,-0.113129,0.0392814,-0.267082,-0.323301,-0.172684,0.166583,0.120378,0.107153,-0.468701,-0.196725,-0.305523,-0.0334113,0.592332,-0.183789,-0.153398,0.110189,0.0698512,0.112121,0.218357,0.213784,-0.0682647,0.438703,0.444684,-0.12477,-0.156997,-0.0108183,-0.041132,-0.0162203,0.122432,-0.358833,0.175095,-0.155543,-0.0380594,-0.529076,-0.228209,0.177759,0.0284235,0.0715198,0.115424,0.224027,0.296282,0.0840518,-0.627667,-0.171978,0.0840188,0.0439547,0.0429454,0.0828599,-0.504665,-0.147036,-0.0429961,0.223745,-0.157116,0.0612562,-0.0180252,-0.120524,-0.0777819,0.0783873,0.262057,-0.349835,0.587413,-0.186133,0.10421,-0.503066,-0.197347,0.202522,-0.171817,0.459378,0.40398,-0.0113755,-0.338898,0.304177,0.0784561,0.497224,-0.0314737,0.441775,0.503072,-0.172561,-0.0182199,-0.116551,0.0147034,0.313915,-0.261949,0.0281355,-0.406889,-0.274519,-0.136884,0.279623,0.0545244,-0.255967,-0.114321,-0.338594,0.614704,0.671603,-0.233236,0.456489,0.0584644,0.239388,-0.0201912,-0.188956,-0.203812,0.182949,-0.354835,-0.175853,0.0158767,-0.276392,-0.48223,-0.680843,-0.071905,-0.478113,-0.384708,-0.122199,0.143949,0.106148,-0.20122,0.179443,0.226897,-0.0353742,-0.108554,-0.228998,0.585197,0.036713,0.0974317,0.0972355,-0.30309,-0.0480313,-0.260727,-0.232926,1.03831,-0.266343,0.475144,0.0343005,-0.122965,0.337948,-0.258642,-0.0158438,-0.165659,-0.461508,0.490753,-0.152534,0.155699,0.286068,0.111825,0.117541,-0.0752802,-0.0672356,0.431406,0.0217163,0.523851,-0.175688,0.00377696,0.10136,-0.440181,0.294786,0.127149,-0.332953,-0.222369,0.0241862,0.0097134,0.125739,0.503022,0.190737,-0.288229,-0.00928669,-0.342188,-0.00813832,-0.550954,-0.195737,0.442844,-0.294305,-0.308786,0.124243,0.196744,0.0433664,0.435241,0.0695233,-0.242143,0.106464,0.153869,0.117734,-0.271913,-0.540389,-0.224,-0.244187,-0.19986,-0.309419,-0.777722,0.429947,-0.311894,0.414312,0.286255,-0.209807,-0.41149,0.286183,-0.530454,-0.132724,0.056287,0.0785088,0.380278,-0.193477,-0.215307,0.14283,-0.138884,0.000738471,-0.0847208,-0.00035573,0.299104,0.000595374,0.235986,-0.182819,0.143655,0.148262,-0.252281,0.375297,0.0813029,0.261438,0.285137,0.51131,-0.358647 +3438.65,0.946397,0.0848144,4,1.6006,0.852961,-0.805877,0.19884,-0.236031,-0.124131,-0.0225204,-0.0993879,0.536132,-0.523005,-0.237303,-0.321616,-0.0845203,0.516987,0.3315,0.8558,0.301452,0.531202,-0.194551,0.0309542,-0.0974504,-1.18263,-0.696249,0.118673,0.0593328,-0.661545,-0.103067,-0.204827,-0.517551,-0.11862,1.08024,-0.68535,0.459864,0.157612,-0.230074,0.173307,-0.373042,0.457611,-0.167883,0.0778836,0.676269,0.545655,-0.128586,-0.686305,-0.000299038,-0.631365,-0.701653,0.0678641,0.525654,-0.14832,0.162332,0.0293936,0.255048,-0.863156,0.842178,0.367732,-0.259002,-0.465176,0.506181,0.0181956,0.429815,0.771074,-0.729878,-1.38514,-0.438439,0.0824717,0.128046,-0.282175,0.633426,-0.642961,0.105561,0.525701,0.515717,-0.393609,0.421947,0.449421,-0.382602,-0.172272,-0.47766,-0.00061297,0.935581,0.173719,0.159686,-0.000740848,-0.113525,0.21492,0.129142,-0.0114279,0.204884,-0.479971,0.335957,-0.359318,0.178114,-0.402596,-0.514263,-0.415826,0.178934,-0.232735,-0.0590949,0.599829,0.512239,0.739791,-0.538993,-0.189346,0.417496,-0.187066,0.0125322,-0.0562377,0.162381,0.47834,0.357312,-0.0803867,-0.194033,0.436724,-0.279409,0.190471,-0.571798,-0.149638,0.223455,0.0337259,-0.0914191,-0.653365,-0.278448,-0.104589,-0.235535,-0.0926991,0.0900374,0.229486,-0.00587643,-0.190615,0.15869,0.0383687,-0.112885,0.288127,-0.395756,-0.31933,0.246147,-0.115837,0.00948394,-0.162227,-0.678746,0.0685939,0.157603,-0.133603,0.33398,0.396102,-0.149644,0.12851,-0.398578,-0.553117,-0.12629,0.0306966,-0.0306873,-0.162932,-0.418989,0.657091,0.648841,-0.478099,0.387047,-0.33671,-0.0257657,0.339096,0.480392,0.283462,0.0549549,0.150196,0.0436037,-0.0447739,0.37848,0.293513,0.221345,-0.368965,-0.00142829,-0.303074,0.384722,0.064115,0.0255286,-0.0731985,-0.326638,0.868762,0.226475,-0.227481,0.283802,-0.1455,0.540849,0.102556,-0.572486,-0.214029,-0.0364666,-0.513712,-0.0218577,-0.050509,0.100517,-0.439596,-0.525532,0.403244,-0.181401,-0.264651,-0.058967,-0.0940575,-0.0929242,0.109232,-0.0587002,-0.414152,-0.12387,0.386125,-0.483836,0.787509,0.155099,-0.154632,0.233243,-0.0780609,0.0795565,0.0550921,0.18538,0.338449,-0.295955,0.405547,0.176257,-0.0653829,-0.163221,-0.560035,0.169162,0.302061,-0.0450761,0.284618,0.167758,-0.0677047,0.0138031,-0.163629,0.307135,-0.179664,-0.673296,-0.0822519,-0.48564,0.18188,0.0186854,-0.619035,0.716511,-0.132215,-0.30153,-0.131411,0.0482275,0.616602,-0.00354282,0.140553,-0.020324,-0.0238438,-0.204319,-0.641479,-0.0221272,-0.300743,0.651714,-0.140322,0.0219143,-0.12576,-0.28166,-0.00721902,-0.0845965,0.0499649,0.0732832,0.146208,-0.0135938,0.349026,-0.345466,0.207017,-0.271834,-0.336146,0.134629,-0.06541,-0.224418,-0.359393,-0.397373,0.46001,0.242575,0.185158,0.35617,0.294943,0.527714,0.103705,-0.00379519,-0.0596469,-0.0398864,0.459918,0.109455,-0.540445,-0.0487564,0.653561,-0.608721,0.591928,0.0515764,-0.140876,0.337222,0.0472868,-0.096775,0.0589561,-0.114421,-0.309939,0.70616,0.168642,0.497404,0.110165,0.334764,0.33191,0.578588,1.14206 +3427.84,0.858342,0.0848144,4,1.55414,0.842151,-0.642175,0.171239,-0.102015,-0.00325451,-0.568518,0.116057,0.475883,0.290037,0.0967021,-0.0235886,-0.373954,0.721522,0.328117,0.425588,0.134414,-0.24388,-0.103736,0.328263,-0.0939217,-1.22773,-0.687253,0.256838,0.0212512,0.167659,0.228567,0.0306831,-0.556925,-0.0839241,1.16073,-0.334389,-0.424781,0.0062157,-0.3695,0.130548,-0.151862,0.174655,0.161465,-0.161016,0.807555,0.310854,0.207944,-0.328872,0.219871,-0.377177,-0.800596,0.423396,0.63004,0.305286,0.174538,-0.233292,-0.0398212,-0.325178,0.961416,-0.0544848,-0.250128,-0.475462,0.696361,-0.19142,0.865961,0.902004,-0.799455,-0.688824,0.246866,-0.11483,-0.088087,0.0978286,0.295448,-0.0420103,-0.317331,0.0144135,0.466964,-0.146812,0.648822,0.454235,0.117064,0.223632,-0.0694268,0.238233,0.734946,-0.155884,0.143322,-0.397197,0.0463803,-0.513586,0.346786,0.425778,-0.147559,-0.230615,0.231236,-0.37908,-0.105596,0.299552,-0.193493,-0.0859068,-0.394783,-0.0328776,-0.219348,0.417316,0.0307373,0.189005,-0.306734,-0.733812,0.276711,-0.140683,0.111314,-0.0570252,0.0526224,0.777915,-0.312934,-0.0246976,-0.0295803,0.347676,0.354307,0.665574,0.105464,-0.061057,0.320894,-0.405227,-0.535601,-0.189676,-0.124225,-0.595478,0.610971,0.26473,-0.185249,-0.179811,0.21492,-0.288761,0.202404,-0.215469,-0.838342,0.404209,0.146942,-0.0877005,-0.355807,-0.0429376,0.218702,0.0398155,0.409483,-0.0788357,0.0112701,-0.260782,0.100546,0.0998048,-0.0648015,0.767294,-0.307208,-0.243043,-0.40776,0.141177,-0.0645868,0.16956,0.636789,0.314537,-0.163063,0.388215,-0.0947976,0.453137,-0.235427,-0.255625,0.383648,-0.34528,0.313772,0.31189,-0.486809,0.334404,-0.353504,0.211541,0.337381,-0.00266168,-0.203464,-0.0148315,-0.771047,-0.308936,-0.468881,-0.356098,-0.256156,0.599111,0.268275,-0.0879995,-0.0799959,-0.860065,-0.0818693,-0.747179,-0.336857,-0.159543,0.238418,-0.202932,-0.182957,-0.0917085,0.347179,-0.45763,0.0561939,0.522489,0.188984,-0.257571,-0.574425,0.0330256,-0.194499,-0.350214,0.128003,0.0301201,0.418373,0.161518,0.0586391,0.60976,-0.183481,0.515165,-0.081475,-0.0686536,0.3224,-0.337551,-0.336921,0.0581831,-0.403295,0.392937,0.804805,-0.850565,-0.0611086,-0.356088,-0.0623836,0.0440659,-0.559721,0.496968,-0.813029,-0.255923,0.152065,0.065608,-0.132562,0.225429,-0.53486,-0.81959,0.158572,0.172005,-0.0774087,-0.178179,0.226745,-0.140234,-0.498615,0.0837894,0.0909413,-0.523249,0.263696,0.421326,0.56997,0.54498,0.255044,-0.21409,-0.578885,-0.786986,-0.0360108,-0.20475,-0.396458,0.02794,-0.429884,0.354512,-0.613802,-0.251325,0.284597,0.338443,-0.0599623,0.0881564,0.350301,0.344326,-0.177554,0.349093,-0.218996,0.179314,0.430907,-0.114196,-0.456858,0.338376,-0.306091,-0.301934,0.309145,-0.122628,0.247699,0.0172654,-0.317217,0.165739,-0.275331,-0.495988,-0.16738,-0.140598,-0.178434,0.0514954,0.0250605,0.0123302,-0.0513429,-0.162382,0.0495436,0.385211,-0.535835,-0.585502,-0.0293024,-0.569311,-0.632448,-0.0251623,0.0654787,0.11617,0.169018,0.340837,0.411119,0.57975 +3453.34,0.904337,0.0848144,4,1.6326,0.785309,-0.945407,0.303555,0.135951,-0.0841839,-0.00488577,0.161362,0.194522,0.0257609,-0.218167,-0.0143112,0.254914,0.461696,-0.10527,0.525398,0.427696,0.0949977,-0.359464,-0.146,-0.119953,-0.629183,-0.596985,0.311944,-0.362511,-0.147322,-0.108054,0.212233,-0.0270629,-0.176168,0.60519,-0.155993,0.138248,0.452292,-0.358612,-0.20545,-0.279933,0.0889308,0.193622,-0.472819,0.667053,0.0296402,0.209932,-0.68543,-0.121157,-0.0937068,-0.473319,0.15739,0.417622,0.129699,0.112672,0.791659,0.0875065,0.0111241,0.66756,-0.142082,0.0708632,-0.494438,0.625719,-0.358069,0.0263659,0.773925,-0.834891,-0.759495,0.224303,0.422131,-0.149902,0.189545,0.0947645,-0.407918,-0.347548,-0.0952788,0.386984,0.0757483,0.619612,0.279284,0.589937,-0.300529,-0.445393,0.308966,0.476867,-0.658006,0.230802,-0.373651,-0.125186,0.162045,-0.539641,-0.00840195,0.379938,-0.426459,-6.66929e-05,0.115998,0.131744,-0.335223,0.299695,-0.269847,-0.625346,-0.106253,0.242914,0.505635,0.497924,0.215162,-0.169282,-0.513288,-0.295129,-0.131798,-0.19178,-0.0776045,-0.146178,0.492177,-0.0224524,-0.187517,0.156635,0.519829,0.179456,-0.12103,-0.873705,-0.195148,-0.141365,0.262388,-0.774367,-0.119251,0.182458,-1.01226,0.454236,0.0815097,-0.359204,0.246652,0.00417793,-0.103493,0.188679,-0.321694,-0.232127,0.465904,0.000635069,-0.252212,-0.334781,-0.28247,0.0675289,-0.541364,-0.0232124,-0.197649,-0.166973,-0.908291,0.00547312,0.0222608,0.139552,0.0589776,-0.0793374,-0.406423,0.404018,-0.0125069,0.311695,-0.388961,-0.127712,0.058179,0.237574,0.0383657,0.530573,-0.294465,-0.0113367,0.318618,0.856273,0.071081,-0.306111,0.156136,-0.201477,-0.547497,-0.384533,-0.144755,0.585173,0.0714888,0.0888382,-0.238318,0.346219,0.211437,-0.675931,0.285932,-0.204968,0.757626,0.458872,0.238532,-0.198153,0.154327,-0.303771,-0.0746673,-0.265307,-0.0735545,-0.310522,-0.487263,-0.0280835,0.532802,0.259067,-0.652526,-0.0478635,0.209675,-0.302338,-0.287501,0.0026086,-0.603047,0.00835309,-0.619947,-0.268836,-0.313226,0.0261387,0.216362,-0.374233,1.17436,0.623692,-0.117857,-0.377476,-0.232878,0.276482,-0.346331,-0.180472,0.120342,-0.418481,0.321434,0.603486,-0.223396,0.270037,-0.56578,0.1484,0.192862,-0.421835,0.201091,-0.158818,-0.1492,0.290147,-0.241626,-0.567659,-0.0310869,-0.182222,-0.249832,-0.520738,0.256299,0.245112,0.294642,0.659241,-0.221193,-0.292449,0.192463,-0.0663435,-0.0144917,-0.0381715,0.171437,0.223593,-0.075427,0.389167,-0.597747,0.316328,-0.179654,-0.227383,-0.0166809,-0.485766,0.188603,-0.433968,-0.161449,0.335469,0.0233481,0.0810396,0.0312049,-0.116868,0.345224,0.340152,0.353973,-0.0437397,-0.436274,0.0928293,0.0918445,0.0500567,-0.131809,-0.195007,0.00415527,0.0846382,-0.152357,0.0410204,0.0573885,0.330315,0.0979969,-0.0429662,-0.219267,-0.624784,-0.216248,0.00553149,0.273963,0.0828384,0.140228,0.124235,-0.543143,0.00753816,0.20819,-0.170671,0.276243,-0.465236,-0.760927,-0.132219,0.0780998,-0.224364,0.261547,-0.233043,0.11109,0.147969,0.333301,0.384667,0.0227838 +3460.54,0.993775,0.0848144,3,1.62685,0.857652,-0.9205,0.285093,0.544634,0.0321487,-0.142534,0.470403,-0.0371671,0.160333,-0.0204626,0.086522,-0.138589,0.588522,-0.347271,0.337268,0.0986285,-0.190685,0.24388,-0.224417,-0.252926,-0.769471,-0.802404,0.333545,-0.550239,-0.0592167,-0.294736,0.30935,-0.418835,-0.126936,0.623987,-0.232482,-0.38135,0.350168,-0.0228914,-0.401175,-0.240645,0.441121,-0.0435112,-0.198167,0.71462,-0.0687982,-0.5409,-1.03675,-0.0805316,0.113993,-0.424354,0.277965,0.480614,0.180334,0.0424737,0.335695,0.196875,0.284478,0.646872,-0.329849,0.163142,-0.176985,0.786863,-0.0778267,-0.102223,0.887035,-0.351517,-0.712422,0.397872,0.552252,0.0357449,0.00944547,-0.111341,-0.312735,-0.498003,-0.296002,0.400789,0.0773909,0.886501,0.42467,0.461421,-0.042578,-0.4879,0.157057,0.123462,-0.378879,0.0283293,-0.0980565,-0.104476,-0.372957,-0.232803,-0.438957,0.409924,-0.0607146,0.168485,0.0404888,0.243436,-0.0256048,0.105561,-0.150154,0.0643935,-0.45434,-0.117538,0.499967,0.247728,-0.043698,-0.0546522,-0.300793,-0.160269,0.0192645,0.139843,-0.331091,0.0982318,0.485043,-0.0526532,-0.377884,-0.455101,0.343714,0.116265,0.10896,-0.00613357,-0.175172,0.202764,-0.193995,-0.684959,-0.271716,0.430415,-0.683682,-0.126502,-0.0110482,-0.374921,0.352314,0.541509,-0.122537,-0.156177,0.127268,-0.0732944,0.52066,-0.187158,0.186168,-0.0701866,-0.299624,0.595189,-0.3282,0.0355479,-0.256706,-0.0579363,-0.373197,0.0572108,-0.0725085,-0.080351,0.318777,0.259177,-0.387303,-0.123966,-0.00424253,-0.0206311,0.268734,0.0291334,-0.123925,0.210587,-0.298618,0.0285805,-0.0621918,0.215807,0.190234,0.585674,0.229089,-0.163019,-0.0883832,-0.247577,0.184694,-0.302716,0.391502,0.262872,-0.106378,0.2035,-0.0429667,0.148507,0.0808766,-0.926321,-0.384205,0.257096,0.544128,0.198224,-0.223973,0.229857,0.162481,-0.213217,0.0858554,-0.0740224,-0.0367269,-0.0152956,-0.295836,-0.267395,-0.156213,0.0260615,-0.712648,-0.123081,0.0391998,-0.277614,-0.483555,-0.251037,-0.391181,-0.299623,-0.515865,0.149661,-0.229222,0.394234,0.00118373,-0.320517,0.913531,0.198317,0.242928,-0.520816,0.137265,0.387485,-0.671872,0.0430234,0.619263,-0.446653,0.450349,1.0659,0.0842646,0.233886,-0.518286,0.246378,0.0261391,-0.289183,0.498974,-0.35919,0.0632478,-0.346976,0.00605146,-0.830065,0.265872,0.027044,-0.335581,-0.119585,0.29154,-0.0572523,0.0567938,0.313522,-0.231468,-0.0340901,0.0795532,0.0491217,-0.233611,0.240843,0.230763,0.219065,0.111808,-0.513651,-0.572997,0.498045,-0.138117,0.147311,-0.0940896,-0.51408,0.31697,-0.517157,0.0935543,0.360199,0.066527,0.380282,0.204111,-0.0626035,0.114182,-0.236667,0.092212,0.127501,-0.0984877,-0.280109,-0.0179267,0.179564,-0.116029,-0.0352039,-0.363479,-0.109723,0.00272526,0.272189,0.2251,0.139477,0.125448,0.268359,-0.0300731,-0.098705,-0.486947,0.284957,0.36935,0.382424,0.326751,-0.131628,-0.428133,0.0655328,-0.0160803,-0.150855,0.239932,-0.520864,-0.446403,-0.249297,-0.260781,0.0341073,-0.288509,0.185698,0.105269,0.174401,0.324452,0.417614,-1.49227 +3462.09,0.984574,0.0848144,4,1.64596,0.781645,-0.679185,0.267819,0.360995,-0.191803,0.13478,-0.3224,-0.0136722,-0.286329,-0.408139,-0.667904,-0.152905,0.353649,-0.0813057,0.919715,-0.20169,0.0463477,-0.490654,0.159755,-0.0100751,-0.839719,-0.596096,0.216509,0.119091,0.0322448,-0.119465,-0.0645124,0.224183,-0.11679,0.705255,-0.885822,0.0376683,-0.157034,-0.452991,-0.159345,-0.382631,-0.18127,0.391128,-0.514142,0.693324,0.576773,0.431995,-0.17979,-0.126384,0.153302,-0.641311,-0.383528,0.508149,0.00292798,0.199005,0.208467,0.211602,-0.926073,0.797207,-0.30273,-0.451527,-1.19307,0.616487,-0.579111,0.280008,0.87253,-0.945362,-1.05454,-0.451685,-0.328394,0.00267334,0.0372774,-0.112277,0.102159,0.426079,0.231085,0.655564,-0.15595,0.179227,0.553677,0.0152973,-0.0256807,0.250712,0.0239259,0.655911,-0.336311,0.172189,0.00731971,-0.384325,0.614754,0.174614,0.0597206,-0.257482,-0.278542,0.0480865,-0.0172529,0.0319793,0.152903,0.421012,-0.47245,-0.100598,0.371468,0.4065,0.114038,-0.200614,0.194782,-0.334392,0.0827369,0.153434,-0.398376,0.315207,0.0320216,0.018886,0.229235,-0.202579,-0.0705615,0.533068,0.380544,0.157051,0.245084,-0.0967812,-0.22065,0.0925189,-0.0785821,-0.350572,0.0355656,-0.0688945,0.411469,-0.36151,0.155617,0.502071,0.0143441,0.466896,-0.352501,0.25243,-0.0830597,0.0284232,-0.0170603,-0.0243901,-0.132062,-0.0735226,-0.130427,-0.0747883,-0.273762,-0.301195,0.114978,0.0785942,-0.204447,0.2466,0.135992,-0.270013,0.352244,-0.302197,0.0281607,-0.115086,0.399622,0.173671,-0.0488187,0.147754,0.433385,0.162192,0.0519715,0.293418,0.271384,0.439124,-0.217762,0.570073,-0.219568,0.0211228,0.284118,0.0237226,-0.200806,-0.126598,-0.406521,-0.105933,0.0736265,-0.248027,0.0708315,-0.146799,-0.33843,0.0449667,0.149189,-0.133732,0.424424,0.140288,-0.139695,0.0301469,-0.220011,0.0663915,-0.231324,-0.244127,0.140103,0.348634,-0.31003,0.132522,0.0179361,0.097779,0.0609176,0.055799,0.268687,0.375294,0.1193,-0.565762,0.441252,0.0295685,0.0688884,-0.0881743,0.338186,-0.161088,-0.292654,0.011751,1.04638,0.0646778,0.241567,0.698266,-0.107236,0.136048,0.770708,0.232173,0.0224583,0.0699319,0.309195,-0.458615,-0.441915,0.0260192,-0.0560031,-0.37721,0.194249,0.0994368,0.228472,-0.373256,-0.287311,0.421915,0.00581622,0.390626,-0.0533866,-0.100032,0.169168,-0.230024,-0.0560704,0.148369,-0.04543,0.364764,0.11525,-0.0575079,0.127797,0.13156,-0.159165,0.414138,0.229315,0.753087,0.322727,0.356907,0.173491,-0.237096,-0.478459,0.476585,-0.0840083,0.297446,0.206569,0.156795,0.0367615,-0.0695993,-0.114997,-0.261468,-0.0178434,-0.111738,0.101717,-0.0470392,0.471922,0.102852,0.0133628,0.399563,0.165104,-0.220179,0.0555473,-0.412757,0.788641,0.0633269,0.157927,-0.0264232,-0.0577121,0.0585712,0.232345,-0.3301,-0.303199,-0.0218118,0.535001,-0.201033,-0.299057,-0.679523,-0.303275,0.17586,0.106747,0.0241303,0.175626,-0.147787,-0.28424,-0.120749,-0.123538,0.113556,0.0278069,-0.121764,0.177725,-0.360194,0.085031,0.204892,0.291601,0.45265,-0.783562 +3460.56,0.726594,0.0848144,4,1.59536,0.845933,-0.77175,0.231038,0.123047,-0.130194,0.501117,-0.553391,-0.063287,0.147538,-0.400995,-0.378511,-0.113907,0.290231,0.0512697,0.677956,0.351655,-0.115865,0.0455911,-0.0331834,-0.246392,-0.565997,-0.870742,0.367318,-0.730292,-0.364973,-0.287679,-0.101672,-0.296882,-0.310372,0.956646,-0.684634,0.239663,-0.0689951,0.047355,0.202922,-0.386119,0.302213,0.347382,-0.514631,1.11265,0.462509,0.071416,-0.775803,-0.228206,-0.45595,-0.444143,-0.485765,0.783102,0.140747,0.33343,-0.00328121,-0.0638455,-0.233648,0.673301,-0.592053,-0.331934,-0.231947,0.538193,0.00692945,0.259175,1.03238,-1.1383,-0.844899,0.34526,0.0402535,-0.356684,-0.0785929,-0.28389,-0.146259,-0.384842,0.359514,0.463717,-0.387288,0.275123,0.434397,0.362191,0.0315318,-0.803833,-0.232442,0.114821,0.0376589,0.169715,-0.267779,-0.118863,-0.178652,-0.105425,-0.538787,0.00975089,-0.23813,0.633981,-0.219334,0.429535,0.0656934,-0.512539,-0.225462,0.0680385,-0.607582,0.116884,0.0338004,0.043762,0.00800934,-0.442577,-0.232376,-0.143219,0.199112,-0.397978,-0.722559,0.532473,0.429218,-0.134999,-0.182801,-0.177516,0.357721,0.0364421,0.291334,0.168937,-0.0565848,0.395958,-0.253043,-0.751554,0.557251,0.246812,-0.500487,-0.286291,-0.404405,0.066218,-0.04502,0.470558,-0.322525,-0.0543324,0.229024,-0.0504304,0.0780604,-0.106612,-0.0250728,0.146671,0.0591622,0.212921,-0.605834,-0.277722,-0.144914,0.604934,-0.101479,0.289608,0.257512,-0.279416,0.0455332,0.0332782,-0.485592,-0.361172,0.0509219,-0.13053,-0.0211457,0.0688953,-0.0353996,0.092009,0.0600276,-0.0413646,-0.306635,-0.149867,-0.169157,0.604229,0.306227,0.0889953,-0.310353,-0.319684,-0.213105,-0.15142,-0.264473,0.299694,0.105183,0.127569,-0.00416176,0.208989,0.201932,-0.266566,0.160183,-0.157105,0.452772,0.109006,0.155609,0.0804511,-0.378343,0.252789,-0.0919213,-0.553515,0.146575,0.390335,-0.443276,0.186003,-0.0597356,0.00139172,-0.631453,0.119795,0.133699,-0.531335,-0.20145,-0.230745,0.469799,-0.167854,-0.0967747,-0.000627256,-0.238673,0.192558,-0.28587,-0.23874,0.533655,-0.143976,-0.326517,-0.0721275,-0.259586,-0.292216,-0.653244,-0.181157,-0.114387,-0.018223,0.0623439,0.146124,-0.0186008,-0.0224039,-0.207081,0.642683,0.246013,-0.26425,0.179829,-0.309325,-0.0534498,0.18479,0.307167,-0.156931,0.233918,0.366777,-0.145637,-0.352176,0.224682,-0.298406,-0.0987827,0.154691,0.409792,0.0214593,0.434219,-0.206672,0.299767,-0.0568575,0.322087,0.63589,0.0915457,-0.0134891,-0.310589,-0.537573,-0.207152,0.181787,-0.0911048,-0.295022,-0.0369669,-0.309938,-0.0296957,-0.369633,0.201877,0.442883,0.396549,-0.0464781,-0.0257735,0.382295,0.17154,-0.111257,-0.0749103,-0.695763,0.291243,-0.0268566,-0.0269421,0.0784312,0.0256588,-0.0506949,-0.266235,0.271375,0.389995,0.140573,0.123056,0.261944,0.0754745,-0.457567,0.260518,-0.402466,0.0670269,0.0258333,0.318596,0.0365076,-0.211386,0.236299,0.124985,-0.0798537,0.0609202,0.0430473,-0.313192,0.0084408,-0.0986137,0.360532,0.0631368,0.591654,0.0825761,0.253253,0.287361,0.503243,-0.0897672 +3459.78,0.564891,0.0848144,4,1.60614,0.858084,-0.834724,0.24464,0.1444,-0.137529,0.533044,-0.570693,-0.081278,0.18731,-0.286088,-0.372787,-0.0534326,0.332049,0.0664878,0.656427,0.344688,-0.160806,0.0513824,-0.0312002,-0.229753,-0.629279,-0.721188,0.380686,-0.762508,-0.415241,-0.297846,-0.0457362,-0.336828,-0.294715,0.964882,-0.688716,0.241562,-0.0286905,0.120647,0.307552,-0.440999,0.438822,0.377279,-0.56109,1.06893,0.498769,0.0468272,-0.777962,-0.237785,-0.472544,-0.376652,-0.455674,0.787326,0.0847361,0.313209,0.0419488,-0.115743,-0.25658,0.524503,-0.675122,-0.298408,-0.239256,0.507652,0.0281295,0.247392,1.02918,-1.13378,-0.901559,0.324445,0.089808,-0.309516,-0.042645,-0.297903,-0.113648,-0.43143,0.41295,0.528935,-0.327938,0.264095,0.37164,0.348682,-0.022286,-0.856072,-0.186411,0.0880981,0.00837893,0.127477,-0.293343,-0.141417,-0.240965,-0.102987,-0.520326,-0.0855302,-0.254443,0.639638,-0.26105,0.411197,0.0734369,-0.478406,-0.171326,-0.0196911,-0.596201,0.139095,-1.34068e-05,0.022223,0.0194766,-0.417265,-0.202811,-0.0897421,0.222025,-0.333941,-0.690752,0.570689,0.394069,-0.033361,-0.187077,-0.124766,0.398554,0.0319661,0.238045,0.176845,-0.0807807,0.311816,-0.240065,-0.725374,0.576938,0.169012,-0.43265,-0.38083,-0.365115,0.0145491,0.0062003,0.447301,-0.312797,-0.0988645,0.149957,-0.0458735,0.0834761,-0.0833862,0.0188373,0.115442,0.0209728,0.143996,-0.635505,-0.177204,-0.166342,0.459247,-0.0655263,0.274496,0.242749,-0.253186,0.121938,0.0280054,-0.510568,-0.341508,0.0704267,-0.143643,-0.0158742,0.0849374,0.000965202,0.15981,0.101709,-0.0191879,-0.358126,-0.159147,-0.213353,0.600283,0.218173,0.103596,-0.266984,-0.344775,-0.141575,-0.147406,-0.210453,0.273001,0.0282812,0.142694,-0.0546705,0.163877,0.237099,-0.294818,0.209995,-0.135028,0.449241,0.114828,0.215133,-0.0114961,-0.328863,0.22777,-0.040028,-0.639711,0.180977,0.36251,-0.441294,0.18566,-0.03508,0.0102217,-0.543571,0.0438634,0.210367,-0.546354,-0.194841,-0.249136,0.45894,-0.200058,-0.0171474,0.0112083,-0.152077,0.226633,-0.244658,-0.21316,0.54605,-0.0908622,-0.208771,-0.0401159,-0.257979,-0.346667,-0.623828,-0.196876,-0.165308,-0.0717323,0.0550862,0.0891835,-0.147891,0.0260771,-0.216555,0.640435,0.295836,-0.230324,0.220203,-0.317022,0.00750849,0.213865,0.373565,-0.263631,0.276836,0.335433,-0.0868948,-0.356986,0.215469,-0.231011,-0.0280434,0.147409,0.437298,-0.00350491,0.390387,-0.260044,0.324414,-0.0365598,0.356852,0.65812,0.133214,-0.0506107,-0.328581,-0.58756,-0.1839,0.221911,-0.084868,-0.224066,-0.0884995,-0.208643,-0.121561,-0.335925,0.215633,0.513291,0.337353,-0.0890194,0.0126529,0.381048,0.14159,-0.0687676,-0.044349,-0.608675,0.237311,0.0542801,0.0317214,0.128861,-0.061286,-0.0665763,-0.220731,0.257525,0.483693,0.0392479,0.237268,0.341584,0.0495858,-0.671447,0.155432,-0.356779,0.0944692,0.0433181,0.307489,0.139174,-0.337837,0.215857,0.130673,-0.0638725,-0.040093,0.0541077,-0.40839,-0.0641268,-0.0433489,0.296235,0.143581,0.57041,0.0813252,0.255152,0.285176,0.505125,-0.149338 +3440.81,0.741209,0.0848144,4,1.62651,0.996664,-0.105491,-0.100955,-0.0324643,-0.131263,-0.660577,0.067355,0.163556,0.243265,0.229966,-0.209457,-0.494359,0.483337,-0.442471,1.07743,0.198899,-0.253465,-0.443876,-0.0435257,-0.2753,-1.44334,-0.635908,-0.00235759,-0.0307504,-0.292092,0.117348,0.492341,-0.455756,-0.110261,0.792721,-0.324592,-0.990928,0.242585,-0.304783,-0.295892,-0.329256,0.389398,-0.0698671,-0.609785,0.906913,0.16915,-0.243732,-0.625563,-0.0669489,-0.00116342,-0.841828,0.0993042,0.603487,0.309283,0.00904526,0.308309,0.0324413,-1.1863,1.07225,-0.206323,-0.0445902,-1.44401,0.609092,-0.653602,-0.175768,0.717075,-0.611998,-1.64337,-0.523477,0.128825,0.319074,-0.00746525,0.345372,-0.551107,0.247308,-0.0268821,0.48175,0.373232,0.295437,0.326866,0.19432,-0.11884,0.190522,-0.0919948,0.619079,-0.498351,0.154663,-0.0412085,-0.0918445,0.214918,-0.115454,0.430088,0.321393,-0.392161,-0.713943,0.339587,-0.564303,0.0295965,0.603457,-0.325506,-0.317991,0.465816,0.111011,0.450223,-0.00638427,0.0244881,-0.0873012,-0.1284,0.0871839,-0.738132,0.711188,0.0343478,-0.366737,0.699687,-0.23431,0.114795,0.118559,0.411282,0.186927,0.0594701,-0.281508,-0.0225945,-0.0172845,0.166269,-0.377132,-0.760019,-0.210305,0.206458,0.295716,0.733981,0.209282,-0.00288765,-0.137786,-0.197041,0.321763,-0.266796,0.261438,0.397009,-0.312295,-0.206381,-0.262289,-0.459508,0.0904121,-0.0555719,-0.319311,-0.077651,-0.22703,-0.488806,-0.196014,-0.360445,0.100416,0.500583,-0.353379,0.380866,0.220136,-0.0632883,0.742037,-0.0176434,0.00271056,0.24407,-0.102772,-0.0334059,0.0553392,0.263536,0.261034,0.158558,0.561403,-0.424673,-0.31106,0.369876,-0.0859262,-0.105603,0.0363558,-0.098475,-0.0278361,-0.152642,0.0184577,0.114491,-0.115575,-0.0379722,-0.362689,-0.338987,0.551267,0.456362,0.162413,-0.396364,0.242496,0.207914,-0.130547,-0.245021,0.248688,-0.638402,-0.100107,0.0543839,-0.300518,0.0852286,-0.238231,-0.292613,0.0999603,-0.0528665,0.338747,-0.52437,-0.437668,-0.664218,-0.0423049,-0.172609,0.29754,-0.0356328,-0.475795,0.16291,-0.284058,0.96747,0.0454497,0.512083,-0.171755,0.375365,0.711261,0.70856,-0.171152,0.722794,-0.0721551,0.206682,0.161349,-0.20167,-0.0397977,-0.352427,-0.908715,-0.199261,-0.20428,0.107202,-0.213493,-0.209437,-0.34107,-0.31956,-0.0819809,0.0888405,-0.504122,0.0369747,-0.0320103,0.316904,0.371556,0.13643,0.448008,-0.765591,-0.089483,-0.352344,0.213194,-0.385607,0.558453,-0.383281,0.0528539,0.17256,0.173483,-0.0903468,0.591362,-0.755119,0.431302,-0.118443,-0.118226,0.283257,-0.353551,0.114494,0.392208,-0.116224,-0.219024,0.148422,0.266305,0.0100176,-0.105684,0.256926,0.0838704,-0.042421,0.566522,-0.248881,0.0975903,-0.235939,-0.545461,-0.0346402,0.236364,0.480863,-0.021751,-0.417797,0.378638,-0.124408,-0.449261,-0.335714,0.312291,-0.0010971,0.196728,0.0206101,-0.00262895,-0.247881,0.0527494,0.0586656,0.0110069,0.284204,0.346124,0.345717,-0.386643,-0.0219357,0.212658,-0.172905,-0.468569,-0.265416,-0.618553,0.115127,0.339615,0.339303,0.582765,0.156219 +3438.88,0.543307,0.0848144,4,1.60047,1.02382,0.0275822,-0.178747,-0.311763,-0.0738557,0.0833853,-0.183775,0.276454,0.345221,0.0260018,-0.0845961,0.365305,0.497497,-0.245677,0.932752,0.381981,-0.208774,0.379086,-0.107029,-0.0512585,-1.07565,-0.591301,0.0132747,0.316019,-0.1555,-0.0791907,0.421503,-0.0482571,-0.193396,0.746969,0.163452,-0.502512,-0.0912102,-0.561944,-0.094542,-0.568078,0.302158,0.223788,-0.709866,0.961052,0.565005,-0.307599,-0.399156,0.268621,-0.464921,-0.176691,0.220996,0.60183,0.148036,0.270246,-0.864109,0.41329,-0.338502,1.20995,0.205081,-0.251813,-0.68107,0.52316,-0.259932,0.0106683,0.990976,-0.538619,-0.965242,-0.309239,0.52504,0.39726,0.188,-0.128069,-0.421437,-0.14968,0.101862,0.469096,-0.0132193,0.21766,0.208466,0.766768,-0.200974,-0.326734,-0.225951,0.79035,-0.209419,0.0813057,0.0181678,0.168135,0.178517,-0.220649,0.274194,0.411145,-0.309369,0.21079,0.0143937,0.0424453,0.067927,0.0397723,-0.0748574,-0.184572,-0.530069,-0.120121,0.174933,-0.319522,-0.152252,-0.481006,-0.424238,0.25135,-0.547034,0.234896,-0.360059,0.227051,0.265763,0.0462494,-0.215719,0.442923,0.179501,-0.231506,0.120718,-0.184873,0.0257028,0.488509,-0.326711,-0.195978,-0.171841,-0.13194,0.157049,0.13555,-0.418225,-0.127381,0.447134,-0.489884,-0.308861,0.529355,0.0470764,0.567274,0.285803,-0.263801,-0.385303,0.301305,0.000142699,0.0462391,-0.221661,-0.335711,0.248444,0.260911,-0.473905,0.443241,0.204148,-0.28614,0.453661,0.0900836,-0.643827,0.205974,0.10795,-0.0823332,0.362011,-0.0536038,0.179363,0.0720762,0.249102,-0.0222503,-0.0595825,0.453581,-0.245855,0.214837,-0.0639197,0.0315169,0.0481567,0.107527,-0.485335,0.21203,0.249526,0.0845596,0.236372,-0.116698,-0.475802,-0.241354,0.69726,-0.386689,-0.148048,0.0940957,0.264916,0.297339,-0.225681,0.595108,0.171295,-0.0683369,-0.276661,-0.226792,-0.224757,0.241749,-0.504646,-0.0229739,0.445633,0.198679,-0.913228,0.0276359,0.0137936,0.000243813,-0.643679,-0.0147039,0.785271,0.00540826,-0.371877,-0.488928,0.123767,0.101718,-0.163103,-0.6683,0.703279,-0.51367,1.08914,0.484057,-0.064555,0.105475,-0.415595,0.401717,-0.172529,-0.203745,0.000545222,0.265096,-0.127542,0.162836,-0.206388,-0.387016,-0.121783,-0.872181,0.349359,-0.690999,0.179328,-0.0355408,-0.51808,-0.791875,-0.129899,-0.523171,-0.175455,0.313806,0.333609,0.595628,-0.0101091,0.23578,0.0320784,-0.180234,0.542628,-0.0947953,0.0706246,0.0401141,0.263796,-0.108335,-0.235529,-0.0136217,-0.516261,0.105043,-0.338436,0.285983,-0.0663621,-0.260725,0.436164,-0.717855,0.144983,-0.0661974,0.104862,0.0454686,0.315157,0.716015,0.27961,0.0224523,-0.379102,0.0380456,0.094917,-0.131513,-0.0395958,0.130489,-0.149995,-0.242617,-0.265389,-0.237996,0.306303,0.269993,-0.227414,-0.261786,-0.0154228,-0.350512,-0.568152,-0.217651,-0.0607766,0.177543,0.00225416,0.116415,0.00614112,-0.0851612,0.160989,-0.114509,0.291078,-0.353182,0.0375103,0.209357,-0.425479,-0.0776375,0.0709998,-0.703557,0.548282,-0.072544,0.116516,0.236774,0.341345,0.486595,0.998887 +3433.45,0.915403,0.0848144,4,1.59764,1.16289,0.287413,-0.350263,-0.429266,-0.214754,0.0345985,0.0477284,0.691204,0.868528,-0.163118,-0.0576947,0.158413,0.707585,0.051218,1.26165,0.337917,-0.438311,-0.602312,-0.138151,-0.312488,-1.4176,-1.02807,-0.157331,0.0413002,-0.0821491,0.303791,0.26097,-0.304889,-0.145619,0.503534,-0.470433,-0.369247,-0.173636,-0.146702,0.00570437,-0.866689,0.121742,0.541843,-0.805464,1.38468,0.759074,-0.38478,-0.535379,0.0355282,-0.165696,-0.525338,0.369656,0.882816,-0.0308858,0.351963,0.249312,0.354525,-0.782425,1.17435,-0.134991,-0.0412031,-1.00729,0.550055,-0.650597,0.416471,0.75073,-1.34855,-1.04296,-0.129491,-0.0386709,0.343125,0.0909998,-0.069223,-0.507854,-0.31776,0.203852,0.325189,0.00881944,0.252918,0.0835724,0.505684,0.209203,-0.24733,-0.169588,0.290045,-0.257876,0.0553657,-0.0630323,-0.359129,-0.105263,0.431657,0.19012,0.14394,-0.282322,0.0881941,-0.163597,-0.193468,-0.19857,0.0453155,-0.606659,-0.0330824,-0.488616,0.518239,0.0841221,-0.2631,0.0863244,-0.362682,-0.428826,-0.331579,-0.3483,0.411226,-0.430524,0.436709,0.38446,0.0291775,-0.160613,0.213412,0.333974,-0.287101,0.441289,-0.159007,-0.242159,0.0686712,-0.377677,-0.323227,-0.242997,-0.121775,0.422508,0.133202,0.168248,-0.0894469,-0.286371,0.112093,-0.13015,0.342703,-0.211683,0.225974,0.13226,-0.299539,-0.551364,0.124479,0.126104,0.0566694,0.222839,-0.537717,0.122732,-0.0508873,-0.176641,0.0583092,0.201621,0.435638,0.392373,0.0705157,-0.383313,-0.231255,-0.0574153,0.0845001,0.414472,0.39475,0.123189,-0.3533,0.373003,-0.0010369,-0.12372,0.592203,-0.404801,0.359237,-0.507194,-0.913466,-0.430909,-0.161158,-1.0079,0.143972,0.705746,-0.146866,-0.186683,-0.133397,0.0434992,-0.264212,-0.0406421,-0.452467,-0.00140729,0.49294,0.73782,0.297596,-0.661038,0.711134,-0.179427,-0.0759539,-0.584726,-0.235253,-0.385341,-0.0729492,-0.848995,0.123805,0.523488,-0.12899,-0.170513,-0.0642814,0.198875,0.364528,-0.459576,0.249774,1.04853,-0.207398,-0.436801,-0.0156759,0.22958,-0.189124,0.0769765,-1.01519,0.982879,-0.186884,0.768206,-0.280254,-0.11584,0.59995,0.230481,0.365846,0.282167,-0.335264,-0.166476,0.0821289,0.0538952,0.128758,-0.139663,-0.454929,0.0132,-0.656301,0.0212017,-0.39191,0.0542299,0.221339,-0.324958,-0.996919,-0.0838819,-0.372429,0.0562842,0.409182,0.196148,0.392136,-0.178784,0.258229,-0.216911,-0.337781,0.0864712,0.156445,0.117829,0.442932,0.242181,0.0164395,-0.0538381,-0.120109,-0.296322,-0.447511,-0.527945,0.152084,0.0429218,0.0911825,0.341265,-0.382204,-0.130772,-0.0543709,0.318381,0.0710424,0.202649,0.310404,0.203761,0.455645,-0.247218,0.135874,0.0411852,-0.021652,-0.289218,0.344126,-0.285878,-0.291545,0.150731,-0.348982,0.117995,0.0985808,-0.224313,0.148021,-0.0722709,0.0933535,-0.161717,-0.36499,0.612697,0.163502,0.169835,-0.234373,0.374496,0.363838,-0.476819,-0.203963,0.101858,0.102503,0.584362,0.0912529,-0.0552467,-0.195983,-0.381193,-0.181251,0.303956,0.267139,0.113228,0.294016,0.336494,0.542233,1.20164 +3413.79,0.898046,0.0848144,4,1.60647,1.12346,-0.405299,-0.0350844,-0.359976,-0.159903,-0.0385271,0.0924861,0.134391,0.331319,-0.643427,-0.263809,-0.0231519,0.491551,0.0473079,0.827828,0.228759,0.0198001,-0.511198,-0.226,-0.553283,-0.998422,-0.635108,0.0873295,-0.217078,-0.0712068,0.355569,0.239583,-0.268525,0.225796,0.319398,-0.225857,0.0107018,0.0307909,-0.785906,-0.139633,0.0126069,0.209424,0.564879,-0.698352,1.01063,1.02613,-0.212128,-0.578139,-0.364068,0.188561,-0.902062,0.143157,0.671142,-0.109426,0.164314,-0.228293,0.677364,-0.755733,0.756417,-0.269111,0.0254899,-0.707768,0.425326,-0.0482808,0.101031,0.847257,-0.372151,-0.707437,0.134036,-0.0482369,0.345277,0.171195,0.0453047,-0.55147,-0.272999,0.0423198,0.538631,0.187203,0.441354,0.0537666,0.264837,0.0670143,-0.149642,-0.302026,0.48128,-0.209509,-0.046853,-0.587488,-0.491784,-0.0616292,-0.309712,-0.181717,0.141816,-0.225763,0.387239,-0.0211674,0.326094,-0.113848,-0.00293459,-0.440337,-0.251278,-0.354932,-0.103345,0.267994,-0.278867,-0.546063,-0.466189,-0.026219,-0.0442875,-0.435486,0.689862,-0.0461805,0.203513,0.571931,-0.0169147,-0.202513,0.25397,0.159412,-0.560204,0.0699756,0.0392423,-0.331584,0.693561,-0.209087,-0.367029,0.19521,0.00422342,-0.488002,0.111238,0.73477,-0.011819,0.522862,0.362478,-0.142115,0.133393,-0.0980518,-0.134179,0.363877,-0.0642475,-0.119036,-0.0622414,-0.15719,-0.101883,0.0880175,-0.853902,-0.143722,0.18687,-0.295153,0.37458,0.219671,0.517465,0.101393,0.274933,-0.248518,-0.167478,0.152985,-0.0611401,0.283434,0.775371,0.206463,-0.296945,0.0456357,-0.112938,-0.534097,0.0531338,-0.26294,0.712901,-0.422902,-0.109787,-0.242196,-0.203638,-0.482229,-0.0550341,0.090757,0.284186,-0.435809,-0.341912,0.722838,-0.292053,-0.403351,-0.215309,0.709878,-0.125873,0.661931,-0.0341702,0.115544,0.676376,-0.321375,-0.0479781,-0.797125,-0.616254,-0.224274,0.397083,0.181639,-0.18779,0.403762,0.0481688,-0.610738,0.0689595,0.0607728,0.125316,-0.153582,-0.457118,0.503895,-0.290359,0.0189366,-0.0973863,-0.179164,-0.0058079,0.122809,-0.636843,1.02843,0.0755418,0.122673,-0.41557,-0.374032,0.248375,0.549184,-0.14236,-0.293613,-0.700321,-0.0884291,-0.18021,0.185887,0.127991,-0.34465,-0.536113,0.152544,-0.254585,0.0890601,-0.414243,0.200171,0.451712,-0.544197,-1.83869,0.111779,-0.287592,-0.461294,0.349873,0.395433,0.63861,0.245822,0.730776,-0.424412,-0.212959,0.128762,0.0681163,-0.0860048,0.0489152,-0.0910968,0.221874,-0.266989,-0.469743,-0.150904,-0.761188,-0.761167,0.162995,-0.133632,0.175851,0.451672,-0.277679,-0.108498,-0.0800009,-0.137672,0.416116,0.220777,-0.0315063,0.12968,0.441875,0.2192,0.108679,-0.156504,0.160848,-0.229548,0.314478,-0.283297,0.0803124,-0.229438,-0.664577,-0.116987,0.218555,-0.530675,-0.0502052,-0.625713,0.498591,-0.334282,0.00526927,-0.244573,0.344255,0.275486,-0.215819,0.226,-0.196272,-0.354918,0.152563,0.234274,0.136625,0.425061,-0.0520037,-0.294142,-0.208932,0.0420612,-0.33314,-0.0402465,-0.158771,0.13587,0.269799,0.368605,0.519421,1.10149 +3414.88,0.855114,0.0848144,5,1.58778,1.10548,-0.364684,-0.047258,0.186196,0.0178946,0.622737,-0.32141,0.911369,0.483035,-0.372693,-0.247996,0.0932173,0.236551,-0.245804,0.888438,-0.102728,-0.537956,-0.330603,-0.320032,-0.599719,-1.01824,-0.627004,-0.166922,-0.00118057,-0.105937,0.105812,0.40452,-0.453692,-0.32767,0.573165,-0.0328774,-0.238855,-0.274226,0.233816,0.167415,-1.36696,0.829602,0.122655,0.189859,0.865405,0.503377,0.280755,-0.357667,-0.0439109,0.0730622,-0.682851,0.319745,0.264237,-0.0245103,0.116943,0.443547,-0.215128,0.204254,0.759633,-0.599651,0.00962403,-0.659693,0.166199,-0.576431,0.47767,0.668666,-0.890621,-1.09179,-0.0693236,-0.10973,-0.206128,-0.345187,-0.0749457,-0.421879,0.00251621,0.501559,0.643916,-0.0822881,0.356456,0.464399,0.0302493,-0.244113,-0.102613,0.0134361,0.206604,-0.145682,0.300802,0.218478,0.135217,-0.412892,0.324891,-0.324894,-0.0888495,-0.255487,-0.254989,0.233347,-0.570543,0.0121877,0.161978,-0.504007,-0.154143,-0.015924,0.262625,0.483763,0.131177,0.459021,-0.126255,-0.513868,0.385104,-0.0685639,-0.0662855,-0.153234,0.410485,0.855004,-0.179108,0.0472767,-0.695997,0.585098,0.302449,-0.350473,0.160581,0.602284,0.0831875,-0.200853,-0.243437,-0.344271,0.484379,-0.311775,-0.260406,0.203202,0.107175,-0.117867,0.134601,-0.414782,-0.0224417,0.0944896,-0.163966,0.738627,-0.425471,0.0959334,0.320664,0.14588,0.766205,-1.23766,-0.258431,-0.00993534,-0.17889,-0.603175,-0.293068,-0.116767,-0.325581,0.324768,-0.410442,-0.325196,-0.10337,0.0923709,0.116462,-0.181654,-0.527496,0.0807221,0.228436,0.110759,0.100014,0.277127,0.592154,0.114453,0.798628,0.0635716,-0.053525,0.155529,0.132493,0.00895905,0.263126,-0.0873245,-0.262048,0.0624886,0.236177,0.0554361,0.0214311,-0.0855274,-0.0913177,-1.20299,0.273347,0.6842,-0.173045,0.340923,0.044104,0.255032,0.0564686,0.311315,0.150443,0.0729506,0.147011,-0.737381,0.147949,0.0934505,0.159656,-0.656452,0.0429486,0.566321,0.319144,-0.416801,-0.221151,-0.223938,-0.067934,-0.155229,-0.0313351,0.162905,0.13974,0.194943,-0.336079,0.806201,0.181909,-0.15246,0.841097,-0.331242,-0.147128,0.125333,0.100957,0.00906337,-0.420345,0.232851,0.189801,-0.224497,-0.703339,-0.0226363,-0.148175,0.198875,-0.564253,0.723798,-0.489818,-0.593602,0.0299589,0.0821766,0.61213,-0.0572764,0.275941,0.194533,-0.443578,0.525453,-0.262622,-0.00167158,0.0368394,-0.157044,0.0652497,0.134229,0.0204405,0.305963,0.390212,-0.0393812,0.539981,0.332578,0.0320647,-0.433338,0.208081,-0.0979211,0.0614417,-0.199523,0.120592,0.629224,-0.336073,0.264241,0.0452295,-0.0227402,-0.245369,-0.0274029,0.110282,-0.330879,0.0708244,-0.00431055,-0.170179,0.289349,-0.124302,0.247248,-0.543181,0.0109408,-0.435275,0.0464357,0.057311,-0.184173,-0.120925,-0.395315,0.226695,0.140674,-0.64824,-0.0633977,-0.293943,0.266935,-0.114412,-0.0722255,0.138038,0.450836,0.189987,-0.201791,-0.190023,0.672907,-0.518144,-0.103621,0.231824,-0.166011,-0.585689,-0.132117,0.358025,-0.186579,0.49495,0.110009,0.251399,0.331677,0.501397,-0.752828 +3411.88,0.970028,0.0848144,4,1.61523,1.10091,-0.137075,-0.103383,0.014797,0.0189273,0.730503,-0.398188,0.829579,0.256273,-0.393665,-0.144383,0.313736,0.185282,-0.204677,0.930523,0.0362422,-0.393576,-0.308073,-0.320946,-0.814905,-0.938774,-0.703359,0.000613716,-0.0366692,-0.0890496,0.322907,0.609108,-0.652881,-0.186585,0.638113,0.143846,-0.193551,-0.295715,-0.078033,0.0534449,-1.28134,0.653481,0.419051,0.0242834,0.879678,0.376747,0.483916,-0.215989,-0.0120761,-0.179217,-0.756448,0.156232,0.166081,-0.147463,0.0127616,0.712521,-0.0751234,-0.30293,0.857457,-0.545936,0.0173121,-0.613471,0.0717071,-0.280619,0.634278,0.864615,-0.697782,-0.929441,-0.0881288,-0.220905,-0.325699,-0.421318,-0.0630157,-0.268979,0.00310305,0.387112,0.47467,-0.0981529,0.549193,0.37319,0.222314,-0.27547,-0.0654647,-0.065944,0.175585,-0.321893,0.130963,0.332641,0.123098,-0.470664,0.319473,-0.215722,0.05602,-0.265837,-0.0933284,0.156869,-0.34352,0.0064446,0.281339,-0.315773,-0.035369,-0.028861,0.312972,0.420813,0.205411,0.152519,-0.0091509,-0.383186,0.279943,-0.154831,0.273335,-0.294993,0.375162,0.807267,0.362044,0.0211029,-0.654173,0.702316,0.290734,-0.191094,0.0223559,0.63188,0.135533,-0.370702,-0.08725,-0.148532,0.407119,-0.251988,-0.338787,-0.111265,-0.156521,0.15288,0.182585,-0.227613,0.0491106,0.0562626,-0.0363509,0.714419,-0.360418,0.0152091,0.466989,0.337676,0.52523,-0.851761,-0.258405,0.0785049,-0.156437,-0.781363,-0.202827,-0.223163,-0.367859,0.480331,-0.34053,-0.36605,0.109563,-0.0121263,-0.0442342,-0.148745,-0.231585,-0.104595,0.178351,0.166916,0.316152,0.0850313,0.668662,-0.0324501,0.889349,0.0502681,0.162441,0.127289,0.20805,-0.053466,0.129788,-0.0434084,0.0164275,0.130802,0.104707,0.142692,0.146295,0.0122901,-0.0925152,-0.898695,0.0459809,0.809172,-0.301876,0.324629,0.0501529,0.368118,-0.105268,0.462783,0.143082,0.24461,0.161393,-0.966536,0.110855,0.10436,0.347196,-0.549812,0.142089,0.472334,0.27563,-0.538836,-0.337535,-0.327549,-0.0193396,-0.0996472,-0.116477,0.0445942,0.113317,-0.0303567,-0.379245,0.870105,0.0731304,0.185004,0.655519,-0.305119,-0.0969988,-0.1482,0.182929,-0.0729992,-0.384819,0.201559,0.284788,-0.275786,-0.717232,-0.0656403,-0.622228,0.269998,-0.63043,0.4524,-0.493568,-0.333869,-0.176438,-0.0161379,0.3888,0.0476085,0.152878,0.302958,-0.683758,0.345614,-0.485212,-0.0910477,0.141626,-0.0391733,0.0773223,0.157987,-0.123586,0.34748,0.266627,-0.308624,0.533738,0.41043,0.170761,-0.303863,0.15904,0.0298148,0.044439,-0.313556,0.121612,0.551247,-0.443082,0.0865381,-0.321074,0.0833555,-0.20359,0.143482,0.22743,-0.176133,0.128502,0.0216152,-0.377323,0.0882984,-0.00558659,0.0678082,-0.605669,0.136226,-0.493392,-0.139866,0.127524,-0.0354075,-0.204539,-0.443195,0.135248,-0.06835,-0.495738,-0.0589563,-0.642424,0.303175,0.0201142,-0.180773,0.0264476,0.25099,-0.373181,-0.273489,-0.306008,0.901529,-0.537013,-0.223998,0.157451,-0.472578,-0.730374,-0.175817,0.368586,-0.28822,0.620353,0.120944,0.211683,0.347769,0.460091,-0.214911 +3410,0.918647,0.0848144,4,1.54562,1.1798,-0.462265,0.0345553,0.351543,0.0562408,0.542866,-0.319472,0.473813,0.752515,-0.51485,-0.126624,-0.0813633,0.352671,-0.338421,0.802928,0.0903706,-0.32272,-0.391416,-0.269972,-0.672493,-0.633524,-0.66177,-0.496691,-0.0938317,-0.134927,0.10005,0.299506,-0.690172,0.241212,0.614019,-0.117408,0.180735,-0.137901,-0.256856,0.0987668,-0.762108,0.4279,0.35938,-0.11049,1.09624,0.782458,0.0651789,-0.399639,0.118727,-0.700167,-0.548918,0.245386,0.341924,0.0820234,0.00337167,0.692059,0.372752,-0.487065,0.496038,-0.433414,-0.157787,-0.539756,0.223117,0.113124,0.586581,0.669972,-0.722298,-0.914607,0.105384,-0.0696177,-0.417494,-1,0.0506925,-0.172679,0.0815218,0.415913,0.642511,-0.0104846,0.186598,0.373119,0.201874,0.253815,-0.252673,0.131984,0.523457,-0.0865324,0.105697,0.320946,-0.127497,-0.3644,0.0024248,-0.31287,0.137808,-0.56804,0.369647,0.414257,-0.0622452,-0.123647,0.201191,-0.238686,0.177852,-0.0115955,0.235767,0.542116,0.201069,0.057979,0.310898,-0.618341,-0.0646209,-0.034053,0.011168,-0.311823,0.669357,0.560656,0.309284,-0.165774,-0.834877,0.360233,0.166673,-0.151265,0.0882024,0.618634,0.276942,-0.234185,-0.805704,-0.000698251,0.155495,-0.151057,-0.186316,-0.224855,-0.22402,0.136344,0.360994,-0.326891,0.477547,0.0196867,0.0579981,0.11923,-0.130968,0.068072,0.105168,0.566994,0.561747,-0.337689,-0.120702,-0.0355221,-0.485213,-0.438534,-0.37572,0.181559,-0.120716,0.204898,0.09152,-0.173428,-0.0344662,0.268632,-0.0176778,-0.125329,-0.186476,0.242587,0.452377,0.000635692,0.0149778,-0.115031,0.299891,0.0843514,0.717204,0.304205,0.0529861,0.264812,0.712606,0.193868,0.134511,-0.0112611,0.108597,-0.209086,0.144981,0.0313915,-0.138177,0.199727,-0.211806,-0.619352,-0.200536,0.839746,-0.691608,0.583182,-0.189148,-0.277734,0.18588,0.0196101,-0.319828,0.0349367,0.23773,-1.02467,-0.329408,0.511882,0.336876,-0.948529,0.232985,0.254528,0.28905,-0.336149,-0.18085,-0.470677,0.371371,-0.0355868,-0.36476,-0.00652494,-0.0477816,0.0256599,-0.31867,0.820096,0.0951342,0.00316539,0.586492,0.198877,0.0149258,0.40582,-0.0993937,-0.256059,-0.394161,0.120407,0.346896,-0.317314,-0.416408,-0.285882,-0.268725,0.328852,-0.823705,0.409158,-0.358866,-0.468658,0.276937,-0.00808993,0.42154,0.187802,0.0470832,0.0347383,-0.747439,0.48921,-0.835315,-0.497864,0.256236,-0.148664,0.266268,0.0924003,0.0281501,0.419944,0.126487,-0.155696,0.462659,0.53352,0.25191,-0.520192,0.526377,-0.345794,0.275332,-0.00821803,0.0409021,0.390065,-0.0488138,0.0351026,-0.267383,-0.094207,-0.22526,0.667718,-0.115132,-0.214982,0.266403,-0.225727,-0.151839,-0.103894,0.441367,0.156889,-0.631466,0.0225317,0.00506762,-0.091854,0.337756,0.29218,-0.24769,-0.482014,-0.0485651,0.0630167,-0.287487,0.419549,-0.485691,0.224983,0.0987827,0.120408,-0.0154108,-0.081875,-0.431775,-0.0182732,-0.0845689,0.746395,-0.368743,-0.319011,0.0917615,-0.899558,-0.299332,-0.235659,0.394686,-0.443728,0.734207,0.127826,0.217776,0.357528,0.466665,-1.51121 +3421.26,0.96917,0.0848144,4,1.66779,0.919512,-0.26631,-0.05182,0.362916,-0.159984,-0.022534,0.207586,0.0644085,0.131022,-0.439532,-0.244674,-0.123459,-0.0522976,-0.408756,0.983888,-0.096182,-0.208241,-0.283448,-0.209297,-0.431405,-1.44482,-1.08881,-0.0204289,-0.447952,0.0344849,0.0179626,0.810575,-0.153288,-0.232387,0.560308,-0.555346,-0.275834,-0.0142263,0.239269,-0.287749,-0.769162,0.324632,-0.0605798,-0.38299,0.611076,0.0660717,-0.109399,-1.0026,0.239875,-0.562579,-0.21664,0.58688,0.609857,-0.497058,0.320971,0.200737,0.263701,-0.0936158,1.12131,-0.30148,0.324372,-0.739509,0.535221,0.227389,0.327661,0.895721,-0.686501,-1.09188,-0.255154,0.340834,0.270084,0.307831,0.0546171,-0.666984,-0.34974,0.561385,0.918932,0.118273,0.591093,0.372091,0.161963,-0.0132181,-0.0503542,0.0816225,0.508447,-0.178219,0.34564,0.0288805,0.478802,0.462412,-0.128088,0.159656,-0.109619,-0.19543,-0.314263,0.408785,0.555704,-0.0575537,0.133827,0.163516,0.290197,-0.0947845,-0.0454358,0.215946,0.0953546,-0.620172,-0.665599,-0.206981,0.213248,-0.260992,-0.261579,-0.0536689,0.702131,0.730128,0.00695567,0.183501,0.494363,0.470231,0.261988,0.0781811,-0.65919,0.0922963,-0.242332,-0.434909,-0.444386,-0.066381,0.0491362,-0.195657,0.0293323,-0.281215,0.500408,0.137288,0.545659,-0.422607,0.0343939,0.343925,-0.0806198,0.669533,-0.172505,-0.167952,0.123364,-0.567295,0.575688,-0.831929,-0.3361,-0.0387323,0.407179,-0.32858,-0.00159689,-0.0768955,0.0346383,0.266619,-0.177046,0.300681,-0.052481,0.308124,0.13726,0.0578,0.197074,0.371025,0.349415,-0.439533,0.801336,0.205054,0.156612,0.51721,0.302466,-0.000388658,-0.374858,-0.105784,-0.595616,0.15138,-0.367532,-0.382925,0.141248,-0.0164455,-0.156618,-0.153759,-0.215437,0.509581,0.0244824,-0.931962,-0.222783,0.795497,0.332361,0.37608,0.00928717,0.456089,-0.690578,-0.344236,0.0606442,0.118251,-0.07158,-0.556474,0.284384,0.159639,-0.302655,-0.349296,0.563889,0.410603,0.109777,0.0540714,-0.165128,-0.376983,-0.105047,-0.1155,0.228612,0.46427,0.376388,-0.0477613,-0.311546,1.03875,0.268015,0.662431,-0.374851,-0.139124,0.219908,0.232855,-0.149474,0.642335,-0.384804,0.224727,0.28697,-0.712224,0.130081,-0.41858,0.519363,0.429193,-0.319796,0.513573,-0.134248,-0.0271993,-0.317409,-0.503467,-0.145115,0.0356184,0.223957,-0.261439,-0.322599,0.594613,0.141862,-0.0153007,1.04816,-0.250834,-0.0861565,0.400186,0.139187,0.445924,0.409428,-0.0999691,0.618527,0.0293828,-0.485233,0.232209,0.225664,-0.465418,0.0758148,-0.090926,0.0137514,0.0862603,-0.0777627,-0.142234,0.445497,0.328271,1.01684,-0.155784,0.144513,-0.264561,0.429384,0.439615,0.165682,-0.397426,0.101631,0.0383667,-0.176497,-0.241065,0.3728,0.633401,-0.0158104,-0.382699,0.217741,-0.107127,0.374727,0.540011,-0.226175,-0.439428,-0.299442,-0.338379,0.187135,0.529756,-0.395116,0.0459458,0.148461,-0.459874,0.0448262,0.365856,-0.0427977,0.0279889,-0.00811716,-0.228848,0.238924,-0.202676,0.135419,-0.261857,0.310096,0.121569,0.298601,0.348668,0.546444,-0.933605 +3411.42,0.905702,0.0848144,4,1.4934,1.03745,-0.354928,-0.000330802,-0.176858,-0.0296913,0.217968,-0.545729,0.549332,0.188796,-0.185435,-0.0936635,0.0532987,0.166137,0.0423453,0.945266,0.282231,-0.106937,-0.483231,0.227299,-0.541499,-0.64116,-0.934092,0.125629,-0.469145,-0.288996,-0.0221118,-0.0376663,-0.531865,-0.0835438,0.636367,0.0640227,0.0827409,-0.00388989,-0.360402,0.278085,-0.739427,0.229839,0.653131,0.0664299,0.735498,0.630664,0.338772,-0.340536,0.252778,-0.254361,0.137321,0.562983,0.77772,0.0227584,0.1374,0.842265,0.321296,-0.739501,0.940041,-0.434984,-0.275383,-0.210769,0.0409699,0.150143,0.534755,0.866623,-0.485792,-0.783775,-0.0967039,0.428336,0.526844,0.110994,0.33931,-0.271725,0.0632372,-0.117993,0.71438,-0.250417,0.130207,0.220136,0.411052,0.46792,-0.207031,0.31619,0.316052,-0.273183,0.209618,-0.0312546,-0.0624982,0.310616,-0.206378,-0.124417,0.356811,-0.0407979,-0.0716233,-0.0253276,-0.306332,0.0112635,0.142423,-0.574138,-0.250801,0.047722,-0.140788,0.802704,-0.0771223,0.0903543,-0.444713,-0.297098,0.276801,-0.570255,-0.108344,-0.0557062,0.626841,0.414039,0.255822,-0.390634,0.577728,0.214149,0.0353765,-0.337183,-0.70071,0.55768,0.0547789,-0.00783105,-0.488688,0.339845,0.403005,-0.160041,0.3262,-0.102467,0.0618689,0.110897,0.274404,-0.499205,0.203785,0.0624325,0.429259,0.0971986,-0.361592,-0.429293,-0.0538883,-0.209017,0.378621,-0.433341,-0.42445,0.0732439,0.316787,-0.306913,0.201751,-0.191586,-0.721274,0.460579,0.156909,-0.59818,-0.699258,0.220149,-0.059865,0.0925147,0.559358,0.169366,-0.14139,-0.523634,0.564963,-0.206923,0.420359,0.34949,0.502471,0.174419,-0.431606,-0.05801,0.350956,0.29115,0.37906,-0.716317,0.480462,0.188278,0.0218367,-0.421972,0.179848,-0.224982,0.0679305,0.00599006,-0.228918,0.679891,0.0736898,0.20043,0.880607,-0.350033,-0.0740984,0.386284,-0.377999,-0.146754,0.722404,-0.622874,0.534147,0.110218,0.0715752,-0.454938,0.0216329,0.682499,-0.0856704,-0.380621,0.0839281,-0.054834,-0.138349,-0.363252,-0.0508685,0.0722067,-0.326014,-0.0978047,-0.156783,1.15954,0.149577,-0.0432658,0.186884,0.417267,0.307797,0.707507,-0.393345,-0.0927169,0.176855,0.62547,0.603658,0.297041,0.0756924,-0.616966,0.572142,-0.635282,-1.08221,0.147091,-0.385952,-0.232457,-0.0822539,-0.221008,-0.329689,0.0150663,0.0546858,-0.478974,-0.116262,0.806058,-0.629797,-0.68958,-0.0197576,-0.67498,0.294958,0.448103,-0.0900972,-0.13483,0.149335,-0.076771,0.493395,0.116365,0.0452137,0.049444,0.391399,-0.627921,0.470785,-0.0246791,-0.283678,0.4443,-0.480678,-0.0862369,0.116082,-0.0131173,-0.0822569,0.458551,0.15108,-0.00460871,0.519595,0.136477,-0.382355,0.0326455,-0.0454122,0.410641,-0.0718421,0.134758,-0.521379,-0.196307,-0.262348,-0.546285,0.849877,0.440745,0.361682,0.15571,-0.488049,-0.311229,-0.172311,-0.100069,-0.119706,0.0477883,0.377849,-0.174339,-0.205632,-0.105078,-0.0725887,0.107851,0.485346,0.444051,0.0742924,-0.231918,0.197827,-0.0394014,-0.0332387,0.188171,-0.2644,0.152066,0.201221,0.389957,0.448576,0.440588 +3420.31,0.696226,0.0848144,4,1.42453,1.05687,-0.988377,0.231142,0.124759,-0.286735,0.0437478,-0.0114224,0.411105,0.751699,-0.20874,-0.26037,0.241026,0.27106,0.142482,1.2201,0.108719,-0.233049,-0.13297,-0.0328152,-0.111066,-0.847124,-0.6076,-0.176823,-0.407224,-0.00758002,-0.295006,0.94302,0.3334,0.0594243,0.69826,-0.156434,0.151131,0.0238304,-0.080737,0.0453391,-0.427033,0.688269,0.65637,0.422714,0.977657,0.853503,-0.0615755,-0.797549,0.0571536,0.279722,-0.427404,0.422076,0.794138,0.0560526,0.401149,1.01629,0.437472,-0.266677,0.980687,0.782232,0.0313795,-0.142766,0.450296,-0.109258,0.17224,1.30287,-0.319385,-0.661854,-0.170915,0.350771,0.364269,0.496818,0.508224,-0.155204,-0.238784,0.544422,0.900055,0.0152302,0.489539,0.72315,0.0658576,-0.13357,-0.584206,-0.0286658,0.159605,-0.177961,0.117078,0.289252,-0.263404,0.13721,0.275626,-0.51277,-0.131824,-0.361273,0.766857,-0.129718,0.203714,-0.0608413,-0.563627,-0.0634499,0.134274,-0.685488,-0.392115,0.417997,-0.447959,0.421351,0.0564819,-0.72633,0.0103356,-0.00905757,0.412418,-0.991204,-0.0311431,0.51476,-0.283327,-0.137903,0.219877,0.103943,0.104654,-0.231718,-0.291467,0.348156,0.376995,0.0256951,-0.519303,-0.165676,-0.171932,-0.0514216,0.296596,0.0881807,0.281393,-0.194822,0.197898,-0.42097,-0.0642489,0.0123413,-0.0247029,0.559879,-0.18799,0.204556,-0.0656376,0.0803223,0.24685,-0.430426,0.0891352,0.0913648,0.277603,-0.864113,0.696675,-0.183088,-0.636427,0.124224,-0.398261,0.219699,-0.778341,0.0405399,0.391278,-0.357529,0.343443,0.791401,0.0452247,-0.058778,0.065994,-0.141909,0.260918,0.221499,0.801755,0.393761,-0.224403,0.384797,-0.298205,5.77387e-05,0.0493237,-0.448207,0.177881,-0.08068,-0.741343,0.128023,0.121154,0.0893301,-0.291992,-0.50499,0.194634,0.738392,0.0425769,0.125291,0.547908,-0.226933,0.0447179,-0.170151,-0.0948577,-0.505411,-0.0230844,-0.551825,0.109555,-0.166329,-0.239012,-0.589583,0.151346,0.387038,0.00443138,-0.566929,-1.25048,-0.426912,0.201607,0.14197,0.130377,-0.320004,-0.283744,0.00346531,0.130338,0.616223,0.124065,0.715886,-0.0331234,-0.0952594,0.118323,0.117694,0.342003,0.134942,-0.507583,0.203293,0.815772,-0.520369,-0.616855,-0.449612,0.718497,0.301161,0.28182,0.577557,0.0569862,-0.312713,-0.248154,-0.469033,-0.0598329,-0.317033,-0.444756,-0.0497806,-0.75217,0.439801,-0.454128,0.329229,0.655349,-0.408345,0.0543074,0.591728,0.0133678,0.288265,0.569321,0.142408,0.241887,0.0415452,-0.122428,-0.0942873,-0.159363,-0.692774,0.403552,-0.138903,0.249009,0.195452,-0.0321191,-0.663322,-0.221087,0.460013,0.354027,0.220207,0.516215,0.219068,-0.0880931,0.155913,0.0996372,-0.62386,-0.268414,0.213835,-0.294296,0.254513,-0.119617,0.737158,-0.514431,0.270729,0.371852,0.279625,0.72536,0.280079,-0.0508173,0.0535183,0.0859159,0.33318,-0.013518,0.102728,0.29087,-0.0935908,0.477995,-0.347629,-0.161236,-0.210115,0.102757,-0.166646,0.0689727,-0.449284,0.106049,-0.0279907,-0.0914779,-0.174833,0.506813,0.137756,0.297256,0.371154,0.545212,-0.486351 +3406.2,0.854733,0.0848144,4,1.41323,1.07741,-1.27582,0.308526,0.372927,-0.0467684,-0.0559474,0.112069,0.447662,0.252006,0.0029597,0.384377,-0.115438,0.215234,-0.183655,0.729138,0.0891844,-0.27227,-0.0405932,-0.118863,-0.486899,-0.688852,-0.461798,-0.445213,-0.0725659,-0.229423,0.2604,0.224734,-0.452099,-0.0958124,0.323045,-0.108278,-0.050275,-0.207866,0.0853453,0.304153,0.166303,0.540094,0.556825,-0.223459,1.19241,1.01605,1.21394,-0.0568501,-0.13325,-0.417883,-0.155564,0.486488,0.843111,0.122795,0.248171,1.02389,0.347911,-0.00436226,0.971362,-0.301616,0.139445,-0.316219,0.513332,0.179553,0.825047,1.14173,-0.560969,-1.09276,0.55356,-0.0895205,-0.481987,-0.0746799,-0.339602,-0.715568,-0.320364,0.137374,0.508988,-0.30529,0.359416,0.299448,0.938435,0.118521,-0.263088,-0.149343,0.526164,-0.313515,0.636504,-0.249249,0.111765,-0.137375,-0.540719,0.161468,0.52102,-0.435783,-0.414878,-0.00499733,0.324398,0.257745,0.471224,-0.505007,0.203059,0.116045,0.356565,0.329972,0.111912,-0.15366,-0.914582,0.52425,0.110498,-1.03351,0.034223,-0.283164,0.590894,0.831,0.176692,-0.336735,0.645732,-0.0052624,-0.424335,0.261644,-0.585657,0.0141551,0.489444,-0.351326,-0.507723,0.373396,-0.146012,-0.0603105,-0.220582,0.134212,0.537121,-0.232646,-0.322823,-0.555877,0.372735,0.0931638,0.328483,0.461148,-0.660309,0.0128686,0.22377,-0.0283314,0.188162,-0.580736,-0.439958,0.183732,0.119559,-0.0446201,0.0384305,0.587778,0.0510061,0.186212,0.0417984,-0.430361,-0.247718,0.311255,-0.509626,-0.203348,0.303192,0.481133,0.822438,0.01998,0.195082,0.134246,0.415359,-0.428041,0.718822,-0.270518,0.220367,0.605289,-0.0101353,0.222633,-0.208832,0.154602,0.325604,-0.0190512,-0.123751,-0.176306,-0.00301826,-0.365063,0.0108711,0.488927,-0.202619,0.905232,0.0432248,-0.660479,-0.169292,0.238191,0.161651,-0.420296,-0.505611,-0.547977,0.172253,-0.61276,0.343253,0.271559,0.724406,-0.255919,-0.0595226,0.180816,0.0388855,-0.392886,-0.871691,-0.170133,0.116805,-0.523803,0.285607,0.280376,-0.082732,-0.17132,-0.475012,1.05441,0.212451,0.297378,0.363099,-0.742446,0.364319,0.227274,0.345245,0.258192,-0.00124873,0.373698,0.0689033,0.376888,0.12877,-0.237176,-0.0512616,0.4407,-0.945353,-0.323738,-0.0989924,0.0245129,0.0591851,-0.135594,-0.179668,-0.270852,-0.277385,-0.0234911,-0.292205,0.710786,-0.191723,0.232733,0.523703,-0.479446,-0.47603,-0.0378052,0.747968,-0.384745,0.0668088,-0.039063,0.423572,-0.369858,0.475357,-0.136309,-0.192986,-0.253739,0.61275,-0.423899,-0.27933,0.455506,-0.750247,0.348378,0.0273076,0.100727,0.503992,0.555895,0.530091,-0.134547,0.336065,0.382427,-0.215661,0.00747084,0.480246,0.475736,-0.363247,-0.231255,-0.312403,-0.00528635,0.57625,0.0342318,0.31403,0.199871,0.0401444,-0.139196,-0.075516,0.193555,-0.144173,0.104208,-0.255698,0.498633,-0.0640225,-0.354933,-0.0326869,-0.290531,-0.386778,0.84206,-0.342679,0.710373,-0.356216,-0.734323,0.116829,-0.371194,0.453127,-0.015619,0.560985,0.168479,0.238623,0.410462,0.488491,-1.34018 +3413.43,0.99913,0.0848144,5,1.45078,0.969226,-1.39638,0.511955,0.366243,-0.198633,0.757272,0.0856305,0.336044,-0.179347,-0.571194,-0.54715,-0.436674,0.764475,-0.0520858,0.758815,-0.345002,-0.19578,0.100106,-0.206809,-0.440182,-1.12377,-0.821718,0.202225,-0.391121,0.10309,-0.120435,0.693501,-0.0489739,-0.0685057,0.976808,-0.803072,0.334459,0.0157721,-0.630406,0.216674,-0.591032,1.06246,0.489183,-0.259759,1.18207,1.17084,0.338265,-0.651426,0.0038125,1.16578,-0.805162,0.472978,0.145044,0.179015,0.513231,1.08919,-0.0951787,-0.120498,0.291455,-0.0401164,-0.161658,-0.658312,0.354873,-0.125666,0.141854,1.02499,-0.477339,-1.08875,0.234213,0.119014,0.322685,0.00543957,0.507339,0.160752,0.315758,0.715122,0.259182,0.276196,0.873046,0.618997,0.179244,-0.0300365,0.0758158,-0.44967,0.514979,-0.296689,0.0473777,0.193881,-0.176071,0.1585,0.347614,-0.643275,-0.317015,-0.719827,0.340952,0.0294042,0.105838,-0.725227,-0.324554,0.180416,-0.00270693,-0.205517,-0.0654009,0.451017,-0.255879,0.0711207,-0.0212658,-0.952109,0.225174,0.609584,0.233982,-0.328184,0.00662249,0.170725,-0.276883,0.285553,-0.516758,0.233157,0.587228,0.0502038,-0.0175983,0.088004,0.232357,0.374589,-0.746097,-0.217106,0.0727363,-0.196611,-0.0435432,0.0199443,-0.348122,0.338891,0.537953,0.00402471,0.0573505,-0.316301,-0.186302,0.340909,0.437445,0.156903,-0.161905,0.126368,0.262187,-0.252124,-0.168747,0.111771,0.185605,-0.700542,0.15827,-0.499314,-0.298323,0.493853,-0.378005,0.0977305,-0.249002,0.286475,0.564752,0.205043,0.215406,0.305253,-0.0835465,0.102796,-0.0188837,-0.418426,-0.0695754,0.0760863,0.641671,0.291303,-0.282811,-0.533209,-0.22935,-0.234449,-0.220391,-0.387184,0.0250206,-0.0592817,0.0794353,0.223295,-0.00194138,0.192697,-0.545899,-0.379553,0.665879,0.316503,0.275105,0.542594,0.606215,-0.498829,-0.286143,-0.252186,-0.0648252,0.260054,0.33452,0.169215,-0.275484,-0.109881,-0.674625,-0.43972,0.320202,0.252211,0.413136,-0.529331,0.00569915,0.195124,-0.00292329,0.268503,0.115017,-0.282329,-0.0377709,-0.039222,-0.213888,0.756355,-0.309018,-0.15396,0.0938419,0.229202,-0.0953596,0.0443586,-0.57124,0.653463,-0.348045,-0.0977497,0.116114,-0.943832,-0.477669,-0.534375,0.125831,-0.0482966,0.256033,0.638968,-0.251312,-0.679842,0.0942999,0.396026,-0.154223,-0.021153,-0.0108498,-0.219603,-0.321009,0.22249,0.507231,-0.043268,0.734766,0.0785356,0.401116,0.338801,-0.966627,0.352406,0.570198,0.345019,0.652966,0.788336,-0.394181,-0.354982,0.298432,-0.56129,0.458771,0.369101,0.0371204,0.382842,0.0645377,-0.286424,0.0575948,0.181696,-0.208588,0.189538,-0.286435,0.305908,-0.110398,0.0956536,0.0215532,-0.203124,-0.63116,0.201826,-0.0439746,-0.099504,-0.0392402,0.232936,-0.157424,0.195035,0.00806793,-0.428194,0.434419,-0.0176759,-0.186363,-0.275754,-0.279331,-0.0160238,0.151347,0.058312,-0.305997,0.807031,0.43142,0.00191085,0.0979836,-0.518313,0.522295,-0.427998,0.207602,0.262707,0.0436699,0.383384,-0.530582,-0.0459435,-0.576649,0.129761,0.313808,0.360223,0.560186,-1.1808 +3415.2,0.887898,0.0848144,4,1.45358,0.979694,-1.41081,0.522663,0.339607,-0.206888,0.766432,0.0847856,0.329611,-0.136258,-0.557561,-0.551062,-0.442649,0.807812,-0.0429558,0.754275,-0.328505,-0.197568,0.129357,-0.215234,-0.420809,-1.10532,-0.825811,0.194359,-0.377591,0.0812297,-0.104735,0.718453,-0.0419513,-0.0667261,0.95161,-0.832128,0.318215,0.0017776,-0.57406,0.173823,-0.56497,1.05017,0.5025,-0.278032,1.17496,1.17986,0.33628,-0.6229,-0.000439647,1.17672,-0.78635,0.470203,0.166333,0.198332,0.474693,1.08484,-0.0954665,-0.121583,0.332705,-0.02754,-0.13412,-0.642205,0.371048,-0.145817,0.127934,1.03897,-0.435232,-1.03586,0.195856,0.0894308,0.337559,0.0334937,0.514768,0.16321,0.32489,0.752706,0.281119,0.282867,0.827018,0.661984,0.205921,0.0183943,0.126078,-0.404351,0.466996,-0.302406,0.0315032,0.207424,-0.142099,0.188714,0.334174,-0.618633,-0.317759,-0.691583,0.336131,0.0871502,0.109783,-0.712862,-0.315657,0.156716,0.0476431,-0.231344,-0.0463303,0.460225,-0.239309,0.103119,-0.014315,-0.943608,0.2328,0.591818,0.233141,-0.302656,6.24841e-05,0.172905,-0.269599,0.29149,-0.534204,0.246012,0.620604,0.00370301,-0.0330799,0.137622,0.290962,0.36986,-0.73859,-0.175382,0.133576,-0.187871,-0.0300456,0.0157477,-0.329573,0.367082,0.49062,0.0198234,0.0955434,-0.318379,-0.209387,0.34755,0.417668,0.16728,-0.172938,0.126062,0.238042,-0.247686,-0.199657,0.0914421,0.145846,-0.737173,0.130055,-0.464967,-0.36234,0.502605,-0.376005,0.136545,-0.270631,0.302479,0.528732,0.237623,0.196308,0.33688,-0.111071,0.0991506,-0.0189291,-0.373327,-0.0312895,0.105315,0.657918,0.310788,-0.281417,-0.512553,-0.191311,-0.255634,-0.19727,-0.374833,0.0275132,-0.0594878,0.0926627,0.272982,0.00963613,0.195885,-0.563913,-0.349921,0.689456,0.356002,0.253488,0.558658,0.552553,-0.483716,-0.277746,-0.206111,-0.0688338,0.257461,0.350981,0.16129,-0.249081,-0.125631,-0.670535,-0.466307,0.293631,0.222682,0.36774,-0.571192,0.0140311,0.204005,-0.00177124,0.253729,0.087811,-0.293831,-0.014595,-0.0279624,-0.206292,0.751564,-0.27447,-0.10927,0.0606998,0.252398,-0.104367,0.0614245,-0.564363,0.670153,-0.323983,-0.107398,0.127246,-0.953217,-0.485915,-0.558846,0.10675,-0.0446915,0.283195,0.648124,-0.24936,-0.691602,0.110628,0.408883,-0.10553,-0.0170242,0.00959838,-0.191524,-0.315479,0.230968,0.523949,-0.0277402,0.723785,0.0461598,0.380541,0.372159,-0.957164,0.319677,0.596921,0.330311,0.668292,0.785609,-0.426425,-0.314445,0.292397,-0.56747,0.475235,0.333386,0.054372,0.381107,0.0862345,-0.21606,0.0548157,0.17331,-0.200637,0.201065,-0.282876,0.285893,-0.126228,0.0917258,0.00333186,-0.258409,-0.626904,0.208168,-0.0652819,-0.101867,-0.0468505,0.219741,-0.153523,0.209587,-0.0174775,-0.440268,0.449552,0.0141152,-0.20858,-0.300709,-0.283216,-0.0410789,0.156261,0.0752278,-0.318598,0.813514,0.403178,-0.0105457,0.0881599,-0.515099,0.529303,-0.451006,0.203867,0.23689,0.0471762,0.41051,-0.539003,-0.102443,-0.577519,0.127697,0.310999,0.357348,0.557673,-1.10858 +3413.07,0.845852,0.0848144,5,1.48485,0.955597,-1.56,0.496927,0.28818,-0.166355,0.984415,0.33481,0.541618,-0.0453946,-0.420245,-0.676246,-0.134573,0.55445,-0.295194,0.586126,0.00566949,-0.323745,0.0156913,-0.604392,-0.245223,-1.0909,-0.742483,-0.0141711,-0.477246,-0.00642095,-0.0570931,0.381832,-0.449545,0.204535,0.756785,-0.853883,0.564466,0.00498758,-0.503776,0.201554,-0.175903,1.14934,0.782856,0.00702875,1.33424,0.952561,0.272009,-0.583071,0.0330574,1.19593,-0.698417,0.620789,0.364459,0.626803,0.436023,0.824108,0.169451,-0.58713,0.371423,0.00397736,-0.255704,-0.59629,0.61273,-0.390072,0.270802,1.27255,-0.595403,-1.03966,0.301192,-0.220778,0.234927,0.0533286,0.51287,0.0189708,0.234408,1.02219,0.214705,0.233631,0.833866,0.721266,-0.115782,-0.436677,0.273345,-0.000784474,0.572456,-0.117037,0.234678,0.0681789,0.0591009,0.21578,0.301734,-0.838344,-0.115941,-0.556291,0.479878,-0.118588,0.316574,-0.106303,-0.559246,0.0370705,0.363682,-0.367389,-0.335298,0.0752884,-0.182255,-0.0517418,0.0216098,-0.737241,0.318358,0.601468,0.459619,-0.250461,0.024307,0.290075,-0.189929,0.0103735,-0.420584,0.476371,0.46971,0.105959,-0.0804939,0.0617209,0.488058,0.549153,-0.729669,-0.323722,-0.111505,-0.13848,-0.0418532,0.0640301,-0.265314,0.480047,0.543,-0.2091,-0.0523528,-0.260117,-0.330968,0.482707,0.1846,0.252991,-0.378503,0.070443,0.189227,-0.317773,-0.0968648,0.161699,-0.0840845,-1.02549,0.0794118,-0.558222,-0.0470445,0.346323,-0.184693,0.16832,-0.205866,0.366448,0.564046,0.172399,-0.205501,0.155255,-0.118132,0.23044,0.0407269,-0.539704,0.0172627,-0.0851342,0.547552,-0.174481,-0.0280307,-0.425025,0.22139,-0.127903,-0.17491,-0.326218,0.128321,0.056755,0.249042,0.0501092,0.180865,-0.0399681,-0.760133,-0.167722,0.502373,0.718783,0.509442,0.340579,0.362027,-0.442736,-0.305262,-0.337803,0.0492672,0.12745,0.898613,-0.0486675,-0.239404,-0.248939,-0.500314,-0.143965,0.433171,0.183822,0.162033,-0.473994,-0.00440741,0.174826,-0.118284,0.32426,0.20404,-0.0367573,-0.167996,-0.320079,-0.32862,0.546135,-0.277997,0.212151,-0.0146919,0.18753,-0.167617,0.22861,-0.759678,0.52409,-0.356859,-0.308767,0.390417,-1.04545,-0.260353,-0.518338,-0.266081,0.169247,-0.138092,0.657924,-0.664817,-0.770517,0.328142,0.232671,-0.271345,0.0375907,-0.324601,-0.00163525,-0.497241,0.459408,0.214352,-0.0701924,0.765429,0.399596,0.368189,0.256368,-0.697912,0.49273,0.604042,0.146544,0.931123,0.584073,-0.246312,-0.391717,0.0422489,-0.727923,0.534096,0.474348,-0.020239,0.632493,0.027344,0.00273866,-0.0124573,0.109385,-0.182519,-0.283313,-0.407384,-0.0377968,0.0658092,-0.0677668,0.0465106,0.248862,-0.171394,0.36133,-0.312174,-0.25687,0.18918,0.38679,0.105438,0.0785232,-0.163083,-0.0552905,0.406146,-0.00383283,-0.16694,-0.207445,-0.0115308,0.10554,0.227883,0.0105554,-0.41136,0.420298,0.306153,0.246986,-0.0421266,0.200991,0.437468,-0.234859,0.133052,0.247117,0.0911472,0.526999,-0.126153,-0.354995,-0.434601,0.139152,0.496018,0.37303,0.704285,-0.771319 +3410.39,0.833211,0.0848144,4,1.4383,0.863581,-1.71054,0.557002,0.284891,-0.136249,0.859315,0.293728,0.535112,-0.166001,-0.405063,-0.798246,-0.0732092,0.671942,-0.314465,0.634743,-0.230709,-0.240531,-0.00771758,-0.574456,-0.253737,-0.938714,-0.680803,-0.0453779,-0.398688,-0.057446,-0.0401235,0.402739,-0.533964,0.19817,0.850578,-0.925404,0.492048,-0.0893128,-0.651024,0.263895,-0.214102,1.1163,0.809381,0.17221,1.46886,0.975389,0.200072,-0.569179,-0.0277145,1.24995,-0.592378,0.502719,0.386702,0.449829,0.402467,0.732657,0.170881,-0.806187,0.415861,-0.0347802,0.0364466,-0.729853,0.528101,-0.339022,0.510416,1.04493,-0.699851,-0.929167,0.436063,0.0730706,0.0977787,0.140669,0.561207,0.0699906,0.34036,0.848027,0.318055,0.392524,0.745254,0.61052,-0.058858,-0.550842,0.235894,-0.0040948,0.547743,-0.259701,0.136321,0.0482978,-0.0525095,0.139928,0.270517,-0.848034,0.00974265,-0.561933,0.391234,0.00364319,0.190817,0.0582873,-0.379588,0.214784,0.528304,-0.550452,-0.28168,0.224483,-0.0503833,0.0514795,0.204024,-0.780462,0.290054,0.533816,0.473706,-0.0519067,-0.165634,0.168342,-0.374129,0.015919,-0.384121,0.497294,0.571976,0.0679748,0.13801,0.156541,0.59923,0.500693,-0.610723,-0.183443,-0.186529,-0.0187391,-0.0290801,0.0524943,-0.274629,0.643807,0.441919,-0.37178,0.0365291,-0.28306,-0.459962,0.473435,0.242638,0.351837,-0.243714,0.269959,0.288207,-0.449422,-0.094034,0.190008,0.0457784,-1.10872,0.113577,-0.720726,-0.0586712,0.432741,-0.0624067,-0.345435,-0.340366,0.271098,0.71874,0.0249147,-0.238289,0.12275,-0.247553,0.379924,0.113158,-0.396786,0.288603,-0.00880353,0.590169,0.162591,0.0500791,-0.354338,0.245909,-0.0228214,-0.452014,-0.306489,0.285116,0.0948839,0.227958,-0.140671,-0.129628,-0.0487874,-0.69067,-0.300032,0.305194,0.660492,0.439718,0.278177,0.424976,-0.489207,-0.256466,-0.342271,-0.0308146,0.110452,0.993712,-0.0531528,-0.137047,-0.206712,-0.361334,-0.292318,0.464647,0.221933,0.308737,-0.45738,-0.144329,0.185831,-0.101935,0.425634,0.00145423,-0.205275,-0.0801131,-0.391289,-0.440942,0.549658,-0.472555,0.170742,-0.106886,0.14407,-0.0579403,0.320486,-0.717239,0.565464,-0.310278,-0.399698,0.491381,-0.986931,-0.100602,-0.445058,-0.0649593,0.201299,-0.497785,0.645347,-0.692813,-0.909814,0.117505,0.234645,-0.220135,0.082554,-0.498153,-0.0508519,-0.467594,0.383032,0.256956,0.101718,0.744344,0.421951,0.308269,0.145095,-0.459804,0.443641,0.401535,0.262384,0.817396,0.52388,-0.128639,-0.426648,0.0390993,-0.703151,0.492591,0.48007,-0.0604868,0.526474,-0.0594119,-0.0990536,-0.0323486,0.15656,0.17788,-0.184107,-0.490933,0.0378337,0.177987,0.165279,0.0449549,0.0986463,-0.11871,0.434804,-0.245035,-0.2219,0.0768169,0.317958,0.0938801,0.102241,-0.174135,-0.0507501,0.27933,0.00794615,-0.218476,-0.139432,0.125982,0.256681,0.179756,-0.00771019,-0.420235,0.578358,0.282719,0.0686062,-0.227209,0.0208819,0.452045,-0.286762,0.0305578,0.142549,-0.0513873,0.449465,-0.000632042,-0.34445,-0.19218,0.132109,0.494728,0.363468,0.703369,-0.629673 +3404.34,0.827378,0.0848144,4,1.45563,0.851873,-1.56656,0.615614,0.617888,-0.113911,0.194789,0.160818,0.427651,0.10172,-0.172029,-0.829023,-0.22092,0.433219,-0.176429,0.792206,-0.153095,-0.320316,-0.14803,-0.195253,-0.118468,-1.0609,-0.415675,0.223651,-0.730606,0.10555,0.0804458,0.379493,-0.305728,0.252006,1.02038,-0.687754,0.0582455,-0.077859,-0.600165,0.307473,0.171172,0.880611,0.814159,0.145052,1.34794,1.12659,0.590771,-0.481222,-0.0220216,0.814996,-0.821818,0.905816,0.327919,0.25259,0.6545,0.938634,0.181228,-0.294178,0.227769,0.180635,-0.194091,-0.656398,0.484761,-0.124924,0.300813,1.07432,-0.624336,-0.891181,0.582513,0.12797,0.0942689,0.159179,-0.105255,0.110266,0.0968671,0.64783,0.160507,-0.132836,0.63188,0.574097,0.722188,-0.424622,0.331305,0.155845,0.704367,-0.407419,0.373665,0.155547,-0.244553,0.0603469,0.158227,-0.966092,-0.421955,-0.747868,0.328596,0.122966,0.225547,-0.0149313,-0.191,0.00573106,0.334401,-0.326408,-0.183224,0.108813,-0.0313141,-0.201852,0.0549971,-0.699356,0.214695,0.816233,0.283159,-0.313757,-0.156119,0.387116,-0.0793605,-0.361744,0.0503043,0.472828,0.360446,-0.440885,-0.0308634,0.260557,0.711633,0.305602,-0.325141,-0.386546,-0.35989,0.0592973,-0.184292,0.0321358,-0.0920255,0.646815,0.60923,-0.724149,0.319111,-0.125304,-0.614963,0.194195,0.215723,0.321915,-0.0879528,-0.0690799,0.370246,-0.286917,0.287382,-0.067272,-0.195297,-0.806025,-0.0229083,-0.00751793,-0.333378,0.426866,-0.257866,-0.266229,-0.296337,0.300916,0.878582,-0.195892,-0.284369,0.495132,0.0199483,0.0283453,-0.115864,-0.104984,0.696705,-0.167555,0.523021,0.130468,0.225211,-0.430506,-0.168121,-0.175379,-0.0786462,0.00495254,0.59676,0.257932,0.237106,-0.244197,0.193877,0.0711284,-0.576492,-0.0218837,0.15635,0.682429,0.173019,0.0194031,0.140743,-0.248039,-0.389406,-0.591513,-0.406924,-0.0603439,1.08792,-0.711217,-0.0435352,0.164586,-0.152326,-0.240414,0.600708,0.134351,0.489068,-0.228078,-0.114407,-0.301553,-0.365832,0.0288944,0.0239873,0.104622,0.00153526,-0.51786,-0.572367,0.640859,-0.32462,-0.00769457,0.0810538,-0.123145,-0.109273,0.482287,-0.652905,0.156466,0.0532299,-0.319667,0.504222,-0.864034,-0.0247156,-0.874415,0.026912,0.34271,0.0982865,0.467826,-0.576701,-0.367744,0.612691,0.533602,-0.185801,0.0664559,-0.570852,0.16887,-0.298772,0.256836,0.0775413,0.583453,0.635348,0.356233,0.433038,0.250639,-0.457674,0.390887,0.434697,-0.0440252,0.790448,0.850816,-0.108485,-0.466522,-0.37159,-0.793952,0.566843,0.287546,0.260611,0.397217,-0.470399,-0.0934264,-0.0876129,0.321172,0.343629,-0.0340523,-0.633988,-0.237524,0.59402,-0.0241958,-0.0982654,0.2537,-0.255266,0.624732,-0.128756,-0.309533,0.418387,0.101294,0.303609,0.205599,-0.31804,-0.227173,0.417599,-0.218954,-0.256362,-0.26908,0.171871,0.135943,0.665383,0.066248,-0.766738,0.45473,0.271798,0.0783601,0.225141,-0.225154,0.385993,-0.117354,0.0115623,0.469789,-0.361386,0.670645,0.0534258,-0.918384,0.0251794,0.144671,0.289641,0.380357,0.538183,-1.83394 +3414.42,0.669998,0.0848144,5,1.64909,0.894118,-1.05381,0.404498,0.825064,-0.00960512,0.0668802,-0.332053,0.314475,0.139001,0.430863,0.122674,-0.289423,0.416303,-0.120108,0.288614,-0.234205,0.423453,0.102444,0.0480486,-0.208598,-1.22315,-1.02437,0.134677,-0.436288,-0.419763,0.35969,0.211128,-1.05904,-0.0227993,0.365663,-0.4078,0.0753955,0.352523,-0.375463,-0.341274,-0.416765,0.550099,0.367553,-0.12706,0.678653,0.951864,0.195025,-0.927398,0.0269765,-0.00293582,-0.801537,-0.428002,0.303227,-0.167543,-0.0988533,0.724681,0.0532316,-0.363485,0.543462,0.0337232,0.00367405,-0.179432,0.570982,-0.153994,0.511443,0.998882,-0.64941,-0.866393,0.0762679,0.0103044,-0.104075,-0.184656,0.161683,-0.721053,-0.102641,-0.120194,0.291545,-0.252642,0.444701,0.871673,-0.195112,0.245411,-0.682919,-0.0456196,0.494846,-0.1171,-0.025253,-0.179603,-0.107088,-0.345529,-0.153168,0.419125,0.203252,0.342769,-0.263278,-0.174931,-0.110602,0.215193,0.11684,-0.365593,-0.213783,-0.0488436,0.331482,-0.0416106,0.0383972,0.200106,-0.557036,-0.0289041,-0.0214369,-1.16758,0.162817,-0.0813086,0.374689,0.735977,0.00775466,0.358558,0.494319,0.13609,-0.563192,0.341896,-0.671192,-0.309848,-0.488936,-0.472086,-0.864263,0.321636,0.0947811,-0.327308,-0.0916428,0.3384,0.46558,-0.513778,0.0679733,0.0570475,-0.182464,-0.0902283,0.370296,0.603671,-0.0896645,-0.515053,-0.0415767,-0.0342506,0.508696,-0.543789,-0.685418,0.107029,0.271079,-0.14014,-0.14448,0.130959,-0.00415827,0.144175,0.0306335,-0.227019,-0.0756869,-0.0378718,-0.27355,0.0393646,0.776442,0.206793,0.430927,-0.132196,-0.0358401,-0.10735,0.0376197,0.177815,0.192833,-0.175692,-0.210226,0.839726,0.0659608,-0.266887,-0.101222,-0.118368,0.0696107,0.0659566,-0.114711,-0.177933,-0.655663,-0.37335,-0.0908534,-0.220741,0.00947589,0.890814,0.184192,-0.237583,0.25337,-0.088881,0.365881,0.025963,-0.139333,-0.571107,-0.544523,-0.0749859,-0.0678631,-0.260458,0.113628,-0.502418,-0.479328,0.0790845,-0.287112,-0.361883,-0.663089,0.556967,-0.0939999,-0.40261,0.187037,-0.367953,-0.0282934,0.0422458,-0.480943,1.06955,0.315901,0.362264,0.216621,0.0063505,0.19253,-0.267745,0.154149,0.557489,-0.534846,0.130191,-0.228836,0.443932,0.185335,-0.312656,-0.101904,0.160301,-0.715534,0.136738,-0.211931,0.0183424,-0.47197,-0.301114,-0.0702627,-0.260804,-0.108123,-0.63278,-0.401738,0.535045,-0.211507,-0.625422,0.475968,-0.488409,-0.583228,0.107903,0.174863,-0.303006,0.248309,0.236527,0.311024,-0.375412,-0.0636774,-0.217454,0.157513,-0.346775,0.628902,-0.651411,-0.64639,0.283413,-0.0394363,0.501003,0.513928,-0.126297,0.0919233,0.452192,0.315328,0.455062,-0.439569,0.194084,0.210488,-0.405605,0.209988,-0.375349,0.1123,-0.164407,-0.8242,0.0437982,-0.113491,-0.19426,0.259561,0.0939437,0.35708,0.557935,-0.0902466,-0.0366157,-0.572785,0.0669173,-0.496001,0.0818525,0.571463,-0.0694077,0.222615,-0.0951874,-0.216451,0.0905396,-0.632982,0.274791,-0.325503,-1.28612,0.064288,-0.695275,-0.118405,0.643672,0.0422819,0.143069,0.214708,0.378245,0.463366,-2.49822 +3425.95,0.999577,0.0848144,4,1.58036,0.871857,-1.02817,0.479846,0.823257,-0.156527,0.152272,0.222998,0.407579,0.339031,0.0560219,-0.103479,-0.0548327,0.0629877,-0.0882127,1.09539,-0.0967611,0.37307,-0.0447319,-0.0356692,-0.302612,-0.415036,-0.246727,0.297087,-0.543556,-0.412009,-0.0799674,0.389885,-0.481811,0.00361353,0.550842,-0.275678,0.367715,0.593129,-0.420927,-0.227744,-0.106555,0.406816,0.696957,-0.952893,0.910032,0.50296,0.539153,-1.05922,0.17445,-0.305546,-0.415693,0.418825,0.2626,0.279194,-0.309532,-0.0624091,-0.151923,-0.778208,0.461026,-0.278517,0.148996,-0.625114,0.62278,-0.413782,0.162907,0.89059,-0.173293,-1.15434,-0.303089,0.0433037,0.206304,0.237078,0.266692,-0.363821,-0.231305,0.205916,0.478828,-0.524812,0.168779,0.557712,-0.166136,0.0714369,-0.254529,0.201603,0.221153,-0.302599,0.475064,-0.00570002,0.223399,-0.287072,-0.080749,-0.20821,0.430542,-0.306397,0.137326,0.153776,0.233484,0.446134,-0.230025,-0.345136,-0.0653323,-0.217831,0.250106,0.740576,0.0348652,0.205739,-0.256273,-0.545014,-0.420531,0.136569,0.0806131,0.153115,-0.0794148,0.351176,-0.692251,0.201752,0.0772619,0.351941,0.0277955,-0.244458,-0.553136,-0.17295,0.185831,0.299261,-0.616025,0.192951,0.170381,-0.0256629,-0.14944,0.363421,-0.220891,0.283548,0.0154726,-0.583394,0.0804625,0.517766,0.643537,0.397351,0.359384,-0.387618,-0.369792,0.123103,0.439095,-0.191853,-0.451322,0.0341946,0.632512,-0.436265,0.283804,0.00864448,0.166061,0.589915,0.264514,-0.456583,-0.114701,-0.0890428,0.100944,-0.0518667,0.48572,0.240209,0.316655,-0.0173974,0.126969,-0.640879,-0.0652753,0.249521,0.0743312,-0.487834,-0.0253599,0.223346,-0.16224,-0.221256,0.282729,0.0384253,0.216889,0.00196346,-0.109723,0.0421206,0.134483,-0.633176,-0.635209,-0.485317,0.290125,0.569876,-0.258817,-0.518688,0.311317,-0.170269,-0.215683,-0.48734,-0.196883,-0.245284,0.372098,-0.140643,0.0866472,-0.0961492,-0.113293,-0.603541,0.28611,0.278268,-0.354844,-0.0521064,-0.517865,-0.270357,-0.0107853,-0.587846,0.456048,-0.221219,0.130228,0.269081,-0.632814,1.12249,0.0591734,0.336882,-0.4479,-0.141217,0.453334,0.209753,-0.411837,-0.465853,-0.569728,0.126588,0.378975,-0.24737,0.0539196,-0.842099,0.224812,0.106941,-0.899538,0.369623,-0.519783,-0.176341,0.561337,0.39211,0.550619,-0.0928454,-0.25507,-0.807319,-0.564967,-0.204537,-0.335307,0.0987161,0.476607,-0.0518272,-0.157885,-0.120715,0.152465,-0.129644,-0.277129,-0.077148,0.0220712,0.364944,-0.11945,-0.273252,-0.525095,-0.549573,0.48918,-0.492604,-0.320511,0.21192,-0.36568,0.339089,0.433953,0.146979,0.197071,0.238003,0.412648,-0.177011,0.425399,0.148694,0.312424,-0.242802,0.238326,-0.682469,-0.0357504,-0.144597,0.254369,0.326138,0.530479,0.240583,0.039339,-0.238823,0.0823754,0.277701,-0.299338,-0.469768,-0.0839445,-0.158119,-0.0999661,0.696538,-0.430978,0.157931,0.218962,0.295091,-0.00192469,-0.162286,-0.0196947,-0.704832,-0.354676,-0.179211,0.27455,-0.302213,-0.929016,0.227073,-0.0779589,0.115168,0.223405,0.339364,0.472657,-2.5698 +3406.01,0.91366,0.0848144,4,1.57132,0.926654,-0.664168,0.328821,0.921941,0.0368775,0.380263,0.274274,0.534594,0.109513,0.389477,0.33266,-0.195869,0.25591,-0.108738,0.913456,0.142968,0.206813,0.170054,-0.0628265,-0.0193288,-0.522455,-0.566293,0.074283,-0.313003,-0.355851,-0.395178,0.302669,-0.353949,0.155517,0.671853,-0.475164,-0.0677136,0.614321,-0.218194,-0.415961,-0.660597,0.28852,0.336569,-0.393406,0.401319,0.778356,-0.13253,-0.591298,0.472872,0.35324,-0.0526223,-0.0363487,0.0575756,0.0497757,0.115998,0.207929,0.158462,-0.63148,0.504544,-0.995938,-0.0339099,-0.0917067,0.677561,-0.515511,0.0394386,1.1355,-0.840456,-0.793697,0.32872,-0.0238753,-0.686307,-0.213025,0.157553,-0.287711,-0.229412,0.418139,0.768436,-0.367643,0.370765,0.477658,0.622371,-0.132751,-0.303957,0.0744883,0.159591,-0.148744,0.251807,-0.447021,0.0359776,0.0114084,-0.233296,0.0255552,-0.0765767,-0.196943,0.662036,0.259785,-0.211302,0.16742,-0.11419,-0.15141,-0.138713,-0.0825742,0.059121,0.543783,-0.194595,-0.00149201,-0.363591,-0.362364,-0.0528064,-0.292865,0.113066,0.0622189,0.00416915,0.63941,-0.516276,0.127682,0.507268,0.478972,0.6583,-0.368789,-0.0948008,-0.102986,0.397892,-0.486353,-0.747705,0.151119,0.305633,-0.829981,-0.310741,0.334399,0.358737,-0.436708,0.274671,-0.00934172,0.0743026,0.336429,-0.219729,0.459173,-0.244672,-0.250461,-0.258212,-0.0197555,0.398217,-0.737811,-0.195595,-0.108286,0.45955,-0.266586,0.329901,-0.132644,0.629883,0.150425,0.0428568,0.148946,0.301714,0.0332039,0.0256373,-0.215529,0.0306763,0.230277,0.797711,0.0889107,-0.132246,-0.779494,-0.136303,-0.273091,-0.172328,0.0968957,0.222535,0.367844,0.233653,-0.401097,0.0198986,-0.695357,-0.0468313,-0.555952,0.117725,-0.121698,-0.103863,-0.370961,-0.529645,0.509251,-0.149889,0.704493,0.0605372,0.103511,0.257801,-0.372567,-0.312051,-0.407574,-0.217424,-0.432884,-0.459018,-0.164334,0.210811,-0.408221,0.0861314,-0.350235,0.0448146,0.42982,0.333298,-0.408274,-0.480278,-0.0615012,-0.0279843,-0.391567,0.362588,-0.562588,0.210529,-0.811395,-0.000815529,1.26374,-0.120745,-0.0486127,-0.564693,-1.1054,0.662399,0.986535,-0.350141,0.193439,-0.259941,0.441031,-0.34226,-0.513321,0.176988,-0.869158,-0.0135221,0.197988,-0.454646,0.292094,-0.386787,-0.681467,-0.250302,-0.325976,-0.471881,0.0754516,-0.735652,-0.301721,-0.381685,0.438677,-0.57309,0.437735,0.0911395,0.206181,-0.08465,-0.279164,-0.0950502,0.302221,0.832529,0.267521,0.540845,0.214043,0.0806916,-0.942501,0.0465895,-0.182565,0.172875,-0.276905,-0.413845,0.114378,-0.139555,0.0617057,0.272435,0.228385,0.310991,0.774888,0.0960646,0.10764,0.601593,-0.0192407,0.178493,0.481548,0.137314,0.305589,-0.0712923,-0.320746,-0.251983,0.0685063,0.479544,0.503984,0.00570238,0.0337401,0.349641,0.253731,-0.201344,-0.171024,-0.489305,0.110992,-0.0640879,-0.0335266,-0.197306,0.663447,-0.0780906,-0.412806,-0.0602859,-0.565383,-0.440899,0.191237,-0.322168,-0.86658,-0.16396,-0.217917,-0.547569,0.138127,-0.610624,0.151045,0.224378,0.388646,0.473686,-3.0997 +3411.1,0.809219,0.0848144,4,1.60913,0.956677,-0.509125,0.222399,0.834183,0.0232092,0.446587,-0.065068,0.602065,-0.0895315,0.199559,-0.0879659,0.0146882,0.141342,-0.285658,0.767496,0.258116,-0.0988441,0.231012,-0.0651705,-0.0695586,-0.484345,-0.614008,0.134312,-0.382131,-0.180197,-0.219279,0.351319,-0.134723,0.415524,0.554708,-0.378877,-0.130876,0.717364,0.10128,-0.428997,-0.580984,0.420402,0.268754,-0.616491,0.665883,0.454809,-0.291946,-0.457225,0.350644,0.173279,-0.197733,0.260326,-0.0405949,0.172086,-0.0184335,0.427595,0.303966,-0.879911,0.589202,-0.831708,-0.0440403,-0.313783,0.638134,-0.732026,-0.0130665,0.897195,-0.823984,-1.04335,0.476472,-0.064322,-0.599238,-0.282347,-0.0293699,-0.313887,-0.494879,0.199767,0.742132,-0.583271,0.424888,0.509155,0.755606,0.232272,-0.155273,-0.0769441,0.326956,-0.143912,0.464336,-0.505952,-0.0804775,0.00892289,0.140525,-0.0399694,0.110835,-0.270627,0.489762,0.235043,-0.176065,0.00883242,-0.0493255,-0.0555936,-0.195125,-0.279608,-0.0856694,0.427961,-0.184645,-0.288946,-0.353227,-0.161322,-0.22536,0.0466466,0.0466147,0.261907,0.0423622,0.495888,-0.569565,-0.0231295,0.23332,0.34799,0.641053,-0.311061,-0.154232,0.0339414,0.0526661,-0.550451,-0.842461,0.0980343,0.264928,-0.906211,-0.396455,0.0850609,0.479213,-0.077332,0.354153,0.222737,-0.139088,0.214992,-0.0680245,0.270311,-0.157978,-0.219378,-0.40613,-0.147407,0.288433,-0.66899,-0.317641,0.0803363,0.465316,-0.226714,0.387037,-0.139316,0.47882,0.138046,0.1963,0.206405,0.300316,0.0418385,0.193681,-0.296339,-0.00768226,0.16741,0.538455,-0.0160134,-0.0721067,-0.760094,-0.0684099,-0.0172743,-0.263851,-0.122919,0.272319,0.269114,0.166716,-0.445002,-0.258025,-0.361668,0.00974481,-0.33332,-0.0658395,-0.316653,-0.060475,-0.83828,-0.592155,0.226823,-0.0588429,0.716352,0.212993,0.355931,0.353614,-0.353379,-0.240372,-0.443944,-0.342296,-0.38107,-0.358643,-0.591052,0.185264,-0.47284,-0.0438255,-0.280171,-0.114139,0.337358,0.334046,-0.378623,-0.685838,-0.109993,-0.0510325,-0.382062,0.345618,-0.38284,0.188983,-0.785342,-0.488149,1.17935,-0.163996,0.0658932,-0.405269,-0.890384,0.382866,0.501229,-0.469247,0.479428,-0.200191,0.589818,-0.443569,-0.486353,0.360722,-0.908683,0.411999,0.51987,-0.443236,0.336378,-0.411485,-0.497582,-0.0945707,-0.28158,-0.198217,0.232629,-0.620173,-0.305699,-0.300923,0.298417,-0.329851,0.485028,-0.0508499,0.0199074,0.204329,-0.398394,-0.190114,0.240189,0.792607,0.352117,0.302604,0.0945655,0.020512,-0.895209,-0.0939796,-0.345378,0.300306,-0.330324,-0.472701,0.0587375,-0.0507396,0.241487,0.513257,0.188424,0.163178,0.894097,0.449526,-0.214664,0.212496,0.164418,0.155062,0.749766,0.103318,0.281771,-0.540595,-0.508083,-0.547319,0.24647,0.575253,0.419524,-0.0716313,0.0253598,0.435003,0.174791,-0.502312,-0.233833,-0.528803,0.0171277,0.151559,-0.0810948,-0.350004,0.718586,-0.163345,-0.374217,0.103816,-0.144956,-0.644268,0.311716,-0.54434,-0.601306,-0.301906,-0.235041,-0.64101,0.347042,-0.44722,0.159781,0.170186,0.399726,0.412536,-2.80075 +3429.97,0.999363,0.0848144,4,1.69431,0.871486,-0.883588,0.408983,1.04166,-0.199346,0.144427,0.167938,0.173613,0.639871,0.23204,-0.206211,-0.0931082,0.189175,-0.107564,0.820204,-0.168394,0.158573,-0.0973008,0.174418,0.149657,-0.451555,-0.472223,0.268795,0.000147769,-0.479092,-0.047667,0.30808,-0.372398,0.603819,0.588576,-1.19411,0.323164,0.347588,-0.0510557,-0.188772,-0.537652,-0.0241984,0.549936,-0.551502,0.672578,0.569383,0.474585,-0.842679,0.00417497,-0.240579,-0.980761,-0.256772,0.255936,0.180008,-0.106279,-0.0506919,-0.249606,0.0348121,0.580642,-0.241628,-0.134139,-1.14916,0.296174,-0.505298,0.131341,1.28578,-0.558624,-1.2169,-0.330979,0.393147,-0.402917,-0.00334684,-0.308461,-0.628711,-0.0366769,0.0277517,0.325087,-0.104779,0.603551,0.419197,0.141246,0.453819,-0.519408,-0.00875707,0.236165,-0.372541,-0.00922794,-0.291242,-0.231768,-0.153199,-0.0128737,-0.222767,-0.418153,0.0503553,0.728913,0.492422,0.165643,-0.196804,0.355254,-0.0648656,0.54007,-0.166252,-0.640984,0.361105,-0.325437,0.224619,-0.735313,-0.480675,0.189636,-0.0554391,0.0749311,-0.0836171,-0.0669614,0.237151,-0.339921,0.298883,0.125883,0.343586,-0.0262911,0.0221987,-0.122021,-0.00512784,-0.0992796,-0.304677,-0.685581,0.373679,-0.186724,-0.145031,-0.519958,0.140965,0.425662,0.27299,0.0929283,-0.454209,0.29442,-0.265595,0.404347,0.655732,0.0106343,-0.0452374,-0.0834456,-0.271907,0.388557,-0.775778,0.120744,0.168021,0.0977499,0.0945817,0.0250352,0.512412,-0.565108,-0.0711916,-0.262538,0.544429,0.242852,-0.0843405,-0.0452746,-0.354081,0.116214,0.218844,-0.0364252,0.297124,-0.00482299,-0.852444,-0.109764,-0.153196,0.757505,-0.270751,0.511009,-0.15274,0.139361,-0.321044,-0.428227,-0.214578,0.135966,0.0700672,-0.00518836,0.0387653,0.00617362,-0.542196,0.213194,-0.142182,0.152785,0.0732646,0.379329,0.343796,0.0339482,-0.331184,-0.164441,-0.419315,-0.7626,-0.0657981,0.683041,-0.73802,-0.00137733,-0.132709,0.0838528,-0.493971,0.250385,0.164101,-0.384691,-0.910678,-0.575456,-0.554774,0.0450434,-0.204951,0.678372,-0.0873763,-0.186326,0.112964,-0.963865,1.09424,-0.0124737,-0.328185,0.244281,0.0483522,0.0365188,-0.0908045,0.45621,-0.159961,0.293949,-0.362366,-0.156808,0.118688,-0.0954581,-0.617076,0.279202,0.183397,-0.947959,0.146262,-0.0873247,0.0518583,-0.087198,-0.456021,-0.709505,-0.160282,-0.417205,-0.479736,-0.270696,0.426918,-0.343007,0.0536132,0.128514,-0.433969,0.0592838,0.167509,-0.024894,-0.0627075,0.328658,-0.317155,0.298046,0.124215,0.13078,-0.269671,-0.145206,-0.202671,0.362651,-0.856097,-0.284478,-0.148012,-0.54645,0.028432,0.0730229,-0.120571,0.563861,0.371543,-0.154193,0.0967465,-0.0775121,-0.215858,0.137147,-0.127809,-0.203679,-0.464017,-0.180318,-0.186366,-0.494865,0.576308,-0.180724,0.0553988,0.296742,0.185603,0.383421,0.499725,-0.0159013,-0.252986,-0.0424495,-0.019873,-0.202832,0.123995,-0.187265,-0.38291,0.0775777,-0.50417,-0.0542827,-0.00764189,-0.217483,-0.303772,-0.133738,-0.261993,0.0665821,-0.710434,0.257613,-0.231671,0.182434,0.131892,0.272804,0.36317,0.522306,-3.17832 +3409.66,0.926703,0.0848144,4,1.52815,0.891011,-1.10393,0.439805,0.631185,-0.0627433,-0.183118,0.266288,0.617379,0.162674,0.313186,-0.232789,0.0635882,0.373291,-0.245457,0.701354,0.0724012,-0.193375,-0.350903,0.118286,-0.35563,-0.325597,-0.259896,0.166032,-0.018265,-0.206628,0.0467536,0.400983,-0.280601,0.360837,0.547221,-0.835288,-0.138114,0.495965,-0.174061,-0.317488,-0.0534994,0.788851,0.526823,0.0740785,0.945404,0.560835,-0.34884,-0.428729,-0.582692,0.556535,-0.590229,0.0751776,0.383077,0.320917,-0.00351901,0.68546,0.143935,0.107909,0.47294,-0.518006,-0.112193,-0.746884,0.492152,-0.555264,0.0342863,1.28689,-0.64509,-0.6826,0.389905,-0.285647,0.0238788,-0.220191,-0.159565,-0.742633,-0.29436,0.325465,0.864682,-0.368736,0.405922,0.664682,0.968245,0.605111,-0.609017,0.0312097,0.147791,-0.636494,0.492398,-0.355195,0.385463,-0.0753958,0.367605,0.0746895,-0.133969,0.0292204,0.618464,-0.235527,0.0242084,0.119693,0.2174,0.107708,-0.948982,0.108813,-0.327045,0.262645,-0.26857,0.245392,0.594369,-0.476133,0.518224,-0.184036,-0.267193,-0.591345,-0.193418,0.618737,-0.0768497,-0.19388,-0.341488,0.37161,-0.0409537,0.214667,-0.249989,0.367127,0.673218,0.172457,-1.3067,-0.419669,-0.282824,-0.209892,-0.347916,0.211044,-0.235711,-0.582552,0.106765,-0.591133,0.456476,-0.251772,-0.112413,0.342605,0.142951,-0.216528,0.0543384,-0.575949,0.261485,-0.977117,-0.330818,-0.178446,-0.60251,-0.605545,-0.186475,0.176912,-0.0455506,0.505262,0.274271,0.249114,-0.503268,0.174038,-0.190925,-0.333961,0.344151,0.372338,-0.0524864,0.265785,0.299548,-0.219652,-0.0930648,-0.165627,1.11334,0.15613,-0.278341,0.351334,-0.360853,-0.609434,-0.285158,-0.173795,0.193918,-0.462479,-0.0863611,0.321591,-0.00768332,0.0318883,-0.503313,-0.0738396,0.21638,0.547798,-0.131552,0.349585,0.46601,0.274059,-0.74102,-0.153648,-0.0274568,-0.213573,0.111324,-0.601288,-0.0838973,0.345556,0.0690236,-0.0844939,-0.275264,0.0156089,0.326875,0.151835,-0.468506,-0.168433,-0.263322,-0.414815,0.486178,0.565335,-0.0299871,-0.868367,-0.763699,1.12876,0.100462,0.504504,-0.0245999,-0.348676,0.179979,0.0889613,0.153388,0.612456,-0.777653,-0.0487109,0.119826,0.0407451,-0.097823,-0.256015,0.272573,0.394967,0.21479,0.295822,-0.433574,-0.322437,-0.135529,0.601073,0.3352,0.199098,0.16049,-0.0666974,-0.343329,0.38794,0.00327118,-0.0631555,-0.0838863,-0.620791,0.0574795,0.0349173,0.0982261,-0.222881,-0.0126211,0.199089,0.43369,0.523744,-0.354286,-0.00213858,-0.404309,-0.545928,0.692997,-0.422542,-0.483112,0.137863,0.141047,0.00420569,-0.560994,0.5032,0.162922,0.638349,0.0758532,0.247435,0.546122,-0.120725,-0.28088,-0.0950607,-0.0419503,0.206019,-0.115277,-0.817909,-0.167051,-0.248626,-0.230616,-0.05924,0.114155,-0.0395387,0.373015,-0.0584086,0.453805,0.367537,-0.394024,0.954352,0.0198472,0.274683,-0.135421,-0.125639,0.159772,-0.378454,0.158636,0.0604085,0.0240576,0.199764,-0.153714,0.00251413,-0.1088,-0.266512,-0.337295,-0.333796,0.0089705,0.159378,0.175631,0.399222,0.419084,-1.9639 +3412.26,0.746068,0.0848144,4,1.52985,0.869469,-0.971082,0.418067,0.66451,-0.129302,-0.158811,0.190914,0.341901,0.113903,0.0618591,-0.338054,-0.193245,0.429838,-0.18187,0.769407,-0.0580541,-0.105282,-0.306064,-0.0304831,-0.00257163,-0.447879,-0.823589,-0.185879,0.149671,-0.0754479,0.1001,0.171495,-0.0963239,0.296715,0.717704,-0.434658,0.0425332,0.510439,-0.340554,-0.614003,-0.19347,0.658074,0.359704,0.0297827,0.781577,0.562489,-0.433955,-0.409735,-0.281287,0.352276,-0.781422,0.13906,0.314173,0.317167,-0.0429207,0.572422,-0.144632,0.241595,0.518143,-0.311698,0.0304392,-0.893688,0.36858,-0.552921,0.302782,1.35428,-0.373237,-0.541113,0.294088,-0.239234,-0.0514708,0.109557,-0.0226028,-0.529877,-0.377251,0.308114,0.549332,-0.359376,0.318334,0.684774,0.910082,0.448559,-0.394016,-0.162471,0.502064,-0.503354,0.652229,-0.348427,0.379135,0.00640797,0.114036,0.0648808,-0.0786116,0.0266751,0.323166,-0.313148,-0.162151,0.208325,0.181858,0.0389869,-0.786672,0.213748,-0.466376,0.269171,-0.201254,0.207958,0.322712,-0.339745,0.526477,0.0620415,0.0612615,-0.346785,-0.304571,0.769161,-0.305971,-0.183994,-0.228813,0.408895,-0.396161,0.378991,-0.361408,0.350039,0.636364,-0.011658,-1.27488,-0.340646,-0.444595,-0.225451,-0.0970416,0.4443,-0.531744,-0.380531,0.0942868,-0.439208,0.251812,-0.131324,0.0480364,0.671844,0.282211,-0.29404,0.190187,-0.3367,0.119112,-0.84376,-0.0743101,-0.381558,-0.629112,-0.337696,-0.11217,-0.107058,0.26346,0.325426,0.134825,0.130543,-0.617865,0.458593,-0.138888,-0.423039,0.311791,0.423938,-0.0526276,0.0690469,0.195992,-0.0613436,0.0625391,0.00473767,1.0931,0.0841242,-0.125667,0.660026,-0.437905,-0.427931,-0.331087,-0.227654,0.0894997,-0.725459,-0.0593982,0.377509,0.00792612,-0.348383,-0.148948,-0.377939,0.168523,0.434371,-0.0935711,0.0761167,0.250272,0.657207,-0.792277,-0.0125305,-0.260464,-0.106088,-0.00518542,-0.652204,-0.207462,0.336123,0.291103,-0.0882448,0.0107695,-0.0398778,0.288986,0.206402,-0.707873,-0.302526,-0.179986,-0.533466,0.771039,0.414694,-0.0133019,-0.644831,-0.751503,1.00173,0.192497,0.216256,-0.0153863,-0.306927,0.384362,0.164859,0.0337042,0.524011,-0.774351,0.00804511,-0.174911,0.0482925,-0.2038,-0.176112,0.294047,0.24058,0.182743,0.315972,-0.506786,-0.253464,-0.0417437,0.630833,0.0676724,0.0871886,0.10446,0.0503091,0.0289735,0.414515,-0.084958,-0.0598814,0.119319,-0.882641,-0.28497,-0.11628,-0.0731962,-0.29117,-0.338896,0.0747484,0.31779,0.533539,-0.470108,-0.0987695,0.144463,-0.46414,0.503242,-0.0709266,-0.107633,0.132755,0.0974069,0.0719839,-0.350604,0.531143,0.0732306,0.895251,0.0155172,0.305662,0.22241,0.0170199,-0.316783,-0.190547,-0.046997,0.0318174,-0.0568847,-0.661464,0.136849,-0.473749,-0.0179339,-0.052252,0.270939,-0.0169882,0.449566,0.0276742,0.472714,0.227756,-0.503847,1.02518,-0.256459,0.209939,0.222891,0.125189,0.237361,-0.14574,0.0477421,0.238257,0.0154287,0.363658,-0.036763,-0.100106,-0.160068,-0.240504,-0.538211,-0.233267,0.420679,0.145266,0.166272,0.381138,0.407765,-2.06729 +3408.81,0.987721,0.0848144,4,1.55934,0.809378,-1.4028,0.612879,0.763209,-0.135071,0.234522,0.0811686,0.53638,0.0410932,0.397414,-0.420091,-0.274117,0.166755,-0.18227,0.88774,-0.151247,-0.348231,-0.24631,0.0665327,-0.466313,-0.339178,-0.214679,0.20351,-0.31046,-0.374625,0.0217578,0.425376,-0.441925,0.451783,0.631205,-0.366083,0.326863,0.441799,-0.33653,-0.464618,-0.15061,0.932026,0.353472,0.125487,0.90631,0.889252,-0.0427994,-0.566084,-0.225804,-0.376609,-0.641256,-0.322133,0.567606,0.360044,-0.00720774,1.0282,-0.186165,0.0983447,0.175683,-0.247606,-0.406479,-0.234127,0.256289,-0.936427,0.0760768,1.06555,0.0255717,-0.776878,-0.229307,0.148075,-0.189992,-0.473352,-0.101932,-0.363711,-0.261022,0.468512,0.699677,-0.210587,0.20787,0.512844,0.175298,-0.0201453,-0.191018,0.235377,0.692635,-1.13598,0.309954,-0.0967646,-0.0996532,-0.174017,-0.766685,-0.147486,-0.361972,-0.244808,0.366113,-0.163416,-0.146607,0.146791,0.391339,-0.109695,-0.322912,0.403013,0.484498,0.313671,-0.318565,0.540822,-0.121385,-0.724241,0.141878,-0.276102,0.112153,-0.291358,-0.349202,0.396757,-0.593748,-0.0987856,-0.955517,0.572926,-0.152326,0.00313932,-0.584384,0.233642,0.542999,-0.163079,-0.928875,-0.235801,-0.457015,-0.132245,0.111972,-0.0519819,-0.299234,-0.250715,0.167739,-0.392646,-0.157787,-0.139253,0.304511,0.658801,0.360228,0.13336,0.0918883,-0.235184,0.665419,-0.539035,-0.086454,0.258297,-0.317413,0.131252,0.405304,0.0136487,-0.232502,0.0108108,0.106731,-0.017226,-0.343738,-0.151183,0.0384035,-0.122219,0.636448,0.3391,-0.146524,0.248343,0.0799434,-0.367731,0.439085,-0.613959,0.745313,0.00342886,0.403819,0.54158,-0.184912,-0.119282,-0.0256697,-0.143973,0.0313972,-0.556716,0.300407,-0.145521,0.20128,-0.737169,0.041909,0.164526,0.255467,0.459286,-0.357905,-0.0300572,0.206764,0.402227,-1.02539,0.349096,-0.40581,-0.205462,0.760008,-0.126301,-0.131229,-0.169614,0.165507,-0.329838,-0.0397747,0.271789,-0.138325,-0.0265248,-0.604017,0.178565,0.306533,-0.510963,0.430974,-0.217873,-0.19098,-0.367986,-0.394613,1.00974,-0.0506135,-0.464399,0.00824374,0.106377,0.24544,0.22377,-0.568635,0.901585,-0.269909,0.0457966,0.450482,0.147042,0.0710874,-0.421052,-0.0729397,0.3401,-0.0277712,0.201118,-0.563795,-0.401135,0.316309,0.100552,-0.216918,0.103706,0.235655,-0.528549,0.107259,0.54834,-0.0702128,-0.741964,0.454255,-0.572278,-0.376745,0.221775,0.00350205,-0.289585,0.303214,-0.0804477,0.273062,0.505297,-0.10677,-0.233339,0.0458493,-0.637703,0.415621,-0.0186575,-0.085551,0.603734,-0.156294,-0.204509,-0.242621,0.41249,0.0565929,0.0220497,0.460563,0.182629,1.02498,-0.285969,0.288447,-1.06696,0.551199,0.0266118,0.117122,-0.692471,-0.423391,0.195778,0.0284167,-0.06703,-0.172128,0.694837,0.420615,-0.313286,0.458489,0.154348,-0.129568,0.620329,-0.266366,0.232346,-0.128643,0.240697,0.0324756,-0.361784,0.269396,0.0904633,-0.506201,0.25863,-0.455311,-0.0226113,-0.0719734,-0.441259,-0.585671,-0.459406,0.708411,0.139811,0.163818,0.373913,0.404745,-2.2157 +3407.09,0.735326,0.0848144,4,1.59893,0.833591,-1.71328,0.706095,1.00009,-0.10781,-0.122403,-0.0404532,0.249323,-0.325834,-0.358426,-0.276014,-0.23611,0.164092,-0.17553,0.554423,-0.183166,-0.34577,-0.292412,-0.335669,-0.336201,-0.792047,-0.347202,-0.1722,-0.220331,-0.0299204,-0.224872,0.605064,-0.427553,0.0318459,0.383519,-0.756425,0.228289,0.333612,-0.235455,0.0837833,-0.132404,0.214314,0.604823,-0.100986,0.894938,0.801717,0.00514977,-0.632084,0.0528251,0.223661,-0.525679,-0.360823,0.195801,0.218636,0.0226767,0.385959,0.30359,0.247272,-0.00388295,-0.0037132,0.206559,-0.754406,0.483863,-0.486025,0.338963,1.29514,-0.250156,-0.460732,-0.192112,0.22627,0.45721,-0.296106,0.0591531,0.105774,0.454245,0.242071,0.631663,0.0281475,0.393092,0.516395,0.690502,0.235535,-0.312528,0.325648,0.724033,-0.796588,0.251526,-0.231353,-0.726069,-0.1509,-0.23988,0.261754,-0.217208,-0.0656872,0.291184,-0.369871,-0.106296,-0.343501,-0.135047,-0.157238,-0.53381,-0.0358739,-0.13562,0.361561,-0.834312,0.111604,-0.350066,-0.513936,-0.0290324,-0.271594,0.141725,-0.323981,0.225843,0.307721,-0.758439,-0.107285,-1.10942,0.626621,-0.193941,-0.521837,-0.978414,0.0695013,0.790697,-0.0324833,-0.160567,-0.549929,-0.335001,0.351275,-0.219827,-0.302814,0.0679843,-0.508566,0.440226,-0.947675,0.00505348,-0.268475,-0.0940877,0.657982,-0.00166472,0.128279,-0.200035,-0.293437,0.712879,-0.996226,-0.116795,0.119163,-0.0499245,-0.493047,0.36064,0.199654,-0.513219,0.411316,0.155078,-0.526217,-0.437961,0.176005,-0.130575,-0.387513,0.813475,-0.108655,-0.261649,-0.00151945,-0.0238267,-0.405916,0.16469,-0.160256,0.932513,-0.0200166,0.637466,0.919485,-0.469717,-0.300025,0.134558,0.071042,0.259186,-0.501284,0.198458,-0.227957,-0.307324,-0.613712,-0.740761,-0.302317,0.438567,0.526465,-0.664298,-0.172,0.693185,-0.00994665,-0.680225,-0.426692,-0.205458,-0.461519,0.435942,-0.365693,-0.0602247,-0.368901,0.0222078,-0.0749899,0.0631398,0.484794,0.0764335,0.167234,-0.449174,0.0518184,0.0420964,-0.562277,0.205179,-0.208198,-0.146957,-0.0496736,-0.959968,1.30996,-0.439179,0.0725691,0.0519442,0.192267,0.189819,0.475807,-0.29683,0.257608,-0.314253,0.195845,0.614566,-0.0188803,-0.205203,-0.179906,-0.284612,0.0548354,0.460045,0.159466,-0.464973,-0.681871,0.0440541,-0.259592,-0.348733,0.287235,0.341976,-0.106882,-0.397964,0.513173,-0.150601,-0.0811769,0.289927,-0.259596,-0.246378,-0.209189,-0.457042,0.622302,-0.0193558,0.48064,0.346005,0.522638,0.344128,-0.0779991,0.184584,-0.334713,0.506585,0.056977,0.113729,0.155508,0.134854,-0.331578,0.644545,0.28535,-0.0383717,0.0966544,0.400975,0.359724,0.818154,-0.262607,0.167249,-0.582678,0.38428,0.248973,-0.0833369,-0.212969,-0.882436,-0.0410468,-0.226584,0.0866688,-0.0406327,0.173174,-0.0454908,-0.245253,0.274941,0.247531,-0.0794649,0.443407,-0.389042,0.147997,-0.324127,0.385164,-0.0301682,-0.184564,0.10733,0.400492,-0.279699,0.200688,-0.130769,-0.305093,-0.107856,-0.341453,-0.639669,0.405043,0.658832,0.178654,0.20456,0.422675,0.452283,-2.9374 +3413.34,0.999588,0.0848144,4,1.60829,0.91387,-1.22967,0.55403,0.874733,-0.0873691,0.074364,-0.0738518,0.504252,0.446901,0.0803573,-0.370233,0.0757271,-0.157069,-0.120713,0.821752,-0.403357,-0.0432354,0.017115,0.0958793,-0.476582,-0.433904,-0.508285,-0.0873037,-0.189705,0.34535,-0.0867344,0.147639,-0.378228,0.069533,0.771803,0.27499,0.478696,-0.00333285,-0.354866,-0.638156,0.132808,0.561661,0.791697,0.149719,0.706423,0.413856,0.167332,-0.38382,-0.505033,0.220668,-0.316254,-0.43271,0.402909,-0.0828572,0.172147,0.104801,-0.15803,-0.261572,0.139899,-0.230512,-0.0173419,-0.280836,0.197808,-0.479641,0.320231,0.731865,-0.193012,-0.569173,0.0302102,0.261704,-0.384149,-0.294458,0.252429,-0.196466,0.18504,0.132186,0.656189,0.0985926,0.0237666,0.819723,0.468063,0.378281,-0.19603,0.398287,0.198141,-0.358751,0.459511,-0.097425,-0.281333,-0.317401,-0.743745,-0.0385969,0.137961,-0.069976,-0.00793609,0.253378,0.198241,0.129301,-0.0363287,-0.567778,-1.00555,0.02015,0.246591,0.241115,-0.431183,-0.0949663,-0.590816,-0.15017,-0.021435,-0.678811,0.243344,-0.380997,0.00557705,0.155351,-0.0672054,0.0268602,-0.444083,0.413169,-0.0902984,-0.305969,-0.35075,-0.474466,0.289654,0.469195,-1.08868,0.0948629,-0.0495377,0.523876,-0.107003,-0.20194,0.265525,-0.550134,0.590415,-0.383783,0.339997,0.483231,-0.222545,0.815203,0.309867,-0.0411788,0.280872,-0.521998,0.417295,-1.33261,-0.563023,0.17747,-0.369339,-1.04685,0.185891,-0.113047,-0.19721,0.811691,-0.0102966,-0.586653,-0.338103,0.698,0.280228,0.112194,-0.266283,0.8489,0.202184,-0.619595,-0.314978,-0.170511,0.238801,0.0658179,0.48307,0.28341,0.167438,0.592433,-0.0968869,-0.594104,-0.661259,-0.0497718,-0.211,-0.169226,-0.047032,-0.255539,-0.653363,-0.480415,-0.420202,-0.41813,-0.281302,0.71588,0.180528,-0.205968,0.207517,-0.601791,-0.594565,-0.0652123,-0.320223,0.0925779,0.115244,-0.217112,0.213461,-0.190774,0.426511,-0.254027,0.221615,0.473292,-0.0116391,-0.402923,-0.319287,-0.00325307,0.329264,-0.208644,0.419246,0.102344,0.601529,-0.448558,-0.311125,0.893226,-0.103106,-0.0123301,0.0778596,-0.542585,0.405195,0.50157,0.144743,0.522835,-0.390834,0.368061,0.448046,-0.349444,-0.61229,-0.311808,0.0313158,0.429459,-0.0427579,0.193779,-0.0757702,-0.950122,0.0121773,0.397899,-0.459563,0.0417531,-0.0657551,-0.368883,-0.233808,0.56154,0.498726,0.125775,0.442573,-0.765741,-0.56922,-0.487885,-0.0186686,-0.0379769,-0.0481724,-0.111717,0.733145,0.0370815,0.0762367,-0.133622,0.0787477,-0.95895,0.464813,-0.096524,-0.57715,0.308663,-0.621878,-0.187771,-0.176278,0.361964,0.0210231,0.636503,0.353894,0.359712,0.625186,0.45247,-0.111568,-1.09002,0.0045475,0.0554144,-0.354961,0.324787,-0.457302,0.245633,-0.333567,0.187946,0.183415,-0.143961,0.793966,-0.231874,0.119413,-0.420923,-0.219692,-0.396709,-0.1058,0.129447,-0.248106,0.510366,0.399105,0.170001,0.0786585,0.106177,-0.0752268,-0.128035,0.102048,-0.491425,0.269983,0.116573,-0.609185,0.0359805,0.636605,0.161583,0.0971829,0.401973,0.311742,-2.76881 +3414.19,0.337779,0.0848144,4,1.63637,0.740593,-1.33931,0.523941,0.860831,-0.184648,0.0403423,0.359589,-0.0353788,-0.348778,-0.119466,0.0608424,-0.379641,0.27125,-0.362272,0.788083,0.0680251,-0.169906,-0.153716,-0.606993,-0.0380344,-0.761589,-0.386829,0.495404,-0.225148,-0.410209,0.283682,0.122541,-0.478925,-0.0674575,1.00748,-0.833322,0.0569466,0.490904,0.107876,-0.494799,-0.294936,0.106632,0.139211,-0.534477,0.791304,0.276532,0.371668,-0.422652,0.225951,0.0288516,-0.314185,0.333982,0.0233807,0.188282,0.12237,0.572031,0.0364853,0.0243475,0.599445,-0.282613,0.0724273,-0.581068,0.300878,-0.268688,-0.0515559,1.16446,-0.641253,-0.736549,-0.404263,-0.325746,0.176721,-0.319195,-0.457786,-0.125039,-0.416769,0.707084,0.682123,-0.0451237,0.733123,0.279283,0.330717,0.281129,-0.103113,-0.395443,0.640488,-0.533703,0.125049,-0.244694,-0.213234,0.0974326,0.0442701,-0.103862,-0.0671175,-0.629953,-0.201974,0.119414,0.160017,-0.13929,0.552834,-0.133785,-0.10875,-0.546124,-0.116444,0.451339,0.460381,-0.0204049,-0.12618,-0.0228919,-0.329053,-0.23766,0.395399,0.0807568,0.282952,0.426628,-0.205181,-0.0504283,0.41732,0.429713,0.245631,0.085844,-0.465968,0.651873,0.00489453,-0.31533,-0.41494,4.92469e-06,-0.435382,-0.932145,0.0889989,0.207001,0.458207,0.524434,0.436795,-0.566256,-0.490418,-0.429578,0.543825,-0.130457,-0.242709,0.412717,-0.730759,0.228698,0.25288,-0.492012,-0.283224,-0.211213,0.281449,0.518955,-0.366392,0.186919,0.159975,0.166596,-0.57182,-0.293757,-0.204057,-0.196784,-0.287129,0.558457,0.568228,0.464203,0.0741111,-0.291334,0.206993,0.251009,0.116616,-0.436724,0.789988,-0.00761022,0.0798833,-0.794584,-0.12712,-0.359025,-0.508667,-0.206116,0.252647,-0.226961,0.0186548,0.0869475,0.224534,-0.403135,0.0593668,-0.00339461,-0.31815,0.27146,-0.0607881,0.464597,0.281939,-0.232269,0.00584222,0.416569,0.124492,0.145611,0.471869,-0.629769,-0.229377,-0.316053,-0.594049,-0.93984,0.201637,0.0600714,-0.0241737,0.00574901,-0.554684,-0.432526,-0.358883,0.16702,-0.0674208,-0.312716,0.322188,-0.0827784,-0.793448,0.783541,-0.148092,0.0695483,0.225245,0.0717794,0.355835,-0.223429,-0.165452,0.227183,-0.462338,0.203299,-0.108722,-0.490184,0.213543,-0.457746,0.393252,-0.175529,-0.012951,0.260305,-0.0921488,0.121166,-0.230405,0.0153908,0.058897,0.119797,-0.113987,-0.551916,-0.651914,0.419406,-0.51459,0.383014,0.200201,0.140519,0.28843,0.193249,-0.1996,-0.043375,0.114034,0.132922,0.524125,-0.142347,-0.732902,-0.0438821,-0.52015,-0.784782,0.574234,-0.275264,0.299172,0.418106,-0.147912,0.0127838,-0.217295,-0.0334821,-0.108896,-0.0186807,-0.396793,0.541011,0.298599,0.129539,0.0188428,0.0892026,-0.652897,-0.277273,-0.226975,-0.295934,-0.142223,-0.255438,0.588831,0.542376,0.0186406,0.111041,0.109197,-0.20761,0.0239111,0.0454152,-0.703284,0.499414,0.30272,0.579522,-0.539674,0.325463,0.079115,-0.0101437,0.0758865,0.137477,-0.334056,-0.501128,-0.0208453,-1.12317,-0.5305,-0.183384,-0.260856,0.338661,0.606765,0.149094,0.18048,0.386127,0.42483,-2.27777 +3391.42,0.475777,0.0848144,5,1.63878,0.920635,-0.92064,0.28953,0.782129,-0.21018,0.0952722,-0.544201,0.260264,0.128099,-0.182695,-0.609319,0.184152,0.11619,-0.466147,0.10314,-0.043139,-0.410944,-0.237039,-0.14931,-0.0192534,-0.825596,-0.956677,0.034764,-0.443838,-0.183126,-0.278787,0.389579,-0.544668,0.381751,0.791779,-0.17207,0.174146,0.283084,-0.369708,-0.278762,0.0184736,0.426684,1.16668,0.184457,0.763407,0.302695,0.500305,-0.63215,-0.0479695,-0.0930226,0.206523,0.161212,0.594833,0.114607,0.167319,0.660554,-0.0268333,-0.917078,0.705737,-0.185023,0.177558,-0.379019,0.0915097,-0.388693,0.483864,0.620439,-0.562232,-1.06141,0.0761786,0.0570128,0.0211789,0.901033,0.183168,-0.29226,-0.605002,-0.123108,0.362893,0.0664167,0.831145,0.371798,0.940035,0.0741468,-0.233033,-0.272538,0.14576,-0.226673,-0.0332891,0.173867,-0.281948,0.303399,-0.410624,-0.144849,-0.0914851,-0.0945615,-0.262052,-0.412878,-0.21703,-0.147415,0.200716,-0.636103,-0.0758681,0.268042,0.311797,0.259312,0.149197,-0.11941,-0.431055,-0.549476,-0.094627,-0.580058,-0.183554,-0.17612,-0.0131918,0.232783,-0.483215,-0.215409,-0.628873,0.424245,-0.273878,-0.190568,-0.276575,-0.0112078,0.448675,0.490147,-0.648031,0.597009,0.23794,-0.408529,-0.395788,-0.368969,-0.295382,0.165079,0.737449,-0.468173,0.226982,-0.0490391,-0.363369,1.07762,-0.235922,-0.477117,0.127887,0.470095,-0.271346,-0.332059,-0.012959,-0.13171,0.0616337,-0.262119,-0.321027,-0.980762,-0.334344,0.303882,-0.30414,-0.239682,0.215991,0.0600358,0.620389,-0.198974,-0.238786,0.482791,-0.0688103,0.166543,0.0487254,-0.081825,-0.190356,-0.082153,0.23925,-0.440221,-0.632496,0.0164717,-0.108509,-0.317711,0.0559113,-0.191704,0.449299,-0.462302,-0.117928,-0.00444386,-0.609769,-0.408979,0.00436491,-0.00808114,-0.0267411,0.777353,-0.188153,-0.329113,0.0309994,-0.862116,0.229494,-0.604163,-0.195399,0.0683584,0.166745,-1.08492,-0.0599231,0.70815,-0.126874,-1.09276,0.445126,0.33427,-0.00510737,-0.512102,-0.203338,0.202866,-0.0903182,-0.463702,0.204916,-0.0738107,-0.413151,-0.107618,-0.146741,0.80236,0.321844,0.532641,-0.311033,0.354096,0.0332022,-0.141851,-0.224832,0.0347961,-0.366624,0.490551,-0.0973764,0.160814,0.196112,-0.600892,-0.21182,-0.441495,-1.12314,0.350129,-0.268961,-0.86831,-0.509128,0.150257,0.0511463,0.118579,-0.177907,-0.691899,-0.509266,0.739899,-0.177874,-0.335537,0.879588,-0.0761364,0.38078,0.313741,-0.914814,0.363629,0.777518,0.161992,0.604064,0.438837,-0.153289,-0.535707,0.380741,-0.102211,0.505059,-0.337111,-0.478065,0.239506,-0.498575,-0.0326602,0.358648,0.219499,0.438839,0.883004,0.700007,0.118107,0.70478,-0.184603,-0.0617157,-0.100931,-0.542506,0.222736,-0.140271,-0.0573251,-0.395413,-0.319821,-0.349895,0.201479,0.422065,0.165026,0.144384,0.532865,0.145858,0.154935,-0.681103,-0.67822,-0.0409864,0.289816,0.0504778,0.276877,0.662721,-0.276869,0.231773,-0.0842651,0.238804,0.191762,0.422995,-0.00925821,-0.359955,0.666281,-0.545858,-0.357966,0.0797576,0.126503,0.188844,0.355672,0.434562,-2.32368 +3413.08,0.857139,0.0848144,4,1.54577,0.978696,-0.832101,0.217957,0.568889,-0.277175,0.220382,-0.0717875,0.0532164,0.00336662,-0.438011,-0.189864,0.356575,0.291853,-0.609074,0.561383,0.184264,-0.320093,-0.0869831,-0.316112,0.157943,-0.977362,-0.845322,0.285338,-0.413165,-0.107871,-0.13028,0.410738,-0.597314,0.0590436,0.655765,-0.172067,0.434006,0.545762,-0.0772059,-0.335164,0.0193421,0.60107,0.13876,-0.357559,0.936359,0.756522,0.502659,-0.192404,-0.174529,-0.306623,0.0337107,0.546822,0.194652,-0.335995,0.32429,0.492915,0.120912,-0.522201,0.493881,-0.284646,0.28512,-0.424464,0.572206,-0.342716,0.685989,0.725196,-0.495717,-1.08703,-0.515255,0.0970655,0.0823676,0.0733348,-0.0809333,-0.245858,0.0866262,0.446916,0.560781,0.274052,0.866419,0.0764187,0.426701,0.313589,-0.222316,-0.367631,0.488231,-0.305784,-0.0598118,-0.15723,-0.180378,0.398993,-0.334486,0.093076,-0.565655,-0.610776,0.141698,-0.640403,-0.500892,0.126459,0.380362,-0.272375,0.0199395,-0.774995,-0.0803278,0.261085,0.353292,-0.550948,-0.591341,-0.473083,0.0752364,-0.110529,0.0701881,-0.344236,0.324846,0.355468,-0.16536,-0.189065,0.196536,0.529651,-0.560862,-0.725864,-0.353923,0.278099,-0.0989461,-0.418591,-0.806406,0.176648,-0.30391,-0.346389,-0.693287,0.107376,-0.239081,-0.442213,-0.0299075,-0.593876,0.152231,-0.0829132,0.104941,0.787693,-0.0279543,-0.216043,0.2834,-0.103429,-0.159104,-0.0625052,0.272429,-0.446577,0.4305,-0.202822,0.108783,-0.265649,0.0797199,0.220679,-0.37806,-0.0051285,0.183714,-0.189352,0.238561,-0.195538,0.120923,0.0192266,0.341141,0.313567,0.390264,0.0204274,-0.441534,-0.314458,0.843461,0.440261,-0.61096,-0.144245,0.198778,0.0887651,-0.436476,-0.105087,0.369451,0.423914,0.230661,0.454425,-0.492756,-0.743743,-0.579006,-0.259103,-0.281613,0.796937,0.141454,-0.226637,0.0865043,-0.90348,-0.107771,-0.714724,-0.0405096,-0.12225,0.0130836,-0.882929,0.150585,0.0106641,0.375105,-0.855357,0.190083,0.0690616,0.238839,-0.702022,0.197654,-0.148014,-0.349588,-0.607053,0.378877,-0.0707494,0.184011,-0.337002,-0.369466,0.818435,-0.063512,-0.042434,-0.142872,-0.189134,0.165968,-0.244065,-0.402183,0.340492,-0.205917,0.199225,0.196632,0.340746,-0.193682,-0.5033,0.41887,-0.27666,-0.0982027,0.403545,0.0991798,-0.411114,-0.752897,0.27116,0.413815,0.111478,-0.0808711,0.211093,-1.04999,0.428419,0.262542,0.268361,0.852132,0.35158,-0.110132,0.10645,-0.371283,0.144188,0.188233,0.462704,0.853145,0.322219,-0.672576,-0.682688,0.129332,-0.500216,0.286075,-0.178492,-0.240591,0.307758,-0.537167,0.346298,0.283545,0.198333,0.331804,0.782705,0.574149,0.296817,0.931458,-0.00238115,0.19603,0.125494,-0.738051,-0.00989991,-0.0482423,0.184442,-0.0925389,-0.18295,-0.159224,-0.249946,0.0838347,0.0600094,0.246419,-0.240887,-0.224168,0.0543415,-0.847478,-0.136032,-0.00599224,0.503472,-0.427379,0.240318,0.385524,-0.392993,0.0902821,-0.35118,0.0615649,0.305885,0.340475,-0.293042,-0.273888,0.635833,-0.682206,-0.659621,0.119817,0.199943,0.22783,0.44715,0.477316,-1.77332 +3416.37,1,0.0848144,5,1.57762,0.978223,-0.583102,0.134989,0.785341,-0.257309,0.403091,-0.0962418,0.362771,0.386732,-0.265385,-0.250728,0.120544,0.114605,-0.419049,0.691632,0.144324,-0.109319,-0.104703,-0.277264,-0.0928948,-1.00207,-1.22202,0.0932591,-0.509286,0.047481,-0.0667895,0.231563,-0.629305,0.364714,0.754111,-0.366964,0.316479,0.479955,-0.220747,-0.36417,-0.154435,0.485345,0.352023,-0.135387,0.766897,0.447049,0.58719,-0.0877688,0.0466335,-0.426722,0.119941,0.314451,0.451808,-0.170891,0.161861,0.122555,-0.0137342,-0.464979,0.843322,-0.305949,0.380544,-0.500174,0.253085,-0.422058,0.348014,0.684876,-0.463676,-0.561049,-0.0535167,0.390907,0.564886,0.297663,-0.0956661,0.211235,0.14539,0.066207,0.383471,0.213291,0.578777,-0.0395033,0.609632,0.0161086,-0.146103,-0.432433,0.520731,-0.409284,0.020312,-0.787087,-0.364687,0.265382,-0.944482,0.0753239,-0.379765,-0.205419,0.367395,-0.40835,-0.742103,0.226488,0.192256,-0.375299,0.088322,-0.711085,0.0329661,-0.162542,0.194439,-0.690071,-0.70066,-0.488453,0.102353,-0.25956,0.24662,-0.497318,0.430321,0.440417,-0.172974,0.0529822,0.332614,0.435978,-0.161837,-0.561274,-0.882407,0.323779,-0.143174,-0.536436,-0.711645,0.187596,0.0141925,-0.23479,-0.436007,0.0402916,0.168337,0.083351,0.179872,-0.578534,-0.142042,0.0700722,0.0773349,0.735193,-0.26776,-0.206464,0.243728,-0.124383,0.22319,-0.0911051,-0.0501093,-0.573006,0.593883,-0.108184,-0.0754934,0.208378,0.413568,0.516497,-0.286151,-0.595172,0.0156957,-0.160689,0.380856,-0.0332301,0.300238,-0.197226,0.798548,0.209551,0.118046,-0.500714,-0.475131,-0.336853,0.858329,0.0910529,-0.108792,-0.02251,-0.0812768,0.0996081,-0.00435936,0.181375,0.245811,0.871521,-0.0957572,-0.0196456,0.0041151,-0.260925,-0.144442,-0.14534,-0.0291291,0.875943,0.252956,-0.338913,0.0195178,-0.216583,-0.228386,-0.0375537,-0.0877501,-0.0410816,0.0899267,-0.02842,0.190462,-0.260975,0.0426859,-0.490269,0.162136,0.174608,0.165504,-0.760471,-0.00912651,-0.0759901,-0.247666,-0.146301,0.359464,0.37386,0.250627,-0.343795,0.0920073,0.869517,0.222346,0.0589519,-0.213645,-0.239117,0.507304,-0.0720658,-0.174475,0.298864,0.0133492,0.097178,0.362279,-0.448743,-0.0243813,-0.258073,0.197165,0.069059,-0.287851,0.37459,0.385954,-0.727068,-0.546669,-0.182514,-0.112499,0.141414,-0.368943,-0.740797,-0.774199,0.533649,0.586751,-0.500718,0.762571,0.399682,-0.281393,0.334092,-0.111449,0.378924,-0.024928,0.538052,0.831824,0.470292,-0.707549,-0.2103,0.0393788,-0.19913,0.417193,-0.286688,0.13197,0.417296,-0.283286,0.383756,0.209834,0.176301,0.629761,0.871139,-0.00789735,0.148141,0.741637,-0.31426,-0.00433486,0.283971,-0.613946,0.0146494,0.116314,0.29186,-0.497824,-0.331632,0.1337,0.254035,0.433331,0.105451,0.527822,-0.143433,-0.260343,-0.0184276,-0.500205,-0.408942,0.0867433,0.211709,-0.340431,-0.157171,0.34576,-0.734703,0.351823,-0.25918,-0.0114998,0.485938,0.214405,-0.151531,-0.583893,0.590215,-0.659969,-1.30747,0.555144,0.12153,0.143693,0.348612,0.379068,-2.51632 +3440.44,0.961127,0.0848144,4,1.58224,1.00569,-0.714815,0.225179,0.934868,-0.2902,0.13443,-0.0473295,0.631369,-0.45737,-0.184772,-0.0773318,0.0320882,-0.0586649,-0.471212,0.931575,-0.0431093,-0.190561,-0.0036852,-0.143804,-0.229698,-0.947464,-0.976096,0.0612584,-0.577024,-0.111299,-0.297527,0.542192,-0.736263,0.0713697,0.613896,-0.257134,-0.0182836,0.89479,-0.196751,-0.286898,-0.0582016,0.432884,0.208694,-0.367358,0.851758,0.326503,0.255502,-0.598419,-0.359796,-0.322517,-0.127521,0.256928,0.0916329,-0.0657185,0.118162,-0.104686,-0.103967,-0.273199,0.55867,-0.618791,-0.0200773,-0.498449,0.3611,-0.567419,0.292522,0.455348,-0.802232,-0.750486,0.072309,-0.148263,0.0562578,0.0203894,-0.0364048,-0.248364,-0.438617,-0.471707,0.508106,0.605599,0.839666,0.337576,0.399538,0.0665258,-0.0722717,-0.0837357,0.507924,0.126981,0.0181363,-0.279627,0.0354758,0.0839477,-0.196149,0.613901,-0.0435693,-0.306338,0.026984,0.408324,-0.554822,-0.244713,0.0907402,-0.0195937,-0.403589,-0.342974,0.0111005,0.579839,0.386757,-0.335581,-0.050896,-0.159508,0.531417,-0.0940536,-0.185361,-0.294421,0.502124,0.0965965,0.204936,0.13441,0.0229506,0.338224,-0.324702,-0.0512983,-0.100445,0.0716636,-0.267585,-0.718983,-0.760726,0.443679,-0.0284692,-0.253768,-0.368102,0.134629,0.0319027,0.245253,0.293995,-0.617785,0.285582,-0.0223924,-0.157971,0.361281,-0.323974,-0.00900637,0.110179,-0.0104206,0.179726,-0.485045,0.0928059,-0.148719,0.316976,-0.443615,-0.215156,0.215165,-0.0798482,0.277256,-0.422509,0.0574598,-0.0784846,-0.271597,0.121541,-0.062118,0.290707,-0.339757,0.385654,0.00674163,0.0324808,0.175078,0.219191,0.0549526,0.436589,0.35037,0.304529,0.193786,-0.376018,0.197173,-0.435392,0.0914285,0.32854,0.199704,-0.0753057,0.0583941,-0.271509,-0.00373137,0.301216,0.146065,-0.138087,0.895906,-0.106131,-0.089215,0.290139,-0.874752,-0.0780421,-0.548129,0.090287,0.0272061,0.149839,-0.706006,0.213839,-0.245241,-0.25294,-0.761958,0.201186,0.00830149,-0.367292,-0.294537,-0.635829,0.619325,-0.0983141,0.0726851,0.501875,-0.0721252,0.461022,0.277788,-0.0699109,0.837105,-0.0221523,0.0709211,-0.63786,-0.0295696,0.134417,0.757291,-0.626755,0.83466,-0.213105,0.0595061,-0.0342753,-0.378068,-0.104152,-0.0311127,0.0101545,0.246608,-0.541446,0.463491,-0.581691,-0.139658,0.719227,-0.019108,0.0247714,0.205357,0.562768,-0.66162,-0.366687,0.451883,0.0458794,-0.419764,0.662469,-0.0162426,-0.00729079,0.0149739,-0.00948722,0.313752,0.153797,0.282905,0.556285,0.658645,-0.66897,-0.166807,0.00346004,-0.855556,0.334653,-0.157621,-0.31949,0.251633,-0.285636,0.550571,0.0995343,-0.112915,0.797743,0.290712,-0.144956,0.182392,0.807,0.0364081,-0.152593,-0.27098,-0.00251555,-0.301548,0.317708,0.255122,-0.0399933,0.0876072,0.375139,-0.134994,0.218883,-0.103484,0.364578,-0.132861,0.3182,0.416726,-0.679624,-0.231165,0.39835,-0.227736,0.25,0.228262,0.235713,-0.523928,0.286463,0.376587,-0.0630243,0.108279,0.201613,-0.0907462,0.122364,0.500062,-0.409854,-0.492366,0.025681,0.160163,0.287734,0.400204,0.536409,-3.06475 +3427.83,0.739488,0.0848144,5,1.6719,0.862472,-0.73813,0.375117,0.866469,-0.0864957,-0.21843,0.401006,0.104488,0.628486,-0.122737,-0.466551,-0.188231,0.0419604,-0.276157,0.807552,0.163357,-0.245625,0.211301,-0.140296,-0.0662939,-0.653466,-0.836367,0.249951,-0.302862,-0.0668898,-0.0597252,0.118297,-0.444617,0.132338,0.993343,-0.423287,0.180214,0.408757,-0.0799269,-0.383393,-0.551656,0.337825,0.433311,-0.356907,0.891439,0.605948,-0.0547682,-0.590063,-0.211062,0.0495548,-1.25165,-0.0734285,-0.00994264,-0.0908895,-0.196096,0.277132,0.00994402,-0.543487,0.539842,-0.331478,-0.614676,-1.24691,0.193204,-0.661659,-0.123863,0.451275,-0.48818,-0.999429,-0.159136,0.400056,-0.202911,-0.0221405,-0.126418,-0.136306,0.412823,0.995998,1.00489,-0.15753,-0.0414845,0.343414,0.434261,-0.444453,-0.571277,-0.00763402,0.573502,-0.429911,-0.020769,0.586108,-0.159248,0.311866,0.347647,-0.821451,0.0845619,-0.692916,-0.500988,-0.187443,0.259752,-0.154086,-0.0964821,-0.283207,0.354447,0.0140048,0.0930705,-0.114302,-0.530402,0.107947,-0.86599,-0.327369,-0.511027,-0.0897586,0.421177,-0.134586,0.207328,0.679201,-0.113354,-0.0998334,-0.206348,0.258576,0.55073,0.279639,-1.27332,0.27753,0.565757,0.111223,-0.215398,-0.460843,-0.44215,0.0903601,0.164936,-0.159273,0.383825,-0.124892,0.448403,-0.0724274,-0.0105943,0.269744,-0.0880758,0.418499,-0.201712,0.130555,-0.000310201,-0.347502,0.457769,-0.367025,-0.584223,0.0036461,0.262024,-0.457,0.507209,-0.193478,0.131459,0.2429,-0.160757,-0.499071,-0.308389,0.159942,-0.0635985,-0.114186,-0.167127,0.96346,0.217726,0.135011,0.0785703,-0.357371,0.282998,-0.321668,0.754554,-0.467103,-0.212449,-0.0996855,0.224524,-0.283831,-0.104625,-0.167022,0.189584,-0.0543696,-0.151787,0.111848,0.20207,-0.278277,-0.66919,-0.26157,-0.287253,0.64331,0.139421,-0.329287,0.171147,0.708319,-0.422101,0.138034,-0.712568,-0.241349,0.266897,-0.0778797,0.149152,0.771365,0.104357,-0.421811,0.0715151,0.313153,0.377527,-0.276284,-0.554434,-0.0996267,-0.0823388,-0.300344,-0.0663673,0.385458,-0.389778,-0.237896,-0.88318,0.880777,-0.29116,0.539654,0.351811,-0.447263,0.0239585,-0.668475,0.292533,-0.071749,-0.41094,0.123276,0.103008,-0.119373,-0.13994,-0.922186,-0.270444,0.160074,-0.490922,0.323812,0.225776,-0.510646,-0.475356,0.0911723,-0.546078,-0.205949,-0.813065,0.447567,-0.246401,0.823775,0.0123001,-0.0449439,0.698554,-0.569554,-0.484081,0.0546677,0.0398649,-0.314556,0.48624,-0.0220274,0.729625,-0.280862,0.354242,-0.0504335,0.419037,-0.318652,0.202352,0.0884919,-0.0568204,0.26899,-0.292422,-0.223485,0.58104,0.16446,-0.114909,0.358424,0.702668,0.279713,-0.112745,0.213622,0.0933187,-0.0773193,0.206073,0.105697,-0.700387,-0.704462,-0.316396,0.00305449,-0.103777,0.246498,0.0518887,-0.0595919,0.278881,0.0104782,-0.460161,-0.787394,0.345585,0.0692548,-0.179448,0.575565,-0.690828,0.197866,0.25503,0.2825,-0.127952,-0.195935,0.327589,0.175146,0.00687303,-0.637846,-0.617164,-0.177879,0.128902,0.251262,-0.286356,0.163058,0.335515,0.403804,0.579237,-2.67569 +3410.32,0.958337,0.0848144,4,1.66155,0.831413,-0.827075,0.370631,0.855679,-0.0299129,-0.0143897,0.155676,0.0658713,0.103025,0.244319,-0.142578,-0.369313,0.269081,-0.486789,0.788575,0.252453,0.0680504,-0.498262,-0.13849,-0.161974,-0.795339,-0.400866,0.333775,-0.740047,0.197275,-0.219887,0.429102,-0.405822,-0.45679,0.702985,0.280854,0.131239,0.172441,0.0878889,0.0696649,-0.0130859,-0.0209138,0.451489,-0.373533,0.52025,0.679097,-0.321422,-0.547481,0.47427,0.174931,-1.56042,-0.105554,0.173679,-0.14221,0.205863,-0.394056,0.110179,-0.179293,0.66526,-0.462477,-0.479998,-0.227415,0.208101,-0.694623,0.244722,0.840001,-0.363658,-0.204591,-0.313679,0.18537,-0.31929,0.634165,-0.185548,-0.583525,0.181037,0.0584166,0.456926,-0.00405258,0.594717,0.231539,0.501401,0.161222,-0.330765,0.27265,-0.0470712,-0.0812824,0.286674,-0.209186,-0.816829,-0.0708855,0.390416,-0.141482,0.959268,-0.377598,-0.379982,0.114309,-0.183112,-0.358593,-0.245667,-0.507146,-0.144918,0.0284841,0.174239,0.871609,-0.474291,0.29847,-0.231409,-0.463431,0.257547,-0.351923,0.244953,-0.185426,-0.154255,0.295172,-0.422323,0.102884,0.15156,0.356198,0.290155,0.0766163,-0.860688,0.122296,0.107144,0.57737,-0.491582,-0.113172,-0.46075,0.105248,-0.136887,-0.326195,0.174306,-0.462409,0.22403,-0.214022,0.0231004,-0.3665,0.270884,0.867365,-0.0766464,0.138727,0.507881,-0.127055,0.285049,0.149846,0.0738892,-0.122935,-0.065465,-0.563443,0.118891,0.17149,-0.00614016,0.432093,-0.222262,-0.680958,-0.734906,0.0431731,0.0711856,-0.456998,-0.00102301,0.924259,0.347661,-0.227502,0.116921,-0.280677,0.438931,-0.117363,0.338117,-0.528751,0.475054,0.0948893,0.0239807,-0.0814971,-0.174864,-0.0772066,0.0573133,-0.223441,-0.229124,-0.175612,0.19216,-0.293805,-0.105564,-0.633801,-0.370448,0.807816,-0.380916,-0.501621,0.540167,-0.0416279,-0.61482,-0.115815,-0.399287,-0.160888,0.257651,0.121396,-0.0231266,-0.127958,0.0404206,-0.358155,0.0246689,0.65641,0.299116,-0.470233,-0.73011,0.77962,-0.307982,-0.0283575,0.211931,-0.0762152,-0.434434,0.337735,-0.269908,0.989489,-0.159464,0.32295,0.0748781,-0.543994,-0.124623,0.570908,-0.323976,0.317821,-0.272915,0.201465,0.138924,-0.583489,0.169928,-0.659338,-0.060714,0.0345647,-0.852844,0.55217,-0.310733,-0.459478,0.132044,-0.0701792,-0.162731,0.0574545,-0.561015,0.166346,-0.0887092,0.663911,-0.410877,0.149367,0.574874,-0.115398,-1.16552,0.402943,0.266987,-0.0951492,0.825535,-0.103539,0.331949,0.676174,0.398099,-0.0811689,0.0490937,-0.531983,-0.158509,-0.426875,-0.238538,0.48146,-0.107128,-0.425261,-0.19297,-0.189753,-0.24301,0.286253,0.449987,0.513207,0.118415,0.47873,-0.396482,-0.12261,0.260465,0.204076,-0.206706,-0.960583,0.18798,0.155797,-0.21325,-0.130425,0.155225,-0.512287,0.346138,-0.171728,-0.506127,-0.394732,-0.424817,0.367803,0.374007,0.700263,-0.655548,0.440219,-0.183103,0.364007,-0.0616187,0.315183,0.36218,-0.165029,-0.193916,0.083245,-0.487782,0.42815,-1.10355,0.190051,-0.395626,0.137737,0.174738,0.371129,0.418017,-2.55848 +3425.04,0.996799,0.0848144,4,1.60698,0.862216,-0.826034,0.2844,0.887741,-0.186174,-0.196717,0.419377,0.137561,-0.0104974,-0.0840501,-0.353411,-0.00850413,0.272242,-0.0837972,0.319077,0.0216511,-0.327384,-0.271965,-0.46604,-0.377922,-0.904625,-1.18112,-0.094476,-0.251288,-0.133534,0.378125,0.344994,-0.369342,-0.301418,0.662107,-0.630785,-0.0159472,0.374124,-0.0509223,0.0891883,-0.152007,0.736859,0.70833,0.106692,0.673481,0.342404,0.287222,-0.433559,-0.0605979,0.603624,0.0131263,0.295681,0.318503,0.211199,-0.056822,0.522773,0.0634014,-0.98024,1.02295,-0.279077,-0.0690707,-0.744028,0.372172,-0.335364,-0.0922608,0.362951,-0.257071,-0.914818,-0.152362,0.397811,-0.223794,-0.0543622,0.253061,-0.688869,-0.475984,0.552306,0.379521,0.492016,0.619949,0.227398,0.17942,0.235151,0.0651225,0.321585,0.71471,0.248552,0.209452,0.222055,-0.164365,-0.28803,0.397283,0.157159,0.178517,-0.632516,-0.347508,0.308015,-0.229782,-0.31673,0.0999526,-0.640076,-0.22801,-0.0804052,-0.102241,0.625321,-0.348151,0.345527,-0.463123,-0.184129,-0.203934,-0.366631,0.0543851,-0.0745968,-0.0427088,0.664075,0.812798,0.142702,0.360886,0.143186,0.0228491,0.179925,-0.427626,0.0573819,0.517097,-0.427136,-0.560185,-0.31743,-0.189134,-0.404384,-0.0110439,-0.309551,0.205931,0.117927,-0.156307,-0.505546,0.378916,-0.427301,0.0022602,0.309585,-0.339724,0.240016,0.0714558,-0.156629,0.447426,-0.568391,-0.0325487,0.0696517,0.364361,-0.512684,-0.443194,-0.727069,-0.0493992,0.527557,0.190043,-0.77603,-0.166457,0.0652203,0.189721,0.159734,0.00531325,0.641713,-0.663237,-0.0592854,0.48633,-0.00172858,0.250171,0.00989865,0.250726,0.243238,-0.165604,0.125722,-0.175242,0.319834,-0.333467,0.536213,0.0565594,-0.285281,-0.24408,0.0589909,-0.193257,-0.299739,-0.139722,-0.0531309,0.310125,1.23765,-0.605543,0.295687,0.166238,0.448189,-0.00754008,-0.322182,-0.676924,0.00843964,0.094121,-0.558595,-0.231716,-0.0837796,0.106276,-0.52373,0.164523,0.238052,0.401794,0.0145823,-0.10998,-0.0789162,0.346653,-0.136423,-0.125078,-0.511715,-0.0810764,-0.0166341,-0.419414,0.906539,0.138996,0.363085,0.34357,0.0409917,-0.0750286,0.0549214,-0.793,0.475788,0.0432226,-0.107864,0.21943,-0.293686,0.147768,-0.391751,-0.359226,0.0689194,-0.461119,0.300793,-0.179564,-0.797309,0.537057,0.189739,0.0684937,-0.164843,-0.174886,-0.27447,-0.389303,0.808871,-0.662203,-0.48222,0.865052,-0.448882,-0.323928,-0.0372039,-0.816817,0.128705,0.703795,-0.434883,0.575024,0.016052,-0.396871,-0.274252,-0.42057,0.295311,0.262486,-0.591885,0.0913273,0.094833,-0.0927103,0.220866,0.19583,0.439139,0.148692,0.0314421,-0.21087,-0.318755,0.251057,0.597779,0.226522,-0.250449,0.0627803,0.0818542,-0.284783,-0.193787,-1.20274,0.244179,0.302642,-0.31324,0.471795,-0.373171,-0.134119,0.288469,-0.302152,-0.391758,0.479283,-0.389809,-0.20125,0.243421,0.270832,-0.120564,0.0816703,-0.139075,-0.0914731,-0.125038,0.0415378,0.118019,0.101885,-0.508604,0.15261,-0.0915634,-0.125283,0.109711,-0.0789431,0.138872,0.195129,0.372655,0.441734,-2.65364 +3401.16,0.916443,0.0848144,4,1.53796,1.09013,-0.656778,0.0753681,0.372686,-0.100609,0.549576,0.115132,0.178833,0.562384,-0.0758266,0.014162,-0.215383,0.222109,-0.109551,1.12648,-0.215039,0.465102,-0.00611652,-0.362217,-0.430368,-0.987112,-1.01375,-0.254363,-0.360071,0.0589545,0.20194,0.545517,-0.209107,0.00354258,0.320776,0.224783,0.415575,-0.303027,0.0859411,-0.443146,-0.148969,0.0847566,0.832815,-0.769666,0.570088,0.584942,0.0268262,-0.321145,-0.0145396,0.126405,-0.491984,0.0517898,0.560647,-0.116454,0.406956,-0.0127187,-0.0104625,-0.139798,1.04541,0.123652,-0.18348,-0.745059,0.689818,-0.0856402,0.519675,0.96443,-0.332897,-0.900306,0.0991541,-0.00798251,-0.205802,0.28321,0.0600378,-0.311698,0.21245,-0.019076,0.397138,-0.782023,0.635636,0.214076,0.366275,-0.0738279,-0.258779,0.0100685,0.469845,0.0729308,0.540796,-0.27885,0.186318,-0.574223,-0.242043,-0.717251,-0.0241065,0.0571047,-0.327778,-0.293747,0.520261,-0.249811,0.102187,0.0899435,-0.417641,-1.04731,0.105719,0.228625,0.617127,0.00638405,-0.507553,-0.290074,0.0547291,-0.5458,0.493791,-0.592301,0.373463,0.476454,0.083194,-0.0229959,0.829571,0.266751,-0.264397,0.1081,-0.426507,0.0777843,-0.346926,0.0356087,-0.211698,-0.168199,0.117606,-0.375607,0.00310497,0.181643,0.522731,0.081941,0.374615,-0.342721,0.0389554,-0.225119,-0.20518,0.508129,-0.142204,-0.714134,0.215125,0.101391,0.435797,-0.756566,-0.513559,0.131087,-0.503846,-0.180348,0.473207,0.652077,0.120391,0.504051,-0.109691,0.044011,-0.480476,0.113535,-0.647568,-0.049853,0.517933,0.74055,0.470071,0.150031,0.284245,-0.164439,0.345705,-0.0883553,1.20158,-0.193143,0.00778983,0.152535,0.0130223,-0.386795,-0.241003,-1.13336,0.292161,0.0038328,-0.349315,-0.248871,0.108063,0.768278,-0.3155,-0.26883,0.372945,0.847933,0.324306,-0.340217,0.304828,-0.563355,-0.161104,-0.498303,0.0320809,-0.855238,0.197071,-0.234207,-0.0865354,-0.00610266,-0.0640254,-0.322817,-0.206151,0.295935,0.117542,-0.211057,-1.17651,0.0807261,0.0484596,-0.137018,0.269388,0.343195,-0.135559,-0.203749,-0.437379,1.35009,-0.336163,-0.163414,-0.116012,-0.858433,0.580249,-0.670005,0.151176,-0.377274,0.130217,0.844664,0.0765665,0.00118103,-0.491444,-0.297498,-0.168433,0.0285433,-0.829153,0.20123,-0.436804,0.017967,-0.55157,0.253439,-0.112531,-0.125351,0.159389,-0.0887943,-0.135633,-0.0683483,0.207869,0.410619,0.769224,-0.534259,0.308069,0.00795855,-0.322255,-0.405996,0.434782,-0.349504,-0.0349528,0.00760854,0.0785848,-0.323657,-0.838738,-0.586735,0.388053,-0.745539,-0.399459,0.321869,0.0408605,0.0606663,0.460217,0.111547,0.451244,0.33089,-0.232469,0.401906,-0.278024,0.192292,0.321001,0.130251,0.123234,0.261878,-0.555032,-0.167043,0.595853,-0.228911,-0.479419,0.458116,0.315647,0.345274,0.863707,-0.11662,0.318035,-0.178652,-1.0454,0.14505,-0.0882554,0.684036,-0.450282,0.226309,0.242736,0.0399473,-0.216815,-0.0369379,0.370529,-0.0370778,-0.0194513,-0.340079,-0.358918,0.264667,-0.220717,-0.208126,0.53628,0.169387,0.264518,0.411566,0.514313,-1.32781 +3397.43,0.975878,0.0848144,4,1.59169,0.91174,-0.602234,0.208143,1.45743,-0.11685,-0.0538804,-0.0433965,0.309279,0.182158,-0.313778,-0.229164,0.269593,-0.0224947,0.0602902,0.880757,-0.406346,0.113031,-0.166039,-0.624281,-0.209117,-0.782238,-0.532373,0.0678084,0.166305,0.41278,-0.0173236,0.612394,-0.19754,0.478842,0.61649,-0.681644,0.127188,0.23135,0.310021,0.144192,-0.353078,0.53657,0.58482,-0.0157219,0.699212,0.232731,0.340755,-0.295946,-0.0351748,-0.352265,-0.0464655,-0.306958,0.454294,0.190416,0.093311,0.477529,0.371983,-0.434584,1.12902,-0.677231,-0.129542,-0.609146,0.637135,-0.649062,-0.0311775,1.01887,-0.307202,-0.773298,-0.0856065,0.410653,0.767884,0.319773,-0.0931635,-0.372453,-0.852785,0.199174,0.629593,0.355409,0.247168,0.713466,-0.470947,0.147555,-0.215837,0.411991,0.602788,0.0826245,0.0952825,-0.0727612,-0.687474,-0.707574,0.192569,0.0848701,0.0150214,-0.343619,-0.298093,0.324708,-0.135935,-0.312562,0.00937741,-0.487766,0.0880139,0.338419,0.683642,0.687501,-0.408726,-0.165819,-0.307548,0.0200984,0.759526,-0.279543,0.449626,-0.113372,0.410188,0.151935,0.680637,-0.16347,-0.556634,0.173332,0.610081,0.224486,-0.386226,-0.0324804,0.639624,0.014681,-1.19102,-0.637604,0.345315,-0.588611,-0.479025,0.0524387,0.499476,-0.13185,-0.149288,0.0527459,0.35799,-0.00206295,-0.17189,0.544712,-0.0102783,0.0365151,-0.405811,-0.2413,0.703993,-0.484248,-0.61109,0.070898,0.12122,-0.708457,0.128066,-0.583115,-0.018352,-0.140643,0.182346,-0.273193,0.10596,0.461868,0.305625,-0.139308,0.0516878,0.528146,0.067574,-0.0366529,0.269029,-0.0875729,0.130809,0.0595408,0.721381,-0.0823573,0.0756055,0.211302,-0.336068,-0.0858019,-0.294415,0.0869078,-0.25792,0.405973,-0.414611,-0.111356,-0.0778513,-0.631368,-0.425288,-0.424294,-0.470491,0.438104,0.0189304,-0.0367373,0.266612,0.377478,0.228674,0.452348,-0.483848,0.158765,-0.038116,-0.931012,-0.00423315,-0.123933,0.172808,-0.647986,-0.080857,0.727215,0.0360012,-0.375273,-0.759751,0.501281,0.113796,-0.577215,0.0148358,-0.689416,0.0603274,0.146775,-0.386683,0.961296,-0.159345,0.863915,0.362757,-0.364401,-0.194065,0.180661,-0.166309,0.441768,-0.21254,-0.151637,0.495237,0.126373,0.445388,-0.676396,0.454982,0.184483,-0.303995,0.312666,0.0769755,-0.720118,0.993078,-0.0278873,0.0380695,-0.107477,-0.0965407,0.0296553,-0.49889,0.810745,-0.348472,-1.06333,0.295662,-0.492497,-0.747672,0.152558,0.226342,0.300067,0.542459,0.345832,0.847781,0.225538,-0.0859355,-0.361727,-0.00751386,-0.557034,0.275583,-0.0895677,0.0936259,0.511652,-0.0337052,0.224152,0.170204,0.198587,-0.152902,-0.135138,0.886883,0.147294,0.270441,-0.27141,-0.0212836,-0.805513,0.150331,0.0145877,-0.361166,-0.535707,-1.31314,0.469861,0.187299,-0.0786473,0.391709,-0.0801725,-0.228826,0.0908247,-0.541347,-0.0192435,-0.246792,-0.30664,-0.0246179,0.339946,-0.501459,0.600867,-0.110715,-0.872063,-0.0777382,0.206097,0.145625,0.223828,-0.530731,-0.6054,0.162853,-0.144123,-0.229121,0.0560878,-0.446614,0.185785,0.174958,0.431028,0.418279,-4.71033 +3410.23,0.97704,0.0848144,4,1.54227,1.01169,-0.679196,0.19825,1.00534,-0.122429,0.0282427,-0.0781691,0.195011,-0.00868888,0.154512,-0.299776,-0.232019,-0.104793,-0.0841458,0.74717,0.0632802,0.219841,0.0668436,-0.134705,-0.455049,-1.121,-0.655028,-0.239329,-0.232217,0.260059,0.101011,0.743889,-0.437313,0.60278,0.525872,-0.794621,-0.104958,0.128686,-0.0275542,0.0143924,0.0947647,0.16818,0.25937,-0.644135,0.523179,0.244069,0.446496,-0.501625,0.0509296,-0.216047,0.103864,-0.00301635,0.132661,0.142879,0.42234,0.655392,0.27775,-0.131785,1.10297,-0.330297,-0.00504162,-0.578467,0.627731,-0.354143,0.189498,1.04744,-0.392913,-0.50502,-0.0704274,0.431736,0.479961,0.47602,-0.0963736,-0.403563,-0.478684,0.139122,0.588614,0.362429,0.20029,0.485514,0.464785,-0.262757,-0.750661,0.161346,0.716898,-0.206571,0.332624,0.22201,-0.583685,-0.563662,-0.376271,0.0490693,-0.440349,-0.405669,-0.315088,0.535037,0.383292,-0.201514,-0.180243,-0.439439,0.451338,-0.0191587,0.524311,0.230295,-0.490941,-0.304467,-0.225238,-0.000473398,0.885814,-0.672519,-0.179162,0.150348,0.21027,0.0911825,0.30007,-0.490091,-0.269531,0.116274,0.217868,0.116751,-0.671352,0.0947678,0.220416,-0.485335,-1.04568,-1.14394,0.374105,-0.804838,0.231906,0.441671,-0.00127535,-0.432893,0.369964,-0.000527415,0.149651,0.18243,-0.348148,0.383947,-0.141004,-0.218422,0.370443,-0.0148313,0.366045,-0.120481,-0.249195,0.050279,0.241891,-1.16257,0.0526726,0.278307,-0.0862001,-0.40453,0.190444,-0.796244,0.0315361,0.524975,0.21284,-0.236527,0.563602,0.437562,0.470726,-0.444234,0.205616,0.0295701,-0.316963,-0.19265,0.742274,-0.255789,0.0355493,0.460628,-0.180578,0.160679,-0.808454,0.169575,0.202983,0.0214806,-0.444471,-0.249485,-0.422419,-0.585576,-0.269655,-0.0624215,-0.503803,0.499698,-0.0202628,0.184591,0.558675,0.0772075,-0.0755238,0.00411131,0.0105463,-0.0938652,0.364943,-0.393665,-0.148795,-0.299591,0.261321,-0.398275,-0.262941,0.219792,0.504475,-0.0416965,-0.757056,0.173387,-0.151217,-0.0874934,0.20162,-0.798321,0.114664,0.14047,-0.733578,0.978541,0.0764094,0.616097,0.168452,-0.313662,-0.356724,-0.105576,-0.242931,0.435113,-0.187774,0.277791,0.16329,0.170447,0.367018,-0.530279,0.48974,-0.0314783,-0.272625,0.422487,-0.240075,-0.822103,-0.0506547,-0.0892698,-0.243488,-0.327392,0.0951659,0.115945,-0.612705,0.420327,-0.0893105,-0.864648,0.261588,-0.559553,-0.352444,-0.291278,0.0339964,0.245506,0.77207,0.407052,0.759883,0.258264,0.00327564,-0.654137,-0.217833,-1.09809,0.282345,-0.211435,-0.272608,0.447848,-0.504175,0.307863,0.331281,0.229676,0.0913311,0.0624522,0.600274,0.446118,0.106824,-0.18042,-0.114357,0.0179504,0.631353,0.321067,-0.655935,-0.436253,-1.16252,1.28973,-0.153116,0.103815,0.278029,0.130434,-0.124635,-0.0952846,-0.462492,-0.181142,-0.658961,0.526603,0.000204027,0.174169,-0.468757,0.531864,-0.0444187,-1.05312,-0.2139,0.0612824,0.17754,0.0322157,0.118823,-0.962416,-0.268747,0.423205,-0.162516,0.164243,-0.284818,0.166967,0.202046,0.408616,0.449496,-3.38441 +3415.86,0.914115,0.0848144,4,1.57465,0.959953,-0.848355,0.328967,1.24839,-0.106536,-0.0372299,0.245944,0.216688,0.215136,-0.139851,-0.228316,-0.380474,0.177292,-0.0843063,1.16213,-0.0743638,0.232058,-0.0990906,-0.515105,-0.0510911,-0.769461,-0.884479,-0.0420999,-0.306714,0.334939,0.120627,0.363984,-0.234577,0.462693,0.699344,-0.88129,0.043877,0.240745,0.197943,-0.0852358,0.0196805,0.286601,0.491075,0.109572,0.691153,0.375943,0.507988,-0.401869,0.0805301,-0.119803,-0.40159,-0.15509,0.277818,0.226963,0.200263,0.777149,0.0303414,-0.279028,0.9133,-0.400721,-0.265642,-0.505981,0.325685,-0.432241,0.655028,0.993136,-0.0437221,-0.7295,-0.177598,0.695945,0.534852,-0.0332552,-0.0457831,-0.31884,-0.436165,0.478007,0.587607,0.357116,0.429907,0.24994,0.282011,-0.386633,-0.803004,-0.0346418,0.635665,-0.149598,0.481733,-0.12669,0.059103,-0.74814,0.0603041,0.0552165,-0.634223,-0.11691,0.21067,0.36303,0.360989,0.0139791,0.110326,-0.50945,0.271124,0.18713,0.509844,0.368434,-0.534812,-0.27145,-0.42886,-0.23386,0.512492,-0.464793,-0.112999,0.224008,0.338614,0.260103,-0.295967,-0.436922,0.00509073,-0.00149359,0.427384,-0.210368,-0.231521,-0.0395019,0.334983,-0.0805228,-0.846447,-0.981408,-0.0954278,-0.554105,0.0365829,0.356592,-0.17664,-0.766768,0.202062,0.230592,0.429366,0.159949,-0.252165,0.528901,-0.210605,-0.0880917,0.00897349,0.082552,0.183803,-0.126122,-0.228958,0.218674,-0.0157195,-0.904329,0.238754,0.0742996,0.0368307,0.12585,-0.152837,-0.838351,-0.501913,0.487074,0.170918,-0.0196258,0.453305,0.47292,0.606947,-0.800868,0.410897,0.386491,-0.301521,0.119828,0.826307,0.211918,0.407516,0.432046,-0.375226,0.131906,-0.454003,-0.173608,0.153536,0.0952394,-0.391846,-0.367613,-0.264965,-0.186832,-0.166946,-0.31488,-0.162797,0.468899,-0.20542,0.401587,0.376815,-0.0503889,-0.196208,-0.524185,-0.25965,-0.0112101,0.235729,-0.362527,-0.172299,0.131761,0.204325,-0.628462,-0.22549,-0.415108,0.320173,-0.225651,-0.58209,0.352905,-0.0170203,-0.551902,0.471686,-0.548031,-0.615512,0.160344,-1.03858,1.03598,0.0741695,0.306422,-0.203791,-0.0624701,-0.122318,-0.0757711,-0.240324,0.628978,-0.358961,0.252826,0.219236,0.245234,0.357471,-0.329225,0.341074,0.0753936,0.0538022,0.3692,-0.496333,-0.982024,-0.241253,0.229084,-0.451806,-0.300221,0.185086,0.0524744,-0.50115,0.413609,0.182728,-0.429756,-0.0146542,-0.599902,0.146527,-0.444698,0.119708,0.649189,1.02455,0.343706,0.515123,0.142222,-0.13309,-0.502504,-0.307596,-1.26744,0.262372,-0.448414,-0.480386,0.472087,-0.0943966,0.228917,0.699616,0.200291,0.240212,0.0140588,0.187939,0.603565,0.421714,-0.538132,-0.0481924,-0.162755,0.373943,0.206304,-0.397539,0.12644,-0.540453,0.455145,-0.153849,-0.0765013,0.339124,0.0199205,-0.139016,-0.276513,-0.564071,0.252208,-0.513391,0.574622,0.215788,0.164511,-0.231607,0.178279,0.189836,-0.630926,-0.29653,0.409716,0.114646,0.219072,-0.0753546,-0.65188,-0.699791,0.475197,0.151869,-0.235481,-0.0576637,0.158655,0.13786,0.398316,0.371295,-4.10649 +3429.15,0.940793,0.0848144,4,1.62756,1.01614,-0.721241,0.211395,0.848502,-0.246665,-0.404759,-0.13159,0.25931,0.203195,-0.202789,-0.24644,-0.0798404,0.0286655,-0.28246,0.683098,0.142647,0.0175945,0.397349,-0.0842656,-0.490164,-1.02728,-1.4524,-0.107871,0.165583,0.142485,0.119405,0.629632,-0.207982,0.69903,0.537503,-0.767155,-0.0548947,0.0637491,-0.273825,-0.342617,-0.320324,-0.100321,0.199786,-0.150366,0.733862,0.489533,0.26567,-0.519701,-0.147464,-0.348845,-0.526739,0.0880291,0.0911858,-0.00374638,-0.063285,0.42702,-0.0380357,-0.0896856,0.909025,-0.291866,-0.267791,-0.712778,0.576605,-0.207113,0.533751,0.850692,-0.11802,-1.01783,0.236968,0.048824,0.402566,0.345337,0.521628,-0.194121,-0.575221,0.627689,0.522447,-0.3115,0.412306,0.25841,0.185237,-0.0753669,-0.441018,-0.286299,0.399559,-0.684894,-0.14494,-0.0560144,-0.0586825,-0.437936,0.0760984,0.326461,-0.496229,-0.17737,0.0955962,0.581692,0.172156,0.112558,0.0615355,-0.37289,-0.121912,0.221994,-0.16489,0.437028,-0.237234,0.53651,-0.340075,-0.0295448,0.1803,-0.327465,-0.175492,-0.409718,0.179814,-0.0646231,-0.211582,-0.403506,-0.132308,0.118894,0.464333,0.248444,-0.385292,-0.218701,0.352942,0.210142,-0.483948,-0.85913,-0.865931,-0.391415,0.20479,0.543099,0.30556,0.105857,0.659319,-0.501798,0.051918,0.0306795,-0.28967,0.448859,-0.239793,-0.0551865,-0.0697769,-0.18955,0.361585,-0.394023,-0.339009,-0.210114,0.14534,-0.866817,-0.198154,0.209123,-0.126631,-0.244611,-0.106131,-0.174522,-0.680799,-0.014873,0.0852329,-0.358568,0.696105,0.512612,0.0837283,-0.557588,0.106665,-0.0211877,-0.583878,0.0797432,0.599876,0.730886,0.607073,-0.232985,-0.0686798,0.197646,-0.334889,0.026717,0.178633,-0.182094,-0.481146,0.154753,-0.620215,-0.630231,0.0325732,0.254097,-0.391895,0.566526,-0.493794,0.402421,0.323649,0.10271,-0.390354,-0.173359,-0.933414,-0.228068,0.0396368,-0.152545,-0.0717603,0.162577,-0.0737181,-0.759153,-0.21037,0.0312553,0.348896,-0.483857,-0.752671,0.605478,0.0392952,-0.453497,-0.305276,-0.528095,-0.742778,-0.207785,-0.580407,0.684331,-0.0789416,-0.0542467,0.0330442,-0.470426,0.19888,-0.244953,-0.425001,0.320783,-0.251993,0.241223,0.0986234,-0.0198888,-0.0575606,-0.409233,-0.120523,0.296929,-0.905325,0.536463,-0.358644,-0.556236,-0.296066,0.080297,-0.468176,-0.276185,-0.362077,-0.0201408,-0.969343,0.396901,0.189138,-0.198207,0.44654,-0.343543,-0.0780871,0.17648,0.061122,-0.127205,0.551748,0.163685,0.606132,0.209879,-0.244186,-0.197038,-0.292129,-0.67631,0.33115,-0.248231,-0.244022,0.120183,-0.0922023,0.712854,0.30887,0.171489,-0.0468797,0.286798,0.338055,0.586163,0.434787,-0.276067,0.14901,-0.0129386,-0.471093,0.197889,-0.533681,-0.106682,-0.219105,0.197723,0.244773,0.00232832,0.0461537,0.275526,-0.137784,-0.217291,-0.418437,0.205505,-0.440664,-0.187553,0.28624,0.396273,-0.0432243,0.492162,0.312408,-0.760159,-0.291758,0.553584,0.133432,0.329282,-0.0743983,-1.40336,-0.487935,0.287292,0.181631,-0.0363348,-0.317961,0.155022,0.23571,0.393728,0.4855,-2.74563 +3416.58,0.941631,0.0848144,5,1.63594,1.07213,-0.734022,0.273605,0.833372,-0.268097,-0.309977,-0.182847,-0.0494535,0.23796,-0.316109,-0.236259,-0.24623,0.022812,-0.186047,0.647664,0.100309,0.0540776,0.130177,-0.291544,-0.36691,-1.07094,-1.09365,-0.0621836,0.210105,0.37937,0.107101,0.565433,-0.169196,0.480825,0.543155,-0.672572,0.0336951,0.148412,-0.315031,-0.368225,-0.14036,-0.142947,0.201327,-0.442278,0.938554,0.380979,0.508175,-0.454344,0.113831,-0.199003,-0.67533,0.0308425,0.0631714,-0.0919874,-0.197551,0.523484,-0.105586,-0.228372,0.736611,-0.364142,-0.0322856,-0.696007,0.309948,-0.196088,0.167266,0.811575,0.11332,-0.899383,0.19623,-0.174854,0.381047,0.396986,0.47302,-0.132456,-0.504511,0.485415,0.344873,-0.0695546,0.666526,0.206177,0.289829,-0.204107,-0.508821,-0.211409,0.548443,-0.888489,0.1207,0.0232658,-0.112601,-0.182563,0.305214,0.346766,-0.9477,-0.267392,-0.156043,0.745748,0.147688,-0.0624018,-0.0308519,-0.21509,-0.0103043,-0.0556695,-0.0471366,0.354644,-0.309466,0.419224,-0.54127,0.049306,0.183762,-0.334697,-0.23073,-0.438209,0.295874,0.32494,-0.570571,-0.425844,-0.32549,-0.117534,0.380299,0.00599849,-0.101561,-0.0571377,0.4028,0.127682,-0.537768,-0.328923,-0.657159,-0.826921,0.117127,0.132822,0.412493,0.192922,0.477084,-0.705418,0.247526,0.00216083,-0.310181,0.299049,-0.365025,-0.155582,-0.124982,-0.362427,0.39801,-0.64449,0.00307615,-0.117078,0.424193,-0.944006,-0.476671,0.197723,-0.327126,0.120059,-0.147663,-0.0470158,-0.443715,0.15979,0.359245,-0.231289,0.541908,0.434655,0.379104,-0.572972,0.156719,0.378499,-0.123397,-0.0658149,0.47711,0.809554,0.356395,-0.593991,-0.0289434,0.188961,-0.259831,-0.00674732,0.407932,-0.217722,-0.521978,0.125838,-0.471324,-0.248401,-0.177915,0.26112,-0.524774,0.321473,-0.880801,0.478747,-0.0862941,0.232544,-0.297232,-0.268857,-0.849708,-0.118472,0.256765,-0.147707,0.104997,-0.0747572,-0.14122,-0.701095,-0.0495648,0.257258,0.486256,-0.366034,-0.626723,0.345328,0.0826293,-0.286937,-0.401951,-0.685218,-0.870809,-0.0983622,-0.833326,0.632935,0.00417936,0.130277,-0.0554752,-0.465247,0.263931,0.174501,-0.423992,0.519009,-0.243188,-0.0280603,-0.0199343,-0.328186,0.125366,-0.328424,0.145751,0.110378,-0.676677,0.555479,-0.346061,-0.545641,-0.277129,0.0519034,-0.888799,-0.374887,-0.243938,-0.29195,-1.12163,0.138272,0.432523,-0.0974341,0.374577,-0.537756,-0.237555,-0.0602361,0.280294,0.0703362,0.410963,0.433939,0.341868,0.0512487,-0.382225,-0.191764,-0.303306,-0.543906,0.298905,-0.383063,-0.431795,0.0127775,-0.274601,0.643885,0.272801,-0.048515,0.0568408,0.323876,0.176543,0.498737,0.224926,-0.297904,0.355709,0.464679,-0.182291,0.0329455,-0.322493,-0.130349,-0.573261,0.447344,0.539328,-0.0316115,0.279941,0.289515,0.0404755,-0.175428,-0.377125,0.59305,-0.287814,-0.17783,0.606132,0.446631,-0.241531,0.251267,0.419884,-0.736824,-0.336321,0.187483,0.119466,0.302454,0.0230099,-1.44141,-0.36881,0.347303,0.336489,0.116877,-0.470009,0.149366,0.193051,0.386479,0.439376,-2.83294 +3411.91,0.693338,0.0848144,5,1.62746,0.899919,-1.35207,0.594427,0.940146,-0.276989,-0.0311598,-0.0215525,0.049239,0.112623,-0.273148,-0.297109,-0.488673,0.236944,-0.303091,0.862966,0.321182,-0.154145,0.300924,-0.178163,-0.233887,-1.19997,-0.607678,0.171166,-0.429282,0.221292,0.614704,0.468092,-0.283172,0.653637,0.817863,-0.948877,0.227349,0.309705,-0.302741,-0.0868542,-0.0735508,0.700365,0.543721,0.103845,0.740884,0.449257,0.813849,-0.80347,-0.0124101,0.566188,-0.813943,0.157657,-0.175644,-0.07081,-0.308729,0.657167,0.00970483,-0.196502,0.600412,-0.571494,0.00716104,-1.07589,0.437871,-0.234422,0.186622,0.994899,-0.0166498,-1.13098,0.374596,-0.00931806,0.291386,0.285481,0.250492,-0.0795311,-0.1142,0.677835,0.467739,0.188097,0.675737,-0.0385415,-0.103604,-0.628841,-0.171287,0.281912,0.682947,-0.66003,0.157314,-0.243344,-0.269108,-0.377268,-0.231532,-0.264973,-0.821018,-0.273958,-0.244901,0.79346,0.0646435,-0.145445,-0.00475256,-0.0771873,0.0122327,0.311676,-0.18751,0.378549,-0.307997,-0.190004,-0.914244,-0.588882,0.648206,-0.415958,-0.464187,-0.541533,0.145432,0.461814,-0.373829,0.151734,-0.0381745,-0.132289,0.307411,-0.213154,-0.0673817,-0.129157,-0.157787,-0.476596,-0.745674,-0.766143,-1.0504,-0.0113097,0.248785,-0.211736,0.110247,-0.0670301,0.333876,-0.957103,-0.093459,0.00482148,-0.368298,0.400211,-0.538779,0.175439,0.319461,-0.229789,0.306448,-0.624181,-0.22994,-0.42001,0.0868516,-0.29531,-0.744442,-0.0653532,0.17329,-0.00972959,-0.00496,0.134575,-0.84896,0.35031,0.124649,-0.512841,0.381934,0.721955,0.420089,-0.098909,0.0913495,0.0974246,0.141585,-0.34572,0.456919,0.702049,0.403847,-0.0772642,0.0908572,-0.0449962,-0.414512,0.216212,-0.0440732,0.260771,-0.390064,0.176573,-0.0626206,-0.371111,-0.294274,-0.588917,0.00105452,0.32252,0.0829644,0.0540208,-0.347805,-0.032511,0.0719802,0.0615052,-0.797643,-0.0632834,0.139429,-0.336595,0.0296299,0.268491,-0.48749,-0.976298,-0.141243,0.133934,0.371125,-0.325529,-0.269025,0.499313,-0.139997,0.151676,-0.0690223,-0.187703,-0.581787,0.20251,-0.76783,0.739938,0.0107342,0.54271,-0.459794,-0.611754,0.334191,0.119371,-0.352514,0.220084,0.0871604,-0.0804925,0.212718,0.0230206,-0.129658,-0.783945,-0.306749,0.504805,-0.780174,0.288492,-0.217633,-0.125121,-0.251782,0.00669383,-0.214299,-0.383528,0.276819,-0.458846,-0.545078,0.275543,-0.136317,0.265962,0.410403,-0.388976,-0.2037,-0.207431,0.534897,0.310838,0.419954,0.622944,0.733079,0.545893,-0.639228,-0.458179,-0.141676,-0.373965,0.298498,0.123039,-0.79314,0.0989009,-0.0976156,0.531665,-0.15164,0.161219,-0.262906,0.184292,0.31774,0.225892,0.821361,0.0284856,-0.00167205,-0.273168,0.697431,-0.0800209,-0.287772,-0.793821,-0.543406,0.16067,0.491658,0.127187,-0.145938,0.280555,0.102161,-0.0633339,-0.276375,0.131313,-0.658777,-0.348797,0.605579,0.387077,0.200651,0.130843,0.588096,-0.990015,-0.299235,-0.625265,-0.316897,0.476176,0.211937,-0.664331,-0.717928,0.220902,0.115408,-0.0914416,-0.520697,0.16942,0.34466,0.411606,0.587078,-2.86872 +3406.42,0.965912,0.0848144,4,1.48654,0.959552,-1.13512,0.551551,1.45027,-0.261443,0.160104,0.0972202,0.351736,0.518322,0.391063,-0.0807713,-0.0776522,0.134966,0.174413,0.937177,0.301066,0.317375,0.288537,-0.162057,-0.251467,-0.915027,-0.47538,0.263082,-0.177581,0.0513913,-0.146607,1.20425,-0.185066,0.34885,0.75984,-0.412101,-0.0430933,0.499,-0.260611,-0.422528,0.151905,0.683537,0.347026,-0.395813,0.851944,0.3136,0.122875,-0.554173,-0.0163171,0.460416,-0.233178,0.0399173,0.198179,0.16678,-0.202156,0.462945,0.0828814,-0.0172732,0.630705,-0.425183,-0.192232,-1.51982,0.252639,-0.397694,0.656851,0.938996,-0.52003,-1.93492,0.0805106,-0.0141205,0.104026,-0.088998,0.394656,-0.467498,0.0951408,0.504336,0.302733,-0.00903305,0.683267,0.0071976,0.663076,0.365471,-0.607533,0.0254108,1.01516,-0.336028,0.0440238,0.13733,-0.980552,-0.429992,0.102657,-0.638001,-0.316185,-0.455709,0.772678,0.321386,0.298988,0.110295,0.0326473,-0.822864,0.111614,-0.139653,0.400533,0.161813,-0.35533,0.00899086,-0.656235,-0.184974,-0.221828,0.0460474,0.187246,-0.30954,0.648947,0.717267,-0.138994,-0.210195,-0.224518,0.113941,0.197723,-0.579527,-0.239884,-0.137328,0.197674,-0.144949,-0.559294,-1.11514,-0.160021,-0.408741,-0.115161,0.483668,0.51131,-0.18281,0.446978,0.134549,-0.119781,0.476825,0.0798551,0.75361,-0.458304,0.095579,-0.127395,-0.0647438,0.537866,-0.478953,-0.7126,-0.269663,-0.882409,-0.516945,0.115743,-0.0733878,-0.44011,0.231395,-0.530827,0.0837038,0.173363,-0.0298621,0.0783168,-0.192633,0.171296,0.370534,0.724226,-0.0281436,0.0845996,0.118263,0.428816,-0.267049,0.757654,-0.97578,-0.385186,0.146801,0.0517803,-0.222164,-0.219284,-1.03939,-0.34721,-0.0310154,-0.451612,0.153897,-0.209547,0.0187648,-0.262456,-0.47447,0.325821,1.02275,-0.0487648,-0.139836,-0.552593,0.160261,-0.553371,-0.101445,-0.72247,-0.372298,0.209912,-0.884197,-0.083307,0.00811855,-0.855479,-0.688147,0.00235441,0.0649451,-0.0587677,-0.15605,-0.788831,-0.356173,-0.305448,-0.00206018,0.0582807,-0.086786,-0.398807,-0.315317,-0.504298,0.946675,-0.15625,0.228149,0.232274,0.00756279,-0.140012,0.549775,-0.0893288,0.401397,0.0501483,0.118576,0.311103,-0.58594,0.236214,-0.391983,0.00519926,0.309445,-0.836679,0.123252,-0.491929,-0.654453,-0.146511,-0.0980928,-0.538208,-0.257016,-0.134087,-0.126805,-0.316527,0.330095,0.0516877,-0.569418,0.0626635,-0.35038,-0.856394,-0.671545,-0.00811067,0.311094,0.207358,0.15401,0.444755,0.0318939,-0.0162661,-0.607883,-0.802574,-0.192885,0.402168,-0.00783242,-0.26314,0.340186,0.286397,0.818491,0.476329,-0.0628844,-0.038025,0.831765,0.453144,0.455218,0.570229,-0.0258397,0.164839,0.00959267,-0.0842479,0.0102226,-0.574175,-0.16455,-0.346565,0.274979,-0.0660775,-0.448917,0.15439,0.0255467,0.349078,-0.05548,0.0690225,-0.161375,-0.206975,0.280202,0.111608,-0.119352,0.147405,-0.188544,0.390867,-0.184979,-0.169244,-0.114995,0.144629,0.080714,0.135794,-0.857176,-0.538113,0.0991365,-0.228665,0.43215,-0.340209,0.173043,0.243097,0.415984,0.493049,-4.88577 +3398.24,0.834631,0.0848144,4,1.7583,0.908108,-1.14413,0.407031,1.32768,-0.295238,0.110718,-0.30667,0.00835554,-0.346884,0.403788,-0.369371,-0.382776,-0.353311,-0.513115,0.533009,-0.0418272,-0.591487,0.139352,-0.703468,-0.253403,-1.35922,-0.418435,-0.249005,-0.363565,-0.17665,-0.16213,0.547811,-0.500962,0.258059,0.79912,-1.21421,0.447661,0.29894,-0.228316,-0.103389,-0.121245,0.247974,0.917498,-0.369443,0.666247,0.233613,0.0212553,-0.577676,-0.304186,0.0568025,-0.477346,0.0714208,0.230645,-0.496092,-0.578861,0.529166,-0.0092,-0.586703,0.545472,-0.0745386,-0.519337,-0.990785,0.243812,-0.960773,0.159335,0.679974,-0.227172,-0.864743,-0.0960381,0.11265,0.0959612,-0.284487,0.0981756,-0.679761,-0.11593,0.603971,0.800435,-0.449945,0.422731,0.168594,0.0356704,-0.380566,0.0960766,-0.104499,0.571649,-0.464036,0.0509131,-0.291145,-0.609735,-0.179019,-0.874727,0.201501,0.234206,-0.916835,-0.00505514,-0.322124,-0.333842,-0.656756,-0.223046,-0.919499,-0.139038,-0.108531,0.2234,0.363866,0.287328,0.0514915,0.286011,-0.0751268,-0.344892,-0.411757,-0.370192,-0.425851,0.528305,0.410655,-0.139272,-0.541517,-0.583873,0.261491,-0.0553015,-0.0393813,0.0756914,0.152635,-0.263344,-0.543876,-0.391566,-0.150931,-0.135732,-0.644423,-0.573488,0.187225,0.388592,0.297184,-0.433646,-0.43512,0.294842,-0.42476,-0.097627,0.460353,-0.10302,0.0320205,-0.856644,0.139758,0.104532,-0.554995,-0.361935,-0.0210054,0.532219,-0.386049,-0.36293,-0.368342,-0.224737,-0.145896,-0.248444,-0.180239,-0.0572775,0.0495737,0.20259,-0.181753,-0.404568,0.539577,0.21567,0.36808,-0.0697031,0.324482,0.290776,-0.518014,0.52174,0.515774,-0.783792,-0.0188598,-0.11435,0.0506104,-0.222162,-0.234325,0.544277,0.204727,0.011193,-0.198417,0.475707,0.159634,-0.189061,0.224143,-0.553489,0.195827,-0.114091,-0.266179,0.788098,-0.756523,0.0819802,-0.195556,-0.773635,-0.525028,-0.0398686,-0.202586,0.12935,-0.55052,0.485996,-1.00875,0.497533,0.12016,-0.0420339,-0.398135,-0.914612,-0.704353,-0.150078,-0.460171,0.0950192,0.36424,-0.580289,-0.111523,-0.701058,0.395094,-0.469506,0.809902,0.0420195,-0.544285,0.0384072,-0.624122,0.297587,0.0992863,-0.69715,0.302538,0.232639,-0.089203,-0.283563,-0.413809,0.0162943,0.413116,-0.169714,0.200087,0.0455075,0.127283,0.352811,0.0174178,-0.6276,-0.0255984,-0.650148,0.169451,0.563068,0.608733,0.147684,-0.230298,0.945983,0.0406843,-0.242636,0.462708,0.0963248,0.166685,0.789706,-0.157666,0.331484,-0.0497053,-0.558746,0.0969633,-0.578912,-0.389558,0.0508404,0.371515,0.196781,0.767308,-0.651993,0.243101,-0.0544348,0.269526,0.167512,0.78287,0.470682,-0.15546,0.36594,0.233108,-0.306887,-0.910478,0.140266,0.227421,0.00227409,-0.396591,-0.125273,-0.0716883,-0.384717,-0.123143,0.17162,-0.105956,0.241552,-0.0563087,0.163793,0.0155681,-0.362156,-0.338758,0.0767361,0.858466,0.0740825,0.231426,-0.166664,-0.584235,0.0860428,-0.149156,0.288236,0.235261,-0.0131845,-0.410105,0.316438,0.503552,-0.0271155,-0.620945,0.136162,0.177862,0.313882,0.421737,0.560252,-3.96587 +3414.4,0.825794,0.0848144,5,1.66403,1.0312,-1.35892,0.467322,0.734929,-0.140104,-0.327169,-0.262102,0.671289,0.522127,-0.140354,-0.55091,-0.219323,0.0706698,0.257595,0.615545,0.0581662,-0.1276,-0.350775,-0.537218,-0.311761,-0.71107,-0.63779,-0.288389,-0.340317,0.13461,-0.565729,0.568977,-0.502258,-0.248464,0.478723,-0.0129704,-0.180037,0.128469,-0.0442984,-0.523077,-0.0644452,0.478731,0.399754,-0.0707102,0.664044,0.488779,0.0270491,-0.811003,0.218602,-0.127576,-0.0762974,0.086067,-0.017907,0.17218,-0.156497,0.474637,-0.155995,-0.467814,0.245751,-0.309279,-0.616479,-1.07874,0.0633478,-0.502868,0.415773,0.87245,-0.626608,-0.389633,-0.463525,-0.930076,0.0373992,-0.248008,-0.377961,-0.644788,-0.134925,0.417355,0.576325,-0.227309,0.519546,0.0856386,0.0219753,0.0605881,0.0182834,-0.0834066,0.431189,-0.663705,0.15711,-0.130483,-0.221793,0.7081,-0.267682,-0.208547,-0.0592781,-0.330273,-0.00651483,0.0714191,-0.286669,-0.36821,0.0886023,-0.00743954,0.209422,-0.788627,-0.163388,0.352702,-0.0337809,0.133744,-0.593612,-0.345552,1.08111,-0.815078,0.43154,-0.293005,0.249463,0.695786,-0.224496,0.3348,-0.418223,0.348761,-0.142729,0.521561,0.299259,0.205841,0.582916,-0.380408,-0.770239,0.440524,-0.415117,-0.996274,-0.517948,-0.267358,0.240748,-0.327652,0.132628,-0.338319,0.201561,0.219032,-0.385429,0.301103,-0.668695,0.0302077,-0.372161,-0.178366,0.211048,-0.416466,-0.141768,-0.141487,-0.148177,-1.21407,0.10955,0.153137,0.127204,0.588722,-0.469087,0.0837191,-0.459882,-0.0174341,-0.12501,0.134897,0.352051,0.612324,0.389156,-0.0504069,0.464591,0.202739,0.95549,0.197434,0.39315,0.442371,0.784615,0.173644,-0.057427,-0.257098,0.352485,-0.0444959,-0.0374606,0.455217,-0.21643,-0.319951,0.242802,-0.355364,-0.284652,-0.19772,-0.129901,1.08027,0.456197,-0.529777,0.180467,-0.0931234,0.312474,-0.149386,0.080001,-0.706697,0.481806,-0.863013,0.251768,-0.26229,0.160055,-0.408158,0.277915,-0.225185,0.217859,-0.376644,-0.183544,-0.380463,-0.067879,0.141821,-0.0268013,0.0924338,0.101268,-0.283252,-0.150014,0.863793,-0.430262,-0.418859,-0.189429,-0.0189658,-0.150649,0.433107,-0.0909482,0.220127,-0.257862,0.0636997,-0.039319,-0.383078,0.210613,-0.288618,-0.476875,-0.0927558,-0.0359334,0.208524,-0.293252,-0.211207,-0.0327992,0.112951,-0.4645,-0.034301,-0.264411,0.393391,-0.488222,0.485339,0.175723,0.358559,0.328903,-0.722893,-0.408374,0.600214,0.157827,0.372542,-0.0973016,0.104879,-0.150795,0.0410928,-0.167026,-0.22734,-0.0313067,-0.624233,0.412034,0.0866432,-0.398026,0.247174,-0.533615,0.134439,-0.0777428,-0.0115147,0.23897,-0.00233596,0.438369,0.246891,0.326809,-0.37597,0.0164526,-0.242413,0.251405,0.164219,-0.342091,0.147841,-0.0415246,0.138188,0.251608,0.0831503,0.213823,-0.178611,-0.738721,0.162634,-0.453532,0.300176,-0.00313808,0.65324,0.115648,0.0552308,-0.188163,0.370167,0.462398,-0.428447,0.0617763,-0.00506111,-0.200251,0.215916,0.329895,-0.168703,0.0936597,-0.189284,-0.118076,-1.01273,-0.170895,0.130697,0.143631,0.36152,0.378987,-2.29305 +3412.68,0.590836,0.0848144,4,1.60943,1.09051,-0.828959,0.229678,1.03619,-0.0579336,0.497606,0.218292,-0.0487431,0.0149239,0.0423194,-0.315169,-0.583368,-0.00327507,-0.724167,0.880322,0.0472537,-0.15728,0.167492,-0.504317,-0.516398,-1.82599,-0.458456,-0.286319,-0.163535,-0.143656,-0.0814568,0.173617,-0.321067,-0.259573,0.334019,-0.869433,0.957571,0.546013,-0.112479,-0.375341,-0.122821,0.580497,0.610207,-0.230748,0.790456,0.424419,0.110069,-0.959135,-0.348946,-0.241764,-0.712487,0.0735857,-0.104788,0.0136697,0.00145613,0.271755,0.054865,-0.184362,0.356414,-0.0973583,-0.0877862,-0.861371,0.480168,-0.793299,0.314374,0.599889,-0.601832,-0.78177,0.150024,0.300803,-0.0897431,0.237281,0.0951676,-0.345097,-0.0546588,0.526559,0.816663,0.0207489,0.406675,0.205894,0.334082,-0.406266,-0.316025,-0.171422,0.839505,-0.62725,-0.0468934,0.0386232,-0.162397,-0.317434,0.275153,-0.0647174,0.706972,-0.178851,-0.295592,-0.0868338,-0.107193,-0.619261,0.393926,-0.537457,-0.401708,0.115101,0.0716241,0.546811,0.154434,0.118706,0.134783,0.0989143,-0.622094,-0.0765765,0.274592,-0.146843,0.342193,0.0141531,-0.218492,-0.201285,0.403755,0.622083,0.280872,-0.0296739,-0.681913,-0.00945201,0.348114,0.35547,0.224773,-0.114883,0.0395936,-0.0624629,0.684732,0.230812,0.480478,0.391861,-0.285493,-0.231431,0.477877,-0.141123,0.0571741,0.480553,-0.31367,-0.293899,0.154716,-0.250345,0.26717,-0.495803,-0.432682,-0.175357,-0.0145807,0.153332,0.340727,0.203489,-0.00980596,0.171011,0.14701,-0.0095605,-0.292661,-0.347653,0.129941,0.324559,0.041109,0.379217,0.21746,-0.208041,-0.241595,0.302724,0.00256734,0.0904824,0.603537,-0.176113,-0.476311,0.373895,-0.204423,0.00723947,-0.381218,-0.351372,0.32588,0.697378,0.215664,-0.0647269,-0.226793,0.403927,-0.199337,0.0459159,-0.204529,0.553174,-0.117149,-0.493315,0.851981,-0.147426,-0.0431416,-0.578451,-0.633755,-0.659441,-0.0345255,-0.491897,0.091736,-0.0443845,-0.056282,-0.674832,-0.419463,0.48292,0.0835297,-0.178616,-0.676934,0.025202,-0.27988,-0.506509,0.0480205,0.216895,-0.195,-0.0500138,-0.464754,1.00192,0.231266,-0.176375,-0.250586,-0.273501,0.428163,0.0550986,0.550398,0.613095,-0.146165,0.662493,0.340003,0.787096,-0.107645,0.0137765,0.556823,0.229826,-0.569641,0.536623,-0.405302,-0.172563,0.208612,0.0743166,0.0778127,0.307458,0.00653375,-0.668332,-0.295894,0.428661,0.325093,-0.519372,0.928044,0.191724,0.0151831,0.283789,-0.331509,-0.245692,0.282003,-0.580381,0.436357,0.304755,-0.111232,-0.344084,-0.806599,-0.328603,0.0991628,-0.38785,0.0937818,0.0546637,-0.435311,0.22898,-0.0583007,-0.0139384,-0.447087,0.40857,0.284052,-0.0138535,-0.0139267,0.672656,0.00629637,-0.152285,-0.328275,-0.259203,-0.215517,-0.236517,-0.353058,0.273567,0.165236,5.59499e-05,0.0817214,-0.22274,1.40974,0.588698,-0.0559242,0.0439894,-0.240802,-0.442722,0.0396997,0.133407,-0.139298,-0.0110874,-0.135252,0.404705,0.193428,0.53181,0.228402,0.162192,-0.137709,-0.807629,-0.408536,0.162121,0.325607,0.499265,0.0760343,0.124475,0.348291,0.352809,0.590162,-3.52624 +3420.09,0.999741,0.0848144,4,1.58183,1.22429,-0.480972,0.0213596,0.922907,-0.0499163,0.398467,0.332132,0.112501,0.540166,-0.648415,-0.0190912,0.0217731,-0.141077,-0.449584,1.42331,-0.415854,-0.0926629,0.0751717,-0.610729,-0.44438,-0.804735,-0.652558,-0.37351,0.052978,0.175685,0.0856475,0.821508,-0.500679,-0.121081,0.520753,-0.939726,0.97043,0.0807522,0.213422,-0.191904,0.138773,1.01733,0.587071,-0.497842,0.71061,-0.0359431,-0.475322,-0.681132,-0.0238648,-0.0544017,-0.766065,-0.0899913,0.0269547,-0.564319,0.315396,0.724675,0.474222,-1.05596,0.3247,-0.465536,-0.0632721,-0.833341,0.236654,-0.358716,0.246233,0.73117,-0.445586,-1.31697,-0.346258,-0.0424517,0.564341,0.284142,0.122777,-0.418244,-0.436873,0.394386,0.287009,0.335289,0.204375,0.49399,0.559445,-0.120077,0.316824,-0.30139,0.542938,-0.0591472,-0.0710648,-0.293609,-0.503445,0.364425,0.256477,-0.245441,0.00667985,-0.362032,0.59462,0.0049323,-0.133771,0.0813828,-0.00459312,-0.565012,-0.230291,-0.0205307,0.0654552,0.0505793,0.759737,0.10818,-0.255743,-0.0110635,0.543364,-0.352281,-0.0891925,0.161311,0.524661,0.280191,0.0330279,-0.280473,0.519199,0.808042,-0.105159,0.130317,-0.120746,0.431192,0.214047,0.152295,-0.472422,0.325463,0.464328,0.648197,-0.820471,0.287717,-0.0731947,0.162974,0.493935,-0.504146,0.0528889,0.0513668,-0.0577005,0.252563,-0.10446,-0.254597,-0.424081,0.299307,0.0717746,-0.656405,-0.321825,-0.19989,0.0568005,-0.396662,-0.1258,-0.136114,0.345547,0.555649,-0.348695,0.690669,-0.556542,0.0263313,-0.393143,-0.373508,-0.539707,0.00692752,0.523565,-0.187418,0.327951,-0.295355,-0.0667965,0.095347,0.717388,0.763101,0.432376,0.0502416,0.346815,-0.0866242,-0.0192156,-0.508539,-0.407946,-0.274482,0.355758,-0.263128,0.0904646,-0.147755,-0.0277578,-0.269852,0.580429,0.880972,-0.551813,0.296818,0.432952,-0.178734,-0.25915,0.210762,0.181328,-0.127971,0.188914,-0.440572,-0.0366118,0.250892,-0.104255,-1.03576,-0.0229864,0.0720183,0.216635,-0.539171,-0.247275,0.10844,-0.229958,0.113282,0.185578,0.0393297,-0.122414,0.439517,-0.105101,0.791271,0.188799,-0.473621,-0.304962,-0.68597,0.256473,0.085636,-0.394297,-0.117192,0.249185,0.316525,0.405848,-0.572983,0.203745,-0.361069,-0.0619454,-0.0916659,-0.478477,0.782252,0.263509,-0.29167,0.252888,0.298844,0.300932,0.500516,-0.322425,-0.800525,-0.0453942,0.58696,-0.152116,0.149563,0.788407,-0.857817,-0.158202,0.645847,-0.199381,-0.139162,0.861094,-0.291279,0.59628,0.0241545,0.0285947,-0.748089,0.501848,-0.939993,0.38769,-0.0826167,-0.167343,0.514894,-0.342429,-0.0655548,0.202257,-0.361951,-0.35942,0.352511,0.312031,0.212504,-0.11132,-0.0432907,-0.0449867,0.461751,-0.517441,-0.263541,-0.324621,-0.0518902,-0.401604,0.109269,0.106361,-0.052559,0.180267,0.00152428,0.494672,-0.0366072,0.193921,-0.319135,0.0100612,-0.1166,0.73019,0.382916,-0.299968,-0.212841,-0.49275,-0.310384,0.342885,0.0546823,0.281402,0.232533,-0.08926,-0.131827,-0.301727,0.525434,-0.122528,0.0724132,-0.126123,0.139881,0.290464,0.374007,0.538947,-3.40158 +3424.84,0.943571,0.0848144,5,1.61834,1.10927,-0.708069,0.18543,0.475898,-0.0282688,0.150326,-0.230827,1.15807,0.21793,-0.263157,-0.604998,-0.197022,0.14778,-0.41896,1.17797,0.0435957,-0.422323,0.13507,-0.742862,-0.413729,-1.32802,-1.30321,-0.0590909,-0.439678,-0.371301,0.0604831,0.481827,0.247845,-0.0575019,0.631583,-0.377413,-0.145984,0.169579,-0.373738,-0.0753328,-0.547098,0.534654,0.928075,-0.254952,0.95994,0.950599,0.360482,-0.889718,0.0922114,-0.0996181,-0.233682,0.0732944,0.100428,0.042075,0.0296075,0.514296,-0.0489945,0.0444769,0.288473,0.0296122,-0.466833,-0.903644,0.360491,-0.128076,0.215349,0.841891,-0.523582,-1.28991,-0.0425719,0.30145,-0.766464,-0.0526343,-0.0530491,-0.139107,-0.279726,-0.0321479,0.715158,-0.0554652,0.452993,0.500202,0.169689,-0.194832,0.113452,0.266783,0.485727,-0.195396,-0.157136,-0.477186,0.289155,-0.475527,-0.29866,-0.3015,0.446276,-0.449475,0.261289,-0.348205,-0.118526,-0.782536,0.185499,0.0870847,-0.0801129,-0.513276,-0.153033,0.384006,-0.134065,0.396476,-0.521363,-0.177814,-0.22215,-0.293839,0.259992,-0.00276232,0.688911,0.351102,0.484361,-0.26779,0.466713,0.633064,0.440787,0.165524,-0.00425334,0.00176475,-0.252038,-0.100645,-0.388904,-0.131473,0.118642,-0.263691,0.599196,0.353155,-0.177958,-0.116443,0.0768993,-0.3891,0.401524,-0.0273593,0.168664,0.0760008,-0.0776826,-0.0676259,-0.272732,0.463387,0.183545,-0.50465,0.236456,-0.524422,0.367825,-0.044449,0.35711,0.429322,-0.538455,0.243288,-0.0821313,-0.209338,-0.297079,0.230789,0.00452721,0.183963,0.310711,0.45833,-0.454765,-0.118105,-0.184466,-0.0305759,-0.315502,0.239245,0.191226,0.363911,-0.00119333,0.34513,0.12813,0.196278,-0.490456,-0.280338,-0.191462,-0.296824,0.23345,0.297788,-0.013425,0.246672,-0.215163,0.361345,0.218388,0.631558,-0.171078,0.195457,0.121951,-0.118994,-0.103467,-0.426772,0.0728627,0.066581,0.146019,-0.316421,0.068932,0.460831,-0.465901,-0.119551,0.605125,0.41667,0.325929,-0.484049,-0.276072,0.679901,-0.152685,-0.327695,0.0219105,-0.636417,-0.247539,-0.579633,-0.748958,0.843642,-0.00811247,0.369221,-0.0566451,-0.202466,0.10709,-0.247347,-0.451584,-0.230064,-0.0509564,0.211043,0.224725,-0.34615,-0.295276,-0.615796,-0.751485,0.813643,-0.179141,0.395839,-0.340729,-0.425644,0.600271,0.0126758,0.508893,0.271295,0.0838095,-0.0635751,-0.387625,0.584025,-0.294819,-0.0988098,0.516558,-0.575748,-0.140262,-0.0472287,0.20113,0.733815,0.339449,-0.399267,0.344307,0.403054,-0.589036,-0.405208,-0.0890088,-0.478524,0.293153,-0.354982,-0.377936,0.543905,-0.666552,-0.370154,0.0268339,-0.322719,0.57077,0.321777,0.525155,0.245681,-0.043272,0.0567235,-0.365207,0.186605,0.426587,-0.0573263,-0.174114,-0.729012,0.135267,0.159982,-0.460035,-0.021232,-0.0148984,-0.150721,0.290862,0.55752,-1.00077,-0.00729083,-0.446908,0.34667,-0.120981,6.77956e-05,0.110394,0.218865,0.372392,0.335476,0.205863,-0.360653,0.216586,0.219711,0.221047,-0.757301,0.112076,-0.265501,-0.1642,0.675497,-0.222941,0.115549,0.311689,0.339925,0.558291,-1.71942 +3420.14,0.995716,0.0848144,4,1.61518,1.14832,-0.642425,0.12076,0.268393,0.0238676,-0.172438,-0.384292,1.15458,0.329852,-0.302523,-0.591233,-0.0431043,0.105492,-0.188142,1.2006,-0.429409,-0.282336,0.263394,-0.711433,-0.521389,-1.03352,-0.776352,0.0732761,-0.666946,-0.381997,0.338965,0.91322,-0.0260251,0.17789,0.546392,-1.14472,-0.200916,-0.205926,-0.464086,-0.186568,-0.323554,0.659183,0.875498,-0.12674,1.17608,0.918224,0.727671,-0.92177,0.225196,0.302035,-0.342903,-0.248819,0.375193,-0.24078,0.176774,0.259931,-0.284224,-0.330511,0.217432,-0.045766,-0.22469,-0.973961,0.514299,-0.0547652,-0.0298653,0.884246,-0.491737,-0.972428,-0.23249,0.330809,-0.578458,-0.765002,0.195693,-0.0870323,-0.144733,-0.101472,0.629111,0.357042,0.519493,0.195605,0.243225,-0.202267,-0.0720698,0.346776,0.831677,-0.0776527,-0.00747401,-0.365279,0.464786,-0.624276,0.223811,-0.0142161,-0.047915,-0.453825,0.305836,-0.0887348,0.0336877,-0.633475,0.690216,0.175878,-0.141913,-0.575381,0.130973,0.216712,-0.416344,0.358116,-0.0937504,0.150427,-0.0601273,-0.275518,0.235858,0.175032,0.151886,0.691353,0.385641,-0.25584,0.213395,0.61994,0.259086,0.291605,-0.293142,0.122845,0.315986,0.322766,-0.463196,0.155667,0.0188606,0.111724,0.153907,0.288837,0.0855347,0.197025,0.0949257,-0.595037,0.0992613,-0.0115494,0.487514,0.354385,-0.251487,0.0755797,-0.038748,0.304155,0.0626047,-0.475819,-0.294905,-0.354805,0.302519,-0.0387486,0.253822,0.235112,-0.0950625,0.194482,-0.130917,-0.296615,-0.463876,0.0795191,-0.111241,0.561725,0.352181,0.229855,-0.111184,0.125118,-0.0789999,-0.131046,-0.132673,-0.146179,0.15971,0.977213,-0.193711,0.0441584,0.310265,0.00375653,-0.17017,0.0148497,0.233765,-0.694677,0.237231,-0.224994,-0.260723,0.0229495,-0.650965,-0.166458,0.123179,0.650601,-0.0559902,0.397013,0.0350715,0.176321,0.129661,-0.754879,0.18168,-0.154941,-0.0593925,-0.559223,0.261333,0.210485,-0.14013,-0.199592,0.376468,0.23235,0.593561,-0.296463,-0.40585,0.562153,-0.0392814,-0.106967,0.455032,-0.190919,-0.637633,-0.540468,-0.854334,0.766958,0.0216991,0.0629408,0.0985398,-0.357663,0.0374087,-0.0579195,-0.257156,-0.244033,-0.0867008,-0.180456,0.239148,-0.173477,0.126424,-0.491045,-0.635912,0.20875,-0.494241,0.709419,-0.422765,0.0747161,0.425752,0.311581,0.427498,0.249132,-0.313654,0.321772,-0.70428,0.193877,-0.629633,-0.139553,0.679118,-0.312726,-0.74625,0.0231986,0.196715,0.395303,0.0533529,-0.253152,0.134889,0.593371,-0.191999,-0.755055,0.0363457,-0.309281,0.514878,-0.123194,-0.302161,0.647017,-0.254937,-0.0259342,-0.168751,-0.0823474,0.011632,0.079186,0.331231,0.368493,-0.0421461,0.0875715,-0.0534186,-0.0328414,0.3879,-0.0787334,-0.342715,-0.502334,-0.0710311,-0.153609,-0.373026,-0.323312,-0.207786,-0.251288,0.27774,0.303136,-0.694396,-0.438456,-0.254355,0.493426,-0.187631,0.0371048,0.0429405,0.293642,0.111411,0.0305925,0.207645,0.0295959,0.0756613,-0.20008,-0.204977,-0.453658,-0.100069,0.0203983,-0.236236,0.710478,-0.170436,0.142937,0.41335,0.37807,0.642923,-1.08895 +3429.54,0.999173,0.0848144,4,1.6219,0.865481,-0.975428,0.17417,0.395433,0.0674977,0.36282,-0.0420059,0.00210614,-0.140125,-0.390036,-0.0193542,-0.366857,0.0029252,-0.209678,0.837516,-0.190507,-0.412621,-0.53968,-0.253055,-0.475252,-0.770695,-1.1712,0.300589,-0.163609,-0.498226,-0.25614,-0.333945,-0.838857,-0.263072,0.33868,0.306437,-0.245215,-0.262297,0.236104,0.128132,-0.40797,0.7154,0.132768,-0.501114,1.37076,0.690537,-0.382714,-0.268811,-0.0556415,0.159944,-0.519547,0.382905,0.30185,0.180828,0.354802,0.361825,0.6332,-0.608129,0.912374,-0.112456,-0.463409,-0.404128,0.540695,-0.239799,0.339177,1.10257,-0.608809,-0.895928,0.0773715,-0.167383,0.0644184,0.513221,-0.0970972,-0.298777,0.220279,0.234148,0.592522,-0.405505,0.12172,0.509488,0.485315,0.308074,0.0592722,-0.413274,-0.352197,0.0966871,0.0839515,-0.0168042,-0.26296,0.309724,-0.590546,-0.176611,-0.139608,-0.0716796,-0.220248,0.205548,0.408153,0.219301,-0.54016,-0.327738,0.148072,0.29593,0.0480783,-0.260399,0.307697,-0.240506,-0.328594,-0.759266,-0.0134266,-0.500507,0.0578772,-0.250664,0.421286,0.214721,-0.294641,-0.124553,-0.380455,0.402883,-0.358849,0.277231,-0.111447,0.0213556,-0.0822867,0.00514298,-0.418493,-0.417493,0.10982,0.0756572,-0.14546,0.341654,0.0460801,0.290876,0.426447,-0.271368,0.139994,0.186808,-0.199762,0.17412,0.0392774,0.184097,0.00900793,0.123659,0.638051,-0.201262,-0.0473592,0.0454975,0.230595,-0.0589286,-0.0962354,0.0584422,0.099919,0.457121,0.0885122,-0.124632,0.408681,0.536072,0.153082,-0.618393,0.131042,0.150613,0.394108,-0.0132089,-0.12761,0.173637,0.491986,0.302135,1.02672,-0.922808,0.138042,0.378553,0.223313,0.15067,-0.254108,0.353845,0.134484,0.684295,0.137575,0.316589,0.317506,0.0995697,0.129624,0.0188261,0.502535,0.528418,0.123822,-0.360149,0.517578,-0.076733,0.118213,-0.0444952,-0.109246,0.0045468,0.222663,0.0347019,-0.0601985,-0.264622,-0.450516,-0.484883,-0.261413,0.119318,-0.0786159,-0.0426841,-0.6958,0.0350134,-0.294181,-0.380516,0.151408,-0.196372,0.496612,0.246501,0.264651,1.14067,-0.145244,0.662893,0.314492,-0.259403,0.0524909,-0.0589627,-0.223556,0.60993,0.120532,-0.0135685,-0.339135,-0.0481188,-0.00886737,-0.17657,0.48721,-0.272614,0.163483,0.555401,0.311916,-0.177148,-0.0318693,-0.182724,-0.520437,0.236003,0.220746,-0.0632281,-0.00998014,0.621581,0.53941,0.401374,0.17096,-0.0585803,0.279275,0.49304,-0.402366,0.0469851,0.2673,0.484257,0.590648,-0.317338,-0.0507438,0.0621221,-0.491513,-0.950474,0.0112473,-0.162525,-0.600542,-0.163893,-0.288033,-0.313301,0.172865,-0.356557,0.393568,0.43572,-0.109537,-0.12888,0.255329,0.024025,-0.0414589,0.0152004,-0.506684,0.195743,-0.220055,0.141351,0.0972774,0.214926,0.0934696,0.338528,-0.179295,-0.287533,0.0194636,-0.295495,-0.198445,0.162862,-0.244009,-0.0911409,0.509566,0.306822,-0.209971,0.0218053,-0.034054,-0.587562,0.0852409,0.0694097,0.41041,0.610978,-0.0594833,-0.14077,-0.321734,-0.317334,0.161436,-0.818657,-0.0777979,0.125472,0.20419,0.35422,0.451873,-0.89052 +3414.94,0.975386,0.0848144,4,1.5946,0.812266,-1.2167,0.208782,0.419295,0.0289996,-0.194999,-0.556818,-0.454243,-0.449088,-0.288232,-0.503628,-0.702569,0.0156704,-0.115568,0.920211,-0.236042,-0.0442826,-0.239905,-0.514489,-0.22229,-1.18479,-0.712878,0.220729,-0.417397,-0.76818,-0.172119,0.448514,-0.408836,-0.191423,0.498178,-0.897805,-0.621515,-0.274999,0.112284,0.333684,-0.173917,0.140053,0.252126,-0.706639,1.1965,0.662404,0.422985,-0.301272,0.309815,0.127302,-0.230585,0.0301287,0.531522,0.0808552,0.639598,0.0238991,0.657891,-0.121193,1.15893,-0.480607,-0.113436,-0.332722,0.826035,-0.212696,0.164946,1.20923,-0.957708,-0.0708335,0.57899,0.322154,0.354629,0.261005,0.253821,-0.850541,0.134708,0.218166,0.799742,-0.532431,0.361359,0.68568,0.386174,0.318191,0.159217,-0.0690465,0.78355,-0.0517906,-0.136221,0.13209,0.0226825,-0.47074,-0.0718908,0.0264373,0.182862,0.12484,-0.154692,0.498139,-0.0978907,-0.11597,-0.0548609,-0.42984,0.125784,0.399379,0.211234,0.306705,0.521164,-0.381512,0.149364,-0.1315,0.492563,-0.450299,0.3895,0.0946121,-0.0444158,0.282465,-0.14497,-0.666915,-0.381687,0.543973,0.156669,-0.0736504,-0.441556,-0.0152296,-0.139375,-0.0860418,-0.462679,-0.116029,0.153447,-0.0398579,0.0603625,0.0403318,-0.113893,-0.0138386,0.530321,-0.546669,0.417662,0.238838,-0.245025,0.0479929,0.423061,0.302247,0.0056382,0.115038,0.403858,-0.236976,-0.291421,-0.289615,-0.509296,-0.284332,0.0236556,-0.180808,0.00980501,-0.0920705,0.0532023,-0.380391,0.253907,0.69739,0.314898,-0.4616,-0.00293345,0.457414,0.656308,-0.121332,0.00486028,0.102639,0.579108,0.373919,0.726392,-0.819888,-0.00872542,0.358909,0.163993,0.0880572,0.0246868,-0.158188,-0.219091,0.195629,-0.0367735,-0.110574,0.0550153,0.1797,-0.0436234,0.2435,0.792675,0.339382,0.333095,-0.140131,0.0365331,-0.166004,-0.436188,0.0385803,-0.0752257,0.142766,-0.581194,0.108218,-0.012851,-0.117158,-0.500395,-0.217445,-0.362391,-0.0443129,-0.0591163,-0.265548,-0.562971,0.250638,-0.294253,-0.382576,0.0634826,0.35797,0.192607,0.122217,0.107802,0.972617,-0.498908,0.0967411,0.0506937,0.0469213,0.0335011,-0.806822,-0.0291767,0.503789,0.263391,0.190831,-0.251817,-0.0942856,-0.122425,-0.134539,0.132158,-0.110676,-0.361674,0.6093,0.0866508,-0.174261,-0.0968252,-0.233501,-0.147959,-0.0279216,0.582673,0.474752,0.0570698,0.389367,0.323309,0.635458,0.981804,-0.528719,-0.837226,0.213673,-0.689496,-0.306563,0.233294,-0.0755196,0.102711,0.107133,-0.148568,-0.127605,-0.358335,-1.01448,0.351873,-0.372949,-0.274224,0.157994,-0.69351,0.117893,0.186281,-0.136838,0.470967,0.458813,0.0345978,-0.228376,0.445662,0.319779,-0.326295,-0.133626,-0.574284,0.000348721,-0.377616,0.238749,-0.350432,-0.191997,-0.111205,0.0982231,0.39004,-0.212022,0.0433239,-0.40548,0.151936,0.0857099,0.122485,0.325282,0.357445,0.526379,-0.414584,0.261836,-0.221773,-0.239607,-0.0804177,-0.0792363,0.169135,0.541079,0.136478,-0.0579508,-0.0206919,-0.435111,-0.458028,-0.100362,-0.0040079,0.106468,0.260938,0.326295,0.510821,-0.799388 +3425.85,0.993186,0.0848144,4,1.52732,0.818268,-1.39534,0.331611,0.236192,0.0248777,-0.0675076,0.167667,-0.56852,-0.0532325,-0.113744,-0.385044,-0.425241,-0.0251419,0.0312493,1.06352,-0.166501,-0.216604,-0.288007,-0.336154,-0.563363,-0.935544,-0.736575,0.419143,-0.396822,-0.75983,-0.24723,0.512375,-0.82251,-0.328409,0.527095,-0.848463,-0.850175,-0.0623585,0.0572685,0.258584,0.101519,0.551301,0.369266,-0.717226,1.00089,0.361099,0.440755,-0.380118,0.0845696,0.435738,-0.542936,0.0379713,0.58067,0.448176,0.589246,-0.361339,0.681583,0.270647,0.989865,-0.465239,0.234117,-0.71513,0.737425,-0.12951,0.0711916,1.02996,-0.375006,-0.331248,0.674635,0.240287,0.448769,0.700374,-0.253914,-0.907094,0.00403766,0.638028,0.830936,-0.610204,0.25448,0.710218,0.163938,-0.0969432,0.0128288,0.241368,0.699907,-0.306756,0.0541575,0.15347,0.0127847,-0.332142,0.154645,0.0573757,0.24574,-0.207486,-0.192495,0.329917,0.010146,-0.348025,-0.091099,-0.0440857,0.319167,0.452019,0.431693,0.117432,0.382558,-0.735089,0.0788107,-0.453447,0.148499,-0.00220522,0.359961,0.312884,-0.079121,0.239106,0.388261,-0.44123,-0.170683,0.395209,0.194239,-0.201466,-0.3804,0.0307726,-0.128296,-0.0198456,-0.659355,-0.162558,-0.0786879,0.13467,0.273793,0.028264,0.22787,-0.171004,0.455131,-0.22496,0.590964,0.175254,-0.214959,0.320196,0.342333,0.261781,0.0531489,0.438523,0.598176,-0.163161,-0.647866,-0.359658,-0.0239072,-0.0111342,-0.018202,-0.0795471,0.122889,0.0617243,0.014329,-0.325757,-0.114604,0.381527,0.015937,-0.589478,0.0687298,0.475884,0.211244,-0.192246,0.378477,0.0683373,0.668012,0.508393,0.549826,-0.177883,-0.0990961,0.509214,0.133149,-0.15819,-0.122601,0.0425977,0.00608031,0.0850105,-0.174659,-0.262507,-0.0766596,0.110804,-0.244756,0.218765,0.406671,0.388054,0.48531,0.445671,0.249135,-0.0166339,-0.251967,-0.216857,-0.289015,-0.23913,-0.426325,-0.00189489,0.154613,-0.252785,-0.821127,-0.803247,-0.0947833,0.0634417,0.284859,-0.225055,-0.222322,0.482045,-0.310849,-0.0809245,0.186442,0.157577,-0.066316,0.250361,-0.339016,1.01622,-0.518293,0.0529196,0.260458,-0.0471181,0.436095,-0.403216,-0.144737,0.556679,0.586313,0.350743,-0.132323,0.219695,-0.191023,-0.117037,0.125224,0.170369,-0.290431,0.522883,0.0551814,-0.5933,0.0591218,-0.226055,0.0420382,0.170205,0.455396,0.161746,0.0649009,0.441053,0.294514,-0.0331549,0.890089,-0.41928,-0.782556,0.0793725,-0.490864,-0.282099,0.649955,0.020102,0.34908,-0.0161222,-0.236142,-0.0849154,-0.0882256,-0.381569,-0.194307,-0.278187,-0.397379,0.32779,-0.283904,-0.168837,0.22651,-0.121077,0.192402,0.415297,0.367191,-0.302369,0.495187,0.262635,-0.0167108,-0.34905,-0.31501,0.0514268,-0.113822,0.18548,-0.587365,0.159668,-0.131607,0.501402,0.416202,0.468362,-0.335154,-0.551773,-0.242908,-0.215631,-0.0537483,-0.146953,0.207527,0.363087,-0.13778,0.506708,-0.19343,-0.558247,-0.127889,-0.190688,-0.291328,0.579897,-0.13971,-0.0871227,-0.0955941,-0.485369,-0.291934,-0.399417,0.0808368,0.135864,0.240794,0.368597,0.490708,-0.291011 +3418.79,0.809929,0.0848144,4,1.54827,0.824795,-1.45269,0.430303,0.281442,-0.0102823,-0.00302839,0.153582,-0.512831,0.0106871,-0.028918,-0.366805,-0.297787,0.10995,0.0580023,0.949296,-0.0931846,-0.242523,-0.297669,-0.385688,-0.539698,-0.995568,-0.660823,0.318413,-0.294208,-0.718717,0.00998405,0.502381,-0.849276,-0.394522,0.520438,-0.930518,-0.615458,0.0262646,-0.200047,0.20224,0.00277931,0.531296,0.273807,-0.737409,0.867215,0.595097,0.566825,-0.296081,0.201284,0.454692,-0.651848,0.248472,0.726385,0.358532,0.572213,-0.33486,0.62859,0.194868,0.666279,-0.579757,0.235609,-0.776125,0.558562,-0.0867413,0.135038,0.923674,-0.336862,-0.301771,0.508402,0.0822874,0.0979429,0.497246,-0.411699,-0.823421,0.0727746,0.525738,0.9489,-0.588372,0.289322,0.814916,0.130652,-0.272281,-0.10288,0.51499,0.638787,-0.4547,0.0753674,0.17417,0.0559493,-0.231029,0.115686,0.222601,0.164288,-0.184486,-0.163911,0.450609,-0.107309,-0.228687,-0.0661631,-0.0554745,-0.0554619,0.499495,0.404161,0.0177592,0.273237,-0.796942,-0.178702,-0.310867,0.250265,-0.13836,0.558873,0.10896,-0.105118,0.22861,0.292761,-0.400955,-0.341369,0.487135,0.0610413,-0.187325,-0.418709,0.0564724,-0.292767,0.0282882,-0.820001,-0.119373,0.0244967,-0.0567899,0.288161,0.12145,0.0931385,-0.0926017,0.329988,-0.180457,0.712547,0.308798,-0.34548,0.366979,0.409554,0.478614,0.160367,0.219201,0.603322,-0.34943,-0.570788,-0.36309,0.109098,-0.131026,0.132024,-0.16687,0.0787744,0.00170242,0.00196904,-0.384131,-0.103638,0.446498,-0.0350373,-0.501277,-0.29173,0.347418,0.196677,-0.297022,0.305676,-0.059169,0.830721,0.406197,0.653984,-0.105882,0.189227,0.579542,0.0206779,-0.191,-0.0448707,-0.0338903,0.0501977,-0.0659742,-0.0430042,-0.121826,0.0148401,-0.100891,-0.0163982,0.275232,0.47456,0.4119,0.481568,0.415804,0.248252,-0.0141265,-0.457384,-0.104268,-0.245069,-0.211778,-0.355895,0.161795,0.271513,-0.351592,-0.495811,-0.735106,-0.0560563,-0.174212,0.305969,-0.0954532,-0.047568,0.435747,-0.253848,0.11149,0.300126,0.247039,-0.104885,0.384034,-0.062034,1.00748,-0.470217,-0.0707367,0.225644,-0.258896,0.566774,-0.533376,-0.182862,0.449233,0.798709,0.309848,-0.105561,0.118097,-0.161268,-0.171511,0.172608,-0.0362143,-0.205209,0.507697,0.028591,-0.501216,0.337131,-0.0864196,0.0564309,0.22966,0.430335,-0.0554918,0.0920257,0.472165,0.300176,-0.307158,0.978109,-0.35962,-0.841579,0.0126758,-0.602747,-0.371058,0.505852,0.0661513,0.267697,-0.190199,-0.0213668,-0.0711403,-0.0023135,-0.412284,0.0598806,-0.418922,-0.152331,0.419708,-0.246601,-0.0877164,0.25525,-0.094452,0.295081,0.332719,0.348229,-0.183874,0.575415,0.352757,-0.12368,-0.340159,-0.384141,0.0447771,-0.325457,0.067661,-0.450115,0.171884,0.00612808,0.442184,0.453259,0.365296,-0.292843,-0.487766,-0.17943,-0.378307,-0.181017,0.0889722,0.257701,0.265455,-0.21034,0.70037,-0.0806088,-0.574853,-0.0782484,0.198243,-0.445804,0.954921,-0.104913,-0.057324,-0.433011,-0.422422,-0.0402397,-0.273268,0.012661,0.11397,0.277267,0.337595,0.526562,-0.486494 +3420.94,0.790621,0.0848144,4,1.60246,0.903157,-1.00358,0.222683,0.0249099,0.0442874,0.176024,0.125475,0.23233,0.226418,-0.41245,-0.0434527,-0.326154,-0.0705656,-0.0138286,0.593112,0.0134741,-0.513503,0.268264,-0.33454,-0.582771,-1.14299,-1.10215,0.328296,-0.240173,-0.587952,-0.250549,0.268114,-0.395522,0.310186,0.742326,-0.235561,-0.385942,-0.0608237,-0.222736,0.104448,-0.447528,0.788092,0.168037,-0.673043,1.02011,0.638133,0.470567,-0.422779,0.543397,0.299755,-0.96632,0.048374,0.241179,0.318659,0.34474,-0.289021,0.341929,0.376958,0.895503,-0.271926,-0.108267,-0.790279,0.392571,0.188315,0.313027,1.14085,-0.606091,-0.646267,-0.0322312,0.131584,0.217145,0.0521551,0.00598337,-0.513001,0.0254111,0.306195,1.00748,-0.649443,0.152203,0.531399,0.386104,0.0552287,-0.284419,0.402524,0.62315,-0.528259,-0.0963615,-0.0706278,-0.0243312,-0.213996,0.048002,-0.000502894,-0.114911,-0.283817,0.0148005,0.467344,-0.210994,0.0402815,0.276868,-0.502147,0.128738,0.0124901,0.425937,0.522338,-0.0381907,-0.643977,-0.235668,-0.499357,-0.538293,-0.396691,0.462561,0.0513489,0.434339,0.167059,-0.0300378,-0.605838,-0.00972555,0.38212,-0.0396688,-0.509835,-0.467805,0.13711,-0.244424,-0.0898204,-0.647543,0.151192,-0.162229,0.121137,-0.0718547,0.364865,0.0732529,-0.124117,-0.21642,0.173389,0.205132,0.11861,-0.0316995,0.41999,0.162689,0.0937228,0.0738148,-0.311691,0.269429,-0.551338,-0.654585,-0.216796,-0.310742,-0.220463,0.136137,-0.107576,-0.0574187,0.251436,0.0215362,0.0140375,-0.109507,0.237323,-0.0251957,-0.169334,-0.606822,0.351204,0.413387,-0.0297343,-0.0902407,-0.147942,0.396154,0.279714,0.198214,-0.343295,0.346603,0.327875,0.0620088,-0.321723,-0.196691,-0.382,0.163314,-0.485721,-0.339476,0.0131107,0.304931,0.058728,-0.317892,0.134513,0.155506,0.324092,0.445809,0.127378,0.362175,-0.006833,-0.613326,-0.281693,-0.00122792,-0.526867,0.338148,0.233312,0.266913,-0.247073,0.276613,-0.860084,-0.16398,0.122536,0.343613,0.238002,-0.130989,0.53611,-0.201218,0.0421854,0.36091,0.511915,0.216587,0.1714,0.176,0.867136,-0.430955,-0.108682,0.0574956,0.172574,0.336469,-0.279185,-0.321493,0.41992,0.211302,0.387697,-0.0177435,0.139649,-0.159465,-0.0954474,0.457582,-0.402758,-0.0655098,0.395204,-0.100433,-0.175975,0.436022,0.048089,0.366434,0.0296777,0.483483,-0.364522,0.0996006,0.235002,0.144098,-0.242943,0.729823,0.185833,-0.749198,-0.0485871,0.546748,-0.214448,0.516761,-0.0411189,0.591066,-0.0398086,-0.51593,-0.226108,-0.0203288,-0.317489,0.368276,-0.590054,-0.1222,0.301694,0.0228699,0.0861382,0.382103,-0.175198,-0.0436345,0.546816,0.0340103,-0.246265,0.443062,0.217153,-0.0689466,-0.303399,-0.33561,-0.151696,-0.417251,-0.143713,-0.478734,-0.0634882,0.23135,0.528895,0.143826,0.353663,-0.129213,-0.358539,-0.34271,-0.0813756,-0.71597,-0.162047,0.318471,0.308598,-0.29134,0.829658,-0.136008,-0.53847,-0.0496017,-0.204074,-0.176011,0.735402,-0.0194164,-0.448633,-0.134326,-0.209113,-0.163408,-1.13997,0.0102115,0.141325,0.223673,0.375932,0.472941,0.228072 +3455.73,0.751461,0.0848144,4,1.69231,0.740616,-1.15006,0.40551,0.14664,-0.113249,-0.143789,-0.371263,-0.0754365,-0.120452,-0.263701,-0.824799,-0.20495,-0.0284397,-0.326276,0.34242,0.204278,-0.045982,-0.637351,0.10584,-0.486181,-0.550105,-0.74412,0.0794338,-0.207922,-0.384967,-0.194039,0.145238,-0.736934,-0.474371,0.938942,-0.575904,-0.193472,0.0752733,-0.50509,-0.34851,-0.242259,0.345662,-0.057583,-0.253194,0.962479,0.146922,0.089787,-0.831651,-0.210094,-0.396475,-0.321017,0.211555,0.233525,-0.588266,0.399134,0.421965,-0.297261,-0.362341,0.508921,-0.206468,0.0161461,-0.490057,0.196689,-0.341674,0.140388,0.48262,-0.867112,-0.77207,0.218167,-0.157811,0.0454725,-0.0862451,-0.194796,0.0606921,0.23542,0.19408,0.636809,0.117766,0.936475,0.356665,0.434488,-0.154874,-0.306928,0.200497,0.139534,0.0552988,0.369595,0.0263653,-0.122247,0.125435,-0.2338,0.189223,-0.0915836,-0.396512,0.234342,-0.283793,0.375695,0.28595,0.195454,0.430456,-0.211188,-0.435864,-0.312422,0.211014,0.169489,0.449257,0.262956,-0.358095,0.450393,-0.18005,0.0291242,0.0114731,0.271529,0.408357,-0.0287011,0.212285,-0.198703,0.436552,0.353939,0.270333,-0.0824278,0.206002,-0.0419124,0.0210435,-0.0593332,0.212313,-0.308373,-0.155656,-0.0145184,0.0390942,0.28936,-0.0536789,0.625978,-0.555706,0.106875,0.312822,0.293948,0.798892,-0.412204,-0.201077,-0.236466,-0.0644151,0.576951,-0.716085,-0.0399954,0.0376395,0.220738,-0.0647457,0.279908,-0.0535526,0.159907,0.36786,-0.555324,-0.148203,0.13865,0.26493,0.399851,0.0875103,0.834113,0.604191,0.290948,0.135461,0.142964,0.334472,0.155651,-0.523419,0.521819,0.261055,-0.0571632,0.265621,0.121444,0.0764941,-0.194978,-0.328806,0.33474,0.0942467,0.274941,0.321534,-0.413658,0.00495469,-0.0663377,-0.0912808,0.00376102,1.05609,-0.0843252,-0.515966,0.0729487,-0.146613,0.372024,-0.267886,-0.163452,-0.267106,0.107846,-0.509404,0.404114,0.176979,-0.225026,-0.152633,0.329666,0.0865515,-0.139116,-0.117533,-0.772121,0.256315,0.139668,-0.302092,0.179342,-0.161636,-0.766569,0.305755,-1.02925,0.742862,0.261447,0.481958,0.122007,-0.485266,-0.17033,0.200431,-0.380968,0.409918,-0.744947,0.0845156,0.180297,-0.162373,-0.217064,-0.700602,0.117911,0.0932118,0.0244021,0.455324,-0.121246,-0.549002,0.106894,0.441592,-0.671735,0.0624019,-0.285666,-0.0815021,-0.103703,0.630248,-0.22911,0.0561289,0.512371,-0.394338,0.425033,0.0360608,-0.711633,0.218816,0.106143,0.326378,0.130931,0.372977,-0.0229016,0.253962,-0.0930504,-0.27114,0.278795,-0.138446,-0.469813,0.422491,-0.129658,-0.243313,-0.287855,-0.0712135,-0.315504,0.261907,-0.126257,0.402256,0.0721787,-0.0874126,-0.267042,-0.255535,0.381484,0.356082,-0.0390852,0.0524264,-0.154677,-0.0698804,0.249048,0.120909,-0.0658024,0.382154,0.300594,0.369465,-0.348005,-0.320134,0.220861,0.11783,0.0220891,0.234709,-0.454983,-0.235731,0.359414,-0.0849848,-0.0181912,0.1672,0.241539,-0.139258,-0.140964,-0.423151,0.214816,0.406853,-0.276408,-0.0668349,0.163865,0.123014,0.186966,0.350733,0.432396,0.144126 +3432.42,0.971319,0.0848144,5,1.65251,0.833136,-1.12294,0.453757,0.729175,-0.138991,-0.123726,-0.00994006,0.370439,-0.0323219,0.28656,0.205494,-0.281431,0.11387,-0.684552,0.256856,0.149782,-0.158416,0.448128,-0.151526,-0.375459,-0.693644,-0.667174,-0.00258852,-0.19971,0.0939965,0.0642207,0.153464,-0.559036,0.448911,0.658426,-0.49277,-0.00397786,-0.155137,-0.200413,-0.0352534,-0.737361,0.133035,0.482382,-1.01633,0.837569,0.309434,0.089276,-0.303633,0.0810096,-0.36638,-0.754315,-0.125326,-0.0319765,0.328861,-0.123976,0.53432,-0.170156,-0.38515,0.182059,-0.67264,-0.414542,-0.650432,0.19103,-0.148252,0.0781674,0.540376,-0.327093,-0.654216,-0.641953,0.351589,0.225947,0.2155,0.689886,-0.436605,-0.190339,0.423056,0.735723,-0.227315,0.86735,0.248405,-0.117712,-0.23573,-0.546801,0.278751,0.574789,-0.206691,0.0951723,-0.0879349,0.0698373,0.0292247,0.144249,-0.239473,0.290699,-0.277018,-0.210964,0.0626968,-0.0522156,-0.227738,0.0599146,-0.780854,0.0474557,0.0811413,0.379596,0.150003,-0.00349633,-0.523132,-0.702542,-0.0362787,-0.450255,0.296966,0.444567,-0.0245264,0.00272606,0.206075,0.179689,-0.0711167,0.0246983,0.668787,0.0441143,0.255091,-0.482672,-0.0965522,-0.273512,-0.306789,-0.434418,-0.130577,-0.411813,-0.0165511,0.11679,0.410518,0.110657,-0.485133,-0.336929,-0.44599,0.0324004,-0.245731,0.285134,0.19766,0.0700784,0.074491,-0.105991,-0.264291,0.363216,-0.536025,-0.677375,0.025754,-0.185375,-0.906763,-0.878486,0.318132,-0.323282,0.374005,0.115981,-0.181273,-0.596061,0.33102,-0.111026,-0.0528664,0.237327,0.191132,0.121986,-0.303161,0.0196323,0.0267472,0.703338,0.415762,0.572701,0.264811,-0.186611,-0.0750661,0.27634,0.141842,-0.192357,0.350954,0.405735,0.220624,0.00228915,0.336841,0.0187608,-0.353626,-0.315618,-0.619238,0.303241,0.78476,0.527549,-0.20054,0.709504,-0.242218,-0.157563,-0.297647,-0.128833,-0.0715257,0.284204,-0.400109,0.0232048,0.316044,0.421975,-0.82067,0.0309697,-0.234161,-0.179293,0.0808539,-0.571368,0.0826337,-0.0284614,-0.0144914,-0.0794732,-0.129859,0.741891,-0.143646,-0.273257,0.927121,-0.215555,-0.158577,0.065865,-0.232082,0.200055,0.0338984,0.338795,0.383531,-0.335134,0.173108,0.115391,-0.0559455,-0.320749,-0.359526,0.235188,0.556086,-0.539544,0.56153,-0.491979,-0.350121,-0.127203,0.0134455,0.306073,0.420128,0.0164443,-0.624764,-0.617862,0.370231,0.327991,0.0627282,0.644724,0.0975226,-0.542333,0.341604,0.107582,0.0065119,-0.230734,0.275105,0.479178,-0.180334,0.166713,-0.377969,0.348707,-0.405943,0.286905,-0.179422,0.223904,0.14997,-0.027409,-0.151264,0.2687,0.436495,-0.570157,0.171273,0.51913,-0.0946727,0.57276,0.0796818,0.169972,0.143251,-0.394993,0.690721,-0.0572215,-0.67989,-0.122076,0.509013,0.0562151,0.000851146,0.206998,0.270634,-0.262219,-0.251267,-0.0427423,-0.104553,-0.50373,-0.294875,0.240729,0.05953,-0.248206,-0.216005,0.360643,0.188699,0.489198,0.371159,-0.617544,0.164943,0.294972,-0.465754,0.115452,0.137831,0.04423,-0.358342,-0.169669,0.144528,0.165357,0.380168,0.406641,-2.04671 +3429.63,0.886137,0.0848144,4,1.67366,0.848788,-1.04394,0.444268,0.911305,-0.126577,-0.101949,-0.0665259,0.397572,0.0318373,0.298973,0.225299,-0.2144,0.270395,-0.62303,0.27673,0.147109,-0.141559,0.308883,-0.221403,-0.379099,-0.571938,-0.599474,-0.00193837,-0.257677,0.107517,-0.0185977,0.355815,-0.512876,0.307754,0.640003,-0.379553,-0.03459,-0.0689085,-0.239795,0.00291858,-0.641108,0.241576,0.523328,-1.09986,0.824513,0.248687,0.034949,-0.383484,-0.0183193,-0.51305,-0.666813,0.139469,-0.107224,0.231535,-0.0467037,0.461631,-0.152467,-0.355745,0.0958418,-0.647797,-0.408901,-0.628316,0.216163,-0.148652,0.116862,0.439839,-0.320402,-0.715145,-0.484893,0.341191,0.102857,0.32878,0.516235,-0.453302,-0.290446,0.433395,0.772807,-0.171546,0.879331,0.238309,-0.13678,-0.277517,-0.696984,0.135439,0.490404,-0.14492,0.06864,-0.116312,0.159314,0.0756676,0.167572,-0.206155,0.379427,-0.308615,-0.49581,0.187702,0.0736493,-0.257012,-0.048723,-0.706812,0.127072,0.16844,0.434037,0.1636,-0.00553483,-0.507044,-0.602918,0.0391045,-0.524229,0.203575,0.414312,-0.156365,-0.0454139,0.167652,0.162222,-0.115537,0.0359479,0.659103,0.103846,0.30498,-0.530797,-0.167402,-0.384593,-0.453306,-0.444545,-0.163534,-0.339455,-0.0791592,0.0515035,0.470045,0.110663,-0.55264,-0.399555,-0.556788,0.0896028,-0.162206,0.290925,0.219988,0.0243549,-0.0331925,-0.0541959,-0.28852,0.355203,-0.658462,-0.576789,0.154829,-0.289013,-0.873197,-0.841382,0.248563,-0.350191,0.146693,0.192198,-0.183959,-0.606384,0.383867,-0.0681838,-0.0565706,0.218228,0.389763,0.18321,-0.121349,-0.0236925,-0.0309184,0.794936,0.337573,0.531276,0.15489,-0.229913,0.0136506,0.289107,0.015781,-0.181183,0.388941,0.320883,0.29375,0.1152,0.409494,-0.0239695,-0.266695,-0.239803,-0.678098,0.200852,0.7078,0.609526,-0.127295,0.651629,-0.188171,-0.206004,-0.236174,-0.166129,-0.097304,0.343087,-0.257764,0.0649975,0.307786,0.381096,-0.909225,0.143755,-0.358764,-0.224871,-0.0339954,-0.566758,0.0613414,-0.0825677,-0.0435764,-0.10066,-0.102661,0.80254,-0.213305,-0.272606,0.933625,-0.137709,-0.196658,0.166637,-0.28486,0.277529,-0.130533,0.203749,0.517513,-0.415476,0.175191,0.107526,-0.0658711,-0.291979,-0.378379,0.31466,0.544689,-0.578257,0.567779,-0.434208,-0.311506,0.00250654,0.0164864,0.249319,0.3523,-0.0167632,-0.604439,-0.486689,0.385737,0.545831,0.101393,0.590548,0.0108088,-0.653893,0.360271,0.301512,0.0210621,-0.181719,0.304019,0.531735,-0.2492,0.158214,-0.309783,0.353382,-0.362123,0.171414,-0.126815,0.240711,0.105398,0.000364127,-0.255452,0.260989,0.42056,-0.636075,0.210996,0.393682,-0.0249483,0.591325,-0.00202426,0.1384,0.189689,-0.467103,0.732264,-0.0151843,-0.737404,-0.101732,0.478717,0.0219532,0.0488067,0.197732,0.35206,-0.289729,-0.246803,-0.00473205,-0.0394197,-0.441305,-0.307036,0.290987,-0.0243103,-0.231355,-0.109468,0.421422,0.200444,0.552867,0.388933,-0.587513,0.193902,0.366481,-0.492019,0.149577,0.0587354,0.010506,-0.307445,-0.189321,0.142654,0.179897,0.377696,0.424143,-2.69348 +3435.85,0.58494,0.0848144,4,1.76761,0.912469,-0.628967,0.252707,1.2144,-0.210013,-0.146062,-0.0808262,0.162801,-0.02575,0.115213,-0.389675,-0.476859,-0.0836048,-0.582752,0.706463,0.133932,-0.0771201,-0.106255,-0.119904,-0.317324,-0.362675,-0.70491,-0.115386,0.239837,0.466497,-0.0244573,0.487587,-0.325063,-0.0425141,0.453065,-0.183007,-0.125732,0.141934,-0.356933,-0.316127,-0.530939,-0.0170199,0.090018,-0.458318,0.648208,0.135348,-0.115134,-0.457615,-0.420947,-0.145419,-1.01286,-0.0998432,0.0935404,0.211883,-0.393732,0.299615,-0.177785,-0.151515,0.120003,-0.51475,-0.148482,-0.668579,0.257411,-0.231181,-0.413762,0.604755,-0.378572,-0.879664,-0.0736602,0.252265,0.0841617,0.56158,-0.0478276,-0.572747,-0.221592,0.3822,0.390226,-0.379622,0.495333,0.133887,0.561033,-0.188164,-0.239128,0.057083,0.205853,-0.283292,0.329848,-0.122005,-0.264534,-0.45174,0.00661023,-0.582859,-0.0376542,-0.186331,-0.33923,-0.08213,0.155521,-0.288119,-0.442565,-0.903207,0.103414,-0.0381465,-0.192046,0.340285,-0.083935,-0.23114,-0.374135,-0.245904,-0.0277874,-0.161454,-0.280322,-0.0581723,0.151595,0.546862,0.0589608,-0.134498,-0.141484,0.831354,0.4491,0.0675669,-0.404036,0.108796,-0.883647,-0.419058,-0.27385,-0.116497,-0.252473,-0.202458,0.0968295,-0.0381908,0.758159,-0.379322,-0.23647,-0.697631,0.178269,0.137911,-0.152152,-0.279739,-0.317709,0.416454,-0.0535301,0.0108806,0.424987,-0.962429,-0.250493,0.307062,-0.271446,-0.530859,-0.248195,-0.00664697,-0.407452,0.378549,0.0565248,0.00701897,-0.087478,0.607528,-0.0258437,-0.343558,0.280028,0.536374,0.25241,-0.530795,0.0943107,-0.20147,0.692167,0.0894481,0.824747,-0.146243,-0.372329,-0.39474,-0.00345008,-0.390689,0.20101,-0.0190747,0.360771,0.348331,0.459224,0.115355,0.119491,-0.136004,0.0788306,-0.311369,0.296426,0.953129,-0.0930345,0.067371,0.240839,-0.137249,0.549231,-0.399187,-0.250836,-0.0228102,0.0735281,-0.456395,-0.49402,-0.13371,0.130976,-0.665476,-0.00903599,-0.334048,0.131251,0.0414786,-0.693095,0.17778,0.0855206,-0.279886,-0.303143,-0.201974,0.504752,-0.0871282,-0.38627,0.952943,-0.246151,-0.290791,-0.147805,0.570064,-0.238352,0.110387,0.0978998,0.583807,-0.888257,-0.175268,0.141682,0.114749,-0.508977,-0.614843,-0.000297011,0.488028,-0.470344,0.0777384,-0.578686,0.0328101,-0.195506,-0.42661,-0.243761,0.580828,0.131883,-0.141101,-0.62039,0.373153,-0.388359,-0.0589908,0.715851,-0.724958,-0.495604,0.0674027,0.0106312,0.314133,0.0873556,0.636814,0.170529,-0.420304,-0.0948414,-0.0521682,0.28981,-0.306802,-0.0422473,-0.156017,-0.119683,0.211367,-0.186337,-0.298959,0.489539,0.034467,0.112587,-0.115302,0.244033,-0.032158,0.45724,-0.208587,0.265278,0.540941,-0.635597,0.265665,0.173886,-0.752771,0.0934858,0.196821,0.0653705,-0.208543,-0.0661761,0.463388,0.30023,-0.14775,0.0325924,-0.129268,-0.1335,-0.00433184,-0.00342923,-0.142865,-0.297282,-0.173474,0.479301,-0.145575,0.532918,0.0259625,0.322443,-0.209985,-0.0124199,-0.517311,0.0322974,-0.11472,-0.273447,-0.262159,-0.306891,0.11472,0.166317,0.338704,0.40782,-3.73382 +3416.57,0.916259,0.0848144,5,1.74187,0.981903,-0.941162,0.394829,0.681102,-0.087926,-0.122581,0.0327835,0.00336203,-0.0540249,0.083597,-0.184015,-0.046746,0.252568,-0.0667623,0.763191,0.0715847,-0.272357,-0.0835522,-0.426506,-0.802987,-0.765039,-0.57722,-0.259181,-0.548246,0.150438,0.250678,-0.34026,-0.568997,0.0845652,0.196153,-1.19184,0.0422447,-0.0182421,-0.345406,-0.131037,-0.394537,0.111574,0.536189,-0.40265,0.860822,-0.0209273,-0.126511,-0.519908,-0.639817,0.321433,-0.469517,0.328395,-0.0164007,-0.176357,-0.249829,0.302525,-0.140145,-0.0910212,-0.388153,-0.555132,-0.400884,-0.764927,0.0751009,-0.159347,-0.011396,0.353268,-0.472937,-1.08121,-0.0232348,-0.0980456,-0.299022,0.125629,-0.214633,-0.729655,-0.225136,0.391568,0.422348,-0.194861,0.69612,0.171046,0.446949,-0.571181,-0.29768,0.150714,0.249873,-0.199769,0.467153,-0.446184,-0.126496,-0.331839,-0.15044,-0.572349,-0.39678,0.113451,0.00653757,0.120642,0.172741,-0.256301,-0.102247,-0.450838,-0.316402,-0.532204,0.223269,0.237257,-0.297817,-0.429236,-0.564803,-0.638054,-0.276648,-0.232531,-0.20703,-0.403775,0.285462,0.583771,-0.0353611,-0.0242516,0.397235,0.905903,0.487321,0.106407,-0.284528,0.0551153,-0.133765,-0.360182,-0.222582,-0.495079,0.193182,-0.344674,-0.0875137,0.680978,0.295049,-0.715053,0.140939,-0.173649,0.452235,-0.0469405,-0.0201362,0.00151601,-0.497724,-0.121926,0.133287,-0.516135,0.641265,-0.595618,-0.365488,0.263452,-0.117652,-0.642157,0.113169,0.362692,-0.323425,0.426738,-0.00296634,0.632501,-0.14223,-0.00987258,-0.203599,0.0391948,0.248743,0.790911,0.532084,0.134118,0.0188371,0.0115504,0.134079,0.120681,1.27371,-0.309893,-0.269455,-0.10634,-0.0868819,-0.277834,0.225173,-0.592956,0.37497,0.382223,0.341045,0.334323,-0.109913,-0.400669,-0.162934,-0.0760231,0.0120199,1.01881,0.32965,0.0342589,0.458396,0.340863,-0.0785356,-0.0404059,-0.379768,-0.568391,-0.21734,-0.0399291,0.13611,0.32205,0.00151124,-0.5267,0.0823142,0.0406757,0.135102,0.109212,-1.31045,0.0117902,-0.243408,-0.510353,-0.449484,-0.660531,0.545793,-0.731331,-0.275567,1.23011,0.234928,0.216282,-0.399312,-0.0291476,-0.38886,0.273539,0.136429,0.427842,-1.04482,0.265734,0.577648,0.279892,-0.208044,-0.59297,0.487739,0.0373071,-0.355543,0.760337,-0.0133968,0.252739,0.0267201,-0.283191,-0.472456,0.511758,0.304103,-0.128533,-0.12301,0.609268,-0.518334,0.522919,0.809877,-0.481763,-0.592353,0.347626,0.377255,-0.0201887,-0.129329,0.119444,0.179797,0.252992,-0.522388,-0.0688029,-0.0945972,-0.24461,0.192098,-0.280258,-0.685915,0.341825,-0.226247,0.152316,0.430743,0.246941,0.0101143,0.060248,-0.0555112,0.217987,0.948746,-0.00472653,0.437523,0.0761579,-0.571719,0.246994,-0.727374,-0.109072,-0.22548,0.436286,-0.0972354,0.509338,-0.190462,0.204482,0.56479,-0.00195964,0.0830667,0.25533,-0.649733,-0.821708,0.352921,0.29746,-0.0446147,-0.225065,0.083902,0.498807,0.59432,-0.0134993,0.0354908,0.0363498,0.183409,-0.597803,-0.225602,-0.121678,0.0035794,-0.162372,-0.0769627,0.185367,0.154395,0.430543,0.392931,-2.11316 +3406.62,0.991856,0.0848144,5,1.70177,1.04671,-0.555576,0.0857924,0.515383,-0.16944,-0.0626398,-0.244983,-0.00457245,0.464836,-0.265648,0.101548,-0.465506,-0.177414,-0.239787,0.716011,-0.0630772,-0.0496002,-0.0038022,-0.255427,-0.53887,-0.671489,-0.74176,-0.288464,-0.324776,0.0278057,-0.183431,-0.101065,-0.730838,0.132975,0.228728,-0.794372,0.129618,-0.343503,-0.115198,-0.174621,-0.606846,0.249581,0.222219,-0.0278159,0.701238,0.267145,0.308323,-1.08922,0.0397112,-0.00693207,-0.596333,0.383111,0.165724,-0.152985,-0.266388,-0.0243549,0.150322,-0.366765,0.227493,-0.405552,-0.248641,-0.337248,0.318564,0.0665021,0.383827,0.621264,-0.459917,-0.92472,0.440031,-0.16263,0.379516,-0.190237,0.131418,-0.398752,-0.631219,0.0158647,0.682519,-0.564805,0.746763,0.145654,0.376731,-1.07597,-0.308789,0.058874,0.102671,-0.336971,0.250174,-0.0568915,0.0781003,-0.00440988,0.215787,0.273185,-0.196191,0.142535,-0.0969457,0.621921,0.414003,-0.11021,0.16015,-0.297374,0.275393,-0.733198,-0.0761873,0.364513,-0.40411,-0.400841,-0.842562,-0.124256,0.0639985,-0.936006,-1.14987,-0.666926,0.153337,0.739748,0.155554,-0.0882832,0.254688,0.82323,-0.0771746,0.456229,-0.252598,0.300149,-1.06748,-0.116947,-0.0559391,-0.22026,0.185838,-0.0719306,0.0797461,0.599686,0.121189,-0.283342,0.257601,-0.670955,0.579365,-0.202228,-0.130801,0.22819,-0.435799,-0.56608,0.352813,-0.238637,0.54973,-0.559339,-0.36917,0.20134,-0.260949,-0.334176,0.193535,0.396752,0.17536,-0.304589,0.135903,0.197399,-0.358216,0.329737,0.213853,-0.121753,0.490292,1.02276,0.176045,-0.21465,0.111088,-0.140879,-0.535297,0.267326,0.813513,-0.219233,0.34332,0.0595582,0.251509,-0.110498,-0.00209544,-0.236464,-0.185645,-0.112668,0.445736,-0.0325514,-0.0907104,-0.571278,0.18148,-0.187648,-0.0413326,0.941127,0.512073,-0.168182,0.388392,-0.315863,-0.32827,0.112468,-0.368609,-0.332344,0.304907,-0.0177533,0.00631618,-0.374962,0.120237,-0.305093,-0.147111,0.0865614,0.116404,-0.003385,-0.897675,-0.328293,0.360843,-0.280184,-0.558854,-0.175445,0.507469,0.029416,-0.619138,1.13775,-0.255396,0.0808031,0.652135,-0.26387,-0.188467,0.657092,0.270149,0.433455,-0.718822,0.412032,0.0332885,-0.35466,-0.357859,-0.519569,-0.394318,0.33726,-0.534841,0.532561,-0.393812,-0.351265,0.51508,-0.202764,-0.610839,0.423075,0.0905401,-0.27512,-0.121747,0.406376,-0.0729215,0.153595,0.791184,-0.309369,-0.106071,0.0431761,0.201391,-0.151105,0.997763,0.364974,0.352664,-0.00186588,-0.715183,-0.277923,0.113173,-0.157202,0.351138,0.279319,0.160434,0.586469,0.192103,-0.121533,0.502821,0.397265,0.0509745,-0.157641,-0.308687,-0.0472393,0.389413,0.218347,0.157731,0.544376,-0.036707,0.377997,0.136071,0.285083,-0.573636,0.1056,-0.157579,0.232257,-0.128311,0.126045,0.181782,0.16545,-0.158534,-0.666627,0.122348,-0.0513835,0.460864,0.45041,0.447108,0.13631,0.189029,0.131149,0.419364,-0.0545958,0.60313,0.49126,0.160532,-0.783661,-0.457954,0.0362942,-0.723466,-0.500119,-0.122982,0.134622,0.18197,0.366908,0.426579,-1.60682 +3410,0.994001,0.0848144,4,1.68387,0.885072,-0.650181,0.23317,-0.120745,-0.179832,-0.0940668,0.0682245,0.30785,0.238003,-0.0787194,0.048568,0.245678,0.302826,-0.213555,0.514363,0.0719128,-0.368808,0.0516954,-0.0600279,-0.469899,-0.738605,-1.01632,0.472474,-0.102853,-0.263303,0.0618231,0.402064,-0.349072,0.0452015,0.355264,-0.0551391,-0.416768,-0.0190656,-0.427911,0.061194,-0.15642,0.0147645,0.183011,-0.120483,0.501347,0.53523,-0.0184266,-0.357883,-0.585179,0.0707302,-0.579159,0.156307,0.444129,0.178284,-0.155693,0.323101,0.101193,0.0191587,0.214159,-0.0758981,-0.38731,-0.898466,0.258738,-0.124403,0.247232,0.328934,-0.665004,-0.550549,-0.471359,-0.107248,0.01274,0.484408,-0.558282,-0.41148,0.0409349,0.670937,0.679465,-0.0226949,0.575817,0.489447,0.511106,-0.415381,-0.59187,0.35685,0.497123,0.330796,0.330701,0.0467492,-0.516384,-0.121148,-0.070045,-0.288838,0.395733,-0.170582,0.572652,-0.392557,0.0203026,-0.229974,0.064209,-0.0276637,-0.304227,-0.579674,-0.665255,0.298932,0.0835733,-0.927086,0.124487,0.23765,-0.499065,-0.275504,0.350851,0.0970942,-0.0484909,0.944913,-0.120431,-0.544756,-0.693379,0.656255,0.390951,-0.112661,-1.02127,0.408462,0.012652,-0.0547521,-0.53002,0.118451,0.594648,-0.400272,0.252668,0.3131,-0.271876,-0.159523,0.348494,-1.22482,-0.30224,0.21693,-0.323975,0.706168,-0.170309,0.0442959,-0.343871,-0.0542456,0.459432,-0.0440843,-0.603706,-0.139164,0.169954,-0.555995,0.654816,0.266258,0.402082,0.236725,0.196917,-0.448719,-0.61647,0.0786861,0.0289641,-0.259484,-0.24188,0.522704,0.0173169,0.283162,0.446959,-0.284196,0.323526,0.0440148,0.692787,-0.173311,0.174938,0.116047,-0.251956,-0.00126654,0.146049,-0.0974947,-0.0889185,0.388719,0.177925,0.203356,0.268142,0.367115,-0.505367,-0.332617,-0.0662265,0.861126,-0.365753,0.263823,0.621067,-0.105558,0.0580848,-0.175748,-0.364583,-0.228685,-0.455988,-0.21107,0.466925,0.580983,0.102662,-0.816797,0.160498,-0.224517,0.101534,-0.124839,-0.948117,0.322456,-0.195973,-0.164495,0.0447828,-0.16971,-0.32337,0.127661,-0.323655,1.34581,0.397296,0.351828,-0.337121,-0.159137,-0.346649,-0.15304,0.324109,-0.0248742,-0.174912,0.652277,0.25294,-0.444811,0.286051,-0.251918,-0.17254,0.401465,-0.59767,0.0555944,-0.786838,-0.204243,-0.589585,-0.164945,-0.178676,0.367106,-0.660578,-0.362609,-0.166145,0.541629,-0.0226433,-0.471038,0.927868,-0.117881,-0.0131867,0.237732,0.281789,0.33781,0.56628,0.0768012,0.293435,-0.33084,0.501565,-0.0896091,0.549399,-0.532053,0.121414,-0.285806,-0.507253,0.329561,-0.13548,-0.285118,-0.0630172,0.142163,0.371013,0.581833,-0.156786,0.364213,0.494011,-0.517598,0.485795,-0.46359,0.257912,0.241584,-0.468715,-0.60897,-0.114368,-0.081557,0.451147,-0.0960684,0.62058,-0.429549,-0.413704,0.119255,0.11686,-0.946535,-0.741336,0.0983743,0.043064,0.0286961,0.00831384,0.036087,0.0671472,-0.403832,0.406863,-0.329798,0.0901459,0.0937904,-0.484175,-0.27397,0.170557,0.617256,-0.369482,-0.585767,0.0142626,0.160582,0.119173,0.400727,0.345214,0.685397 +3414.71,0.995239,0.0848144,5,1.60662,0.878884,-0.666165,0.24005,0.281348,0.00285936,0.0121691,-0.260426,-0.197921,0.337136,0.070633,0.0826383,-0.934002,0.248815,-0.306562,0.79191,0.314197,0.0582638,0.108318,0.0803213,0.0613652,-0.529836,-0.688934,0.296236,-0.424969,-0.310631,0.0541908,0.418245,-0.322677,0.311329,0.703849,-0.322369,0.0169554,0.241207,0.137153,-0.296271,-0.572781,0.0408755,0.417109,-0.434753,0.771612,-0.0120175,-0.0954428,-0.953405,0.0107971,-0.446729,-0.132102,0.0807045,0.346787,-0.0185941,-0.0479238,0.0442421,0.0558132,-0.231733,0.301143,-0.224111,-0.23591,-0.0974757,0.265445,-0.0467982,0.3466,0.551735,-0.412223,-1.21017,0.126741,-0.153326,0.235872,-0.255091,-0.745723,-0.222764,-0.788071,0.0646651,0.747173,-0.581732,0.560187,0.336982,0.567654,-0.467805,-0.186372,0.223454,0.464898,-0.479902,0.0629987,0.447877,-0.0122093,0.408628,-1.3474,0.0887898,-0.255816,-0.187867,0.0202157,0.10951,0.107186,-0.238578,0.36907,-0.537353,-0.316856,-0.194727,-0.472324,0.178568,0.254598,0.0736171,-0.380698,-0.36499,0.844083,-0.387557,0.546539,-0.201728,0.377563,0.875527,-0.6901,-0.062014,0.115097,0.814097,0.135902,0.447493,-0.428242,0.39697,0.00188107,0.0916058,0.182919,0.286773,0.438578,-0.579534,-0.164781,0.00718244,0.425104,0.53395,-0.0220951,-0.900042,-0.396379,0.168689,0.0617349,0.235895,-0.197525,-8.0306e-05,-0.269804,0.0607766,0.303798,-0.496738,0.215954,-0.302895,0.297184,-0.205958,0.0765544,0.134321,-0.0940872,0.322334,0.00429811,-0.0161761,0.265774,0.621635,0.142941,0.543698,-0.227858,0.623708,-0.0942893,0.548715,0.174582,-0.0693731,0.145889,-0.117828,0.73238,-0.664526,-0.0650125,-0.27516,-0.015747,-0.195035,0.0812638,-0.675419,0.249325,-0.171651,0.267857,0.12313,0.025193,-0.137171,-0.493139,-0.463903,0.311834,0.929312,-0.529932,-0.219023,0.469191,-0.290801,0.306089,-1.09641,-0.334563,-0.390116,0.318073,-0.134347,0.118521,0.103042,-0.372807,-0.855719,-0.171598,0.061535,-0.129297,-0.261951,-0.678432,0.00825431,0.186858,-0.408606,0.24163,0.132982,-0.579303,-0.00818976,-0.693047,0.939909,-0.239893,0.716972,0.0447169,-0.227793,0.0315594,0.327294,0.277056,0.395018,-0.510118,0.334829,0.447439,-0.810389,-0.469116,0.0329496,0.215655,0.22011,-0.203163,0.631927,-0.830647,-0.680935,0.048822,0.129138,-0.269331,0.453064,0.213523,0.431415,-0.373149,0.786374,-0.321723,-0.0675948,0.79315,-0.388282,-0.680915,-0.32623,0.0994786,-0.167019,0.590022,0.129342,0.606642,0.351936,0.230194,-0.401116,0.0107136,-0.535579,0.480867,0.0146069,-0.0949843,0.383753,-0.831922,-0.050192,-0.265785,-0.0455535,0.267969,0.18663,-0.00157924,-0.187323,-0.0888812,-0.112683,0.124574,0.199507,-0.118677,0.125682,-0.286543,-0.0511122,-0.353923,0.16653,-0.0136007,-0.0950584,0.267368,-0.288066,-0.764464,0.267747,0.00428556,-0.531493,-0.0829417,-0.325497,0.195759,0.180131,-0.424391,-0.0192657,0.532339,-0.68319,0.233952,0.418455,0.0139509,0.332003,-0.107006,-0.487662,-0.0729736,-0.232734,-0.545442,-0.191085,0.0727616,0.151217,0.160233,0.388867,0.400291,-0.759573 +3410,0.956983,0.0848144,4,1.485,0.911457,-0.972567,0.368689,0.386821,-0.0726638,0.247275,0.360119,0.31899,-0.0809681,0.155644,-0.0825177,0.461321,0.369777,0.0798335,0.599359,0.0404774,-0.147827,0.0655922,0.0906215,-0.0679759,-0.604516,-0.0733431,0.457878,-0.0699915,0.143174,0.0727605,0.125206,0.288675,-0.143057,0.324449,-0.0487319,-0.196647,0.490643,-0.191998,0.00754075,-0.121556,0.482602,-0.0503601,0.0197553,0.732971,0.871189,0.512842,0.0249008,-0.0801982,-0.125738,-0.479021,0.00641217,0.239748,0.204366,0.351387,0.242,0.422658,-0.14003,0.419661,-0.130866,-0.219017,-0.795057,0.35888,-0.439623,-0.190995,0.441705,-0.129347,0.188383,0.0915407,-0.548217,-0.116519,0.193748,1.0039,-0.639594,-0.360328,0.44144,0.525173,0.0107263,0.571448,0.724533,0.174408,-0.14054,-0.443172,0.0626967,0.135517,-0.232496,-0.064183,-0.577655,0.417754,-0.359614,0.84457,-0.566992,0.553078,0.00324538,-0.0976543,0.242731,-0.020033,0.149641,0.0420854,-0.329905,0.222123,0.0671794,0.366424,0.79918,-0.0333939,-0.138969,-0.200153,-0.0599388,-0.0853571,-0.353065,0.195963,0.00595235,-0.0966103,0.108323,0.336367,-0.17894,-0.400425,0.318484,-0.0855152,0.03185,-0.187127,-0.0688372,0.196778,-0.0567415,-0.555487,-0.395034,-0.527205,0.447247,0.087278,0.344266,0.538966,-0.00534934,0.392838,-0.0947691,0.468668,0.00832656,0.0875613,0.768399,0.135866,-0.121251,-0.117167,-0.198858,0.450662,-0.514713,-0.848867,-0.122403,0.0713436,-0.533556,-0.0313834,-0.237226,-0.548308,0.326016,0.160622,-0.685699,-0.300937,-0.0212124,0.103574,0.103592,0.979155,0.374782,-0.231198,-0.5863,0.459014,0.304436,0.00818299,-0.113083,0.352853,0.361199,-0.243716,1.03995,0.135284,-0.188964,-0.609571,0.572625,0.0481208,-0.762605,0.260515,-0.0468029,0.167158,-0.099135,-0.0133182,0.253234,0.251522,0.917701,-0.00174991,-0.471211,-0.465708,-0.149319,-0.389372,0.464027,-0.444583,-0.150087,-0.299401,-0.229754,-0.00465676,-0.21725,-0.103047,-0.305812,0.0785077,-0.1699,0.302024,-0.275,-0.355326,-0.412465,-0.596111,-0.198579,-0.278524,-0.11978,0.320452,-0.434051,0.0724646,1.44042,-0.461749,-0.122942,0.228679,-0.53414,0.311229,0.0566778,0.0677103,0.567937,0.127401,0.332385,-0.101397,0.0725223,-0.0644805,-0.390809,0.350025,-0.0801224,-0.0327841,0.320568,0.331253,-0.0831056,-0.684008,-0.350364,0.253381,0.228898,-0.344811,-0.496317,-0.277814,0.206112,0.0729859,0.488282,0.850063,-0.250774,-0.189207,0.447791,0.125876,-0.163809,0.226701,-0.318244,0.340092,-0.321363,-0.102677,-0.103837,-0.0776153,-0.99388,0.146716,-0.314517,-0.462753,-0.0675657,0.123979,0.151848,0.0784396,-0.31853,0.170274,0.196648,-0.628226,0.133681,-0.08161,0.366936,0.228036,-0.609252,0.188778,0.0845759,-0.506728,-0.125957,-0.145981,0.148501,0.083962,-0.173298,0.214647,-0.0649734,0.991834,-0.285539,-0.584474,0.429909,-0.286871,-0.260673,0.0903941,-0.0499452,-0.0349296,1.01847,-0.678279,0.543108,0.267153,-0.0458514,0.44546,-0.192955,-0.119807,-0.213538,0.102026,0.278545,-0.526608,-0.271737,-0.196328,0.138207,0.116124,0.371763,0.34077,-1.23106 +3420.83,0.850201,0.0848144,4,1.52784,0.83599,-1.0804,0.479715,0.189976,-0.0702524,-0.0583955,-0.0335918,0.319747,0.562042,0.1781,-0.127134,-0.8325,0.605213,0.256312,0.695617,0.366792,0.229865,-0.104511,0.163038,-0.214902,-0.699039,-0.370843,0.723264,0.519375,0.00389113,0.426514,0.255494,-0.350513,-0.222405,0.583124,-0.168524,0.0468218,0.149724,-0.408492,-0.376113,-0.467369,0.5789,0.285436,-0.273553,0.699999,0.154058,0.011404,-0.898672,-0.0344045,0.302489,-0.383694,0.100682,0.2817,-0.288764,-0.0382196,-0.0175916,0.538761,-0.368029,0.384596,-0.0199588,-0.404923,-0.506689,0.530918,-0.0160519,-0.390307,0.762888,-0.691793,-1.13473,0.0247342,0.661781,-0.199809,-0.0174521,-0.335724,-0.297762,-0.00207825,0.227106,0.580523,-0.224419,0.772008,-0.108196,0.0700198,0.363018,-0.536952,0.154681,0.603084,-0.0695958,0.117612,-0.548786,-0.365719,0.436816,0.087999,-0.419635,0.427481,0.158279,-0.266097,0.00511171,-0.240431,-0.094176,-0.0129257,-0.439665,0.0634987,-0.235432,-0.2386,0.312413,0.457975,-0.634134,-0.594336,-0.252107,0.220049,-0.11063,0.325464,-0.162261,0.14309,0.565848,0.0306516,-0.841618,0.502411,0.53039,0.398317,0.401822,-0.745586,-0.0373355,0.29764,-0.306529,0.254828,-0.288899,0.256304,-0.153241,-0.62438,-0.206212,-0.0117205,-0.0510978,-0.113553,-0.313661,-0.085916,-0.185848,-0.512165,0.501314,0.302108,0.189355,-0.0248642,-0.140059,0.468595,-1.00988,0.0828275,-0.356606,-0.0072111,-0.170544,-0.220575,0.229405,-0.274322,0.500807,0.274849,-0.388088,0.386589,0.319027,0.0148455,0.1195,0.269557,0.24131,0.197901,-0.0619139,0.0997218,0.0191245,0.467182,-0.613827,0.647646,0.185069,0.565592,-0.04117,-0.297407,0.0954145,-0.00147127,0.702379,-0.404339,0.00217498,-0.167027,0.0458209,0.232351,0.400992,-0.643493,-0.0624056,0.489787,0.757718,-0.0610912,-0.507363,-0.401592,0.138165,0.535213,0.0326957,-0.383903,-0.109383,0.746718,-0.789598,0.128831,0.0402003,0.284904,-0.993978,0.117947,0.585349,0.00280527,0.161169,-0.170162,-0.529691,-0.34212,-0.261184,0.214056,0.215788,-0.0359504,0.331784,-0.401999,1.35034,-0.0989322,0.0916431,0.0534577,0.000769434,0.320134,-0.299031,-0.283663,-0.406434,-0.0545869,0.165035,0.588855,-0.296986,-0.108685,-0.108451,-0.312674,0.297597,-0.481834,0.351434,0.081423,-0.437323,0.551887,-0.119975,0.1039,-0.079562,0.227781,-0.143853,0.123092,0.304994,-0.0564348,0.192911,0.562832,-0.355971,-0.436133,0.0370319,-0.0642609,0.0456707,0.367207,0.455012,0.105015,0.405804,0.411566,-0.486745,-0.543637,0.257306,0.5398,-0.0209696,0.102987,0.397307,-0.47944,0.292491,-0.440237,-0.238613,-0.21795,-0.0818475,-0.130559,-0.157235,0.37689,0.406247,0.240084,0.552715,-0.20321,-0.195712,-0.151884,-0.196946,0.230409,0.000844844,0.481581,0.047681,0.180087,0.0910608,0.101232,-0.453833,-0.594289,-0.428505,-0.790283,-0.423485,0.186263,0.0940029,0.139087,0.347029,0.106766,-0.597164,-0.0374944,-0.0181457,-0.0899816,0.0277854,-0.217811,-0.526221,0.193757,0.493402,-0.489493,0.363556,0.261369,0.123158,0.166207,0.350939,0.407685,-0.450551 +3432.65,0.941502,0.0848144,4,1.55012,0.955046,-0.18271,0.103139,0.234381,-0.136484,0.319371,-0.00571802,0.434659,0.787202,0.302383,-0.0372271,-0.817715,0.521845,0.286076,0.790713,0.531582,0.201374,0.0357504,0.273533,0.202583,-0.661564,-0.362156,0.600709,0.570361,0.238048,0.246216,0.348859,-0.00249071,-0.22563,0.543718,0.159825,-0.0406367,0.41464,-0.42003,-0.274297,-0.432337,0.684618,0.357511,0.0927708,0.916928,-0.135723,0.285168,-0.436044,-0.143097,0.195106,-0.738169,0.0292994,0.335887,-0.166137,0.184459,-0.0259716,0.197183,-0.110928,0.607152,-0.500929,-0.530102,-0.800405,0.358391,-0.465956,-0.295487,0.485201,-0.736391,-0.461621,-0.147034,0.948222,0.133352,0.173307,-0.257094,-0.211021,-0.243202,0.113503,0.80749,-0.144896,0.674348,0.312431,0.339542,0.0237738,-0.616846,0.084829,0.330908,-0.372664,-0.00323166,-0.519536,-0.215436,0.646496,-0.123127,-0.525862,0.72499,-0.184634,0.124965,0.212951,-0.253911,0.100521,0.293906,-0.193539,-0.0200792,-0.380281,0.316595,0.475066,0.555571,-0.492402,-0.384716,-0.333386,-0.225362,-0.276049,0.162902,0.134473,0.225814,0.618492,-0.281104,-0.644179,0.348714,0.460975,0.532591,0.114041,-0.71395,-0.0369362,0.375448,-0.407207,0.127926,-0.304227,0.0740865,0.378506,-0.273059,0.283193,0.0982463,-0.0260213,-0.0886853,-0.0823102,-0.0163188,-0.140326,-0.386633,0.478438,-0.129063,0.067435,-0.154142,-0.236052,0.139769,-0.955849,-0.0361319,-0.352512,0.0687134,0.0659336,-0.453445,0.15149,-0.00723149,0.712806,0.442093,-0.229268,0.221751,0.114202,0.258557,-0.0937837,0.0869682,0.219881,0.379413,-0.47558,0.275624,0.0302627,0.291951,-0.126728,0.68875,0.252743,0.127073,0.307417,-0.0911605,0.125576,0.00839619,0.682486,-0.266724,0.255911,0.0616433,-0.065308,0.183671,0.398493,-0.713023,-0.0898587,0.432177,1.01915,0.140195,-1.13109,-0.115004,0.229942,0.0334276,0.0662037,-0.37186,-0.158045,0.491936,-0.612243,0.304298,-0.045161,0.465945,-0.588486,0.227139,0.467212,-0.0404649,-0.142281,-0.332143,-0.630802,-0.396094,-0.516805,0.00861584,-0.0133278,0.270885,0.316136,-0.308813,1.16725,-0.00711736,-0.0998919,0.203139,-0.0332375,0.307756,-0.0882346,-0.474103,0.290727,-0.14299,0.0312219,0.695129,-0.328184,0.0354642,-0.418172,-0.238175,0.499281,-0.343729,0.0186159,-0.217693,-0.3496,0.269002,-0.0886358,-0.121797,0.0205754,0.203612,-0.434527,-0.0643631,0.176134,-0.0667842,0.0989344,0.704259,-0.0237313,-0.109985,0.240979,-0.115901,-0.0933909,0.613821,0.384388,-0.158768,0.0276747,0.182226,-0.539763,-0.305447,0.0695647,0.355899,-0.398485,0.00291717,0.253759,-0.576144,0.217903,-0.162389,-0.331883,-0.148628,-0.144977,-0.102273,0.066836,0.0658001,0.154963,0.566916,0.32759,0.250804,0.174523,0.079018,0.0657479,0.0956729,-0.320486,0.332606,-0.144635,0.295257,-0.34991,0.00767004,-0.377778,-0.197863,-0.84189,-0.800471,-0.317515,0.195851,0.0501818,-0.157426,0.576015,-0.0908099,-0.297896,0.174472,-0.106844,0.0340208,0.32208,-0.0422901,-0.804532,0.0450795,0.186148,-0.67064,0.417463,0.0341869,0.147612,0.218917,0.384203,0.467886,-0.884146 +3454.83,0.747286,0.0848144,4,1.46318,0.832553,-0.771494,0.345167,0.158875,-0.081384,0.170777,-0.157647,0.0819645,0.254277,0.580412,-0.0542105,0.337846,0.781375,-0.0658146,0.966562,0.408784,0.177023,0.0109301,0.235962,-0.205044,-0.70678,-0.221535,0.812346,0.338185,-0.0926354,0.453457,0.188932,0.609019,-0.170799,0.782122,-0.411221,-0.0182935,0.315567,-0.418876,-0.010967,0.159598,0.499023,0.0749087,-0.599471,0.913231,0.0992367,0.00319574,-0.526213,-0.39366,0.448773,-0.599434,-0.0599201,0.809964,0.296005,0.232378,0.367779,0.267723,-0.113799,0.649932,-0.183129,-0.26068,-0.436259,0.650873,-0.0931537,0.108599,0.540901,-0.542916,-0.710198,0.525246,0.112948,0.16868,0.176767,-0.0872329,-0.810417,-0.0633142,0.285497,0.537081,0.683141,0.598092,0.35269,0.127648,-0.325292,0.176172,-0.131305,0.402758,-0.445298,-0.130369,-0.472376,-0.143025,0.0777041,0.492305,-0.420211,0.728153,0.0117705,0.32909,0.0161615,0.361412,-0.298506,-0.053017,-0.274833,0.315268,-0.108573,-0.0280392,0.0203715,0.16968,-0.645466,-0.352593,0.215473,-0.393199,-0.367485,0.123462,-0.361534,-0.0594888,0.577669,0.14882,-0.816253,0.0382572,0.421134,0.158942,0.0816172,-0.143004,0.00233751,0.155705,0.139333,-0.514161,0.140794,-0.636893,-0.247159,-0.42516,0.478022,0.224582,0.0662036,-0.123533,-0.373037,0.287828,-0.185084,-0.00892008,-0.167587,-0.385384,-0.386173,0.128024,-0.108551,0.440773,-0.565691,-0.0528851,-0.0431412,0.0235553,-0.344575,-0.352641,0.131871,-0.485654,0.553013,0.214375,-0.146085,-0.328323,0.050918,0.217171,0.253512,-0.218411,0.252045,-0.0263235,0.0200425,0.117313,-0.0184976,-0.011335,0.263753,0.75726,-0.0208199,-0.252483,0.293144,-0.280394,-0.3491,-0.282152,-0.138297,0.505949,0.392569,-0.123924,0.204795,0.0911235,0.0222999,-0.135134,-0.300476,0.135879,0.937552,0.425429,-0.338652,0.126262,-0.224105,0.344579,-0.293475,0.024448,-0.37558,0.0964967,0.0091233,0.001412,0.324846,-0.276548,-0.822226,-0.262578,0.178372,0.145693,-0.124921,0.302968,0.202415,-0.196108,-0.082209,0.0204604,0.221942,0.162718,-0.733024,-0.322428,1.3137,-0.0909313,0.259977,-0.534009,0.182721,-0.163935,-0.185081,-0.579926,0.262408,-0.429051,0.124992,0.773736,-0.566448,0.0471736,-0.198756,-0.173499,0.214803,-0.262046,0.287651,-0.384525,-0.141017,-0.121601,-0.142091,-0.382658,0.11434,-0.320459,0.036223,-0.149744,0.200453,0.148633,0.255653,0.622919,0.128066,-0.432293,0.0351476,0.120467,0.482261,0.580043,-0.184443,-0.172478,0.314436,0.0853203,0.22389,0.050054,-0.0971532,0.330787,-0.0897746,0.453926,0.254383,-0.231398,-0.483073,-0.333823,-0.124595,-0.010472,-0.0238734,0.0461228,0.158781,-0.107057,-0.157778,0.292239,0.0498451,-0.061089,0.155762,-0.0541911,0.218311,-0.0292829,0.160561,0.316056,0.329164,0.136791,0.463095,0.0864668,-0.49574,-0.293111,-0.0360225,-0.257986,0.377374,-0.248729,-0.108889,-0.263269,0.138717,0.219856,-0.108356,0.0627676,0.315636,-0.0790091,-0.114003,-0.162612,0.2326,0.306104,0.37112,-0.224495,0.152506,-0.222865,0.0961766,0.209241,0.310124,0.457429,-0.437803 +3453.84,0.381933,0.0848144,5,1.51794,0.905337,-0.015727,-0.0594511,-0.0563616,-0.125688,0.404479,-0.232843,0.293561,0.6367,0.360674,0.266093,-0.213502,0.692787,-0.0390017,1.11414,0.510833,0.0709659,-0.149071,0.108908,-0.0354854,-0.727798,-0.750408,0.494479,0.240436,0.0820445,0.27906,-0.0334476,0.0600491,0.191217,0.696217,-0.285611,0.419852,0.188617,-0.0242007,0.190946,-0.687509,0.111417,0.00504169,0.102798,1.1658,0.573313,0.0824823,-0.784453,0.11108,-0.295484,-0.0911989,-0.128962,0.841709,0.122366,0.349783,-0.233947,-0.064497,-0.777951,1.00201,-0.122989,0.209221,-1.2012,0.269053,-0.150985,0.349871,0.705709,-1.01597,-0.805996,0.486284,0.0482686,0.00153725,-0.0482497,0.0528125,-0.440091,-0.21004,-0.0968363,0.597915,0.171589,0.195849,0.151848,0.269822,-0.0567427,0.129202,0.0917742,0.457531,-0.102316,0.0477334,0.196968,0.0493858,-0.377975,-0.0590607,-0.447045,-0.192561,-0.245839,-0.0158975,-0.0682117,-0.0142614,0.108736,0.0532804,-0.414865,-0.117051,-0.315189,-0.092463,0.144305,-0.120053,0.13706,0.316296,-0.179422,0.0745704,-0.438146,0.368781,-0.525337,0.181121,0.457307,-0.0854661,0.38866,-0.401603,0.289304,0.224832,-0.0354794,-0.0630909,0.0755579,-0.0773961,-0.0458157,-0.394087,0.416398,0.280498,-0.0977212,-0.0830383,-0.677053,0.0516724,0.147997,-0.35985,-0.15278,-0.308002,-0.680877,-0.13885,0.0984297,0.0966835,-0.0552787,0.0255801,-0.0531961,0.479486,-0.398436,-0.583759,-0.255562,-0.0415609,-0.2169,0.296843,-0.150036,0.172126,0.576905,0.0943163,0.219994,-0.155357,0.161815,0.0957849,-0.299359,-0.0861411,0.838016,-0.224462,-0.305047,0.179477,-0.272973,0.316495,0.100605,0.393368,-0.225832,-0.0771172,0.223458,-0.126111,0.00696392,0.23363,-0.303511,-0.0336313,0.0772543,0.00776138,-0.141724,-0.053765,0.0620414,-0.0216639,0.191652,-0.253875,0.84876,0.128979,-0.155294,-0.26054,-0.0575329,0.272002,-0.0440454,-0.488185,-0.761217,-0.231761,-0.96365,0.44413,-0.3865,-0.306793,-0.122452,0.354499,0.0692855,-0.0106985,-0.111182,-0.309453,0.134751,-0.248656,-0.201206,0.0260047,-0.0441223,0.068867,-0.0828604,0.0293141,0.97084,0.0974975,0.141364,0.100687,-0.51429,-0.128064,0.20167,-0.722401,-0.0105248,-0.163223,-0.289231,0.110084,0.05679,0.355714,-0.207253,-0.205253,0.292579,0.169087,0.0307845,-0.39888,-0.220045,0.320993,0.391474,0.632401,0.0992015,-0.274484,0.0969118,0.445805,0.625818,-0.453595,-0.26521,0.537742,-0.13375,0.40241,-0.248831,-0.0746178,0.205703,0.290299,0.114723,0.259124,-0.208512,0.415758,-0.46072,-0.0734561,-0.258963,0.37853,-0.203767,-0.46953,-0.140139,-0.0575556,0.205878,0.241179,-0.0548458,0.0101939,0.462117,0.191715,0.673927,-0.072627,0.236932,0.147267,0.00966663,-0.25656,0.268082,-0.110094,-0.111524,-0.730796,0.152599,-0.273221,-0.447187,0.0744614,-0.074902,-0.025351,0.479656,-0.170499,-0.243166,-0.195287,-0.0938993,-0.00291784,0.136783,-0.0835766,-0.399784,0.237182,-0.102237,-0.0414717,-0.0214826,-0.153632,0.423841,-0.00774465,-1.02317,-0.193669,0.0333028,0.349737,-0.381987,-0.488413,0.0913109,0.214549,0.302177,0.463195,0.200524 +3451.63,0.681633,0.0848144,4,1.49589,0.859662,-0.609341,0.161965,0.166594,-0.0538837,-0.298493,0.0879673,0.410939,0.387307,0.0428912,-0.117042,0.0860115,0.849688,0.628447,0.947987,0.0892367,-0.143825,-0.192735,0.174366,-0.333816,-0.695852,-1.03886,0.351475,0.123765,-0.354276,-0.00679254,0.489304,0.0745366,-0.110731,0.676503,0.337928,-0.291357,0.232374,-0.0266894,0.174299,-0.26971,0.321824,0.990106,-0.711887,1.05206,1.08339,-0.0437676,-0.626313,-0.125212,-0.155207,-0.301589,0.0688497,0.992487,0.0389492,0.503216,-0.00597979,0.0832084,-0.473157,1.13309,0.397386,-0.0384125,-0.825629,0.755549,-0.41705,0.223304,1.10863,-0.720837,-0.549757,-0.116,-0.125399,-0.296268,0.101544,-0.030818,-0.428118,0.137071,-0.0423925,0.278555,-0.710742,0.578764,0.718774,-0.012448,0.313877,-0.391865,-0.107156,0.451699,0.21232,0.153386,0.0699451,0.101242,-0.302687,0.248524,-0.264555,0.120205,-0.15344,-0.277953,-0.158395,0.255991,-0.165046,0.21063,-0.173489,-0.207921,-0.201999,0.0021962,0.478735,-0.162718,0.130281,-0.165904,0.110957,-0.62813,-0.962898,0.492464,-0.105768,-0.00883952,-0.0729922,-0.448534,-0.180444,-0.0589646,0.25926,-0.482911,-0.109923,-0.263666,0.284535,0.132088,0.386188,-0.643489,0.147595,0.35925,-0.227555,-0.0697866,-0.163862,0.600158,-0.198525,0.533738,-0.22981,0.415127,-0.582304,0.00311622,0.536952,-0.170581,-0.182186,0.308998,-0.230874,0.358741,-0.447729,-0.396618,0.0841701,-0.00980235,-0.509575,0.475247,0.211237,-0.0837505,0.455203,0.206422,-0.00910607,-0.308315,0.235908,0.28593,0.0582739,0.179537,0.465079,-0.331048,-0.601765,-0.0510941,-0.097854,0.104415,0.459636,0.565715,-0.131714,-0.163789,0.385015,-0.524379,-0.351227,-0.53462,-0.285184,0.896287,-0.173285,-0.171526,-0.280718,-0.601409,0.219856,-0.436455,0.223867,0.24257,0.524598,0.0352475,-0.0346249,0.101339,-0.196189,0.215863,-0.363607,-0.278075,-0.44188,0.422175,-0.173982,-0.3371,-0.417803,0.0160654,-0.636286,0.265573,0.185093,0.323933,-0.0213893,-0.320908,0.3352,-0.0137007,-0.0907432,0.419874,-0.105948,0.208328,-0.265236,0.0288788,1.07476,-0.367524,0.178855,0.0415396,-0.0143983,0.0767808,0.250242,0.17668,0.0761826,-0.269575,-0.124003,-0.0533079,-0.433167,0.0578094,-0.246881,0.301374,-0.0352353,-0.341646,0.0203197,0.0688478,-0.0939315,0.196074,0.34535,-0.602872,-0.120268,-0.364273,-0.222347,-0.213922,0.31113,0.212224,0.0688695,0.0577498,-0.151801,-0.581884,-0.0158605,0.0125205,-0.223713,-0.00134321,0.0829355,0.347262,0.000358548,-0.305486,0.0292264,-0.226498,-1.11393,0.317833,-0.243261,-0.105812,0.1501,-0.00725221,0.0631668,0.339116,0.211405,-0.250856,0.044817,-0.040498,-0.272687,0.102227,-0.247905,0.075019,-0.81076,0.239169,-0.335878,-0.422783,-0.273828,0.243497,0.300114,-0.131738,-0.324707,-0.0434124,-0.237997,0.182083,-0.0228713,-0.0413396,0.480122,-0.00547489,0.113691,-0.256618,0.332319,0.00925627,0.300822,-0.104144,0.0385146,-0.0909474,0.176211,0.350965,0.227766,0.127748,0.059258,-0.353837,-0.408521,0.202097,-0.22813,0.317367,0.104789,0.307707,0.323711,0.554714,-0.396982 +3426.23,0.598284,0.0848144,4,1.48804,0.836148,-0.980535,0.203933,0.038652,-0.0858028,-0.142779,-0.00655602,0.648547,0.524893,0.0753653,0.116584,-0.285312,0.866989,0.229531,0.579232,-0.0492228,0.0323093,-0.39586,-0.0714406,-0.213951,-0.789356,-0.838112,0.321512,0.133476,-0.534471,-0.108039,0.534325,0.197421,0.0108236,0.832494,-0.259685,-0.129161,0.106518,0.192711,0.414003,-0.425967,0.375688,1.07367,-0.513554,1.19063,1.02968,0.122731,-0.751185,-0.147006,-0.356946,-0.225496,-0.052434,1.16988,0.130372,0.54347,-0.117294,0.188926,-0.526378,1.21097,0.274048,0.278296,-0.532455,0.466828,-0.457223,0.611599,1.34479,-0.690012,-0.379566,0.0196378,0.423808,-0.172875,0.354619,0.54456,-0.278432,0.105121,-0.000490605,0.208462,-0.714767,0.289674,0.880175,-0.311437,-0.040456,-0.32691,-0.0720996,0.548494,0.420637,-0.0308875,0.306085,-0.0975552,-0.341445,0.307561,-0.30695,-0.131993,-0.397166,-0.584554,-0.193824,0.120287,-0.0778258,0.203523,-0.552039,-0.625444,-0.525916,-0.28244,0.584873,-0.463945,0.197814,0.034043,-0.219559,-0.00568654,-0.348956,0.33957,-0.2735,0.0673201,0.221828,0.0359069,-0.0244719,0.14954,0.207301,-0.393348,0.230283,-0.205859,-0.160398,0.0898596,0.392858,-0.931188,0.028011,0.361665,0.0741907,-0.376959,-0.0255306,0.153134,-0.0803936,0.207375,-0.480106,0.297477,-0.378973,0.00067942,0.540603,-0.340921,-0.0924425,0.0909874,-0.495822,0.499028,-1.09655,-0.749205,-0.103718,-0.196958,-0.426769,0.550656,-0.28967,-0.0341018,0.161953,0.0682138,-0.183032,-0.139929,0.205481,-0.113843,-0.185422,0.052138,0.440984,-0.319517,-0.328957,-0.317371,-0.136763,0.116786,0.494599,0.786732,0.242775,-0.339616,0.685951,-0.361047,-0.287138,-0.600428,0.276213,0.397316,-0.127683,-0.0880154,-0.174928,-0.331006,0.293148,-0.37948,0.584714,0.265709,0.568908,-0.320292,0.0170729,0.183059,0.203292,0.010619,-0.353138,-0.548981,-0.435856,0.427811,-0.138876,-0.345825,-0.412597,0.0624994,0.0261789,0.322364,0.311824,0.223726,-0.351264,0.0555012,0.0446937,-0.0196493,-0.263801,0.996809,-0.286397,0.0986027,-0.00139245,0.0735356,0.974806,-0.346232,0.0302803,0.27579,-0.400868,0.00840868,-0.0370042,0.180546,-0.0458344,-0.494649,-0.0110403,0.285645,-0.519544,0.353157,-0.303676,0.524518,0.378616,-0.333622,0.0810918,-0.00115991,-0.138485,0.0440969,-0.0346768,-0.31271,0.00653392,-0.209747,-0.207176,0.160332,0.571688,0.0328001,-0.00157977,0.418719,-0.194965,-1.43624,0.577546,0.121284,0.19737,-0.409629,-0.351988,0.339011,-0.0186654,-0.577571,-0.570532,-0.157948,-0.84101,0.626129,-0.839034,-0.206941,0.113909,0.0761531,-0.0426845,-0.112142,0.0273502,-0.116138,0.224323,0.217415,-0.440871,-0.179691,-0.235071,-0.272301,-0.581142,0.154395,0.0142906,-0.301863,-0.170298,-0.0672524,0.165944,-0.310302,0.0325342,-0.0197033,-0.308522,0.175042,-0.483394,0.101323,0.114682,-0.351704,-0.00269697,-0.0789422,0.136002,-0.141581,0.501654,-0.398487,0.00903287,-0.203658,-0.272686,-0.0696515,0.267421,0.0372247,-0.42041,-0.145886,-0.209977,0.353424,0.103653,0.185532,0.12426,0.403137,0.352505,0.634931,0.224693 +3441.02,0.995947,0.0848144,4,1.39743,1.01117,-1.18204,0.336294,0.185217,0.0230328,-0.215615,0.0458205,0.626638,0.607636,-0.200487,-0.0997793,0.200321,0.517881,-0.08278,0.747406,-0.0916498,-0.308431,0.282011,0.112695,-0.591022,-0.936104,-1.00337,0.221647,-0.0938564,-0.163588,0.203159,0.452669,-0.106459,0.0928335,0.769439,0.0963174,-0.0187281,0.0920216,-0.0986353,-0.119824,-0.530715,-0.258086,0.570878,0.158467,1.37676,0.750231,0.540526,-0.798332,0.147936,-0.0816662,-0.547257,0.342643,0.770261,0.428786,0.474451,0.0311604,0.350973,-0.221765,0.611546,0.352786,-0.00158494,-0.800712,0.563982,-0.0922346,0.953413,1.43621,-0.402882,-0.0599569,-0.0603034,0.198637,0.276841,0.486577,0.139552,-0.239341,0.0413851,0.223447,0.592044,-0.24165,0.689503,0.80007,0.332819,-0.122542,0.270419,0.158747,0.405075,-0.215476,-0.076415,0.00770223,0.0491496,-0.0819357,0.225458,-0.358835,-0.242634,-0.33575,-0.440598,0.33731,0.112559,0.0588573,0.23501,-0.698434,-0.705474,0.179173,-0.0378078,0.387615,0.0368822,0.2682,-0.27515,-0.264525,0.15027,-0.0592018,0.526549,-0.673112,0.209381,0.273569,0.390993,0.0982438,-0.062419,0.213803,-0.427556,0.0947546,0.0278373,0.215552,0.391813,0.451996,-0.708603,-0.402556,-0.108388,-0.128567,-0.164482,0.115892,-0.0562997,-0.255408,0.0434095,-0.59588,0.101411,-0.111817,-0.887223,0.607043,-0.0211392,-0.174042,-0.00400338,0.0239153,0.288995,-0.640131,-0.07146,-0.0737744,-0.0192437,-0.532256,0.217558,-0.341927,-0.265077,0.286852,-0.0101045,-0.462787,-0.104046,0.216989,-0.38804,-0.0550845,0.146282,0.372996,-0.141853,0.334391,-0.0916744,-0.119703,0.430561,0.599161,0.501015,0.154562,0.252083,0.876973,-0.304377,-0.126874,-0.326103,0.0871673,0.13466,0.0430633,-0.141387,0.273694,0.156606,-0.0476792,-0.0331392,0.540342,-0.0596833,0.494984,-0.57065,-0.490888,-0.0115005,0.312749,-0.154258,-0.116821,-0.573575,-0.234016,0.0118428,-0.232123,-0.222703,0.0904091,0.260245,0.0344054,0.0625223,0.156622,0.0332864,-0.172503,-0.142452,-0.0756259,-0.0539391,-0.00475197,0.566518,-0.183371,-0.145624,0.384968,-0.793498,0.711832,-0.258208,0.363388,0.0973239,-0.385454,0.26461,0.112454,0.356278,0.270921,-0.540756,-0.041538,-0.0291765,0.0596489,0.388874,-0.325653,0.0983567,-0.0620747,-0.624398,0.365403,0.0475402,-0.263497,0.447458,0.204684,-0.31506,0.0308441,0.0829801,0.0188537,0.277585,0.497498,0.165661,0.0303539,0.117671,-0.838557,-0.129669,0.0751411,0.0833991,0.214207,0.149673,0.218453,0.455878,0.180562,0.213466,-0.288236,-0.0899114,-0.695622,0.219445,-0.168377,0.500991,-0.00475255,-0.0305268,-0.240587,0.166204,-0.00159052,0.0739389,0.672353,-0.0756369,0.396097,-0.0390254,0.173577,0.0301834,-0.143755,0.0381366,-0.345166,-0.399599,0.370981,-0.382386,0.502108,-0.488076,-0.264501,-0.117349,-0.621812,0.681786,-0.300874,0.208725,-0.0807331,-0.399971,0.20198,-0.363217,0.306175,-0.432933,0.138913,-0.514747,0.0259233,-0.10372,0.0648429,-0.0216377,0.355915,-0.110655,-0.635834,0.0816032,-0.247747,-0.11149,-0.0993537,0.136148,0.108286,0.218137,0.329068,0.467051,-0.708775 +3450.13,0.78309,0.0848144,4,1.41935,0.958724,-1.27833,0.424832,0.0152358,-0.0454755,0.0822283,0.312074,0.227943,0.723375,0.0778615,-0.309148,-0.23369,0.642379,0.288466,1.07164,-0.00607711,-0.0594983,-0.370561,-0.224171,-0.372356,-1.14481,-0.69407,0.312654,-0.187444,-0.502403,0.347967,0.595017,-0.102093,-0.222638,0.931359,0.0191579,-0.355869,0.284017,-0.157239,0.200092,-0.255629,0.297981,0.598544,0.138566,1.29935,0.690208,0.570782,-0.713723,-0.0216468,-0.108999,-0.312063,0.286035,1.03126,-0.00776304,0.704229,0.241322,0.391808,0.0147543,0.492326,0.447182,-0.274995,-0.144496,0.288966,-0.302326,0.605721,1.34881,-0.243645,-0.311061,0.565182,-0.274009,-0.074078,-0.201741,-0.110693,-0.218922,0.538126,0.501317,0.388328,0.0494236,0.241157,0.433053,0.689914,0.336981,0.0090668,0.371212,0.157681,-0.194149,0.291216,-0.159894,0.0300372,-0.15148,0.0921598,-0.0466019,0.0778854,-0.588376,0.201511,0.746974,0.112074,-0.238332,-0.0715548,-0.256742,-0.0294732,-0.0589625,-0.29742,0.0664912,0.173937,0.0593748,-0.544661,-0.415599,-0.252286,0.0337184,0.130744,-0.667574,0.339472,0.259901,0.301756,-0.567196,-0.65942,0.332472,-0.230991,0.363258,-0.421758,0.115064,0.659993,-0.0904027,-0.712372,-0.0742578,0.103692,0.34691,-0.205681,0.158167,0.00468944,-0.0700551,0.28799,-0.28326,-0.276661,-0.102826,-0.13797,0.626543,0.628887,0.0605359,0.196919,0.183432,0.805852,0.0752281,0.113188,-0.255498,0.0339261,-0.342379,-0.392756,-0.120227,-0.0481307,0.350806,-0.16271,-0.275681,0.0119541,0.136296,-0.127116,0.0269146,0.77996,-0.000166164,0.0384557,0.523686,-0.0327455,0.231118,0.455869,-0.141452,0.712757,0.783812,0.165869,0.272434,-0.59709,-0.00758079,0.117873,-0.0257529,-0.00846307,-0.218545,-0.0607632,-0.143848,0.298681,-0.164622,-0.0991508,-0.130513,0.168258,0.32573,-0.232874,-0.379742,0.0129544,0.504089,0.329339,0.0715602,-0.468593,-0.635784,0.368682,0.0355081,0.203036,0.168551,0.540188,0.21798,0.111413,0.0339602,0.200851,-0.111787,-0.455482,0.184347,-0.221085,-0.651356,0.0797729,0.295882,0.00799487,0.31036,-0.102478,0.904901,-0.226152,0.3063,-0.108914,-0.406195,0.267643,0.218825,0.286117,-0.27019,-0.0519421,-0.0981148,0.190563,-0.718667,-0.119301,-0.0661292,0.370218,-0.141404,-0.385835,0.143391,-0.44489,-0.469984,0.0781845,0.0590126,0.110544,0.0739947,-0.513931,0.0850071,-0.39672,0.184392,0.171563,0.233223,0.328803,-0.39343,0.0491068,0.338019,0.187213,-0.00637307,0.375623,0.35645,0.354702,-0.103998,-0.331761,-0.477057,-0.0447506,-0.657896,0.363493,-0.374619,-0.0537283,-0.249451,0.227543,-0.191065,0.091992,-0.150739,0.400431,0.297133,0.297612,0.346099,-0.0969394,0.585294,-0.0894437,-0.00761622,0.0421132,-0.182303,-0.259343,-0.316465,-0.147294,0.00374117,0.357187,-0.0600185,-0.252611,-0.275212,0.281793,0.0297975,-0.0919997,0.411028,0.0317671,0.615393,-0.223431,-0.0406804,-0.226383,0.292681,-0.122632,-0.0563276,0.00860393,0.16387,-0.36314,-0.0714751,-0.258258,-0.362663,0.214345,-0.453671,-0.230826,-0.0500837,-0.000718335,0.0911976,0.213378,0.301989,0.461928,-0.0460732 +3421.25,0.935155,0.0848144,4,1.42391,1.01249,-1.23079,0.423101,-0.20691,-0.0228949,0.308201,0.0957908,0.379125,0.263519,-0.22769,-0.200387,0.162178,0.599675,-0.0769747,0.885061,0.159019,-0.259585,0.0252186,0.332072,-0.817228,-0.827173,-0.660192,0.0350577,-0.198294,-0.0827349,-0.0439161,-0.144192,-0.737825,0.0886442,0.724127,-0.539294,0.0118874,0.0615638,-0.329653,0.205713,-0.110378,0.729216,0.165672,-0.294275,1.27107,1.22821,0.433114,-0.726279,-0.0213311,0.819486,-0.426848,-0.187987,0.764248,-0.262165,0.497651,0.348385,0.452445,-0.412764,0.195732,0.012959,-0.515261,-0.812255,0.582257,0.1576,0.678772,1.52088,-0.619744,-0.787848,0.30785,0.155208,0.416331,-0.255551,0.138607,-0.540301,0.0799604,0.0477325,0.41028,-0.393075,0.430155,0.342399,0.524393,0.0827976,0.0941815,0.435129,0.131571,-0.296545,0.152259,0.499261,0.11666,0.00657661,0.711909,0.214062,0.386046,-0.378571,-0.0404103,0.548937,0.193313,-0.378382,-0.110553,-0.1509,-0.0435392,0.0280996,0.254477,0.0765761,0.0483458,-0.137204,-0.00591702,-0.258412,0.103957,-0.299494,0.397834,-0.457362,0.102622,0.044886,0.517592,-0.156281,0.056905,0.508543,0.0508822,0.176447,-0.249614,-0.105439,0.0865682,-0.214546,-1.04822,-0.429864,0.325235,-0.0699312,-0.0043461,0.018566,0.736918,-0.260528,0.351216,0.00426915,0.0341085,0.0852756,0.57896,0.433882,0.0895928,0.00582347,-0.266195,0.105928,0.420548,-0.463623,-0.396579,-0.111294,0.275173,0.12271,0.302894,-0.390712,-0.241941,0.628843,-0.014163,-0.159941,-0.148653,0.1472,-0.171453,-0.109803,0.065538,0.360669,0.239691,0.138964,-0.132635,0.210548,0.516877,-0.649089,0.315139,0.264045,0.71929,0.555931,-0.511827,0.316339,-0.436792,-0.0214736,0.450565,-0.117289,-0.141728,-0.133393,0.5085,0.248902,-0.323483,0.34883,0.191165,0.0257866,-0.154465,-0.608897,0.199552,0.41022,-0.0365743,-0.0445704,-0.0687254,-0.127262,0.226645,-0.587199,-0.180145,0.167919,-0.0629501,-0.295776,0.0661464,0.109133,0.00853853,0.147113,-0.953431,-0.259435,-0.186783,-0.180208,0.104275,0.202349,-0.219559,0.571702,-0.0774554,0.901163,-0.173573,0.349967,-0.262319,-0.379023,0.0300693,-0.190321,-0.105628,0.515268,-0.0163642,0.0810968,0.991333,-0.312151,0.347857,-0.526442,0.157129,0.338646,0.105096,0.181754,0.116631,-0.625249,0.0747671,-0.189121,0.0974782,0.193647,-0.44405,-0.53313,-0.325435,0.25698,0.535203,-0.382408,0.251929,-0.17559,-0.902146,0.367853,0.406938,-0.167724,0.799974,0.437953,0.170456,-0.194287,-0.0979208,-0.140221,-0.237824,-0.183771,0.0242781,-0.611289,0.166584,-0.040731,-0.118624,0.0432906,0.504761,0.252188,0.603563,0.370396,0.243589,-0.281913,-0.0388456,0.0535387,-0.0755729,0.278502,-0.250685,0.0664616,-0.105391,-0.173827,0.155065,0.228577,0.463908,-0.229744,0.205642,-0.20065,0.333513,0.20277,0.0710326,0.684839,-0.0948166,0.201204,-0.304747,0.47572,-0.645806,0.472443,0.0831646,-0.172621,-0.00137126,-0.123465,0.373881,-0.21202,0.0283685,-0.481028,-0.373772,0.175966,-0.884401,-0.139712,-0.0183936,0.140221,0.284602,0.374461,0.533481,0.571921 +3438,0.973632,0.0848144,4,1.36769,1.08787,-1.20848,0.358467,0.171145,-0.0823725,0.338452,-0.0100331,0.221509,0.146986,-0.26663,-0.142918,0.121322,0.513333,-0.165704,1.03148,-0.00814493,-0.0677772,0.2226,-0.095594,-0.764646,-0.468616,-0.826303,0.0621336,-0.19584,0.175224,0.0223601,0.273546,-0.707209,0.0846401,0.798184,-0.41218,0.0599018,-0.0381467,-0.390145,0.225706,0.0644298,0.337119,0.236619,-0.182404,1.26799,1.18124,0.273562,-0.645939,0.119701,0.598506,-0.400636,-0.140904,0.791572,-0.402309,0.507806,0.448472,0.21339,-0.149176,0.315213,0.0585932,-0.559059,-0.396439,0.378307,0.331127,0.690647,1.4395,-0.430879,-0.653697,0.240953,0.163141,0.425335,-0.356512,0.265426,-0.727786,0.22443,0.130786,0.470244,-0.14428,0.553837,0.492913,0.235837,-0.0870454,0.0705776,0.420822,0.0928006,-0.219143,0.219277,0.448373,-0.078762,0.166806,0.418378,0.207557,0.125432,-0.495528,-0.249453,0.748416,0.231112,-0.394362,0.00490994,0.0281848,-0.0720928,-0.0805939,0.111231,0.189463,0.233644,-0.221735,0.0887136,-0.277545,0.120698,-0.0850051,0.847147,-0.214582,0.477469,-0.0833092,0.25114,-0.0741638,0.278132,0.50219,-0.0912863,0.425526,-0.137955,0.126012,-0.131349,-0.0942322,-0.679198,-0.420897,0.117887,0.0950127,0.260131,0.0787957,0.346313,0.0764424,0.113399,-0.36542,0.112252,0.0815377,0.257614,0.549945,0.0453787,-0.166487,-0.226262,0.14676,0.448174,-0.273462,-0.415286,0.0758163,0.158534,-0.00527304,0.0480261,-0.288425,-0.425783,0.473771,-0.0900075,-0.244973,-0.407518,0.294882,-0.000891488,-0.187293,0.31774,0.437236,0.257876,0.4834,-0.0192806,0.292313,0.616444,-0.467286,0.354409,0.275189,0.778365,0.471756,-0.407311,0.624274,-0.317088,-0.156984,0.236572,-0.226246,0.125911,0.280835,0.303116,0.526827,-0.320705,0.190803,0.347314,0.134057,-0.429353,-0.676366,0.0699529,0.264267,0.278831,-0.187519,-0.0170557,-0.0813582,0.147543,-0.109572,-0.193213,0.142397,0.140328,-0.062008,0.140344,-0.159599,0.0426838,0.0848238,-0.802609,-0.0591817,-0.160595,-0.0937776,0.0850269,0.213985,-0.420671,0.126491,-0.345845,0.89079,-0.493267,0.347083,-0.228724,-0.514932,0.0506824,-0.00188834,-0.176638,0.487255,0.176723,-0.0451231,0.818998,-0.292839,0.253099,-0.543056,0.330969,0.319025,0.196175,0.234401,-0.146907,-0.577857,-0.140979,-0.103469,0.365878,0.122872,-0.125862,-0.22584,-0.356497,0.709411,0.567106,-0.14251,0.250932,-0.467977,-0.837541,0.0619776,0.154647,-0.299095,0.665998,0.306294,0.259473,-0.173097,-0.00844112,-0.187701,-0.257555,-0.18167,0.0844648,-0.500627,-0.0436393,-0.304772,-0.212275,0.0379807,0.436837,0.149223,0.604429,0.311006,0.0223622,-0.154956,0.346915,0.20352,0.0395262,-0.0374426,-0.230437,0.205715,-0.301694,-0.55128,0.138646,0.26658,0.274665,-0.277402,0.0550288,-0.419044,0.160099,0.241888,0.232678,0.342958,-0.0608716,0.234417,-0.264508,0.56862,-0.679789,0.27343,-0.0976188,-0.322362,0.079963,-0.0206184,0.476846,-0.326139,-0.0843638,-0.448503,-0.310771,-0.129752,-0.814134,-0.310256,0.242997,0.0916108,0.275681,0.302673,0.525054,-0.808184 +3435.15,0.955769,0.0848144,5,1.39808,1.0581,-1.2298,0.362812,0.131659,-0.0894974,0.293427,-0.08509,0.200522,0.124869,-0.240788,-0.15879,-0.00132194,0.526991,-0.216221,0.840758,-0.0517622,0.0451912,0.389393,-0.0668877,-0.642018,-0.66054,-1.01685,-0.0530572,-0.165536,0.017155,-0.0504099,0.407792,-0.364496,0.108773,0.86921,-0.244272,0.183021,0.032808,-0.602142,0.251976,0.218385,0.187977,0.153671,-0.036748,1.35203,1.27197,0.265818,-0.676076,0.274705,0.463884,-0.484206,0.000392742,0.908977,-0.240735,0.528036,0.375097,0.258712,-0.491337,0.31009,-0.212122,-0.483206,-0.218364,0.28247,0.359429,0.881813,1.43466,-0.347205,-0.805726,0.422435,0.306477,0.419787,-0.282653,0.000625302,-0.588112,0.105106,0.363303,0.523532,-0.113031,0.485721,0.490741,0.149325,-0.315578,0.0102598,0.32556,0.159507,-0.327739,-0.0500194,0.281921,0.0747613,0.24105,0.438475,0.105578,0.0170005,-0.503909,-0.321858,0.726659,0.359676,-0.275299,0.0316862,0.0448933,0.141288,-0.103442,0.0471811,0.26377,0.411829,-0.307185,0.211146,-0.225315,-0.0473341,-0.120909,0.618586,-0.254178,0.317584,0.0652642,0.0676496,-0.0602275,0.313104,0.554819,-0.105135,0.420771,0.20688,0.306625,-0.132077,-0.120373,-0.600508,-0.265835,0.0997162,-0.0270753,0.113494,0.283541,0.416454,-0.00696993,0.187035,-0.251383,0.185752,0.0678238,0.344889,0.555771,-0.0714792,-0.301629,-0.123793,0.1288,0.36161,-0.309496,-0.343343,-0.103366,0.0441225,0.0628352,-0.0578996,0.0674659,-0.374281,0.355699,-0.100884,-0.214838,-0.230974,0.338872,0.118911,-0.0626054,0.362513,0.542801,0.136005,0.401583,0.0960397,0.0884508,0.513481,-0.559562,0.557858,0.123672,0.699408,0.423271,-0.386203,0.756737,-0.361363,-0.253466,0.375329,0.0839028,0.111358,0.200428,0.354164,0.403122,-0.101472,0.0500694,0.500052,0.262129,-0.553033,-0.710394,0.149416,0.431295,0.233524,-0.215547,-0.0312675,-0.201156,0.244319,-0.396842,-0.269564,0.11644,0.130688,-0.0918948,0.072856,-0.123925,0.130025,0.195447,-0.773999,-0.00561138,-0.229596,0.100184,-0.22168,0.0664003,-0.496503,0.284793,-0.192413,0.895131,-0.293774,0.125028,-0.114775,-0.436255,0.160263,0.147461,-0.455335,0.598036,0.101713,-0.0416582,0.855644,-0.178895,0.149154,-0.559547,0.396843,0.566525,0.240519,0.152027,-0.106567,-0.305977,-0.183252,-0.0959261,0.50497,0.236685,-0.26114,-0.241303,-0.261974,0.746312,0.325328,-0.197812,0.152451,-0.531234,-0.609507,0.061397,-0.19778,-0.311649,0.711139,0.290198,0.27181,0.0588726,0.158062,-0.0654124,-0.287766,-0.417265,0.13929,-0.242445,-0.209717,-0.275366,-0.0862902,-0.00889403,0.392861,0.224586,0.52416,0.15247,-0.141993,-0.156129,0.464697,0.407119,0.0278065,0.124333,0.0369014,0.269889,-0.340657,-0.571376,-0.0290536,0.445939,0.249985,-0.584968,-0.0172377,-0.422111,0.0116411,0.113869,0.221514,0.420197,-0.300646,0.237845,-0.438916,0.568006,-0.602216,0.598499,0.0364503,-0.315717,0.113425,0.0167191,0.435237,-0.46485,-0.28027,-0.322483,-0.0152505,-0.0566397,-0.73623,-0.281599,0.257747,0.0986476,0.261721,0.314082,0.511586,-0.585219 +3437.63,0.932988,0.0848144,4,1.40029,1.07094,-1.22012,0.350705,0.173824,-0.118749,0.365623,-0.0482668,0.213016,0.0673116,-0.203154,-0.139214,-0.167756,0.447694,-0.0999578,0.7731,-0.138399,-0.00613885,0.36065,-0.124081,-0.63312,-0.594102,-1.10898,-0.0742462,-0.239106,-0.0580493,-0.06171,0.447067,-0.399985,0.0863418,0.787271,-0.235563,0.0906441,0.0390398,-0.554387,0.224017,0.253794,0.187229,0.250688,-0.0722663,1.39769,1.11786,0.237863,-0.597194,0.271627,0.507535,-0.441702,-0.0116486,0.90096,-0.353659,0.500261,0.243825,0.183824,-0.533418,0.215967,-0.123744,-0.429331,-0.167043,0.356065,0.238106,0.899068,1.38618,-0.48518,-0.875082,0.395148,0.195905,0.415351,-0.255621,0.0458741,-0.588407,0.116389,0.405647,0.500083,-0.0866508,0.567889,0.42577,0.166619,-0.136458,-0.0131103,0.41847,0.145211,-0.230615,0.0464336,0.245249,0.0723403,0.230079,0.349017,0.105801,-0.0807766,-0.491263,-0.261079,0.70437,0.260785,-0.266523,0.0854389,-0.0258046,0.215884,-0.143192,0.0442729,0.261906,0.322566,-0.440754,0.197815,-0.206477,-0.0615904,-0.114039,0.674779,-0.239303,0.28516,0.139326,0.0573077,0.0933693,0.227083,0.561811,-0.20806,0.515599,0.168918,0.273923,-0.063483,-0.0511006,-0.644209,-0.285321,0.0438966,0.119896,0.129876,0.261363,0.377666,-0.0802924,0.12331,-0.158067,0.201985,0.181954,0.397756,0.633143,-0.0638384,-0.306262,-0.123866,0.122349,0.360878,-0.230197,-0.430848,-0.145261,-0.0101805,0.0593446,0.0216461,0.0109457,-0.431365,0.321241,-0.149968,-0.372288,-0.320194,0.309709,0.103606,-0.182481,0.376572,0.531355,0.127128,0.355718,0.0924248,0.0979622,0.668364,-0.500761,0.5802,0.212336,0.60962,0.396799,-0.364889,0.647391,-0.339774,-0.20668,0.362614,0.108657,0.174933,0.0580185,0.361619,0.381281,-0.237755,0.0576112,0.596079,0.252452,-0.672604,-0.678973,0.133668,0.435398,0.150188,-0.239175,0.00682872,-0.245586,0.350364,-0.43987,-0.305006,-0.0393992,0.204821,-0.0900008,0.0656137,-0.121868,0.149655,0.243018,-0.832065,0.00476807,-0.195535,-0.0700809,-0.146088,0.0765068,-0.402944,0.247635,-0.199451,0.890721,-0.389419,0.114367,-0.121636,-0.346036,0.0721906,0.179694,-0.520478,0.5645,0.0897089,-0.0738705,0.842898,-0.199733,0.0525573,-0.582011,0.414104,0.554339,0.260177,0.136454,0.0306783,-0.233009,-0.0765568,-0.0606594,0.45194,0.307913,-0.230022,-0.197881,-0.199102,0.64608,0.239353,-0.166672,0.101011,-0.519617,-0.572888,0.00275567,-0.283883,-0.2655,0.745607,0.310942,0.264339,-0.00960327,0.133631,-0.0545355,-0.240272,-0.366543,0.275552,-0.245869,-0.104374,-0.234226,-0.175761,-0.0702317,0.424707,0.309435,0.459068,0.127827,-0.0325132,-0.127945,0.483678,0.35287,0.0465416,0.0498096,0.181574,0.292039,-0.321534,-0.764018,0.0457927,0.52683,0.368293,-0.60645,-0.117283,-0.449032,0.0663878,0.0509244,0.340558,0.444787,-0.177779,0.220765,-0.401515,0.574652,-0.551776,0.534154,-0.0295447,-0.193801,0.155446,0.0907709,0.477128,-0.389,-0.317189,-0.151871,-0.109079,-0.0490952,-0.721972,-0.170593,0.312174,0.100284,0.257613,0.316676,0.507555,-0.73198 +3435.71,0.919116,0.0848144,4,1.4268,0.962399,-1.32476,0.400596,0.518926,-0.0135124,-0.0892681,-0.0684112,0.0941991,0.358442,0.291863,-0.3497,0.0856337,0.208264,-0.25778,0.828615,0.160282,0.32474,0.0564251,0.149328,-0.613126,-0.720531,-0.838889,0.158471,-0.217287,-0.0161703,0.0688702,0.487302,-0.576168,-0.244571,0.733339,-0.563874,0.120262,0.102653,-0.114924,0.0298217,-0.499079,0.531917,0.721787,-0.312437,1.14072,0.674507,0.171851,-0.595,0.0618162,0.313133,-0.481481,0.114392,0.527469,-0.00560117,0.631042,0.798243,0.478331,-0.401833,0.469931,-0.480944,-0.0658131,-0.964562,0.413384,-0.159237,0.70872,1.7047,0.0572183,-0.971879,0.659465,0.0171438,0.100266,-0.0621046,0.378006,-0.298337,-0.258663,0.390395,0.534297,0.303111,0.533877,0.347005,0.0855477,0.140363,-0.114917,0.482374,0.259484,0.173487,0.156047,0.298667,0.0946855,-0.031108,-0.193922,0.389701,-0.0452759,-0.269161,-0.108587,1.08905,-0.186846,0.221964,0.455757,0.0485818,0.0361663,0.0211833,0.416434,0.022335,0.0187409,-0.126037,-0.16084,-0.562328,-0.0703024,0.247374,0.404155,0.0563757,0.539572,0.455182,-0.406307,-0.366789,0.465431,0.589686,-0.0424733,0.528364,-0.164131,0.359244,0.291207,0.268642,-0.894427,0.0121649,0.417428,-0.0841082,0.376028,0.149078,0.694709,0.0346256,-0.0792741,-0.262978,0.459426,0.0429917,0.161376,0.55649,0.183296,0.248956,-0.139464,0.0791227,0.46463,-1.06995,-0.599151,-0.053648,0.291601,-0.205738,-0.0657229,0.42162,-0.523282,0.226122,-0.209633,-0.162401,0.304566,0.455425,0.0172329,-0.131373,0.32788,0.534086,0.149001,0.464868,0.146965,0.340624,0.248397,-0.193851,0.429344,0.206182,0.10828,0.332708,-0.00380416,0.235107,-0.450743,0.204113,0.392436,-0.182866,0.0670999,0.163285,0.160659,0.263619,-0.111242,0.0988852,0.223608,0.47148,0.0969592,-0.235094,0.317684,0.364707,0.0643077,0.27397,0.452035,-0.23725,0.716919,-0.87742,0.175207,-0.409302,-0.113976,-0.441626,-0.0259651,-0.288368,-0.134486,-0.303154,-0.348001,-0.0587651,0.0625841,-0.675037,0.0136152,0.277876,0.392174,-0.297124,0.0147472,0.774165,-0.32379,0.114452,0.182622,-0.519027,-0.219466,0.30985,-0.104433,0.295831,0.0630648,-0.191872,0.376844,-0.436239,0.235688,-0.554466,-0.29211,0.0361406,0.310946,0.154032,-0.035909,-0.337914,0.384635,0.0965488,-0.0706307,0.164812,-0.0814201,-0.337145,-0.448941,0.440189,0.534827,-0.396214,0.043378,-0.656704,-0.520085,-0.00315657,-0.0819509,-0.187244,0.639684,0.20139,0.091906,0.404802,-0.121466,-0.637431,-0.20751,-1.07696,0.175841,-0.156999,-0.58227,-0.187124,-0.315884,-0.00952654,0.223994,-0.224307,0.720103,0.545215,-0.297928,-0.499233,0.211081,0.514344,-0.228772,-0.413434,0.177159,0.322287,-0.0845647,-0.54528,0.0883467,0.512789,0.190785,-0.246434,0.313049,-0.23303,0.142235,0.272484,-0.320392,0.190775,-0.356025,-0.044069,-0.103398,0.406992,-0.63088,0.354035,-0.206743,-0.0688569,0.338338,0.257249,0.0846205,0.0501613,-0.175792,-0.475687,-0.452831,-0.217721,-0.421243,-0.549178,0.342024,0.140624,0.308638,0.374999,0.555552,-1.67788 +3451.04,0.55868,0.0848144,4,1.58692,0.873819,-1.02051,0.224041,0.0116696,-0.0978383,0.314533,0.247985,0.032363,-0.457135,-0.247512,-0.20262,-0.60728,0.177587,-0.298164,0.323342,0.0961115,-0.357344,0.0181022,-0.164674,-0.0779836,-0.817519,-1.05667,0.368814,-0.495091,-0.52354,0.201317,-0.214262,-0.203357,-0.0736924,0.517275,-0.375649,-0.474943,0.234287,-0.312548,0.254742,-1.03628,0.839156,0.044214,-0.477799,1.32061,1.10889,0.50621,-0.978089,0.2883,0.112043,-1.28857,0.0785287,0.801088,0.073245,0.153773,0.388257,0.175508,-0.445149,0.527068,0.0474993,-0.265687,-0.569523,0.29507,0.147866,0.49775,0.826095,-0.63513,-0.976456,0.152906,-0.0839394,-0.0375083,0.310615,0.202858,-0.487667,-0.0566673,0.234184,0.702865,-0.0139824,0.886066,0.699378,0.0062821,-0.102441,-0.0893173,-0.0363753,0.0950739,-0.488871,-0.285466,-0.213145,0.21265,-0.21494,-0.369307,-0.184431,0.200946,-0.584164,0.317547,-0.328358,-0.100931,0.137186,-0.237958,0.0172719,0.470249,-0.308352,0.338916,0.214711,-0.250805,-0.394001,0.0487458,0.0184571,0.340833,0.149463,0.048176,-0.845725,0.0993395,0.579726,0.281174,0.0155881,-0.00181752,0.687164,0.460173,0.0286713,0.0734139,0.0492669,-0.378117,-0.352903,-0.283086,0.0711549,-0.0660999,-0.145387,-0.348053,0.133231,-0.775973,0.170156,0.229903,-0.307117,0.0852305,0.0585801,0.234727,0.480991,-0.57573,-0.254631,-0.103735,-0.173802,0.372636,-0.335033,-0.238142,-0.0340886,0.349499,-0.354947,0.171914,0.122954,0.196142,0.502829,-0.0418982,-0.308472,-0.488237,-0.0613002,0.119673,-0.415949,0.156711,0.508723,0.325626,-0.0771271,-0.0444387,0.0178971,0.170556,0.379506,0.573842,-0.346269,0.167983,-0.0194685,-0.194743,-0.509583,-0.134839,0.202025,-0.0592472,-0.0751828,0.363906,0.327113,-0.177499,0.156885,0.0982171,-0.276711,-0.117342,0.617803,0.246708,0.0156009,0.0103822,0.0157959,-0.0176441,-0.225537,0.0723227,-0.158163,-0.0260527,0.18732,0.188398,0.166713,0.200007,-0.595981,0.00947985,0.37732,0.0496059,-0.144862,-0.238997,0.360654,-0.469201,-0.166813,0.505227,0.0840236,0.233323,-0.172143,-0.471491,0.872648,0.116917,0.526288,-0.403951,-0.303328,0.118164,-0.0755029,0.148864,0.587574,-0.264628,-0.445419,-0.108428,0.212022,0.465299,-0.534604,0.329643,0.589264,-0.108697,0.151698,0.079329,-0.4838,-0.180834,-0.0915293,-0.18074,0.463088,-0.818357,0.00892127,-0.18731,0.763736,-0.255224,0.422706,0.373454,-0.468763,-0.256347,0.147097,0.190709,0.28958,0.456101,0.230685,0.442201,0.123141,-0.467511,-0.00357595,-0.0034587,-0.431961,0.284649,-0.367265,0.0912779,-0.0211058,-0.582603,0.292599,0.686051,-0.00392263,0.10861,0.11285,0.106361,0.276798,0.47725,0.122858,0.0801732,-0.117017,-0.00164525,-0.044355,-0.180258,0.130314,-0.194414,-0.411907,0.292087,-0.149546,-0.176903,-0.00509414,0.437997,0.0662093,-0.104365,-0.51119,-0.302191,0.148893,0.347969,0.1017,-0.27521,0.400747,0.123121,0.435084,0.142121,0.0907537,0.394211,0.0642156,-0.00264015,-0.371033,-0.80028,0.0372395,0.14032,0.106351,-0.494831,0.105999,0.298672,0.325576,0.546509,0.351494 +3415.45,0.707908,0.0848144,4,1.57113,0.924046,-1.24123,0.282615,-0.026964,-0.140852,0.294982,0.0107162,0.169389,-0.36852,-0.436012,-0.245916,-0.535253,0.240285,-0.155647,0.370834,-0.125855,-0.416715,-0.197063,-0.16941,-0.507977,-0.912184,-1.50792,0.192165,-0.253512,-0.338674,0.0197336,-0.0127555,-0.526392,-0.377801,0.761263,-0.183263,-0.220147,0.166825,-0.220037,0.158432,-0.772032,1.02045,0.415934,-0.207578,1.45921,0.922038,0.722898,-0.929227,0.408514,0.208633,-1.20939,0.116163,0.587394,0.0401769,0.405257,0.249572,0.593341,-0.22281,0.370312,0.048825,-0.191721,-0.531695,0.367172,0.23068,0.676994,1.0334,-0.869886,-0.875167,0.808716,-0.0631131,0.0223559,0.313179,0.0348669,-0.249611,-0.268544,0.0408652,0.669505,0.0653983,1.019,0.864156,-0.338558,-0.185819,-0.274816,-0.148945,0.194458,-0.194877,-0.175576,-0.221924,0.392686,-0.361222,0.073736,0.280899,0.631681,-0.619794,-0.0258497,-0.0772334,-0.0959338,0.068738,-0.214242,0.248757,0.730434,-0.301092,0.159207,0.381225,-0.450986,-0.393247,-0.0410144,-0.366999,0.295503,0.745027,0.592634,-0.650467,0.0005937,0.503554,-0.13521,-0.272163,-0.36892,0.753446,0.149677,-0.20078,-0.0778689,0.355953,-0.257643,-0.401091,-0.0886297,0.0785662,0.291904,0.271248,-0.240666,0.198307,-0.463452,0.179138,-0.0235797,-0.277413,-0.205207,0.164643,0.537132,0.140794,-0.232249,-0.088476,-0.40657,-0.0260658,0.337415,-0.324557,-0.711903,0.00316539,0.0357807,-0.311072,0.251967,-0.241794,-0.123969,0.517828,0.0971034,-0.0880873,-0.378042,0.204182,0.0239387,-0.172784,-0.164307,0.85975,0.59885,-0.0138587,0.219824,0.00477899,-0.144912,0.504702,0.564935,-0.546234,0.384882,0.094375,-0.263862,-0.584298,-0.192675,0.309953,0.166828,0.0558031,0.23584,-0.234516,-0.154796,-0.0533136,0.30226,0.0146814,0.368324,0.650646,0.274701,0.216736,0.257035,0.106666,0.273653,-0.118498,0.245654,-0.459337,-0.000542745,0.0129835,0.114422,0.222609,0.478702,-0.295396,-0.0218491,-0.0120307,-0.00307671,-0.0534237,-0.475414,0.580827,-0.156737,-0.02818,0.107675,0.253947,0.223888,-0.00614169,-0.417038,0.831464,-0.314729,0.231124,-0.406322,-0.35328,0.378874,-0.0532886,0.198927,0.0405978,-0.498627,-0.580847,-0.243922,0.018815,0.320542,-0.45326,-0.0411063,0.557972,-0.0413344,0.286218,-0.390211,-0.607361,0.154811,0.0189882,0.0697603,0.555851,-0.754612,-0.314567,-0.34725,0.673929,0.0719659,0.496179,0.593082,-0.160216,0.00944151,-0.0734637,-0.296196,0.097195,0.361955,0.425197,0.204364,0.0798352,-0.433067,-0.358672,-0.0896572,-0.47624,0.396138,0.108166,0.0449743,0.0709163,-0.86607,0.208876,0.416362,-0.204229,0.0507415,0.112097,-0.0361355,-0.279066,0.602594,-0.0766156,-0.0980497,-0.264788,0.0889004,-0.122834,-0.0643087,-0.205276,-0.556594,-0.0867173,0.0466595,-0.568864,-0.308504,-0.18897,-0.0520505,0.345742,-0.272745,-0.262248,-0.184593,0.167248,0.0235319,0.38913,-0.35026,-0.206843,-0.0209916,0.483809,0.20171,0.349925,0.729226,0.124874,-0.116098,-0.911022,-0.981022,0.112506,0.307855,-0.402126,-0.0252725,0.119223,0.29519,0.345287,0.543314,0.446334 +3434.51,0.964386,0.0848144,4,1.57903,0.913312,-1.30244,0.342084,0.237633,0.0082129,-0.0519954,-0.236632,0.124069,-0.0414923,-0.130473,-0.352798,-0.876455,0.123236,-0.655304,0.467075,-0.0861428,-0.292966,-0.0727216,-0.162748,-0.181392,-0.553883,-1.19694,-0.0104566,-0.192488,-0.679048,-0.0877418,-0.0332208,-0.548622,-0.431239,0.568566,-0.338804,0.00801538,0.117998,-0.187058,0.115666,0.100093,0.692028,0.547303,0.168115,1.26792,0.790049,0.592596,-1.14776,0.123526,0.00368933,-1.15438,0.313261,0.799077,0.165084,0.163398,0.526359,0.353672,-0.554881,0.421646,-3.65584e-05,-0.129839,-0.675357,0.160768,-0.366959,0.767816,0.917248,-0.839914,-0.859848,0.368459,-0.233724,-0.108352,0.325019,-0.0907618,0.0060623,-0.4259,0.379288,0.514619,-0.383804,0.549805,0.461669,0.207759,-0.111931,-0.170066,0.00669296,-0.00831236,-0.289359,0.0750544,-0.551159,0.215307,-0.0981195,-0.0117464,0.171819,0.115783,-0.397172,-0.0715956,-0.0513475,0.132516,0.112515,-0.0869545,0.0500021,0.287533,-0.26169,-0.116381,0.257623,-0.207501,-0.14991,0.271073,0.0129958,0.428501,0.504748,0.566371,-0.616573,0.218439,0.57265,0.309522,-0.429492,-0.191767,0.664095,-0.0720735,0.209546,-0.437158,0.131415,-0.125534,0.059085,-0.499181,-0.107089,0.515413,-0.273885,-0.0241333,0.115906,-0.150331,0.39249,0.162131,-0.141028,-0.151,0.259944,0.180069,0.151254,-0.171372,0.0700307,0.0387461,-0.117339,0.194089,-0.386012,-0.962598,0.1029,0.0374215,0.0230163,0.0138057,0.300514,-0.0466197,0.283202,-0.151415,-0.141125,-0.0293519,0.0792185,0.0629813,-0.0258174,-0.101961,0.695765,0.450692,-0.251665,0.00678188,0.20743,0.185368,0.0200781,0.15315,-0.478402,0.601918,-0.38808,-0.0409507,-0.269428,-0.333942,0.233012,-0.11759,0.0735727,0.438221,0.0226442,0.359717,-0.377139,0.103923,0.0023976,-0.23143,0.76944,0.132913,0.239427,0.11257,-0.195387,0.044337,-0.0639895,0.331757,-0.783743,0.0979239,-0.143536,0.592896,0.340354,0.778625,-0.208836,-0.261349,0.179147,0.128903,-0.244216,-0.0482198,0.259263,-0.2994,0.177502,0.381634,-0.134182,-0.0847763,0.329903,-0.711734,0.639364,-0.0853778,-0.350298,0.144489,-0.417286,0.357092,0.307506,0.114701,0.280466,-0.194387,-0.289657,0.0477949,-0.0313756,0.41971,-0.488441,0.365454,0.46572,-0.112014,0.383788,-0.0965673,-0.27684,-0.351109,0.0832272,0.467055,0.152726,-0.527863,-0.0135219,-0.270693,0.626083,0.171675,-0.191538,0.546546,-0.289794,0.40776,-0.0737832,-0.676409,0.254795,0.378182,0.430884,0.649341,0.363552,-0.646139,-0.596796,0.232048,-0.688336,0.411806,-0.0292557,0.0566696,0.130983,-0.448473,0.182042,0.582722,-0.199953,0.0459177,0.152823,-0.00626138,-0.0495712,-0.0711964,0.312404,-0.1036,-0.274983,-0.0658187,-0.0796952,-0.171921,-0.503915,-0.162756,0.217592,0.342308,-0.0262873,-0.122153,0.0398448,0.0808746,0.800076,-0.137407,-0.130585,-0.332947,-0.43331,0.141425,0.0570059,0.0138647,-0.529142,-0.216515,0.564825,0.226246,0.044167,0.123102,0.119785,-0.078907,-0.659279,-0.873158,0.0743605,0.494766,-0.540572,-0.202835,0.12738,0.277407,0.356903,0.526694,-0.466697 +3454.22,0.999181,0.0848144,5,1.5844,0.8323,-1.25164,0.454327,0.281341,-0.143922,0.0266516,-0.122406,-0.0455032,-0.00155809,0.00645367,-0.509921,0.203495,0.201268,-0.100718,0.70978,-0.0332419,0.0717566,-0.387641,0.0352787,-0.343078,-0.837965,-0.805231,0.397886,0.175766,-0.0508076,-0.246685,0.395573,-0.0485556,0.0727017,0.888657,-0.512156,0.0333349,-0.0667623,-0.536796,-0.0574205,-0.529258,0.511629,0.431189,-0.672816,1.19473,0.507235,0.00370675,-0.530654,-0.00154997,0.374691,-0.307748,0.26143,0.416567,0.0948666,0.371206,1.14419,0.445933,-0.992539,0.637115,-0.00501686,-0.346439,-0.352619,0.309019,0.0340611,0.508818,0.814417,-0.619242,-1.05544,0.124192,0.0493715,-0.100861,-0.151223,0.606671,-0.439153,0.400417,0.37816,0.905147,0.290379,0.399218,0.550572,0.196572,-0.173034,-0.136256,0.0730625,0.272602,-0.444718,-0.0470562,-0.0887283,0.00345503,-0.52562,-0.589696,-0.521117,0.432338,-0.523595,0.177069,-0.167646,0.300486,0.173083,0.119128,-0.437724,-0.294614,-0.133372,0.129455,-0.0491693,0.229008,-0.12336,-0.509996,-0.744627,-0.273978,0.00610364,0.092121,-0.0570004,0.129642,0.397761,-0.468691,-0.196756,0.250084,0.158151,0.00573097,0.298011,0.181669,-0.0278353,0.204809,-0.386799,-0.412612,0.24891,-0.401611,0.319314,0.147388,0.447499,0.464877,-0.532843,0.469026,-0.189618,0.214111,-0.00576004,-0.166063,0.512902,0.276988,-0.22754,-0.0266916,0.0394612,0.456133,-0.580774,0.451861,-0.3987,-0.549764,-0.580761,0.156053,-0.0706924,0.156143,0.462254,-0.466573,-0.229891,-0.550014,0.630299,0.141653,-0.010058,0.574729,-0.067805,-0.156153,0.245904,-0.118653,-0.0818,0.184564,0.274453,0.870674,0.378057,-0.229012,0.609402,-0.329833,-0.194429,0.0348237,-0.177207,0.257829,-0.0866372,-0.365127,-0.134477,-0.259898,-0.100994,-0.231846,-0.0468567,-0.132058,0.592587,0.19629,-0.0925024,0.0937026,0.151851,0.170849,-0.0401541,-0.505675,0.163317,0.563453,-0.618842,-0.269615,0.0643338,-0.446988,-0.421316,0.393872,0.2637,0.100804,-0.259987,-0.822168,0.297628,-0.0854392,-0.619641,-0.463707,0.132099,0.0298617,-0.380049,-0.0934584,0.559419,0.287439,0.351513,0.398853,0.0153072,-0.379246,-0.262406,-0.468444,0.251946,0.125327,0.1621,0.28335,-0.1762,0.053996,-0.357642,-0.32845,-0.0542236,-0.670796,0.12599,-0.132638,-0.0752958,-0.143351,-0.447892,-0.263311,0.0823585,0.120402,-0.233281,-0.00542556,0.37125,-0.430622,-0.133504,0.571685,-0.238542,-0.612715,0.0463266,0.40691,-0.168849,0.313186,-0.187712,0.382961,0.0278249,-0.22656,0.252924,0.0280152,-0.281879,0.393016,-0.511601,-0.0500504,0.181222,0.0894628,-0.387648,-0.301402,-0.0130402,-0.22016,0.391699,0.573877,0.444372,-0.469181,0.0881326,-0.28025,-0.234487,0.188335,0.206085,-0.00811498,0.104253,-0.29699,0.122543,-0.302896,0.0673428,0.00847595,0.072424,0.486851,-0.239626,-0.0672126,0.0550399,0.0700241,0.258274,-0.247371,-0.00178341,-0.185324,0.432964,-0.0523023,-0.428782,-0.0887062,0.236216,0.211794,-0.283764,0.145335,-0.130367,0.44871,0.06087,-0.326056,0.0480328,-0.221566,0.122197,0.295487,0.349567,0.543587,-0.558314 +3420.49,0.907978,0.0848144,5,1.45215,0.794468,-1.29832,0.440651,0.549151,-0.155929,0.133838,-0.1091,0.317308,0.637841,0.432361,-0.20457,-0.922959,0.128068,-0.399511,0.741368,0.37218,-0.063398,0.112062,-0.169554,0.0380875,-0.469889,-0.518721,0.238525,-0.132748,-0.118383,-0.135266,0.430718,-0.21665,0.0883003,0.786119,-0.333975,-0.396194,0.609862,-0.359184,0.306947,-0.278096,0.924813,0.888335,-0.213855,1.18442,1.21648,0.972198,-0.0906126,0.370121,0.0385032,-0.816341,-0.0172607,0.533019,0.0334413,0.572077,0.332282,0.126991,0.372167,1.03292,-0.491453,-0.331295,-0.722985,0.420032,-0.195591,0.522515,1.34006,-0.419929,-0.580201,0.0711185,0.0688207,0.322656,0.327332,-0.523185,-0.104414,-0.331993,0.371628,0.604153,-0.0757797,0.356938,0.219971,0.367358,-0.0521914,0.181691,-0.111762,0.480511,-0.104695,0.236029,-0.437616,-0.242241,0.321699,0.44288,0.0227489,-0.37444,-0.376118,-0.293545,0.609016,-0.247117,0.000889497,-0.00138464,-0.101499,0.266312,-0.327482,0.364464,0.517162,-0.160515,-0.0414672,-0.227797,0.201413,0.532697,-0.331832,0.530865,-0.498038,0.0470945,0.464504,-0.118061,0.00479746,-0.118842,0.306318,0.431937,0.066885,-0.705107,0.438122,0.144877,-0.0319756,-0.776127,-0.438458,0.220939,-0.403311,-0.190688,0.169477,-0.226983,0.24724,-0.0303006,-0.0919504,0.203309,0.442446,0.0950848,0.239206,-0.51578,0.180905,0.119274,0.0257789,0.0765451,-0.357587,-1.0567,0.176511,0.296933,-0.140215,0.198536,-0.072549,-0.338449,0.183831,-0.0572163,0.126611,0.407808,-0.408884,0.236465,0.0732607,0.0305026,0.529228,0.126613,-0.0415905,0.349585,-0.160693,-0.0346279,-0.56526,-0.060629,-0.335367,0.430415,-0.381278,0.100909,-0.16225,-0.471281,-0.000129822,0.039519,0.269449,-0.140211,0.0638197,0.437876,-0.272542,0.018633,-0.193127,0.109026,0.452714,-0.384512,-0.0768463,0.322481,-0.427783,-0.479002,-0.264488,-0.151594,-0.421475,-0.019135,0.010521,0.699741,0.118845,0.457801,-0.552371,-0.411736,0.00765236,0.327543,-0.305244,-0.17981,-0.00708528,-0.195729,-0.058245,0.619793,-0.0820612,-0.295668,-0.113152,-0.611133,0.747248,-0.495038,-0.122237,-0.363106,-0.258064,0.253436,0.593719,-0.0644471,-0.0222178,-0.103973,0.219775,-0.205902,-0.394253,-0.386891,-0.528286,0.179641,0.679969,0.597608,0.369758,-0.334692,-0.386692,-0.107972,0.470606,0.166245,-0.57032,-0.219332,0.298613,-0.475593,0.682801,0.293148,-0.0909201,0.15286,-0.0909175,0.350551,-0.0159475,-0.29366,0.338078,0.26991,0.228823,0.613655,0.62765,0.0950505,-0.428987,0.0112655,-0.785126,0.382312,0.187657,0.179127,0.831775,-0.546317,0.146038,0.209234,0.104676,0.173699,0.00666966,0.201391,-0.210132,0.684802,0.205024,0.061445,0.0803642,0.00196741,-0.166579,-0.125868,-0.313635,0.0788784,0.190665,0.230505,0.226438,0.312479,-0.147709,-0.351271,0.254881,-0.312009,-0.206321,-0.427671,0.0320175,0.195525,0.261588,0.0201628,-0.177128,-0.138064,0.146159,-0.244068,0.0899107,0.32038,0.823392,0.0564113,-0.426699,-0.628827,-0.0903059,0.177686,-0.261318,0.43842,0.134148,0.323008,0.366263,0.568338,-1.47224 +3433.87,0.861139,0.0848144,4,1.44727,0.762286,-1.52839,0.548734,0.655378,-0.181339,-0.0999148,0.18143,-0.197051,0.334062,0.0550301,-0.337376,-0.545685,0.269597,-0.37005,0.463268,0.283931,-0.18041,-0.0607425,-0.387147,0.137866,-0.523846,-0.604621,0.290303,-0.328312,0.250234,-0.317632,0.379594,-0.233629,0.133501,1.01565,-0.633131,-0.544502,0.772229,0.0814904,-0.134379,0.17214,0.298029,0.998532,-0.332473,0.777472,0.960257,1.03356,-0.171257,0.369225,-0.137058,-0.550971,0.191887,0.501234,0.557744,0.351458,0.202455,0.387654,-0.0715512,1.03704,-0.332924,-0.217298,-0.995752,0.230627,0.0350642,0.393414,1.54032,-0.242478,-0.6841,0.218232,0.167259,0.237839,0.242266,-0.0996089,-0.370457,-0.335259,0.612201,0.579652,-0.179106,0.538817,0.0808526,0.786737,0.315278,-0.0501972,0.0412984,0.273004,-0.39076,0.332761,0.00630888,-0.0229977,0.40203,-0.0822249,-0.0240452,-0.305877,-0.38605,-0.0853254,0.336235,-0.558594,-0.214035,0.446231,-0.459321,-0.183664,-0.576339,0.324624,0.224928,0.0084108,-0.39624,-0.333265,-0.00209046,0.38609,-0.0859073,0.412203,-0.336479,0.299692,0.239732,0.0802136,-0.132022,0.095789,0.0909112,0.182851,-0.115213,-0.366875,0.309618,-0.00730538,0.043029,-1.04044,-0.0365445,0.456798,-0.652286,-0.0835102,0.316472,0.297827,-0.437337,-0.226485,-0.451562,-0.130433,0.146696,-0.0087513,0.634698,-0.645907,-0.181769,-0.0506437,0.464748,0.278337,-0.566493,-0.882809,0.129604,0.272187,-0.406112,0.128304,-0.298045,-0.0456679,0.449253,-0.178695,-0.185664,0.310878,-0.183486,0.471831,0.215847,-0.0563664,0.476824,0.213558,-0.111042,0.529451,-0.246205,0.164596,-0.477635,0.0532134,-0.281015,0.514195,-0.57028,-0.114758,-0.355335,-0.0103773,-0.0239161,-0.10725,0.0639182,-0.428453,0.172341,0.409438,-0.572603,-0.261841,0.0225871,-0.198325,0.415952,-0.263046,-0.223595,0.0209865,-0.526397,-0.434747,-0.529412,-0.303641,-0.204433,0.1215,0.191276,0.27743,-0.166675,0.244969,-0.962245,-0.264495,-0.0972128,0.377927,-0.428679,-0.305517,-0.253405,-0.185264,-0.644023,0.372681,-0.594045,-0.106749,-0.101853,-0.655852,0.947439,-0.38011,0.108713,0.00264332,-0.506068,0.0820626,0.0169769,0.314506,0.285958,-0.414932,-0.0450485,0.146282,-0.515138,-0.421798,-0.783655,0.560852,0.396579,-0.168771,0.569516,-0.747115,-0.437187,0.459301,0.315686,-0.348972,-0.280427,-0.500637,0.303659,-0.656268,0.87213,-0.48128,0.314061,0.205506,-0.534571,0.294551,0.0703965,-0.174112,0.500832,0.588142,-0.114407,0.558183,0.711976,-0.230364,-0.247825,0.207121,-0.551767,0.125538,0.197549,-0.326487,0.690623,-0.353915,-0.142424,0.670943,0.331818,-0.105802,-0.189209,-0.172187,0.388782,0.269681,0.321193,-0.0283592,0.353623,-0.0817788,-0.0261867,-0.257516,-0.0473185,-0.314772,0.050607,-0.0689172,0.143962,0.169374,-0.136163,-0.192222,0.120388,-0.509119,0.279303,-0.389813,0.192094,0.0297096,0.0880351,-0.524365,0.109454,-0.241947,-0.37275,-0.142702,0.057212,0.464965,0.38212,0.195066,-0.190713,-0.362206,0.0996275,0.0885196,0.0436444,-0.534531,0.116242,0.270477,0.340943,0.520074,-1.74815 +3399.44,0.872033,0.0848144,5,1.45695,0.882534,-0.753946,0.18595,0.375746,-0.12237,0.034283,-0.82658,-0.162673,0.242164,0.260328,0.0208039,-0.299839,0.063308,0.11541,0.648565,0.316448,0.0942557,-0.489896,-0.360194,-0.160374,-0.680732,-0.701263,0.175731,-0.0220706,-0.358816,0.0558068,0.655845,-0.61994,-0.450338,0.953638,-0.20525,-0.187181,0.522673,0.0817509,-0.153298,-0.542072,0.706735,0.700712,-0.386404,0.938234,0.980964,0.726176,-0.475825,0.513047,0.384458,-0.73826,0.209766,0.268385,0.212016,0.223046,-0.105713,0.444174,-0.75841,1.26387,0.0816393,-0.27839,-1.00969,0.429069,0.240543,0.573078,0.847482,-1.0788,-0.797711,0.332846,-0.160283,0.0241153,-0.0424844,-0.199117,-0.138599,-0.559492,0.692425,0.942546,0.0131069,0.82752,0.190834,0.0989897,0.328134,0.189694,-0.330632,0.296585,-0.0508867,0.435554,-0.29167,-0.107356,-0.34042,0.300419,-0.579232,0.500715,-0.319203,-0.49197,0.533634,-0.296791,0.05468,0.163894,-0.583302,-0.382124,-0.381072,0.233824,0.377713,-0.118701,-0.543638,0.0294815,-0.455701,-0.427372,0.337393,0.630486,-0.259974,0.10219,0.588813,0.00457392,-0.0887254,0.604466,0.219185,-0.142429,0.0341122,-0.0364783,0.440605,-0.0132125,-0.297551,-0.751053,0.00918234,-0.109015,-0.0200864,0.344796,0.461281,1.40753,0.38636,0.178721,-0.151046,0.140555,-0.140683,-0.0171873,0.460871,0.370325,0.177088,0.281744,0.348833,0.431063,-0.479906,-0.0847191,-0.0274905,-0.531167,0.199784,0.489648,-0.481881,0.301171,0.368467,0.0175787,0.231293,0.25475,-0.338042,-0.0133255,0.0637807,0.0177115,0.157408,0.345668,-0.0577354,0.289786,-0.398753,-0.23056,-0.332228,0.3895,0.527547,-0.526528,-0.0827921,0.0392402,0.15875,0.0376765,-0.136908,0.0987607,-0.120752,-0.109835,0.365391,-0.059883,0.0843691,0.454571,-0.987581,-0.461236,0.676405,0.304421,-0.713533,-0.755011,0.189082,0.242683,0.415347,-0.545198,-0.16834,0.228114,-0.232825,0.274514,0.245569,0.338367,-0.239128,0.257196,0.773863,0.134779,-0.30789,-0.630214,-0.0680878,0.315936,-0.361758,0.0491861,-0.266691,-0.322093,0.442475,0.0113497,0.789807,-0.308832,0.335764,-0.217402,-0.180567,-0.122882,-0.0801216,0.184539,-0.216808,-0.0693256,0.666063,-0.499771,-0.534562,-0.279096,-0.129205,-0.18537,0.199003,-0.40617,0.373429,-0.262647,-0.292515,0.265032,-0.546263,-0.685886,-0.137333,-0.694899,-0.151525,-0.148557,0.590879,0.179884,0.0700935,0.421698,-0.230495,-0.32333,0.177696,0.243396,-0.042297,0.6006,0.197174,0.332493,-0.341687,-0.154038,-0.521281,-0.0746303,-0.207366,0.462784,-0.0162433,0.288252,0.494122,-0.331551,-0.00102783,0.337811,-0.218601,0.00432395,0.88056,0.306525,-0.0399501,0.526936,0.564852,0.0270375,-0.396223,0.211402,-0.274272,-0.250019,0.633372,-0.192296,0.293874,-0.916618,0.166135,0.417374,-0.0967529,-0.0351713,0.47393,-0.389177,0.404821,-0.231538,-0.269919,0.655596,0.192007,-0.119415,0.0928445,0.294646,-0.0558007,-0.146229,0.631118,-0.141534,0.531639,0.190845,-0.757786,-0.0982327,0.00632019,-0.0880591,-0.222221,0.228666,0.152864,0.318359,0.390978,0.564233,-1.10034 +3390.78,0.818317,0.0848144,4,1.46223,0.787959,-0.987509,0.270533,0.163677,-0.0441643,0.00461266,-0.259825,0.0243185,0.659873,-0.0419047,0.362761,-0.60766,0.77432,-0.430251,0.741389,0.035226,-0.267547,-0.632826,-0.0985939,-0.0788666,-0.903528,-1.01368,0.29026,0.227029,-0.195344,-0.216579,0.147589,0.181987,0.00177818,0.647504,0.0504378,0.281028,0.97436,-0.171922,0.264711,-0.145502,0.148863,0.653466,0.11201,0.688155,0.935763,0.373181,-0.333749,-0.232671,-0.640477,0.0598573,0.186591,0.476495,0.314607,0.120285,0.0313447,0.212808,-0.313602,1.08728,-0.276037,0.414295,-0.326381,0.463354,-0.211528,0.156634,1.09854,-1.15843,-0.972791,-0.101153,-0.231302,0.0448937,0.193024,-0.365985,-0.245469,-0.686081,0.288437,0.49081,0.157179,0.347628,0.199365,0.48028,1.12207,0.0894373,0.0166182,0.449393,0.103933,0.174191,-0.210864,0.267464,-0.0427675,-0.19815,-0.0577499,0.169853,-0.136494,-0.371608,0.306496,-0.420716,0.302431,-0.172708,-0.169724,0.039663,0.315523,0.302229,0.39862,0.183992,0.173357,0.115116,-0.197915,-0.0310783,0.0474936,0.326611,0.214653,0.219129,0.527652,-0.471575,-0.497493,0.671562,0.347191,-0.148425,0.232481,-0.454225,-0.0651484,-0.0846382,0.549211,-0.787969,0.341601,-0.0292407,-0.5205,-0.429158,1.28353,0.610141,-0.168208,0.289284,-0.420931,0.456856,0.204124,0.452875,0.64926,-0.248997,0.0182114,0.910904,0.180376,0.377704,-0.0382076,-0.136482,0.00619012,-0.520891,-0.347594,0.328561,-0.0810594,-0.357686,0.817662,-0.0421685,-0.161012,-0.476509,-0.084258,0.186279,0.0714868,0.373895,1.0567,-0.178523,-0.173102,0.52389,0.177815,0.970165,0.250786,0.927389,0.00921094,-0.607076,-0.11697,0.281997,-0.205644,-0.132551,-0.367892,0.0550741,-0.164569,-0.209313,-0.272811,-0.149911,0.00111892,-0.122192,-0.435786,-0.637264,0.762475,-0.101961,-0.0258204,0.210083,-0.145225,-0.128494,-0.449619,-0.281182,-0.22833,-0.169229,0.377329,-0.272756,-0.137051,0.26836,-0.266068,-0.260137,0.117509,0.232051,-0.0685482,-0.471589,0.383811,0.0972155,-0.265183,-0.154459,-0.172148,0.439126,-0.22857,-0.213586,1.18771,-0.45018,0.147088,-0.705901,0.0712969,0.0303944,-0.392532,-0.57647,0.123465,0.000551697,0.286981,-0.125193,-0.541024,-0.117474,-0.232262,-0.0338103,0.0751767,-0.422085,0.535793,-0.384205,0.252874,0.57982,-0.354666,-0.271625,0.147439,-0.699994,-0.541885,-0.212279,0.587801,0.134347,0.198828,0.857005,-0.205837,-0.87553,-0.0127179,-0.0174602,0.141883,0.153635,-0.170802,0.1838,0.108784,0.355293,0.109123,0.111383,-0.453516,0.262462,-0.240766,0.340708,0.493933,-0.904767,0.577175,0.284363,0.49612,0.0745815,-0.141741,0.391135,-0.139735,0.380245,0.105938,-0.49106,0.055746,-0.353553,-0.663293,-0.143511,-0.635982,-0.635571,0.105514,-0.601684,-0.544816,0.234692,-0.401835,0.68361,-0.0437342,-0.0941898,-0.472526,-0.384489,-0.107128,0.0750479,0.117991,0.560996,0.92764,0.321366,-0.229588,0.0545545,-0.140233,-0.400026,0.62976,0.132393,-0.496765,-0.510947,-0.00985581,0.169364,-0.139975,0.0382824,0.138231,0.23486,0.371794,0.484624,-0.200883 +3407.23,0.878864,0.0848144,4,1.48653,0.795003,-1.1405,0.416434,0.277787,-0.156461,0.098308,0.0520476,0.241959,0.186597,0.239982,-0.299973,-0.314052,0.620341,-0.114355,0.738519,0.43699,0.465801,-0.242444,0.184314,-0.443425,-0.775794,-0.898052,0.260244,-0.249467,-0.00355167,-0.317682,0.0654103,-0.772173,-0.346389,0.678116,0.0506102,-0.392694,0.301643,-0.293062,-0.179957,-0.397288,0.275547,0.288822,-0.133498,0.983717,0.356091,-0.269404,-0.68315,0.029863,0.108322,-0.966528,0.713258,0.111218,-0.238188,0.12292,0.540033,0.276484,0.00668269,0.906178,0.350336,-0.212421,-0.656978,0.565247,-0.271613,0.51241,0.885768,-0.368753,-0.891676,0.430637,0.302202,0.220796,-0.086979,-0.103953,-0.278815,0.240759,-0.117926,0.353713,0.0731029,0.874545,0.40155,-0.00328109,-0.327465,-0.176342,0.336607,0.627245,0.227388,0.464553,0.113935,-0.500043,-0.189752,0.498559,0.261846,0.0214982,-0.50033,0.0364158,0.121708,-0.0120191,-0.0640004,-0.0673076,0.351609,0.197768,-0.359914,-0.318422,0.5352,-0.012574,0.16319,-0.321269,-0.174165,0.0256307,-0.619987,0.0646325,-0.47933,0.421203,0.509612,0.0157991,-0.458696,-0.262104,0.259182,-0.335437,-0.0580418,0.0500589,0.348863,0.722265,-0.245635,-0.354686,0.138133,-0.645354,-0.265821,0.129387,-0.225569,0.352204,0.199828,-0.00867652,-0.0989466,0.540281,-0.420537,0.33384,0.00240707,-0.188755,-0.387158,-0.833894,-0.124978,0.407145,-0.446087,-0.0734153,0.196741,0.1853,-0.70593,0.618091,0.0627086,0.395013,0.306139,0.0624984,-0.488141,-0.0603751,-0.334741,0.260915,-0.0106796,0.183029,-0.00741297,0.57512,-0.00798098,-0.168219,0.240937,-0.00852135,-0.108343,0.749838,0.456179,0.133027,-0.151139,0.167917,-0.147196,-0.372529,-0.0615828,0.356046,-0.0747712,-0.0135908,-0.0288917,-0.357307,-0.205577,-0.414744,-0.0495864,0.239601,0.520564,-0.0801983,0.116757,0.0159159,-0.139387,-0.32807,0.176492,0.0667017,-0.161759,0.147018,-0.243206,0.115469,-0.263987,0.13402,-0.84089,0.22996,0.475733,-0.260962,-0.11549,-0.973274,0.594456,-0.0678447,-0.657849,0.65225,-0.116528,0.149104,0.164922,-0.249582,0.757785,-0.323245,0.0818736,-0.206206,-0.224859,0.25796,0.213846,0.532342,0.215308,-0.32721,0.342236,0.739024,0.42697,-0.0339101,-0.757973,0.143062,0.40124,-0.359603,0.496088,-0.103219,0.0712731,-0.416803,0.350874,0.252292,-0.189415,0.312469,-0.154282,-0.484377,0.119049,0.251233,-0.405445,0.0536232,0.326337,0.467426,-0.542846,-0.198823,0.103797,0.681321,-0.31117,0.536886,0.0452788,-0.26153,-0.732971,-0.145867,-1.0148,0.196795,-0.448933,0.314988,-0.0414176,0.676021,-0.110028,-0.133143,-0.053058,0.444204,0.513673,0.39604,0.397912,-0.305439,0.62349,0.640957,-0.374637,-0.258106,0.0880596,0.0452318,0.150901,0.0426093,0.553677,-0.262865,-0.239383,0.274475,-0.17008,0.587233,-0.0456892,-0.0838204,0.222302,-0.0716707,0.258126,0.667837,0.57128,-0.206527,-0.076413,0.0893822,-0.629838,-0.129721,-0.666427,-0.046056,-0.345799,-0.179052,-0.219046,0.949482,-0.392131,-0.0936495,0.126686,-0.382169,0.118504,0.260155,0.344245,0.510054,-0.597768 +3420.02,0.670814,0.0848144,4,1.54523,0.81567,-1.02385,0.402588,0.360023,-0.111996,-0.0356387,0.0204453,0.22622,0.229068,0.0895539,-0.276457,-0.122429,0.782843,-0.178413,0.678949,0.295893,0.320751,-0.4148,0.347149,-0.251169,-0.9319,-0.939721,0.273878,-0.187687,-0.0324833,-0.353235,-0.140059,-0.827244,-0.27967,0.774538,0.262218,-0.293919,0.403301,-0.346148,-0.0417189,-0.33964,0.459206,0.338395,-0.163689,0.697675,0.236725,-0.315108,-0.668851,-0.0699098,0.173265,-0.940563,0.601193,0.0894866,-0.0361775,0.291265,0.450386,0.226271,-0.14866,0.881236,0.301945,-0.230107,-0.913763,0.504917,-0.500033,0.482407,1.05018,-0.642596,-0.916381,0.754546,0.423595,-0.0368988,-0.271193,-0.110713,-0.243905,0.277856,0.0486343,0.372741,0.024563,1.01056,0.288938,0.0433424,-0.179814,-0.320482,0.545088,0.765012,0.065812,0.362317,0.136125,-0.856888,-0.12913,0.411497,0.0508865,-0.0620845,-0.627879,0.214952,0.337195,0.0994376,-0.0892031,0.0346249,0.388224,0.177313,-0.33913,-0.156181,0.479463,-0.116469,-0.239382,-0.192329,0.116935,0.434491,-0.494941,0.0372772,-0.394933,0.300811,0.45949,0.0254166,-0.361797,-0.0702651,0.15828,-0.158538,0.0808848,-0.0944983,0.355892,0.523416,-0.169671,-0.397984,-0.0331644,-0.295184,-0.0934761,0.419647,-0.0593954,0.0602358,0.330526,-0.214849,-0.123611,0.447318,-0.223315,0.310804,-0.0473425,-0.306089,-0.555322,-0.849247,-0.281754,0.331383,-0.563391,-0.221635,0.082546,0.137407,-0.486979,0.584195,0.0167987,0.48986,0.402333,0.233089,-0.85122,-0.0837536,-0.263644,0.225689,-0.137607,0.183155,0.240542,0.442478,0.141897,-0.213825,0.023436,-0.183225,-0.059891,0.569971,0.440032,0.110339,-0.114076,0.17671,-0.240353,-0.254541,-0.0115526,0.148282,0.16032,-0.153991,0.134958,-0.170978,-0.277836,-0.347662,0.152324,-0.0357564,0.64351,0.168788,-0.00426246,0.201658,-0.0848984,-0.0866492,0.0341939,-0.146259,-0.188237,0.386082,0.00278589,0.101755,0.00977091,0.349299,-0.849973,0.10788,0.727278,-0.250078,-0.213955,-0.843153,0.456743,0.021371,-0.520765,0.57013,0.126874,0.229716,0.319571,-0.29009,0.94923,-0.0232759,0.000730609,-0.300898,-0.321689,0.256968,0.162211,0.530983,0.237126,-0.201172,0.353995,0.72709,0.370445,-0.0220334,-0.528433,0.096003,0.364447,-0.55332,0.584037,-0.165318,-0.0329094,-0.223818,0.284348,0.316939,-0.237785,0.346782,-0.0470234,-0.442881,0.349099,0.314861,-0.260657,0.157112,0.194193,0.591309,-0.634431,-0.140299,0.00263163,0.690702,-0.0562005,0.683569,0.300782,0.0641088,-0.525705,-0.289558,-0.995041,0.231544,-0.428309,0.327461,0.129308,0.567158,0.0111054,-0.0560983,-0.201762,0.441812,0.384376,0.153631,0.5005,-0.205166,0.711834,0.610951,-0.0716132,-0.322696,0.034755,-0.00105624,-0.293677,0.0567134,0.467646,-0.515112,-0.137828,0.181958,-0.00996817,0.48651,-0.06743,-0.266765,0.040112,-0.0641134,-0.153329,0.819418,0.555725,-0.212899,-0.138608,0.000577603,-0.140916,-0.0179072,-0.59164,-0.170082,-0.145173,-0.231552,-0.196419,0.7656,-0.193824,-0.172481,0.0915708,-0.352866,0.117786,0.371035,0.3432,0.609126,-0.907889 +3407.9,0.952707,0.0848144,4,1.4568,0.891984,-1.54197,0.661679,0.133609,-0.159163,0.142291,0.600269,0.281022,0.23663,-0.103061,0.352278,0.32955,0.472049,0.0937945,1.0331,0.180546,0.208083,-0.0414972,-0.0917427,-0.275048,-0.253895,-0.713388,0.397701,-0.0537737,-0.102096,0.267512,0.652468,0.0271155,0.100185,0.544979,-0.957123,-0.238019,0.540708,-0.570244,-0.0759273,-0.404813,0.693354,0.375404,0.056542,0.974927,1.13899,0.916155,-1.33027,-0.209093,-0.137918,-0.105299,0.373786,0.0464582,-0.130092,0.459494,0.639176,-0.228821,-0.22272,0.126868,-0.189672,-0.283862,-0.284268,0.18949,0.0748636,0.382728,0.877517,-0.350146,-0.554865,0.10814,0.169604,-0.136169,-0.0495146,0.407203,-0.319362,-0.546103,0.00183507,0.787474,-0.0670521,-0.242023,0.211119,0.0598821,0.170232,-0.244775,0.0493794,-0.162997,-0.207946,-0.0494536,-0.450624,0.332487,-0.0330382,-0.333202,0.249802,0.345664,0.455049,0.0560975,0.271352,-0.470559,0.14479,0.07556,-0.697229,0.207773,-0.124488,0.0773328,0.0233667,0.154099,-0.132193,-0.26943,-0.854808,0.192125,0.303934,0.155254,0.459664,0.444555,0.172733,-0.458006,0.00662448,0.350504,0.281931,0.0667491,0.199779,-0.247671,-0.301669,-0.115965,-0.569766,-0.737187,-0.451897,-0.493834,-0.200725,-0.36134,-0.0471206,0.247131,0.086143,0.666745,-0.730932,-0.410958,0.0535409,-0.389041,0.727947,-0.229256,-0.0315626,0.820127,-0.042487,0.935008,-0.559152,-0.232904,-0.0766753,0.274802,-0.259647,-0.465861,-0.367961,-0.53388,0.334148,0.0546815,0.893394,-0.174983,-0.13631,-0.1477,0.0736665,0.545373,0.312747,-0.0761346,-0.245255,0.203337,-0.376699,0.732962,0.372657,0.254878,-0.119758,-0.12023,0.21652,0.230687,0.0353221,-0.40646,-0.0584172,0.15726,-0.324332,-0.00265162,-0.616363,0.126562,0.345775,-0.308179,-0.0950427,0.587274,0.494308,-0.0924005,-0.0847888,-0.0156648,-0.481818,-0.388924,-0.154734,-0.27923,-0.415683,-0.440496,-0.674011,-0.062878,-0.039463,-0.302446,-0.304831,-0.559464,-0.0327414,0.34867,0.246379,-0.28279,0.0164737,-0.0717468,-0.267273,-0.405004,-0.123665,-0.181307,-0.0362099,-0.268019,1.26668,-0.30147,0.621691,-0.0794966,-0.010049,-0.0427932,-0.100782,-0.814826,0.170357,-0.613559,-0.0480655,0.163894,-0.541396,0.317331,-0.533176,-0.0876944,-0.268723,-0.158669,0.763711,0.0672932,-0.66791,0.451322,-0.337674,-1.01109,0.074556,-0.70974,-0.157727,-0.291697,0.424974,-0.241393,0.246043,0.676341,-0.741693,-0.73764,0.449271,0.313824,-0.292946,-0.0239083,0.292481,0.24988,-0.16266,-0.46065,0.152307,0.154449,-0.139231,0.262647,-0.44607,-0.531994,0.327538,-0.592444,-0.0308846,0.169547,0.457639,0.0130223,0.163708,0.365028,-0.228021,0.542914,-0.263722,-0.0532979,0.108338,0.275747,-0.301031,-0.038927,-0.086226,-0.44959,-0.283941,0.444593,-0.211173,0.031599,0.155464,-0.0293179,0.569576,-0.180409,-0.207759,-0.323586,0.377836,0.0464759,0.0279253,-0.339643,0.187072,0.339464,-0.21226,-0.00728045,0.65878,0.361118,0.514815,0.144963,-0.0341247,-0.982944,-0.0723766,-0.0333999,-0.329755,0.118061,0.128163,0.206657,0.357998,0.454595,-0.341285 +3413.55,0.385398,0.0848144,5,1.55839,0.767735,-1.47506,0.647323,-0.123937,-0.116374,-0.395187,0.782364,1.15164,-0.129863,-0.135795,0.216495,0.493826,0.724339,0.171695,0.867803,0.657396,0.170113,0.108968,0.169443,-0.141439,-0.41361,-0.452884,0.316243,-0.292676,-0.14338,-0.0819826,-0.0406883,-0.048744,0.130377,0.796017,-0.63,-0.314143,0.639992,-0.674096,0.0131588,-0.0126192,0.746354,0.536353,-0.142585,0.944262,0.958598,0.360904,-1.18626,-0.267487,-0.3982,-0.232195,0.574699,0.133506,-0.31931,0.529788,0.130848,-0.122068,-0.42177,-0.0051111,-0.186325,-0.538157,-0.72843,0.304522,0.0938144,-0.102497,1.1838,-0.477418,-0.3871,-0.117945,-0.0373623,0.117673,0.147281,0.174365,-0.135794,-0.542914,0.035972,0.502637,0.251141,0.361571,0.33111,0.436917,0.303784,-0.398997,0.0582383,-0.0604157,-0.539707,0.401504,-0.0205096,-0.132611,-0.112851,0.262385,-0.39241,-0.0564952,-0.145092,-0.201327,0.0637192,-0.436095,-0.240134,-0.173347,-0.591058,0.224544,-0.492471,0.0419385,-0.0333039,0.573285,0.637779,-0.28592,-0.26431,-0.215885,0.644338,0.27346,0.0243547,0.461412,0.168645,0.0840604,-0.14714,0.236354,0.63675,0.34569,0.293773,-0.459148,-0.46125,-0.419785,-0.722126,-0.344526,-0.454838,-0.544564,-0.648546,-0.283856,-0.971123,-0.507124,0.27686,0.286298,-0.203724,0.0817274,-0.060734,-0.119234,0.285734,-0.231278,-0.225753,0.266404,-0.34943,0.34306,-0.604913,-0.0144651,0.0637889,0.0889488,-0.371376,0.178886,0.242506,-0.666057,0.092548,0.148058,0.83902,-0.107305,-0.050369,-0.257299,-0.121223,-0.266781,0.656579,0.432931,-0.376512,0.129601,-0.438616,0.178533,0.244284,0.690111,0.0096395,-0.115048,-0.177303,-0.186235,0.139647,-0.373726,0.0233464,0.201733,-0.199602,0.242471,-0.420212,-0.602925,0.719643,-0.132077,-0.024621,0.550376,0.60526,-0.485459,0.351891,-0.0856985,-0.0993974,-0.990698,-0.215238,-0.0172235,-0.348284,-0.565733,-0.463522,0.0371139,0.0122157,-0.28109,-0.27782,-0.322793,-0.0522414,0.0461641,-0.210748,-0.399821,0.275958,0.057936,-0.135325,-0.195541,0.0543497,-0.273632,-0.113134,-0.472733,1.04967,0.415408,0.246448,-0.0836165,-0.14879,0.196437,0.220089,-0.365965,0.0673192,-0.330717,0.233404,0.0342796,-0.181484,0.126511,-0.556219,0.29414,-0.400304,0.0151814,0.489244,-0.359751,-0.839209,0.464402,-0.290353,-0.958564,0.0918514,-0.558585,0.144682,0.00808159,-0.0680762,-0.137628,-0.0207656,0.52245,-0.822929,-0.511364,0.39165,0.147749,-0.290986,-0.451143,-0.0697366,0.678753,0.374561,-0.587313,-0.283564,-0.143775,-0.558413,0.26472,-0.402558,-0.00407617,0.285257,-0.50105,-0.325305,0.0944992,-0.155646,-0.113281,0.536948,0.0835449,-0.358851,0.0950671,-0.22839,-0.0923617,-0.0464679,-0.0571425,-0.143526,-0.0344514,-0.33137,-0.00442133,0.118679,0.159993,0.217507,0.331831,0.0846295,0.204593,0.358155,-0.000642153,-0.428608,-0.581458,0.363721,0.245887,-0.133136,-0.29375,0.0737316,0.0554907,-0.385143,0.270559,-0.229024,0.252827,0.0368813,0.117308,-0.0871498,-0.413341,-0.306845,0.093625,-0.321103,-0.547227,0.140043,0.241936,0.374224,0.49187,0.802734 +3413.97,0.515559,0.0848144,5,1.49982,0.932005,-0.495215,0.242748,0.107953,-0.164519,0.409599,0.0702712,-0.23922,0.419345,0.277272,0.339278,0.0593183,0.490537,-0.146934,1.38624,0.260326,0.465695,-0.209029,0.364206,-0.0939069,-1.14079,-0.825097,0.125858,-0.15896,-0.289845,0.220552,0.501543,0.0611495,0.533202,0.805044,-0.354372,0.256669,0.235775,-0.189404,0.254348,-0.918102,0.695068,0.0561333,-0.594339,0.936935,0.115366,0.168886,-0.548957,-0.447347,-0.13344,-1.0095,0.232047,0.0280399,-0.0334116,-0.120205,0.935718,0.187554,-0.643041,0.388301,-0.0424604,-0.280927,-1.37165,0.609053,-0.564975,-0.0827867,0.938047,-0.721454,-1.04515,0.482229,0.158612,-0.64397,-0.357933,0.334264,-0.646459,-0.231016,0.0735299,0.770583,-0.444435,0.230042,0.692912,-0.0915221,-0.544945,-0.0874447,-0.165312,0.898342,-0.329265,0.159346,0.614449,-0.0942334,-0.0268952,-0.118872,0.15769,-0.112113,-0.246217,0.451986,-0.124055,0.498997,-0.0863688,-0.0240617,-0.22441,-0.176883,0.14674,0.025537,0.507475,-0.212901,-0.196336,-0.407087,0.105382,0.341213,-0.48907,0.051553,-0.16193,0.357363,0.571674,-0.605011,0.251252,-0.0261711,0.36263,-0.393859,0.218449,-0.255992,-0.0565245,0.715786,0.252922,-0.465552,-0.128444,0.387162,0.584959,0.388133,0.814145,0.548794,0.141021,-0.142093,-0.574838,-0.361031,0.243933,0.427317,0.269552,-0.00475402,-0.592641,-0.0308796,-0.0697289,0.0775693,-0.282885,-0.89052,0.111694,0.220303,0.129924,0.206715,0.163384,0.254319,-0.112143,-0.116868,-0.624663,-0.24122,-0.0377121,0.0982776,-0.227158,0.714138,0.0210317,0.0149789,0.515147,0.0866312,0.198368,-0.355359,0.00372084,0.901275,0.155866,0.240902,0.135796,0.439402,-0.459729,0.0167817,0.0136586,0.219099,-0.0564636,0.0854342,0.234957,0.499176,-0.366761,-1.11797,0.062247,0.886852,0.537439,0.72595,-0.692506,0.0424669,0.519216,0.623429,-0.422936,0.0648281,-0.344784,0.0172412,-0.251116,-0.0382796,-0.160892,-0.400028,-0.400877,-0.164984,0.108364,0.0564444,-0.505803,-0.453795,0.148748,-0.0483279,-0.270018,0.705838,-0.11102,0.582451,-0.137584,-0.625884,0.960469,-0.35699,0.144875,0.0717191,-0.661371,-0.130061,0.0469976,-0.392906,0.40687,-0.0864248,0.0873904,0.627273,-0.197997,0.14108,0.15345,0.136693,0.596419,-0.929029,0.510297,-0.0910927,-0.0438599,0.00704514,-0.0327138,0.147382,0.223131,0.15292,-0.172089,0.557079,0.251261,0.309836,0.526545,0.304122,-0.46529,0.338462,0.0516287,0.188994,-0.201974,0.80956,0.369709,-0.0802154,-0.431379,-0.160875,0.0384411,0.315676,-0.67747,0.755632,-0.373642,-0.390351,0.366948,-0.189207,0.763081,0.305811,0.575259,0.22277,-0.00223619,0.075619,0.0628503,-0.044517,0.190645,0.324185,0.313083,0.276883,0.135801,-0.249925,-0.555185,-0.308947,-0.145275,-0.45091,0.107039,-0.0425283,0.44116,0.509729,-0.170816,0.0974515,0.344019,-0.347455,-0.0856718,0.212183,0.116887,0.168484,0.303693,0.0901347,0.54376,0.249262,0.728538,0.421205,0.809837,-0.725926,-0.442425,0.225655,0.220656,-0.189567,0.145623,0.235109,0.160652,0.331468,0.400814,0.575733,-0.435191 +3408.46,0.823022,0.0848144,5,1.54864,0.961042,-0.181104,0.124367,0.580444,-0.0357177,-0.167905,0.152196,1.07086,0.156634,-0.0105888,-0.214875,0.202033,0.730853,0.24187,1.28697,0.584266,-0.34151,0.604382,0.166604,-0.197767,-1.18013,-0.527223,-0.0535549,0.291722,-0.0697902,0.434027,0.392622,-0.0845492,0.0562891,0.791664,-0.101172,-0.0303383,0.290361,-0.187934,-0.737568,0.0373571,0.684306,0.188963,-0.325423,1.16667,0.632989,0.353199,-0.875759,-0.348636,0.115238,-0.867841,-0.315713,0.0498886,-0.0517307,-0.117967,-0.677,-0.258573,-0.505269,0.692199,-0.385316,-0.31413,-0.613472,0.281589,-0.68384,-0.126247,1.28197,-0.452235,-1.14373,0.0202179,0.440787,0.87564,0.529193,0.201572,-0.108041,0.170302,0.147086,0.337628,-0.0584643,0.361642,0.0659254,0.052961,0.254384,-0.360621,-0.0234938,0.727581,-0.413321,0.525629,-0.544574,-0.00944168,-0.33287,0.216241,-0.262642,0.333022,-0.263625,-0.485303,0.273434,-0.557185,0.14061,0.359653,-0.017979,-0.174142,-0.251872,0.162958,-0.27751,0.245684,0.109602,-0.363898,-0.0924832,-0.0245932,-0.0727479,0.746923,-0.124023,0.154265,0.837982,0.594381,-0.157938,0.0695555,0.493738,0.0938059,0.10443,-0.211468,0.052365,0.266972,-0.361373,-1.24664,0.2113,-0.0459821,-0.685899,-0.541951,0.00550914,-0.0203368,0.402085,0.319132,-0.192638,0.623136,-0.462268,-0.0601692,0.0679678,-0.623342,-0.0429926,-0.207003,-0.2812,0.395907,-0.0485176,-0.0710521,0.177399,-0.207783,-0.474934,0.132997,0.49574,-0.260598,0.704709,-0.148849,0.242792,-0.176994,0.320016,0.283928,0.44436,-0.288447,0.564946,0.445086,-0.146293,-0.116909,0.144872,0.623788,-0.0641964,0.640285,0.228044,0.3073,0.47323,-0.411497,0.0736615,0.0998845,-0.107168,0.396613,0.118049,-0.0251638,-0.0482986,-0.59863,0.575455,0.364703,0.184475,-0.771843,0.222031,-1.00538,-0.17003,0.0319634,-0.283125,-0.43722,0.124545,-0.31252,-0.136295,0.301686,-0.0300117,0.0456978,0.364311,-0.00620479,-0.471859,-0.270756,-0.171934,-0.0268556,-0.307458,-0.248733,0.216183,0.282335,-0.311208,0.210557,-0.140122,-0.44138,-0.379647,-0.547336,0.89245,0.696213,0.256807,-0.04319,-0.132793,0.477846,0.122234,-0.161134,0.501356,-0.0124164,-0.170577,-0.217314,-0.319348,-0.378723,-0.881438,-0.20634,0.0985399,0.40813,0.282181,-0.28562,-0.114065,0.186182,0.495108,-0.185897,-0.0386807,-0.145906,0.242341,-0.0915818,0.423177,0.455367,0.158277,0.135418,-0.722517,0.231756,-0.488818,0.327565,-0.00248669,0.0821877,-0.158131,0.636914,0.478462,-0.029494,-0.393024,-0.382006,-0.445491,0.0523988,-0.308682,-0.0977499,0.200806,-0.331758,0.306378,0.18606,-0.0204284,-0.174142,0.824229,-0.0378012,-0.00819691,0.34494,-0.190605,-0.115541,-0.0669451,0.0535608,-0.0203291,0.0100293,0.463048,-0.0171792,-0.202598,0.787452,0.002188,-0.0404927,0.334667,0.1217,0.130072,-0.0372667,-0.598196,0.0464376,0.385337,0.218097,0.218566,0.1453,0.315854,0.22388,-0.272141,0.2197,-0.656684,0.0267499,-0.284928,0.137675,-0.166852,0.509154,-0.584199,-0.0195329,-0.315329,-0.512201,0.140182,0.384794,0.374409,0.620317,-2.09125 +3445.62,0.902831,0.0848144,4,1.78852,0.926523,-0.640596,0.328402,0.884037,-0.137791,0.138917,-0.0597451,-0.278684,0.268556,0.121119,-0.0279319,-0.343488,0.0286331,-0.45884,0.784869,-0.0282112,0.0948127,-0.335151,-0.163038,-0.329312,-0.874116,-0.647889,0.0102386,-0.225987,-0.0846856,0.123668,0.249727,-0.0303239,-0.451952,0.550986,-0.26753,0.422412,0.526882,-0.756921,-0.630771,-0.503885,0.288979,-0.0302281,-1.17211,0.731111,0.0245161,-0.44571,-0.710333,0.235641,-0.139494,-0.850613,-0.789019,-0.256945,-0.489555,-0.106857,0.620448,-0.346053,-0.751899,0.551424,-0.06446,0.0640855,-1.2104,0.326132,-0.441275,-0.108808,0.619637,-0.805136,-1.38911,0.0433976,0.327892,-0.363122,-0.157719,-0.141618,-0.38932,-0.323017,0.248818,0.676948,-0.347754,0.515981,0.519752,0.644043,-0.350152,-0.239948,-0.04503,0.469388,-0.105804,0.0285346,-0.219818,-0.148712,-0.0616444,0.0256856,0.0182691,0.451315,-0.40177,-0.0462852,-0.268064,0.256366,-0.256077,0.171016,-0.649206,0.0570065,0.115747,0.174872,0.417885,0.0323864,0.000122824,-0.201175,-0.638208,0.0346519,-0.238339,0.329903,0.0201613,0.401958,0.101977,-0.544686,-0.393986,0.469227,0.201409,0.0691512,-0.289241,0.0354524,0.176509,-0.0437783,0.417222,-0.40774,-0.142274,0.270949,-0.270367,0.663302,0.367239,0.0964914,0.0527298,0.193464,-0.437528,-0.233352,0.318916,0.204557,0.517044,-0.136516,0.0187432,-0.184184,-0.191405,0.182534,-0.82578,-0.262879,-0.0395445,0.22624,-0.0446845,0.00383618,0.178277,-0.110914,0.531889,-0.0331883,-0.390907,0.0767399,-0.315731,-0.167473,-0.0698819,0.226519,-0.05845,0.121649,0.807834,-0.187685,-0.162843,-0.00209795,0.124689,0.255801,-0.679782,0.154435,0.148697,0.251174,0.113393,-0.386634,0.125926,0.120518,-0.585632,-0.321475,-0.559356,-0.163925,-0.675385,-0.652344,-0.355924,-0.0437786,0.61655,0.702262,0.0572858,0.419651,0.106043,-0.315257,-0.198917,-0.30472,-0.197796,-0.217287,-0.325117,-0.216757,-0.135652,0.00910925,-0.578005,0.40212,0.313942,-0.102921,-0.134444,-0.201241,-0.353929,-0.167619,-0.265568,-0.0511624,-0.0639906,0.608548,-0.111203,0.0370677,0.848025,-0.787977,0.189474,-0.221961,-0.11543,0.574618,0.0626142,-0.476705,0.420522,0.144651,0.140556,0.309027,-0.231813,0.208987,-0.250994,0.371145,0.144534,-0.385286,0.663772,-0.207395,-0.245516,-0.388671,-0.00308158,-0.253368,0.0169701,-0.183253,-0.735309,-0.345648,0.546631,-0.23547,0.144099,0.317167,-0.122484,-0.111597,0.041685,-0.415672,0.15862,0.41176,0.501445,0.140871,-0.118871,-0.169735,-0.213007,0.0216685,-0.321216,0.277253,0.125246,-0.16604,-0.258958,-0.432653,-0.366316,-0.0160669,0.307745,0.122796,-0.0611054,-0.0815171,0.306539,-0.286952,0.637844,0.043303,-0.429739,-0.0984956,-0.30046,-0.160119,-0.267685,-0.615964,0.244542,-0.35673,-0.198094,-0.231815,-0.158617,0.343722,0.330147,-0.266971,0.456708,-0.080073,0.285151,0.218843,0.211947,-0.417002,0.324781,0.248799,0.240873,-0.303313,0.0939888,-0.0494795,0.296388,-0.169458,-0.353495,0.178033,0.20231,-0.0684166,-0.191452,0.290281,0.103485,0.214335,0.321691,0.462963,-2.72476 +3445.32,0.318619,0.0848144,5,1.76993,0.923166,-0.435468,0.192403,0.594771,-0.131891,0.054394,-0.153389,-0.200815,0.0799876,-0.245556,-0.0918451,-0.259082,0.0230656,-0.392276,0.722623,0.042013,-0.208637,-0.312906,-0.398921,-0.288593,-0.90518,-0.691366,0.280983,-0.292408,0.133191,0.0385538,0.151789,-0.0669952,-0.387501,0.689356,-0.0737125,0.481141,0.426166,-0.428948,-0.741898,-0.138889,0.140596,0.250057,-0.807869,0.571009,0.344625,-0.674281,-0.904754,0.212917,0.156516,-0.870761,-0.584114,-0.203742,-0.444361,-0.14334,0.322182,-0.355258,-0.886195,0.688489,-0.216976,-0.0276609,-1.34637,0.095078,-0.498173,-0.13326,0.71308,-0.631856,-1.53881,-0.134066,0.0736597,-0.364426,0.0790012,0.235958,-0.350177,-0.0524263,0.667289,0.695262,-0.203807,0.934975,0.291593,0.424107,-0.259458,-0.237335,0.178067,0.575731,-0.242852,0.109109,-0.0815045,-0.0241876,-0.481061,0.365658,0.0858868,0.36971,-0.272637,-0.0605751,0.131946,0.174874,-0.186221,0.328787,-0.440189,0.271343,-0.0161862,0.175393,0.286005,0.0627422,0.0944195,-0.454725,-0.604813,-0.0174084,-0.0564539,0.357034,-0.116797,0.31243,0.268806,-0.805211,-0.266187,0.579758,0.03906,0.115816,-0.155082,0.354238,0.0788272,-0.0396615,0.0467783,-0.581653,-0.206686,0.116337,-0.168532,0.433452,0.356217,-0.0710903,0.0584834,0.130904,-0.164073,-0.164533,0.244078,0.153535,0.428145,0.0470693,-0.33176,0.285278,0.0354248,0.28319,-0.468667,-0.286657,0.0236129,0.227711,-0.0389279,0.190668,-0.00944478,-0.233122,0.22722,-0.11315,-0.499806,0.379044,-0.299804,-0.0341769,0.12397,0.193751,0.255231,0.409519,0.545331,0.02518,-0.311653,0.0702219,0.182015,0.239149,-0.61849,0.135302,0.268876,0.118681,0.178436,-0.431535,0.229129,0.402814,-0.497721,-0.172409,-0.326692,-0.0636575,-1.02786,-0.508728,-0.185736,-0.102125,0.52987,0.431126,0.117744,0.232281,-0.0416416,0.196701,-0.593285,0.229519,-0.497309,-0.258612,-0.486083,-0.0309329,-0.37895,0.239286,-0.956416,-0.179834,0.285288,0.0529998,-0.147211,-0.39944,-0.327176,-0.394124,-0.0250787,0.137511,0.253718,0.266325,-0.301614,-0.102571,0.964506,-0.73615,-0.165183,-0.0355269,0.1632,0.309658,0.058134,-0.348643,0.454951,-0.150173,0.198361,0.308196,-0.413789,0.371749,-0.255037,0.211277,0.127038,-0.107461,0.799329,-0.0413649,-0.386873,-0.248995,-0.0246425,0.0343574,0.0810709,-0.202135,-0.68282,-0.308007,0.642306,0.133268,0.259762,0.05183,-0.0824593,-0.11748,-0.135646,0.14393,0.33758,-0.0344446,0.945911,0.182902,0.293115,-0.11056,-0.0332058,0.175034,-0.290436,0.306095,-0.148839,-0.0791137,0.0550675,-0.224561,-0.420835,-0.0782719,0.121756,-0.0655126,-0.0412174,-0.182122,0.496041,-0.0427589,0.658762,0.159816,-0.542051,0.228386,-0.0885924,-0.319649,-0.12962,-0.607204,0.0536782,-0.207792,0.00171664,-0.0118105,-0.629568,0.292028,-0.0403858,-0.113264,0.624274,0.0832426,0.186959,0.184111,0.291994,-0.119173,0.404199,0.364375,0.250824,-0.0107545,-0.31582,-0.183747,0.338152,-0.060704,-0.244994,0.245465,-0.174079,-0.0827555,-0.528942,0.0832589,0.122889,0.271429,0.350555,0.520988,-1.75739 +3437.33,0.992708,0.0848144,4,1.77672,0.842534,-1.54791,0.619922,0.748468,-0.246987,-0.00552409,0.105004,-0.106733,-0.609866,-0.464143,-0.101566,-0.563232,-0.294744,-0.215132,0.655687,-0.381817,-0.0208128,-0.19278,-0.256789,-0.821465,-1.14026,-0.892157,-0.112634,-0.587878,-0.589691,-0.0103616,0.132846,-0.711617,0.206425,0.874297,-1.04237,-0.413406,-0.0305215,-0.424545,-0.0279209,-0.137692,0.477515,0.0920957,-0.0748628,0.697723,0.151271,0.393526,-0.7935,-0.441409,-0.144846,-0.352171,0.078505,-0.400135,0.0642668,-0.0282501,0.376169,-0.312088,-0.565139,0.145075,-0.535128,-0.697562,-0.779337,0.40437,-0.465441,0.189773,1.1615,-0.859453,-0.679632,-0.0564271,0.0106592,0.138749,-0.00131444,0.629022,-0.35693,-0.55176,-0.0819386,0.644316,-0.168181,-0.254495,0.453977,0.0901371,0.507348,-0.00794506,-0.184037,0.235094,-0.297244,0.2865,-0.362616,0.172352,0.263889,0.0086156,-0.481196,-0.445158,-1.05119,0.417567,-0.194171,-0.259829,0.20082,-0.4357,0.222295,-0.131138,-0.24494,0.077632,0.180959,0.0949585,0.073006,-0.131293,-0.468901,0.118644,-0.553973,-0.139295,0.295997,-0.0373819,0.324751,0.752075,-0.0692508,0.16702,0.397919,-0.321078,0.230208,-0.292337,-0.000839565,0.1543,-0.116615,-0.642215,-0.182682,-0.256735,-0.200813,-0.562022,-0.0703107,0.530505,-0.0458639,0.0214603,-0.529175,0.321028,-0.0196047,-0.209428,0.475483,-0.451521,-0.05918,-0.0696073,-0.234495,0.687743,-0.515463,-0.0374628,-0.089123,0.277198,-0.470909,0.0282349,0.425162,0.0987078,0.350843,-0.293181,-0.12827,-0.416575,0.40082,0.0678318,-0.179367,-0.105856,-0.00573295,-0.0546329,-0.772367,0.0221036,0.135975,0.199794,-0.0351124,0.68569,0.369754,-0.2852,0.00334177,0.277358,-0.236969,0.00914942,0.245149,0.263172,0.102722,-0.116672,0.14451,-0.353247,0.439444,-0.332364,-0.483159,0.164181,0.41145,-0.139748,0.0824716,0.107958,-0.197366,-0.380315,0.0285261,-0.532763,-0.116966,0.101304,0.309106,0.349265,-0.00238211,0.0303713,-0.376393,0.0686862,0.22398,0.241499,-0.159208,0.0502955,0.0304783,0.230797,-0.292109,-0.0709904,-0.572757,-0.155599,-0.124041,-0.52455,0.554948,0.477403,0.327542,0.0759377,-0.604025,-0.258816,-0.546584,0.459698,0.449835,-0.257414,0.0758538,0.358255,-0.118071,-0.117958,-0.528935,0.0742083,0.464434,0.0095323,0.338023,-0.136577,-0.333235,0.12456,0.434032,-0.468012,-0.237474,-0.385512,0.11061,-0.249771,-0.00672937,-0.508884,-0.112352,0.463537,-0.391968,0.0105385,-0.0454067,-0.187887,-0.185633,0.69313,-0.388376,0.562461,-0.307053,-0.0568279,-0.0781889,-0.119798,-0.607727,0.401068,-0.321783,-0.418675,0.519356,0.269899,0.532139,0.500911,0.272374,0.25438,0.198723,-0.0963822,-0.238693,0.148741,-0.058141,-0.188485,0.244752,-0.132368,0.323098,0.0601482,-0.298425,-0.495688,-0.110599,0.20537,0.145683,0.420929,0.382101,0.612403,-0.108367,-0.163815,-0.630102,-0.676569,0.252156,0.582329,0.189537,-0.339606,-0.195946,0.0936444,-0.148458,0.022062,0.0792847,0.32099,0.13389,-0.139183,-0.680418,-0.76485,0.121602,-0.422137,0.385279,0.0933463,0.122391,0.217357,0.349844,0.466215,-1.91046 +3438.95,0.70284,0.0848144,4,1.77295,0.943878,-0.782894,0.246752,0.388186,-0.0572431,0.0858878,-0.430071,0.120467,0.437041,-0.314937,-0.376788,0.0205732,0.00148533,-0.602355,1.11481,-0.194127,-0.122141,-0.138215,-0.249825,-0.551386,-0.972926,-0.666474,0.0552416,-0.161091,0.0869441,-0.509928,-0.150866,-0.341331,-0.460048,0.737364,-0.38201,0.181935,0.340364,-0.819181,-0.346332,-1.07223,0.560803,0.37678,-0.717201,1.08611,0.111906,-0.523847,-0.821471,-0.0915703,-0.340518,-0.766425,0.0857059,0.229536,-0.46741,-0.141422,0.33626,-0.12491,-0.230012,0.562451,-0.366484,-0.360777,-1.4259,0.251013,-0.668147,0.120994,0.450685,-0.561667,-1.44498,0.215427,-0.078357,-0.0632714,0.0417413,-0.402143,-0.481819,0.134032,0.453958,0.666117,-0.0049408,0.436515,0.187843,-0.0467372,-0.803872,-0.294654,0.350057,0.407794,-0.149894,0.141238,0.107401,-0.34965,-0.425086,0.00731862,-0.00415977,0.645512,0.0103194,-0.333448,0.127831,0.130063,-0.211159,0.172622,-0.323,-0.0704508,0.0305582,-0.137883,0.190426,0.321202,0.00948649,-0.29768,-0.123413,0.121789,0.0781352,0.351257,-0.406527,0.564701,0.50986,-0.859369,-0.317857,-0.220077,0.138152,0.395622,-0.15999,-0.00798556,-0.146015,-0.188323,-0.0781646,-0.162086,-0.00815688,0.233283,-0.00617639,0.309281,0.136269,-0.163472,0.0934564,0.0415116,-0.225932,-0.282657,0.292096,0.193355,-0.35738,0.0958494,-0.479896,0.0326386,0.0227401,0.119851,-0.198027,-0.375974,0.0489534,-0.267875,-0.0910647,0.215692,-0.442925,-0.0523182,0.0418163,-0.403606,0.0868633,0.218453,-0.366187,0.249839,-0.235392,0.540657,0.287111,0.324072,0.628607,-0.204991,-0.152978,0.152008,0.0377043,0.101298,-0.294866,0.144771,0.00681257,-0.0983625,0.219723,-0.312114,-0.268951,-0.0420619,-0.199697,-0.0574109,-0.0645983,0.181972,-0.541745,-0.342938,0.113642,0.100356,0.948024,0.130519,-0.156667,-0.0903985,-0.149487,0.328603,-0.374857,0.142621,-0.524108,-0.179369,-0.857781,-0.0405744,-0.179066,-0.690568,-0.512679,-0.412232,-0.17442,0.0159441,-0.109077,-0.928369,-0.211661,-0.315049,-0.0738659,0.373999,0.533324,0.197846,0.0963249,-0.11102,0.829526,-0.416844,-0.0192856,-0.173603,0.404235,-0.0797386,0.638162,-0.88436,0.00722802,-0.222999,0.0796213,0.417352,0.027383,-0.0324872,-0.396798,-0.01035,-0.343722,-0.49124,0.613628,0.084365,-0.173144,0.00283392,-0.421266,0.112094,-0.00353793,0.235782,-0.393389,0.133576,0.479685,0.209839,0.1146,0.482615,0.106715,-0.247566,-0.0525206,0.0208158,0.196959,-0.12476,0.481028,-0.139708,0.2403,-0.126506,-0.238297,0.101775,-0.612664,0.180707,-0.285501,-0.0371766,0.0914334,-0.492287,-0.449658,-0.549791,-0.0686096,-0.133959,0.256859,0.242267,0.520154,0.125288,0.373566,-0.22758,-0.388059,0.138557,-0.352894,-0.24486,-0.285808,0.334129,0.0242423,-0.0579376,-0.200299,-0.266886,0.130717,-0.0255611,0.111772,-0.208282,0.528539,0.23399,-0.19894,-0.0808764,0.152669,0.106821,0.397683,0.119732,-0.017482,-0.174924,0.105024,-0.231657,0.222743,-0.246976,-0.00356579,0.164497,0.0269443,0.252446,-0.485153,-0.169084,0.102411,0.334368,0.320017,0.578245,-0.992833 +3418.67,0.979166,0.0848144,4,1.8122,1.05485,-0.685737,0.238235,0.712906,-0.0633711,-0.149975,-0.0650611,0.336841,0.344201,0.19055,-0.401145,-0.287093,-0.198788,-0.32627,1.41055,0.147958,-0.229777,-0.130911,-0.564161,-0.546806,-0.808204,-0.815188,-0.208171,-0.457766,-0.439605,-0.11757,0.139865,-0.258973,-0.378931,0.41383,-0.227515,0.305728,0.200259,-0.429253,-0.53518,-1.28521,1.00348,0.299797,-0.329321,0.495627,0.00613466,-0.0811273,-0.705295,-0.0382742,-0.842154,-1.19029,-0.133348,0.122563,-0.561122,-0.464807,0.513866,-0.0433736,-0.0967401,0.4056,-0.638659,-0.34289,-0.672367,0.258379,-0.244068,0.0255151,0.714231,-0.884921,-1.53131,-0.181294,-0.00613143,-0.096686,0.365264,0.249647,-0.272654,0.210795,0.155356,0.475788,0.136751,-0.154249,0.030157,0.306389,-0.286722,0.0716629,0.0820746,0.616095,-0.0191471,-0.0981244,-0.261365,-0.195219,-0.371903,-0.303865,-0.625327,0.50225,-0.247251,-0.278546,-0.289347,-0.152367,-0.0533165,-0.0234852,-0.27286,-0.352653,-0.207944,-0.0062237,0.363781,0.0365446,0.189223,-0.429704,-0.00216637,0.0742593,0.27507,0.44457,-0.41264,0.405209,0.440483,-0.27471,-0.203351,-0.447477,0.374162,-0.450173,0.1825,-0.378111,0.151939,0.0720373,-0.95138,-0.114362,-0.156198,-0.260906,-0.222912,-0.719658,0.584453,0.292661,0.329625,0.0484646,-0.252496,-0.0447653,0.404349,-0.102623,0.324151,-0.0693618,-0.0211194,0.018434,-0.0148623,0.328226,-0.341606,0.0304486,-0.181799,-0.258667,-0.416406,-0.285586,0.133848,0.366708,0.0144504,-0.300061,-0.62383,0.233808,-0.0942745,-0.00638315,0.0627703,-0.185606,0.281463,-0.390559,0.434824,-0.112197,-0.281384,-0.25736,-0.166137,0.0821374,0.403878,-0.504553,-0.0534927,-0.322881,0.0723494,0.048235,0.361822,0.231737,0.129324,-0.30673,-0.176946,-0.0520022,-0.63368,-0.434502,-0.31876,-0.302741,0.720914,0.156449,0.379338,0.0745115,-0.413713,0.0295144,-0.10233,-0.291696,-0.324787,0.597231,-0.509076,0.04657,-0.166808,-0.783029,-0.897764,0.148599,0.183551,0.364067,-0.256796,-0.478887,0.0185707,-0.313907,-0.0848285,0.306871,0.449961,-0.00413428,0.0975696,-0.262411,0.644358,-0.336577,-0.17579,-0.278338,-0.253622,0.310153,-0.100296,-0.331375,0.0693694,0.0419228,-0.150922,0.37206,-0.1163,-0.0240104,-0.877547,-0.139998,0.106589,-0.615086,0.242241,-0.359763,-0.0971593,0.176084,0.289207,-0.370458,-0.13276,-0.220332,0.0694113,0.210688,0.162845,-0.419948,0.108037,0.186606,-0.715364,-0.0426193,0.318652,-0.0603631,0.242533,-0.102802,-0.444479,0.213684,0.335155,-0.0518025,-0.102956,0.112431,-0.744582,0.0209657,-0.274747,-0.343052,0.0237408,-0.505694,-0.708765,-0.506595,0.0238768,-0.295821,0.028495,-0.0805927,0.0972581,-0.160412,0.0216038,-0.0850252,-0.0530456,-0.431567,-0.414164,-0.522129,0.416773,0.629782,-0.382715,-0.245901,0.799508,0.0474225,0.0586254,0.0160414,0.0561695,-0.542088,-0.0157827,0.662207,0.431862,-0.081324,0.0905028,-0.415716,-0.208696,-0.0304846,-0.675231,-0.182369,0.107528,0.125945,0.427241,-0.299186,0.173095,0.135622,-0.26368,-0.324634,-0.24422,0.00243512,0.0963909,0.361384,0.310469,0.601152,-2.26921 +3402.84,0.745833,0.0848144,4,1.58338,1.22519,-0.108914,-0.106982,0.619535,-0.333849,0.351525,-0.054686,0.483789,-0.0709734,-0.146876,-0.266288,-0.152544,-0.15875,-0.292328,0.794018,-0.183276,-0.246493,0.0134593,0.00761916,-0.489769,-0.642046,-0.407537,-0.51143,-0.23477,-0.105434,0.22274,0.612155,-0.410281,0.108861,0.599889,0.15838,0.023611,-0.154552,-0.345767,-0.347552,0.338598,-0.359462,0.198074,-0.94717,0.960536,0.411541,0.517812,-0.828268,-0.418032,-0.135472,-0.64219,-0.240678,0.487052,0.285928,0.290648,-0.617429,-0.0694434,-0.491849,0.888823,-0.175159,-0.276413,-0.682845,0.0193869,-0.422438,0.354683,0.702706,-0.373567,-0.278218,0.131176,0.21314,0.436293,-0.43763,-0.0678146,-0.714133,-0.612315,0.43481,0.859196,-0.201439,0.994224,0.596723,0.15448,0.31637,-0.647309,-0.167389,-0.134823,-0.83207,0.355302,0.286014,-0.23454,0.291343,0.00519968,0.293593,-0.137549,-0.829613,-0.366385,0.400994,0.0556495,0.186979,0.146833,-0.0960087,0.346263,-0.354871,0.312116,0.0479406,0.191346,-0.862597,-0.236153,-0.720614,0.354686,-0.144596,0.306388,-0.169728,-0.167512,0.33196,0.262676,0.174501,0.480649,0.170404,0.440294,-0.123151,-0.420183,0.306729,0.00517729,0.439636,-0.845267,-0.0366591,-0.0659814,-0.194662,0.172824,-0.17346,0.10892,-0.385524,0.359255,-0.197792,0.478172,-0.15287,0.225687,0.140864,-0.68427,-0.165695,-0.179124,-0.23837,0.195297,-0.900178,-0.44504,-0.0666032,0.587922,-0.339312,0.27303,-0.0263457,-0.365016,0.564222,-0.397853,-0.0350726,-0.6627,0.163312,0.377312,-0.111496,0.297178,0.156371,0.534012,-0.292649,0.108756,0.526874,0.147727,0.122869,0.843206,-0.282711,0.574415,0.408293,0.0762272,-0.322925,-0.473213,-0.12759,-0.0526749,-0.428402,-0.218143,0.201969,-0.136922,0.0783535,0.2511,0.0376328,-0.176206,0.703532,-0.180165,-0.660639,0.0689272,0.212319,-0.110926,-0.0968565,0.0964696,-0.0495035,-0.344704,0.285672,0.181687,0.0636369,0.575902,-0.0709955,-0.105344,0.0412204,-0.513347,-0.467573,-0.796734,-0.231327,0.0267038,-0.153114,-0.161524,-0.469247,-0.0716352,-0.41482,-0.355448,0.51902,-0.0556544,0.267527,0.171084,0.100993,-0.07584,0.277397,-0.662043,-0.0546627,-0.0869022,0.224995,-0.546732,-0.17756,-0.22574,0.1927,0.500297,0.339873,0.0741814,0.413983,0.13195,-0.415788,0.366293,-0.292254,-0.535187,-0.0193291,-0.439178,-0.331185,-1.06207,1.00196,0.100656,-0.248769,0.902982,-0.467574,-0.291076,-0.221773,0.16834,0.0720762,0.581691,0.88059,0.64773,0.0217605,0.041056,0.0828688,0.155757,-0.327139,0.665997,-0.317763,-0.324419,0.411652,0.0491239,0.0138265,0.4255,0.0900496,0.462969,0.554068,0.236433,-0.0716253,0.646481,0.278559,-0.23849,-0.456047,0.446538,0.468618,0.38284,-0.675828,-1.06673,0.596385,-0.0220051,-0.597654,0.218085,0.180517,0.135555,0.162592,0.0145162,0.0196654,-0.648075,-0.179247,0.243396,0.524476,0.249582,0.568472,-0.113335,0.148074,-0.0600213,0.143149,0.0683183,-0.319596,0.590589,-1.08583,-0.139395,0.268182,0.104265,-0.0454512,-0.266233,0.143284,0.177884,0.378528,0.421762,-2.39728 +3396.34,0.966122,0.0848144,4,1.69402,1.09001,-0.310386,0.0192292,0.353527,-0.20206,0.18437,-0.196578,0.723423,0.265107,-0.647035,0.0619648,0.0689927,-0.159678,-0.490936,0.799376,-0.375624,0.310974,-0.0811675,-0.173525,-0.574476,-0.910406,-0.232755,-0.0274092,-0.710591,0.0373327,0.387982,-0.0731703,-0.251213,-0.42744,1.00358,0.0906984,0.122757,-0.245632,-0.617618,0.0150075,-0.477798,0.281928,0.128262,-0.309773,0.878098,0.063319,-0.117815,-0.554933,-0.12086,0.166173,-0.557798,-0.186596,0.192206,-0.238506,0.130794,0.358394,-0.208731,-0.29579,0.850842,-0.334734,0.0525259,-0.482987,-0.0458175,0.0857619,-0.50091,0.723341,-0.859666,-0.615332,-0.484955,0.354007,0.416489,-0.496104,0.0581811,-0.463858,-0.0988376,0.399502,1.00536,0.434385,0.499322,0.548459,0.31974,-0.371605,-0.251469,0.0154403,-0.435547,-0.66932,0.0255152,-0.207953,0.0864996,0.0399207,0.604845,-0.063112,0.0701725,-0.549345,-0.549573,0.31074,-0.122052,0.021642,0.402538,-0.39415,0.202403,-0.270352,0.00627754,0.470148,0.183291,-0.431932,-0.292405,-0.645137,0.0624628,0.155668,0.178044,-0.0025589,-0.574047,0.288446,0.0370597,0.0429655,0.942714,0.224153,-0.134817,0.057803,-0.792378,-0.0959408,-0.113028,-0.124288,-1.01225,0.0791148,-0.0123186,0.450401,0.140958,-0.158252,0.183091,0.113315,0.112878,0.0293632,0.0300922,0.391152,0.0229671,0.584641,-0.148171,-0.346819,0.430191,-0.678172,0.504433,-0.753672,-0.584416,0.0277794,0.51086,-0.479723,-0.395792,-0.546646,0.412308,0.260905,-0.604862,-0.547526,-0.496571,0.312545,0.308383,-0.437198,-0.117126,0.108338,0.270672,-0.131108,-0.510658,0.52424,0.314314,-0.238244,0.639764,-1.02981,0.479962,0.243372,-0.120061,-0.285585,-0.829497,0.114724,0.382617,0.0993646,-0.204116,0.703103,0.0270473,0.443151,0.0691997,-0.418552,0.393663,0.770255,-0.141136,-0.181588,0.0355381,0.0687639,0.0933726,0.174033,0.289844,-0.17413,0.3332,-0.740717,0.369686,0.286755,0.0764467,-0.0876808,-0.241692,0.134792,-0.0036269,-0.633371,-0.666525,0.0929628,-0.268616,0.202416,0.647226,-0.188651,0.19806,-0.7332,-0.522003,0.417972,-0.0345417,0.360961,0.433131,0.395079,0.185921,-0.201877,-0.529356,0.03271,-0.347261,-0.336807,0.125781,-0.903454,0.0226143,-0.292951,-0.0121511,-0.022589,-0.103845,0.29645,-0.488503,-0.462365,0.554683,0.0219378,-0.817719,-0.185391,-0.0192965,-0.0778711,-0.969743,0.638564,-0.224511,-0.0309505,0.410103,-0.896541,-0.425539,-0.159387,-0.412909,0.244665,0.37061,-0.262298,0.363267,0.10846,-0.315531,-0.061356,-0.487832,-0.688895,0.652993,-0.623637,0.132078,0.485803,-0.374698,0.0711402,0.192416,0.00150818,0.460406,0.549562,0.159158,-0.0519642,0.355248,0.102344,-0.372007,-0.607255,0.403242,0.548877,0.0460857,-0.14599,-0.0773852,0.606425,0.337023,-0.420279,0.303884,-0.214234,0.191842,-0.328753,-0.101171,-0.34987,-0.551102,-0.151356,-0.180346,0.397928,0.144966,0.759715,-0.0373399,-1.04891,0.0220534,0.430343,-0.26337,-0.07161,0.53163,-0.254393,0.292191,0.188167,0.00884601,-0.030887,0.464049,0.175923,0.182649,0.419432,0.427375,-1.21134 +3432.31,0.874552,0.0848144,5,1.74755,1.03878,-0.292658,0.111436,0.194455,-0.196202,-0.0771321,0.0842063,0.505545,0.159756,-0.303984,-0.287705,-0.191322,0.0324227,-0.13554,0.976387,-0.244903,-0.347837,-0.225282,-0.150151,-0.369492,-0.802763,-1.04965,0.216479,-0.0463312,-0.660865,-0.0653366,0.774872,-0.43503,0.191373,0.673664,-0.0671538,-0.0393794,-0.356878,-0.937372,-0.598535,-0.560733,0.358481,0.103626,-0.387864,0.921045,0.349502,0.00822977,-0.372341,-0.474571,-0.689867,-0.745409,-0.166955,0.255172,0.0634346,-0.0799036,-0.513802,0.0693965,-0.692176,0.48614,-0.337283,-0.424935,-0.390685,0.0215239,-0.724161,0.260894,0.636033,-0.812169,-0.652682,-0.201646,0.289139,0.104081,-0.306165,-0.105442,-0.400639,-0.509863,0.451631,0.63896,0.159455,0.581854,0.673807,-0.0919748,0.375725,-0.22025,-0.105865,0.675976,-0.104959,-0.0675971,0.0938024,-0.0738797,-0.329651,-0.519071,-0.124278,0.155476,-0.552159,0.165668,-0.154186,0.668353,0.408776,-0.299835,0.105648,-0.121724,-0.421126,-0.00901449,-0.00553524,-0.0908226,0.269728,-1.01919,-0.0564734,0.0565579,-0.779244,0.453188,-0.286968,0.303454,0.431051,-0.0141502,0.1727,-0.729582,0.293572,-0.0303798,-0.368978,-0.490809,0.449772,0.18758,0.034234,0.228921,0.367294,-0.507993,-0.150689,-0.0744334,0.36073,0.0170273,0.518154,0.0832041,-0.791336,0.194923,0.0557672,0.0777158,0.431392,0.077493,-0.204661,-0.280599,-0.0194265,0.0547159,-0.182924,0.0157559,-0.419443,-0.10485,-0.860559,0.509684,0.518113,-0.233999,0.0921297,-0.151651,-0.0673243,0.381332,0.506945,0.268708,0.44973,0.551053,0.312271,0.0160414,-0.413063,0.00941585,0.0157188,0.179638,-0.364524,0.350543,-0.0437347,-0.500209,0.213422,0.0499885,-0.00208752,-0.0193778,-0.0361194,-0.545806,-0.35417,-0.0761288,-0.416118,-0.577012,-0.82277,-0.673892,-0.177162,0.273232,0.606154,0.0385533,-0.289591,0.432769,-0.0334122,-0.326745,-0.803895,-0.54824,-0.362771,-0.170446,-0.335187,0.100495,0.176517,0.0815228,-0.637019,-0.357352,0.0332603,-0.0959275,-0.0300257,-0.493624,0.268508,-0.245226,0.0374039,0.191765,0.2606,-0.120856,-0.0723083,0.0420153,0.918365,-0.0294815,-0.295337,0.243926,-0.389409,-0.117238,0.0134027,-0.729081,0.43664,-0.268325,0.35855,0.498229,0.057587,-0.921408,-0.362037,0.195237,-0.0480845,-0.395544,0.501163,-0.51691,-0.265585,0.193537,-0.223978,0.161793,0.0471666,-0.44752,-0.171305,-0.512634,0.48498,0.238625,0.236191,0.576098,0.0704407,-0.470243,0.12188,0.308594,0.641513,0.198444,0.720305,0.36121,-0.0130389,0.195439,0.327601,0.0904752,-0.437192,0.634191,-0.204914,-0.25103,0.239694,-0.383062,0.0460841,-0.244683,-0.00869226,0.227198,0.0708068,-0.0928814,0.208745,0.0977189,0.459432,-0.0950056,0.226632,-0.111897,0.0790149,0.0338189,0.0596396,-0.322393,-0.147215,-0.316606,0.305211,0.00489578,-0.0994114,0.649118,-0.376851,-0.240571,-0.138346,-0.316481,0.244493,0.20265,0.00594473,-0.371282,0.121855,0.123728,0.369816,0.00924393,-0.36764,-0.0235231,-0.16999,0.0525768,-0.443053,-0.129298,-0.00718968,-0.83509,-0.274197,-0.0591539,0.125177,0.202348,0.353804,0.449831,-0.637384 +3420.6,0.985122,0.0848144,4,1.66549,0.932548,-0.753585,0.1437,0.390064,-0.14749,0.106577,-0.138764,0.259898,0.145564,-0.197943,-0.318934,-0.430592,0.53244,-0.331662,0.468201,-0.322628,0.183261,-0.162442,0.0749684,-0.790731,-1.20473,-0.325365,-0.201249,-0.102652,-0.0540569,-0.181834,-0.477503,-0.0910888,-0.289944,0.663352,-0.460285,0.317764,-0.0557338,0.06204,0.0331759,-0.604436,0.320643,0.445199,0.0650024,1.16209,0.371829,-0.793612,-0.284806,0.131746,-0.0484232,-0.24679,-0.128156,0.251921,-0.158901,-0.0690198,0.255572,-0.0257448,-0.357875,0.985199,0.352198,0.171048,-0.735933,0.190308,-0.207223,-0.154455,0.838741,-0.726348,-0.0833057,0.0962158,-0.112363,0.022608,-0.342811,0.0994863,-0.556836,-0.428699,0.264651,0.14746,-0.0738531,0.350343,0.518159,0.518503,-0.301623,-0.546115,0.334985,0.312422,-0.226259,0.197544,-0.51753,-0.0122556,0.187501,0.271354,-0.523286,-0.254348,-0.455897,-0.589505,0.0845209,-0.219058,-0.256833,0.553324,-0.187205,0.232405,-0.395282,-0.169727,0.245259,-0.0638351,-0.0581515,-0.295182,-0.557532,0.264997,-0.418973,0.155293,-0.0291511,-0.0507093,0.798008,-0.527677,-0.29406,0.952717,0.279288,-0.440325,0.221734,-0.812895,0.000467388,0.469198,-0.313796,-1.04443,-0.0557688,-0.0489739,-0.396534,0.420636,-0.259102,-0.233491,-0.663518,0.104086,0.115172,0.0854983,-0.116498,-0.0263171,0.504379,0.0818121,-0.383565,0.161969,-0.419941,0.534857,-0.672823,-0.00183422,0.378968,-0.0636214,-0.341287,-0.231464,-0.473363,0.165726,0.177401,-0.0421196,-0.0319896,-0.660874,0.225709,0.303752,-0.278142,0.401961,0.205157,-0.202975,-0.164357,-0.195961,-0.246386,0.837635,-0.0880089,0.711641,0.235939,-0.176238,-0.627482,-0.0926494,-0.50183,0.0630019,-0.486078,0.320649,0.149106,-0.229649,0.0557391,0.08039,0.324868,0.330203,-0.541391,0.360179,0.489252,0.0105511,-0.426601,0.235748,-0.298562,0.0301339,0.295445,-0.406185,-0.221575,0.538508,-0.824653,-0.412765,-0.041191,0.0325139,-0.0861818,0.00206803,-0.0464955,-0.116616,-0.664667,-0.470165,-0.348322,-0.0709425,-0.2977,0.149279,0.0762697,0.604736,0.0338051,-0.713355,0.726371,0.157044,-0.234398,0.25297,0.181075,0.45805,-0.339045,0.00851179,0.203694,-0.893265,-0.12366,0.122449,-0.161574,-0.0523043,-0.271917,0.493711,0.162003,-0.276521,0.396261,-0.409406,0.116915,-0.335968,0.0457669,-0.554955,-0.139277,-0.143042,-0.334657,0.348101,0.405375,-0.17568,-0.357853,0.516839,-0.261756,-0.501205,0.0714819,-0.540515,0.109932,0.241385,-0.006459,0.245617,0.438927,0.112346,-0.552456,-0.00963498,-0.35696,0.498582,-0.413704,-0.254021,0.106766,0.388463,-0.229696,0.0929254,0.00708643,-0.457846,0.867586,0.181416,0.111484,0.103837,-0.215075,-0.0179802,-0.288688,-0.279137,0.172527,0.0326249,-0.673362,-0.70713,0.588435,0.293449,-0.477969,0.221451,0.375871,0.716386,-0.00537653,0.12041,-0.103215,-0.580643,0.303526,0.142066,0.462716,0.0173391,-0.188069,0.302842,-0.572142,-0.0467417,0.360026,0.148415,-0.180296,-0.12726,0.144247,0.216659,-0.204912,0.116671,-0.135655,0.261983,0.12718,0.173464,0.356624,0.41649,-0.981599 +3410.56,0.627927,0.0848144,4,1.74225,0.799075,-0.914841,0.259707,0.492827,-0.1027,0.0681741,0.122183,-0.200483,-0.337574,-0.490693,-0.48086,-0.722846,0.369054,-0.163073,0.446269,-0.433896,-0.166023,-0.302108,-0.277483,-0.369782,-0.436643,-1.42478,0.198705,-0.245269,-0.580472,-0.292268,0.0198847,-0.436323,0.0697108,0.642044,-0.537404,-0.147812,0.0478146,-0.498716,-0.173146,-0.146944,0.0136891,0.522294,-0.238525,0.942467,0.531204,0.152297,-0.415652,-0.294641,0.011244,-0.727798,-0.126774,0.407914,0.203517,-0.145722,0.113679,0.193525,-0.908633,1.13965,-0.325,-0.250926,-0.462058,0.569485,-0.481744,-0.0181253,0.968514,-0.147628,-1.49202,-0.603373,0.217409,-0.122727,0.129236,-0.167388,-0.389146,0.474467,0.29426,0.55706,-0.260582,0.830205,0.678562,-0.412173,0.357516,0.20765,0.303384,0.204273,-0.282362,0.201915,-0.177622,-0.538674,-0.663388,-0.251868,-0.861891,0.09323,-0.485837,-0.0694571,-0.191523,0.408317,0.30393,0.00528814,0.303219,-0.17297,-0.220873,0.224741,-0.0387445,0.15551,-0.0269944,-0.774706,0.155407,-0.58604,0.00484014,0.795118,-0.0791767,0.440443,0.812282,0.108583,0.0919954,-0.421322,0.0702332,0.375146,0.108451,-0.0286066,0.189823,0.141809,0.0332335,-0.830031,-0.247581,-0.121222,0.323523,-0.581095,0.0199031,-0.146583,0.897058,0.321076,-0.754528,0.947746,-0.430619,0.0624009,0.612873,0.174199,-0.149844,-0.0375502,-0.526285,0.392629,-0.489083,-0.507439,-0.523946,-0.369258,-0.117401,0.248074,-0.158065,-0.452337,0.668243,-0.45232,-0.121423,0.0897621,0.0139324,0.336434,-0.25832,0.350286,-0.0515355,0.129746,-0.0595026,-0.263249,-0.522318,0.590677,-0.289586,0.673314,-0.0721079,0.198491,0.527739,-0.0232583,0.113567,-0.00267378,0.124572,0.198778,-0.0951931,-0.262563,-1.0059,-0.547574,-0.52645,-0.35533,-0.265639,0.171304,0.612705,0.397944,-0.0449865,0.610885,-0.167065,-0.124586,-0.697811,0.231475,-0.0235833,-0.122959,0.368419,-0.176167,-0.208973,-0.134551,-0.525321,-0.559788,0.111765,0.0148657,-0.248515,-0.775171,0.313762,-0.135922,-0.048571,-0.0785194,0.356799,-0.27226,-0.573103,-0.859935,0.873744,-0.328554,0.347022,0.107766,-0.222281,-0.583438,0.272405,-0.863088,0.0646782,-0.390201,0.325311,0.305603,-0.389337,0.120485,-0.250534,-0.22385,0.271986,-0.247297,0.550862,-0.533172,-0.112626,0.163829,0.0364156,-0.505282,-0.151632,-0.388307,-0.0949755,-0.131066,0.60629,-0.168668,0.619009,0.211991,-0.745722,-0.0995136,0.562068,-0.321366,-0.609605,0.553854,0.23742,0.825451,-0.284877,0.113115,-0.565171,-0.108507,-0.544289,0.733795,-0.505811,-0.452021,-0.0467784,-0.56222,-0.228269,0.220771,0.046499,0.1809,-0.369093,-0.0881283,0.409791,-0.243387,0.101138,-0.134009,-0.219456,-0.240361,-0.587832,0.201466,0.0521897,0.0571066,0.229389,-0.776404,-0.129393,0.136461,0.0186927,0.0739451,-0.118177,-0.431286,-0.352649,-0.238889,0.169361,0.215363,0.347219,-0.0411447,0.621324,-0.224998,-0.0761323,-0.117181,-0.480975,-0.348765,0.415583,-0.0495432,-0.342437,0.578954,0.0390567,-0.324528,-0.227632,-0.308748,0.147479,0.254098,0.384029,0.504081,-1.04651 +3401.73,0.810272,0.0848144,5,1.69038,0.97052,-0.849723,0.0917333,0.233372,-0.111503,-0.105169,0.0960981,0.244732,-0.992374,-0.234613,-0.353074,-0.977591,0.124419,-0.377235,0.183102,-0.614971,-0.0884343,-0.0614793,-0.0944721,-0.472701,-1.03773,-1.27728,0.0588066,0.098762,-0.227635,-0.261922,-0.153922,-0.231265,-0.559291,0.747123,-0.711643,-0.579367,0.0517326,-0.299835,0.276143,-0.776009,0.732295,0.205296,-0.00405212,1.14854,0.786494,0.19458,-0.132612,0.301803,0.104925,-0.855367,-0.154322,0.341745,-0.451083,-0.14127,-0.0305528,0.0645574,-0.303792,1.20928,0.121524,0.0672175,-0.464515,0.62623,-0.245966,-0.048773,1.0585,-1.2376,-0.907172,-0.0337177,0.230701,-0.166263,-0.402738,-0.08993,-0.355796,-0.222931,0.558184,0.314989,0.0127908,0.740465,0.547453,0.670821,-0.436142,-0.745712,-0.580478,-0.522113,0.184434,-0.205801,-0.655429,-0.452907,-0.193475,0.547653,-0.396932,-0.0394453,-0.704128,0.554167,0.658811,-0.167205,0.0727532,0.0480591,-0.348387,-0.263599,0.0137164,-0.0633808,0.285898,0.0221154,-0.183619,-0.695794,-0.447124,0.724401,-0.234054,-0.132381,-0.436433,0.167968,1.08443,-0.28603,0.191357,0.0772488,0.14622,0.432865,-0.260206,-0.470345,-0.169878,-0.217577,-0.340515,-0.701893,-0.182975,0.388784,0.354022,0.174238,0.18864,0.39696,0.49582,0.133519,-0.736614,0.131369,-0.1801,-0.0859375,0.702875,-0.0542577,-0.462021,-0.0885365,-0.606567,0.12787,-0.557384,-0.0902909,-0.08315,-0.19842,-1.38841,0.223634,-0.311921,0.085173,-0.182037,-0.122073,-0.0682151,-0.222203,-0.202686,0.308487,0.17517,0.131585,0.485844,0.466978,-0.384315,0.264347,-0.16065,0.313935,-0.106711,0.51342,0.179105,-0.0568619,-0.0828739,0.3065,-0.113779,-0.326624,0.0990646,-0.0675645,-0.000395095,-0.397236,-0.0259335,0.276672,-0.482988,-0.438846,-0.245631,0.365155,0.504856,-0.343593,0.416615,0.0802613,-0.12947,-0.0847877,0.110222,-0.43101,-0.289057,0.265903,-0.39673,-0.156139,0.0638935,0.368244,-0.0462764,0.187753,0.0629565,0.310375,-0.424458,-0.804695,0.856797,-0.263851,-0.196594,0.480201,-0.199227,0.169447,0.270795,0.165404,0.575467,-0.289325,0.314202,-0.629795,0.23417,-0.298054,0.0112615,-0.249327,0.332806,-0.186527,-0.036296,0.27824,-0.353588,-0.429071,-0.609457,-0.140608,0.588941,0.0879978,0.299891,-0.615847,-0.218068,0.0206992,0.160738,-0.504646,-0.25488,-0.0662003,0.23654,-0.813264,0.201839,0.0899566,0.0229799,0.20219,-0.399582,0.491471,0.197527,0.0557886,-0.109034,0.102933,0.210966,0.0323852,0.455924,-0.264279,0.0676331,-0.158887,-0.527039,0.610971,-0.478617,-0.467662,-0.0622324,0.23843,0.0160382,0.516555,-0.304479,-0.606884,0.368964,-0.427359,0.42074,-0.370167,0.255335,-0.357987,-0.440487,0.00112105,-0.0596447,-0.017443,-0.0841671,0.366425,0.00250105,-0.0852242,-0.163601,0.176856,0.143768,-0.0155552,-0.115878,0.0052833,0.218938,0.164077,-0.0749152,0.425157,0.543001,0.518212,0.534485,-0.120579,-0.675299,-0.423362,0.0945776,0.394353,0.128428,-0.453949,-0.497517,-0.626595,0.106262,-0.375505,0.0262507,0.234243,0.130213,0.363054,0.36085,0.602539,-0.41286 +3424.77,0.740563,0.0848144,4,1.68504,0.802786,-0.811947,0.0974211,0.317532,-0.179698,-0.414346,-0.331159,-0.208304,-0.428426,-0.32719,-0.296105,-0.516833,0.24183,-0.801242,-0.0957845,-0.179277,-0.17262,-0.0833299,-0.0569493,-0.545711,-0.615778,-1.26899,0.0659381,0.0252687,-0.33222,0.147999,-0.183369,-0.414937,-0.0556023,0.739128,-0.611717,-0.344961,0.227518,0.228687,0.301175,-0.339162,0.703703,0.225979,-0.0352444,0.958352,0.883109,0.397069,-0.143906,0.107577,0.0183473,-0.57989,-0.13189,0.305326,-0.337354,-0.00804801,-0.320247,0.0358503,-0.221138,1.44905,0.222096,-0.175475,-0.197502,0.905851,-0.206865,0.312887,0.926881,-0.62581,-0.51071,0.387913,0.54678,0.069936,-0.432048,0.0261185,-0.00252,-0.400952,0.187064,0.610016,0.0633344,0.954624,0.502215,0.213862,-0.742388,-0.477831,-0.388539,-0.114274,0.366521,-0.065337,-0.541362,0.108552,0.0560528,-0.170109,-0.231786,0.217102,-0.565993,0.667338,0.430145,0.0481223,0.0718919,-0.627598,-0.379694,-0.159208,-0.444864,0.191033,0.346944,-0.238169,0.230427,-0.795705,-0.321103,0.023058,0.164039,0.204808,-0.248306,0.450737,0.768099,0.265378,-0.326376,0.0799037,0.233628,-0.0345778,0.0266138,-0.6988,-0.0868475,0.213758,-0.202556,-0.384831,-0.150776,0.106814,0.4264,-0.10703,0.0283322,0.313755,0.367616,-0.087302,-0.305986,0.198229,-0.0185262,-0.112906,0.965208,0.0268403,-0.350789,0.238457,-0.579023,0.579653,-0.93433,-0.010529,-0.077692,-0.363528,-0.642181,0.162403,-0.219333,-0.261202,-0.219891,-0.308189,0.00171486,-0.267337,-0.531345,0.308586,0.175924,0.307148,0.182639,0.386292,0.127858,0.203841,-0.312743,-0.18834,-0.0104001,0.395154,0.124506,-0.0456883,0.253898,0.434648,0.110112,0.031998,0.14085,-0.326578,-0.103638,-0.255252,-0.436324,-0.0379724,-0.0903177,-0.116993,-0.408572,0.41165,0.239568,0.0141737,-0.122193,0.178912,0.429065,-0.810583,-0.52558,-0.327015,0.0322204,-0.116097,-0.375806,-0.255527,-0.315828,0.457983,-0.183016,0.256462,-0.210339,-0.0741603,-0.499752,-0.637658,0.566835,-0.177763,-0.101553,0.57053,-0.456563,-0.0291337,-0.122393,-0.613403,0.59056,-0.324874,-0.153802,-0.0831955,-0.106798,-0.288778,0.726539,-0.110922,0.334483,0.0646918,0.0865993,0.00419513,-0.42697,-0.442382,-0.873996,-0.276137,0.959013,-0.485004,0.5624,-0.39024,-0.509941,0.14356,0.14231,0.0818692,-0.138248,-0.59265,0.22925,-0.386171,0.446987,-0.127788,-0.0294859,0.30713,-0.558139,0.242417,-0.0326098,-0.158552,0.420949,0.215928,0.292042,0.394861,0.125692,-0.00461059,-0.411439,-0.0125896,-0.375102,0.507142,-0.196157,-0.27092,-0.0311994,-0.104199,0.14594,0.220173,0.00487553,-0.117614,0.606168,-0.495578,-0.217742,0.126451,0.231108,-0.256329,0.144298,0.150211,0.005312,-0.0150636,-0.298803,0.22382,0.243669,-0.194368,-0.195127,-0.0420084,0.174121,0.0919525,-0.317183,0.0383084,0.255555,-0.426077,-0.147676,0.963315,0.653218,0.32799,0.647999,0.0412373,-0.307335,-0.137407,0.239665,0.191934,0.131696,-0.282747,0.0401231,-0.192685,0.0063701,-0.71535,-0.0142305,-0.0222367,0.130609,0.38941,0.361399,0.624027,-0.409238 +3409.76,0.992226,0.0848144,4,1.51265,0.858042,-1.02917,0.152768,-0.125282,-0.137145,-0.493652,-0.00346691,0.504848,0.25345,-0.43139,-0.44084,-0.188624,0.419164,0.268288,0.523467,-0.055969,-0.462061,-0.453369,0.0572206,-0.064212,-0.683979,-0.763522,0.304038,-0.448001,-0.755898,-0.132017,0.128426,-0.607399,-0.25283,0.955929,-0.606784,-0.230964,0.213644,-0.0968565,-0.016849,-0.137368,0.400708,0.620496,-0.160084,1.36448,0.15981,0.347719,-0.370542,0.116668,-0.413978,-0.929224,0.329251,0.58482,0.239662,0.38838,0.41869,0.447042,-0.525875,1.14319,-0.10221,0.0782353,-0.273633,0.451722,0.0359797,0.153332,1.4759,-0.127651,-1.53007,-0.202502,-0.0112168,-0.0231411,-0.0564399,0.334031,-0.409374,0.0598511,0.264181,0.732716,-0.162274,0.266696,0.556185,0.0761713,0.592359,-0.202816,0.290496,0.297394,-0.454494,0.101406,-0.54399,0.0546042,-0.742064,0.130593,0.322581,-0.454395,-0.64983,-0.573235,-0.197755,-0.326087,0.0486913,0.947833,-0.527683,-0.588775,-0.0746371,-0.0226648,0.100481,0.265651,-0.621685,-0.159942,0.079691,-0.142448,-0.563875,0.258262,0.423708,0.448642,0.445917,-0.286056,-0.0757731,-0.202522,0.496844,0.179829,0.122795,-0.680891,0.362535,-0.144327,0.146251,-0.868095,-0.14206,-0.722342,-0.171105,0.317332,0.223067,-0.146517,-0.139808,0.768718,-0.390762,0.253527,0.0640215,-0.0623479,0.742894,-0.316277,0.371478,-0.525419,-0.000812263,0.0387571,-0.849747,-0.620865,-0.252575,0.361736,-0.234004,-0.694886,0.598606,0.0184679,0.745535,-0.588787,0.11332,-0.213328,0.299529,0.0967628,0.334174,-0.0188972,0.335099,-0.0234676,-0.382692,-0.107408,0.538229,0.191308,-0.0884678,1.21296,0.479664,-0.297256,0.458726,-0.00725662,-0.0443272,-0.105065,-0.251312,0.512581,0.169839,-0.101076,-0.119582,0.186415,-0.347772,-0.635652,0.538595,0.190296,0.486049,-0.00531822,0.267026,-0.257093,0.186286,0.489734,-0.289591,-0.189707,-0.200431,0.482241,-0.358025,0.326138,0.276492,0.185466,-0.44141,-0.293779,0.429725,0.0834971,-0.487157,-0.792537,-0.232725,-0.329746,-0.436216,-0.221139,0.25681,-0.196943,-0.148597,-0.222323,0.592859,0.319249,0.185489,-0.0954169,0.017641,-0.111311,-0.338972,-1.10368,0.0948023,-0.699554,0.142149,0.146057,-0.180611,0.3619,-0.434153,0.189038,0.228616,0.03054,0.670217,0.0103559,0.206184,0.229682,-0.377091,0.0722496,0.0522837,0.285757,-0.587104,-0.286794,0.435927,0.296349,-0.0494265,0.344537,0.0167238,-0.248789,-0.0482656,0.280875,-0.650956,0.162107,0.211196,0.692916,0.163682,-0.086413,-0.0305884,-0.325537,0.268814,0.440148,-0.149313,-0.0846248,-0.161404,-0.517815,-0.349678,0.109484,-0.204141,0.111449,-0.082411,0.149098,0.303177,0.448611,-0.0515767,-0.309915,-0.0180449,-0.0488848,-0.202354,-0.490277,-0.424142,-0.842731,0.204534,-0.151384,0.220391,0.0246873,0.292694,0.203586,0.392001,-0.252395,-0.755034,-0.601895,0.484182,-0.450629,-0.140015,-0.15008,0.190804,-0.0294423,-0.377309,-0.0832608,-0.173955,0.114877,0.19453,0.124595,-0.819567,0.174094,-0.359791,0.234517,-0.216849,0.0930752,0.150168,0.255513,0.387515,0.505483,0.841732 +3398.03,0.689822,0.0848144,5,1.62977,0.795207,-0.798727,0.0720662,0.237137,0.016276,-0.0892767,-0.0588645,-0.293896,0.0414542,-0.557648,-0.55372,-0.746015,0.14982,-0.197628,0.274563,0.0219281,-0.154951,-0.588677,0.0170544,-0.306402,-0.624599,-0.302634,0.283421,-0.352258,-0.181734,-0.0261312,-0.426588,-0.400582,-0.0832605,1.01705,-0.18857,-0.24281,-0.084439,0.13586,-0.247732,-0.263572,0.264746,0.407489,-0.161872,1.23862,0.473708,0.564519,-0.277877,-0.365261,-0.546418,-0.965411,0.184725,0.916369,0.0114499,-0.00997758,0.445869,0.321655,-0.998478,1.1563,-0.549128,-0.0990821,-0.362932,0.637742,-0.127173,-0.0972931,1.2428,-0.325236,-1.6257,-0.366569,0.279386,0.146345,0.204089,-0.245539,-0.675982,0.0826053,0.401696,0.463161,-0.207109,0.675019,0.658006,0.337156,1.02031,-0.182403,-0.0224566,0.00154435,-0.542129,-0.235312,-0.549149,-0.402564,-0.89606,-0.0636747,-0.408521,-0.41726,-0.74138,-0.284295,-0.270878,-0.407705,-0.0808263,0.245445,0.152452,-0.330598,0.0726448,-0.00556601,0.150133,-0.244685,-0.142396,-0.503177,0.235218,-0.311697,-0.137422,0.610848,-0.402412,0.641142,0.617579,-0.643359,-0.233377,0.293324,0.341431,-0.044442,-0.00149246,-0.477002,0.0750153,-0.176839,0.0282947,-1.36665,-0.368732,-0.397509,0.35647,0.197412,-0.317757,0.155696,0.203373,0.755061,-0.409508,0.2066,0.0427208,0.385197,0.528513,-0.126007,0.037334,-0.284824,0.0317498,-0.0945538,-0.692406,-0.545458,-0.0704373,0.382003,-0.223763,-0.0752507,0.573796,0.263682,0.452362,-0.297149,-0.240547,0.170524,0.2411,-0.116116,0.349672,0.0568198,0.0972825,0.0816049,0.100726,-0.319595,0.205247,-0.0979757,-0.617089,1.09724,0.243981,0.049028,0.152915,-0.132416,-0.410427,0.290415,-0.240828,0.276078,0.165134,0.0975691,0.0693404,0.215261,-0.747817,-0.0481164,0.349632,0.623372,0.522462,0.101718,0.0430889,-0.469189,-0.577832,-0.282167,-0.973243,-0.323423,-0.273624,0.295554,-0.549813,0.0558525,-0.210706,-0.231293,-0.845221,0.0382952,0.32789,-0.0414247,-0.372819,-0.524658,-0.222699,-0.268898,-0.513402,0.238514,0.644259,-0.500003,0.214482,-0.498584,0.553919,-0.138867,0.230888,0.0920061,-0.0857051,-0.223363,-0.201545,-0.739387,0.116032,-0.188633,0.168527,0.333302,-0.287101,0.729324,-0.746498,0.640314,0.232074,-0.142393,0.399224,-0.213447,0.107627,0.163244,-0.0157807,0.201337,-0.0354003,0.353713,-0.146954,-0.410234,0.628482,0.152727,0.0193666,0.131557,0.29894,0.278208,0.228095,0.0493847,-0.359202,-0.0268639,0.600618,0.737248,1.118,-0.322146,-0.0773166,-0.0128418,-0.176336,0.306862,-0.819662,-0.261297,0.170876,-0.315238,0.0189762,0.186118,0.235692,0.0663666,0.0373421,0.262008,0.530629,0.54522,-0.22026,-0.359233,-0.462089,0.190524,-0.578993,-0.0173635,-0.0897697,-0.91819,0.127037,-0.0959988,0.2527,0.0762597,0.45569,0.165325,0.189216,-0.169448,-0.228205,-0.121079,0.03879,-0.0412615,0.254579,0.205172,0.109735,0.460255,-0.297876,0.248502,-0.157636,0.114187,0.180733,0.315508,-0.430886,0.0893663,0.287221,-0.213676,0.104104,0.482324,0.140498,0.303709,0.37483,0.551098,-0.216111 +3396.44,0.959689,0.0848144,5,1.62583,0.794875,-0.98149,0.179647,0.105846,-0.0829973,-0.000169112,-0.371518,-0.153389,0.323317,-0.360991,-0.808949,-0.75244,0.213848,-0.578446,0.715268,0.098866,-0.192179,-0.532368,-0.258938,-0.00154674,-0.527875,-0.693135,0.112171,-0.172799,-0.246358,-0.0151617,-0.0444556,-0.62275,-0.190462,1.08255,-0.0657926,-0.256678,-0.0649111,-0.18541,-0.142084,-0.245817,0.343408,0.381857,-0.454962,1.25833,0.439428,0.548743,-0.377528,-0.0435523,-0.474259,-0.796836,-0.159549,0.877909,-0.0425623,0.171006,0.15405,0.251174,-1.0817,1.0238,-0.273394,-0.374741,-0.381784,0.344859,-0.0337161,0.126248,1.23342,-0.341995,-1.36692,-0.087495,0.042564,0.0957062,0.0876768,-0.039488,-0.735174,0.21115,0.564841,0.651548,-0.420944,0.731696,0.329047,0.00565502,0.607385,-0.185059,-0.0957909,-0.182661,-0.535623,0.367877,-0.833055,-0.164657,-0.623137,-0.423285,-0.296722,0.114194,-0.497976,-0.0475771,-0.26321,-0.135641,0.0280666,0.184941,0.183815,-0.686157,0.311177,0.421061,0.428701,0.100902,0.0191292,-0.562202,0.383953,-0.0896386,0.256583,0.422063,-0.419367,0.751245,0.587559,-0.807482,-0.196307,0.432825,0.34381,0.357166,0.131008,-0.37081,-0.164117,-0.325926,-0.269939,-1.3668,-0.289706,-0.253069,0.211523,0.132634,-0.296619,0.113878,-0.298682,0.511104,-0.178184,0.324487,0.152256,0.0607153,0.0395553,-0.465776,0.222282,-0.200102,-0.0723063,0.341721,-0.68809,0.148564,-0.124917,0.61898,-0.446198,-0.298581,0.564892,0.507714,0.633683,-0.432091,-0.213507,0.112706,0.212608,-0.249451,0.261256,0.140025,0.111255,0.00342513,-0.0277621,-0.0440446,0.172145,-0.270445,-0.558559,0.858022,0.122769,-0.176876,-0.00221736,-0.134215,-0.402173,0.368362,-0.290442,0.130844,0.542948,0.08995,0.377387,0.126276,-0.344717,-0.00339149,0.0505179,0.477303,0.695769,0.117027,0.212163,-0.266515,-0.163352,-0.14733,-1.02892,-0.174137,-0.270391,0.140614,-0.154841,0.385907,-0.368259,-0.138938,-0.640364,0.239568,0.240446,0.0771546,-0.218249,-0.24396,-0.0313564,-0.36785,-0.385204,0.330829,0.395521,0.313566,-0.124393,-0.508978,0.338678,-0.141005,0.22937,-0.0239125,-0.228818,0.0111105,-0.350883,-0.485931,-0.173451,-0.115242,0.283194,0.117526,-0.124105,0.322956,-1.01225,0.504557,0.495788,0.0365135,0.244205,-0.366113,-0.0736789,0.385478,0.225761,0.186188,-0.136248,0.176452,-0.396193,-0.393861,0.515186,-0.402937,-0.190808,0.277081,-0.198001,0.445763,0.24622,0.429643,-0.161852,0.314888,0.773355,0.496499,1.08496,-0.401647,-0.452916,-0.0644816,-0.0623129,0.522828,-0.315106,0.0175688,-0.138116,-0.299834,-0.542136,-0.084112,0.0982088,0.193449,0.504955,0.305072,0.360918,0.735963,-0.156436,-0.686862,-0.812885,0.379569,-0.821899,-0.112125,0.454864,-0.667212,-0.0569866,0.165773,0.254499,0.0231614,0.404288,0.068402,0.18029,0.272377,-0.139533,-0.263118,-0.0811196,-0.237013,0.184488,0.0432722,-0.0192105,0.56561,-0.543881,-0.0587296,0.0971094,0.287431,0.123205,0.382715,-0.434813,-0.172604,0.282467,-0.597847,-0.101263,0.581632,0.153601,0.292747,0.391919,0.541061,0.235222 +3412.98,0.924775,0.0848144,4,1.57342,0.892772,-0.604758,0.0439213,0.265932,-0.19022,0.10958,0.24605,0.308924,-0.298784,0.0906917,-0.414044,0.0482915,0.278798,0.612891,0.605404,0.189311,-0.33281,0.041745,0.176556,-0.356297,-0.721708,-0.637605,0.121901,-0.543213,-0.267045,-0.0333095,-0.351709,-0.545901,0.185033,0.964779,-0.333393,-0.0922681,0.561216,0.103658,-0.104142,-0.771802,0.668015,0.659377,-0.0161494,0.895942,0.245381,0.349106,-0.501486,-0.0961865,0.109198,-0.345466,0.161703,0.723152,0.209167,0.072268,0.47504,-0.388479,-0.515559,0.867424,-0.201245,0.0618548,-0.569256,0.594989,-0.116678,0.32195,0.978707,-0.568649,-0.443461,-0.599232,0.0394098,0.220297,0.266237,0.124995,-0.433736,0.0646523,0.49043,0.8038,-0.66239,0.519286,0.184093,0.302152,-0.15489,-0.0480481,-0.210778,0.238773,-0.091027,-0.0624633,-0.598745,-0.152787,-0.447263,-0.294687,0.393912,-0.455639,-0.688161,-0.384349,0.218389,-0.079451,0.200419,-0.106423,0.0485569,-0.135889,-0.573049,0.209692,0.415476,0.241399,-0.805894,0.208125,-0.570899,0.0251664,0.0439274,0.311702,-0.395262,0.293756,0.734982,0.336693,0.266781,-0.217005,0.554765,-0.0311619,0.388114,0.41289,0.523696,-0.338956,-0.132551,-1.02206,-0.274212,-0.187383,0.275085,-0.20909,-0.101044,0.644376,-0.165445,0.0687668,-0.511114,0.465701,0.0749459,-0.591571,0.212676,-0.458258,0.136348,0.0940567,-0.112358,0.065819,-0.445473,-0.410581,-0.039653,-0.253711,-0.134878,0.138093,0.255636,0.0203735,0.365911,-0.615085,-0.275199,-0.410532,0.128854,-0.0315633,0.625068,0.45994,0.304602,0.199443,0.1761,-0.238491,0.427432,0.426922,-0.00807656,0.577979,-0.259568,-0.724576,-0.0237144,-0.209294,-0.30901,-0.347431,-0.461368,0.413036,0.198461,-0.168867,-0.168371,-0.125213,-0.553031,-0.108108,0.107358,0.189696,0.463816,-0.473007,-0.441946,-0.110437,-0.112715,0.241857,0.0732068,0.531443,-0.0980619,0.485802,0.0243788,-0.256868,-0.134072,0.494064,-0.513653,0.10768,0.238035,0.110634,-0.272997,-1.16385,0.275543,0.0546691,0.135677,0.354172,-0.290988,0.360843,0.326208,0.0312339,0.586426,-0.0955048,0.123888,-0.281082,0.0292972,0.52924,0.447535,-0.451347,0.520677,-0.1565,0.117104,0.443047,-0.0921543,0.0982823,-0.217505,0.150036,0.181033,-0.0678148,0.298775,-0.631249,0.0704676,0.0865113,0.460267,-0.279447,0.342291,-0.085364,-0.0189476,-0.0883257,0.727533,0.219586,0.708972,0.463463,-0.219411,0.378548,-0.120942,0.236226,-0.020586,0.167559,0.208159,0.131062,0.493758,-0.461191,-0.370131,-0.526176,-0.0338361,0.255475,-0.0664768,0.00987142,-0.0437168,-0.283228,-0.134652,0.492127,0.0754056,-0.0126181,0.37005,-0.108465,-0.255234,0.257402,-0.208988,-0.387619,-0.0691895,0.516346,-0.0581278,0.150118,-0.410523,-0.91113,0.269101,0.276198,-0.0168396,-0.110971,-0.05662,-0.0818801,0.343032,-0.449858,-0.251502,-0.398769,-0.350294,-0.264185,0.117383,0.2348,1.0317,0.651824,-0.355035,0.341391,-0.198271,0.621547,0.610309,-0.0784096,-0.146196,0.0539288,-0.230433,0.340374,0.287487,-0.331383,0.125969,0.195464,0.354921,0.442113,-0.564143 +3422.39,0.972341,0.0848144,4,1.56807,0.902231,-0.623742,0.0322604,0.383106,-0.166312,-0.00381991,0.238395,0.228959,-0.236629,0.0378148,-0.409851,0.0317722,0.234087,0.597413,0.571088,0.235789,-0.270924,0.0111458,0.0488403,-0.328986,-0.779257,-0.884335,0.122273,-0.606776,-0.229148,-0.0909585,-0.201066,-0.598847,0.209276,1.02409,-0.201169,-0.248094,0.422428,-0.0795978,-0.108402,-0.831443,0.728809,0.628165,-0.151579,1.02224,0.221432,0.305403,-0.338296,-0.151825,0.109235,-0.359565,0.216685,0.631833,0.333605,0.0380658,0.316172,-0.39632,-0.408349,1.02409,-0.100933,0.0385536,-0.540441,0.45499,-0.18137,0.0899079,1.0145,-0.563979,-0.602852,-0.488933,0.114181,-0.0592257,0.211653,-0.00534932,-0.519389,-0.0265098,0.302863,0.738315,-0.663377,0.46178,0.216041,0.284986,-0.20117,-0.155479,-0.246842,0.65863,-0.0461557,-0.0510181,-0.629811,-0.188399,-0.215403,-0.139974,0.279272,-0.492595,-0.748015,-0.481883,-0.221956,-0.13221,0.244036,0.12812,-0.0459212,-0.172818,-0.707051,0.23097,0.365532,0.052035,-0.962036,0.126895,-0.515932,-0.0255255,0.117204,0.251998,-0.540789,0.441795,0.758472,0.112533,0.290292,-0.253844,0.621606,-0.178222,0.31106,0.0505973,0.330227,-0.160242,-0.0715349,-1.06853,-0.236065,-0.0831982,0.182278,-0.054391,-0.0726164,0.565699,-0.0883912,0.0472071,-0.619708,0.567103,0.0349028,-0.459285,0.119887,-0.529011,0.103139,-0.0962591,-0.0814157,0.0890195,-0.489509,-0.474874,-0.118572,-0.00876838,-0.290309,0.343111,0.250583,-0.171441,0.450915,-0.574772,-0.388116,-0.515103,0.277447,-0.161321,0.64929,0.594094,0.392181,0.0712978,0.302007,-0.217981,0.329461,0.472763,0.0442381,0.566993,-0.047111,-0.796221,-0.0775022,-0.186339,-0.352398,-0.383713,-0.387187,0.37904,0.108173,-0.24391,-0.250456,-0.139094,-0.463213,0.0162244,-0.0160972,0.378293,0.453703,-0.283368,-0.439749,-0.135313,-0.0366273,0.225715,-0.00955196,0.691975,-0.107515,0.487497,0.210376,-0.198343,-0.0786591,0.371867,-0.548158,0.123521,0.232162,0.135435,-0.314263,-1.07255,0.28976,-0.0058839,0.140359,0.31163,-0.248717,0.371269,0.473669,-0.00253063,0.505341,-0.100462,0.215773,-0.266365,0.0788369,0.5399,0.510724,-0.541993,0.510403,-0.0875285,0.170016,0.539915,-0.0317507,0.158868,-0.187764,0.141645,0.161407,0.0345159,0.180213,-0.649901,0.238339,0.291906,0.339115,-0.373753,0.474225,-0.0951914,0.00849327,-0.0640089,0.787173,0.3608,0.628979,0.412921,-0.159707,0.441207,0.0116261,0.109253,7.63875e-05,0.114757,0.226948,0.0460162,0.424449,-0.459188,-0.437417,-0.418449,0.0463394,0.237836,-0.267595,-0.0745869,-0.00844815,-0.380326,-0.137838,0.562868,0.201349,0.0111393,0.527604,-0.0301617,-0.151179,0.258696,-0.120204,-0.333878,-0.0509401,0.248622,-0.132094,0.0633453,-0.361711,-0.755447,0.327989,0.195877,-0.206227,-0.108935,0.0243637,-0.0690442,0.545209,-0.425387,-0.42301,-0.397007,-0.400362,-0.0811928,0.330773,0.215158,0.936364,0.66341,-0.229034,0.2391,-0.268889,0.414086,0.559328,-0.171439,-0.308765,0.101808,-0.205746,0.269777,0.228859,-0.323932,0.114811,0.199248,0.338838,0.446372,-0.960152 +3398.16,0.993781,0.0848144,4,1.5268,0.975884,-1.08594,0.41136,0.480911,-0.0871423,-0.00250677,0.427477,0.513365,0.663284,0.0489443,-0.134307,-0.505145,0.502183,-0.463697,0.810834,0.150888,-0.143229,-0.0367693,0.0440219,0.0968258,-0.778502,-1.50814,-0.310218,0.253738,-0.525825,-0.0523247,0.455228,-0.324317,0.0866187,0.583903,-0.213072,0.223188,-0.155582,-0.606233,-0.402491,-0.636343,0.641914,0.473439,-0.0657425,0.990988,0.159073,0.632851,-0.934234,0.012962,0.467821,-0.292707,0.0380886,0.695353,-0.226866,-0.527507,0.612266,0.00455533,0.107955,0.616168,0.134436,-0.146891,-0.699697,-0.17392,-0.403298,-0.220986,1.08673,-0.30055,-0.605258,-0.184203,0.628292,-0.202677,-0.113593,-0.0273871,-0.435236,-0.741821,0.628422,0.148946,-0.107376,0.774003,0.407054,0.16645,-0.0410514,-0.539407,-0.246779,0.165377,-0.120936,0.59056,0.145264,0.101333,-0.189472,0.301738,-0.496164,0.0526537,-0.401303,-0.00584784,0.232885,0.277426,0.265849,0.521324,1.11836,-0.743279,-0.219302,0.327839,0.235786,-0.00871192,0.280693,-0.306708,0.159189,-0.308495,-0.298917,-0.0930853,-0.353782,0.391778,1.01225,-0.267468,0.492687,0.332437,0.186097,0.272719,0.0100566,-0.326284,0.503113,-0.436031,0.252473,-0.371616,-0.196964,-0.374519,0.301427,0.455811,-0.0910806,0.0135757,-0.214994,0.186832,-0.628608,0.282483,-0.308373,-0.669203,0.824986,-0.403675,0.31617,-0.350973,-0.217268,0.364378,-0.444536,0.0477499,0.198068,0.0357731,-0.000304588,0.282113,0.921901,-0.0895346,0.114807,0.0698925,0.152128,-0.133102,0.524892,0.509568,-0.593942,-0.135382,-0.040618,0.00611612,0.02305,0.524467,0.584578,0.0137238,0.0723784,0.861373,0.0536062,0.349081,-0.201873,-0.540935,0.234518,0.0465388,-0.660971,0.536252,-0.266901,0.134063,-0.34577,-0.373191,0.244824,0.292221,-0.146282,0.119454,0.739446,0.602125,-0.220115,0.435378,0.0486926,-0.182957,-0.383671,-0.379056,-0.324197,0.321542,-0.212661,0.0182063,0.0408868,0.152693,-0.446612,0.180402,-0.274836,-0.681856,-0.645971,-0.397869,0.610527,0.317611,0.212216,0.465407,-0.261027,0.277628,0.102899,-0.688115,1.01519,0.126555,0.108878,0.292047,0.156656,0.0184634,0.607766,0.229601,-0.653672,-0.545767,0.211251,0.720749,-0.117565,0.0847181,-0.142951,-0.0449792,-0.210268,-0.299377,-0.0629651,-0.669854,0.0769034,-0.217292,-0.0379105,-0.466687,-0.332372,-0.541659,-0.206318,-0.0424094,0.671597,-0.0771865,0.603782,0.25008,-0.451749,-0.211734,0.867829,-0.0140168,-0.0299838,0.133416,0.334943,0.307502,0.385321,-0.328177,-0.319497,0.127631,-0.132772,0.243016,0.330718,-0.284802,0.377533,-0.34232,0.292184,0.507662,0.0109676,0.301228,0.525545,0.622827,0.119461,0.331858,0.546159,0.119387,-0.359012,0.185231,0.337577,-0.00104908,0.0134792,-0.587449,0.297737,-0.0826178,-0.45721,-0.152532,0.0978206,0.412381,-0.147514,0.0111969,-0.831123,-0.387962,0.0979389,-0.223068,0.323554,0.631537,0.114786,0.149991,-0.205458,-0.0401691,0.555612,-0.310489,0.249467,0.459321,-0.913628,0.0763074,0.214289,-0.299463,-0.116598,0.332592,0.144147,0.26257,0.379666,0.512416,-1.59279 +3407.55,0.765437,0.0848144,4,1.52166,1.02237,-1.06405,0.337917,0.54764,-0.0721488,0.013172,0.367906,0.578703,0.662335,0.0588622,-0.122976,-0.537334,0.431972,-0.407176,0.781822,0.138063,-0.105205,-0.113646,0.033658,0.0165493,-0.804357,-1.47143,-0.361756,0.259827,-0.616981,-0.00894298,0.422474,-0.203718,0.0932018,0.633442,-0.143967,0.234792,-0.183967,-0.585497,-0.289532,-0.640712,0.564683,0.576858,-0.162189,0.903512,0.125544,0.59437,-0.84274,-0.0810731,0.427345,-0.371344,0.0212597,0.71927,-0.309134,-0.515002,0.714778,-0.0779275,0.149601,0.529113,0.000116645,-0.0870066,-0.547357,-0.100915,-0.434316,-0.135334,1.13834,-0.410465,-0.519848,-0.228699,0.615772,-0.213724,-0.161969,-0.104463,-0.445984,-0.670673,0.69952,0.162804,-0.12819,0.825377,0.442478,0.111283,-0.1462,-0.465438,-0.294864,0.197819,-0.0839063,0.598318,0.204435,0.165867,-0.066096,0.259342,-0.380474,0.0262418,-0.461983,-0.0446483,0.0847909,0.250407,0.178153,0.539314,1.01922,-0.753645,-0.289752,0.378074,0.184948,0.0550636,0.285304,-0.44104,0.133393,-0.280596,-0.373773,-0.100469,-0.371505,0.296103,1.03209,-0.476063,0.444373,0.327019,0.281586,0.268572,0.155443,-0.186643,0.518887,-0.332608,0.385356,-0.487378,-0.29185,-0.47476,0.39967,0.467079,0.0900022,0.10953,-0.150432,0.352143,-0.605047,0.183901,-0.220728,-0.597435,0.753183,-0.354252,0.387121,-0.329379,-0.274884,0.420943,-0.620965,0.136343,0.0724112,0.0308875,0.0920331,0.245289,0.931289,-0.0743872,0.0707647,0.0459556,0.0640851,-0.177387,0.441644,0.467741,-0.629993,-0.206147,0.0696561,0.0788222,0.150257,0.536059,0.519984,0.0801957,0.126022,0.931088,0.176922,0.358511,-0.192472,-0.575995,0.247235,-0.0322842,-0.676922,0.433574,-0.30549,0.0199456,-0.210293,-0.397751,0.0997614,0.179728,-0.144128,0.135843,0.704278,0.60056,-0.149083,0.384547,0.0478861,-0.229034,-0.433403,-0.408452,-0.195508,0.412015,-0.388168,0.0757801,0.185074,0.0574291,-0.399339,0.160823,-0.152807,-0.804465,-0.683571,-0.334092,0.534922,0.289327,0.155115,0.443995,-0.324006,0.179556,0.03293,-0.648003,0.969187,0.109567,0.0996267,0.311158,0.178009,0.109009,0.394627,0.332048,-0.492766,-0.483978,0.151099,0.696772,-0.136121,-0.0732943,-0.0841976,-0.193107,-0.101363,-0.316301,0.00174985,-0.622488,-0.0116171,-0.220913,0.0603761,-0.486218,-0.282542,-0.544558,-0.192445,-0.0793878,0.697263,-0.125714,0.531799,0.259314,-0.41887,-0.304707,0.958602,0.114319,0.120225,0.103756,0.362759,0.331395,0.401708,-0.307295,-0.35564,0.0859186,-0.0652398,0.202805,0.289627,-0.332791,0.392778,-0.404401,0.315358,0.50402,0.0354613,0.212839,0.448962,0.60667,0.206756,0.291508,0.453948,0.0717603,-0.299393,0.137984,0.271557,0.096576,0.0646094,-0.517181,0.425363,0.0213858,-0.417414,-0.149802,0.12854,0.304252,-0.107575,0.003695,-0.857007,-0.429466,0.278656,-0.21258,0.23408,0.653942,0.236581,0.23256,-0.283815,-0.0544453,0.518987,-0.230906,0.175536,0.507821,-0.893287,0.0894359,0.256732,-0.205101,-0.110979,0.409803,0.14368,0.275575,0.379051,0.524952,-1.84725 +3420.87,0.9753,0.0848144,4,1.5247,0.97512,-0.852194,0.313664,0.67628,-0.174094,-0.146697,0.60292,0.689746,-0.0775234,-0.28729,-0.271287,0.0880182,0.309703,-0.0638605,1.02889,0.118954,0.253223,0.538511,0.146337,-0.01979,-0.778612,-0.33351,-0.182659,-0.199268,0.214317,-0.324649,0.515056,0.0983237,0.453213,0.939207,-0.153778,0.310853,-0.025125,-0.495684,0.237708,-0.253575,0.330805,0.693552,-0.424499,0.95574,0.90339,-0.0226684,-0.420154,-0.286994,0.595922,-0.0837777,0.12941,0.343849,0.0676943,-0.158617,0.574469,-0.266003,-0.192042,0.856306,-0.546528,0.140786,-1.12073,0.0974884,-0.253033,0.32312,0.988277,-0.345807,-0.938402,-0.0947051,-0.464711,0.0764435,-0.0802524,0.473411,-0.296945,-0.364745,0.292861,0.514339,0.00341243,0.230058,0.352581,0.117324,0.223239,-0.303937,-0.529421,0.801446,-0.893767,0.172442,-0.224736,0.0271597,-0.337438,-0.123235,0.125419,-0.484566,-0.420712,-0.132232,-0.211592,0.391252,0.299051,0.0355743,-0.756093,0.227277,-0.427169,0.177349,0.0945058,-0.157524,0.485586,-0.798799,-0.475627,0.151232,-0.356893,0.535601,-0.230431,0.0261104,0.431241,-0.00952528,0.217816,0.0219168,0.0477281,0.206256,-0.0783767,-0.0694985,0.329293,0.510039,-0.572095,-0.625133,0.132047,-0.23981,-0.00946882,-0.0687149,-0.429463,0.0339433,0.179242,0.180989,-0.475902,0.742992,-0.0162318,-0.309494,0.375158,-0.0837244,-0.508475,-0.142073,-0.586101,0.00776536,-0.844665,-0.939622,0.0641102,0.00998457,-0.475106,-0.441645,-0.238642,-0.110477,0.592839,0.00824482,-0.535183,0.0650485,0.60596,0.222879,-0.689977,0.797395,0.504701,0.209016,0.234284,-0.0480702,-0.387818,0.0296922,-0.606639,0.55681,-0.235126,0.494132,0.444415,-0.00948409,0.036706,0.276357,-0.3878,0.535642,-0.0928554,-0.499054,-0.20924,0.148469,0.192942,0.0601527,-0.177244,0.584343,0.377422,-0.0353089,-0.0762005,0.395583,0.181274,-0.132124,-0.241037,-0.263314,-0.0419692,0.494083,-0.285139,-0.175086,0.488995,-0.391045,-0.762264,0.104976,-0.209124,0.160081,-0.399348,-1.00343,0.718064,0.277119,-0.585191,0.621268,0.157909,-0.240261,0.0466346,-0.230545,0.90277,-0.942249,-0.0917933,0.303105,-0.150261,-0.395107,0.213397,0.443784,0.319321,-0.135029,0.320442,0.306371,0.0810687,0.214664,-0.56083,-0.127711,-0.0400036,-0.270587,0.0759312,-0.00171116,0.00330906,0.469051,-0.0915096,-0.202716,-0.16651,0.436768,-0.568735,-0.281,0.790085,-0.140279,0.367176,0.434079,-0.592107,-0.735238,-0.106838,0.541291,0.257082,-0.0934,0.314566,0.486431,-0.144113,-0.233217,-0.293199,-0.361111,-0.854554,0.453716,-0.533957,-0.0657987,0.236521,-0.575097,-0.172499,0.46356,0.437124,0.0386035,0.231189,0.486794,0.189924,0.368488,-0.362606,-0.184848,-0.0775867,0.0418751,0.476056,0.161718,-0.650785,-0.15469,0.174109,0.31009,-0.00930806,0.0434002,0.188257,0.166523,0.167723,-0.0513687,-0.268448,-0.207744,0.574063,0.0258705,0.296407,0.489357,0.741083,0.518937,-0.582318,-0.31678,0.142681,-0.330639,-0.0583249,0.1055,-0.63558,-0.739236,-0.452898,-0.183782,-0.164861,0.293788,0.140858,0.208909,0.375311,0.457066,-2.25056 +3387.73,0.937812,0.0848144,4,1.61493,0.898051,-1.21008,0.537985,1.09706,0.0217161,0.198594,-0.206453,0.109685,0.680634,-0.0497886,0.207063,0.233637,0.228183,-0.368763,0.96377,-0.108372,-0.188336,-0.32776,-0.577031,-0.260612,-0.849785,-1.01659,-0.309167,0.0833819,-0.368526,0.400027,0.690337,-0.695094,-0.155356,0.627892,-0.429171,0.199908,0.442296,-0.802788,-0.05202,-0.455537,0.550723,0.681644,0.0193224,0.894122,0.444089,0.112601,-0.614555,0.16681,0.316218,-0.446519,-0.568633,-0.276646,-0.117462,-0.208967,0.562459,-0.0338239,-0.463561,0.593685,-0.438071,-0.386992,-0.376307,0.409639,-0.650447,0.26394,1.36023,-0.610771,-0.528687,0.357158,0.34348,-0.10403,0.373848,-0.0220578,-0.108372,-0.581817,0.0641546,0.399783,-0.460656,0.536086,0.522436,0.742026,0.0492896,0.0215748,-0.0493771,0.28895,-0.556854,0.758951,0.119635,-0.111633,0.319877,-0.216585,-0.0988678,0.679776,-0.118666,0.0112192,0.586196,0.0382018,0.389556,-0.244486,0.175841,0.13689,-0.286634,0.180842,0.198169,0.0121831,0.258952,-0.625422,0.115927,-0.377859,-0.575311,0.307136,-0.069358,0.736926,0.804695,-0.267256,0.00110389,0.397322,0.03595,-0.197642,-0.273711,-0.602911,-0.0159367,0.0335949,0.381379,-0.919402,0.085569,-0.203855,0.284884,-0.242258,0.589311,0.88027,-0.129028,0.445359,-0.066705,-0.575435,-0.261142,0.89043,0.439311,-0.0775447,-0.191066,-0.0973592,0.186887,0.326944,0.0470572,-0.151437,0.314507,0.176424,-0.259006,-0.543113,0.557833,0.108431,0.00062477,-0.108616,-0.348518,-0.328316,0.0605755,0.391159,-0.311712,0.435282,0.0276934,0.147519,-0.29376,0.0508858,0.267507,-0.15767,-0.00503631,0.691526,-0.421863,-0.466451,0.182884,0.0702361,-0.123396,-0.346283,0.0589978,0.112928,0.167181,-0.29538,0.461234,-0.250988,-0.226043,-0.380737,-0.196629,-0.484641,0.463428,0.31384,0.322086,-0.309154,-0.176873,0.0531682,-0.405606,-0.692948,-0.175297,-0.149103,-0.813892,-0.0404959,-0.540581,0.571347,-0.107808,0.404742,0.702902,0.013763,-0.54054,-0.624813,0.528786,0.00307747,-0.237171,0.550276,0.644921,-0.394866,0.290538,-0.671879,1.26606,-0.0602658,0.553929,-0.274993,0.0613641,-0.230307,-1.17245,0.153726,-0.243114,-0.244379,-0.359051,0.113074,-0.423574,-0.400673,-1.03045,-0.746642,0.174901,-0.477566,0.85643,-0.362351,-0.310937,-0.047561,0.00411574,-0.480537,-0.431303,-0.54398,0.186236,0.0963351,0.139349,0.234332,-0.174178,0.0981931,-0.374328,-0.44424,-0.2612,0.258794,0.22043,0.693243,-0.400986,0.827745,0.199259,-0.72483,-0.62221,0.183603,-0.409898,0.218401,-0.383408,-0.331539,0.633123,-0.308976,0.565016,0.0948477,0.220954,-0.261183,0.321197,-0.251295,0.0155329,-0.750799,0.226037,0.221284,-0.198733,0.383413,-0.380754,0.204513,-0.689548,0.688347,-0.215732,-0.311658,-0.691934,-0.187806,-0.929279,0.536352,-0.118251,-0.209618,0.142081,-0.241181,0.301127,0.0414844,-0.215892,-0.615188,-0.0179956,0.223238,0.605016,-0.329859,0.108922,0.150073,-0.355791,-0.137515,-0.3618,0.0248049,-0.532689,-0.878998,0.428147,0.0419412,0.154034,0.214451,0.392472,0.463089,-3.49463 +3401.34,0.99766,0.0848144,4,1.57235,0.928848,-0.95991,0.382844,0.777355,-0.02425,-0.195767,-0.163902,0.126313,0.360127,-0.243467,-0.074424,-0.178604,0.318413,-0.258733,0.574213,-0.0110147,0.131652,-0.0216694,-0.485569,-0.268057,-0.702779,-0.677046,-0.185531,-0.187443,0.267119,0.0912952,0.0352395,-0.7679,-0.0981501,0.427647,-0.194881,-0.0164877,0.473991,-0.676794,-0.173645,-0.590254,0.613948,0.986745,-0.274721,1.0661,0.310756,0.0932607,-0.54532,0.205843,0.122367,-0.412646,-0.205826,0.134586,0.04425,-0.260714,0.764811,-0.00783308,-0.438362,0.857105,-0.21434,-0.268269,-0.479278,0.718837,-0.325655,-0.0450513,1.20649,-0.627932,-1.0797,0.208404,0.167438,-0.299998,0.379594,0.0481362,-0.11179,-0.471323,0.235455,0.655225,-0.611592,0.709298,0.36499,0.387557,-0.158002,0.337233,0.34381,0.121108,-0.554816,0.469228,0.2127,0.788866,0.168743,0.630112,0.280972,0.685183,-0.214007,-0.243049,0.169193,-0.157978,0.336286,-0.141674,0.169095,-0.0780821,-0.57438,0.00918795,-0.36074,0.0307906,0.237115,-0.425291,-0.0970348,0.431697,-0.526765,0.271538,-0.0739371,0.478663,0.92558,-0.0977637,0.10797,0.571439,-0.191128,-0.163452,0.274083,-1.00001,-0.427767,-0.000384996,0.123824,-0.960765,0.185454,-0.13664,0.154377,-0.192432,0.257376,0.933249,0.13897,0.39068,-0.125333,-0.118672,0.0633893,0.55533,0.664075,-0.271539,-0.50434,-0.218047,0.147814,0.453312,-0.289818,-0.258813,0.4566,-0.480689,-0.338152,-0.84197,0.119791,-0.101265,0.20652,0.174789,-0.172886,-0.174673,0.00691903,0.182205,-0.715203,0.487892,0.533818,0.606976,0.0750223,0.0383495,0.308868,0.0484285,0.686027,0.36833,0.0699147,-0.367815,0.126957,0.350021,-0.420897,-0.344435,-0.398546,-0.0129925,-0.185531,-0.434834,0.326158,-0.00324997,-0.241622,-0.421181,-0.508096,-0.431674,0.246261,0.304619,0.334677,-0.113912,-0.0160606,0.123806,0.131016,-0.248315,-0.29033,0.043766,0.0592563,0.0442099,-0.165481,-0.278802,-0.00746056,0.344117,0.881125,0.301509,0.038338,-0.849221,0.388395,0.528474,-0.13588,-0.0617094,-0.156727,0.0224392,0.141549,-0.213119,1.10704,0.0462664,0.866532,-0.0822933,-0.307451,0.152518,-0.491678,-0.179108,-0.00655727,-0.461837,-0.110028,0.141462,-0.234656,-0.244711,-0.872035,-0.400464,0.307303,-0.295823,0.613095,-0.492595,0.195123,-0.869948,-0.0141483,-0.459114,-0.206156,-0.0943338,-0.240558,-0.14989,-0.0110135,0.0071013,0.210589,0.638271,-0.671791,-0.230792,-0.206706,-0.0153594,0.305436,0.939021,-0.363881,0.47379,0.0504416,-0.685423,-0.172665,0.0797075,-0.320333,0.597132,-0.22805,-0.388311,0.578225,0.0377305,0.137878,0.241917,0.221732,0.0432552,0.404793,-0.378095,0.562615,0.0145172,0.702472,0.0257454,-0.759975,0.0871594,-0.459128,0.157236,-0.195673,0.362371,-0.455528,-0.677508,0.0679097,0.0912635,-0.578777,0.549361,-0.416196,-0.496737,-0.242554,-0.0316951,0.0769361,0.0189031,-0.125706,-0.625583,0.383583,0.102009,0.130675,-0.630122,0.427479,0.192347,-0.310109,-0.127762,-0.151153,0.591456,-0.7732,-0.236112,-0.0353109,-0.433109,0.171013,0.315841,0.413538,0.561997,-2.50312 +3397.17,0.88357,0.0848144,4,1.57556,0.860458,-1.3302,0.538484,0.742594,0.00687405,0.135378,-0.37754,0.0740501,0.522579,0.218114,0.0668742,-0.19919,0.22903,-0.312385,0.697106,-0.158338,0.102429,-0.304943,-0.257353,-0.461091,-0.565048,-1.05373,-0.177669,-0.116913,0.233846,0.0613964,0.37245,-0.444985,-0.206759,0.631694,-0.368617,0.00483579,0.7153,-0.214489,-0.337297,-0.298767,0.324542,0.842841,-0.435372,0.826399,0.907786,0.115881,-0.870206,-0.0893424,0.27607,-0.516336,0.336422,-0.0135817,-0.129659,-0.386357,0.388066,0.328683,-0.531219,0.771022,-0.505671,-0.50899,-0.432988,0.556391,-0.0842086,-0.412307,1.43719,-0.300807,-1.30624,0.638009,0.0406501,-0.224714,0.148849,0.258896,-0.340722,-0.275847,0.457211,0.580495,-0.665047,0.862209,0.668649,0.444727,0.177738,-0.16383,0.218988,0.176667,-1.0667,0.684589,0.229044,0.531547,-0.123881,0.467883,-0.0996421,-0.0814004,-0.232397,-0.325446,-0.0319225,-0.409342,0.405178,0.0877538,-0.0253327,0.538897,-0.557367,0.377694,0.112898,-0.0483113,0.368535,-0.593111,-0.383524,0.495814,-0.30435,0.0864087,0.0717389,0.346285,1.04634,0.526642,-0.207191,0.0220549,0.0713235,-0.268468,0.119429,-1.39139,-0.139711,0.118012,0.257441,-0.657071,0.139105,-0.48294,0.186757,0.0641207,0.724095,1.14233,-0.0650657,0.371122,-0.616874,0.504394,-0.107305,0.105763,0.800091,-0.213068,-0.888247,0.315596,0.121346,0.343772,-0.612124,-0.0968513,0.314375,-0.520539,-0.334934,-0.568287,-0.142812,-0.519898,0.157511,0.490308,0.0204777,-0.0524736,0.167865,-0.0376247,0.000591273,0.539027,0.444929,0.112508,0.12531,0.245798,-0.0766902,0.398754,0.263065,0.329649,0.363727,-0.171588,-0.0358298,-0.262634,-0.268767,-0.115044,-0.547179,-0.170533,-0.0189115,-0.389072,0.142486,0.226611,-0.231343,-0.630575,-0.377884,0.128158,0.433803,0.228891,0.205587,-0.155002,0.118075,-0.515458,-0.16689,-0.571828,-0.403967,0.362673,-0.617652,0.01546,0.110969,0.179053,-0.433719,-0.129143,0.571298,0.243311,-0.208189,-0.769366,0.749756,0.146529,0.39398,-0.411965,0.0982245,-0.168312,0.309579,-0.666279,1.20406,0.287914,0.488896,0.0191563,-0.188389,-0.115909,-0.0547416,0.118479,-0.117605,-0.61991,0.123186,-0.323851,0.377764,-0.255979,-0.811921,-0.262479,0.302764,-0.724701,0.626839,-0.84942,0.28689,-0.641281,-0.367888,-0.939045,-0.449287,-0.208495,-0.0333311,-0.0127845,0.0673186,0.085538,0.313103,0.312482,-0.443011,-0.29324,-0.491416,0.241926,0.313742,0.420576,-0.42131,0.634509,0.349927,-0.678406,-0.565876,-0.0745313,-0.0996909,0.599583,-0.4363,-0.26737,0.358579,-0.0380886,-0.0506773,0.0525873,0.111869,0.141937,-0.209055,-0.585396,0.958278,0.328536,0.462412,-0.0168208,-0.688212,-0.130145,-0.444153,-0.0353865,0.298057,0.587127,-0.261507,-0.132959,0.123153,-0.346359,-0.42964,0.178294,-0.182458,-0.0559339,-0.310654,0.0963046,-0.0826839,0.0712084,0.317307,-0.272081,-0.202381,-0.206584,-0.295244,-0.446562,0.296178,-0.17302,-0.0915744,-0.600983,-0.504916,0.433605,-0.846067,-0.510849,-0.127065,0.130874,0.167388,0.276256,0.409131,0.525601,-2.22442 +3396.56,0.656407,0.0848144,4,1.53548,0.84245,-1.56593,0.67659,0.95092,0.037677,-0.0351887,-0.404975,0.0844169,0.402087,0.27685,-0.188324,-0.455057,0.306057,-0.251054,0.751298,0.0861439,0.0994313,-0.436734,-0.371376,-0.359063,-0.657555,-1.20667,0.0666099,-0.188234,0.238078,0.199143,0.312726,-0.334467,0.0010582,0.603848,-0.680743,0.201494,0.789719,-0.54266,-0.210531,-0.0333442,0.372173,0.630974,-0.425152,1.00361,0.801765,0.305451,-0.82424,-0.174037,0.247488,-0.450705,0.592226,-0.0683579,-0.0675794,-0.425535,0.74616,0.414629,-0.619371,0.474411,-0.421647,-0.280769,-0.596118,0.579868,0.0163712,-0.453254,1.40136,-0.284036,-0.979077,0.498309,0.0826785,-0.168376,-0.0101551,0.181233,-0.369382,-0.0645353,0.100068,0.657261,-0.76876,0.687724,0.408979,0.324517,0.0941024,-0.148668,0.350853,0.425523,-0.951037,0.573304,0.101929,0.138428,0.0216808,0.496559,0.0289207,0.056006,-0.304065,-0.403192,-0.0721597,-0.619752,0.417523,0.0969937,0.149559,0.623598,-0.481724,0.0677091,0.219103,0.0324378,0.0089507,-0.325148,-0.474762,0.323657,-0.199761,-0.0463379,-0.0982461,0.218602,0.990792,0.780314,-0.331587,-0.24746,0.047257,-0.111464,0.476814,-1.15536,-0.371098,0.0921769,0.243438,-0.882371,0.210347,-0.439093,0.26051,0.182283,0.68118,1.03539,0.166781,0.257092,-0.57468,0.450937,0.16071,-0.32373,0.672248,-0.195709,-0.724514,0.50027,0.246087,0.540164,-0.488222,-0.270719,0.31081,-0.445578,-0.385781,-0.17791,-0.447952,-0.500801,0.178985,0.520333,0.00616133,-0.104756,0.0654311,0.153382,-0.17301,0.31299,0.494061,0.0820917,0.189366,0.457173,-0.204979,0.42326,0.577537,0.236348,0.388423,-0.242717,-0.366719,-0.106967,-0.190034,-0.0286642,-0.269742,-0.130439,0.0691791,-0.386031,0.13964,0.0909203,-0.416968,-0.767175,-0.0846543,0.157742,0.403001,0.410807,0.326391,0.00807501,-0.119543,-0.132609,-0.143106,-0.902495,-0.325307,0.572459,-0.411603,0.124943,0.0727932,0.00538958,-0.376385,-0.0195418,0.390197,0.367317,0.127383,-0.810608,0.830788,-0.11526,0.0581077,-0.54835,-0.387447,0.284532,0.216418,-0.828113,1.20966,0.174083,0.318417,-0.210874,0.106589,-0.144265,0.0875533,0.257216,-0.0202113,-0.757655,0.114251,-0.177784,0.250453,-0.250479,-0.795682,-0.372154,0.229569,-0.793915,0.703084,-0.764874,0.232401,-0.351948,-0.292118,-0.755016,-0.490147,-0.155019,0.196977,0.202551,0.253306,0.177317,0.683693,0.196585,-0.101372,-0.515513,-0.394442,0.016048,0.234006,0.0327215,-0.671992,0.596978,0.481007,-0.435639,-0.524179,-0.125961,-0.156726,0.563677,-0.925763,0.210362,0.458344,-0.231065,0.0156671,-0.153516,0.155496,0.163904,-0.107347,-0.525111,0.708242,0.299205,0.351666,-0.0366657,-0.774719,-0.0303241,-0.463207,-0.321954,0.43975,0.410375,-0.2196,0.181327,-0.0564462,-0.422447,-0.505868,-0.141759,0.102418,-0.0937606,-0.665678,-0.140366,-0.381486,0.0678259,0.360267,-0.200706,0.27377,-0.313293,-0.264153,-0.514708,0.0242261,0.0031853,-0.122506,-0.399603,-0.62182,0.544697,-0.942286,-0.0567923,-0.124532,-0.249499,0.157669,0.317228,0.397076,0.56323,-2.93909 +3399.44,0.929932,0.0848144,4,1.63368,0.746386,-1.47541,0.636097,0.849634,-0.0185241,-0.114231,-0.207214,-0.124162,-0.0912381,0.0190913,-0.919343,-0.0182551,0.300964,0.023267,0.455639,0.251167,0.182634,-0.581726,0.0897329,-0.200065,-0.966614,-1.31467,0.0975244,0.157753,0.130186,0.939192,0.0193753,-0.357105,-0.204935,0.308597,-0.442008,-0.217806,0.354335,-0.533906,-0.364664,-0.837473,0.726718,0.71934,0.17876,0.947543,0.632448,-0.136536,-1.00466,0.142444,0.19563,0.0215469,0.200447,0.375861,0.0370727,-0.159418,0.557569,0.13594,0.29869,0.681281,-0.268717,-0.637839,-0.647131,0.444616,-0.541881,-0.239249,0.913586,-0.68364,-0.820119,0.125319,0.437997,0.120118,-0.92633,-0.0696596,-0.13107,-0.0914798,0.371273,0.595623,-0.431208,0.720917,0.36691,-0.0205451,-0.0792445,-0.360383,0.56491,0.640119,-0.16038,0.317004,-0.742061,-0.510131,-0.651134,-0.0832707,-0.32514,0.663098,-0.326675,-0.238584,-0.160585,-0.111199,0.0633843,0.477337,0.519715,-0.560093,-0.809333,0.426694,0.0655431,-0.0302499,0.359721,-0.155608,0.0642916,-0.236386,-0.345802,-0.0460977,-0.0721421,0.0568678,0.578756,0.325669,-0.390754,0.244443,0.00921654,-0.00278027,0.451155,-0.674549,0.260634,0.399602,0.571146,-0.624757,-0.0398857,0.475337,-0.132252,0.230607,0.889238,0.16413,-0.364785,-0.125148,-0.439958,-0.109167,-0.0334764,-0.317584,0.014768,0.00742051,-0.207153,0.645112,-0.142243,0.556535,-0.706495,0.58083,0.334214,-0.411595,-0.372977,-0.766761,-0.0613964,-0.647048,0.615484,0.20735,-0.061791,-0.145343,0.00156024,0.314989,0.0434531,0.35842,0.747871,0.866496,-0.535273,0.031908,0.0300937,0.102138,0.20741,0.632261,-0.132079,0.0458559,-0.493405,-0.11068,0.125922,0.256721,0.0190145,0.207838,0.133686,-0.387733,0.150763,0.313826,-0.0701937,-0.718083,-0.267957,0.566754,0.682192,0.429594,-0.438319,0.21153,0.104525,0.361367,-0.393423,-0.582885,-0.469774,0.791588,-0.222638,0.0627764,0.174584,-0.0862568,-0.430668,0.491299,0.646944,-0.127603,0.0793996,-0.528341,0.523185,0.236131,-0.524731,-0.0514067,-0.687419,-0.720728,-0.337873,-0.242311,1.35404,-0.0298463,-0.204947,-0.0748516,0.34905,-0.171822,-0.278837,0.165371,0.290303,-0.766709,0.146105,-0.352526,-0.337813,-0.142997,-1.32896,0.531773,0.190682,-0.633941,0.552098,-1.034,0.136289,0.668736,-0.218031,-0.0533275,-0.189619,-0.232147,-0.0148401,-0.15197,0.261818,0.0834301,0.533232,0.485355,-0.319202,-0.240472,-0.0298711,0.0893623,0.274961,-0.293614,-0.344135,0.348715,0.472117,-0.196867,-0.327244,-0.590291,-0.670576,0.0960372,-0.351579,0.598386,0.163962,-0.449158,0.144775,0.329662,0.0185866,-0.0993095,0.290168,-0.347578,0.308541,-0.0691335,0.530117,0.368647,-0.236487,-0.00682844,-0.0751495,-0.0732705,-0.341099,0.00464693,-0.156253,-0.278908,0.484643,-0.0785212,0.212775,0.197217,-0.271838,-0.335079,0.00864951,-0.551795,0.00792173,-0.0144325,0.530364,0.119702,-0.272979,0.212682,-0.415517,-0.328262,0.0108484,0.0356921,0.54545,-0.142219,-0.311852,0.0851169,-0.574615,-0.421026,-0.52416,-1.02078,0.162043,0.246463,0.402546,0.496451,-2.32991 +3395.15,0.982157,0.0848144,4,1.59612,0.750679,-1.94201,0.89346,1.57314,-0.199324,-0.459067,-0.606322,0.478849,0.0497007,0.532659,-0.226536,-0.465833,0.275635,-0.165983,0.713099,0.100315,-0.15379,-0.527127,-0.362036,-0.0769411,-0.76683,-0.932959,0.0634043,-0.749993,0.0520176,0.00908812,0.290734,-0.452731,-0.102146,0.3014,-0.905046,0.162489,0.553702,-0.213203,-0.0623288,0.238077,0.513001,0.697589,-0.395879,0.440045,0.833114,0.468655,-0.735413,0.00584721,0.0642326,-0.232811,0.59664,0.621076,-0.186447,-0.213989,0.514412,-0.299278,-0.557541,0.114199,-0.165961,-0.229424,-1.07666,0.477241,-0.591794,0.192071,1.32808,0.230432,-1.28749,-0.158007,0.0241633,-0.0832027,0.315561,0.096196,-0.635813,0.0208694,-0.0892388,0.531096,-0.457692,0.230186,0.234447,0.621554,0.131059,-0.191258,-0.0710088,0.358514,-0.0546021,0.445535,0.23653,0.539641,-0.220982,-0.108313,-0.145911,-0.310007,0.12741,0.2395,0.16652,-0.137907,-0.221277,-0.414905,-0.639417,0.00288316,0.113593,0.118544,0.618495,-0.145124,0.0243563,-0.123402,-0.760003,0.787437,-0.356401,-0.316084,-0.865953,1.13208,0.384171,-0.0992741,-0.375852,-0.135745,0.335206,0.220821,0.0537412,0.239982,-0.149705,0.140324,0.196823,-1.05507,-0.355588,-0.127237,0.215784,-0.152344,0.135465,0.58131,0.292833,0.302327,-0.541659,-0.284952,-0.442394,-0.324617,0.501312,-0.406871,0.205577,0.35425,-0.258404,0.433815,-0.632016,-0.460195,0.0427401,0.684116,-0.97356,-0.443016,0.302012,0.277651,0.0635096,0.24607,-0.527579,-0.0564271,0.134718,-0.239059,-0.279177,0.39364,0.241542,0.0972701,-0.23901,0.228014,-0.320379,0.850379,-0.103373,0.471537,-0.664658,-0.342751,-0.0843115,-0.648365,-0.33692,-0.404282,0.278334,0.333221,-0.365856,-0.0861224,-0.270611,-0.414332,-0.488897,-0.2035,0.282017,0.328532,0.32868,0.022306,0.37185,0.268666,-0.275576,-0.863267,-0.0874274,-0.0839551,-0.675208,0.384591,-0.201929,-0.0420999,-0.532711,0.0885409,-0.78331,-0.547983,0.397728,0.34752,-0.278743,0.0433177,-0.420134,-0.0462236,-0.436807,-0.0602767,-0.445646,-0.363731,-0.250051,-0.0510553,1.16472,-0.707564,-0.263223,-0.549024,-0.228313,-0.0961132,0.60796,-0.230214,0.167279,-0.225225,0.123795,-0.275818,0.177266,0.489271,-0.49513,-0.307822,-0.158282,-0.287768,-0.293269,-0.425011,-0.315911,0.262259,0.363239,0.133301,-0.0900698,0.265374,0.356861,-0.628382,0.473957,0.0177684,-0.580663,0.0497559,-0.647555,-0.00230446,0.271265,0.163781,0.00272851,0.433084,0.184252,0.108278,0.384097,0.329481,-0.461924,0.0683429,-0.242557,0.248183,-0.404422,0.135555,-0.0113592,-0.0439075,-0.115513,1.21149,0.27001,0.240012,-0.295684,-0.539441,0.663125,0.436903,0.38081,0.451907,-0.299238,-0.597009,-0.0284833,-0.227919,-0.0676065,-0.796403,0.355931,0.0728943,-0.655461,0.241548,0.112314,0.569262,0.611714,-0.00303567,0.324023,-0.75979,-0.0414269,-0.600684,0.101444,-0.221189,0.786501,0.707793,0.435861,0.00782534,-0.36666,0.494994,0.123246,-0.267478,-0.531971,-0.329902,0.433518,-0.555847,0.0779301,-0.121252,0.163957,0.288034,0.404916,0.536688,-4.73066 +3398.2,0.988585,0.0848144,4,1.563,0.613794,-1.29042,0.543678,0.271008,-0.0522718,-0.0612437,0.178629,-0.732335,-0.673814,0.625541,-0.697533,0.49271,0.950749,-0.106318,0.632548,0.113894,0.11489,-0.156155,0.381285,0.0883932,-0.934924,-0.679256,0.829755,0.0785415,0.289494,0.0961338,-0.188683,-0.690243,0.215798,0.739097,-0.245707,-0.0438321,0.116071,-0.427544,-0.560456,-0.526062,0.586482,0.168871,-0.441605,0.911866,0.679715,0.0202297,-0.214533,0.315302,-0.401249,-0.520259,-0.0601295,0.529086,0.267766,0.47651,-0.205381,0.254928,-0.000931411,0.501826,-0.181187,0.0922901,-0.443966,0.697555,-0.242939,0.122994,1.03135,-1.16845,-1.34329,0.496774,-0.0862929,0.132468,-0.396583,0.503806,-0.264347,0.196884,0.0239179,0.274935,-0.142386,0.374236,0.609424,0.152701,0.204019,-0.542544,0.186675,0.766017,-0.45255,-0.26121,-0.431542,-0.893632,-0.129006,0.0471451,0.171426,0.072945,-0.188729,-0.436945,0.0124891,0.170618,0.326369,0.487296,-0.165782,-0.0523992,-0.471045,0.343144,-0.0394721,-0.153456,0.30553,-0.545408,-0.274119,-0.0271881,-0.342154,0.291753,-0.310096,-0.791952,0.263958,0.363264,0.325965,-0.016926,0.577834,-0.253319,0.0554734,-0.338072,0.0256854,0.238136,-0.483295,-0.387978,0.437211,0.415905,-0.51531,0.262535,0.179761,0.129982,0.517432,-0.157989,0.201817,-0.130879,-0.0788834,-0.0533289,0.0425303,0.12222,-0.0508838,0.0331826,-0.517833,0.265975,-0.347521,-0.238018,-0.314033,-0.313943,-0.109893,0.173701,0.124535,0.183719,0.498952,0.128317,0.156223,-0.520852,0.0867824,0.567422,0.229865,-0.0540447,0.412005,0.207904,0.331997,-0.000470823,-0.0846138,-0.45243,-0.41793,0.00686079,0.746713,0.251549,0.279901,-0.318839,0.151829,-0.370203,0.0783997,0.0502027,0.74779,-0.0800393,-0.472663,0.189752,-0.00233779,-0.605991,-0.336604,0.327789,0.624851,0.0356805,-0.40418,0.233828,0.521209,0.244182,-0.682252,-0.596751,-0.204535,0.272828,-0.818778,-0.272928,0.444972,-0.252719,-0.498962,0.661763,0.469876,-0.54187,-0.283388,-0.734203,0.339915,-0.277447,-0.0424837,-0.234366,-0.0140637,0.518823,-0.17953,-0.939721,1.22536,0.310055,0.222861,0.469679,0.0936218,0.519833,-0.472238,-0.194161,0.442274,0.0191072,0.231349,0.38445,-0.448265,-0.717641,-0.577566,0.479157,0.649606,-0.658488,0.110288,-0.10419,-0.526879,0.164991,-0.159593,-0.301307,0.232873,-0.318118,-0.729536,-0.409725,0.088518,-0.122671,0.651443,0.59497,-0.0258869,-0.407818,-0.220475,0.178386,0.0909338,0.266294,-0.180239,0.252875,0.0525313,-0.775639,-0.35303,0.0240617,-0.688608,0.490069,-0.0344983,-0.0216456,0.304681,-0.429134,0.0960402,-0.839878,-0.350317,-0.176681,0.512706,0.434103,-0.115753,-0.0606941,-0.28842,0.126711,0.0531976,0.336117,0.197412,-0.0711222,-0.135912,0.271842,-0.142821,-0.034687,0.85225,0.051548,-0.340735,0.090184,-0.71007,-0.844863,-0.37064,-0.159434,0.0327265,-0.0739489,-0.0622818,-0.203219,-0.232805,-0.19995,-0.928648,0.286974,0.345742,-0.358348,0.277055,-0.236572,-0.287848,0.338106,-0.669289,-0.23771,-0.0105385,-0.5299,0.13448,0.451035,0.366716,0.671592,-0.246379 +3400.57,0.998152,0.0848144,4,1.54052,0.669082,-1.84162,0.78826,0.41675,-0.0299472,-0.0615603,-0.107247,0.708061,-0.37457,0.32868,-0.272239,0.181489,0.895383,-0.325691,0.849548,0.460249,0.0073436,-0.04944,0.307533,0.0846785,-0.608078,-0.527253,0.671276,-0.052096,-0.247658,-0.0743713,0.301446,-0.0764363,0.466838,0.597085,-0.796479,-0.602951,0.356147,-0.608544,-0.162261,-0.346409,0.735623,0.507716,-0.67203,1.03941,0.710583,0.296798,-0.331723,0.0228194,-0.175422,-0.122383,0.0880524,0.310638,0.00588719,0.171383,0.00365947,-0.0697043,-0.190695,0.0407381,-0.258532,-0.162356,-1.00815,0.265364,-0.0861897,0.318259,0.916013,-1.10465,-0.513096,0.286054,0.106575,0.146206,-0.266477,0.605484,-0.92039,-0.197677,0.074884,-0.166312,0.0417693,0.483849,0.0266554,0.0761573,0.0492048,-0.391088,0.26749,0.430049,-0.462241,-0.268407,-0.110399,-0.565794,-0.428343,0.517357,-0.156517,-0.0800815,0.0888619,0.409337,0.161574,0.425725,0.193421,0.424259,-0.144645,0.815132,-0.0532408,0.0944778,0.295771,-0.080714,-0.233402,-0.618856,-0.0536695,0.635998,0.256052,0.469717,-0.398437,-0.254027,0.236562,-0.48984,0.0303347,-0.354335,0.553208,0.0575633,-0.126763,-0.0355141,0.0463207,0.0862565,0.0404431,-0.430106,0.404064,-0.0822224,0.000719441,0.169478,-0.104477,0.222628,0.939787,-0.131587,-0.0533068,-0.437848,-0.601541,0.0640017,0.397709,-0.183708,-0.106454,0.0827818,-0.921023,0.505533,-0.0330553,-0.515737,-0.0757627,-0.104436,-0.682212,0.0197871,-0.592036,-0.0182432,0.101242,0.213032,-0.229042,0.579253,0.142764,0.00947052,-0.231252,0.494445,0.0545858,0.352078,0.630108,0.223549,0.659281,0.644676,-0.116182,0.861584,0.145548,-0.367087,0.208462,-0.137808,0.390909,-0.256581,0.0969538,0.29208,0.861797,0.299882,-0.242375,-0.347637,-0.500014,0.165414,-0.188353,0.181221,0.99369,0.743543,-0.201877,-0.357776,-0.126468,-0.374137,0.0355115,-0.253831,-0.422148,0.63121,-0.741661,-0.490968,-0.0201668,0.1638,-0.641596,-0.184224,-0.275945,0.00731497,-0.219049,-0.342104,0.155251,-0.296595,-0.556927,-0.584193,-0.0887498,0.224637,0.419676,-0.0148604,1.23871,-0.441754,-0.0104465,0.0200397,-0.238183,0.00305145,-0.115761,-0.588313,0.0440001,-0.013511,0.0567024,0.527052,-0.382669,-0.70597,-0.778988,0.0881084,-0.169858,-0.420453,0.304561,-0.269247,-0.655297,-0.0304453,-0.170396,-0.381654,0.319065,0.39491,0.0355047,-0.159979,0.395128,-0.194982,-0.133474,0.260591,-0.227216,-0.598057,0.213829,-0.540447,0.11139,0.0551949,0.19003,0.233621,0.695615,-0.234784,-0.5272,0.207591,-0.283733,0.507326,-0.963423,-0.120301,0.0695556,-0.676658,-0.0462403,-0.47197,-0.209108,-0.55041,-0.154503,0.03785,-0.253183,0.177467,-0.518457,0.117779,-0.321393,-0.516882,0.175654,0.0618492,0.156036,-0.589331,0.0616665,0.190782,0.0705825,0.192735,-0.698613,0.137196,-0.0559767,-0.140143,-0.626184,-0.57001,0.692585,0.312537,0.128152,-0.588278,-0.429133,-0.0205015,-0.35301,-0.0334343,-0.158616,0.00435641,0.240588,-0.10805,-0.874591,-0.119148,-0.148526,0.306965,0.150174,0.493464,0.150308,0.152122,0.387695,0.390028,-0.798357 +3395.17,0.910274,0.0848144,5,1.57465,0.64797,-1.51467,0.653774,0.0773839,-0.0344857,0.267099,0.188763,0.0260814,-0.324691,0.657348,-0.821273,-0.434054,1.2544,-0.217063,0.619928,0.43356,0.423119,-0.209931,0.197135,0.0392664,-0.498705,-0.567327,0.868443,0.284535,0.0757695,-0.196602,0.038373,-0.110298,0.346126,0.819586,0.256592,-0.586679,-0.0220912,-0.487443,-0.223742,-0.478522,0.271315,0.247504,-0.0723289,0.736733,0.35995,0.560981,-0.741594,-0.461241,0.168983,-0.392429,-0.305935,0.22701,0.259911,0.330236,-0.0129391,0.291667,-0.3118,0.2941,-0.0914336,0.080484,-0.310295,0.235391,-0.252215,0.416348,0.962311,-0.517205,-0.773858,0.119796,-0.0302447,0.130088,-0.302852,0.71621,-0.652411,0.0524118,-0.126144,0.26627,0.115516,0.463178,0.302897,0.374287,-0.13812,0.113833,-0.136276,0.410699,-0.935237,-0.103959,-0.653781,-0.241083,-0.160581,-0.879934,-0.0146244,0.0255088,-0.203055,-0.546133,-0.279353,0.126612,-0.0672589,0.219739,-0.260534,0.662838,-0.565551,-0.562722,0.524796,0.162889,-0.0764496,-0.830096,-0.136187,-0.0018802,0.237511,0.658513,-0.178367,-0.0665659,0.627941,-0.196436,0.0578609,0.213244,0.492591,0.389106,0.0391973,0.280847,-0.0302193,0.223508,0.162852,-0.517272,-0.052092,-0.326059,0.747965,-0.460481,0.241955,0.0844642,0.351997,-0.247625,-0.204148,0.555567,-0.600655,0.339586,0.037855,-0.0720471,-0.612219,0.118577,0.365642,0.443709,-1.0551,-0.426233,-0.132962,-0.217247,0.082504,0.129674,0.174702,0.213623,-0.556358,-0.190609,-0.28358,-0.481829,0.413515,0.44438,0.196117,0.859973,0.264392,-0.123662,-0.401652,-0.259709,0.481551,0.551002,-0.0173511,0.684031,0.308863,-0.425375,0.208931,0.115722,-0.268728,-0.131323,-0.0351242,-0.275702,0.88775,0.0810989,-0.918192,-0.395282,-0.168104,-0.53959,0.0387061,0.185717,0.577962,0.0828491,-0.200398,-0.275963,0.0216471,0.328939,-1.00158,-0.0766117,-0.851303,0.788166,-0.184188,-0.425064,0.24551,0.0414391,-0.932174,-0.372523,0.127124,-0.684963,-0.342584,-0.251539,0.132308,0.0199013,-0.213568,-0.038089,-0.0557808,0.277826,-0.408536,-0.755334,1.24768,0.135179,0.124135,0.299267,-0.0973573,-0.354623,-0.0444362,-0.296517,0.30196,0.595018,0.0751295,0.425253,-0.204818,-0.290011,-0.337537,0.554772,0.0961661,-0.178204,0.538069,-0.721424,0.00702562,0.805685,-0.602555,-0.613891,0.222788,0.0346412,-0.285745,-0.0512308,0.538578,-0.32227,-0.522358,0.549074,-0.226707,-0.0593729,0.268152,-0.585383,0.0400264,0.199012,0.564476,0.233598,0.826541,-0.0195266,-1.20776,0.175374,-0.393929,0.279694,0.0579224,0.089603,0.274266,-0.336261,0.0490802,-0.609802,-0.249615,0.456069,0.0980487,0.431932,0.228387,-0.0484617,-0.192512,0.330675,-0.509846,0.265547,0.0864788,-0.13163,0.111319,-0.517075,0.229919,0.244132,0.178233,0.0784209,-0.081844,0.157784,-0.340942,-0.264168,-0.441726,-0.410499,0.366987,0.0231272,0.0442218,-0.197238,0.297266,0.14578,-0.244208,0.193685,-0.10293,-0.162756,0.859233,-0.580681,-0.860613,-0.157545,-0.568362,-0.204298,0.409513,-0.373503,0.174223,0.240652,0.4174,0.490563,0.356605 +3386.15,0.986144,0.0848144,5,1.64556,0.928487,-0.191548,0.0055378,0.13093,0.0925305,-0.373582,-0.545288,0.460515,0.851343,0.365615,0.206742,0.199963,0.321124,0.168514,0.918648,-0.144759,-0.255376,-0.28815,-0.462019,-0.403418,-1.36109,-0.763137,-0.243224,-0.177865,-0.415386,-0.159071,-0.209245,-0.247547,0.0412248,0.399619,-0.627097,-0.0834062,0.203781,-0.0680763,0.351446,-0.768045,0.574193,0.470595,-0.34463,1.21367,0.462653,-0.284283,-0.260456,-0.113584,-0.660852,-1.21497,0.532073,0.659314,-0.442146,0.515372,0.826024,-0.176058,-0.650683,0.840551,-0.316278,-0.00799447,-0.858557,0.379492,0.215682,0.114803,0.678971,-0.50585,-0.764614,-0.216638,0.304134,0.172155,0.0321767,-0.632733,-0.673333,-0.0644625,0.953596,0.678782,-0.379595,0.532504,0.595194,0.407594,0.257595,-0.404633,0.137836,0.438436,0.34208,0.73449,0.0683518,-0.165088,0.242853,0.935928,-0.640913,-0.574728,0.0808995,0.625118,0.186975,0.0443399,0.199,-0.144907,0.207804,-0.376818,0.0265423,0.62971,-0.439914,0.0164417,0.155265,-0.371873,-0.705004,0.170012,-0.423865,0.134965,-0.31635,0.574221,0.579328,-0.540467,-0.233461,-0.0351902,0.409793,-0.289458,-0.259979,-0.892593,0.169426,0.000230448,-0.268432,-0.703321,-0.479237,-0.147892,-0.616842,0.197085,0.460529,-0.0307823,-0.160358,0.100027,-0.205985,-0.351798,0.149082,-0.0844165,0.786313,-0.147717,0.43102,-0.148909,-0.340222,0.298845,0.0935182,-0.166839,0.277141,0.16311,-1.11364,0.236652,0.235219,-0.481508,0.48253,0.451187,-0.38523,0.110185,0.0802973,0.146415,-0.274836,-0.465523,0.317812,0.108832,-0.0094138,-0.112784,-0.375162,-0.402947,-0.351049,0.117081,-0.33738,0.495766,0.244917,-0.314221,-0.130344,-0.0404231,-0.323769,0.59054,-0.599706,-0.0534846,0.386113,-0.139151,0.551273,-0.0602426,-0.254026,0.0329434,0.815172,-0.0974214,-0.0384974,0.907421,0.194401,-0.181318,0.277851,-0.274187,-0.30854,-0.0134283,-0.206122,0.122452,-0.199177,-0.19492,-0.121971,0.527306,0.385302,0.878046,-0.227955,-0.746776,0.240432,0.151007,-0.209664,0.0847123,0.217475,-0.240336,0.162143,-0.530601,1.32779,-0.460483,0.0737712,-0.0095449,0.0666233,0.308021,0.42497,-0.0615431,-0.0510894,-1.08407,-0.252465,0.375058,-0.324432,-0.0749637,-0.730983,-0.132224,0.321664,-0.575452,0.158201,0.247346,-0.540605,-0.746405,0.605986,0.431528,0.261325,-0.38763,-0.341039,-0.783194,0.121257,0.119588,0.488635,0.516522,-0.326475,-0.121876,0.560201,0.676101,0.0400062,0.150305,-0.465917,-0.227978,-0.24666,-0.0101094,0.133988,-0.150595,-0.942899,0.366901,-0.47026,-0.431639,0.337737,-0.301652,-0.0800872,0.610401,0.408862,-0.371558,0.257528,-0.444054,0.114008,0.214721,-0.223982,0.1025,0.287839,-0.516896,0.00384826,-0.010589,-0.664356,-0.0655033,-0.288658,-0.398766,-0.500338,-0.491533,0.110365,0.122832,-0.053301,-0.391994,0.208562,0.0239389,-0.280027,-0.117009,0.139743,-0.101043,-0.237967,-0.0697328,0.135553,-0.062756,0.269861,-0.171021,-0.553165,0.124509,-0.287757,0.19456,0.363781,-0.39316,-0.733977,0.401727,0.148881,0.358009,0.385852,0.598338,-0.358364 +3380.03,0.984029,0.0848144,4,1.59323,0.862867,-0.641641,0.181856,0.412778,-0.0185087,-0.382717,0.277597,0.128374,0.145691,-0.133872,-0.388824,-0.562285,0.0284307,0.0635606,0.388395,0.246186,-0.494305,-0.255307,-0.221325,-0.438168,-0.778167,-1.08535,-0.0829219,-0.214914,0.0557109,0.0948915,-0.144398,0.0529182,0.0156057,0.383571,-0.88246,-0.407408,-0.316544,-0.611807,0.22283,-0.425463,0.128754,0.073463,-0.191916,1.29145,0.436455,-0.142811,-0.756099,0.496198,-0.405357,-0.70883,-0.11783,0.627173,-0.773059,-0.258994,0.178093,0.0248474,-0.152118,0.940338,-0.622031,-0.145829,-0.637708,0.33691,-0.194012,0.280322,0.833486,-0.253549,-1.22055,-0.508119,0.397118,-0.101442,-0.208431,0.148034,-0.249597,-0.125709,-0.0301631,0.841542,-0.021518,0.954978,0.582136,0.711837,0.506569,-0.298415,-0.0246236,0.995145,-0.0378659,0.328219,0.0742095,-0.0770262,0.0488952,0.109461,-0.639554,0.492851,0.141617,0.700802,0.789129,0.58515,-0.0497645,-0.167552,-0.236472,0.32194,-0.0734952,0.121753,0.365037,0.0480287,-0.175841,0.178115,-0.600713,-0.260034,-0.343294,0.293981,-0.0995605,1.40382,0.627876,-0.441961,-0.405966,0.0922587,0.331433,0.309757,-0.0827142,-0.636684,0.117228,-0.0428083,-0.372377,0.0217289,-0.307004,0.120631,0.75238,0.0432406,0.00839465,0.181672,0.262808,0.11766,0.00636818,0.406914,0.135045,0.161565,0.365752,0.448575,0.154643,0.13066,0.607177,0.607814,-0.802689,0.179314,0.446282,0.103339,-0.469989,0.375522,-0.0478064,-0.378228,0.433634,0.18346,0.722164,0.12418,0.301028,0.408829,-0.0798299,0.446067,0.35409,-0.165663,-0.71598,-0.214282,-0.205113,0.506136,0.169656,0.817521,0.306653,0.488083,-0.601844,0.107095,0.201067,0.0656045,0.605165,0.398445,-0.240813,-0.0920803,-0.449266,-0.343078,-0.478524,-0.366188,-0.442997,0.198984,0.549183,-0.334982,-0.118846,0.472313,0.356422,0.00717478,-0.219776,-0.914708,-0.153343,0.0352495,-0.492691,0.307679,-0.191172,0.549257,-1.0129,0.332475,0.0865223,0.265713,0.0970427,-0.720253,-0.573835,0.2618,-0.771538,0.0763587,-0.132867,0.701435,-0.285308,-0.367589,1.37575,0.455117,0.556244,0.518021,0.111946,-0.883367,-0.105431,-0.110539,0.551869,-0.482024,-0.0258176,0.0337243,0.500835,-0.206988,-0.750076,-0.25357,0.44479,-0.538794,0.287606,0.419306,0.499412,-0.399676,0.00360401,-0.52383,-0.170059,0.299057,-0.631798,-0.00512587,0.976988,0.00842645,-0.273178,0.786893,-0.49531,0.714459,0.347417,0.380799,-0.0549654,0.282385,-0.388179,0.0579021,-0.176735,0.353572,-0.381532,-0.62027,-0.558001,0.317669,-0.538406,0.211429,0.578486,0.0140006,-0.154132,0.260562,0.0783043,0.315522,0.560996,0.110085,0.714918,-0.0553685,0.0924885,0.498986,-0.190968,0.270968,-0.0373215,-0.415392,-0.280758,0.531594,0.175857,0.310766,0.0692601,-0.193816,-0.0892041,1.25941,-0.228142,-0.602818,-0.100852,-0.15889,0.690045,-0.357884,0.873997,-0.12396,0.415159,-0.157804,-0.0418371,-0.111628,-0.106848,0.535607,0.412664,-0.339478,-0.685303,-0.0929088,-0.192766,-0.293428,-0.0389697,-0.199722,0.192583,0.289754,0.438843,0.538288,-1.13332 +3371.51,0.943343,0.0848144,4,1.61,0.955341,-0.761603,0.13504,0.367112,-0.0410016,-0.342994,0.202411,-0.229073,0.649231,0.222823,-0.198776,-0.178092,0.11476,0.0720081,0.712447,-0.139814,0.0682855,-0.235724,-0.50017,-0.375626,-0.969239,-1.32146,-0.0735946,0.219111,0.0247632,-0.120395,-0.215939,-0.240501,-0.281672,0.352238,-0.566002,-0.214617,0.058024,0.185121,-0.0248736,-0.333831,0.377877,0.249598,-0.252618,1.0177,0.404295,-0.996378,-0.291987,0.117475,-0.165258,-0.418889,0.308952,0.691909,-0.683828,0.263298,0.968862,0.152285,0.191261,1.15148,-0.232007,0.0144615,-0.529516,0.423293,-0.178587,0.632743,0.831604,-0.705005,-0.688554,-0.472686,0.479261,-0.825123,-0.0264408,0.344362,-0.930354,0.364047,0.205146,0.810154,-0.118623,0.817145,0.404602,0.000529105,-0.200153,-0.555992,0.260698,0.498037,0.337699,0.337113,-0.448603,0.0646583,-0.202069,-0.361402,-0.598886,-0.405332,0.0302469,0.582411,-0.0199768,0.447218,0.144201,0.420651,0.17127,-0.0669977,-0.0990045,-0.310535,-0.109993,0.839963,-0.585247,-0.261874,-0.361825,-0.377246,-0.173123,0.698601,-0.209987,1.10511,0.894826,-0.783807,0.319052,-0.0667396,0.286614,0.650766,-0.0390535,-0.816593,0.247518,0.0586921,-0.133609,-0.511935,-0.0139425,0.0616954,0.255744,0.00544739,-0.384321,0.645659,0.260713,-0.222956,-0.674464,0.254487,0.305268,-0.0973645,0.637587,-0.0435983,-0.151427,0.0504345,0.383858,0.376585,-1.11673,-0.623004,-0.16815,-0.124234,-0.431774,0.404439,0.0398491,-0.352808,0.553118,0.103939,0.299824,0.401301,-0.00665055,0.265804,-0.169509,0.0132146,1.03707,0.385197,-0.149597,-0.23215,-0.0380589,1.22832,0.0179564,0.507127,0.70861,0.0160642,-0.182744,-0.377246,0.517269,0.126602,0.0542657,0.05645,-0.209444,-0.339089,-0.147125,-0.269771,-0.0597985,-0.189875,-0.200075,0.35989,0.790606,-0.379485,-0.507228,-0.181419,0.301059,-0.270008,0.137024,-0.457434,-0.415424,-0.00774121,-0.128487,0.81669,-0.765175,0.316963,-0.868557,0.176386,0.689533,0.187958,-0.58946,-0.80224,-0.869809,-0.235502,-0.608095,0.0134902,-0.48773,-0.0965,-0.863443,-0.133524,1.09438,-0.280458,0.925056,0.179092,0.0449752,-0.131972,0.136882,0.218092,0.44519,-0.448805,0.262774,0.146549,0.477201,-0.337591,-1.10662,0.276986,0.175041,-0.292464,0.272658,-0.166413,-0.131274,-0.843062,0.494602,0.0281245,0.0215368,0.381833,-0.959245,-0.259945,0.593285,-0.288355,-0.48909,0.684079,-0.565757,0.595391,0.227255,0.0230016,-0.170868,-0.0995835,-0.738167,0.401218,0.320532,-0.10701,-0.554934,-0.420005,-0.99094,-0.0751546,-0.664856,0.177848,0.673078,-0.235928,0.214262,-0.0112417,0.33947,0.0123226,-0.00684162,0.32425,0.572924,-0.12164,0.303743,0.238027,0.1595,0.0340272,0.386312,-0.267543,-0.60494,0.159152,-0.0737639,-0.085229,0.223315,-0.0384536,0.263749,0.805452,-0.0634376,-0.423185,-0.410562,-0.397268,0.310963,-0.287761,0.691017,-0.132957,-0.260964,-0.106189,-0.245796,-0.256169,0.259746,0.340363,0.373521,-0.337429,-0.171465,-0.103124,-0.297866,0.249335,0.0987034,0.786397,0.188035,0.2107,0.43363,0.45902,-1.01539 +3392.4,0.751037,0.0848144,4,1.54291,1.064,-0.367749,-0.0184095,0.544059,0.0288679,-0.0659135,0.588603,-0.0349482,0.462892,-0.282345,-0.177079,-0.188201,-0.344159,-0.228139,0.731931,0.461436,-0.472525,0.0110685,-0.362335,-0.505042,-0.847847,-0.439757,-0.342297,-0.484318,-0.343898,0.280831,0.157418,-0.012655,0.0796639,0.426154,-0.427602,-0.115633,-0.262198,-0.208105,0.0211063,-0.629782,-0.317288,0.719741,-0.196088,1.05799,0.384921,0.24656,0.00297373,-0.000981371,-0.0915915,-0.497382,-0.0826764,0.777768,-0.211901,0.199826,0.496311,0.208299,-0.455467,0.98448,-0.336266,0.315327,-0.535393,0.519657,0.0410892,0.538316,0.603293,-0.444502,-0.938121,-0.0162916,0.584289,-0.577696,-0.054077,-0.131483,-0.417066,0.15531,0.659272,1.04547,-0.0142371,0.970234,0.165732,0.634012,0.0462324,0.377042,0.288719,0.503044,0.230645,0.784824,-0.590848,-0.205964,0.141832,0.128766,-0.246168,-0.285452,0.228214,0.494028,0.14726,-0.0325132,0.139013,0.446531,0.136571,0.0424328,-0.848589,-0.528383,-0.00555602,0.588722,0.0894811,-0.349011,-0.416945,-0.148754,-0.10212,0.442162,-0.244444,0.594986,0.245009,-0.54431,0.134042,-0.967928,0.368169,0.296959,-0.0259313,-0.806363,0.522569,-0.177014,-0.193873,-0.487006,-0.121061,-0.0969027,0.0404937,-0.299933,0.189429,0.456549,-0.232096,0.161781,-0.656773,-0.230524,0.17741,-0.543421,0.916673,-0.446923,0.177156,0.171688,0.317803,0.407301,-0.650154,-0.781765,-0.0739197,-0.608696,-0.176931,0.176845,0.0340544,-0.512501,0.389307,0.245559,0.0814287,0.204977,0.236083,0.143408,0.0958143,0.457165,1.23386,0.522324,-0.401349,-0.313361,0.744475,1.00394,-0.153969,0.800829,1.01621,0.0541939,-0.000333349,-0.30765,0.624511,-0.233297,0.0695873,0.330263,0.293958,0.00965064,0.341395,-0.172487,-0.539567,-0.212001,-0.381911,0.243999,1.08522,-0.0427252,0.0694771,-0.0405156,0.45102,0.0553253,-0.146573,-0.700199,-0.382574,-0.0647167,-0.738996,0.271175,0.241464,-0.298462,-0.578276,0.0961655,0.413808,-0.126904,-0.403109,-0.237489,-0.189043,0.0767008,-0.326341,0.0114295,-0.37425,-0.477264,-0.223454,0.0262321,0.998494,-0.484103,0.838574,0.11407,-0.220601,0.213628,0.208538,0.514296,0.221641,-0.849975,0.383849,0.235987,-0.2449,0.260131,-0.995109,-0.0842304,0.442645,-0.615914,0.128661,0.209991,-0.158241,-0.908538,0.349122,0.206772,0.145132,0.177377,-0.585632,-0.539171,0.756795,-0.253546,0.113921,0.87456,-0.527022,0.383124,0.565226,0.0756783,0.248939,0.144503,-0.520093,0.170463,0.143243,-0.258608,-0.420146,-0.412233,-1.01191,0.0190911,-0.918223,-0.190204,0.511475,-0.360724,0.181155,0.0966389,0.161174,0.163233,0.091219,0.339589,0.323639,-0.321913,0.58745,-0.146431,-0.324179,0.290159,0.171718,-0.537674,-0.3867,-0.4285,0.19157,0.197134,-0.252821,0.294199,0.355058,0.160601,-0.082995,-0.119404,0.33261,-0.270195,-0.165848,-0.0870484,0.481914,-0.116907,-0.342584,0.29686,0.135707,-0.0282112,0.384951,-0.53947,0.179317,-0.070201,-0.130421,-0.133482,-0.139609,-0.1264,-0.137779,0.505665,0.191463,0.205882,0.437565,0.453742,-1.94088 +3389.52,0.725242,0.0848144,4,1.55412,1.05847,-0.373651,-0.0687043,0.527812,0.0209118,-0.0722046,0.538274,-0.0221243,0.494749,-0.356677,-0.169671,-0.189112,-0.292654,-0.17601,0.738603,0.374575,-0.463174,0.0984955,-0.39565,-0.49468,-0.872594,-0.392027,-0.297597,-0.612748,-0.342906,0.224185,0.128728,-0.0481467,0.0731281,0.418647,-0.427378,-0.183445,-0.233467,-0.211396,0.0238595,-0.565183,-0.272774,0.75858,-0.198521,0.985352,0.337712,0.241737,0.0257051,0.0716736,-0.0222948,-0.538578,0.000162086,0.798149,-0.158521,0.268988,0.446929,0.277982,-0.466178,1.04329,-0.293716,0.272884,-0.551068,0.467541,0.0598929,0.521522,0.620768,-0.473395,-0.913886,-0.0720899,0.64307,-0.519099,-0.0946259,-0.103799,-0.334603,0.117967,0.650531,1.02417,0.0685369,1.00808,0.179625,0.625945,0.0507907,0.347227,0.266673,0.489109,0.196621,0.763686,-0.59618,-0.197406,0.0279146,0.110441,-0.296639,-0.358132,0.207727,0.502732,0.174638,-0.0632267,0.216045,0.435933,0.147603,0.0709036,-0.859893,-0.559249,-0.0349967,0.550292,0.106085,-0.276117,-0.500841,-0.221732,-0.126465,0.515435,-0.199821,0.612449,0.355935,-0.53572,0.0734788,-0.91959,0.375142,0.259673,-0.0880601,-0.87254,0.586727,-0.20214,-0.311895,-0.618681,-0.132894,-0.144,0.0420934,-0.231904,0.140976,0.421205,-0.268285,0.191575,-0.660784,-0.381632,0.156469,-0.523233,0.881294,-0.423208,0.109469,0.156106,0.345426,0.414669,-0.672034,-0.745887,-0.0244931,-0.576199,-0.154323,0.189131,0.146636,-0.562812,0.446365,0.26167,0.0895091,0.282037,0.309641,0.19868,0.144429,0.555587,1.28217,0.506548,-0.338348,-0.287438,0.741659,1.02693,-0.115396,0.801701,1.11551,0.0614898,0.00322132,-0.289282,0.728623,-0.200866,0.0716033,0.28118,0.364582,0.00639601,0.269102,-0.195066,-0.609379,-0.161486,-0.451205,0.315698,1.0712,-0.039576,0.091975,-0.0615055,0.503731,-0.0386406,-0.0802177,-0.698997,-0.388986,-0.0941957,-0.85758,0.285421,0.236456,-0.292625,-0.584646,0.142959,0.471232,-0.182469,-0.490514,-0.279782,-0.226315,0.0348855,-0.310461,-0.0360004,-0.341461,-0.533281,-0.202589,0.052112,0.91506,-0.554484,0.809083,0.243117,-0.166491,0.216872,0.286769,0.524514,0.217041,-0.906033,0.379537,0.19023,-0.222453,0.222232,-1.04788,-0.0953036,0.476079,-0.518548,0.0419005,0.244328,-0.196372,-0.96936,0.290293,0.243511,0.104519,0.18947,-0.54078,-0.552663,0.803652,-0.26641,0.0623993,0.841667,-0.476985,0.310676,0.567406,0.0189902,0.213899,0.192855,-0.546881,0.175821,0.127286,-0.236671,-0.387675,-0.409605,-1.00608,0.000579524,-0.845586,-0.130206,0.519712,-0.37221,0.229924,0.0855019,0.190089,0.205013,0.21377,0.267037,0.446764,-0.270186,0.567088,-0.143131,-0.35772,0.222691,0.0882152,-0.545535,-0.369954,-0.38382,0.242233,0.142643,-0.172865,0.320762,0.418895,0.231373,-0.0472787,-0.164445,0.395102,-0.108101,-0.172967,-0.00959193,0.441545,-0.165426,-0.396617,0.280869,0.167202,-0.0415406,0.482533,-0.444106,0.264828,-0.0871683,-0.0832749,-0.176253,-0.123824,-0.123218,-0.0466343,0.522481,0.180314,0.215531,0.424634,0.464253,-1.81318 +3388.49,0.671578,0.0848144,4,1.57094,1.05338,-0.331969,-0.0445675,0.497026,0.00752058,-0.0457022,0.484072,-0.0431675,0.56718,-0.345833,-0.119226,-0.173317,-0.292338,-0.219356,0.699718,0.332087,-0.493098,0.064865,-0.428516,-0.41537,-0.928442,-0.414094,-0.310636,-0.571138,-0.328375,0.216085,0.103882,0.0403822,0.106892,0.452315,-0.538833,-0.201146,-0.153724,-0.237641,0.0274303,-0.552509,-0.245168,0.779968,-0.170412,0.93815,0.37303,0.228441,0.0262441,0.121073,-0.0740578,-0.583857,0.111806,0.79997,-0.161846,0.336202,0.435093,0.27813,-0.432908,1.01878,-0.348224,0.261588,-0.464305,0.331998,0.0902944,0.527539,0.648506,-0.48179,-0.879719,-0.0912961,0.610316,-0.482932,-0.100585,-0.0643429,-0.307184,0.0704346,0.629737,1.03221,0.0614525,0.941075,0.185293,0.620367,0.126775,0.324753,0.361935,0.336646,0.240282,0.787611,-0.491407,-0.176531,-0.0107504,0.148014,-0.268231,-0.367211,0.297836,0.452774,0.181541,-0.103902,0.238467,0.410047,0.179067,0.0159257,-0.91077,-0.537014,-0.0573725,0.55002,0.0713563,-0.341992,-0.423272,-0.211752,-0.0698903,0.535894,-0.249235,0.70414,0.309135,-0.511712,0.0592126,-0.873388,0.40621,0.144015,-0.141427,-0.787495,0.611851,-0.12103,-0.365603,-0.682944,-0.161472,-0.0379338,0.0160489,-0.227804,0.222293,0.347651,-0.318548,0.0992653,-0.628711,-0.343268,0.155891,-0.465214,0.849909,-0.344145,0.103144,0.248449,0.358792,0.39442,-0.653792,-0.76223,0.0313181,-0.621471,-0.0841377,0.112545,0.215693,-0.591044,0.40265,0.258282,0.100146,0.320973,0.336174,0.195539,0.206177,0.530388,1.29035,0.443357,-0.371245,-0.280707,0.749888,0.958049,-0.156842,0.808384,1.06027,0.135517,-0.0595883,-0.406933,0.711239,-0.203711,0.0790876,0.26555,0.345225,-0.0165738,0.235403,-0.2423,-0.677687,-0.201632,-0.454142,0.340327,1.09287,-0.0553293,0.0377433,-0.0408923,0.440051,-0.138605,-0.114492,-0.642623,-0.353612,-0.142035,-0.816244,0.28795,0.22711,-0.321282,-0.54734,0.16973,0.466005,-0.165702,-0.440152,-0.283857,-0.275197,0.00805269,-0.334226,-0.00772781,-0.396521,-0.554435,-0.135322,0.0094503,0.935451,-0.478556,0.843182,0.242137,-0.242844,0.200073,0.303302,0.539744,0.259423,-0.89696,0.325743,0.132246,-0.137117,0.320294,-1.039,-0.0353655,0.540776,-0.525114,0.043542,0.330667,-0.132337,-0.983431,0.283791,0.220229,0.111574,0.208487,-0.635109,-0.613224,0.7901,-0.220224,0.0679839,0.870877,-0.460236,0.314258,0.541766,0.00955555,0.166225,0.189638,-0.469635,0.124871,0.060672,-0.306267,-0.326609,-0.576454,-0.970687,0.0312841,-0.827679,-0.14525,0.518061,-0.438834,0.247497,0.0204911,0.176085,0.249856,0.3068,0.229356,0.47347,-0.321704,0.58443,-0.169677,-0.408163,0.178081,0.128884,-0.523064,-0.427856,-0.377316,0.264912,0.0733028,-0.194418,0.334565,0.410298,0.229467,-0.0109021,-0.139598,0.36028,-0.146082,-0.207796,-0.0517102,0.516167,-0.137168,-0.494086,0.248955,0.174206,-0.0259003,0.461732,-0.458796,0.25408,-0.00498247,0.0175915,-0.150143,-0.163577,-0.183247,-0.00487601,0.554101,0.176164,0.214075,0.419719,0.462682,-1.7266 +3368.2,0.978646,0.0848144,5,1.50963,1.09115,-0.411629,-0.0768664,0.643283,0.106771,0.0300282,0.605098,0.67931,0.595975,0.182643,-0.0661525,0.299734,0.0940492,-0.515237,0.634625,0.0859815,-0.365878,-0.180833,-0.612569,-0.448319,-0.724443,-0.758031,-0.417143,-0.349599,-0.18682,-0.232752,-0.0192216,-0.4132,-0.0396931,0.45372,-0.758088,0.134925,-0.108876,0.245946,0.214848,-0.436614,0.0259304,0.683047,0.193993,1.46755,0.416923,0.286543,-0.258952,0.0553805,-0.00265921,-1.11638,0.134388,0.896725,-0.589554,0.371056,0.615086,0.014343,-0.68576,1.04623,-0.477549,0.565266,-0.288367,0.463664,-0.271665,0.472621,0.526403,-0.544189,-0.858516,0.089517,-0.394214,-0.738114,0.0175484,-0.176254,-0.220342,-0.0871573,0.889227,0.667534,0.327214,1.09518,0.155706,0.698494,-0.261783,-0.147257,0.13324,0.854679,0.55443,0.481159,-0.675875,-0.454391,-0.397554,0.252209,-0.129217,0.214254,-0.273338,0.554523,0.111012,0.441892,0.515878,0.0382717,-0.59879,0.433573,-0.502781,0.477437,0.0926392,0.2531,0.372846,-0.324126,0.297367,0.463319,-0.459744,0.607432,-0.574898,1.24102,0.575385,-0.178692,-0.52679,0.00203273,0.66447,0.504728,-0.344947,-0.281856,0.420917,-0.408288,-0.0892103,-0.486726,-0.427224,0.126084,0.180107,-0.0323105,0.390135,-0.040004,-1.02543,0.415231,-0.992292,0.474787,0.0140664,-0.167086,0.458983,-0.585812,0.370778,0.284974,0.387739,-0.0837633,-1.12263,-0.805938,0.0710238,0.0418557,-0.514347,0.320818,0.564232,-0.399962,0.463421,-0.0545755,0.0771607,-0.0168499,0.366717,0.380994,0.0178921,0.44027,0.62295,0.271359,-0.686136,-0.229656,0.506772,0.358123,-0.257708,0.395667,0.0668566,0.585996,-0.510645,-0.453425,0.029804,0.125713,-0.061596,0.413265,-0.526998,0.101717,0.527833,-0.503789,0.16487,-0.470725,-0.123195,-0.136966,1.42925,0.576587,0.206287,0.412085,0.501077,-0.445447,-0.709588,-0.967545,-0.564714,0.541089,-0.0168188,0.0970369,0.127398,-0.455192,-0.755758,0.29607,0.291548,-0.0695209,-0.283892,-0.828102,-0.664422,0.310227,0.631862,0.488355,-0.0868267,-0.17176,0.092482,0.010827,1.17531,-0.397785,0.631248,0.276873,0.134309,0.357102,0.320716,0.104688,-0.100237,-0.499733,-0.0795642,0.335343,-0.40418,-0.0938588,-0.630777,-0.477963,0.661458,-0.849351,0.334946,0.606184,-0.60028,-0.970598,-0.176493,0.0998918,0.232931,-0.415244,-0.187806,0.0917312,1.05596,-0.29131,-0.431917,0.942907,-0.289522,0.305363,0.209881,0.50101,-0.0514574,0.227092,0.197137,-0.266286,0.150887,-0.317059,-0.0701753,0.614107,-0.985822,-0.350078,0.269977,-0.57367,0.386679,-0.269825,0.00224164,0.659537,0.0380065,-0.105117,0.357845,0.415,0.408778,0.097677,0.206663,-0.0614768,-0.321529,-0.0184068,0.154723,-0.330053,-0.458179,-0.101685,-0.33767,0.115421,-0.450707,-0.365485,-0.403307,0.11823,0.0529305,0.18501,0.320156,-0.812441,-0.788921,-0.34292,1.3733,-0.244162,0.183078,0.502598,-0.152012,-0.0770298,0.184971,-0.288522,-0.0445013,-0.0344751,-0.963742,0.015849,-0.272832,-0.196521,-0.839493,0.494925,0.215149,0.198872,0.463841,0.445951,-2.29255 +3395.9,0.996953,0.0848144,4,1.57893,0.968588,0.330175,-0.230341,0.308363,0.0957111,0.25939,0.511032,0.771999,-0.210179,0.0993892,0.092918,-0.297917,0.77373,-0.213131,0.902207,0.150404,0.0349454,0.331484,-0.196565,0.122789,-0.732478,-0.96423,-0.279647,0.466604,0.150414,0.61471,0.934643,0.233178,0.566299,0.988124,-0.272838,0.246261,0.00644634,-0.0449063,-0.214719,-0.512864,0.287541,0.000147594,-0.807205,0.879135,-0.0918617,-0.625655,-0.162075,-0.496613,-0.0855345,-0.587908,-0.130973,0.888775,0.119928,0.339852,-0.481049,0.0932053,-0.243114,1.28754,-0.415925,0.246987,-0.922922,0.282529,-0.297414,-0.309583,0.467126,-0.188984,-1.19481,-0.617887,0.236323,-0.416546,-0.404962,0.419331,-0.590878,-0.48589,-0.336078,0.565764,0.422788,0.308301,0.492182,0.246015,-0.0996019,-0.00843849,-0.517155,0.0634976,-0.253657,0.625581,-0.241004,0.138485,0.180674,0.120884,-0.596019,-0.204305,-0.444145,0.205194,0.276047,0.383833,0.0489203,0.0724704,-0.193375,0.110536,0.0868127,0.0611861,0.303845,0.381552,-0.173973,-0.0143148,-0.462197,-0.400548,0.0381511,-0.081533,-0.616773,0.248659,0.599844,-0.0763638,0.536343,-0.0524983,0.451182,0.403561,-0.20923,-0.809881,0.60112,0.441465,-0.147023,-0.768814,-0.126379,-0.679978,-0.713325,-0.139603,-0.0355527,-0.0343748,0.872455,-0.0436107,0.14482,-0.142934,-0.0586375,0.477046,0.902811,-0.095509,-0.406676,-0.0221177,-0.166702,0.329812,-1.41193,-0.230673,0.624123,-0.214986,-0.474947,-0.19896,-0.491821,-0.089247,-0.00626092,-0.018389,0.155208,-0.649263,0.407738,0.0121383,0.175702,0.30088,-0.515897,-0.01661,0.254415,0.177963,-0.247103,0.391203,-0.187794,1.37458,-0.319257,-0.0443274,0.439431,-0.00995713,0.315687,-0.0490775,-0.343424,0.538997,-0.218457,0.137919,-0.521168,-0.0870796,-0.17233,0.575231,0.295439,0.645747,0.469022,-0.490359,-0.474662,0.0813251,-0.583008,-0.150141,-0.125636,0.294962,-0.0188424,-0.239409,-0.900026,-0.0591154,0.290633,0.490629,-0.495928,0.265514,0.155539,0.566397,-0.618014,-0.577467,0.642952,0.24108,-0.71839,0.160209,-0.00102329,0.383688,-0.121526,-0.663003,0.833054,0.330216,-0.0635327,0.389526,-0.17229,-0.147568,0.200906,-0.0431161,0.539171,0.254108,0.0392758,0.307881,0.326274,-0.0515358,-0.603728,0.392972,0.0878525,0.203661,0.086857,-0.353582,0.108874,0.431571,0.1798,-0.335288,0.0939274,-0.198974,-0.813999,-0.286176,0.669978,0.00910819,0.214103,0.709629,-0.363558,-0.208325,0.045625,-0.144137,-0.96684,0.231011,0.64806,0.264884,-0.299912,-0.111606,-0.771537,-0.0991395,-0.08134,0.471197,-0.473266,-0.233561,0.170332,-1.04377,-0.275151,0.106893,0.414733,-0.180391,0.00434372,-0.0991093,-0.56688,0.149511,-0.525159,-0.231969,0.337161,-0.418957,0.104292,0.149191,0.208079,-0.152977,0.501005,-0.253807,0.19245,-0.0615326,0.540445,0.360366,-0.364328,-0.168314,-1.14519,-0.283891,-0.0831589,-0.464618,-0.260817,-0.615165,0.430664,-0.215612,-0.283192,0.0396173,0.180454,-0.133368,0.218514,0.0530935,0.137144,-0.0627468,0.446655,-0.952796,0.0879936,-0.0552859,0.156206,0.382779,0.395229,0.618692,-1.13615 +3388.09,0.417094,0.0848144,5,1.62602,1.14368,-0.309224,0.00172207,0.946546,-0.186002,-0.00437582,0.405246,0.0514157,0.107803,0.0145376,0.115169,0.384092,-0.0549513,-0.447485,0.697939,-0.204003,0.268129,0.0988455,0.150475,-0.433111,-0.7934,-0.786439,-0.56242,0.173209,-0.525121,-0.309901,-0.0781568,-0.224389,0.39385,0.320762,-0.775498,0.0487565,-0.175803,-0.242101,-0.0845021,-0.906257,0.536242,0.195245,-0.222862,0.393907,0.769293,0.76212,-0.586181,0.294646,-0.335244,-1.30717,-0.117764,0.197332,0.156411,-0.108864,0.186826,0.189236,-0.831318,0.949702,-0.0927243,-0.398759,-0.374652,0.819688,-0.342503,0.065984,1.01189,-0.893467,-1.21728,0.202795,-0.0998791,0.241846,0.176041,0.269847,-0.793512,-0.368801,-0.124641,0.55873,0.193684,0.72641,0.441941,0.135934,-0.301418,-0.690676,-0.0635861,0.533086,0.525151,0.494505,-1.04406,-0.200888,-0.150182,0.196662,-0.628503,-0.244967,-0.253469,0.253224,0.0473699,0.0133207,0.530357,0.579559,-0.563769,0.0399288,-0.360586,0.481831,0.490914,-0.244594,0.02875,-0.41787,0.164185,0.134021,-0.330572,0.427271,-0.123076,-0.131472,0.558239,0.0172629,-0.813316,0.406063,0.304772,-0.314303,0.249781,-0.0708841,0.0565792,-0.420755,-0.181118,-0.784548,-0.150323,0.963487,0.381509,0.228538,-0.0846457,0.671749,0.216302,0.446174,-0.728208,0.300861,0.0246042,-0.231174,0.409193,-0.0748895,0.0697253,-0.0319786,-0.180049,-0.226575,-0.407371,-0.0459683,0.0139397,-0.293513,-0.293991,-0.0716662,0.375174,-0.670238,0.103712,-0.174642,-0.0438206,0.475006,0.248286,0.354099,-0.201082,1.10649,0.215253,0.753838,0.205356,0.186941,-0.736098,-0.176557,0.291672,0.60339,0.361278,0.381407,-0.174165,-0.503154,-0.460626,-0.0354954,0.104844,0.0802316,0.23277,-0.225836,-0.160403,0.311296,-0.337998,-0.668477,-0.390696,-0.123488,0.748996,0.827417,-0.206995,-0.313731,0.702061,-0.372587,-0.659959,-0.479266,-0.328824,0.0506691,0.347363,-0.0926989,0.250419,0.282305,-0.491475,-0.717511,-0.556167,-0.392369,-0.450358,-0.264161,0.0198853,0.425828,-0.629275,0.546415,0.0464554,-0.512229,0.0205919,-0.963146,1.15871,-0.27146,0.257799,0.196484,-0.0818306,-0.244218,-0.32441,-0.455217,0.432589,-0.36321,0.580022,0.238655,-0.902266,-0.078969,-0.348907,0.0101317,0.275296,-0.786748,0.387507,-0.351428,-0.443159,-0.830408,-0.31327,0.00965307,-0.119677,-0.0477832,0.243289,-0.440088,0.669205,0.0361865,0.302489,0.223396,-0.33242,-0.0702334,0.108249,0.14911,0.0984949,0.76915,0.263463,0.305942,-0.136929,-0.145055,-0.167239,-0.335663,-0.689534,0.210388,-0.261988,-0.639615,0.189116,-0.00271405,0.276637,0.0729532,0.378673,-0.360552,0.843661,0.28215,0.893111,-0.139069,0.0701155,0.215819,-0.160163,0.437789,0.0752537,-0.604652,-0.0669672,-0.456106,-0.772764,0.494469,0.00624246,0.39871,-0.370686,0.116154,0.157463,-0.267522,0.796306,-0.63636,0.419207,0.312403,0.575179,0.105802,0.733454,-0.0476145,-0.0536293,-0.14802,0.0495681,0.28002,0.103973,-0.0885308,-1.2024,0.477905,-0.600006,0.227763,0.0779767,0.183165,0.175758,0.258184,0.419235,0.508118,-3.33094 +3378.32,0.540487,0.0848144,5,1.56788,1.08098,-0.583165,0.134582,0.498718,-0.311542,0.00917613,-0.142745,1.0378,-0.0541747,-0.318085,0.0907163,-0.366681,0.244152,0.0438163,0.753355,-0.045907,-0.402146,0.161912,-0.581041,-0.37379,-1.20027,-0.594961,-0.195346,-0.178523,-0.619157,0.285845,0.200699,-0.356549,-0.152836,0.451577,-0.00533636,0.101016,-0.00335789,-0.792646,0.0501907,-0.225627,0.52803,0.683928,-0.234896,0.713183,0.121511,0.0458451,-0.577668,-0.197355,0.188261,0.070833,0.765111,-0.20302,-0.0202461,0.203723,0.148285,-0.0611331,0.0338199,0.696248,-0.1683,0.269097,-1.04112,0.49452,-0.0332523,0.341821,0.418049,-0.545095,-0.434592,-0.565361,0.279279,-0.166045,-0.276156,0.00173803,0.135681,-0.11973,0.534538,0.495193,-0.0234599,0.435868,0.406472,0.135083,-0.150919,0.391814,-0.274429,0.529101,-1.10791,0.25033,0.359777,-0.0469077,-0.119274,-0.306256,0.552235,0.115953,-0.320447,0.174925,0.434386,-0.0594488,0.203962,-0.818872,0.542607,0.275596,-0.285198,-0.378025,0.401448,0.428816,-0.115722,-0.628192,-0.712257,0.458753,-0.57869,-0.361966,0.160419,0.489593,0.351562,0.297089,0.0861978,-0.0474654,0.335524,0.114914,-0.0747079,-0.483523,0.1118,0.233269,-0.356686,-0.408103,0.108434,-0.888893,-0.589593,-0.0672715,0.675326,-0.29941,0.039758,0.104116,-0.584922,-0.54491,-0.198383,0.482705,0.62399,-0.397714,-0.725824,-0.0699631,0.15057,0.441485,-0.466257,-0.383065,0.168048,-0.0523449,-0.190522,0.3642,0.375325,0.487775,0.310334,-0.0331808,-0.353613,-0.834698,0.038692,0.613408,0.0447462,-0.229968,0.613853,-0.570909,-0.187912,0.264619,0.834185,0.526929,-0.624175,1.02608,-0.22566,0.0639528,0.377291,0.862746,0.0602975,-0.440677,-0.0898011,0.135458,-0.0199576,-0.112878,0.0367985,-0.488307,0.229195,0.133804,-0.252625,0.284125,0.837423,-0.27083,-0.152603,0.761963,-0.749182,-0.16039,-0.144543,-0.131149,-0.0231152,0.122461,-1.54911,0.04422,-0.158783,-0.216721,-0.571519,0.494507,0.754806,0.669038,-0.510825,-0.592262,0.301572,-0.312471,-0.292014,0.346656,-0.0783232,0.758831,-0.177838,-0.403942,1.03406,0.271074,0.18396,-0.127839,0.283282,0.411106,0.732834,-0.236994,0.137051,-0.235969,0.0579801,-0.110448,-0.0078781,-0.147992,-0.39719,0.0578958,0.347683,-0.0905168,0.860602,-0.739408,-0.159341,1.27169,0.28542,-0.537073,-0.183355,-0.277343,-0.515754,-0.236511,0.404964,-0.343573,0.0873002,0.886158,0.120676,-0.236173,0.375271,0.0429669,0.175203,-0.197648,0.438116,0.893498,0.465286,-0.173946,-0.307492,0.455509,-0.395718,0.683435,-0.352297,0.219647,0.765204,-0.786525,0.27462,0.0800022,0.171909,0.257997,0.13832,0.31167,-0.240761,0.67987,0.0905781,0.114074,0.275571,-0.108505,0.206057,0.996237,-0.350426,0.185709,1.10427,-0.233693,-0.360717,0.348018,0.826836,0.260331,-0.0875366,0.201296,-1.0307,0.0344991,-0.0199019,0.60963,-0.240761,-0.277297,0.0571739,0.383315,0.0821562,0.0021355,-0.0538735,0.0783517,0.450693,0.0753696,0.146551,-0.204852,0.873341,-0.22292,-0.521939,0.0955436,0.1837,0.208465,0.428602,0.45658,-1.74221 +3400.79,0.971985,0.0848144,4,1.51421,1.0857,-0.932619,0.348997,0.416282,-0.164028,-0.279155,0.0512421,0.311501,0.0714631,-0.50476,-0.638388,-0.182257,0.387292,-0.799385,0.859518,0.131591,-0.124403,-0.352645,-0.412975,-0.472718,-1.07928,-0.415679,0.0351601,0.0224992,0.364946,0.230114,0.464136,-0.240305,-0.0410583,0.473128,-0.496686,0.655011,0.395981,-0.803389,-0.210526,-0.765319,-0.110719,0.924448,0.00445271,0.705619,0.364856,0.350129,-0.396853,-0.147321,0.156971,-1.00364,-0.0339053,0.392068,0.281874,0.413716,-0.184606,0.0641039,-0.353798,0.13624,-0.274891,0.0784873,-0.713313,0.391765,-0.24874,0.474758,0.637945,-1.08814,-0.703122,0.379688,0.625081,-0.0375058,-0.100058,0.839834,-0.114516,0.23011,0.284633,0.551005,0.489452,0.906723,0.394039,0.463705,-0.0483905,0.0170145,0.0124525,0.590687,-0.505251,0.148273,0.0182071,-0.305655,0.103517,0.019014,-0.302597,0.0642734,0.0379605,-0.496723,-0.467743,-0.269821,0.141876,0.188076,-0.0501493,-0.290676,-0.554411,-0.586621,0.351437,-0.119971,0.0167354,-0.656259,0.103367,-0.352043,-0.213777,0.130893,0.105845,-0.0141698,0.13003,0.42364,-0.0634679,0.137164,0.306186,0.706438,-0.668071,-0.588585,-0.0967651,-0.0510245,-0.302741,-0.646501,0.274444,0.0687423,-0.53239,0.0524257,0.182817,0.118666,0.127176,0.53153,-0.27629,-0.0085748,-0.0257078,0.0184151,0.185374,-0.0209492,0.283076,0.223633,-0.10419,0.0293232,-0.610432,-0.887768,-0.197762,-0.679429,-0.142629,-0.410951,-0.300449,0.00218037,0.513592,0.0934991,-0.305964,-0.147525,-0.108577,0.458375,-0.150724,-0.290105,0.461425,-0.434133,-0.755658,0.283654,-0.194386,0.0500048,-0.325285,0.322868,0.362938,-0.0567388,0.0527803,-0.0908927,-0.322744,-0.386191,0.748705,0.103916,0.0423012,-0.0696723,0.142155,-0.943604,-0.157681,-0.681349,-0.122847,-0.647401,1.21483,0.37652,-0.544798,0.346511,-0.177959,0.330116,-0.206037,0.00230178,-0.187626,0.459656,0.200239,-0.0636134,0.442464,0.370857,-0.671616,0.480452,-0.11056,0.130421,-0.503129,-0.777479,-0.141707,0.0950834,-0.235107,0.347376,-0.330358,-0.00631222,-0.123506,-0.516074,0.901645,0.0550899,-0.0417519,-0.240832,0.0230548,0.180735,0.00837906,-0.261423,0.12317,-0.475163,0.519899,0.69059,-0.0109103,-0.385292,-0.466677,-0.124627,-0.0271697,-0.528068,0.278111,-0.396157,-0.237849,0.145214,0.251765,-0.0897134,0.167112,-0.261386,-0.449416,-0.289155,0.132112,0.075402,0.215592,0.804171,0.18055,0.422551,0.518258,0.901293,0.794049,0.731566,1.06635,0.543611,-0.0286574,0.552452,-0.407838,0.569485,-1.04907,0.460182,0.0784547,-0.284399,0.614609,0.0265156,0.407474,0.394802,-0.0165119,0.185523,0.374538,-0.199984,0.591459,0.339145,0.347353,0.342413,-0.514611,-0.816882,-0.0891181,0.466931,0.00960487,-0.778302,-0.870016,-0.597306,-0.359105,0.604947,0.891228,0.799093,0.28729,-0.140062,-0.267591,-0.11722,-0.629794,0.100764,-0.00883669,-0.23509,0.769093,0.176472,0.401581,0.195998,0.228013,-0.00620379,0.580936,-0.222602,-0.138989,0.280988,-0.176078,-0.00396002,-0.365925,0.257406,0.157854,0.229297,0.397309,0.47885,-1.58717 +3411.1,0.961489,0.0848144,4,1.58245,1.05869,-0.67684,0.209823,0.410771,-0.223179,0.0195301,0.343599,0.375194,0.0381604,-0.359057,-0.00842258,-0.15891,0.395648,-0.331835,0.777512,-0.0639176,-0.422042,0.232919,-0.364482,-0.225927,-0.825759,-0.289521,-0.093801,-0.409282,-0.0471423,0.579852,0.255567,-0.652126,-0.0584212,0.650986,0.273044,0.630927,-0.0017606,-0.671711,-0.316455,-0.471347,0.347725,0.977551,0.276423,0.815633,0.625373,0.101739,-0.797226,0.0270689,-0.0367087,-0.752947,-0.137444,0.299357,0.171025,0.361354,0.0335444,0.0445659,-0.161977,0.588416,0.0446936,0.317548,-0.719945,0.483031,-0.0574201,0.626621,0.932714,-0.701472,-0.550506,-0.427405,0.488693,0.195919,0.107645,0.713389,0.357369,-0.0361036,0.111037,0.313877,0.807458,0.471752,0.538864,0.17239,0.0219935,0.156039,0.0909359,0.48059,-0.68919,0.232037,-0.43398,-0.621445,0.229702,-0.208463,-0.0938699,0.155313,-0.270239,-0.595335,-0.393596,0.288128,-0.259548,-0.00698529,-0.050437,-0.169024,-0.532482,0.305721,0.235468,0.0754263,0.272607,-0.255274,-0.315035,0.0205676,-0.0823316,0.111201,-0.11955,0.139877,0.362097,0.287176,-0.239246,0.149596,0.387533,0.529898,-0.544681,-0.621359,0.110093,0.325401,0.123007,-0.427477,0.226504,0.140499,-0.949533,0.323083,0.0846792,0.632518,0.56747,0.0597793,-0.154312,0.412804,-0.0172844,-0.0855226,0.639728,-0.0532969,0.327962,0.283077,0.254322,0.479094,-0.663389,-0.928088,-0.093316,-0.860741,-0.339639,0.133878,-0.0618558,-0.22543,0.212559,-0.133558,0.139334,-0.296276,-0.0379087,0.558995,0.190836,-0.356312,0.294632,-0.14962,0.0286741,-0.338882,-0.490393,0.385854,-0.225315,0.56909,0.185908,-0.0904494,0.209203,0.115581,-0.152494,-0.235114,-0.0028311,0.470326,0.351301,-0.199864,-0.335153,-0.225079,-0.0554133,-0.537893,-0.314621,-0.684146,0.791749,-0.291599,-0.0296854,0.323011,0.0994466,0.0974018,-0.600804,-0.558909,-0.175616,0.220356,0.474006,-0.267419,0.299282,0.742198,-0.716955,0.119921,0.0114084,0.468256,-0.415007,-0.216134,-0.329163,0.0911898,-0.271711,-0.18226,-0.0190969,-0.075711,-0.349306,-0.603997,1.07227,-0.3053,0.187999,-0.0172199,0.114653,0.00382454,-0.3232,-0.759736,-0.172289,0.401166,0.298976,0.549508,-0.327315,-0.284445,-0.803421,0.173723,0.25433,-0.969951,0.13716,-0.359315,-0.521607,0.387246,-0.233308,-0.288619,0.036676,-0.574069,-0.215235,-0.104347,0.386064,0.0726707,-0.491791,0.662273,0.113388,0.209882,0.438553,0.511877,0.329079,0.458097,0.584853,0.766222,0.461046,0.644095,0.0289593,0.536449,-0.828591,0.346449,0.0781239,-0.255614,0.777128,-0.487984,0.154005,-0.0670562,-0.0191457,0.482172,-0.176935,-0.514502,0.395261,0.243838,0.274101,-0.365536,-0.509799,0.0873147,-0.307734,0.213759,-0.341146,-0.370151,0.545907,-0.531438,-0.138886,0.309642,-0.0574554,0.849577,-0.00262798,-0.0554528,-0.351574,-0.163759,0.281449,0.265171,-0.0488059,-0.000584754,-0.0620511,0.33256,-0.0886096,0.0219362,0.223768,-0.247974,0.64971,-0.103454,-0.367477,-0.158281,-0.241689,0.097809,-0.0447805,0.0913569,0.157977,0.222873,0.397464,0.472095,-1.4405 +3436.87,0.977912,0.0848144,4,1.5041,1.00657,-0.586203,0.161925,0.456096,-0.0662007,0.134352,0.333949,0.380188,0.0280413,-0.143689,-0.099598,-0.29021,0.250457,-0.182373,0.805119,0.0694944,-0.0853702,-0.0261445,-0.668493,-0.27491,-0.772067,-0.668087,0.167056,-0.157861,0.00027315,0.209105,0.344487,-0.217955,0.10718,0.694574,0.245557,0.255433,0.287923,-0.161994,0.171853,-0.636121,0.401468,0.679064,-0.450698,0.974162,0.360049,0.165858,-0.424785,-0.187092,-0.230793,-0.410309,0.0563941,0.536956,0.289286,0.170079,0.0395043,0.179127,-0.288104,0.829986,-0.166094,-0.140753,-0.56014,0.535935,-0.225073,0.58937,0.744647,-0.461984,-1.03288,0.154986,0.412072,0.164101,-0.0923034,0.979773,-0.217728,-0.169517,0.306371,0.416222,0.376627,0.442781,0.744603,0.115756,-0.071502,0.230546,0.0433457,0.342391,0.0415831,0.291921,-0.312931,-0.400255,-0.233051,-0.152482,-0.0160658,0.084562,-0.418429,-0.685283,-0.419106,-0.00706733,0.0998529,0.087342,-0.00156736,0.429024,-0.291556,0.430659,0.235977,0.111567,0.296465,-0.472582,-0.282139,-0.373914,-0.0624898,-0.0377593,-0.22632,0.142487,0.439376,0.220893,0.209718,0.0735505,0.303071,0.623498,0.0360868,-0.915675,0.0535322,0.207362,-0.375192,0.0774704,-0.181501,0.133281,-0.0559711,0.250885,0.120046,0.391288,0.324323,0.364275,-0.116599,-0.205475,0.00632027,0.2349,0.537739,-0.0397788,0.218683,0.363917,0.240358,0.256323,-0.852684,-0.387778,-0.165344,-0.676991,-0.0727197,0.541344,-0.496768,-0.122287,0.744948,-0.278571,-0.0745472,0.00907008,0.118051,0.537263,-0.267573,-0.262737,0.59247,-0.204568,-0.175115,0.079773,-0.168391,0.587892,0.270138,0.520933,0.0466269,-0.290542,0.164979,0.0544654,-0.277369,-0.431777,-0.0733401,0.350585,-0.412371,-0.023267,-0.433406,-0.230527,0.0512864,-0.618238,-0.132257,0.00321978,0.404813,-0.483472,-0.51375,0.300181,-0.0986995,-0.258166,-0.0723021,-0.515689,-0.0535648,0.0285527,0.27875,0.309115,-0.0934893,0.443641,-0.514785,0.169532,-0.0624626,0.49554,-0.619526,-0.462254,-0.166248,-0.115128,-0.581432,-0.309823,-0.176893,0.391322,-0.335223,-0.34875,0.970981,-0.617322,-0.10695,0.12823,0.185882,0.166924,-0.22904,-0.53351,-0.118149,0.0497892,0.00977154,0.445399,-0.31897,0.0507325,-0.0140949,-0.320944,0.425696,-0.675349,0.0308632,-0.788044,-0.682545,-0.400515,-0.392562,0.20549,-0.0442445,-0.31247,-0.147363,-0.407333,0.397668,0.0133503,-0.0802916,0.914974,0.17287,0.127794,-0.0523517,0.189419,0.194382,0.53738,0.596817,0.842626,0.511823,0.477431,-0.0770951,-0.0452529,-0.959527,0.391535,-0.0250798,0.141488,0.687664,-0.177582,0.0278717,-0.271537,0.19609,0.273547,-0.0269909,-0.161173,-0.156723,0.518951,-0.138619,0.0213197,-0.404167,0.289284,-0.669203,-0.0325907,-0.33614,-0.35084,0.621151,-0.618634,-0.0869268,0.663626,-0.265451,0.56788,-0.250165,0.201921,-0.162092,0.523021,0.230103,0.0161043,0.0729025,-0.470652,-0.338244,0.11054,0.0560594,0.123473,0.0579825,0.0281277,0.85506,-0.173322,-0.377212,-0.437789,0.00739652,-0.135063,-0.00918098,0.224127,0.13394,0.172962,0.365978,0.415887,-1.61862 +3431.06,0.981525,0.0848144,4,1.63347,1.06061,-0.894454,0.328998,0.483282,-0.195195,-0.244536,0.0167426,0.227174,0.101807,-0.112974,-0.50297,-0.0952838,0.035042,-0.222685,0.774091,0.247883,-0.0279446,0.129767,0.115613,-0.11457,-0.933222,-0.558386,-0.0493721,-0.143305,-0.365676,-0.279211,0.358788,-0.125696,-0.106874,0.312927,-0.529482,-0.217315,0.266216,0.0797445,-0.269506,-0.257876,-0.0273745,0.400199,-0.0684724,0.825244,0.685143,0.0629131,-0.710621,-0.156944,0.209708,-0.71499,0.138875,0.38875,-0.267168,-0.155364,0.421747,0.0655485,-0.265041,0.475826,-0.25829,-0.170691,-0.392268,0.301626,-0.255312,-0.25049,0.405758,-0.479439,-0.329542,-0.421948,0.392505,-0.338528,0.202661,-0.249163,-0.221567,0.109037,0.290711,0.828572,-0.251326,0.734885,0.0472125,0.354301,-0.00803687,-0.666042,-0.599594,0.215745,-1.04509,0.0707444,-0.0586947,0.38013,0.0222205,0.320517,-0.337,0.221741,-0.0439558,0.499487,0.238501,-0.454211,-0.490326,-0.0524924,-0.600752,-0.134105,-0.379511,-0.274466,0.361495,0.0550582,-0.294331,-0.422139,-0.145947,0.461798,-0.176523,0.433238,-0.663849,0.236912,0.483061,-0.366599,-0.481016,0.569922,0.166252,-0.512534,-0.135148,-0.261052,-0.229856,0.0867074,0.52517,-0.736266,-0.454398,-0.200016,-0.178612,-0.1199,0.0237608,0.404147,-0.211484,0.25542,-0.265789,0.457493,0.0643444,-0.134111,0.544794,-0.283249,-0.42018,-0.676085,-0.283744,-0.210454,-0.21657,-0.530731,0.141525,0.806457,-0.537291,-0.0408924,0.60054,-0.0968438,0.324861,0.231097,-0.218657,-0.24261,-0.396648,-0.394438,-0.173505,0.687829,0.72805,0.148074,-0.0607467,0.248371,0.188347,-0.0464787,-0.619056,0.660285,0.0684046,0.257657,0.0282943,-0.667573,-0.0335653,0.1379,-0.0120894,-0.184113,0.402623,-0.269017,0.0333246,-0.146114,-0.401671,-0.197364,-0.449454,-0.250396,1.30195,0.574713,0.2903,-0.0622957,0.216679,0.283026,-0.607912,-0.199815,-0.158687,0.582345,-0.494025,-0.193001,0.0973623,-0.22631,-0.539901,-0.10183,0.208868,-0.309115,-0.430336,-0.54569,-0.116806,0.0170707,0.145054,0.551738,0.283836,-0.366421,0.140003,-0.224911,1.09907,0.27047,0.719818,-0.613917,-0.48896,0.0621566,0.425999,0.182029,0.273712,-0.189833,0.330609,-0.182275,-0.384351,-0.32107,-0.650234,0.294648,0.0635676,0.100507,0.238935,0.135361,0.0159177,0.60026,0.0673415,-0.861207,-0.340079,-0.0378743,-0.304842,-0.446772,0.00746613,-0.132927,0.094431,0.458068,-0.707845,-0.630246,0.44577,-0.0927191,-0.0824168,0.105284,0.299396,0.293577,0.120227,0.0352378,-0.279064,0.289167,0.368151,0.378024,-0.406565,-0.525543,-0.107788,-0.651057,-0.134741,0.121017,0.0282254,0.0961405,0.592957,0.360786,0.374448,-0.435969,0.668073,0.239583,0.201921,-0.0329732,0.328056,-0.621847,-0.0801517,0.131759,-0.195326,0.594566,0.176154,-0.24509,-0.0655367,-0.393126,0.234785,-0.416056,0.0374683,-1.06643,0.0960173,-0.218572,0.33725,0.167256,0.666757,0.114293,-0.701117,-0.135934,-0.0122637,-0.226115,-0.883974,-0.308597,-0.242655,0.245665,0.104971,-0.11419,-0.361623,0.0117851,0.151527,0.13862,0.389265,0.372317,-1.63928 +3419.93,0.95471,0.0848144,4,1.53164,1.06015,-0.980924,0.342163,0.317518,-0.159532,-0.105744,0.287068,0.309367,0.554616,-0.241554,-0.272832,0.105861,0.191573,0.129062,0.734563,-0.244388,0.0365843,0.110667,0.17924,-0.369109,-0.495009,-0.358349,-0.144724,-0.343805,-0.372497,0.234539,0.243352,-0.105732,0.053467,0.238273,-0.450026,-0.25805,0.46786,-0.319721,-0.111028,-0.230206,0.84432,0.102859,-0.44364,0.439762,0.520144,0.371484,-0.603409,-0.0860082,-0.0152943,-0.24101,0.21709,0.479048,-0.00261461,-0.226011,0.152409,0.200148,-0.0603436,0.337909,0.0341972,0.208933,-0.127508,0.330791,0.0383825,0.141084,0.193598,-0.752891,-0.957902,0.645454,0.312691,0.182904,0.432552,0.202598,-0.574395,-0.115568,0.321431,0.377367,-0.222431,0.756217,0.518421,0.10366,0.0255966,-0.461842,-0.186116,0.234749,-0.464263,0.592384,-0.43008,0.287191,0.155464,0.047066,-0.957143,0.133558,-0.058783,0.997521,0.228155,-0.550242,-0.710433,0.106201,-0.877697,0.245931,0.0643348,-7.25288e-05,0.632324,0.0533132,-0.22252,-0.560136,-0.333034,-0.119997,-0.179687,0.872593,-0.249965,0.544821,0.806901,-0.38123,-0.492698,0.372462,0.333372,0.553378,-0.424366,-0.597774,0.13482,-0.212729,0.302034,-0.093284,-0.0268199,0.310143,0.443475,0.0463429,0.0925851,0.644437,0.0580795,-0.0854418,-0.459128,0.0195646,0.247575,0.171167,0.220781,0.189149,-0.28136,-0.129013,-0.258625,0.351622,-0.427382,0.0917315,-0.212991,-0.165772,-0.516029,-0.0297596,0.276326,-0.237796,0.151317,0.0942445,-0.41051,0.18766,0.266593,0.0169633,0.126001,-0.000209813,0.439275,0.322703,-0.0389365,0.173532,-0.283476,-0.404526,-0.187515,0.510195,-0.390429,-0.636736,-0.339952,0.162499,-0.363799,-0.0883904,0.0418715,-0.607502,0.0871039,-0.125401,-0.431441,-0.46417,-0.382377,-0.107877,-0.569616,0.551363,1.51475,0.0176735,0.474815,0.447673,0.489674,-0.110641,-0.256564,-0.321549,-0.118858,0.207212,-0.683209,0.342357,0.0819568,-0.0390169,-0.42989,-0.362201,-0.0897709,-0.334236,-0.360661,-0.625319,0.390568,0.0243922,-0.103414,0.509895,0.127979,-1.094,0.256455,-0.593102,1.35687,0.590464,-0.0211282,-0.258742,-0.483724,-0.00669206,-0.187072,0.0759023,0.576687,-0.401538,0.172335,0.491109,0.191046,0.0876321,-0.213434,-0.176441,0.252201,-0.64697,0.248497,-0.172682,-0.0523448,0.34008,-0.0209651,-0.207278,0.174212,0.0372575,-0.638605,-0.654265,0.474159,0.0829252,0.729257,1.33672,-0.0386281,-0.672619,-0.569485,0.267938,0.106569,0.641288,0.352982,0.657469,0.398152,-0.331854,-0.153316,-0.5987,-0.649549,0.325199,-0.0825873,0.0557072,-0.0737279,0.0475037,-0.049841,-0.32366,0.419311,0.363368,0.498216,0.296933,0.687425,-0.0110499,0.113471,0.188231,-0.544016,-0.0061559,-0.277638,-0.222282,-0.107828,-0.609207,0.212077,-0.0749269,0.274991,0.155287,-0.161272,0.00944198,0.148864,0.00844077,0.179172,-0.129282,-0.0114483,0.00618141,0.034132,-0.0851222,0.869919,0.582083,0.384862,0.131403,0.390743,0.111429,0.0491189,-0.606797,-0.448166,0.653164,0.608799,0.277693,-0.399966,-0.539308,0.171142,0.126694,0.413693,0.35594,-1.16596 +3423.15,0.848565,0.0848144,4,1.56622,0.891078,-1.10438,0.419908,0.0637422,-0.160715,-0.0546407,0.292876,0.0968987,0.116043,-0.179979,0.0192125,-0.321494,0.185264,-0.180152,0.606139,0.218241,0.169674,-0.214239,0.503258,-0.557304,-0.760201,-0.529956,-0.006659,-0.177258,-0.248722,-0.379422,0.255233,-0.460639,-0.208904,0.49765,-0.509002,-0.147596,0.0919455,0.0340054,-0.267339,0.138509,0.346728,0.202264,0.0118574,0.930621,0.392835,0.249936,-0.467842,-0.45016,0.747817,-0.646703,-0.169264,0.0122955,-0.134014,0.0480983,0.279774,0.0882684,-0.233588,0.328678,0.0616288,0.125143,-0.184724,0.389037,-0.204853,-0.157112,0.207932,-0.136678,0.0110074,-0.169101,0.1985,0.0916122,-0.617068,-0.328059,0.056433,-0.0204298,0.616899,0.949957,-0.320708,0.792376,0.278098,0.251471,-0.347418,-0.753212,0.180969,0.261886,-0.331028,0.138489,-0.00440835,0.364496,0.108199,-0.309076,-0.746443,0.409818,-0.410001,0.053399,0.561875,0.0646974,-0.307798,-0.25276,-0.904103,-0.0421461,0.0891493,-0.173554,0.248368,0.382666,-0.614407,0.113383,-0.0960699,-0.120364,-0.532905,0.589954,0.18074,-0.212816,0.761352,0.470798,0.0465653,-0.222252,0.343309,-0.186941,-0.0131749,-0.424427,-0.179357,0.359936,0.0481529,0.130729,0.15875,-0.512966,-0.508113,-0.00495782,0.0142511,0.497928,-0.0380129,0.089457,-0.57027,0.0821254,0.0988548,-0.102287,0.376576,0.138052,-0.327637,0.140881,-0.446919,0.649699,-0.258333,-0.273689,0.0882707,0.00912261,-0.689376,0.271352,0.397872,0.0591372,0.769878,0.224298,-0.724288,-0.413812,-0.178009,-0.297051,0.507102,-0.227681,-0.176364,-0.490052,0.5056,0.450331,0.408763,0.184772,-0.469293,0.780837,-0.401905,0.427168,0.191224,0.154645,-0.0404587,0.375629,0.376568,0.276763,-0.314019,0.0603973,-0.36167,-0.479051,-0.143366,-0.55456,-0.214409,0.381176,1.14574,-0.342265,0.218108,0.451391,0.171711,0.181766,-0.731756,0.328747,0.000815636,-0.666389,-0.127842,0.329479,0.283994,0.077299,-0.338198,-0.0918356,-0.0366018,-0.72489,0.182079,-0.673286,-0.180888,0.240167,-0.215688,0.212383,0.350831,0.071367,-0.1295,-0.263047,1.0288,0.62138,0.0594031,-0.333211,-0.188813,0.361601,-0.0725611,0.363753,0.312853,-0.444364,0.44076,0.326524,0.0820867,-0.208237,-0.277837,-0.0110661,0.547444,0.462918,0.555443,-0.612806,-0.497906,-0.347514,0.0949423,-0.045917,0.0231703,-0.484801,-0.241211,-0.617437,0.180553,-0.539869,-0.0204236,1.18384,-0.414698,-0.469472,0.130762,-0.0403569,0.119162,0.674677,-0.101001,0.57703,0.330307,-0.640954,-0.308324,-0.550691,-0.662239,0.384287,-0.300985,-0.290364,-0.178583,0.214221,0.187608,0.185818,-0.0194443,0.383071,0.595217,0.239693,0.23212,0.341965,-0.0343815,0.242209,-0.46359,-0.415555,0.00223411,-0.649032,-0.13493,-0.357687,-0.29929,-0.372089,0.287579,0.421133,0.49657,0.242376,-0.460163,-0.00294281,-0.00840428,-0.276917,0.402747,0.149946,0.249326,0.04353,0.502691,-0.0618878,-0.379805,0.151549,0.432288,-0.403009,-0.324484,-0.0640821,-0.522744,0.468984,0.195138,-0.11212,0.483799,0.320471,0.139353,0.101744,0.3733,0.318973,0.00143864 +3422.78,0.8849,0.0848144,5,1.64362,0.959744,-0.662713,0.214389,0.590687,-0.0642256,0.134542,-0.0765337,0.464984,0.256654,0.0495225,-0.304437,-0.0397415,0.425466,-0.161149,0.595583,-0.187218,0.231452,0.113708,-0.36816,-0.448245,-0.654616,-0.696528,-0.062921,-0.322959,-0.155721,0.657477,-0.159785,-0.00860552,0.257088,0.706611,-0.194305,0.287688,0.0811018,-0.0912494,-0.229882,-0.841338,0.0996714,0.360831,-0.339241,0.973206,0.401023,0.360263,-0.897331,0.305084,-0.912597,0.0259912,-0.125081,0.187641,-0.137789,0.169387,0.346227,0.077227,-0.293558,0.605523,-0.0832428,-0.304363,-0.792883,0.34383,-0.6892,0.323844,0.561095,-1.05366,-1.16569,0.136768,0.337385,0.0501099,0.663737,0.0256954,-0.686149,-0.418415,-0.0406915,0.254801,-0.380538,0.508857,0.975337,0.198127,0.122338,0.178914,0.400366,0.396027,-0.308768,0.320545,-0.124618,-0.445789,-0.498101,0.526575,0.255011,-0.159591,-0.178566,0.0717652,-0.472657,-0.339633,0.0351313,0.283602,0.4208,0.255023,-0.722113,0.450436,0.561038,-0.120004,0.40774,-0.77034,-0.395888,0.384286,-0.166701,0.110716,-0.537976,0.614384,0.277249,-0.412067,-0.522905,0.411313,0.598423,-0.164954,-0.178746,0.0301778,0.0384238,-0.184933,-0.35615,-1.01773,-0.352322,-0.34649,0.0717215,0.00021058,0.265907,0.00995331,0.0941205,0.3998,-0.182637,-0.0713763,-0.193497,-0.327451,0.729131,-0.130545,-0.201493,-0.345389,-0.016835,0.593966,-0.824641,-0.548949,-0.053816,0.102377,-0.235896,-0.151624,-0.229975,-0.214324,0.196861,-0.345305,0.368571,0.0166795,0.21296,0.187134,-0.646996,0.445072,1.16144,0.409706,-0.70479,-0.00474341,0.0429319,0.443368,0.429678,0.447209,0.674396,-0.605413,0.114657,-0.227106,-0.16976,-0.676772,-0.0624427,-0.158137,0.0449777,0.0419364,-0.054053,0.0484409,0.105591,-0.244143,-0.0951895,-0.481906,0.81395,0.47457,-0.436097,-0.0704606,0.0729299,-0.244017,-0.0340036,-0.833732,-0.334032,0.765379,-0.541415,-0.326626,-0.815469,0.25219,-0.265733,0.0238785,0.242909,0.686916,-0.195295,-0.524269,-0.0557688,-0.234281,-0.221266,0.0738441,-0.706204,0.281505,-0.0144009,-0.231815,0.986973,-0.810856,-0.0778139,0.188962,-0.34163,-0.109568,0.0655855,-0.615239,0.173528,-0.194638,0.164255,0.391909,-0.424959,0.288085,-0.799114,-0.0220306,-0.158281,-0.891081,0.33469,-0.0121676,0.0680854,0.20967,-0.205236,-0.262116,0.168312,-0.0786749,-0.380031,0.0754604,0.383899,0.338955,-0.0736512,0.334525,-0.266966,0.0848347,-0.155573,0.298872,-0.17755,-0.0135959,0.150202,0.381483,-0.260826,0.483904,-0.349801,0.0572811,-0.340793,0.776781,-0.394265,-0.180326,0.485192,-0.31713,-0.14799,-0.164291,0.178793,-0.268465,-0.0642387,-0.117754,0.403906,0.27547,0.52082,-0.183945,0.0581119,0.311501,-0.143257,0.105894,-0.340066,-0.153517,0.60454,0.406071,-0.191016,0.0490248,-0.30795,0.0745717,0.59914,-0.300915,-0.201555,-0.445344,-0.0539433,0.0912729,-0.0546793,-0.312821,-0.351294,-0.0245444,-0.0960938,0.11466,-0.649776,0.15601,0.246767,-0.397346,-0.299769,-0.538071,0.267623,-0.344443,-0.701343,-0.274923,0.129828,0.206201,0.360317,0.454094,-1.85317 +3408.16,0.952005,0.0848144,4,1.53312,0.940438,-0.736876,0.352883,0.229181,-0.152276,0.178551,0.625844,-0.293118,0.271119,0.0490812,-0.207589,0.529477,0.574236,-0.0528317,0.784682,0.114969,-0.133937,0.0340103,-0.0784595,-0.0154134,-0.656849,-0.0408796,0.161453,-0.00498631,0.379356,0.372279,0.482851,-0.246218,-0.311568,1.14144,-0.0110993,0.231364,0.23198,-0.971795,-0.50983,0.0112841,0.0845374,0.0466279,-0.467125,0.617209,0.781785,0.0860036,-0.716286,-0.132367,-0.107921,-0.538991,-0.142802,0.0254619,-0.285702,-0.174301,-0.0455738,0.419023,0.103958,0.686409,-0.277014,-0.564891,-0.809696,0.415348,-0.114959,0.332654,0.739744,-0.800842,-0.773238,0.0360549,0.483236,0.36183,-0.136604,0.300496,-0.899638,0.606115,0.215434,0.567225,0.624699,1.07432,0.472518,0.20099,-0.177328,0.186116,0.294469,0.469369,-0.529299,0.246485,0.103198,-0.371312,-0.320318,0.558157,-0.590733,0.220806,-0.690866,-0.290106,0.147132,0.253166,-0.0469568,0.737742,-0.371696,0.608256,0.00357801,0.375973,0.186189,-0.47361,-0.223785,-0.523091,-0.460399,0.402219,-0.00326654,-0.123333,-0.124651,0.286698,0.737238,0.216658,-0.15575,0.0875258,0.0246428,-0.202715,0.499695,-0.641929,-0.0904153,0.62143,-0.630195,-0.609579,-0.573737,-0.028028,-0.48432,-0.66844,-0.454428,0.190278,-0.328466,0.144566,-0.712286,0.177958,-0.0761303,0.249886,0.465172,0.113291,0.120202,-0.645577,-0.130306,0.653969,-0.855123,-0.637294,0.074289,0.17587,-1.33509,-0.528587,0.345168,-0.0800677,0.901477,-0.168965,-0.494874,0.0273352,0.345988,0.216524,0.0283724,-0.236195,0.603348,-0.0722111,0.213102,-0.0336793,-0.440695,0.209931,-0.74298,0.270539,0.328194,-0.385098,0.679318,0.105713,0.0420689,0.11464,0.58089,-0.43298,-0.641723,-0.265274,-0.230127,0.36123,0.13422,-0.524495,-0.1148,0.162914,0.765329,-0.110253,0.256424,0.216878,-0.0184083,-0.289164,0.0273264,0.326531,-0.446524,0.0449175,-1.15502,0.0392302,0.552529,0.00467142,-0.528714,0.0362202,0.563748,0.0875644,-0.24877,-0.632928,0.412457,0.232614,0.40958,-0.192213,-0.292381,-0.456962,-0.519456,-0.353398,0.774523,0.167718,-0.135356,-0.114848,0.310453,0.497657,0.00398378,-0.154673,0.640692,-0.175316,0.362513,0.0756443,-0.462873,-0.0188938,-0.778246,-0.300603,0.431294,0.398216,0.657159,0.153846,-0.413599,0.0126419,-0.364414,-0.67969,-0.172695,-0.169555,-0.219423,0.201077,0.273649,-0.394642,-0.122054,0.699147,0.311597,-0.0160794,-0.529819,0.0199727,-0.0805897,0.521855,0.510334,0.722845,0.632312,-0.826426,-0.276736,0.209956,-0.143511,0.422106,0.11353,-0.471525,0.19744,-0.743964,0.421599,-0.591946,0.0315373,0.206662,0.794868,-0.283207,0.232183,0.534096,0.101231,-0.0655499,-0.0621135,-0.383022,0.381837,-0.205643,0.0458768,0.134306,-0.317541,-0.103293,-0.0182616,0.504491,-0.0350526,0.293682,0.11877,-0.341982,-0.0717767,0.0181934,-0.0726981,0.0862398,-0.0476151,0.0917859,1.00685,0.0087681,-0.379998,-0.254846,0.0077536,0.453851,0.165738,-0.292174,-0.000445972,0.205532,-0.00393642,0.336833,-0.456993,-0.264633,0.153641,0.190455,0.391971,0.436412,-0.79979 +3409.31,0.957933,0.0848144,5,1.45845,0.763859,-1.33254,0.584411,0.81533,-0.191494,0.395506,-0.269575,0.270293,0.164515,0.579148,-0.128855,0.165986,0.511876,-0.460915,0.644732,0.167315,0.283081,0.311674,-0.0537394,0.257121,-0.651844,-0.991518,0.561131,-0.436805,0.0632789,-0.0993037,0.250116,-0.245213,0.11077,0.991736,-0.287171,-0.129695,0.466389,-0.683756,-0.267085,-0.527196,0.427067,0.695807,-0.299563,0.347175,0.436811,0.485767,-0.494271,-0.0221914,0.393027,-0.265124,0.318339,0.483355,0.192812,0.487075,0.569802,-0.0291279,-0.639297,0.676445,-0.30466,0.0293595,-0.60074,0.316175,-0.265625,0.175509,0.903728,-0.0939904,-0.334293,0.346216,0.086739,-0.54167,0.413089,-0.613111,-0.362198,-0.688733,-0.581138,0.468063,-0.15962,0.459959,0.445534,0.432089,-0.168337,-0.50919,-0.10086,0.126922,-0.0870181,0.254198,-0.108419,-0.112669,-0.0316732,-0.719343,0.46905,0.116498,-0.242522,-0.234907,0.0951403,-0.0530869,0.392084,-0.377212,0.0954756,-0.249055,-0.360151,0.0691519,0.961711,0.159436,0.0784515,-0.15144,-0.50768,-0.386082,-0.151847,0.100802,-0.308567,0.337438,0.180261,-0.484584,-0.388665,-0.311387,0.182976,0.238717,-0.161749,0.358205,0.209694,-0.59709,0.315671,-0.740948,0.486521,-0.416711,-0.183151,-0.182722,0.819009,0.304529,0.523916,-0.030382,-0.0274817,-0.558151,0.000218234,0.366893,0.808891,-0.330483,-0.450015,0.105881,0.162317,0.258681,-0.360967,-0.172218,0.15109,0.0615119,0.159528,0.565193,-0.134826,-0.130604,-0.06918,-0.336477,0.142184,-0.531561,-0.0765891,0.296078,0.24338,0.517397,0.696289,-0.134574,-0.0320692,0.747965,0.339219,0.323874,0.154723,0.53109,-0.340133,-0.00028721,-0.408888,-0.326611,-0.13731,-0.58673,-0.118221,0.769112,0.297237,-0.281075,0.166632,-0.36402,-0.18122,-0.000108515,-0.283571,0.231778,0.859616,0.134928,-0.768806,0.309182,-0.640892,0.0346141,-0.40376,-0.439582,-0.328738,0.167734,-0.0514796,-0.094524,0.0554277,0.168191,-0.380428,0.104213,-0.486293,0.167968,-0.282491,-0.344306,-0.0106257,-0.0894707,-0.663661,0.0295906,-0.212741,0.416815,0.14243,-0.28814,1.11545,-0.242969,0.486707,0.312575,-0.327877,-0.102891,0.151107,-0.0752255,0.371757,-0.22522,0.403886,0.412924,-0.67995,-0.0912383,-0.280886,0.23991,-0.313708,-0.982113,0.0765793,-0.666374,-0.292749,0.124708,0.271594,0.218022,-0.0378441,0.173591,0.09726,-0.451471,0.581618,0.447164,0.13243,0.576319,-1.1803,-0.498441,0.0946538,-0.33253,0.0919005,0.314946,-0.0819595,-0.0899233,-0.41269,0.24493,-0.272798,0.0804391,-0.739824,0.502175,-0.286628,-0.017352,0.555747,0.44088,-0.395687,1.23976,0.506493,0.490164,-0.432226,0.523484,0.177872,-0.234327,0.302913,-0.0480469,-0.267651,0.0559863,0.0124402,0.196356,-0.349546,-0.592604,0.638658,0.493627,0.421998,0.44605,-0.250602,0.540185,0.0950895,-0.207965,-0.129319,-0.449147,0.270752,0.12223,0.602834,-0.287849,-0.0431497,0.263432,-0.162284,0.0174702,0.380391,-0.119896,0.114874,0.231913,-0.906032,-0.248411,0.137098,-0.768175,0.255159,0.376244,0.148389,0.221732,0.385213,0.470885,-2.40496 +3412.82,0.910008,0.0848144,5,1.55929,0.635892,-1.84244,0.70946,0.287904,-0.112871,0.227665,-0.218346,0.0501493,0.433664,0.264349,-0.384653,-0.0338732,0.688519,-0.238926,0.644509,0.322472,0.192601,0.0673585,-0.0632472,0.0157167,-0.501415,-1.26731,0.0884284,-0.268361,-0.240189,-0.142625,0.18752,-0.0824463,0.250656,0.801795,-0.208951,-0.0613328,0.49463,-0.120655,0.0296913,-0.574749,0.455043,0.627541,-0.500731,0.561616,0.529516,0.463297,-0.571618,0.137262,0.137681,-0.161784,0.717683,0.569942,0.294653,0.290696,0.772994,0.0765048,-0.51878,0.623992,-0.194669,0.10795,-0.45427,0.183396,-0.478511,0.0137547,0.801561,-0.280067,-0.377742,-0.122069,-0.156606,-0.350137,0.199741,-0.61436,-0.165133,-0.0995283,-0.430027,0.558496,-0.174378,0.205483,0.843941,0.169423,-0.126267,-0.316525,0.0613007,0.256033,0.236648,0.368515,-0.306331,0.0718469,0.267508,-0.656738,-0.361953,0.102291,-0.345249,-0.36996,-0.0246848,-0.0562217,0.114353,-0.476131,0.249116,-0.308634,-0.404986,-0.185495,1.04148,0.161009,0.0188584,-0.277658,-0.306465,-0.320394,-0.513041,0.116271,-0.192757,0.176858,0.426692,-0.218398,-0.396616,0.00990079,0.399239,-0.232427,-0.197901,-0.0666679,0.322901,-0.323599,-0.0513709,-1.08057,0.269402,-0.47141,-0.463265,-0.0886584,0.635544,0.0253359,0.076097,0.113078,0.0288613,-0.51928,-0.301709,0.359344,0.527963,-0.126663,-0.275456,-0.121655,-0.319953,0.327905,-0.267282,0.20128,0.315334,0.299445,-0.375824,-0.018495,0.287757,-0.223893,-0.0621549,-0.44437,-0.367867,-0.577199,0.236959,0.204395,0.223663,0.590413,1.09997,-0.380977,-0.00211715,0.506705,0.245927,0.546033,-0.162501,0.281715,0.275542,-0.0814641,-0.497276,-0.141808,-0.456188,-0.260584,0.0746899,0.461957,-0.372039,-0.0364522,-0.0225197,-0.442534,-0.352875,-0.234974,-0.170705,0.45893,0.628711,0.425915,-0.148108,0.673157,0.0790932,-0.0411736,-0.419331,0.10806,0.0132388,0.138369,-0.0528174,-0.0138844,0.538087,0.182864,-0.781607,0.382861,-0.867071,0.216548,-0.287824,-0.372331,0.136386,0.151175,-1.04627,0.231692,0.0699361,0.234632,0.103762,-0.105909,0.930849,-0.625123,-0.0877964,0.0151463,0.0488913,0.275851,-0.285856,-0.105345,0.337477,0.0873928,0.814455,0.0534975,-0.123685,-0.405208,-0.110394,0.352023,-0.191394,-0.63785,0.108818,-0.439227,-0.324904,0.107078,0.405757,0.426442,0.0105583,0.117469,-0.372324,-0.461108,0.734777,0.619627,0.315098,0.673967,-1.09471,-0.799761,-0.25414,-0.0375442,0.583003,0.393184,0.0700607,0.212194,-0.299043,-0.447759,-0.397374,0.247724,-0.57828,0.472328,-0.278011,0.123987,0.3896,-0.0621268,-0.123952,1.01202,0.425573,0.162651,0.0972355,0.376122,0.158124,-0.303174,-0.0635178,0.124641,-0.087062,0.0325029,-0.262822,0.111674,-0.335773,-0.643133,0.277682,0.279013,0.218664,0.58531,-0.341639,0.207391,0.0221735,0.144165,-0.512295,0.131221,0.629859,0.0140044,0.512911,-0.277985,-0.276891,0.0364162,-0.589472,0.0172111,0.138547,-0.0209641,0.705712,0.331385,-0.68102,0.0227047,-0.225275,-0.0072342,-0.34582,0.300553,0.144597,0.127735,0.380259,0.357401,-0.197269 +3411.55,0.997762,0.0848144,4,1.51329,0.7109,-1.41114,0.56071,0.230375,-0.0554456,0.0238874,-0.209496,0.1031,-0.500585,0.0234424,-0.165507,-0.0524967,0.627787,-0.506568,0.435391,0.188906,0.0381441,0.0947014,0.119159,0.0700387,-0.50177,-0.633,0.522445,-0.36416,0.0140075,-0.899809,-0.111335,-0.261081,0.134532,0.971834,-0.144993,-0.640776,0.545736,-0.681484,-0.0492747,-0.844349,0.559329,0.550827,0.244794,0.573557,0.532183,0.303278,-0.599034,0.0424505,0.788336,-0.266453,0.0608932,0.682775,0.0211118,0.139601,0.343319,0.0783148,0.181787,0.553872,0.16279,0.0589079,-0.805201,-0.0323483,0.23509,0.32935,1.27148,-0.217024,-0.796363,0.458568,0.0240808,0.356088,-0.533979,0.323133,-0.127745,-0.856607,0.113111,0.409515,0.263878,0.397348,0.303581,0.231193,0.218735,-0.0109414,0.188874,0.333235,-0.102074,0.590879,0.0615852,-0.445802,-0.0311053,0.355014,-0.0218529,-0.0274267,-0.409921,-0.167531,-0.264063,-0.251958,-0.100554,-0.0181643,0.0275926,0.557676,-0.533689,0.132044,0.251505,-0.121464,-0.00694863,-0.546105,-0.338521,0.264179,-0.349516,0.131478,-0.466963,0.290555,0.643897,-0.380144,0.045463,0.138911,0.489922,0.247149,0.0669423,0.347868,0.419709,-0.0258967,0.682759,-0.349294,-0.17002,0.211822,-0.527172,0.113481,0.547532,-0.072534,0.0195105,0.052679,0.0925414,0.0170351,-0.147341,0.460292,-0.0873153,-0.162637,-0.223126,0.219647,0.277069,0.625938,-0.26382,-0.256643,0.100604,-0.000979899,-0.128766,0.418898,-0.0864852,-0.117361,0.166924,0.0443832,-0.480524,-0.862725,0.0372009,0.304521,-0.241196,-0.121182,0.296343,-0.118564,0.0247844,0.21394,-0.513029,-0.0288563,0.288707,0.622056,0.284446,-0.556665,-0.850565,-0.233397,-0.0852235,-0.238916,0.231523,0.227814,-0.459484,0.100938,-0.325174,0.0481028,-0.0267442,-0.10932,-0.101964,0.454346,0.560345,0.0676176,-0.403272,0.185085,-0.103939,-0.20506,0.140544,-0.0725565,0.0425698,0.643806,-0.346421,-0.186001,0.00432725,0.606195,-0.609106,-0.253402,-0.29696,0.168339,-0.323371,-0.991468,0.0464736,-0.00992958,-0.69481,0.263477,-0.150919,-0.0210599,0.347663,-0.406411,0.788761,0.38321,-0.465934,-0.460741,-0.0209347,0.238975,-0.113723,-0.346368,-0.0320527,-0.239129,0.530417,-0.384979,-0.174238,0.0138767,-0.287153,0.191004,-0.0870891,-0.576628,0.153005,-0.568005,-0.462475,0.204199,0.368002,-0.0701819,0.212508,-0.517314,-0.482492,0.166144,0.743522,-0.216686,0.215486,0.469154,-1.15963,-0.544053,-0.254759,-0.331231,0.411499,0.700786,-0.543114,0.685059,-0.0160402,-0.474598,-0.339732,-0.143838,-0.793186,0.139924,-0.425486,-0.551636,0.313354,-0.284005,0.0911578,0.398925,0.130678,0.802835,-0.142618,-0.220011,0.0230638,-0.0434661,0.283941,-0.0430893,-0.604079,-0.125563,0.0104624,-0.198894,-0.290196,0.354199,0.099711,0.00824279,-0.680353,0.528433,-0.599647,0.130944,0.373875,-0.197523,-0.168621,-0.865899,-0.0368293,-0.257292,-0.0421898,0.160244,0.303248,-0.0482564,-0.288322,-0.0229487,-0.00298081,-0.540104,-0.0642953,0.335584,-0.201062,-0.137742,-0.410487,0.279848,-0.14939,0.227909,0.129596,0.301514,0.359994,0.549103,-0.2848 +3449.66,0.985106,0.0848144,4,1.48823,0.677708,-1.66626,0.624813,0.414837,-0.0391532,-0.286109,-0.476761,-0.0647475,0.503754,0.323045,-0.533615,-0.216749,0.604564,-0.196666,0.808961,0.498,0.139713,-0.26257,-0.211241,0.0980745,-0.654654,-1.08749,0.496251,-0.461193,-0.174148,-0.480914,0.730907,-0.295024,0.072891,1.00282,-0.394933,-0.667389,0.287735,-0.0416874,0.0436244,0.0493064,0.0670642,0.924755,-0.352873,1.01981,0.897326,0.217989,-0.32504,0.0056966,-0.309701,-0.100461,0.671443,0.564909,0.091997,0.287494,0.66085,-0.082782,0.178992,0.672429,-0.337013,0.393192,-0.885608,0.564262,-0.162546,0.152764,1.14557,-0.80215,-1.05748,0.355748,0.634768,0.272916,0.0187239,-0.448579,-0.464209,-0.230377,0.333745,0.442275,0.392269,0.417509,0.244837,0.162543,0.101072,-0.208296,-0.17089,0.0837124,-0.156328,0.126456,0.366615,0.0129557,-0.371909,-0.630249,-0.333324,-0.288308,-0.131228,-0.0603054,0.904902,0.280416,0.0639296,0.139432,0.36936,0.0427129,-0.236453,-0.440539,0.52175,-0.181029,0.0194057,-0.791761,-0.321776,-0.416105,-0.662625,0.288121,-0.0991833,0.000799252,0.353254,0.531861,-0.0303681,-0.181409,0.384371,-0.00389967,-0.315753,-0.117759,-0.232123,-0.00764254,-0.511604,-0.506443,-0.60891,0.16426,-0.503657,-0.259058,0.435958,0.182563,0.395591,0.16172,-0.42229,0.0098296,-0.0386513,0.311665,0.32984,-0.087684,0.00625131,-0.397383,0.0244591,0.20455,-0.409076,-0.535634,0.109446,0.40273,-0.482963,-0.0412274,-0.116891,0.107787,-0.0797484,-0.505873,-0.0032784,-0.145718,0.149598,0.35812,-0.0312267,-0.0343075,0.562264,0.23948,0.261377,0.0757508,0.0389667,0.307579,0.075052,0.677321,0.139635,-0.150396,-0.0112696,-0.025058,0.127576,-0.537251,-0.0107008,0.259297,0.105325,-0.11821,0.258154,-0.441406,0.0816715,-0.203923,-0.14688,0.330844,0.238477,0.173953,0.0898982,0.328299,0.185964,0.0430742,-0.698967,-0.22039,-0.0699622,0.172646,-0.188835,-0.0104962,-0.202744,-0.0780681,-0.166416,-0.134913,0.142629,0.158786,-0.289216,-0.283823,0.247638,0.270531,-0.287127,0.0308088,0.414208,0.0350616,-0.146742,-0.175707,0.746349,-0.543408,0.147729,0.26761,0.134726,0.100389,-0.0957875,-0.394706,0.288374,0.12624,0.441448,0.277609,-0.0853433,-0.70299,-0.417858,0.00431403,0.203684,-0.0522171,0.175586,-0.141962,-0.145007,0.231731,-0.12012,-0.0320131,-0.0281942,-0.056758,-0.0185228,0.0312974,0.358627,-0.233932,0.134059,0.271469,0.158274,-0.783247,0.162595,0.415088,0.487751,0.190889,0.0348616,0.0841119,0.0775142,0.0828395,-0.413067,0.261119,-0.279863,-0.00575897,0.021275,-0.52006,0.0673317,-0.348426,-0.0701407,0.369962,0.366065,-0.556777,0.261732,0.251834,-0.46864,-0.109517,-0.425853,-0.157559,0.0866595,0.600523,-0.144806,0.0130902,0.0542918,-0.320731,0.501774,-0.3454,0.200191,0.00788017,0.459596,0.291897,-0.368941,0.0173819,0.0328999,-0.272269,-0.404447,0.13484,-0.187828,-0.0728482,0.294025,0.0436447,0.155663,0.0897565,0.433678,0.154719,-0.344721,-0.154865,-0.21279,-0.196146,-0.410625,-0.088148,-0.450967,-0.274485,0.0873924,0.251782,0.295622,0.501779,-0.794372 +3463.95,0.88411,0.0848144,4,1.50997,0.705473,-1.54665,0.590953,0.307063,-0.135302,-0.41209,-0.14211,0.239971,0.428624,0.186839,-0.204047,-0.211109,0.465871,-0.107173,0.660411,0.456943,0.0453012,-0.366408,-0.24132,0.155947,-0.532677,-0.873436,0.370541,-0.51398,0.0082637,-0.459703,0.689202,-0.082785,-0.0043653,0.966756,-0.287893,-0.491606,0.169337,-0.325297,-0.282545,0.127839,-0.0155041,0.689896,-0.339097,0.991504,0.826821,0.551719,-0.337547,-0.157253,-0.52188,-0.372022,0.698778,0.521499,0.0494609,0.472986,0.654716,0.127229,0.125989,0.717298,-0.452195,0.280567,-0.606484,0.631027,-0.102663,0.519571,1.30153,-0.67187,-0.843137,0.353435,-0.00880755,0.1905,-0.361538,-0.215114,-0.168506,-0.536114,0.398969,0.504316,0.350036,0.697909,0.396976,0.0882503,0.304634,-0.263762,-0.149727,0.188281,-0.0263241,0.182192,0.183277,0.0106569,-0.0948876,-0.38993,-0.23929,-0.169425,-0.2763,-0.205403,0.628293,0.304114,0.0953129,0.113225,0.299779,0.271565,-0.0330127,-0.256899,0.500948,-0.283766,0.1785,-0.549236,-0.240595,-0.650438,-0.623199,0.00621995,-0.204224,0.17197,0.274231,-0.000328606,-0.216252,-0.217868,0.348378,-0.32544,-0.211992,-0.471974,-0.144584,0.118001,0.0346849,-0.649191,-0.717849,0.270154,-0.514142,0.0674573,0.156959,0.194711,0.356629,0.153349,-0.410412,0.0539078,0.240822,0.0350678,0.247623,-0.232404,0.212441,-0.266205,0.109691,0.23991,-0.551765,-0.171563,-0.1389,0.549383,-0.51451,-0.152694,-0.0892214,0.151876,0.306715,-0.427934,0.0544373,-0.18065,0.113912,0.194133,-0.0182864,0.0641519,0.463171,0.486222,0.329743,0.00366103,-0.148253,-0.210219,-0.274699,0.456786,0.176292,0.0391943,-0.0912546,-0.124136,0.0541254,-0.607172,-0.125671,0.294802,0.214768,-0.123141,0.369012,-0.347207,0.0223612,-0.112345,-0.0142401,0.301376,0.271693,0.457551,-0.224279,0.447327,0.121087,-0.330361,-0.151183,-0.25455,-0.30028,0.186959,-0.289281,0.0715528,0.399742,-0.142283,-0.301923,0.165354,0.1999,0.0185016,-0.291592,0.028809,0.170561,0.364301,-0.164591,-0.369495,0.421942,-0.203713,-0.289864,-0.203265,1.07404,-0.0201438,0.427531,0.115554,0.179447,-0.00822472,-0.127883,-0.0673367,0.256683,0.0751797,0.426406,0.369397,-0.25139,-0.409187,-0.251674,0.306322,0.144064,-0.183654,0.331997,-0.17521,-0.202872,0.316185,-0.0844171,0.227818,0.0124765,-0.033558,0.0279606,-0.0974494,0.27328,-0.0719815,0.200347,0.688559,0.232232,-0.828014,-0.130318,0.120493,0.452207,0.267771,0.0002854,0.278066,0.140432,0.163844,-0.520318,0.373078,-0.254362,-0.157498,0.215691,-0.63049,0.11661,-0.173459,-0.214618,0.247423,0.254818,0.160606,0.0152928,0.174837,-0.366198,-0.0672867,-0.268799,0.00383645,-0.31017,0.515282,-0.192667,0.100477,-0.0148715,-0.264004,0.596637,-0.5083,0.0250367,-0.115948,0.339107,0.29472,-0.516306,-0.226692,-0.21409,-0.16019,-0.429542,0.0429595,-0.107418,-0.159926,0.359673,0.111333,0.168931,-0.00974805,0.414621,0.245227,0.062281,-0.147834,-0.375175,-0.104928,-0.229067,-0.436288,-0.47259,-0.197568,0.0987735,0.298829,0.314283,0.546652,-0.470624 + +# Elapsed Time: 4.78942 seconds (Warm-up) +# 4.60144 seconds (Sampling) +# 9.39086 seconds (Total) + diff --git a/src/test/interface/example_output/matrix_summary.csv b/src/test/interface/example_output/matrix_summary.csv new file mode 100644 index 0000000000..48d875eed4 --- /dev/null +++ b/src/test/interface/example_output/matrix_summary.csv @@ -0,0 +1,23 @@ +name,Mean,MCSE,StdDev,MAD,5%,50%,95%,ESS_bulk,ESS_tail,R_hat +"lp__",-15.3787,1.17576,3.71807,0.779848,-20.9245,-14.8305,-12.6946,5,5,1.31109 +"accept_stat__",0.68789,0.0961912,0.304183,0.252626,0.208269,0.779947,0.989055,5,5,1.05408 +"stepsize__",0.894277,nan,0,0,0.894277,0.894277,0.894277,nan,nan,nan +"treedepth__",0.9,0.1,0.316228,0,0.45,1,1,nan,nan,nan +"x[1]",0.608917,0.0690549,0.218371,0.108465,0.284524,0.666485,0.866975,5,5,0.905216 +"x[2]",0.479369,0.051013,0.161317,0.164219,0.263389,0.451793,0.686842,5,5,1.00156 +"y[1,1]",0.425556,0.124575,0.393941,0.150819,0.0588995,0.164637,0.926039,5,5,1.431 +"y[1,2]",0.595682,0.0758338,0.239808,0.178212,0.249647,0.663856,0.850511,5,5,1.11989 +"y[1,3]",0.473713,0.104663,0.330973,0.39317,0.0677836,0.483405,0.863312,5,5,0.986085 +"y[2,1]",0.511464,0.0868387,0.274608,0.383569,0.167417,0.487338,0.895304,5,5,1.43105 +"y[2,2]",0.559192,0.0872593,0.275938,0.307409,0.230475,0.525767,0.932888,5,5,0.915761 +"y[2,3]",0.51956,0.0997935,0.315575,0.212694,0.0361943,0.536618,0.930452,5,5,1.32719 +# Inference for Stan model: issue_342_model +# 1 chains: each with iter=10; warmup=1000; thin=1; 10 iterations saved. +# +# Warmup took 0.23 seconds +# Sampling took 0.0018 seconds +# Samples were drawn using hmc with nuts. +# For each parameter, ESS_bulk and ESS_tail measure the effective sample size +for the entire sample (bulk) and for the the .05 and .95 tails (tail), +# and R_hat measures the potential scale reduction on split chains. +At convergence R_hat will be very close to 1.00. diff --git a/src/test/interface/example_output/matrix_summary.nom b/src/test/interface/example_output/matrix_summary.nom new file mode 100644 index 0000000000..b3ac3112bd --- /dev/null +++ b/src/test/interface/example_output/matrix_summary.nom @@ -0,0 +1,15 @@ + Mean MCSE StdDev MAD 5% 50% 95% ESS_bulk ESS_tail R_hat + +lp__ -15 1.2 3.7 0.78 -21 -15 -13 5.0 5.0 1.3 +accept_stat__ 0.69 0.096 0.30 0.25 0.21 0.78 0.99 +stepsize__ 0.89 nan 0.00 0.00 0.89 0.89 0.89 +treedepth__ 0.90 0.10 0.32 0.00 0.45 1.0 1.0 + +x[1] 0.61 0.069 0.22 0.11 0.28 0.67 0.87 5.0 5.0 0.91 +x[2] 0.48 0.051 0.16 0.16 0.26 0.45 0.69 5.0 5.0 1.0 +y[1,1] 0.43 0.12 0.39 0.15 0.059 0.16 0.93 5.0 5.0 1.4 +y[1,2] 0.60 0.076 0.24 0.18 0.25 0.66 0.85 5.0 5.0 1.1 +y[1,3] 0.47 0.10 0.33 0.39 0.068 0.48 0.86 5.0 5.0 0.99 +y[2,1] 0.51 0.087 0.27 0.38 0.17 0.49 0.90 5.0 5.0 1.4 +y[2,2] 0.56 0.087 0.28 0.31 0.23 0.53 0.93 5.0 5.0 0.92 +y[2,3] 0.52 0.100 0.32 0.21 0.036 0.54 0.93 5.0 5.0 1.3 diff --git a/src/test/interface/example_output/mix.nom b/src/test/interface/example_output/mix.nom index fbe76363e9..11693838f2 100644 --- a/src/test/interface/example_output/mix.nom +++ b/src/test/interface/example_output/mix.nom @@ -7,12 +7,10 @@ No divergent transitions found. Checking E-BFMI - sampler transitions HMC potential energy. E-BFMI satisfactory. -The following parameters had fewer than 0.001 effective draws per transition: - mu[1], mu[2], theta -Such low values indicate that the effective sample size estimators may be biased high and actual performance may be substantially lower than quoted. +Rank-normalized split effective sample size satisfactory for all parameters. -The following parameters had split R-hat greater than 1.05: - mu[1], mu[2], theta +The following parameters had rank-normalized split R-hat greater than 1.01: + mu[1], mu[2], sigma[1], theta Such high values indicate incomplete mixing and biased estimation. You should consider regularizating your model with additional prior information or a more effective parameterization. diff --git a/src/test/interface/example_output/stansummary_console_default.txt b/src/test/interface/example_output/stansummary_console_default.txt new file mode 100644 index 0000000000..ff8c3f6cb3 --- /dev/null +++ b/src/test/interface/example_output/stansummary_console_default.txt @@ -0,0 +1,23 @@ +Inference for Stan model: bernoulli_model +4 chains: each with iter=1000; warmup=1000; thin=1; 1000 iterations saved. + +Warmup took (0.0030, 0.0030, 0.0040, 0.0030) seconds, 0.013 seconds total +Sampling took (0.0090, 0.010, 0.010, 0.0090) seconds, 0.038 seconds total + + Mean MCSE StdDev MAD 5% 50% 95% ESS_bulk ESS_tail R_hat + +lp__ -7.3 0.020 0.74 0.33 -8.8 -7.0 -6.8 1513 1592 1.0 +accept_stat__ 0.93 0.0018 0.12 0.038 0.67 0.97 1.0 +stepsize__ 0.90 nan 0.020 0.021 0.88 0.90 0.93 +treedepth__ 1.4 0.0080 0.48 0.00 1.0 1.0 2.0 +n_leapfrog__ 2.5 0.023 1.3 0.00 1.0 3.0 3.0 +divergent__ 0.00 nan 0.00 0.00 0.00 0.00 0.00 +energy__ 7.8 0.027 1.0 0.74 6.8 7.5 9.7 + +theta 0.25 0.0033 0.12 0.12 0.077 0.24 0.47 1408 1292 1.0 + +Samples were drawn using hmc with nuts. +For each parameter, ESS_bulk and ESS_tail measure the effective sample size +for the entire sample and for the the .05 and .95 tails, respectively, +and R_hat measures the potential scale reduction on split chains. +At convergence R_hat will be very close to 1.00. diff --git a/src/test/interface/example_output/stansummary_default.csv b/src/test/interface/example_output/stansummary_default.csv new file mode 100644 index 0000000000..eed10f83bb --- /dev/null +++ b/src/test/interface/example_output/stansummary_default.csv @@ -0,0 +1,19 @@ +name,Mean,MCSE,StdDev,MAD,5%,50%,95%,ESS_bulk,ESS_tail,R_hat +"lp__",-7.28676,0.0202121,0.738616,0.329575,-8.7823,-6.99022,-6.7503,1512.77,1591.97,1.00073 +"accept_stat__",0.925878,0.0017776,0.116281,0.0378478,0.674387,0.974472,1,5207.13,3498.57,1.00097 +"stepsize__",0.904266,nan,0.019724,0.0209365,0.883328,0.900309,0.933117,nan,nan,nan +"treedepth__",1.3515,0.00798399,0.479067,0,1,1,2,3601.3,3690.75,1.00019 +"n_leapfrog__",2.515,0.0230858,1.31423,0,1,3,3,3070.14,2630.54,1.00411 +"divergent__",0,nan,0,0,0,0,0,nan,nan,nan +"energy__",7.7689,0.0271304,1.0079,0.744065,6.80125,7.45947,9.72882,1439.36,1817.6,1.00135 +"theta",0.251297,0.00327489,0.121547,0.123091,0.0771694,0.237476,0.473885,1407.51,1291.71,1.00679 +# Inference for Stan model: bernoulli_model +# 4 chains: each with iter=1000; warmup=1000; thin=1; 1000 iterations saved. +# +# Warmup took (0.0030, 0.0030, 0.0040, 0.0030) seconds, 0.013 seconds total +# Sampling took (0.0090, 0.010, 0.010, 0.0090) seconds, 0.038 seconds total +# Samples were drawn using hmc with nuts. +# For each parameter, ESS_bulk and ESS_tail measure the effective sample size +for the entire sample and for the the .05 and .95 tails, respectively, +# and R_hat measures the potential scale reduction on split chains. +At convergence R_hat will be very close to 1.00. diff --git a/src/test/interface/fixed_param_sampler_test.cpp b/src/test/interface/fixed_param_sampler_test.cpp index 27d8cd9b15..763b0f7f3d 100644 --- a/src/test/interface/fixed_param_sampler_test.cpp +++ b/src/test/interface/fixed_param_sampler_test.cpp @@ -1,6 +1,6 @@ #include #include -#include +#include #include #include #include @@ -32,16 +32,16 @@ TEST(McmcPersistentSampler, check_persistency) { } catch (...) { ADD_FAILURE() << "Failed running command: " << command; } - std::ifstream output_stream; output_stream.open((convert_model_path(model_path) + ".csv").data()); stan::io::stan_csv parsed_output = stan::io::stan_csv_reader::parse(output_stream, 0); - stan::mcmc::chains<> chains(parsed_output); + stan::mcmc::chainset chains(parsed_output); for (int i = 0; i < chains.num_params(); ++i) { - test_constant(chains.samples(0, i)); + auto draws = chains.samples(i); + test_constant(draws.col(0)); } } diff --git a/src/test/interface/multi_chain_test.cpp b/src/test/interface/multi_chain_test.cpp index 8564cf4e8e..fe673ec049 100644 --- a/src/test/interface/multi_chain_test.cpp +++ b/src/test/interface/multi_chain_test.cpp @@ -1,7 +1,7 @@ #include #include #include -#include +#include #include #include @@ -24,14 +24,12 @@ TEST(interface, output_multi) { { std::string csv_file = cmdstan::test::convert_model_path(model_path) + "_10.csv"; - std::vector filenames; - filenames.push_back(csv_file); - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); + std::ifstream infile; + std::stringstream warnings; + stan::io::stan_csv sample; + infile.open(csv_file.c_str()); + sample = stan::io::stan_csv_reader::parse(infile, &warnings); + stan::mcmc::chainset chains(sample); constexpr std::array names{ "lp__", "accept_stat__", "stepsize__", "treedepth__", "n_leapfrog__", "divergent__", @@ -49,14 +47,12 @@ TEST(interface, output_multi) { { std::string csv_file = cmdstan::test::convert_model_path(model_path) + "_11.csv"; - std::vector filenames; - filenames.push_back(csv_file); - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); + std::ifstream infile; + std::stringstream warnings; + stan::io::stan_csv sample; + infile.open(csv_file.c_str()); + sample = stan::io::stan_csv_reader::parse(infile, &warnings); + stan::mcmc::chainset chains(sample); constexpr std::array names{ "lp__", "accept_stat__", "stepsize__", "treedepth__", "n_leapfrog__", "divergent__", diff --git a/src/test/interface/optimization_output_test.cpp b/src/test/interface/optimization_output_test.cpp index 3881846742..8271bc587d 100644 --- a/src/test/interface/optimization_output_test.cpp +++ b/src/test/interface/optimization_output_test.cpp @@ -1,5 +1,4 @@ #include -#include #include #include #include diff --git a/src/test/interface/output_sig_figs_test.cpp b/src/test/interface/output_sig_figs_test.cpp index ea1f91b0f7..a5b02732e4 100644 --- a/src/test/interface/output_sig_figs_test.cpp +++ b/src/test/interface/output_sig_figs_test.cpp @@ -1,7 +1,7 @@ #include #include #include -#include +#include #include #include @@ -22,14 +22,12 @@ TEST(interface, output_sig_figs_1) { EXPECT_FALSE(out.hasError); std::string csv_file = cmdstan::test::convert_model_path(model_path) + ".csv"; - std::vector filenames; - filenames.push_back(csv_file); - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); + std::ifstream infile; + std::stringstream warnings; + stan::io::stan_csv sample; + infile.open(csv_file.c_str()); + sample = stan::io::stan_csv_reader::parse(infile, &warnings); + stan::mcmc::chainset chains(sample); EXPECT_NEAR(chains.samples(8)(0, 0), 0.1, 1E-16); } @@ -50,14 +48,12 @@ TEST(interface, output_sig_figs_2) { EXPECT_FALSE(out.hasError); std::string csv_file = cmdstan::test::convert_model_path(model_path) + ".csv"; - std::vector filenames; - filenames.push_back(csv_file); - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); + std::ifstream infile; + std::stringstream warnings; + stan::io::stan_csv sample; + infile.open(csv_file.c_str()); + sample = stan::io::stan_csv_reader::parse(infile, &warnings); + stan::mcmc::chainset chains(sample); EXPECT_NEAR(chains.samples(8)(0, 0), 0.12, 1E-16); } @@ -78,13 +74,11 @@ TEST(interface, output_sig_figs_9) { EXPECT_FALSE(out.hasError); std::string csv_file = cmdstan::test::convert_model_path(model_path) + ".csv"; - std::vector filenames; - filenames.push_back(csv_file); - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); + std::ifstream infile; + std::stringstream warnings; + stan::io::stan_csv sample; + infile.open(csv_file.c_str()); + sample = stan::io::stan_csv_reader::parse(infile, &warnings); + stan::mcmc::chainset chains(sample); EXPECT_NEAR(chains.samples(8)(0, 0), 0.123456789, 1E-16); } diff --git a/src/test/interface/print_test.cpp b/src/test/interface/print_test.cpp deleted file mode 100644 index 7ab0210a09..0000000000 --- a/src/test/interface/print_test.cpp +++ /dev/null @@ -1,153 +0,0 @@ -#include -#include -#include - -using cmdstan::test::count_matches; -using cmdstan::test::get_path_separator; -using cmdstan::test::run_command; -using cmdstan::test::run_command_output; - -TEST(CommandPrint, next_index_1d) { - std::vector dims(1); - std::vector index(1, 1); - dims[0] = 100; - - ASSERT_EQ(1U, index.size()); - EXPECT_EQ(1, index[0]); - for (int n = 1; n <= 100; n++) { - if (n == 1) - continue; - next_index(index, dims); - ASSERT_EQ(1U, index.size()); - EXPECT_EQ(n, index[0]); - } - - index[0] = 100; - EXPECT_THROW(next_index(index, dims), std::domain_error); - - index[0] = 1000; - EXPECT_THROW(next_index(index, dims), std::domain_error); -} - -TEST(CommandPrint, next_index_2d) { - std::vector dims(2); - std::vector index(2, 1); - dims[0] = 100; - dims[1] = 3; - - ASSERT_EQ(2U, index.size()); - EXPECT_EQ(1, index[0]); - EXPECT_EQ(1, index[1]); - for (int i = 1; i <= 100; i++) - for (int j = 1; j <= 3; j++) { - if (i == 1 && j == 1) - continue; - next_index(index, dims); - ASSERT_EQ(2U, index.size()); - EXPECT_EQ(i, index[0]); - EXPECT_EQ(j, index[1]); - } - - index[0] = 100; - index[1] = 3; - EXPECT_THROW(next_index(index, dims), std::domain_error); - - index[0] = 1000; - index[1] = 1; - EXPECT_THROW(next_index(index, dims), std::domain_error); - - index[0] = 10; - index[1] = 4; - EXPECT_NO_THROW(next_index(index, dims)) - << "this will correct the index and set the next element to (11,1)"; - EXPECT_EQ(11, index[0]); - EXPECT_EQ(1, index[1]); -} - -TEST(CommandPrint, matrix_index_1d) { - std::vector dims(1); - std::vector index(1, 1); - dims[0] = 100; - - EXPECT_EQ(0, matrix_index(index, dims)); - - index[0] = 50; - EXPECT_EQ(49, matrix_index(index, dims)); - - index[0] = 100; - EXPECT_EQ(99, matrix_index(index, dims)); - - index[0] = 0; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 101; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); -} - -TEST(CommandPrint, matrix_index_2d) { - std::vector dims(2); - std::vector index(2, 1); - dims[0] = 100; - dims[1] = 3; - - EXPECT_EQ(0, matrix_index(index, dims)); - - index[0] = 50; - index[1] = 1; - EXPECT_EQ(49, matrix_index(index, dims)); - - index[0] = 100; - index[1] = 1; - EXPECT_EQ(99, matrix_index(index, dims)); - - index[0] = 1; - index[1] = 2; - EXPECT_EQ(100, matrix_index(index, dims)); - - index[0] = 1; - index[1] = 3; - EXPECT_EQ(200, matrix_index(index, dims)); - - index[0] = 100; - index[1] = 3; - EXPECT_EQ(299, matrix_index(index, dims)); - - index[0] = 1; - index[1] = 0; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 0; - index[1] = 1; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 101; - index[1] = 1; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 1; - index[1] = 4; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); -} - -TEST(CommandPrint, functional_test__issue_342) { - std::string path_separator; - path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "print"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "matrix_output.csv"; - - run_command_output out = run_command(command + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; - EXPECT_EQ(1, count_matches("deprecated", out.output)) - << "expecting to find deprecated message"; -} - -TEST(CommandPrint, help_deprecated_message) { - std::string path_separator; - path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "print"; - - run_command_output out = run_command(command + " --help"); - EXPECT_EQ(1, count_matches("deprecated", out.output)) - << "expecting to find deprecated message"; -} diff --git a/src/test/interface/print_uninitialized_test.cpp b/src/test/interface/print_uninitialized_test.cpp deleted file mode 100644 index 78cb20dd41..0000000000 --- a/src/test/interface/print_uninitialized_test.cpp +++ /dev/null @@ -1,24 +0,0 @@ -#include -#include -#include - -using cmdstan::test::convert_model_path; -using cmdstan::test::run_command; -using cmdstan::test::run_command_output; - -TEST(interface, print_uninitialized) { - // This was stan-dev/stan issue #91 - std::vector model_path; - model_path.push_back("src"); - model_path.push_back("test"); - model_path.push_back("test-models"); - model_path.push_back("print_uninitialized"); - - std::string command - = convert_model_path(model_path) + " sample num_warmup=1 num_samples=0" - + " output file=" + convert_model_path(model_path) + ".csv"; - - run_command_output out = run_command(command); - EXPECT_EQ(int(stan::services::error_codes::OK), out.err_code); - EXPECT_FALSE(out.hasError); -} diff --git a/src/test/interface/stansummary_test.cpp b/src/test/interface/stansummary_test.cpp index 034cff84ba..3676cd6533 100644 --- a/src/test/interface/stansummary_test.cpp +++ b/src/test/interface/stansummary_test.cpp @@ -6,6 +6,7 @@ #include #include #include +#include using cmdstan::test::count_matches; using cmdstan::test::get_path_separator; @@ -69,77 +70,31 @@ TEST(CommandStansummary, next_index_2d) { EXPECT_EQ(1, index[1]); } -TEST(CommandStansummary, matrix_index_1d) { - std::vector dims(1); - std::vector index(1, 1); - dims[0] = 100; - - EXPECT_EQ(0, matrix_index(index, dims)); - - index[0] = 50; - EXPECT_EQ(49, matrix_index(index, dims)); - - index[0] = 100; - EXPECT_EQ(99, matrix_index(index, dims)); - - index[0] = 0; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 101; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); -} - -TEST(CommandStansummary, matrix_index_2d) { - std::vector dims(2); - std::vector index(2, 1); - dims[0] = 100; - dims[1] = 3; - - EXPECT_EQ(0, matrix_index(index, dims)); - - index[0] = 50; - index[1] = 1; - EXPECT_EQ(49, matrix_index(index, dims)); - - index[0] = 100; - index[1] = 1; - EXPECT_EQ(99, matrix_index(index, dims)); - - index[0] = 1; - index[1] = 2; - EXPECT_EQ(100, matrix_index(index, dims)); - - index[0] = 1; - index[1] = 3; - EXPECT_EQ(200, matrix_index(index, dims)); - - index[0] = 100; - index[1] = 3; - EXPECT_EQ(299, matrix_index(index, dims)); - - index[0] = 1; - index[1] = 0; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 0; - index[1] = 1; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 101; - index[1] = 1; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); - - index[0] = 1; - index[1] = 4; - EXPECT_THROW(matrix_index(index, dims), std::domain_error); +TEST(CommandStansummary, order_param_names_row_major) { + std::vector names_col_major + = {"lp__", "foo", "bar", "theta[1]", "theta[2]", + "theta[3]", "gamma[1,1]", "gamma[2,1]", "gamma[3,1]", "gamma[1,2]", + "gamma[2,2]", "gamma[3,2]", "rho[1,1,1]", "rho[2,1,1]", "rho[3,1,1]", + "rho[1,2,1]", "rho[2,2,1]", "rho[3,2,1]", "rho[1,1,2]", "rho[2,1,2]", + "rho[3,1,2]", "rho[1,2,2]", "rho[2,2,2]", "rho[3,2,2]", "zeta"}; + std::vector expect_row_major + = {"lp__", "foo", "bar", "theta[1]", "theta[2]", + "theta[3]", "gamma[1,1]", "gamma[1,2]", "gamma[2,1]", "gamma[2,2]", + "gamma[3,1]", "gamma[3,2]", "rho[1,1,1]", "rho[1,1,2]", "rho[1,2,1]", + "rho[1,2,2]", "rho[2,1,1]", "rho[2,1,2]", "rho[2,2,1]", "rho[2,2,2]", + "rho[3,1,1]", "rho[3,1,2]", "rho[3,2,1]", "rho[3,2,2]", "zeta"}; + auto names_row_major = order_param_names_row_major(names_col_major); + for (size_t i = 0; i < names_col_major.size(); ++i) { + EXPECT_EQ(expect_row_major[i], names_row_major[i]); + } } TEST(CommandStansummary, header_tests) { - std::string expect - = " Mean MCSE StdDev 10% 50% 90% N_Eff " - "N_Eff/s R_hat\n"; + std::string expect_console + = " Mean MCSE StdDev MAD 10% 50% 90%" + " ESS_bulk ESS_tail R_hat\n"; std::string expect_csv - = "name,Mean,MCSE,StdDev,10%,50%,90%,N_Eff,N_Eff/s,R_hat\n"; + = "name,Mean,MCSE,StdDev,MAD,10%,50%,90%,ESS_bulk,ESS_tail,R_hat\n"; std::vector pcts; pcts.push_back("10"); pcts.push_back("50"); @@ -150,12 +105,15 @@ TEST(CommandStansummary, header_tests) { EXPECT_FLOAT_EQ(probs[2], 0.9); std::vector header = get_header(pcts); - EXPECT_EQ(header.size(), pcts.size() + 6); + EXPECT_EQ(header.size(), pcts.size() + 7); EXPECT_EQ(header[0], "Mean"); + EXPECT_EQ(header[1], "MCSE"); EXPECT_EQ(header[2], "StdDev"); - EXPECT_EQ(header[4], "50%"); - EXPECT_EQ(header[6], "N_Eff"); - EXPECT_EQ(header[8], "R_hat"); + EXPECT_EQ(header[3], "MAD"); + EXPECT_EQ(header[5], "50%"); + EXPECT_EQ(header[7], "ESS_bulk"); + EXPECT_EQ(header[8], "ESS_tail"); + EXPECT_EQ(header[9], "R_hat"); Eigen::VectorXi column_widths(header.size()); for (size_t i = 0, w = 5; i < header.size(); ++i, ++w) { @@ -163,7 +121,7 @@ TEST(CommandStansummary, header_tests) { } std::stringstream ss; write_header(header, column_widths, 4, false, &ss); - EXPECT_EQ(expect, ss.str()); + EXPECT_EQ(expect_console, ss.str()); ss.str(std::string()); write_header(header, column_widths, 24, true, &ss); EXPECT_EQ(expect_csv, ss.str()); @@ -198,59 +156,6 @@ TEST(CommandStansummary, percentiles) { EXPECT_THROW(percentiles_to_probs(pcts), std::invalid_argument); } -TEST(CommandStansummary, param_tests) { - std::string path_separator; - path_separator.push_back(get_path_separator()); - - std::vector pcts; - pcts.push_back("10"); - pcts.push_back("50"); - pcts.push_back("90"); - Eigen::VectorXd probs = percentiles_to_probs(pcts); - - // bernoulli model: 6 sampler params, ("lp__", is model param) - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; - std::vector filenames; - filenames.push_back(csv_file); - stan::io::stan_csv_metadata metadata; - Eigen::VectorXd warmup_times(filenames.size()); - Eigen::VectorXd sampling_times(filenames.size()); - Eigen::VectorXi thin(filenames.size()); - stan::mcmc::chains<> chains = parse_csv_files( - filenames, metadata, warmup_times, sampling_times, thin, &std::cout); - EXPECT_EQ(chains.num_chains(), 1); - EXPECT_EQ(chains.num_params(), 8); - - size_t max_name_length = 0; - size_t num_sampler_params = -1; // don't count name 'lp__' - for (int i = 0; i < chains.num_params(); ++i) { - if (chains.param_name(i).length() > max_name_length) - max_name_length = chains.param_name(i).length(); - if (stan::io::ends_with("__", chains.param_name(i))) - num_sampler_params++; - } - EXPECT_EQ(num_sampler_params, 6); - - size_t model_params_offset = num_sampler_params + 1; - size_t num_model_params = chains.num_params() - model_params_offset; - EXPECT_EQ(num_model_params, 1); - - Eigen::MatrixXd model_params(num_model_params, 9); - std::vector model_param_idxes(num_model_params); - std::iota(model_param_idxes.begin(), model_param_idxes.end(), - model_params_offset); - get_stats(chains, sampling_times, probs, model_param_idxes, model_params); - - double mean_theta = model_params(0, 0); - EXPECT_TRUE(mean_theta > 0.25); - EXPECT_TRUE(mean_theta < 0.27); - double rhat_theta = model_params(0, 8); - EXPECT_TRUE(rhat_theta > 0.999); - EXPECT_TRUE(rhat_theta < 1.01); -} - // good csv file, no draws TEST(CommandStansummary, functional_test__issue_342) { std::string path_separator; @@ -259,7 +164,7 @@ TEST(CommandStansummary, functional_test__issue_342) { std::string csv_file = "src" + path_separator + "test" + path_separator + "interface" + path_separator + "matrix_output.csv"; run_command_output out = run_command(command + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; + ASSERT_FALSE(out.hasError); } // good csv file, variational inference @@ -271,7 +176,7 @@ TEST(CommandStansummary, variational_inference) { + "interface" + path_separator + "variational_inference_output.csv"; run_command_output out = run_command(command + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; + ASSERT_FALSE(out.hasError); } TEST(CommandStansummary, no_args) { @@ -281,8 +186,7 @@ TEST(CommandStansummary, no_args) { std::string command = "bin" + path_separator + "stansummary"; run_command_output out = run_command(command); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); } TEST(CommandStansummary, bad_input_files) { @@ -294,8 +198,7 @@ TEST(CommandStansummary, bad_input_files) { + "interface" + path_separator + "no_such_file"; run_command_output out = run_command(command + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); } TEST(CommandStansummary, bad_csv_file_arg) { @@ -305,15 +208,14 @@ TEST(CommandStansummary, bad_csv_file_arg) { std::string command = "bin" + path_separator + "stansummary"; std::string csv_file = "src" + path_separator + "test" + path_separator + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; + + path_separator + "bern1.csv"; std::string arg_csv_file = "--csv_filename " + path_separator + "bin" + path_separator + "hi_mom.csv"; run_command_output out = run_command(command + " " + arg_csv_file + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); } TEST(CommandStansummary, bad_sig_figs_arg) { @@ -329,15 +231,13 @@ TEST(CommandStansummary, bad_sig_figs_arg) { run_command_output out = run_command(command + " " + arg_sig_figs + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); arg_sig_figs = "--sig_figs 101"; expected_message = "--sig_figs: Value 101 not in range"; out = run_command(command + " " + arg_sig_figs + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); } TEST(CommandStansummary, bad_autocorr_arg) { @@ -347,27 +247,24 @@ TEST(CommandStansummary, bad_autocorr_arg) { std::string command = "bin" + path_separator + "stansummary"; std::string csv_file = "src" + path_separator + "test" + path_separator + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; + + path_separator + "bern1.csv"; std::string arg_autocorr = "--autocorr -1"; run_command_output out = run_command(command + " " + arg_autocorr + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); arg_autocorr = "--autocorr 0"; out = run_command(command + " " + arg_autocorr + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); expected_message = "not a valid chain id"; arg_autocorr = "--autocorr 2"; out = run_command(command + " " + arg_autocorr + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); } TEST(CommandStansummary, bad_percentiles_arg) { @@ -377,30 +274,27 @@ TEST(CommandStansummary, bad_percentiles_arg) { std::string command = "bin" + path_separator + "stansummary"; std::string csv_file = "src" + path_separator + "test" + path_separator + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; + + path_separator + "bern1.csv"; std::string arg_percentiles = "--percentiles -1"; run_command_output out = run_command(command + " " + arg_percentiles + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); - arg_percentiles = "--percentiles \"0,100\""; + arg_percentiles = "--percentiles \"0,100.001\""; out = run_command(command + " " + arg_percentiles + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); arg_percentiles = "--percentiles \"2,30,5\""; out = run_command(command + " " + arg_percentiles + " " + csv_file); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); arg_percentiles = "--percentiles \"2,50,95\""; out = run_command(command + " " + arg_percentiles + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; + ASSERT_FALSE(out.hasError); } TEST(CommandStansummary, bad_include_param_args) { @@ -408,43 +302,43 @@ TEST(CommandStansummary, bad_include_param_args) { = "--include_param: Unrecognized parameter(s): 'psi' "; std::string path_separator; path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "stansummary"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; - std::string arg_include_param = "-i psi"; - - run_command_output out - = run_command(command + " " + arg_include_param + " " + csv_file); + std::string csv_dir = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "example_output" + + path_separator; + + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << " -i psi --"; + for (int i = 1; i < 5; ++i) { + ss_command << " " << csv_dir << "bern" << i << ".csv"; + } + run_command_output out = run_command(ss_command.str()); EXPECT_TRUE(boost::algorithm::contains(out.output, expected_message)); - ASSERT_TRUE(out.hasError) - << "\"" << out.command << "\" failed to quit with an error"; + ASSERT_TRUE(out.hasError); } TEST(CommandStansummary, check_console_output) { - std::string lp - = "lp__ -7.3 3.7e-02 0.77 -9.1 -7.0 -6.8 443 " - "19275 1.0"; - std::string theta - = "theta 0.26 6.1e-03 0.12 0.079 0.25 0.47 384 " - "16683 1.00"; - std::string accept_stat - = "accept_stat__ 0.90 4.6e-03 1.5e-01 0.57 0.96 1.0 1026 " - "44597 1.00"; - std::string energy - = "energy__ 7.8 5.1e-02 1.0e+00 6.8 7.5 9.9 411 " - "17865 1.0"; + std::vector header + = {"Mean", "MCSE", "StdDev", "MAD", "5%", + "50%", "95%", "ESS_bulk", "ESS_tail", "R_hat"}; + std::vector divergent + = {"divergent__", "0.00", "nan", "0.00", "0.00", "0.00", "0.00", "0.00"}; + std::vector theta + = {"theta", "0.25", "0.0033", "0.12", "0.12", "0.077", + "0.24", "0.47", "1408", "1292", "1.0"}; std::string path_separator; path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "stansummary"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; - - run_command_output out = run_command(command + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; - + std::string csv_dir = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "example_output" + + path_separator; + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary "; + for (int i = 1; i < 5; ++i) { + ss_command << " " << csv_dir << "bern" << i << ".csv"; + } + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); std::istringstream target_stream(out.output); std::string line; @@ -456,60 +350,71 @@ TEST(CommandStansummary, check_console_output) { std::getline(target_stream, line); // sample time std::getline(target_stream, line); // blank std::getline(target_stream, line); // header + boost::char_separator sep(" \t\n"); + boost::tokenizer> header_tok(line, sep); + int i = 0; + for (const auto& token : header_tok) { + EXPECT_EQ(token, header[i]); + i++; + } std::getline(target_stream, line); // blank - std::getline(target_stream, line); // lp - EXPECT_EQ(lp, line); std::getline(target_stream, line); // accept stat - EXPECT_EQ(accept_stat, line); std::getline(target_stream, line); // stepsize std::getline(target_stream, line); // treedepth std::getline(target_stream, line); // n_leapfrog std::getline(target_stream, line); // divergent - + boost::tokenizer> divergent_tok(line, sep); + i = 0; + for (const auto& token : divergent_tok) { + EXPECT_EQ(token, divergent[i]); + i++; + } std::getline(target_stream, line); // energy - EXPECT_EQ(energy, line); - std::getline(target_stream, line); // blank - std::getline(target_stream, line); // theta - EXPECT_EQ(theta, line); + boost::tokenizer> theta_tok(line, sep); + i = 0; + for (const auto& token : theta_tok) { + EXPECT_EQ(token, theta[i]); + i++; + } } TEST(CommandStansummary, check_csv_output) { std::string csv_header - = "name,Mean,MCSE,StdDev,5%,50%,95%,N_Eff,N_Eff/s,R_hat"; + = "name,Mean,MCSE,StdDev,MAD,5%,50%,95%,ESS_bulk,ESS_tail,R_hat"; std::string lp - = "\"lp__\",-7.2719,0.0365168,0.768874,-9.05757,-6.96978,-6.75008,443." - "328,19275.1,1.00037"; - std::string energy - = "\"energy__\"" - ",7.78428,0.0508815,1.0314,6.80383,7.46839,9.88601,410." - "898,17865.1,1.00075"; + = "\"lp__\",-7.28676,0.0202121,0.738616,0.329575,-8.7823,-6.99022,-6." + "7503,1512.77,1591.97,1.00073"; std::string theta - = "\"theta\",0.256552,0.00610844,0.119654,0.0786292,0.24996,0.470263,383." - "704,16682.8,0.999309"; + = "\"theta\",0.251297,0.00327489,0.121547,0.123091,0.0771694,0.237476,0." + "473885,1407.51,1291.71,1.00679"; std::string path_separator; path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "stansummary"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; - - std::string target_csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator - + "example_output" + path_separator - + "tmp_test_target_csv_file.csv"; - std::string arg_csv_file = "--csv_filename=" + target_csv_file; - - run_command_output out - = run_command(command + " " + arg_csv_file + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; + std::string csv_dir = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "example_output" + + path_separator; + std::string target_csv_file = "test" + path_separator + "interface" + + path_separator + + "tmp_test_target_csv_file_a.csv"; + + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << "--csv_filename=" << target_csv_file; + for (int i = 1; i < 5; ++i) { + ss_command << " " << csv_dir << "bern" << i << ".csv"; + } + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); std::ifstream target_stream(target_csv_file.c_str()); - if (!target_stream.is_open()) + if (!target_stream.is_open()) { + std::cerr << "Failed to open file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } std::string line; std::getline(target_stream, line); EXPECT_EQ(csv_header, line); @@ -521,42 +426,46 @@ TEST(CommandStansummary, check_csv_output) { std::getline(target_stream, line); // n_leapfrog std::getline(target_stream, line); // divergent std::getline(target_stream, line); // energy - EXPECT_EQ(energy, line); std::getline(target_stream, line); EXPECT_EQ(theta, line); target_stream.close(); int return_code = std::remove(target_csv_file.c_str()); - if (return_code != 0) + if (return_code != 0) { + std::cerr << "Failed to remove file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } } TEST(CommandStansummary, check_csv_output_no_percentiles) { - std::string csv_header = "name,Mean,MCSE,StdDev,N_Eff,N_Eff/s,R_hat"; + std::string csv_header = "name,Mean,MCSE,StdDev,MAD,ESS_bulk,ESS_tail,R_hat"; std::string lp - = "\"lp__\",-7.2719,0.0365168,0.768874,443.328,19275.1,1.00037"; + = "\"lp__\",-7.28676,0.0202121,0.738616,0.329575,1512.77,1591.97,1.00073"; std::string path_separator; path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "stansummary"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; - - std::string target_csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator - + "example_output" + path_separator - + "tmp_test_target_csv_file.csv"; - std::string arg_csv_file = "--csv_filename=" + target_csv_file; - - std::string arg_percentiles = "-p \"\""; - - run_command_output out = run_command(command + " " + arg_csv_file + " " - + csv_file + " " + arg_percentiles); + std::string csv_dir = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "example_output" + + path_separator; + std::string target_csv_file = "test" + path_separator + "interface" + + path_separator + + "tmp_test_target_csv_file_b.csv"; + std::string arg_percentiles = " -p \"\""; + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << "--csv_filename=" << target_csv_file << arg_percentiles; + for (int i = 1; i < 5; ++i) { + ss_command << " " << csv_dir << "bern" << i << ".csv"; + } + run_command_output out = run_command(ss_command.str()); ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; std::ifstream target_stream(target_csv_file.c_str()); - if (!target_stream.is_open()) + if (!target_stream.is_open()) { + std::cerr << "Failed to open file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } std::string line; std::getline(target_stream, line); EXPECT_EQ(csv_header, line); @@ -564,39 +473,47 @@ TEST(CommandStansummary, check_csv_output_no_percentiles) { EXPECT_EQ(lp, line); target_stream.close(); int return_code = std::remove(target_csv_file.c_str()); - if (return_code != 0) + if (return_code != 0) { + std::cerr << "Failed to remove file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } } TEST(CommandStansummary, check_csv_output_sig_figs) { std::string csv_header - = "name,Mean,MCSE,StdDev,5%,50%,95%,N_Eff,N_Eff/s,R_hat"; - std::string lp = "\"lp__\",-7.3,0.037,0.77,-9.1,-7,-6.8,4.4e+02,1.9e+04,1"; - std::string energy = "\"energy__\",7.8,0.051,1,6.8,7.5,9.9,4.1e+02,1.8e+04,1"; + = "name,Mean,MCSE,StdDev,MAD,5%,50%,95%,ESS_bulk,ESS_tail,R_hat"; + std::string lp + = "\"lp__\",-7.3,0.02,0.74,0.33,-8.8,-7,-6.8,1.5e+03,1.6e+03,1"; + std::string energy + = "\"energy__\",7.8,0.027,1,0.74,6.8,7.5,9.7,1.4e+03,1.8e+03,1"; std::string theta - = "\"theta\",0.26,0.0061,0.12,0.079,0.25,0.47,3.8e+02,1.7e+04,1"; + = "\"theta\",0.25,0.0033,0.12,0.12,0.077,0.24,0.47,1.4e+03,1.3e+03,1"; std::string path_separator; path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "stansummary"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "bernoulli_chain_1.csv"; - - std::string target_csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator - + "example_output" + path_separator - + "tmp_test_target_csv_file.csv"; - std::string arg_csv_file = "--csv_filename " + target_csv_file; - std::string arg_sig_figs = "--sig_figs 2"; - - run_command_output out = run_command(command + " " + arg_csv_file + " " - + arg_sig_figs + " " + csv_file); - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; + std::string csv_dir = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "example_output" + + path_separator; + std::string target_csv_file = "test" + path_separator + "interface" + + path_separator + + "tmp_test_target_csv_file_c.csv"; + + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << "--csv_filename=" << target_csv_file << " --sig_figs 2"; + for (int i = 1; i < 5; ++i) { + ss_command << " " << csv_dir << "bern" << i << ".csv"; + } + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); std::ifstream target_stream(target_csv_file.c_str()); - if (!target_stream.is_open()) + if (!target_stream.is_open()) { + std::cerr << "Failed to open file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } std::string line; std::getline(target_stream, line); EXPECT_EQ(csv_header, line); @@ -613,66 +530,52 @@ TEST(CommandStansummary, check_csv_output_sig_figs) { EXPECT_EQ(theta, line); target_stream.close(); int return_code = std::remove(target_csv_file.c_str()); - if (return_code != 0) + if (return_code != 0) { + std::cerr << "Failed to remove file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } } TEST(CommandStansummary, check_csv_output_include_param) { std::string csv_header - = "name,Mean,MCSE,StdDev,5%,50%,95%,N_Eff,N_Eff/s,R_hat"; - std::string lp - = "\"lp__\",-15.5617,0.97319,6.05585,-25.3432,-15.7562,-5.48405,38.7217," - "372.539,1.00208"; - std::string energy - = "\"energy__\",20.5888,1.01449,6.43127,10.2634,20.8487,30.9906,40.1879," - "386.645,1.00109"; + = "name,Mean,MCSE,StdDev,MAD,5%,50%,95%,ESS_bulk,ESS_tail,R_hat"; // note: skipping theta 1-5 std::string theta6 - = "\"theta[6]\",5.001,0.365016,5.76072,-4.99688,5.23474,14.1597,249.074," - "2396.33,1.00109"; + = "\"theta[6]\",5.001,0.365016,5.76072,5.37947,-4.95375,5.22746,14.1688," + "230.645,464.978,1.00054"; std::string theta7 - = "\"theta[7]\",8.54125,0.650098,6.22195,-0.841225,8.09613,19.256,91." - "6001,881.279,0.999012"; - // note: skipping theta 8 + = "\"theta[7]\",8.54125,0.650098,6.22195,5.35785,-0.814388,8.09342,19." + "2622,92.3075,241.177,1.00244"; std::string message = "# Inference for Stan model: eight_schools_cp_model"; std::string path_separator; path_separator.push_back(get_path_separator()); - std::string command = "bin" + path_separator + "stansummary"; - std::string csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator + "example_output" - + path_separator + "eight_schools_output.csv"; - - std::string target_csv_file = "src" + path_separator + "test" + path_separator - + "interface" + path_separator - + "example_output" + path_separator - + "tmp_test_target_csv_file.csv"; - std::string arg_csv_file = "--csv_filename=" + target_csv_file; - - // both styles of name supported - std::string arg_include_param = "--include_param theta.6 -i theta[7]"; - - run_command_output out = run_command(command + " " + arg_csv_file + " " - + arg_include_param + " " + csv_file); - - ASSERT_FALSE(out.hasError) << "\"" << out.command << "\" quit with an error"; + std::string csv_dir = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "example_output" + + path_separator; + std::string target_csv_file = "test" + path_separator + "interface" + + path_separator + + "tmp_test_target_csv_file_d.csv"; + + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << "--csv_filename=" << target_csv_file + << " --include_param theta.6 -i theta[7] " << csv_dir + << "eight_schools_output.csv"; + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); std::ifstream target_stream(target_csv_file.c_str()); - if (!target_stream.is_open()) + if (!target_stream.is_open()) { + std::cerr << "Failed to open file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } std::string line; std::getline(target_stream, line); EXPECT_EQ(csv_header, line); std::getline(target_stream, line); - EXPECT_EQ(lp, line); - std::getline(target_stream, line); // accept_stat - std::getline(target_stream, line); // stepsize - std::getline(target_stream, line); // treedepth - std::getline(target_stream, line); // n_leapfrog - std::getline(target_stream, line); // divergent - std::getline(target_stream, line); // energy - EXPECT_EQ(energy, line); - std::getline(target_stream, line); EXPECT_EQ(theta6, line); std::getline(target_stream, line); EXPECT_EQ(theta7, line); @@ -680,6 +583,99 @@ TEST(CommandStansummary, check_csv_output_include_param) { EXPECT_EQ(message, line); target_stream.close(); int return_code = std::remove(target_csv_file.c_str()); - if (return_code != 0) + if (return_code != 0) { + std::cerr << "Failed to remove file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; + FAIL(); + } +} + +TEST(CommandStansummary, check_include_param_order) { + std::vector expect_names + = {"y[1,1]", "y[2,2]", "y[2,1]", "y[1,3]"}; + std::string path_separator; + path_separator.push_back(get_path_separator()); + std::string csv_file = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "matrix_output.csv"; + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << " -i y.1.1 -i y.2.2 -i y.2.1 -i y.1.3 " << csv_file; + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); + std::istringstream target_stream(out.output); + std::string line; + + std::getline(target_stream, line); // model name + std::getline(target_stream, line); // chain info + std::getline(target_stream, line); // blank + std::getline(target_stream, line); // warmup time + std::getline(target_stream, line); // sample time + std::getline(target_stream, line); // blank + std::getline(target_stream, line); // header + std::getline(target_stream, line); // blank + boost::char_separator sep(" \t\n"); + for (size_t i = 0; i < expect_names.size(); ++i) { + std::getline(target_stream, line); + boost::tokenizer> line_tok(line, sep); + for (const auto& token : line_tok) { + EXPECT_EQ(token, expect_names[i]); + break; + } + } +} + +TEST(CommandStansummary, check_reorder_stats) { + std::string path_separator; + path_separator.push_back(get_path_separator()); + std::string csv_file = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "matrix_output.csv"; + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " << csv_file; + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); + + std::ifstream expected_output( + "src/test/interface/example_output/matrix_summary.nom"); + std::stringstream ss; + ss << expected_output.rdbuf(); + EXPECT_EQ(1, count_matches(ss.str(), out.output)); +} + +TEST(CommandStansummary, check_reorder_stats_csv) { + std::string path_separator; + path_separator.push_back(get_path_separator()); + std::string target_csv_file = "test" + path_separator + "interface" + + path_separator + + "tmp_test_target_csv_file_e.csv"; + std::string csv_file = "src" + path_separator + "test" + path_separator + + "interface" + path_separator + "matrix_output.csv"; + std::stringstream ss_command; + ss_command << "bin" << path_separator << "stansummary " + << "-c " << target_csv_file << " " << csv_file; + run_command_output out = run_command(ss_command.str()); + ASSERT_FALSE(out.hasError); + + std::ifstream expected_output( + "src/test/interface/example_output/matrix_summary.csv"); + std::stringstream ss_expected; + ss_expected << expected_output.rdbuf(); + + std::ifstream target_stream(target_csv_file.c_str()); + if (!target_stream.is_open()) { + std::cerr << "Failed to open file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; + FAIL(); + } + std::stringstream ss_actual; + ss_actual << target_stream.rdbuf(); + target_stream.close(); + + EXPECT_EQ(ss_expected.str(), ss_actual.str()); + + int return_code = std::remove(target_csv_file.c_str()); + if (return_code != 0) { + std::cerr << "Failed to remove file: " << target_csv_file << "\n"; + std::cerr << "Error: " << std::strerror(errno) << std::endl; FAIL(); + } } diff --git a/src/test/interface/variational_output_test.cpp b/src/test/interface/variational_output_test.cpp index f9d80a57f0..178922abe1 100644 --- a/src/test/interface/variational_output_test.cpp +++ b/src/test/interface/variational_output_test.cpp @@ -1,5 +1,5 @@ #include -#include +#include #include #include @@ -27,13 +27,13 @@ class CmdStan : public testing::Test { y22 = "y[2,2]"; } - stan::mcmc::chains<> parse_output_file() { + stan::mcmc::chainset parse_output_file() { std::ifstream output_stream; output_stream.open(output_file.data()); stan::io::stan_csv parsed_output = stan::io::stan_csv_reader::parse(output_stream, 0); - stan::mcmc::chains<> chains(parsed_output); + stan::mcmc::chainset chains(parsed_output); output_stream.close(); return chains; } @@ -48,7 +48,7 @@ TEST_F(CmdStan, variational_default) { ASSERT_EQ(0, out.err_code); - stan::mcmc::chains<> chains = parse_output_file(); + auto chains = parse_output_file(); ASSERT_EQ(1, chains.num_chains()); ASSERT_EQ(1000, chains.num_samples()); } @@ -59,7 +59,7 @@ TEST_F(CmdStan, variational_meanfield) { ASSERT_EQ(0, out.err_code); - stan::mcmc::chains<> chains = parse_output_file(); + auto chains = parse_output_file(); ASSERT_EQ(1, chains.num_chains()); ASSERT_EQ(1000, chains.num_samples()); } @@ -70,7 +70,7 @@ TEST_F(CmdStan, variational_fullrank) { ASSERT_EQ(0, out.err_code); - stan::mcmc::chains<> chains = parse_output_file(); + auto chains = parse_output_file(); ASSERT_EQ(1, chains.num_chains()); ASSERT_EQ(1000, chains.num_samples()); }