From 7946efebcb046fb8088139f1beeecfdc5f4dac6d Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Fri, 11 Oct 2024 15:15:05 -0400 Subject: [PATCH 01/40] adding chainset and unit tests --- src/stan/mcmc/chainset.hpp | 504 ++++ src/test/unit/mcmc/chainset_test.cpp | 334 +++ .../mcmc/test_csv_files/bernoulli_500.csv | 557 +++++ .../mcmc/test_csv_files/bernoulli_default.csv | 1057 +++++++++ .../mcmc/test_csv_files/bernoulli_thin.csv | 1057 +++++++++ .../mcmc/test_csv_files/bernoulli_warmup.csv | 2057 +++++++++++++++++ .../mcmc/test_csv_files/bernoulli_zeta.csv | 1057 +++++++++ .../test_csv_files/eight_schools_empty.csv | 57 + 8 files changed, 6680 insertions(+) create mode 100644 src/stan/mcmc/chainset.hpp create mode 100644 src/test/unit/mcmc/chainset_test.cpp create mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_500.csv create mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_default.csv create mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_thin.csv create mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_warmup.csv create mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv create mode 100644 src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv diff --git a/src/stan/mcmc/chainset.hpp b/src/stan/mcmc/chainset.hpp new file mode 100644 index 0000000000..3846212e95 --- /dev/null +++ b/src/stan/mcmc/chainset.hpp @@ -0,0 +1,504 @@ +#ifndef STAN_MCMC_CHAINSET_HPP +#define STAN_MCMC_CHAINSET_HPP + +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +namespace stan { +namespace mcmc { +using Eigen::Dynamic; + +/** + * An mcmc::chainset object manages the post-warmup draws + * across a set of MCMC chains, which all have the same number of samples. + * + * @note samples are stored in column major, i.e., each column corresponds to + * an output variable (element). + * + */ +class chainset { + private: + size_t num_samples_; + std::vector param_names_; + std::vector chains_; + + public: + /* Construct a chainset from a single sample. + * Throws execption if sample is empty. + */ + explicit chainset(const stan::io::stan_csv& stan_csv) { + if (chains_.size() > 0) { + throw std::invalid_argument("Cannot re-initialize chains object"); + } + if (stan_csv.header.size() == 0 || stan_csv.samples.rows() == 0) { + throw std::invalid_argument("Error: empty sample"); + } + param_names_ = stan_csv.header; + num_samples_ = stan_csv.samples.rows(); + chains_.push_back(stan_csv.samples); + } + + /* Construct a chainset from a set of samples. + * Throws execption if sample column names and shapes don't match. + */ + explicit chainset(const std::vector& stan_csv) { + if (stan_csv.empty()) + return; + if (chains_.size() > 0) { + throw std::invalid_argument("Cannot re-initialize chains object"); + } + if (stan_csv[0].header.size() == 0 || stan_csv[0].samples.rows() == 0) { + throw std::invalid_argument("Error: empty sample"); + } + param_names_ = stan_csv[0].header; + num_samples_ = stan_csv[0].samples.rows(); + chains_.push_back(stan_csv[0].samples); + std::stringstream ss; + for (size_t i = 1; i < stan_csv.size(); ++i) { + if (stan_csv[i].header.size() != param_names_.size()) { + ss << "Error: chain " << (i + 1) << " missing or extra columns"; + throw std::invalid_argument(ss.str()); + } + for (int j = 0; j < param_names_.size(); j++) { + if (param_names_[j] != stan_csv[i].header[j]) { + ss << "Error: chain " << (i + 1) << " header column " << (j + 1) + << " doesn't match chain 1 header, found: " + << stan_csv[i].header[j] << " expecting: " << param_names_[j]; + throw std::invalid_argument(ss.str()); + } + } + if (stan_csv[i].samples.rows() != num_samples_) { + ss << "Error: chain " << (i + 1) << ", missing or extra rows."; + throw std::invalid_argument(ss.str()); + } + chains_.push_back(stan_csv[i].samples); + } + } + + /** + * Report number of chains in chainset. + * @return chainset size. + */ + inline int num_chains() const { return chains_.size(); } + + /** + * Report number of parameters per chain. + * @return size of parameter names vector. + */ + inline int num_params() const { return param_names_.size(); } + + /** + * Report number of samples (draws) per chain. + * @return rows per chain + */ + inline int num_samples() const { return num_samples_; } + + /** + * Get parameter names. + * @return vector of parameter names. + */ + const std::vector& param_names() const { return param_names_; } + + /** + * Get name of parameter at specified column index. + * Throws exception if index is out of bounds. + * + * @param index column index + * @return parameter name + */ + const std::string& param_name(int index) const { + if (index < 0 || index >= param_names_.size()) { + std::stringstream ss; + ss << "Bad index " << index << ", should be between 0 and " + << (param_names_.size() - 1); + throw std::invalid_argument(ss.str()); + } + return param_names_[index]; + } + + /** + * Get column index for specified parameter name. + * Throws exception if name not found. + * + * @param name parameter name + * @return column index + */ + int index(const std::string& name) const { + auto it = std::find(param_names_.begin(), param_names_.end(), name); + if (it == param_names_.end()) { + std::stringstream ss; + ss << "Unknown parameter name " << name; + throw std::invalid_argument(ss.str()); + } + return std::distance(param_names_.begin(), it); + } + + /** + * Assemble samples (draws) from specified column index across all chains + * into a matrix of samples X chain. + * Throws exception if column index is out of bounds. + * + * @param index column index + * @return matrix of draws across all chains + */ + Eigen::MatrixXd samples(const int index) const { + Eigen::MatrixXd result(num_samples(), chains_.size()); + if (index < 0 || index >= param_names_.size()) { + std::stringstream ss; + ss << "Bad index " << index << ", should be between 0 and " + << (param_names_.size() - 1); + throw std::invalid_argument(ss.str()); + } + for (int i = 0; i < chains_.size(); ++i) { + result.col(i) = chains_[i].col(index); + } + return result; + } + + /** + * Assemble samples (draws) from specified parameter name across all chains + * into a matrix of samples X chain. + * Throws exception if parameter name is not found. + * + * @param name parameter name + * @return matrix of draws across all chains + */ + Eigen::MatrixXd samples(const std::string& name) const { + return samples(index(name)); + } + + /** + * Compute mean value for specified parameter across all chains. + * + * @param index parameter index + * @return mean parameter value + */ + double mean(const int index) const { return samples(index).mean(); } + + /** + * Compute mean value for specified parameter across all chains. + * + * @param name parameter name + * @return mean parameter value + */ + double mean(const std::string& name) const { return mean(index(name)); } + + /** + * Compute sample variance for specified parameter across all chains. + * 1 / (N - 1) * sum((theta_n - mean(theta))^2) + * + * @param index parameter index + * @return sample variance + */ + double variance(const int index) const { + Eigen::MatrixXd draws = samples(index); + return (draws.array() - draws.mean()).square().sum() / (draws.size() - 1); + } + + /** + * Compute sample variance for specified parameter across all chains. + * 1 / (N - 1) * sum((theta_n - mean(theta))^2) + * + * @param name parameter name + * @return sample variance + */ + double variance(const std::string& name) const { + return variance(index(name)); + } + + /** + * Compute standard deviation for specified parameter across all chains. + * + * @param index parameter index + * @return sample sd + */ + double sd(const int index) const { return std::sqrt(variance(index)); } + + /** + * Compute standard deviation for specified parameter across all chains. + * + * @param name parameter name + * @return sample sd + */ + double sd(const std::string& name) const { return sd(index(name)); } + + /** + * Compute median value of specified parameter across all chains. + * + * @param index parameter index + * @return median + */ + double median(const int index) const { return (quantile(index, 0.5)); } + + /** + * Compute median value of specified parameter across all chains. + * + * @param name parameter name + * @return median + */ + double median(const std::string& name) const { return median(index(name)); } + + /** + * Compute maximum absolute deviation (mad) for specified parameter. + * + * Follows R implementation: constant * median(abs(x - center)) + * where the value of center is median(x) and the constant is 1.4826, + * a scale factor for asymptotically normal consistency: `1/qnorm(3/4)`. + * (R stats version 3.6.2) + * + * @param index parameter index + * @return sample mad + */ + double max_abs_deviation(const int index) const { + Eigen::MatrixXd draws = samples(index); + auto center = median(index); + Eigen::MatrixXd abs_dev = (draws.array() - center).abs(); + Eigen::Map map(abs_dev.data(), abs_dev.size()); + return 1.4826 * stan::math::quantile(map, 0.5); + } + + /** + * Compute maximum absolute deviation (mad) for specified parameter. + * + * Follows R implementation: constant * median(abs(x - center)) + * where the value of center is median(x) and the constant is 1.4826, + * a scale factor for asymptotically normal consistency: `1/qnorm(3/4)`. + * (R stats version 3.6.2) + * + * @param name parameter name + * @return sample mad + */ + double max_abs_deviation(const std::string& name) const { + return max_abs_deviation(index(name)); + } + + /** + * Compute the quantile value of the specified parameter + * at the specified probability. + * + * Throws exception if specified probability is not between 0 and 1. + * + * @param index parameter index + * @param prob probability + * @return parameter value at quantile + */ + double quantile(const int index, const double prob) const { + // Ensure the probability is within [0, 1] + if (prob <= 0.0 || prob >= 1.0) { + throw std::out_of_range("Probability must be between 0 and 1."); + } + Eigen::MatrixXd draws = samples(index); + Eigen::Map map(draws.data(), draws.size()); + return stan::math::quantile(map, prob); + } + + /** + * Compute the quantile value of the specified parameter + * at the specified probability. + * + * Throws exception if specified probability is not between 0 and 1. + * + * @param name parameter name + * @param prob probability + * @return parameter value at quantile + */ + double quantile(const std::string& name, const double prob) const { + return quantile(index(name), prob); + } + + /** + * Compute the quantile values of the specified parameter + * for a set of specified probabilities. + * + * Throws exception if any probability is not between 0 and 1. + * + * @param index parameter index + * @param probs vector of probabilities + * @return vector of parameter values for quantiles + */ + Eigen::VectorXd quantiles(const int index, + const Eigen::VectorXd& probs) const { + if (probs.size() == 0) + return Eigen::VectorXd::Zero(0); + if (probs.minCoeff() <= 0.0 || probs.maxCoeff() >= 1.0) { + throw std::out_of_range("Probabilities must be between 0 and 1."); + } + Eigen::MatrixXd draws = samples(index); + Eigen::Map map(draws.data(), draws.size()); + std::vector probs_vec(probs.data(), probs.data() + probs.size()); + std::vector quantiles = stan::math::quantile(map, probs_vec); + return Eigen::Map(quantiles.data(), quantiles.size()); + } + + /** + * Compute the quantile values of the specified parameter + * for a set of specified probabilities. + * + * Throws exception if any probability is not between 0 and 1. + * + * @param name parameter name + * @param probs vector of probabilities + * @return vector of parameter values for quantiles + */ + Eigen::VectorXd quantiles(const std::string& name, + const Eigen::VectorXd& probs) const { + return quantiles(index(name), probs); + } + + /** + * Computes the split potential scale reduction (split Rhat) using rank based + * diagnostic for a set of per-chain draws, for bulk and tail Rhat. + * Based on paper https://arxiv.org/abs/1903.08008 + * + * @param index parameter index + * @return pair (bulk_rhat, tail_rhat) + */ + std::pair split_rank_normalized_rhat(const int index) const { + return analyze::split_rank_normalized_rhat(samples(index)); + } + + /** + * Computes the split potential scale reduction (split Rhat) using rank based + * diagnostic for a set of per-chain draws, for bulk and tail Rhat. + * Based on paper https://arxiv.org/abs/1903.08008 + * + * @param name parameter name + * @return pair (bulk_rhat, tail_rhat) + */ + std::pair split_rank_normalized_rhat( + const std::string& name) const { + return split_rank_normalized_rhat(index(name)); + } + + /** + * Computes the effective sample size (ESS) for the specified + * parameter across all chains, according to the algorithm presented in + * https://arxiv.org/abs/1903.08008, section 3.2 for folded (split) + * rank-normalized ESS for both bulk and tail ESS. + * + * @param index parameter index + * @return pair (bulk_ess, tail_ess) + */ + std::pair split_rank_normalized_ess(const int index) const { + return analyze::split_rank_normalized_ess(samples(index)); + } + + /** + * Computes the effective sample size (ESS) for the specified + * parameter across all chains, according to the algorithm presented in + * https://arxiv.org/abs/1903.08008, section 3.2 for folded (split) + * rank-normalized ESS for both bulk and tail ESS. + * + * @param name parameter name + * @return pair (bulk_ess, tail_ess) + */ + std::pair split_rank_normalized_ess( + const std::string& name) const { + return split_rank_normalized_ess(index(name)); + } + + /** + * Computes the mean Monte Carlo error estimate for the central 90% interval. + * See https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package + * + * @param index parameter index + * @return pair (bulk_ess, tail_ess) + */ + double mcse_mean(const int index) const { + double ess_bulk = analyze::split_rank_normalized_ess(samples(index)).first; + return sd(index) / std::sqrt(ess_bulk); + } + + /** + * Computes the mean Monte Carlo error estimate for the central 90% interval. + * See https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package. + * + * @param name parameter name + * @return pair (bulk_ess, tail_ess) + */ + double mcse_mean(const std::string& name) const { + return mcse_mean(index(name)); + } + + /** + * Computes the standard deviation of the Monte Carlo error estimate + * https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package. + * + * @param index parameter index + * @return pair (bulk_ess, tail_ess) + */ + double mcse_sd(const int index) const { + Eigen::MatrixXd s = samples(index); + Eigen::MatrixXd s2 = s.array().square(); + double ess_s = analyze::split_rank_normalized_ess(s).first; + double ess_s2 = analyze::split_rank_normalized_ess(s2).first; + double ess_sd = std::min(ess_s, ess_s2); + return sd(index) + * std::sqrt(stan::math::e() * std::pow(1 - 1 / ess_sd, ess_sd - 1) + - 1); + } + + /** + * Computes the standard deviation of the Monte Carlo error estimate + * https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package + * + * @param name parameter name + * @return pair (bulk_ess, tail_ess) + */ + double mcse_sd(const std::string& name) const { return mcse_sd(index(name)); } + + /** + * Compute autocorrelation for one column of one chain. + * Throws exception if column index is out of bounds. + * Autocorrelation is computed using Stan math library implmentation. + * + * @param chain chain index + * @param index column index + * @return vector of chain autocorrelation at all lags + */ + Eigen::VectorXd autocorrelation(const int chain, const int index) const { + Eigen::MatrixXd s = samples(index); + Eigen::Map chain_col(samples(chain).data(), + num_samples()); + Eigen::VectorXd autocorr_col(num_samples()); + stan::math::autocorrelation(s.col(chain), autocorr_col); + return autocorr_col; + } + + /** + * Compute autocorrelation for one column of one chain. + * Throws exception if column index is out of bounds. + * Autocorrelation is computed using Stan math library implmentation. + * + * @param chain chain index + * @param name column name + * @return vector of chain autocorrelation at all lags + */ + Eigen::VectorXd autocorrelation(const int chain, + const std::string name) const { + return autocorrelation(chain, index(name)); + } +}; + +} // namespace mcmc +} // namespace stan + +#endif diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp new file mode 100644 index 0000000000..9662c3159c --- /dev/null +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -0,0 +1,334 @@ +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +class McmcChains : public testing::Test { + public: + void SetUp() override { + bernoulli_500_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_500.csv", + std::ifstream::in); + bernoulli_default_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_default.csv", + std::ifstream::in); + bernoulli_thin_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_thin.csv", + std::ifstream::in); + bernoulli_warmup_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_warmup.csv", + std::ifstream::in); + bernoulli_zeta_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv", + std::ifstream::in); + eight_schools_1_stream.open( + "src/test/unit/mcmc/test_csv_files/eight_schools_1.csv", + std::ifstream::in); + eight_schools_2_stream.open( + "src/test/unit/mcmc/test_csv_files/eight_schools_2.csv", + std::ifstream::in); + eight_schools_5iters_1_stream.open( + "src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv", + std::ifstream::in); + eight_schools_5iters_2_stream.open( + "src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv", + std::ifstream::in); + + if (!bernoulli_500_stream || !bernoulli_default_stream + || !bernoulli_thin_stream || !bernoulli_warmup_stream + || !bernoulli_zeta_stream || !eight_schools_1_stream + || !eight_schools_2_stream || !eight_schools_5iters_1_stream + || !eight_schools_5iters_2_stream) { + FAIL() << "Failed to open one or more test files"; + } + bernoulli_500_stream.seekg(0, std::ios::beg); + bernoulli_default_stream.seekg(0, std::ios::beg); + bernoulli_thin_stream.seekg(0, std::ios::beg); + bernoulli_warmup_stream.seekg(0, std::ios::beg); + bernoulli_zeta_stream.seekg(0, std::ios::beg); + eight_schools_1_stream.seekg(0, std::ios::beg); + eight_schools_2_stream.seekg(0, std::ios::beg); + eight_schools_5iters_1_stream.seekg(0, std::ios::beg); + eight_schools_5iters_2_stream.seekg(0, std::ios::beg); + + bernoulli_500 + = stan::io::stan_csv_reader::parse(bernoulli_500_stream, &out); + bernoulli_default + = stan::io::stan_csv_reader::parse(bernoulli_default_stream, &out); + bernoulli_thin + = stan::io::stan_csv_reader::parse(bernoulli_thin_stream, &out); + bernoulli_warmup + = stan::io::stan_csv_reader::parse(bernoulli_warmup_stream, &out); + bernoulli_zeta + = stan::io::stan_csv_reader::parse(bernoulli_zeta_stream, &out); + eight_schools_1 + = stan::io::stan_csv_reader::parse(eight_schools_1_stream, &out); + eight_schools_2 + = stan::io::stan_csv_reader::parse(eight_schools_2_stream, &out); + eight_schools_5iters_1 + = stan::io::stan_csv_reader::parse(eight_schools_5iters_1_stream, &out); + eight_schools_5iters_2 + = stan::io::stan_csv_reader::parse(eight_schools_5iters_2_stream, &out); + } + + void TearDown() override { + bernoulli_500_stream.close(); + bernoulli_default_stream.close(); + bernoulli_thin_stream.close(); + bernoulli_warmup_stream.close(); + bernoulli_zeta_stream.close(); + eight_schools_1_stream.close(); + eight_schools_2_stream.close(); + eight_schools_5iters_1_stream.close(); + eight_schools_5iters_2_stream.close(); + } + + std::stringstream out; + + std::ifstream bernoulli_500_stream, bernoulli_default_stream, + bernoulli_thin_stream, bernoulli_warmup_stream, bernoulli_zeta_stream, + eight_schools_1_stream, eight_schools_2_stream, + eight_schools_5iters_1_stream, eight_schools_5iters_2_stream; + + stan::io::stan_csv bernoulli_500, bernoulli_default, bernoulli_thin, + bernoulli_warmup, bernoulli_zeta, eight_schools_1, eight_schools_2, + eight_schools_5iters_1, eight_schools_5iters_2; +}; + +TEST_F(McmcChains, constructor) { + stan::mcmc::chainset chain_1(eight_schools_1); + EXPECT_EQ(1, chain_1.num_chains()); + EXPECT_EQ(eight_schools_1.header.size(), chain_1.num_params()); + EXPECT_EQ( + eight_schools_1.metadata.num_samples / eight_schools_1.metadata.thin, + chain_1.num_samples()); + + std::vector eight_schools; + eight_schools.push_back(eight_schools_1); + eight_schools.push_back(eight_schools_2); + stan::mcmc::chainset chain_2(eight_schools); + EXPECT_EQ(2, chain_2.num_chains()); + EXPECT_EQ(eight_schools_1.header.size(), chain_2.num_params()); + EXPECT_EQ( + eight_schools_1.metadata.num_samples / eight_schools_1.metadata.thin, + chain_2.num_samples()); + + std::vector bernoulli; + bernoulli.push_back(bernoulli_default); + bernoulli.push_back(bernoulli_thin); + bernoulli.push_back(bernoulli_warmup); + stan::mcmc::chainset chain_3(bernoulli); + EXPECT_EQ(3, chain_3.num_chains()); + EXPECT_EQ(bernoulli_default.header.size(), chain_3.num_params()); + EXPECT_EQ(bernoulli_default.metadata.num_samples, chain_3.num_samples()); +} + +TEST_F(McmcChains, addFail) { + std::vector bad; + bad.push_back(bernoulli_default); + bad.push_back(bernoulli_500); + EXPECT_THROW(stan::mcmc::chainset fail(bad), std::invalid_argument); + + bad.clear(); + bad.push_back(bernoulli_default); + bad.push_back(eight_schools_1); + EXPECT_THROW(stan::mcmc::chainset fail(bad), std::invalid_argument); + + bad.clear(); + bad.push_back(bernoulli_default); + bad.push_back(bernoulli_zeta); + EXPECT_THROW(stan::mcmc::chainset fail(bad), std::invalid_argument); +} + +TEST_F(McmcChains, paramNameIndex) { + stan::mcmc::chainset chains_csv(eight_schools_1); + EXPECT_EQ(1, chains_csv.num_chains()); + for (int i = 0; i < eight_schools_1.header.size(); i++) { + EXPECT_EQ(eight_schools_1.header[i], chains_csv.param_name(i)); + EXPECT_EQ(i, chains_csv.index(eight_schools_1.header[i])); + } + EXPECT_THROW(chains_csv.param_name(-5000), std::invalid_argument); + EXPECT_THROW(chains_csv.param_name(5000), std::invalid_argument); + EXPECT_THROW(chains_csv.index("foo"), std::invalid_argument); +} + +TEST_F(McmcChains, eight_schools_samples) { + std::vector eight_schools; + eight_schools.push_back(eight_schools_1); + eight_schools.push_back(eight_schools_2); + stan::mcmc::chainset chain_2(eight_schools); + Eigen::MatrixXd mu_all = chain_2.samples("mu"); + EXPECT_EQ(chain_2.num_chains() * chain_2.num_samples(), mu_all.size()); + mu_all = chain_2.samples(7); + EXPECT_EQ(chain_2.num_chains() * chain_2.num_samples(), mu_all.size()); + + EXPECT_THROW(chain_2.samples(5000), std::invalid_argument); + EXPECT_THROW(chain_2.samples("foo"), std::invalid_argument); +} + +TEST_F(McmcChains, split_rank_normalized_rhat) { + stan::mcmc::chainset chain_1(eight_schools_1); + EXPECT_EQ(1, chain_1.num_chains()); + + // test against R implementation in pkg posterior + Eigen::VectorXd rhat_8_schools_1_bulk(10); + rhat_8_schools_1_bulk << 1.0012958313, 1.0046136496, 1.0085723580, + 1.0248629375, 1.0111456620, 1.0004458336, 0.9987162973, 1.0339773469, + 0.9985612618, 1.0281667351; + + Eigen::VectorXd rhat_8_schools_1_tail(10); + rhat_8_schools_1_tail << 1.005676523, 1.009670999, 1.00184184, 1.002222679, + 1.004148161, 1.003218528, 1.009195353, 1.001426744, 1.003984381, + 1.025817745; + + for (size_t i = 0; i < 10; ++i) { + auto rhats = chain_1.split_rank_normalized_rhat(i + 7); + EXPECT_NEAR(rhats.first, rhat_8_schools_1_bulk(i), 0.05); + EXPECT_NEAR(rhats.second, rhat_8_schools_1_tail(i), 0.05); + } +} + +TEST_F(McmcChains, split_rank_normalized_ess) { + std::vector eight_schools; + eight_schools.push_back(eight_schools_1); + eight_schools.push_back(eight_schools_2); + stan::mcmc::chainset chain_2(eight_schools); + EXPECT_EQ(2, chain_2.num_chains()); + + // test against R implementation in pkg posterior (via cmdstanr) + Eigen::VectorXd ess_8_schools_bulk(10); + ess_8_schools_bulk << 348, 370, 600, 638, 765, 608, 629, 274, 517, 112; + Eigen::VectorXd ess_8_schools_tail(10); + ess_8_schools_tail << 845, 858, 874, 726, 620, 753, 826, 628, 587, 108; + + for (size_t i = 0; i < 10; ++i) { + auto ess = chain_2.split_rank_normalized_ess(i + 7); + EXPECT_NEAR(ess.first, ess_8_schools_bulk(i), 5); + EXPECT_NEAR(ess.second, ess_8_schools_tail(i), 5); + } +} + +TEST_F(McmcChains, ess_short_chains) { + std::vector eight_schools_5iters; + eight_schools_5iters.push_back(eight_schools_5iters_1); + eight_schools_5iters.push_back(eight_schools_5iters_2); + stan::mcmc::chainset chain_2(eight_schools_5iters); + EXPECT_EQ(2, chain_2.num_chains()); + + for (size_t i = 0; i < 10; ++i) { + auto ess = chain_2.split_rank_normalized_ess(i + 7); + EXPECT_TRUE(std::isnan(ess.first)); + EXPECT_TRUE(std::isnan(ess.second)); + } +} + +TEST_F(McmcChains, summary_stats) { + std::vector eight_schools; + eight_schools.push_back(eight_schools_1); + eight_schools.push_back(eight_schools_2); + stan::mcmc::chainset chain_2(eight_schools); + EXPECT_EQ(2, chain_2.num_chains()); + + // test against R implementation in pkg posterior (via cmdstanr) + Eigen::VectorXd s8_mean(10), s8_median(10), s8_sd(10), s8_mad(10), s8_q5(10), + s8_q95(10); + s8_mean << 7.95, 12.54, 7.82, 5.33, 7.09, 4.12, 5.72, 11.65, 8.80, 8.26; + s8_median << 8.00, 11.27, 7.39, 5.44, 6.64, 4.54, 5.93, 11.38, 8.28, 7.05; + s8_sd << 5.48, 9.57, 6.85, 8.39, 6.91, 6.57, 6.85, 7.76, 8.40, 5.53; + s8_mad << 5.49, 8.79, 6.39, 7.38, 5.98, 6.25, 6.59, 7.79, 7.59, 4.66; + s8_q5 << -0.46, -0.39, -3.04, -8.90, -3.31, -7.58, -5.84, 0.10, -4.15, 2.08; + s8_q95 << 17.01, 30.47, 19.25, 19.02, 18.72, 14.49, 16.04, 25.77, 22.71, + 18.74; + Eigen::VectorXd probs(3); + probs << 0.05, 0.5, 0.95; + + for (size_t i = 0; i < 10; ++i) { + auto mean = chain_2.mean(i + 7); + EXPECT_NEAR(mean, s8_mean(i), 0.05); + auto median = chain_2.median(i + 7); + EXPECT_NEAR(median, s8_median(i), 0.05); + auto sd = chain_2.sd(i + 7); + EXPECT_NEAR(sd, s8_sd(i), 0.05); + auto mad = chain_2.max_abs_deviation(i + 7); + EXPECT_NEAR(mad, s8_mad(i), 0.05); + auto q_5 = chain_2.quantile(i + 7, 0.05); + EXPECT_NEAR(q_5, s8_q5(i), 0.5); + auto q_95 = chain_2.quantile(i + 7, 0.95); + EXPECT_NEAR(q_95, s8_q95(i), 0.5); + auto qs_5_50_95 = chain_2.quantiles(i + 7, probs); + EXPECT_EQ(3, qs_5_50_95.size()); + EXPECT_NEAR(qs_5_50_95(0), s8_q5(i), 0.5); + EXPECT_NEAR(qs_5_50_95(1), s8_median(i), 0.05); + EXPECT_NEAR(qs_5_50_95(2), s8_q95(i), 0.5); + } +} + +TEST_F(McmcChains, mcse) { + std::vector eight_schools; + eight_schools.push_back(eight_schools_1); + eight_schools.push_back(eight_schools_2); + stan::mcmc::chainset chain_2(eight_schools); + EXPECT_EQ(2, chain_2.num_chains()); + + // test against R implementation in pkg posterior + Eigen::VectorXd s8_mcse_mean(10), s8_mcse_sd(10); + s8_mcse_mean << 0.288379, 0.4741815, 0.2741001, 0.3294614, 0.2473758, + 0.2665048, 0.2701363, 0.4740092, 0.3621771, 0.3832464; + s8_mcse_sd << 0.1841825, 0.2854258, 0.192332, 0.2919369, 0.2478025, 0.2207478, + 0.2308452, 0.2522107, 0.2946896, 0.3184745; + + for (size_t i = 0; i < 10; ++i) { + auto mcse_mean = chain_2.mcse_mean(i + 7); + EXPECT_NEAR(mcse_mean, s8_mcse_mean(i), 0.5); + auto mcse_sd = chain_2.mcse_sd(i + 7); + EXPECT_NEAR(mcse_sd, s8_mcse_sd(i), 0.7); + } +} + +TEST_F(McmcChains, const_fail) { + std::ifstream bernoulli_const_1_stream, bernoulli_const_2_stream; + stan::io::stan_csv bernoulli_const_1, bernoulli_const_2; + bernoulli_const_1_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv", + std::ifstream::in); + bernoulli_const_1 + = stan::io::stan_csv_reader::parse(bernoulli_const_1_stream, &out); + bernoulli_const_1_stream.close(); + bernoulli_const_2_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv", + std::ifstream::in); + bernoulli_const_2 + = stan::io::stan_csv_reader::parse(bernoulli_const_2_stream, &out); + bernoulli_const_2_stream.close(); + std::vector bernoulli_const; + bernoulli_const.push_back(bernoulli_const_1); + bernoulli_const.push_back(bernoulli_const_2); + stan::mcmc::chainset chain_2(bernoulli_const); + EXPECT_EQ(2, chain_2.num_chains()); + auto rhat = chain_2.split_rank_normalized_rhat("zeta"); + EXPECT_TRUE(std::isnan(rhat.first)); + EXPECT_TRUE(std::isnan(rhat.second)); + auto ess = chain_2.split_rank_normalized_ess("zeta"); + EXPECT_TRUE(std::isnan(ess.first)); + EXPECT_TRUE(std::isnan(ess.second)); +} + +TEST_F(McmcChains, autocorrelation) { + stan::mcmc::chainset chain_1(eight_schools_1); + EXPECT_EQ(1, chain_1.num_chains()); + + Eigen::VectorXd mu_ac_posterior(10); + mu_ac_posterior << 1.00000000000, 0.19487668999, 0.05412049365, 0.07834048575, + 0.04145609855, 0.04353962161, -0.00977255885, 0.00005175308, + 0.01791577080, 0.01245035817; + auto mu_ac = chain_1.autocorrelation(0, "mu"); + for (size_t i = 0; i < 10; ++i) { + EXPECT_NEAR(mu_ac_posterior(i), mu_ac(i), 0.05); + } +} diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_500.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_500.csv new file mode 100644 index 0000000000..f7c479a86e --- /dev/null +++ b/src/test/unit/mcmc/test_csv_files/bernoulli_500.csv @@ -0,0 +1,557 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-07-20 18:55:04 UTC +# method = sample (Default) +# sample +# num_samples = 500 +# 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 = examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 3634950897 (Default) +# output +# file = bernoulli_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-25-gbb9ce42 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +# Adaptation terminated +# Step size = 0.908714 +# Diagonal elements of inverse mass matrix: +# 0.533354 +-6.77412,0.987824,0.908714,2,3,0,6.8785,0.279254 +-6.89323,0.977402,0.908714,1,3,0,6.89338,0.321021 +-6.78182,1,0.908714,2,3,0,6.8661,0.218479 +-6.78182,0.773777,0.908714,1,3,0,7.98348,0.218479 +-7.21517,0.892133,0.908714,1,3,0,7.43887,0.381517 +-9.70031,0.447016,0.908714,1,1,0,9.70243,0.59546 +-7.64929,1,0.908714,2,3,0,9.25311,0.111255 +-7.80318,0.993575,0.908714,2,3,0,7.9051,0.102697 +-6.75708,0.98594,0.908714,1,3,0,7.94373,0.233437 +-6.74807,1,0.908714,2,3,0,6.75624,0.251184 +-6.76508,0.961627,0.908714,2,3,0,6.97493,0.227399 +-6.76508,0.694403,0.908714,1,3,0,8.48868,0.227399 +-7.46,0.856941,0.908714,1,3,0,7.64341,0.123565 +-6.84767,0.988752,0.908714,1,3,0,7.39531,0.197147 +-6.76112,0.937435,0.908714,2,3,0,7.4025,0.270583 +-6.76723,0.993298,0.908714,2,3,0,6.80703,0.226049 +-6.75849,1,0.908714,1,1,0,6.7661,0.232214 +-6.75856,0.916923,0.908714,2,3,0,7.37221,0.232155 +-6.76412,0.905032,0.908714,2,3,0,7.46252,0.228033 +-6.75246,0.98558,0.908714,2,3,0,6.86086,0.261903 +-7.14063,0.806926,0.908714,2,3,0,7.89708,0.15144 +-7.65515,0.922931,0.908714,1,1,0,7.65525,0.110908 +-6.85804,0.996431,0.908714,2,3,0,7.69222,0.194631 +-6.7956,0.992136,0.908714,2,3,0,6.94247,0.212823 +-6.75011,0.941177,0.908714,2,3,0,7.20539,0.241987 +-6.83571,0.977386,0.908714,1,3,0,6.86933,0.304611 +-7.04002,0.894555,0.908714,1,3,0,7.42018,0.163442 +-6.91021,0.955935,0.908714,1,3,0,7.47326,0.325253 +-6.75575,1,0.908714,2,3,0,6.89311,0.234677 +-6.74979,0.982019,0.908714,2,3,0,6.87707,0.25749 +-6.75266,0.999273,0.908714,1,1,0,6.75273,0.262168 +-6.75854,0.989314,0.908714,2,3,0,6.81651,0.232168 +-7.35696,0.872376,0.908714,1,3,0,7.52038,0.131354 +-7.17209,1,0.908714,1,1,0,7.3618,0.148109 +-6.76514,0.974208,0.908714,1,3,0,7.33856,0.273592 +-6.81293,0.933943,0.908714,2,3,0,7.16788,0.206861 +-6.78344,0.990552,0.908714,2,3,0,6.90852,0.284208 +-6.75189,1,0.908714,1,3,0,6.77606,0.261105 +-6.91381,0.79852,0.908714,2,3,0,8.08135,0.183007 +-7.36903,0.965086,0.908714,2,3,0,7.37005,0.403004 +-7.24594,1,0.908714,1,1,0,7.45634,0.38605 +-7.10956,1,0.908714,1,1,0,7.2858,0.3648 +-7.1841,0.701565,0.908714,2,3,0,8.86758,0.376798 +-6.75487,0.962329,0.908714,2,3,0,7.41982,0.264819 +-6.91264,0.952408,0.908714,1,3,0,7.01286,0.183226 +-6.74841,0.935239,0.908714,2,3,0,7.4253,0.253501 +-7.01744,0.836819,0.908714,2,3,0,7.72885,0.166491 +-6.76439,0.998239,0.908714,1,3,0,6.993,0.227849 +-6.77316,0.99526,0.908714,2,3,0,6.8081,0.222694 +-7.23311,0.91075,0.908714,1,3,0,7.31151,0.142098 +-6.93024,1,0.908714,2,3,0,7.17757,0.180038 +-7.0312,0.98107,0.908714,1,1,0,7.04685,0.164616 +-6.76558,0.997454,0.908714,2,3,0,7.04984,0.22708 +-8.32852,0.675198,0.908714,1,3,0,8.99917,0.0799677 +-7.54902,1,0.908714,1,1,0,8.23363,0.117493 +-7.19487,1,0.908714,1,1,0,7.50636,0.1458 +-8.13201,0.809671,0.908714,1,3,0,9.46989,0.484014 +-7.47984,1,0.908714,1,1,0,8.05615,0.416966 +-7.85717,0.884683,0.908714,1,1,0,8.02328,0.45821 +-6.76221,0.977312,0.908714,2,3,0,8.06601,0.229347 +-6.8572,0.99033,0.908714,2,3,0,6.86077,0.311201 +-6.82348,1,0.908714,1,1,0,6.86184,0.300519 +-7.97359,0.617908,0.908714,1,3,0,9.12086,0.0943758 +-7.45034,1,0.908714,1,1,0,7.91667,0.124258 +-6.93542,0.985719,0.908714,1,3,0,7.36867,0.179135 +-7.60792,0.840752,0.908714,1,3,0,8.27659,0.431913 +-7.5992,1,0.908714,1,1,0,7.86308,0.43093 +-7.5992,0.252049,0.908714,1,1,0,10.4877,0.43093 +-7.35221,1,0.908714,1,1,0,7.66226,0.400786 +-7.82219,0.85935,0.908714,1,1,0,7.93875,0.454706 +-8.08711,0.972194,0.908714,2,3,0,8.37798,0.479988 +-7.0257,1,0.908714,2,3,0,7.75859,0.349846 +-7.2537,0.977501,0.908714,2,3,0,7.30002,0.387173 +-6.93473,0.786102,0.908714,2,3,0,8.43393,0.331018 +-6.77979,1,0.908714,1,3,0,6.89224,0.282354 +-6.74895,0.998922,0.908714,1,3,0,6.78592,0.244633 +-6.93759,0.731848,0.908714,2,3,0,8.66514,0.17876 +-7.61391,0.908155,0.908714,1,3,0,7.64703,0.113391 +-7.36814,1,0.908714,1,1,0,7.62491,0.130463 +-8.28709,0.92711,0.908714,2,7,0,8.30461,0.49743 +-7.35295,1,0.908714,2,3,0,8.06187,0.400884 +-7.54375,0.940763,0.908714,1,1,0,7.69381,0.424567 +-6.75119,0.974925,0.908714,2,3,0,7.73022,0.240141 +-6.75836,0.95575,0.908714,2,3,0,7.0279,0.23232 +-6.75759,1,0.908714,1,1,0,6.76028,0.232976 +-7.84043,0.766398,0.908714,1,3,0,8.25276,0.100783 +-7.36878,1,0.908714,1,1,0,7.78742,0.130413 +-6.92704,0.987905,0.908714,1,3,0,7.29386,0.180603 +-6.87173,1,0.908714,1,1,0,6.93002,0.19151 +-6.87173,0.792653,0.908714,1,3,0,8.27612,0.19151 +-6.76869,0.995507,0.908714,2,3,0,6.91339,0.22518 +-6.76869,0.717822,0.908714,1,3,0,8.35048,0.22518 +-7.02303,0.821164,0.908714,2,3,0,7.978,0.165721 +-6.88921,1,0.908714,1,1,0,7.00276,0.1878 +-7.03623,0.937861,0.908714,1,3,0,7.42379,0.351828 +-10.0552,0.518188,0.908714,2,7,0,10.1628,0.0395289 +-7.03905,1,0.908714,2,3,0,9.71561,0.16357 +-7.06047,0.973981,0.908714,2,3,0,7.42468,0.160808 +-7.12565,0.996219,0.908714,2,3,0,7.17004,0.153088 +-7.31585,0.989771,0.908714,2,3,0,7.34328,0.134732 +-6.95355,0.922218,0.908714,1,3,0,7.97785,0.33521 +-7.348,0.886923,0.908714,1,1,0,7.36349,0.400227 +-6.77188,1,0.908714,1,3,0,7.21394,0.277942 +-6.76938,1,0.908714,1,1,0,6.77619,0.276409 +-6.82464,0.974309,0.908714,2,3,0,6.93407,0.300918 +-6.82568,0.970555,0.908714,1,3,0,7.00774,0.20302 +-6.79962,1,0.908714,1,1,0,6.82614,0.211349 +-6.75759,0.877431,0.908714,2,3,0,7.82851,0.232976 +-6.75086,0.998853,0.908714,1,3,0,6.76664,0.259492 +-7.33482,0.846044,0.908714,1,3,0,7.63709,0.133151 +-7.16299,1,0.908714,1,1,0,7.34291,0.149055 +-8.75594,0.821593,0.908714,1,3,0,8.95305,0.0663607 +-8.15624,1,0.908714,1,1,0,8.74352,0.0865339 +-7.81872,1,0.908714,1,1,0,8.18978,0.101892 +-6.80465,0.995317,0.908714,2,3,0,7.84167,0.209584 +-6.75107,0.961176,0.908714,2,3,0,7.07814,0.259841 +-6.75107,0.667664,0.908714,1,3,0,8.23261,0.259841 +-7.18165,0.905003,0.908714,1,3,0,7.23074,0.376419 +-7.40419,0.932419,0.908714,1,1,0,7.49683,0.407552 +-7.4394,0.988812,0.908714,1,1,0,7.62997,0.411994 +-6.75917,0.993332,0.908714,1,3,0,7.47631,0.231653 +-7.77958,0.781858,0.908714,1,3,0,8.14744,0.103939 +-7.62945,1,0.908714,1,1,0,7.86107,0.112444 +-7.32531,0.874756,0.908714,1,3,0,9.12726,0.397178 +-7.58534,0.973387,0.908714,2,3,0,7.7175,0.429359 +-7.3058,1,0.908714,1,1,0,7.61966,0.394511 +-6.86476,0.950946,0.908714,2,3,0,7.68758,0.193074 +-6.75907,0.999201,0.908714,1,3,0,6.848,0.231736 +-6.81488,0.981992,0.908714,1,3,0,6.86672,0.297452 +-7.12749,0.877474,0.908714,1,3,0,7.53085,0.152884 +-6.93162,0.939572,0.908714,1,3,0,7.6458,0.330306 +-6.93162,0.579221,0.908714,1,3,0,9.27146,0.330306 +-6.83618,1,0.908714,1,1,0,6.91448,0.30476 +-6.91338,0.917038,0.908714,2,3,0,7.31475,0.32602 +-7.47192,0.764242,0.908714,1,3,0,8.40039,0.122719 +-7.14254,1,0.908714,1,1,0,7.42972,0.151233 +-7.19146,0.991848,0.908714,1,1,0,7.25374,0.14614 +-7.69363,0.975593,0.908714,2,3,0,7.69497,0.108673 +-6.94366,0.980252,0.908714,1,3,0,7.6055,0.177727 +-7.011,0.987352,0.908714,1,1,0,7.03516,0.16739 +-6.97478,0.979684,0.908714,2,3,0,7.30686,0.172717 +-6.74912,0.999884,0.908714,1,3,0,6.98098,0.24416 +-6.74847,0.999843,0.908714,1,3,0,6.75042,0.253766 +-6.77517,0.93181,0.908714,2,3,0,7.18521,0.221652 +-6.76821,0.996145,0.908714,2,3,0,6.81418,0.225463 +-7.23433,0.907078,0.908714,1,3,0,7.32294,0.141983 +-6.93527,0.913967,0.908714,2,3,0,8.04455,0.331141 +-6.93527,0.944334,0.908714,1,1,0,7.09508,0.331141 +-7.63421,0.917304,0.908714,2,3,0,7.63678,0.434847 +-8.03923,0.875841,0.908714,1,1,0,8.25081,0.475618 +-8.05107,0.998702,0.908714,2,3,0,8.4526,0.476706 +-6.96517,1,0.908714,1,1,0,7.7138,0.337711 +-6.94063,0.913554,0.908714,1,3,0,7.44295,0.17824 +-6.75536,0.999264,0.908714,1,3,0,6.92615,0.235069 +-7.19254,0.905078,0.908714,1,3,0,7.30265,0.146032 +-8.26893,0.92568,0.908714,2,3,0,8.26977,0.495896 +-6.74879,1,0.908714,1,3,0,8.1113,0.245114 +-6.80386,0.985605,0.908714,1,3,0,6.8233,0.293235 +-6.75302,1,0.908714,1,3,0,6.79229,0.262636 +-6.74803,0.999968,0.908714,2,3,0,6.75324,0.250358 +-6.79121,0.935958,0.908714,2,3,0,7.12846,0.214516 +-6.79849,0.998388,0.908714,1,1,0,6.80662,0.211756 +-7.04329,0.961,0.908714,1,3,0,7.05285,0.163013 +-8.53646,0.734634,0.908714,1,3,0,9.67005,0.517597 +-7.18561,0.795245,0.908714,1,3,0,9.94139,0.146728 +-7.2002,0.997601,0.908714,1,1,0,7.27996,0.145271 +-7.4789,0.957777,0.908714,1,1,0,7.50062,0.12223 +-6.75687,0.919771,0.908714,2,3,0,8.39363,0.233623 +-6.80427,0.984738,0.908714,1,3,0,6.84715,0.2934 +-6.75364,0.996023,0.908714,1,3,0,6.82815,0.236907 +-6.75483,0.999906,0.908714,2,3,0,6.75591,0.235608 +-6.75222,0.960645,0.908714,2,3,0,7.00681,0.238665 +-6.75222,0.927459,0.908714,1,3,0,7.07132,0.238665 +-7.17217,0.901262,0.908714,1,3,0,7.28755,0.374946 +-6.80147,0.963964,0.908714,1,3,0,7.36707,0.21069 +-6.81478,0.997101,0.908714,1,1,0,6.82373,0.206282 +-6.8825,0.968009,0.908714,1,3,0,7.06895,0.318227 +-6.75428,1,0.908714,1,3,0,6.85643,0.26415 +-6.8299,0.978999,0.908714,2,3,0,6.89631,0.302702 +-6.8299,0.914015,0.908714,1,1,0,7.0507,0.302702 +-7.42933,0.770589,0.908714,1,3,0,8.11299,0.12579 +-7.35642,1,0.908714,1,1,0,7.50639,0.131397 +-6.74851,0.988929,0.908714,1,3,0,7.43821,0.246095 +-6.74851,0.742452,0.908714,1,3,0,7.91223,0.246095 +-6.74851,0.799271,0.908714,1,3,0,7.62641,0.246095 +-6.74851,0.905637,0.908714,1,3,0,7.14193,0.246095 +-6.76219,0.93724,0.908714,2,3,0,7.16486,0.229364 +-7.30761,0.886668,0.908714,1,3,0,7.43817,0.13543 +-7.30761,0.839285,0.908714,1,3,0,8.62316,0.13543 +-7.97789,0.910498,0.908714,1,1,0,7.97789,0.0941795 +-7.35198,1,0.908714,1,1,0,7.89337,0.131754 +-7.10926,1,0.908714,2,3,0,7.32943,0.154942 +-6.76513,0.998525,0.908714,2,3,0,7.1151,0.227364 +-6.99908,0.954565,0.908714,1,3,0,7.02636,0.169089 +-6.75185,0.916544,0.908714,2,3,0,7.71399,0.239174 +-6.97382,0.944543,0.908714,1,3,0,7.04778,0.339532 +-6.74846,0.997272,0.908714,2,3,0,6.9973,0.246315 +-6.74816,0.997686,0.908714,2,3,0,6.76266,0.252077 +-6.74847,0.997492,0.908714,2,3,0,6.76317,0.246277 +-6.81636,0.988966,0.908714,2,3,0,6.83226,0.205792 +-6.76063,0.993324,0.908714,1,3,0,6.86519,0.270193 +-7.64821,0.860891,0.908714,2,3,0,7.66465,0.11132 +-7.16955,1,0.908714,1,1,0,7.57615,0.148372 +-7.3481,0.954576,0.908714,2,3,0,7.82003,0.132067 +-6.84136,0.93905,0.908714,1,3,0,7.79554,0.30641 +-6.75169,1,0.908714,1,3,0,6.82458,0.260807 +-6.76669,0.994348,0.908714,1,3,0,6.78433,0.226382 +-6.78509,0.86006,0.908714,2,3,0,7.86098,0.217038 +-6.75205,0.903072,0.908714,2,3,0,7.55551,0.238888 +-6.99765,0.962386,0.908714,2,3,0,7.04726,0.169297 +-6.80545,0.97104,0.908714,1,3,0,7.21146,0.293868 +-6.91207,0.946132,0.908714,1,3,0,7.13294,0.183333 +-6.81282,0.990502,0.908714,2,3,0,7.0188,0.206898 +-6.77557,0.837862,0.908714,2,3,0,8.25793,0.221451 +-6.76692,1,0.908714,1,1,0,6.77619,0.22624 +-6.81167,0.989913,0.908714,1,1,0,6.81168,0.207263 +-6.81167,0.602724,0.908714,1,3,0,9.29224,0.207263 +-7.05008,0.814323,0.908714,2,3,0,8.19071,0.162132 +-7.73132,0.843442,0.908714,1,3,0,8.66471,0.445337 +-8.86572,0.688422,0.908714,1,1,0,9.03283,0.542019 +-6.92478,0.928578,0.908714,1,3,0,9.46452,0.181007 +-7.66429,0.903992,0.908714,2,3,0,7.92134,0.11037 +-6.81386,1,0.908714,2,3,0,7.46033,0.297077 +-6.75612,1,0.908714,2,3,0,6.80175,0.234321 +-6.92743,0.854724,0.908714,2,3,0,7.69256,0.180534 +-7.07593,0.929538,0.908714,1,3,0,7.54827,0.359018 +-7.11069,0.989449,0.908714,1,1,0,7.19844,0.364991 +-7.49852,0.585154,0.908714,2,3,0,9.68386,0.41922 +-8.34668,0.919281,0.908714,2,3,0,8.47136,0.502398 +-6.91187,1,0.908714,2,3,0,8.23578,0.183371 +-6.84993,1,0.908714,1,1,0,6.90846,0.196586 +-6.82957,1,0.908714,1,1,0,6.85881,0.20192 +-7.39847,0.949098,0.908714,2,3,0,7.44012,0.406821 +-7.6596,0.919352,0.908714,1,1,0,7.81457,0.437641 +-6.75521,1,0.908714,1,3,0,7.49746,0.265181 +-7.24941,0.862522,0.908714,1,3,0,7.53565,0.14058 +-6.7484,1,0.908714,2,3,0,7.16709,0.253448 +-6.7484,0.559047,0.908714,2,3,0,9.55547,0.253448 +-6.80652,0.98444,0.908714,1,3,0,6.82956,0.208953 +-7.20137,0.896714,0.908714,1,3,0,7.4821,0.379439 +-6.85505,1,0.908714,1,1,0,7.10114,0.310569 +-6.79088,1,0.908714,1,1,0,6.84032,0.287728 +-8.31401,0.709229,0.908714,1,3,0,8.38238,0.499687 +-6.78169,0.977372,0.908714,2,3,0,8.57978,0.218538 +-6.82582,0.986866,0.908714,2,3,0,6.90008,0.20298 +-6.85125,0.994642,0.908714,1,1,0,6.86259,0.196263 +-7.55097,0.892351,0.908714,1,3,0,7.62612,0.117367 +-6.77223,0.99997,0.908714,1,3,0,7.57572,0.223189 +-7.14234,0.928858,0.908714,1,3,0,7.19564,0.151255 +-7.4983,0.938509,0.908714,2,3,0,7.94043,0.120885 +-7.62386,0.994334,0.908714,2,3,0,7.71546,0.112783 +-6.88775,0.98425,0.908714,1,3,0,7.55004,0.188099 +-7.06536,0.966334,0.908714,1,1,0,7.06745,0.160195 +-6.74918,0.920068,0.908714,2,3,0,7.78042,0.244006 +-6.91549,0.958767,0.908714,1,3,0,6.96304,0.326525 +-6.74821,0.999858,0.908714,1,3,0,6.90203,0.25246 +-6.86485,0.977653,0.908714,2,3,0,6.91354,0.313398 +-6.8315,1,0.908714,1,1,0,6.87177,0.303233 +-6.75095,0.994806,0.908714,2,3,0,6.86494,0.259645 +-7.30921,0.878546,0.908714,1,3,0,7.37367,0.394981 +-7.30921,0.655901,0.908714,1,3,0,8.84541,0.394981 +-7.13948,1,0.908714,2,3,0,7.34292,0.369741 +-6.75655,1,0.908714,1,3,0,7.06659,0.266556 +-7.06682,0.915516,0.908714,2,3,0,7.31939,0.357405 +-7.90705,0.636339,0.908714,1,3,0,9.64058,0.0974971 +-6.74957,0.951094,0.908714,1,3,0,8.23858,0.257005 +-6.83116,0.977039,0.908714,1,3,0,6.87097,0.201479 +-6.83116,0.791887,0.908714,1,3,0,8.08968,0.201479 +-6.94595,0.976719,0.908714,1,1,0,6.94731,0.177344 +-7.57988,0.953045,0.908714,2,3,0,7.58586,0.428736 +-7.37923,1,0.908714,2,3,0,7.6725,0.404335 +-6.81679,1,0.908714,2,3,0,7.29686,0.20566 +-6.84825,0.993328,0.908714,1,1,0,6.85668,0.197004 +-6.76645,0.995787,0.908714,2,3,0,6.88708,0.226531 +-7.2684,0.880815,0.908714,1,3,0,7.45887,0.389277 +-7.99183,0.792266,0.908714,1,1,0,8.06249,0.47121 +-6.85081,0.940553,0.908714,1,3,0,8.35779,0.196369 +-7.27106,0.887527,0.908714,1,3,0,7.66804,0.389655 +-7.16114,1,0.908714,2,3,0,7.33854,0.373211 +-6.80237,0.963743,0.908714,1,3,0,7.35785,0.210373 +-7.13147,0.97024,0.908714,2,3,0,7.14699,0.368437 +-6.87269,1,0.908714,2,7,0,7.06819,0.191298 +-7.58441,0.896355,0.908714,1,3,0,7.65019,0.115225 +-7.69276,0.985851,0.908714,1,1,0,7.8004,0.108723 +-8.32633,0.976407,0.908714,2,3,0,8.34038,0.0800467 +-6.90494,0.864111,0.908714,1,3,0,9.49568,0.323962 +-6.90848,0.998976,0.908714,1,1,0,6.95111,0.324831 +-6.90848,0.32177,0.908714,1,3,0,11.0628,0.324831 +-7.58354,0.707243,0.908714,2,7,0,8.60866,0.11528 +-6.74809,0.97428,0.908714,1,3,0,7.75813,0.251467 +-6.85981,0.982857,0.908714,2,3,0,6.87494,0.194216 +-7.9178,0.833211,0.908714,1,3,0,8.1031,0.0969825 +-7.81594,1,0.908714,1,1,0,8.04318,0.102035 +-6.91105,0.989095,0.908714,2,7,0,7.59875,0.325457 +-7.43773,0.738257,0.908714,1,3,0,8.32822,0.125174 +-7.1226,1,0.908714,1,1,0,7.39692,0.15343 +-6.92882,0.937975,0.908714,2,3,0,7.66082,0.329662 +-6.77654,1,0.908714,2,3,0,6.89558,0.22097 +-6.77795,0.999678,0.908714,1,1,0,6.78426,0.220279 +-6.8047,0.994038,0.908714,1,1,0,6.80683,0.20957 +-6.96924,0.97475,0.908714,1,3,0,6.97033,0.173576 +-7.09012,0.978088,0.908714,1,1,0,7.10826,0.157179 +-8.02052,0.934383,0.908714,2,3,0,8.02402,0.473888 +-8.02052,0.598122,0.908714,1,1,0,9.28419,0.473888 +-6.99397,0.869143,0.908714,1,3,0,8.82627,0.169833 +-7.02538,0.994224,0.908714,1,1,0,7.06714,0.165401 +-6.778,0.95656,0.908714,2,3,0,7.42706,0.281404 +-6.75006,1,0.908714,1,3,0,6.77229,0.258039 +-7.22674,0.87445,0.908714,1,3,0,7.46003,0.1427 +-6.94689,0.942196,0.908714,1,3,0,7.82695,0.333746 +-6.74814,0.999227,0.908714,1,3,0,6.94141,0.24805 +-6.89367,0.782885,0.908714,2,3,0,8.25831,0.186897 +-6.75923,0.999039,0.908714,1,3,0,6.87521,0.2316 +-6.87657,0.966593,0.908714,1,3,0,6.94978,0.31664 +-6.76737,0.987823,0.908714,1,3,0,6.94763,0.225964 +-7.17051,0.900793,0.908714,1,3,0,7.34282,0.374685 +-6.88676,1,0.908714,2,7,0,7.10122,0.188304 +-7.68147,0.820702,0.908714,1,3,0,8.26649,0.440018 +-6.75178,1,0.908714,1,3,0,7.53182,0.260938 +-6.90883,0.965136,0.908714,1,3,0,6.92304,0.324916 +-6.98197,0.992929,0.908714,2,3,0,7.01388,0.341219 +-7.30649,0.812328,0.908714,1,3,0,8.211,0.135525 +-7.36624,0.990929,0.908714,1,1,0,7.4508,0.130614 +-6.81583,0.99202,0.908714,1,3,0,7.31404,0.205955 +-6.75621,0.994675,0.908714,1,3,0,6.8535,0.266221 +-7.13381,0.942594,0.908714,2,3,0,7.14829,0.152185 +-7.65037,0.922343,0.908714,1,1,0,7.65041,0.111191 +-7.49005,1,0.908714,1,1,0,7.70942,0.121453 +-6.77268,1,0.908714,2,3,0,7.32882,0.278418 +-6.77842,0.998472,0.908714,1,1,0,6.78362,0.281632 +-6.79256,0.98633,0.908714,1,3,0,6.87502,0.213988 +-6.76053,0.994638,0.908714,1,3,0,6.83367,0.270106 +-6.80113,0.989305,0.908714,1,1,0,6.80113,0.292131 +-6.75125,0.997222,0.908714,1,3,0,6.81724,0.240039 +-6.7523,0.999076,0.908714,2,3,0,6.75956,0.23856 +-6.97393,0.951209,0.908714,1,3,0,7.01985,0.172847 +-6.84669,0.972542,0.908714,1,3,0,7.25942,0.308061 +-7.24597,0.889437,0.908714,1,1,0,7.2462,0.386054 +-7.24597,0.490451,0.908714,1,1,0,8.73758,0.386054 +-8.44478,0.678847,0.908714,1,1,0,8.48264,0.510368 +-7.1973,1,0.908714,2,3,0,8.06937,0.378821 +-7.06249,1,0.908714,2,3,0,7.22405,0.35663 +-6.74912,0.99824,0.908714,1,3,0,7.06146,0.244171 +-6.86268,0.804464,0.908714,2,3,0,8.12593,0.193549 +-7.04836,0.961132,0.908714,2,3,0,7.24841,0.162354 +-6.99656,0.978929,0.908714,2,3,0,7.36365,0.169456 +-7.47928,0.956698,0.908714,2,7,0,7.48047,0.416898 +-7.18272,1,0.908714,1,1,0,7.47002,0.376585 +-7.71626,0.843994,0.908714,1,1,0,7.77836,0.443744 +-6.93061,1,0.908714,1,1,0,7.47656,0.330074 +-6.75287,1,0.908714,1,3,0,6.89865,0.262439 +-6.95222,0.955965,0.908714,1,3,0,6.96937,0.33492 +-6.94197,1,0.908714,1,1,0,7.0013,0.332653 +-6.87242,0.944841,0.908714,1,3,0,7.26765,0.191358 +-8.16288,0.798114,0.908714,1,3,0,8.43127,0.0862668 +-7.85211,1,0.908714,1,1,0,8.20928,0.100195 +-7.58781,1,0.908714,1,1,0,7.88452,0.115011 +-8.64279,0.899118,0.908714,2,3,0,9.22174,0.0696434 +-6.89814,0.964739,0.908714,2,7,0,8.23257,0.322266 +-6.76345,0.988855,0.908714,1,3,0,6.96055,0.228481 +-6.76345,0.60166,0.908714,1,3,0,9.12762,0.228481 +-6.84407,0.986038,0.908714,1,3,0,6.8463,0.198055 +-8.20745,0.771965,0.908714,1,3,0,8.54693,0.0845048 +-7.30362,0.842843,0.908714,1,3,0,10.1088,0.394212 +-7.19523,0.775857,0.908714,1,3,0,8.47836,0.145764 +-6.84902,0.992622,0.908714,1,3,0,7.1356,0.19681 +-6.80565,1,0.908714,1,1,0,6.84432,0.209246 +-6.88808,0.98265,0.908714,1,1,0,6.88912,0.188032 +-6.81184,1,0.908714,1,1,0,6.87405,0.207211 +-6.74853,0.998494,0.908714,1,3,0,6.8217,0.254007 +-7.23176,0.876868,0.908714,1,3,0,7.44636,0.142225 +-7.00773,1,0.908714,2,3,0,7.20145,0.16785 +-6.83243,0.665749,0.908714,2,3,0,10.9764,0.20113 +-6.87659,0.96949,0.908714,1,3,0,7.09033,0.316645 +-6.86175,1,0.908714,2,3,0,6.90034,0.312517 +-6.78375,0.975067,0.908714,2,3,0,7.02931,0.284362 +-6.90052,0.968288,0.908714,1,1,0,6.90064,0.322864 +-7.22292,0.90825,0.908714,1,1,0,7.23175,0.382672 +-8.60879,0.351257,0.908714,1,3,0,11.6041,0.0706709 +-6.84054,0.977626,0.908714,2,7,0,8.19522,0.306152 +-6.7522,0.993342,0.908714,2,3,0,6.88344,0.261547 +-6.76809,0.99836,0.908714,2,3,0,6.76809,0.225533 +-7.27371,0.760955,0.908714,2,3,0,8.40547,0.138381 +-7.39548,0.981538,0.908714,1,1,0,7.45793,0.128335 +-6.77782,0.997121,0.908714,1,3,0,7.38358,0.220345 +-8.39967,0.781608,0.908714,2,3,0,8.48011,0.0774578 +-7.94853,1,0.908714,1,1,0,8.41022,0.0955334 +-6.89382,0.981368,0.908714,1,3,0,7.90594,0.186867 +-7.00112,0.97936,0.908714,1,1,0,7.0105,0.168796 +-7.13666,0.962029,0.908714,2,3,0,7.47149,0.151873 +-9.42179,0.472929,0.908714,3,7,0,14.5051,0.0505387 +-7.10693,0.965086,0.908714,2,7,0,8.92172,0.364357 +-7.61817,0.851425,0.908714,1,1,0,7.66206,0.433062 +-7.61817,0.802485,0.908714,1,1,0,8.24578,0.433062 +-7.51469,1,0.908714,1,1,0,7.79959,0.421148 +-7.00339,1,0.908714,2,3,0,7.3763,0.345529 +-6.76181,0.987801,0.908714,1,3,0,7.06619,0.229638 +-7.18842,0.911935,0.908714,1,3,0,7.27663,0.146446 +-7.02123,1,0.908714,1,1,0,7.17693,0.165968 +-7.79957,0.827658,0.908714,1,3,0,8.69613,0.452412 +-6.76509,1,0.908714,1,3,0,7.58142,0.273555 +-6.76509,0.738206,0.908714,1,3,0,7.82013,0.273555 +-6.80571,0.989219,0.908714,1,1,0,6.80599,0.293971 +-8.55806,0.510835,0.908714,1,3,0,10.2116,0.072242 +-7.77979,1,0.908714,1,1,0,8.47835,0.103927 +-8.68101,0.968869,0.908714,2,3,0,8.68167,0.0685113 +-8.22121,1,0.908714,1,1,0,8.71416,0.0839714 +-7.08834,0.964573,0.908714,1,3,0,8.12704,0.157391 +-6.77717,0.973532,0.908714,1,3,0,7.26609,0.280957 +-6.79505,0.98469,0.908714,1,3,0,6.8774,0.213032 +-6.84232,0.976747,0.908714,1,3,0,6.9746,0.30671 +-6.80862,0.976131,0.908714,1,3,0,6.99911,0.208254 +-6.80862,0.546152,0.908714,1,3,0,9.72594,0.208254 +-7.04285,0.981404,0.908714,2,3,0,7.04576,0.353056 +-6.95663,1,0.908714,1,1,0,7.06087,0.335878 +-6.81332,0.939855,0.908714,2,3,0,7.313,0.296878 +-7.06268,0.931243,0.908714,1,1,0,7.06278,0.356665 +-7.79769,0.793679,0.908714,1,1,0,7.81875,0.452219 +-7.36192,1,0.908714,2,3,0,7.7802,0.40207 +-7.82005,0.954193,0.908714,2,3,0,7.94075,0.45449 +-7.74235,1,0.908714,1,1,0,8.0877,0.446496 +-6.88696,1,0.908714,2,3,0,7.60521,0.188262 +-6.8766,1,0.908714,1,1,0,6.91003,0.190447 +-7.05552,0.965777,0.908714,1,1,0,7.0568,0.161435 +-8.486,0.910009,0.908714,2,3,0,8.55768,0.513644 +-7.45189,1,0.908714,2,3,0,8.2455,0.413544 +-6.9774,1,0.908714,1,1,0,7.32243,0.340276 +-7.29049,0.784801,0.908714,2,7,0,8.17028,0.136904 +-6.80942,0.894275,0.908714,2,3,0,8.41977,0.207992 +-6.91112,0.97881,0.908714,1,1,0,6.91157,0.183511 +-7.0077,0.969929,0.908714,2,3,0,7.25196,0.167856 +-7.40787,0.933642,0.908714,1,1,0,7.40787,0.127393 +-7.57073,0.977189,0.908714,1,1,0,7.64061,0.116093 +-6.87537,0.91685,0.908714,1,3,0,8.2093,0.316315 +-7.4501,0.683694,0.908714,2,3,0,8.75695,0.413322 +-6.78028,1,0.908714,1,3,0,7.28608,0.282606 +-6.8814,0.951843,0.908714,2,3,0,7.07742,0.317936 +-6.8814,0.668561,0.908714,1,3,0,8.62627,0.317936 +-7.25552,0.894726,0.908714,1,1,0,7.25934,0.387434 +-9.7468,0.716678,0.908714,2,3,0,9.75147,0.598149 +-9.42958,1,0.908714,2,7,0,9.49002,0.050383 +-7.12587,0.955093,0.908714,1,3,0,9.6186,0.153063 +-6.98683,1,0.908714,1,1,0,7.11845,0.17089 +-6.82892,0.881548,0.908714,2,3,0,8.05898,0.202103 +-6.76443,0.996099,0.908714,2,3,0,6.86468,0.227823 +-6.79927,0.986253,0.908714,1,3,0,6.85551,0.291366 +-7.5089,0.745061,0.908714,2,3,0,8.26529,0.120162 +-6.75489,0.99426,0.908714,1,3,0,7.57866,0.235543 +-6.7867,0.992781,0.908714,2,3,0,6.81215,0.216352 +-9.57855,0.643629,0.908714,2,3,0,9.60821,0.0475095 +-6.86355,1,0.908714,2,3,0,9.18567,0.193349 +-6.91066,0.990508,0.908714,1,1,0,6.92482,0.183598 +-7.20224,0.792619,0.908714,2,3,0,8.67486,0.14507 +-6.8246,0.993136,0.908714,1,3,0,7.14534,0.203334 +-6.7484,0.89603,0.908714,2,3,0,7.71981,0.246566 +-7.38449,0.8756,0.908714,2,3,0,7.70514,0.405018 +-8.03126,0.8108,0.908714,1,1,0,8.14051,0.474883 +-8.21238,0.942001,0.908714,1,1,0,8.58411,0.491059 +-6.77435,0.973635,0.908714,2,3,0,8.48288,0.222072 +-7.4589,0.865226,0.908714,1,3,0,7.61502,0.123643 +-6.83063,0.932501,0.908714,2,7,0,7.93244,0.302946 +-6.99395,0.885354,0.908714,2,3,0,7.49169,0.34365 +-6.99395,0.798005,0.908714,1,3,0,7.89523,0.34365 +-7.43536,0.71824,0.908714,1,3,0,8.49534,0.125347 +-7.74984,0.958068,0.908714,1,1,0,7.78968,0.105539 +-6.89265,0.990056,0.908714,2,7,0,7.5427,0.320873 +-6.89265,0.550213,0.908714,1,3,0,9.40337,0.320873 +-7.79507,0.676177,0.908714,1,3,0,8.98811,0.103121 +-7.07148,0.975104,0.908714,1,3,0,7.693,0.159436 +-7.39971,0.947033,0.908714,1,1,0,7.40468,0.128012 +-7.90299,0.934161,0.908714,1,1,0,7.91389,0.0976926 +-8.65802,0.924381,0.908714,1,1,0,8.66977,0.0691892 +-9.21258,0.957744,0.908714,1,1,0,9.29525,0.0549516 +-9.04738,1,0.908714,1,1,0,9.42482,0.0587723 +-7.35321,0.939807,0.908714,1,3,0,8.98756,0.131654 +-6.82224,0.994909,0.908714,2,3,0,7.407,0.204021 +-6.97304,0.969418,0.908714,1,1,0,6.97304,0.172986 +-6.74861,1,0.908714,2,3,0,6.94018,0.254313 +-7.0768,0.63347,0.908714,2,3,0,9.34757,0.158784 +-7.18864,0.993672,0.908714,2,3,0,7.22464,0.146424 +-7.60022,0.8546,0.908714,1,3,0,8.75127,0.431045 +-6.90251,1,0.908714,1,1,0,7.38904,0.323359 +-7.41937,0.855759,0.908714,1,1,0,7.42212,0.409481 +-9.79054,0.461021,0.908714,1,1,0,9.81688,0.600653 +-7.16347,1,0.908714,2,3,0,8.942,0.373579 +-7.01203,1,0.908714,1,1,0,7.16854,0.347221 +-6.83641,0.955169,0.908714,1,3,0,7.27663,0.200051 +-6.79662,0.984361,0.908714,1,3,0,6.96527,0.290248 +-7.02116,0.894083,0.908714,2,3,0,7.42908,0.348982 +-6.75609,1,0.908714,1,3,0,6.96946,0.266101 +-6.82245,0.986625,0.908714,1,3,0,6.82387,0.300159 +-7.7373,0.683024,0.908714,1,3,0,8.66388,0.106225 +-7.52727,1,0.908714,1,1,0,7.78194,0.118927 +-6.80467,0.99303,0.908714,1,3,0,7.49888,0.209581 +-6.86328,0.995849,0.908714,2,3,0,6.86601,0.193412 +-6.7527,1,0.908714,2,3,0,6.84135,0.262221 +-6.89757,0.968179,0.908714,1,3,0,6.90889,0.322123 +-6.7829,0.971235,0.908714,2,3,0,7.09147,0.283942 +-6.76687,1,0.908714,1,1,0,6.78086,0.274774 +-7.56409,0.874398,0.908714,2,3,0,7.57617,0.116518 +# +# Elapsed Time: 0.005 seconds (Warm-up) +# 0.005 seconds (Sampling) +# 0.01 seconds (Total) +# diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_default.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_default.csv new file mode 100644 index 0000000000..d45074864f --- /dev/null +++ b/src/test/unit/mcmc/test_csv_files/bernoulli_default.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-07-20 18:56:30 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 = examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 3635036313 (Default) +# output +# file = bernoulli_out.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-25-gbb9ce42 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +# Adaptation terminated +# Step size = 0.932037 +# Diagonal elements of inverse mass matrix: +# 0.591014 +-7.81355,0.761218,0.932037,1,3,0,8.13669,0.102158 +-8.71049,0.894869,0.932037,1,1,0,8.72268,0.0676546 +-7.3531,0.957519,0.932037,1,3,0,8.53469,0.131664 +-7.02007,1,0.932037,1,1,0,7.29505,0.166128 +-8.49033,0.716959,0.932037,1,3,0,9.20407,0.513986 +-7.18724,1,0.932037,1,1,0,8.06459,0.377282 +-10.0621,0.636916,0.932037,2,3,0,10.0852,0.615706 +-8.11851,1,0.932037,1,1,0,9.65805,0.482811 +-6.86936,0.948809,0.932037,2,3,0,8.60097,0.192035 +-7.13756,0.935492,0.932037,2,3,0,7.43717,0.151774 +-7.09122,1,0.932037,1,1,0,7.19518,0.157048 +-6.91669,1,0.932037,1,1,0,7.06383,0.182475 +-6.76371,0.840542,0.932037,2,3,0,8.08838,0.228308 +-6.84805,0.983351,0.932037,1,3,0,6.84861,0.197051 +-8.3727,0.653843,0.932037,2,3,0,9.53079,0.504537 +-7.25928,0.806553,0.932037,1,3,0,9.43963,0.139678 +-6.95987,0.853051,0.932037,2,3,0,9.71446,0.175062 +-6.95334,1,0.932037,1,1,0,7.00708,0.17612 +-6.98417,0.993206,0.932037,1,1,0,7.02663,0.171288 +-8.9535,0.727406,0.932037,1,3,0,9.27425,0.0610911 +-7.08162,0.995936,0.932037,2,3,0,9.00617,0.158197 +-7.16691,0.98306,0.932037,1,1,0,7.22238,0.148646 +-6.8898,1,0.932037,1,1,0,7.10684,0.18768 +-7.8902,0.846547,0.932037,1,3,0,7.96857,0.0983126 +-7.24239,1,0.932037,1,1,0,7.78446,0.14123 +-7.94748,0.888836,0.932037,1,1,0,7.94857,0.0955821 +-6.83694,0.864212,0.932037,2,3,0,8.91495,0.305006 +-6.83694,0.425574,0.932037,1,3,0,9.01249,0.305006 +-6.80131,0.985852,0.932037,1,3,0,6.93894,0.210747 +-6.74824,0.978446,0.932037,2,3,0,6.95179,0.252645 +-6.74832,0.945401,0.932037,2,3,0,7.0277,0.24694 +-6.85442,0.972221,0.932037,1,3,0,6.87104,0.310384 +-6.86406,0.996818,0.932037,1,1,0,6.89618,0.313175 +-7.11238,0.918504,0.932037,1,1,0,7.12695,0.365274 +-7.11238,0.431368,0.932037,1,1,0,8.53302,0.365274 +-6.79843,1,0.932037,1,1,0,7.00834,0.291015 +-6.74804,0.996585,0.932037,2,3,0,6.81732,0.249269 +-9.50952,0.509265,0.932037,1,3,0,9.67564,0.584141 +-8.27778,1,0.932037,1,1,0,9.48419,0.496645 +-7.2527,1,0.932037,2,3,0,8.04703,0.140278 +-6.75205,0.907555,0.932037,2,3,0,8.25548,0.238895 +-7.3411,0.857468,0.932037,1,3,0,7.42326,0.399305 +-7.07094,1,0.932037,1,1,0,7.32247,0.358137 +-7.04767,0.556206,0.932037,2,3,0,9.56585,0.353943 +-6.87625,1,0.932037,2,3,0,6.9975,0.190522 +-7.12535,0.945777,0.932037,1,1,0,7.12652,0.153122 +-7.12535,0.913353,0.932037,1,1,0,7.53634,0.153122 +-6.78755,1,0.932037,2,3,0,7.04258,0.286194 +-7.7545,0.780448,0.932037,1,3,0,7.76329,0.447766 +-6.77502,0.859809,0.932037,2,3,0,8.49845,0.221729 +-7.19668,0.726665,0.932037,2,3,0,8.64609,0.145619 +-9.64819,0.775506,0.932037,2,3,0,10.0305,0.0462333 +-6.86272,0.7808,0.932037,1,3,0,10.9403,0.312792 +-6.99329,0.696273,0.932037,2,3,0,8.30815,0.343519 +-6.99329,0.700745,0.932037,1,1,0,7.63428,0.343519 +-7.11558,0.957857,0.932037,1,1,0,7.18108,0.365809 +-6.80487,1,0.932037,2,3,0,7.09376,0.209509 +-6.97334,0.955154,0.932037,2,3,0,7.16146,0.17294 +-7.2664,0.98044,0.932037,2,3,0,7.27318,0.139035 +-7.06819,1,0.932037,2,3,0,7.25815,0.159843 +-6.74803,0.991749,0.932037,1,3,0,7.05576,0.250595 +-7.05542,0.823118,0.932037,2,3,0,7.78068,0.161448 +-6.89251,1,0.932037,1,1,0,7.02757,0.18713 +-6.76584,0.932575,0.932037,2,3,0,7.49343,0.22691 +-6.75064,0.997924,0.932037,2,3,0,6.78013,0.241023 +-6.91371,0.96173,0.932037,1,3,0,6.93351,0.183027 +-6.74953,0.994131,0.932037,1,3,0,6.91533,0.256915 +-8.33302,0.635332,0.932037,1,3,0,9.05105,0.0798054 +-8.04729,1,0.932037,1,1,0,8.43889,0.0910907 +-8.42015,0.956552,0.932037,1,1,0,8.53727,0.0767553 +-7.91154,1,0.932037,1,1,0,8.4304,0.0972813 +-7.65791,1,0.932037,1,1,0,7.97836,0.110745 +-7.97869,0.955317,0.932037,1,1,0,8.06587,0.0941427 +-6.81845,1,0.932037,1,3,0,7.88771,0.205153 +-6.76575,0.914099,0.932037,2,3,0,7.34829,0.274011 +-6.74964,0.996733,0.932037,2,3,0,6.78491,0.257167 +-6.77106,0.99494,0.932037,1,3,0,6.77141,0.27745 +-6.77106,0.945747,0.932037,1,3,0,6.92649,0.27745 +-6.77106,0.856062,0.932037,1,3,0,7.35372,0.27745 +-6.88028,0.948865,0.932037,2,3,0,7.03829,0.18966 +-7.33958,0.635769,0.932037,2,3,0,9.861,0.132761 +-8.06974,0.890942,0.932037,1,1,0,8.07292,0.0901234 +-6.97186,0.998838,0.932037,1,3,0,7.91764,0.173168 +-6.76939,0.981956,0.932037,1,3,0,7.03238,0.276417 +-7.44177,0.80944,0.932037,1,3,0,7.79154,0.124879 +-8.01591,0.972061,0.932037,2,3,0,8.03736,0.0924685 +-9.92045,0.865258,0.932037,2,3,0,9.92397,0.607959 +-7.31963,1,0.932037,2,3,0,10.3209,0.134414 +-6.9789,1,0.932037,1,1,0,7.25409,0.172086 +-7.21981,0.951312,0.932037,1,1,0,7.23197,0.143362 +-7.47612,0.930523,0.932037,2,3,0,8.12075,0.122424 +-6.81131,0.990375,0.932037,2,3,0,7.55719,0.207381 +-6.80278,0.920389,0.932037,2,3,0,7.43635,0.210229 +-6.88803,0.979103,0.932037,1,1,0,6.89063,0.188041 +-7.02902,0.795987,0.932037,2,3,0,8.6993,0.164908 +-6.74805,0.993012,0.932037,1,3,0,7.01716,0.250947 +-6.93322,0.952905,0.932037,1,3,0,6.95228,0.330673 +-6.76781,0.904559,0.932037,2,3,0,7.33629,0.275396 +-6.76232,0.985564,0.932037,2,3,0,6.83656,0.271521 +-6.87137,0.974516,0.932037,1,3,0,6.87148,0.31522 +-7.21556,0.953187,0.932037,2,3,0,7.22785,0.381575 +-6.76367,0.998041,0.932037,1,3,0,7.1984,0.228336 +-6.82308,0.981349,0.932037,1,3,0,6.86896,0.30038 +-6.82308,0.352125,0.932037,1,3,0,10.8402,0.30038 +-6.99474,0.738309,0.932037,2,3,0,8.0486,0.34381 +-6.99474,0.963463,0.932037,1,1,0,7.1311,0.34381 +-6.8637,0.713515,0.932037,2,3,0,8.29356,0.313071 +-6.94178,0.974091,0.932037,1,1,0,6.96832,0.332611 +-6.80481,1,0.932037,2,3,0,6.9081,0.209531 +-6.92327,0.971351,0.932037,1,1,0,6.92425,0.181278 +-7.1233,0.957499,0.932037,1,1,0,7.13244,0.153351 +-6.76778,0.973133,0.932037,1,3,0,7.19571,0.275378 +-6.90939,0.888041,0.932037,2,3,0,7.29419,0.325052 +-7.3757,0.927908,0.932037,2,3,0,7.37586,0.129868 +-7.33194,1,0.932037,1,1,0,7.48008,0.133389 +-6.86262,0.893077,0.932037,2,3,0,9.38827,0.193563 +-6.74929,0.996117,0.932037,1,3,0,6.86347,0.256335 +-6.74964,0.943201,0.932037,2,3,0,7.03592,0.242941 +-6.9015,0.968295,0.932037,2,3,0,6.96204,0.18535 +-7.81106,0.864491,0.932037,1,3,0,7.86554,0.102287 +-8.616,0.90424,0.932037,1,1,0,8.63659,0.0704513 +-8.16761,1,0.932037,1,1,0,8.67561,0.0860773 +-6.96545,1,0.932037,1,3,0,8.01828,0.174173 +-6.75813,1,0.932037,1,3,0,6.92669,0.232517 +-6.75424,1,0.932037,1,1,0,6.75812,0.236232 +-7.76056,0.503853,0.932037,2,3,0,10.2889,0.104957 +-7.12518,1,0.932037,1,1,0,7.64631,0.153141 +-7.67249,0.905419,0.932037,1,1,0,7.67491,0.109892 +-7.63881,1,0.932037,1,1,0,7.83222,0.11188 +-7.3844,0.889767,0.932037,1,3,0,8.80917,0.405007 +-6.76719,1,0.932037,1,3,0,7.348,0.226074 +-7.47953,0.852161,0.932037,1,3,0,7.59716,0.122185 +-7.42386,1,0.932037,2,3,0,7.59422,0.126195 +-7.91668,0.975432,0.932037,2,3,0,7.94672,0.0970356 +-6.83066,1,0.932037,2,3,0,7.62924,0.302955 +-6.96269,0.956934,0.932037,1,1,0,6.97473,0.337182 +-6.74847,0.963031,0.932037,2,3,0,7.15706,0.253745 +-6.80708,0.988647,0.932037,2,3,0,6.82289,0.208765 +-6.91792,0.9732,0.932037,1,1,0,6.91947,0.18225 +-6.84983,1,0.932037,2,3,0,6.91467,0.196611 +-6.88905,0.990653,0.932037,1,1,0,6.90679,0.187834 +-7.15463,0.975663,0.932037,2,3,0,7.16,0.372177 +-6.9586,1,0.932037,1,1,0,7.13267,0.336303 +-7.56708,0.803851,0.932037,1,1,0,7.59178,0.42727 +-6.76736,1,0.932037,1,3,0,7.31987,0.275105 +-6.80123,0.959699,0.932037,2,3,0,6.95431,0.292173 +-6.80123,0.759564,0.932037,1,3,0,7.84546,0.292173 +-6.80123,0.902778,0.932037,1,3,0,7.20675,0.292173 +-6.80123,0.96482,0.932037,1,1,0,6.88076,0.292173 +-6.78299,0.988689,0.932037,2,3,0,6.88032,0.217954 +-7.1107,0.936673,0.932037,1,3,0,7.12632,0.154778 +-7.31567,0.961429,0.932037,1,1,0,7.35195,0.134747 +-7.07455,0.968694,0.932037,2,3,0,7.7776,0.159058 +-6.74831,0.993779,0.932037,1,3,0,7.05357,0.247022 +-6.84249,0.975275,0.932037,1,3,0,6.85756,0.306763 +-6.88224,0.995647,0.932037,2,3,0,6.90622,0.31816 +-8.68021,0.668585,0.932037,2,3,0,8.68611,0.0685348 +-7.80603,1,0.932037,1,1,0,8.5851,0.102548 +-7.27572,1,0.932037,1,1,0,7.73044,0.138203 +-8.91337,0.902662,0.932037,2,3,0,9.15324,0.545374 +-7.22471,0.840347,0.932037,1,3,0,9.85532,0.142893 +-7.57214,0.980256,0.932037,2,3,0,7.60142,0.116002 +-7.46188,1,0.932037,1,1,0,7.66831,0.123431 +-7.21293,1,0.932037,1,1,0,7.46083,0.144026 +-7.27196,0.911127,0.932037,1,3,0,8.06683,0.389783 +-6.99285,1,0.932037,1,1,0,7.22442,0.343431 +-7.64686,0.789204,0.932037,1,1,0,7.67915,0.436243 +-7.64686,0.588674,0.932037,1,1,0,8.70948,0.436243 +-6.76317,0.84811,0.932037,2,3,0,8.40171,0.228672 +-6.75852,0.995961,0.932037,2,3,0,6.79457,0.232184 +-6.96185,0.956175,0.932037,2,3,0,7.06538,0.174745 +-6.7597,0.95957,0.932037,2,3,0,7.23201,0.269421 +-6.95356,0.940807,0.932037,1,3,0,7.05195,0.176085 +-6.74802,0.995879,0.932037,1,3,0,6.94105,0.250316 +-6.80409,0.985416,0.932037,1,3,0,6.81492,0.209778 +-6.78431,0.93291,0.932037,2,3,0,7.30965,0.217376 +-6.85124,0.98309,0.932037,1,1,0,6.85256,0.196264 +-6.91874,0.970098,0.932037,1,3,0,7.11707,0.327302 +-6.91874,0.434093,0.932037,1,3,0,9.39656,0.327302 +-6.92998,0.940657,0.932037,2,3,0,7.25758,0.180084 +-6.7616,0.987015,0.932037,1,3,0,6.96899,0.270965 +-6.77385,0.996249,0.932037,1,1,0,6.77617,0.279101 +-7.11956,0.891801,0.932037,1,3,0,7.32561,0.153771 +-7.10361,0.938678,0.932037,1,3,0,7.72046,0.363797 +-7.10361,0.642361,0.932037,1,1,0,7.89438,0.363797 +-8.5001,0.593919,0.932037,1,1,0,8.53813,0.514754 +-7.1692,1,0.932037,2,3,0,8.39313,0.148408 +-6.99964,1,0.932037,2,3,0,7.15856,0.169008 +-6.82605,1,0.932037,1,1,0,6.95904,0.202915 +-6.80069,1,0.932037,1,1,0,6.8286,0.210965 +-6.80069,0.826864,0.932037,1,3,0,7.56839,0.210965 +-6.80069,0.712989,0.932037,1,3,0,8.08135,0.210965 +-6.79864,1,0.932037,1,1,0,6.81323,0.211702 +-7.21975,0.922333,0.932037,1,3,0,7.24006,0.143367 +-6.75061,0.978686,0.932037,1,3,0,7.23991,0.259057 +-8.50882,0.710206,0.932037,2,3,0,8.58833,0.0738116 +-6.98994,1,0.932037,1,3,0,8.37388,0.170428 +-8.68191,0.796805,0.932037,2,3,0,9.47091,0.528667 +-7.31609,1,0.932037,2,3,0,8.2644,0.395923 +-7.14381,1,0.932037,1,1,0,7.36712,0.370442 +-7.14381,0.475525,0.932037,1,1,0,8.41075,0.370442 +-7.29505,0.813437,0.932037,2,3,0,8.20133,0.136508 +-7.97276,0.895575,0.932037,1,1,0,7.97663,0.0944136 +-9.00874,0.888587,0.932037,1,1,0,9.0167,0.0597133 +-8.5484,1,0.932037,1,1,0,9.10361,0.0725465 +-7.88735,1,0.932037,1,1,0,8.51142,0.0984513 +-7.36782,1,0.932037,1,1,0,7.8262,0.130489 +-7.34887,1,0.932037,1,1,0,7.48713,0.132005 +-6.81839,0.987631,0.932037,2,3,0,7.46646,0.205169 +-6.81839,0.712592,0.932037,1,3,0,8.16085,0.205169 +-6.74807,0.998893,0.932037,1,3,0,6.81316,0.251268 +-6.87013,0.959268,0.932037,2,3,0,6.97825,0.314875 +-6.76585,1,0.932037,1,1,0,6.83725,0.274086 +-6.7566,0.994396,0.932037,2,3,0,6.80045,0.233869 +-6.7566,0.628726,0.932037,1,3,0,8.7002,0.233869 +-6.82277,0.986161,0.932037,1,3,0,6.82387,0.203864 +-7.3013,0.877627,0.932037,1,3,0,7.5333,0.393891 +-8.78447,0.79108,0.932037,2,3,0,8.87542,0.536201 +-7.50584,1,0.932037,1,1,0,8.46306,0.420094 +-7.15669,1,0.932037,1,1,0,7.48033,0.372505 +-7.43591,0.967588,0.932037,2,3,0,7.54437,0.411558 +-6.96987,0.913229,0.932037,1,3,0,7.88228,0.173478 +-6.89773,1,0.932037,1,1,0,6.97541,0.186089 +-7.36158,0.930716,0.932037,1,3,0,7.36402,0.130984 +-7.16589,1,0.932037,1,1,0,7.37174,0.148752 +-6.95869,1,0.932037,1,1,0,7.13528,0.175252 +-7.16168,0.929564,0.932037,1,3,0,7.57434,0.373296 +-8.02154,0.725795,0.932037,1,1,0,8.09574,0.473982 +-8.63423,0.930003,0.932037,2,3,0,9.03662,0.52509 +-6.93887,1,0.932037,1,1,0,8.0172,0.331956 +-6.87271,1,0.932037,1,1,0,6.94734,0.315589 +-6.77339,1,0.932037,2,3,0,6.85408,0.222571 +-6.98298,0.942095,0.932037,1,3,0,7.07789,0.341427 +-6.75868,1,0.932037,1,3,0,6.91623,0.268536 +-6.7906,0.973381,0.932037,2,3,0,6.88716,0.2876 +-7.56742,0.820209,0.932037,1,3,0,7.57193,0.427309 +-6.75108,1,0.932037,1,3,0,7.35001,0.259868 +-6.80655,0.983396,0.932037,1,3,0,6.83092,0.208942 +-6.91728,0.973208,0.932037,1,1,0,6.91879,0.182366 +-7.7691,0.915431,0.932037,2,3,0,7.98664,0.449282 +-6.765,1,0.932037,1,3,0,7.46164,0.273492 +-7.37311,0.856184,0.932037,1,3,0,7.3856,0.403538 +-7.3305,1,0.932037,1,1,0,7.55404,0.39788 +-7.3305,0.663523,0.932037,1,1,0,8.12143,0.39788 +-7.12567,0.837343,0.932037,1,3,0,8.09517,0.153086 +-7.15885,0.957841,0.932037,2,3,0,7.71194,0.149489 +-6.75049,0.994782,0.932037,1,3,0,7.12461,0.241282 +-6.81461,0.982255,0.932037,1,3,0,6.83366,0.297352 +-6.75614,0.996516,0.932037,1,3,0,6.83027,0.234298 +-6.74853,0.904663,0.932037,2,3,0,7.2911,0.246039 +-7.01677,0.911602,0.932037,2,3,0,7.26139,0.348138 +-6.92929,0.642216,0.932037,2,3,0,8.77716,0.32977 +-7.65529,0.771289,0.932037,1,1,0,7.66932,0.43717 +-7.01834,1,0.932037,1,1,0,7.46402,0.348441 +-6.74897,1,0.932037,1,3,0,6.95557,0.255474 +-9.81129,0.348606,0.932037,1,3,0,11.6845,0.0433987 +-10.4379,0.964322,0.932037,1,1,0,10.6078,0.0342236 +-12.3737,0.923455,0.932037,1,1,0,12.3737,0.0170254 +-8.6914,0.906628,0.932037,1,3,0,12.5921,0.0682079 +-7.8205,1,0.932037,1,1,0,8.59832,0.1018 +-6.76573,0.925015,0.932037,1,3,0,8.00716,0.274002 +-7.18424,0.803585,0.932037,2,3,0,7.86457,0.146867 +-6.74867,0.98391,0.932037,1,3,0,7.18696,0.254535 +-6.74867,0.809678,0.932037,1,3,0,7.5541,0.254535 +-6.78928,0.864392,0.932037,2,3,0,7.45892,0.21529 +-7.73008,0.857073,0.932037,2,3,0,7.95215,0.106623 +-6.90924,0.999548,0.932037,1,3,0,7.59486,0.183866 +-6.83204,1,0.932037,1,1,0,6.89889,0.201236 +-6.92095,0.978894,0.932037,1,1,0,6.92784,0.181697 +-6.84946,1,0.932037,1,1,0,6.91633,0.196703 +-6.87329,0.97872,0.932037,1,3,0,7.05429,0.315746 +-7.77797,0.726161,0.932037,1,1,0,7.77978,0.450197 +-7.91451,0.983052,0.932037,2,3,0,8.2695,0.463836 +-6.99541,0.905965,0.932037,1,3,0,8.38798,0.169623 +-6.76541,0.9819,0.932037,1,3,0,7.04888,0.273777 +-6.75969,1,0.932037,1,1,0,6.76622,0.269411 +-6.88511,0.980043,0.932037,2,3,0,6.89657,0.188645 +-6.77682,0.92494,0.932037,2,3,0,7.55206,0.220831 +-7.22693,0.885941,0.932037,1,3,0,7.36359,0.383265 +-7.08301,1,0.932037,2,3,0,7.27,0.360257 +-6.74807,1,0.932037,1,3,0,7.01313,0.251185 +-6.78184,0.991048,0.932037,1,3,0,6.7889,0.218469 +-7.7414,0.782413,0.932037,1,3,0,7.94246,0.446396 +-8.34868,0.79224,0.932037,1,1,0,8.64598,0.502563 +-6.96656,1,0.932037,1,1,0,7.85206,0.338006 +-8.55062,0.559382,0.932037,1,1,0,8.55696,0.518696 +-8.71259,0.939683,0.932037,1,1,0,9.36157,0.530944 +-7.02011,1,0.932037,1,1,0,8.0992,0.34878 +-7.73032,0.771978,0.932037,1,1,0,7.7681,0.445231 +-7.58699,1,0.932037,1,1,0,7.95753,0.429546 +-10.1664,0.37457,0.932037,1,1,0,10.2962,0.621272 +-9.05941,1,0.932037,2,3,0,10.4928,0.555399 +-6.95163,0.994678,0.932037,1,3,0,9.25144,0.176401 +-6.991,0.991344,0.932037,1,1,0,7.03106,0.170271 +-6.93665,1,0.932037,1,1,0,7.01246,0.178921 +-7.53693,0.951931,0.932037,2,3,0,7.60421,0.42377 +-7.35042,1,0.932037,1,1,0,7.65542,0.400548 +-6.74833,1,0.932037,1,3,0,7.21002,0.253091 +-7.30096,0.866757,0.932037,1,3,0,7.34306,0.393844 +-7.33424,0.995938,0.932037,2,3,0,7.52117,0.398384 +-7.00834,1,0.932037,1,1,0,7.27119,0.346501 +-7.00834,0.750927,0.932037,1,3,0,7.93882,0.346501 +-6.85276,0.717415,0.932037,2,3,0,8.2801,0.309891 +-6.88149,0.915088,0.932037,2,3,0,7.26489,0.189404 +-7.01531,0.954346,0.932037,2,3,0,7.30842,0.166787 +-8.49716,0.821021,0.932037,2,3,0,8.90444,0.0741898 +-7.75198,1,0.932037,2,3,0,8.42455,0.105422 +-6.78374,0.995713,0.932037,1,3,0,7.67855,0.217625 +-6.78319,0.955918,0.932037,2,3,0,7.05067,0.284087 +-6.76877,0.993356,0.932037,2,3,0,6.83116,0.225131 +-6.76604,1,0.932037,2,3,0,6.77242,0.226786 +-6.80257,0.828664,0.932037,2,3,0,7.81548,0.210302 +-6.7921,0.928548,0.932037,2,3,0,7.34502,0.214164 +-6.7921,0.869785,0.932037,1,3,0,7.3846,0.214164 +-6.78247,1,0.932037,1,1,0,6.7969,0.218184 +-6.77338,0.944315,0.932037,2,3,0,7.11056,0.278828 +-6.88767,0.984579,0.932037,2,3,0,6.89149,0.188115 +-6.87758,1,0.932037,1,1,0,6.91573,0.190237 +-6.98427,0.975828,0.932037,1,1,0,6.997,0.171274 +-8.16006,0.847199,0.932037,1,3,0,8.23533,0.0863802 +-6.92926,1,0.932037,1,3,0,8.02086,0.180209 +-6.75334,1,0.932037,1,3,0,6.89875,0.237258 +-6.76157,0.984481,0.932037,2,3,0,6.84166,0.270942 +-6.77437,0.916298,0.932037,2,3,0,7.16943,0.222065 +-6.89883,0.966797,0.932037,2,3,0,7.01941,0.185873 +-7.61554,0.929243,0.932037,2,3,0,7.77465,0.432768 +-6.74865,1,0.932037,1,3,0,7.4327,0.2456 +-7.90889,0.736401,0.932037,1,3,0,8.30046,0.0974084 +-7.36433,1,0.932037,1,1,0,7.84078,0.130766 +-6.7517,1,0.932037,2,3,0,7.32628,0.239385 +-7.47731,0.835796,0.932037,1,3,0,7.65004,0.122341 +-6.82682,1,0.932037,1,3,0,7.36972,0.202696 +-6.75257,1,0.932037,1,3,0,6.81023,0.238212 +-6.74814,0.924039,0.932037,2,3,0,7.16556,0.251902 +-6.77547,0.992637,0.932037,1,3,0,6.7818,0.221503 +-6.77883,0.96017,0.932037,2,3,0,7.01271,0.281846 +-6.83214,0.92718,0.932037,2,3,0,7.10706,0.303446 +-6.74855,0.999857,0.932037,1,3,0,6.82323,0.245948 +-6.75208,0.991977,0.932037,2,3,0,6.79074,0.261375 +-6.74875,1,0.932037,2,3,0,6.7511,0.254796 +-6.76331,0.987877,0.932037,2,3,0,6.81164,0.228577 +-7.11253,0.925924,0.932037,1,3,0,7.14728,0.154568 +-7.33832,0.934594,0.932037,2,3,0,7.89183,0.132864 +-7.40317,0.891695,0.932037,1,3,0,8.40906,0.407422 +-6.83199,1,0.932037,2,3,0,7.43757,0.20125 +-6.83199,0.774019,0.932037,1,3,0,8.04658,0.20125 +-6.99888,0.961352,0.932037,1,1,0,7.00012,0.169119 +-6.76802,0.991205,0.932037,2,3,0,7.06627,0.225576 +-7.1899,0.912501,0.932037,1,3,0,7.23327,0.146297 +-7.0344,0.951025,0.932037,1,3,0,7.71962,0.351486 +-6.74861,0.964191,0.932037,2,3,0,7.23266,0.245744 +-6.9356,0.954146,0.932037,1,3,0,6.96807,0.179103 +-6.8766,1,0.932037,1,1,0,6.94182,0.190446 +-6.86303,0.963467,0.932037,2,3,0,7.17361,0.312881 +-6.89691,0.996253,0.932037,2,3,0,6.92839,0.321957 +-6.74898,0.989445,0.932037,2,3,0,6.95643,0.244562 +-6.75192,0.906807,0.932037,2,3,0,7.25324,0.239077 +-6.89356,0.962004,0.932037,1,3,0,6.92873,0.321106 +-6.8915,1,0.932037,1,1,0,6.93856,0.320577 +-8.04782,0.661095,0.932037,1,1,0,8.04944,0.476407 +-6.96778,1,0.932037,2,3,0,8.10818,0.173806 +-6.94531,0.967319,0.932037,1,3,0,7.30665,0.333397 +-6.79303,1,0.932037,1,1,0,6.89785,0.28869 +-6.75073,0.998473,0.932037,1,3,0,6.79703,0.240873 +-6.74807,0.922346,0.932037,2,3,0,7.17097,0.248807 +-6.79664,0.986959,0.932037,2,3,0,6.82676,0.290259 +-7.42084,0.890966,0.932037,2,3,0,7.44601,0.12642 +-7.07938,1,0.932037,1,1,0,7.36895,0.158469 +-6.76996,0.975074,0.932037,1,3,0,7.1524,0.27677 +-6.97097,0.781354,0.932037,2,3,0,7.8694,0.173307 +-7.45672,0.874497,0.932037,1,3,0,7.94747,0.41414 +-7.73982,0.898709,0.932037,1,1,0,7.95818,0.446231 +-6.75761,1,0.932037,1,3,0,7.45331,0.267571 +-6.75128,1,0.932037,2,3,0,6.75597,0.26018 +-6.74857,0.969275,0.932037,2,3,0,6.90378,0.245862 +-6.78162,0.964009,0.932037,2,3,0,6.94604,0.218566 +-6.94452,0.969782,0.932037,1,3,0,6.94577,0.177582 +-6.83464,1,0.932037,1,1,0,6.92359,0.200526 +-6.85125,0.978801,0.932037,2,3,0,7.03988,0.196263 +-8.70862,0.498506,0.932037,2,3,0,10.892,0.0677086 +-7.14422,0.988771,0.932037,1,3,0,8.54862,0.151051 +-8.22719,0.86569,0.932037,1,3,0,8.25029,0.083741 +-7.98302,1,0.932037,1,1,0,8.34174,0.0939456 +-7.66766,1,0.932037,1,1,0,8.02784,0.110173 +-8.24143,0.924458,0.932037,1,1,0,8.28161,0.0831957 +-7.67998,1,0.932037,1,1,0,8.20801,0.109457 +-7.87681,0.972029,0.932037,1,1,0,7.99803,0.0989677 +-6.74849,0.941373,0.932037,1,3,0,7.96721,0.253832 +-7.11836,0.837369,0.932037,2,3,0,7.62397,0.366273 +-6.79142,1,0.932037,2,3,0,7.01021,0.287974 +-6.77524,1,0.932037,1,1,0,6.79217,0.279893 +-6.79636,0.997801,0.932037,2,3,0,6.8016,0.290137 +-6.79636,0.948581,0.932037,1,1,0,6.90729,0.290137 +-6.87559,0.872276,0.932037,2,3,0,7.36427,0.316373 +-7.91757,0.674512,0.932037,1,3,0,8.87065,0.0969933 +-6.74935,0.935438,0.932037,1,3,0,8.03013,0.256485 +-6.74803,0.97594,0.932037,2,3,0,6.86976,0.250537 +-6.81513,0.982667,0.932037,1,3,0,6.82306,0.297542 +-7.49872,0.879887,0.932037,2,3,0,7.51782,0.120857 +-7.49872,0.948913,0.932037,1,1,0,7.85236,0.120857 +-8.04293,0.922216,0.932037,1,1,0,8.07282,0.0912801 +-7.35293,1,0.932037,2,3,0,7.93996,0.131677 +-7.35293,0.883408,0.932037,1,1,0,8.02395,0.131677 +-6.80493,1,0.932037,1,3,0,7.25923,0.209492 +-6.82698,0.998151,0.932037,2,3,0,6.83752,0.202651 +-6.88114,0.986899,0.932037,1,1,0,6.89144,0.189478 +-6.74827,0.964042,0.932037,2,3,0,7.17919,0.25277 +-6.93633,0.882605,0.932037,2,3,0,7.40536,0.178978 +-8.02922,0.766313,0.932037,1,3,0,8.54794,0.474694 +-6.88064,1,0.932037,1,1,0,7.62039,0.317732 +-6.99856,0.960668,0.932037,1,1,0,7.02674,0.344573 +-6.9205,1,0.932037,1,1,0,7.0171,0.327717 +-7.23497,0.895629,0.932037,1,1,0,7.26191,0.384449 +-6.81255,0.65863,0.932037,2,3,0,8.81442,0.296589 +-6.8557,0.986062,0.932037,1,1,0,6.86976,0.310763 +-6.8557,0.724177,0.932037,1,3,0,7.66358,0.310763 +-6.75301,0.997497,0.932037,1,3,0,6.85969,0.23766 +-9.62741,0.500859,0.932037,1,3,0,9.855,0.591191 +-7.2064,1,0.932037,2,3,0,8.74926,0.3802 +-6.75431,0.815869,0.932037,2,3,0,7.99167,0.264191 +-6.77251,0.990864,0.932037,2,3,0,6.80395,0.22304 +-7.81008,0.844756,0.932037,2,3,0,8.00316,0.102338 +-8.11847,0.959711,0.932037,1,1,0,8.22643,0.0880753 +-9.24757,0.890376,0.932037,2,3,0,10.2168,0.0541819 +-6.88942,0.799493,0.932037,1,3,0,10.3695,0.320039 +-6.88942,0.261019,0.932037,1,3,0,10.9724,0.320039 +-6.80124,0.870892,0.932037,2,3,0,7.43049,0.29218 +-6.74978,0.998863,0.932037,1,3,0,6.80164,0.242642 +-7.17245,0.854684,0.932037,2,3,0,7.6,0.374989 +-8.81972,0.538088,0.932037,1,1,0,8.86828,0.538741 +-7.40622,1,0.932037,2,3,0,8.5393,0.127518 +-7.26318,0.961918,0.932037,2,3,0,8.05474,0.139325 +-7.34728,0.984906,0.932037,1,1,0,7.43596,0.132134 +-6.86243,0.997387,0.932037,1,3,0,7.24798,0.193608 +-6.89308,0.975225,0.932037,1,3,0,7.09809,0.320982 +-7.32886,0.939094,0.932037,2,3,0,7.34307,0.397658 +-7.57152,0.913466,0.932037,1,1,0,7.74604,0.427779 +-6.94728,1,0.932037,1,1,0,7.36923,0.333835 +-6.81842,1,0.932037,1,1,0,6.91356,0.298735 +-6.76216,1,0.932037,2,3,0,6.80728,0.229381 +-6.85768,0.974601,0.932037,2,3,0,6.94204,0.194717 +-6.77062,0.988638,0.932037,1,3,0,6.90934,0.277178 +-6.91451,0.978923,0.932037,2,3,0,6.91452,0.326292 +-6.78227,1,0.932037,1,1,0,6.87294,0.283622 +-7.62346,0.806356,0.932037,1,3,0,7.63204,0.433652 +-6.83206,1,0.932037,1,1,0,7.34914,0.303417 +-7.29941,0.815839,0.932037,2,3,0,7.843,0.136132 +-7.31671,0.996885,0.932037,1,1,0,7.4311,0.134659 +-6.78343,0.991818,0.932037,2,3,0,7.37529,0.21776 +-6.86006,0.980687,0.932037,1,1,0,6.8608,0.194157 +-6.77605,1,0.932037,1,1,0,6.83853,0.221209 +-6.86042,0.973286,0.932037,1,3,0,6.93518,0.312134 +-6.75338,0.997358,0.932037,1,3,0,6.86494,0.237216 +-6.83799,0.976298,0.932037,1,3,0,6.868,0.305342 +-7.00374,0.713633,0.932037,2,3,0,8.19304,0.345598 +-6.75259,0.98344,0.932037,2,3,0,7.10169,0.238182 +-6.79496,0.987555,0.932037,1,3,0,6.81495,0.289538 +-6.9391,0.981259,0.932037,2,3,0,6.94195,0.332008 +-7.22517,0.904285,0.932037,1,1,0,7.25937,0.383004 +-7.21052,1,0.932037,1,1,0,7.37602,0.38082 +-6.75985,0.787087,0.932037,2,3,0,8.11836,0.269544 +-6.86031,0.946513,0.932037,2,3,0,7.03793,0.194099 +-8.19403,0.780681,0.932037,1,3,0,8.38612,0.0850298 +-6.7609,1,0.932037,2,3,0,7.87703,0.270409 +-6.95309,0.78127,0.932037,2,3,0,7.88077,0.176161 +-9.56705,0.565191,0.932037,1,3,0,10.2818,0.587604 +-6.75776,1,0.932037,1,3,0,8.93023,0.232834 +-6.77632,0.994978,0.932037,1,1,0,6.77679,0.221079 +-6.82265,0.996019,0.932037,2,3,0,6.82416,0.203899 +-6.89139,0.983404,0.932037,1,1,0,6.89889,0.187357 +-6.89139,0.777655,0.932037,1,3,0,8.12126,0.187357 +-7.13161,0.926877,0.932037,1,3,0,7.44089,0.36846 +-8.35546,0.633109,0.932037,1,1,0,8.40627,0.503122 +-7.06834,0.886614,0.932037,1,3,0,8.96147,0.159824 +-7.28399,0.958522,0.932037,1,1,0,7.31204,0.137472 +-7.28327,1,0.932037,1,1,0,7.40052,0.137535 +-7.93284,0.898826,0.932037,1,1,0,7.93762,0.0962692 +-7.81694,1,0.932037,1,1,0,8.08024,0.101983 +-7.6919,1,0.932037,1,1,0,7.94232,0.108772 +-6.76979,0.932315,0.932037,1,3,0,7.86435,0.276668 +-6.97696,0.966811,0.932037,2,3,0,6.99094,0.172382 +-7.49857,0.902721,0.932037,2,3,0,7.93254,0.120867 +-7.50324,0.999237,0.932037,1,1,0,7.65578,0.120547 +-6.91611,1,0.932037,2,3,0,7.33316,0.326673 +-6.74956,1,0.932037,1,3,0,6.89861,0.243108 +-8.35635,0.667972,0.932037,1,3,0,8.48862,0.503195 +-8.35709,0.999715,0.932037,1,1,0,8.94945,0.503256 +-7.01492,1,0.932037,2,3,0,8.49553,0.16684 +-7.08433,0.985549,0.932037,1,1,0,7.13054,0.157871 +-7.29556,0.986569,0.932037,2,3,0,7.32674,0.136464 +-6.82002,1,0.932037,2,3,0,7.16863,0.299304 +-6.82002,0.827599,0.932037,1,1,0,7.18527,0.299304 +-6.96415,0.766705,0.932037,2,3,0,7.8936,0.337494 +-7.10108,0.953204,0.932037,1,1,0,7.15511,0.363367 +-7.08567,1,0.932037,1,1,0,7.2067,0.36072 +-8.18465,0.665208,0.932037,1,1,0,8.22692,0.488652 +-6.98816,1,0.932037,2,3,0,8.27915,0.170692 +-6.9991,0.951104,0.932037,2,3,0,7.40622,0.344679 +-6.87003,0.959893,0.932037,1,3,0,7.2399,0.191886 +-8.86597,0.67165,0.932037,1,3,0,9.3173,0.0633574 +-9.22117,0.969943,0.932037,1,1,0,9.41531,0.0547614 +-10.3294,0.926924,0.932037,1,1,0,10.3727,0.0356412 +-8.32325,0.989504,0.932037,2,3,0,10.9313,0.0801578 +-8.85098,0.946649,0.932037,1,1,0,8.95519,0.0637563 +-9.31959,0.960963,0.932037,1,1,0,9.47897,0.0526385 +-10.3022,0.93649,0.932037,1,1,0,10.3691,0.0360059 +-10.3363,0.998194,0.932037,1,1,0,10.7444,0.0355494 +-7.06812,1,0.932037,2,3,0,10.0104,0.159851 +-7.09449,0.998201,0.932037,2,3,0,7.16215,0.156661 +-7.41044,0.941678,0.932037,1,1,0,7.42835,0.127199 +-6.74954,0.897451,0.932037,2,3,0,8.358,0.256927 +-7.01483,0.952044,0.932037,2,3,0,7.06471,0.166853 +-7.04361,0.949288,0.932037,1,3,0,7.50082,0.353197 +-6.84344,1,0.932037,1,1,0,6.98754,0.30706 +-6.76346,1,0.932037,1,1,0,6.81845,0.272378 +-6.77171,0.981093,0.932037,2,3,0,6.85292,0.277844 +-6.84864,0.975946,0.932037,1,1,0,6.84963,0.308656 +-6.79009,1,0.932037,1,1,0,6.8359,0.287368 +-7.3603,0.823525,0.932037,1,3,0,7.7309,0.131086 +-7.81047,0.929962,0.932037,1,1,0,7.84015,0.102318 +-7.78154,1,0.932037,1,1,0,7.99363,0.103835 +-6.7517,1,0.932037,2,3,0,7.65292,0.239378 +-6.78798,0.848042,0.932037,2,3,0,7.61324,0.21582 +-6.76,0.921142,0.932037,2,3,0,7.25211,0.269673 +-6.79557,0.983288,0.932037,2,3,0,6.85013,0.212834 +-7.19183,0.926349,0.932037,1,3,0,7.21025,0.146103 +-7.38792,0.988215,0.932037,2,3,0,7.43851,0.128917 +-6.96601,1,0.932037,2,3,0,7.30212,0.174084 +-7.05786,0.980406,0.932037,1,1,0,7.08973,0.161138 +-7.16196,0.993052,0.932037,2,3,0,7.20877,0.149163 +-6.77281,0.912405,0.932037,2,3,0,8.28922,0.22288 +-6.75974,1,0.932037,1,1,0,6.77054,0.2312 +-6.74904,0.896827,0.932037,2,3,0,7.34903,0.244397 +-6.99017,0.938166,0.932037,1,3,0,7.02613,0.342891 +-9.18272,0.444151,0.932037,1,1,0,9.18621,0.563582 +-7.27998,1,0.932037,1,1,0,8.53072,0.390916 +-6.81588,0.976625,0.932037,1,3,0,7.39388,0.205939 +-6.85158,0.981914,0.932037,1,3,0,6.98055,0.309541 +-7.61781,0.765141,0.932037,1,1,0,7.61874,0.433021 +-6.79258,0.997137,0.932037,1,3,0,7.61795,0.21398 +-8.09444,0.722711,0.932037,1,3,0,8.35089,0.48065 +-8.09444,0.731058,0.932037,1,1,0,9.00859,0.48065 +-8.96537,0.715603,0.932037,1,1,0,9.37304,0.548986 +-8.78035,1,0.932037,1,1,0,9.62889,0.535902 +-7.21874,0.836764,0.932037,1,3,0,9.71962,0.143465 +-6.75061,0.911636,0.932037,2,3,0,8.14176,0.241082 +-7.65204,0.639147,0.932037,2,3,0,8.88575,0.436812 +-6.95151,1,0.932037,1,1,0,7.42019,0.334765 +-7.03245,0.89047,0.932037,2,3,0,7.4925,0.164448 +-6.93323,1,0.932037,1,1,0,7.03482,0.179514 +-6.93323,0.839701,0.932037,1,3,0,7.95662,0.179514 +-6.8181,1,0.932037,1,1,0,6.90794,0.205258 +-6.96817,0.964576,0.932037,1,1,0,6.96901,0.173744 +-6.75177,1,0.932037,2,3,0,6.94088,0.260926 +-6.75748,0.994596,0.932037,2,3,0,6.77947,0.267449 +-6.75598,1,0.932037,2,3,0,6.75911,0.265983 +-7.35596,0.838068,0.932037,1,3,0,7.60728,0.131434 +-6.75779,0.906448,0.932037,2,3,0,8.09794,0.267737 +-6.83162,0.952059,0.932037,2,3,0,6.9908,0.303273 +-7.67816,0.806003,0.932037,1,3,0,7.67819,0.43966 +-6.92603,0.932427,0.932037,1,3,0,8.01057,0.180783 +-7.07054,0.950192,0.932037,2,3,0,7.4224,0.159552 +-6.7484,0.994215,0.932037,1,3,0,7.0485,0.246555 +-7.08258,0.918347,0.932037,1,3,0,7.15481,0.158082 +-7.08258,0.737878,0.932037,1,3,0,9.18161,0.158082 +-7.35202,0.949338,0.932037,1,1,0,7.3743,0.131751 +-6.74881,0.983413,0.932037,1,3,0,7.33477,0.245074 +-6.95539,0.949695,0.932037,1,3,0,6.9911,0.175786 +-7.15608,0.958335,0.932037,1,1,0,7.16954,0.149783 +-6.83348,0.99773,0.932037,1,3,0,7.08351,0.200841 +-7.24483,0.931935,0.932037,1,3,0,7.25275,0.141003 +-6.98535,1,0.932037,1,1,0,7.20252,0.171111 +-6.79714,0.986131,0.932037,2,3,0,7.11242,0.212252 +-6.75975,0.994219,0.932037,2,3,0,6.84154,0.231186 +-7.85764,0.768175,0.932037,1,3,0,8.13554,0.0999182 +-7.75607,1,0.932037,2,3,0,8.00291,0.1052 +-7.45436,1,0.932037,1,1,0,7.77479,0.123968 +-6.75812,0.956844,0.932037,1,3,0,7.53861,0.268042 +-6.78653,0.996723,0.932037,2,3,0,6.78699,0.285711 +-6.78653,0.689753,0.932037,1,3,0,7.7558,0.285711 +-7.13767,0.941965,0.932037,2,3,0,7.15428,0.151762 +-6.8166,0.824152,0.932037,2,3,0,8.71226,0.205717 +-6.79612,1,0.932037,1,1,0,6.82009,0.21263 +-7.16066,0.926371,0.932037,2,3,0,7.36744,0.149299 +-6.7485,0.867631,0.932037,2,3,0,8.25218,0.253873 +-6.7485,0.374064,0.932037,1,3,0,9.69677,0.253873 +-6.906,0.899506,0.932037,2,3,0,7.30301,0.184481 +-6.97495,0.960716,0.932037,1,3,0,7.26467,0.339768 +-6.87784,0.957976,0.932037,1,3,0,7.22871,0.190181 +-6.76764,1,0.932037,1,3,0,6.85023,0.225799 +-7.06045,0.939987,0.932037,2,3,0,7.20313,0.160811 +-7.56678,0.90837,0.932037,1,1,0,7.56807,0.116345 +-8.21909,0.9114,0.932037,1,1,0,8.24106,0.0840531 +-7.1694,0.972439,0.932037,1,3,0,8.05615,0.148387 +-7.51659,0.939017,0.932037,1,1,0,7.53941,0.119642 +-6.80441,1,0.932037,2,3,0,7.33714,0.293457 +-6.84769,0.986098,0.932037,1,1,0,6.85924,0.308366 +-6.75447,1,0.932037,1,3,0,6.82024,0.264369 +-6.75447,0.941471,0.932037,1,3,0,6.92636,0.264369 +-7.31897,0.848317,0.932037,1,3,0,7.54592,0.134469 +-7.51256,0.936742,0.932037,2,3,0,8.23518,0.119914 +-7.00844,1,0.932037,1,1,0,7.41354,0.16775 +-6.81721,1,0.932037,2,3,0,6.95395,0.298298 +-7.45194,0.852204,0.932037,1,3,0,7.45194,0.413549 +-6.87259,1,0.932037,2,3,0,7.42285,0.191321 +-6.75616,1,0.932037,1,3,0,6.8471,0.234287 +-6.89502,0.961898,0.932037,1,3,0,6.94092,0.321477 +-6.77836,1,0.932037,2,3,0,6.87334,0.220083 +-6.79421,0.982898,0.932037,2,3,0,6.9004,0.28921 +-7.26621,0.798873,0.932037,2,3,0,7.90837,0.139052 +-6.86681,0.892468,0.932037,2,3,0,9.22078,0.192607 +-6.79361,1,0.932037,1,1,0,6.85058,0.213582 +-6.77748,1,0.932037,2,3,0,6.79435,0.220507 +-6.77887,0.999632,0.932037,1,1,0,6.78659,0.21984 +-6.78375,0.998717,0.932037,1,1,0,6.79108,0.217619 +-6.74954,0.987641,0.932037,2,3,0,6.86737,0.256925 +-7.83854,0.756676,0.932037,1,3,0,7.90005,0.456351 +-7.50039,1,0.932037,1,1,0,7.94015,0.419443 +-6.7491,1,0.932037,1,3,0,7.35194,0.244238 +-6.7636,0.996702,0.932037,1,3,0,6.76405,0.228378 +-6.78205,0.845782,0.932037,2,3,0,7.69714,0.218372 +-6.75014,0.997559,0.932037,2,3,0,6.79806,0.241923 +-8.34122,0.670679,0.932037,1,3,0,8.47733,0.501947 +-7.99963,1,0.932037,1,1,0,8.62888,0.471941 +-8.76385,0.745363,0.932037,1,1,0,9.14503,0.534703 +-7.04418,1,0.932037,1,1,0,8.14217,0.353302 +-7.43305,0.868749,0.932037,1,1,0,7.49441,0.4112 +-7.43305,0.297658,0.932037,1,1,0,9.48457,0.4112 +-6.83865,0.968461,0.932037,1,3,0,7.58424,0.199459 +-7.53033,0.883514,0.932037,1,3,0,7.57348,0.118724 +-6.96261,0.979104,0.932037,2,3,0,7.81614,0.174624 +-7.0999,0.990364,0.932037,2,3,0,7.12317,0.156026 +-8.07438,0.928426,0.932037,2,3,0,8.16995,0.478833 +-7.08332,1,0.932037,1,1,0,7.75278,0.36031 +-6.82918,1,0.932037,1,1,0,7.0036,0.302462 +-7.53288,0.784396,0.932037,1,1,0,7.53294,0.423295 +-7.05091,1,0.932037,2,3,0,7.39902,0.162026 +-7.40251,0.977978,0.932037,2,3,0,7.41207,0.127799 +-6.82898,1,0.932037,2,3,0,7.24836,0.302395 +-6.79153,1,0.932037,1,1,0,6.8253,0.288021 +-6.79153,0.459704,0.932037,1,3,0,9.85444,0.288021 +-6.76756,1,0.932037,1,1,0,6.7869,0.275233 +-6.97728,0.932763,0.932037,1,3,0,7.10469,0.172333 +-6.95157,1,0.932037,1,1,0,7.01491,0.17641 +-6.75905,0.960947,0.932037,2,3,0,7.21354,0.26886 +-6.7615,0.936647,0.932037,2,3,0,7.06828,0.229862 +-6.89331,0.972573,0.932037,1,3,0,6.89762,0.18697 +-6.77722,0.906489,0.932037,2,3,0,7.52048,0.280983 +-7.05175,0.910169,0.932037,1,3,0,7.23443,0.161917 +-6.92365,1,0.932037,1,1,0,7.04143,0.18121 +-6.92285,1,0.932037,2,3,0,6.9668,0.181353 +-7.13379,0.955304,0.932037,1,1,0,7.14184,0.152188 +-7.4804,0.884188,0.932037,1,3,0,8.21421,0.417034 +-7.40948,1,0.932037,1,1,0,7.67663,0.408227 +-6.7729,0.94969,0.932037,2,3,0,7.7319,0.222833 +-6.88124,0.967448,0.932037,1,3,0,6.95576,0.317894 +-8.24949,0.746027,0.932037,2,3,0,8.25756,0.0828895 +-6.96905,1,0.932037,1,3,0,8.10239,0.173607 +-7.27306,0.939109,0.932037,1,1,0,7.27863,0.138439 +-7.00308,0.956818,0.932037,1,3,0,7.78354,0.345468 +-6.75472,0.998187,0.932037,1,3,0,6.9917,0.235716 +-6.75494,0.999941,0.932037,1,1,0,6.75678,0.235495 +-6.87358,0.96725,0.932037,1,3,0,6.91321,0.315825 +-6.88529,0.996099,0.932037,1,1,0,6.92345,0.318963 +-8.16803,0.810902,0.932037,2,3,0,8.16856,0.487197 +-8.16803,0.500501,0.932037,1,1,0,9.65653,0.487197 +-6.84099,0.909134,0.932037,2,3,0,8.86386,0.198846 +-6.7482,0.97014,0.932037,2,3,0,7.07304,0.252336 +-6.88126,0.965042,0.932037,1,3,0,6.91312,0.189453 +-6.91537,0.971395,0.932037,1,3,0,7.15288,0.326496 +-6.74803,1,0.932037,1,3,0,6.88372,0.250563 +-6.78862,0.991449,0.932037,2,3,0,6.8033,0.215557 +-6.75166,1,0.932037,1,3,0,6.77932,0.239445 +-7.64177,0.652534,0.932037,2,3,0,8.81793,0.435682 +-7.39307,1,0.932037,1,1,0,7.74629,0.406126 +-7.39307,0.385651,0.932037,1,1,0,9.0256,0.406126 +-6.79731,0.988358,0.932037,1,3,0,7.44468,0.212186 +-7.26742,0.912562,0.932037,1,3,0,7.29563,0.138943 +-8.03606,0.881597,0.932037,1,1,0,8.03636,0.0915803 +-7.18684,0.969203,0.932037,1,3,0,7.89297,0.146604 +-7.82185,0.895632,0.932037,1,1,0,7.82342,0.10173 +-6.9258,0.999365,0.932037,1,3,0,7.68077,0.180825 +-6.84345,1,0.932037,1,1,0,6.91592,0.198213 +-8.02819,0.799375,0.932037,1,3,0,8.18865,0.0919253 +-9.74173,0.805241,0.932037,1,3,0,9.76127,0.0445821 +-8.33143,1,0.932037,1,1,0,9.60755,0.0798627 +-7.18582,0.972127,0.932037,1,3,0,8.16309,0.146708 +-6.92783,1,0.932037,1,1,0,7.13538,0.180463 +-7.11005,0.961217,0.932037,1,1,0,7.12168,0.154851 +-6.79373,1,0.932037,1,3,0,7.04271,0.213532 +-7.11956,0.955726,0.932037,2,3,0,7.20271,0.366472 +-7.48398,0.958399,0.932037,2,3,0,7.57261,0.417468 +-7.05344,1,0.932037,2,3,0,7.38948,0.354998 +-6.89526,1,0.932037,1,1,0,7.02854,0.321538 +-6.75297,0.996542,0.932037,2,3,0,6.92061,0.237701 +-6.83977,0.975809,0.932037,1,3,0,6.86918,0.305909 +-6.8251,1,0.932037,2,3,0,6.85672,0.301077 +-6.76932,1,0.932037,1,1,0,6.8089,0.276371 +-7.2411,0.887441,0.932037,1,3,0,7.24713,0.385345 +-6.77198,0.978158,0.932037,2,3,0,7.39681,0.223328 +-6.91344,0.959133,0.932037,1,3,0,6.99309,0.326033 +-7.04881,0.85015,0.932037,2,3,0,7.62026,0.162296 +-7.60525,0.863371,0.932037,1,3,0,8.23873,0.431613 +-6.78473,0.999819,0.932037,1,3,0,7.58373,0.217191 +-6.78473,0.898858,0.932037,1,3,0,7.22409,0.217191 +-7.78377,0.579188,0.932037,2,3,0,9.7066,0.103716 +-7.70743,1,0.932037,1,1,0,7.93357,0.10789 +-7.96247,0.96471,0.932037,1,1,0,8.07171,0.0948869 +-7.12674,0.974601,0.932037,1,3,0,7.81844,0.152967 +-6.75681,1,0.932037,1,3,0,7.07784,0.233681 +-6.74929,0.899259,0.932037,2,3,0,7.32696,0.243745 +-6.74929,0.646445,0.932037,1,3,0,8.08205,0.243745 +-7.15628,0.857788,0.932037,2,3,0,7.57467,0.372439 +-7.75903,0.923317,0.932037,2,3,0,7.84476,0.448237 +-6.85106,0.987384,0.932037,2,3,0,7.98227,0.19631 +-8.0294,0.746944,0.932037,1,3,0,8.39902,0.474711 +-6.8022,0.859301,0.932037,2,3,0,8.84948,0.210434 +-6.77032,1,0.932037,1,1,0,6.79542,0.22424 +-7.64151,0.740592,0.932037,2,3,0,8.46249,0.435654 +-8.37811,0.917274,0.932037,2,3,0,8.62816,0.504979 +-7.49482,1,0.932037,1,1,0,8.22793,0.418775 +-9.18827,0.523755,0.932037,1,1,0,9.33046,0.563944 +-7.76093,1,0.932037,1,1,0,8.88732,0.448435 +-6.97798,1,0.932037,1,1,0,7.50122,0.340396 +-7.35575,0.873861,0.932037,1,1,0,7.39654,0.401255 +-7.35575,0.110444,0.932037,1,1,0,11.0745,0.401255 +-7.35575,0.0800688,0.932037,1,3,0,15.4327,0.401255 +-7.48223,0.672997,0.932037,1,3,0,8.8362,0.121997 +-6.78001,0.901552,0.932037,2,3,0,8.42084,0.28247 +-7.27496,0.91456,0.932037,2,3,0,7.304,0.13827 +-7.27496,0.889573,0.932037,1,1,0,7.87313,0.13827 +-6.74818,0.981145,0.932037,1,3,0,7.27579,0.252199 +-6.74818,0.540736,0.932037,1,3,0,8.56126,0.252199 +-6.84577,0.975084,0.932037,1,3,0,6.8552,0.307778 +-6.84577,0.460221,0.932037,1,3,0,8.80117,0.307778 +-7.22623,0.87774,0.932037,1,1,0,7.23183,0.383162 +-6.86085,0.957571,0.932037,1,3,0,7.44679,0.193973 +-6.84216,1,0.932037,1,1,0,6.8764,0.198544 +-6.82726,0.902432,0.932037,2,3,0,7.67881,0.202571 +-7.01244,0.957121,0.932037,1,1,0,7.01282,0.167187 +-6.753,0.947388,0.932037,2,3,0,7.40574,0.262602 +-6.75612,0.999688,0.932037,2,3,0,6.75709,0.266127 +-7.10487,0.901325,0.932037,1,3,0,7.25063,0.155448 +-6.75288,0.934052,0.932037,2,3,0,7.61355,0.262456 +-6.75911,0.998131,0.932037,1,1,0,6.75973,0.268918 +-6.97448,0.935151,0.932037,1,3,0,7.07933,0.172763 +-8.33687,0.727783,0.932037,1,3,0,8.95629,0.501587 +-7.19311,1,0.932037,1,1,0,7.97929,0.378182 +-6.86239,0.957299,0.932037,1,3,0,7.41859,0.193617 +-8.81489,0.675307,0.932037,1,3,0,9.25628,0.0647295 +-9.08174,0.976561,0.932037,1,1,0,9.30033,0.0579512 +-8.72465,1,0.932037,2,3,0,9.23184,0.067248 +-9.02058,0.973248,0.932037,1,1,0,9.2222,0.059423 +-6.75096,0.87105,0.932037,1,3,0,9.3739,0.240494 +-6.77061,0.8673,0.932037,2,3,0,7.49474,0.224077 +-7.18049,0.687335,0.932037,2,3,0,8.77168,0.147248 +-6.83677,0.997719,0.932037,1,3,0,7.10412,0.199956 +-7.0242,0.942244,0.932037,1,3,0,7.2293,0.349561 +-6.75027,1,0.932037,1,3,0,6.95554,0.258452 +-7.19098,0.922423,0.932037,2,3,0,7.25741,0.146188 +-6.75095,0.998409,0.932037,2,3,0,7.18042,0.240521 +-6.87936,0.965588,0.932037,1,3,0,6.90968,0.31739 +-6.78928,1,0.932037,2,3,0,6.85581,0.215288 +-7.24713,0.912602,0.932037,1,3,0,7.27833,0.14079 +-7.64349,0.933948,0.932037,1,1,0,7.6686,0.111601 +-7.89818,0.963732,0.932037,1,1,0,7.99945,0.0979248 +-9.96894,0.866816,0.932037,2,3,0,10.0037,0.610637 +-8.27408,1,0.932037,1,1,0,9.73188,0.496333 +-8.97796,0.763178,0.932037,1,1,0,9.46742,0.549854 +-7.07994,1,0.932037,2,3,0,9.38837,0.158401 +-6.75736,0.879611,0.932037,2,3,0,8.01228,0.267336 +-6.7519,1,0.932037,1,1,0,6.75617,0.261115 +-6.78524,0.992274,0.932037,1,3,0,6.78539,0.285089 +-7.86462,0.758008,0.932037,1,3,0,7.87664,0.458948 +-7.97349,0.959152,0.932037,1,1,0,8.36464,0.469482 +-7.11236,1,0.932037,2,3,0,7.71314,0.365271 +-7.71805,0.799983,0.932037,1,1,0,7.78908,0.443934 +-9.81575,0.716945,0.932037,2,3,0,10.0088,0.602086 +-7.32169,1,0.932037,1,1,0,8.93058,0.396686 +-6.74807,0.833534,0.932037,2,3,0,8.05557,0.251241 +-6.74803,1,0.932037,2,3,0,6.74806,0.250572 +-6.75538,0.991246,0.932037,2,3,0,6.79373,0.235049 +-6.93792,0.962649,0.932037,2,3,0,7.01983,0.331741 +-7.2862,0.88434,0.932037,1,1,0,7.31645,0.391789 +-6.99084,1,0.932037,2,3,0,7.19845,0.170294 +-7.65042,0.905856,0.932037,2,3,0,8.20379,0.436635 +-7.41337,1,0.932037,1,1,0,7.7679,0.40872 +-8.85702,0.576942,0.932037,1,1,0,8.98493,0.541403 +-6.78589,1,0.932037,1,3,0,8.17164,0.285406 +-6.90223,0.954007,0.932037,1,3,0,7.03131,0.185207 +-8.14191,0.811993,0.932037,1,3,0,8.27248,0.0871143 +-8.10592,1,0.932037,1,1,0,8.36491,0.0885962 +-8.2689,0.993522,0.932037,2,3,0,8.4528,0.0821583 +-9.32894,0.899169,0.932037,1,1,0,9.34484,0.0524422 +-8.02809,1,0.932037,1,1,0,9.18688,0.0919298 +-6.99166,0.993898,0.932037,1,3,0,7.87392,0.170173 +-8.06441,0.911089,0.932037,2,3,0,8.31617,0.477926 +-8.7506,0.922675,0.932037,2,3,0,9.16274,0.533736 +-7.8978,1,0.932037,1,1,0,8.75888,0.462211 +-6.94446,1,0.932037,1,1,0,7.56554,0.333209 +-8.54285,0.771096,0.932037,2,3,0,8.54633,0.518094 +-6.78594,1,0.932037,1,3,0,7.9627,0.285428 +-6.78594,0.906519,0.932037,1,3,0,7.16707,0.285428 +-6.92112,0.942672,0.932037,2,3,0,7.08892,0.181666 +-6.87261,0.875781,0.932037,2,3,0,8.17854,0.191316 +-7.08975,0.952205,0.932037,1,1,0,7.09201,0.157223 +-7.02149,1,0.932037,2,3,0,7.12326,0.165933 +-7.04584,0.998287,0.932037,2,3,0,7.10444,0.162681 +-7.04584,0.672299,0.932037,1,3,0,9.55749,0.162681 +-7.77921,0.832639,0.932037,1,3,0,8.43718,0.450325 +-6.93132,0.932106,0.932037,1,3,0,8.11383,0.179848 +-7.37155,0.932331,0.932037,1,3,0,7.37171,0.130194 +-6.74802,0.977866,0.932037,1,3,0,7.37247,0.250051 +-6.90501,0.947815,0.932037,2,3,0,7.04469,0.32398 +-6.90501,0.515929,0.932037,1,1,0,8.06608,0.32398 +-7.26517,0.747153,0.932037,2,3,0,8.10285,0.139146 +-6.77759,0.959776,0.932037,1,3,0,7.38193,0.281187 +-6.75799,1,0.932037,1,1,0,6.77244,0.267921 +-6.79277,0.99575,0.932037,2,3,0,6.79381,0.213903 +-6.76109,1,0.932037,1,1,0,6.78457,0.230166 +-6.7596,0.969448,0.932037,2,3,0,6.95304,0.231305 +-6.79156,0.988014,0.932037,2,3,0,6.84381,0.214376 +-6.78312,1,0.932037,1,1,0,6.79707,0.217895 +-6.77762,0.949288,0.932037,2,3,0,7.08484,0.2812 +-7.09494,0.924565,0.932037,1,3,0,7.09566,0.362318 +-6.95426,1,0.932037,2,3,0,7.09613,0.335364 +-7.28442,0.889685,0.932037,1,1,0,7.32064,0.391541 +-6.79484,0.997398,0.932037,2,3,0,7.36362,0.213111 +-6.81648,0.99449,0.932037,1,1,0,6.8247,0.205753 +-6.84974,0.991789,0.932037,1,1,0,6.86103,0.196633 +-6.74879,0.865097,0.932037,2,3,0,7.74614,0.245131 +-6.88211,0.967449,0.932037,1,3,0,6.902,0.189273 +-6.74845,0.957844,0.932037,2,3,0,7.24214,0.246361 +-7.20685,0.887254,0.932037,1,3,0,7.25766,0.380267 +-7.20685,0.564767,0.932037,1,3,0,8.81898,0.380267 +-7.20685,0.320306,0.932037,1,3,0,12.13,0.380267 +-6.97752,0.935114,0.932037,2,3,0,7.66742,0.172296 +-6.87049,1,0.932037,1,1,0,6.96427,0.191784 +-6.74837,0.966424,0.932037,2,3,0,7.14605,0.253312 +-6.98253,0.907073,0.932037,2,3,0,7.2529,0.341334 +-7.79349,0.745081,0.932037,1,1,0,7.81771,0.451791 +-6.77388,1,0.932037,1,3,0,7.46942,0.279119 +-6.90086,0.954561,0.932037,1,3,0,7.00827,0.185473 +-6.79914,1,0.932037,2,3,0,6.8716,0.291311 +-8.11178,0.713466,0.932037,1,3,0,8.12201,0.482208 +-8.11178,0.190125,0.932037,1,1,0,11.1441,0.482208 +-7.24841,1,0.932037,1,1,0,7.88964,0.386408 +-7.23081,1,0.932037,1,1,0,7.40517,0.383837 +-6.80377,1,0.932037,2,3,0,7.08741,0.293202 +-6.85418,0.994603,0.932037,2,3,0,6.86482,0.310312 +-6.74965,0.98222,0.932037,2,3,0,6.95136,0.257173 +-7.03844,0.928412,0.932037,1,3,0,7.0566,0.352239 +-7.22621,0.808036,0.932037,1,3,0,7.93488,0.14275 +-6.77583,0.927823,0.932037,2,3,0,7.69178,0.280224 +-6.86535,0.971878,0.932037,1,1,0,6.86662,0.313541 +-6.77928,0.990027,0.932037,1,3,0,6.92787,0.219648 +-6.78451,0.998625,0.932037,1,1,0,6.79187,0.217287 +-6.78451,0.773207,0.932037,1,3,0,7.90069,0.217287 +-6.75189,0.967957,0.932037,2,3,0,6.99818,0.23911 +-6.88731,0.96889,0.932037,1,3,0,6.89993,0.18819 +-6.83332,1,0.932037,1,1,0,6.8859,0.200884 +-6.96445,0.969353,0.932037,1,1,0,6.9678,0.174331 +-6.74853,0.993691,0.932037,1,3,0,6.95955,0.253983 +-6.79227,0.98474,0.932037,2,3,0,6.83336,0.288352 +-6.78141,0.965461,0.932037,2,3,0,6.96936,0.218663 +-6.75837,0.995995,0.932037,1,3,0,6.80286,0.268259 +-6.80841,0.982527,0.932037,1,3,0,6.84862,0.208324 +-6.92145,0.989324,0.932037,2,3,0,6.92312,0.327942 +-6.94393,0.992369,0.932037,1,1,0,6.99666,0.33309 +-8.0719,0.66438,0.932037,1,1,0,8.0808,0.478608 +-8.30789,0.913191,0.932037,1,1,0,8.7652,0.499176 +-6.88395,1,0.932037,2,3,0,7.79691,0.318612 +-6.88395,0.525809,0.932037,1,3,0,8.46396,0.318612 +-7.66074,0.862122,0.932037,2,3,0,7.66587,0.110579 +-7.48718,1,0.932037,1,1,0,7.73391,0.121652 +-7.24771,1,0.932037,1,1,0,7.49536,0.140737 +-6.75294,0.907734,0.932037,2,3,0,8.2612,0.23774 +-6.75294,0.882023,0.932037,1,3,0,7.23222,0.23774 +-6.75294,0.648763,0.932037,1,3,0,8.1161,0.23774 +-6.75671,0.998954,0.932037,1,1,0,6.75747,0.233769 +-7.51733,0.821118,0.932037,1,3,0,7.63136,0.421461 +-7.23718,1,0.932037,2,3,0,7.55107,0.384773 +-7.23718,0.584164,0.932037,1,1,0,8.1976,0.384773 +-6.75151,1,0.932037,1,3,0,7.10952,0.260533 +-6.76119,0.993068,0.932037,2,3,0,6.78713,0.270643 +-6.79508,0.984853,0.932037,2,3,0,6.84415,0.213018 +-8.30022,0.789495,0.932037,2,3,0,8.51335,0.0809972 +-7.08882,0.985416,0.932037,1,3,0,8.13433,0.157333 +-6.74804,0.991804,0.932037,1,3,0,7.07332,0.249263 +-6.76797,0.994746,0.932037,1,3,0,6.77114,0.275501 +-6.87611,0.984786,0.932037,2,3,0,6.88112,0.190553 +-7.10363,0.930507,0.932037,1,3,0,7.38443,0.3638 +-7.1931,0.968366,0.932037,1,1,0,7.30124,0.378181 +-7.02744,1,0.932037,1,1,0,7.20716,0.350175 +-7.47087,0.716122,0.932037,1,3,0,8.36114,0.122794 +-7.77445,0.953734,0.932037,1,1,0,7.84235,0.104212 +-7.10232,0.976364,0.932037,1,3,0,7.65215,0.155744 +-6.89247,0.977052,0.932037,2,3,0,7.36801,0.187138 +-6.88406,1,0.932037,2,3,0,6.92287,0.188864 +-7.00739,0.972361,0.932037,1,1,0,7.01912,0.167899 +-7.4581,0.959878,0.932037,2,3,0,7.46539,0.414309 +-7.4581,0.358894,0.932037,1,1,0,9.21803,0.414309 +-8.39486,0.699937,0.932037,1,1,0,8.5651,0.506344 +-6.98009,0.931934,0.932037,1,3,0,8.77344,0.171904 +-7.75622,0.895607,0.932037,2,3,0,8.30908,0.447944 +-7.45294,1,0.932037,1,1,0,7.85686,0.413673 +-7.81191,0.87317,0.932037,1,1,0,8.02199,0.453667 +-7.07889,1,0.932037,2,3,0,7.65163,0.158528 +-8.02018,0.93056,0.932037,2,3,0,8.11738,0.473856 +-7.32245,1,0.932037,1,1,0,7.89443,0.396789 +-7.11924,1,0.932037,2,3,0,7.35057,0.366419 +-7.13426,0.994637,0.932037,1,1,0,7.25741,0.368892 +-6.81324,1,0.932037,1,1,0,7.02809,0.296845 +-7.90962,0.554652,0.932037,2,3,0,9.26763,0.0973734 +-10.1284,0.790216,0.932037,1,3,0,10.2416,0.0384446 +-8.90062,1,0.932037,1,1,0,10.0537,0.0624477 +-6.80723,1,0.932037,2,3,0,8.62687,0.208714 +-6.86729,0.973895,0.932037,2,3,0,7.02735,0.192499 +-6.79392,1,0.932037,1,1,0,6.85106,0.213461 +-7.40012,0.888235,0.932037,2,3,0,7.70807,0.407031 +-6.93792,1,0.932037,2,3,0,7.29993,0.178704 +-7.00949,0.984312,0.932037,1,1,0,7.03975,0.167602 +-7.13808,0.973678,0.932037,1,1,0,7.17115,0.151717 +-6.78692,0.965669,0.932037,1,3,0,7.25761,0.285893 +-6.87345,0.885758,0.932037,2,3,0,7.29989,0.315791 +-7.7385,0.869841,0.932037,2,3,0,7.74068,0.446092 +-7.7385,0.102215,0.932037,1,1,0,11.7215,0.446092 +-8.03266,0.893586,0.932037,1,1,0,8.35655,0.475011 +-8.22194,0.92979,0.932037,1,1,0,8.66902,0.491883 +-7.3561,1,0.932037,2,3,0,7.97443,0.131423 +-6.78127,1,0.932037,1,3,0,7.27452,0.218728 +-6.82275,0.984055,0.932037,1,3,0,6.89491,0.300263 +-7.6571,0.742126,0.932037,1,3,0,8.29259,0.110793 +-8.03026,0.829375,0.932037,1,3,0,9.64909,0.47479 +-7.37223,1,0.932037,1,1,0,7.93907,0.403423 +-6.79515,0.988926,0.932037,1,3,0,7.42116,0.212995 +-6.82487,0.992469,0.932037,1,1,0,6.83189,0.203253 +-7.12496,0.969767,0.932037,2,3,0,7.16248,0.367365 +-8.26834,0.652897,0.932037,1,1,0,8.32004,0.495847 +-8.67193,0.856184,0.932037,1,1,0,9.18766,0.527922 +-6.90442,1,0.932037,1,1,0,8.03082,0.323833 +-7.94108,0.68975,0.932037,1,1,0,7.94519,0.466396 +-7.78516,0.528351,0.932037,1,3,0,10.1916,0.103643 +-7.48177,1,0.932037,1,1,0,7.8074,0.122029 +-6.80338,0.90422,0.932037,2,3,0,8.07863,0.293044 +-6.89878,0.96934,0.932037,1,1,0,6.90583,0.322427 +-7.30937,0.866085,0.932037,1,1,0,7.32592,0.395003 +-6.85274,1,0.932037,1,1,0,7.15684,0.309887 +-6.85274,0.743543,0.932037,1,3,0,7.59752,0.309887 +-6.85274,0.563681,0.932037,1,3,0,9.12334,0.309887 +-7.14252,0.905701,0.932037,1,1,0,7.15244,0.370233 +-6.88606,1,0.932037,1,1,0,7.07414,0.319166 +-6.81352,1,0.932037,1,1,0,6.87385,0.296952 +-7.22426,0.603012,0.932037,2,3,0,8.88007,0.382871 +-6.75466,1,0.932037,1,3,0,7.17215,0.235789 +-6.77207,0.962029,0.932037,2,3,0,6.97984,0.223275 +-7.20122,0.9126,0.932037,1,3,0,7.2415,0.145171 +-7.97419,0.889846,0.932037,1,3,0,7.97427,0.0943483 +-7.1089,0.976552,0.932037,1,3,0,7.82637,0.154983 +-7.1089,0.884111,0.932037,1,3,0,7.82698,0.154983 +-6.98201,0.835391,0.932037,2,3,0,9.32581,0.171614 +-7.4823,0.923908,0.932037,1,3,0,7.48233,0.121992 +-8.13382,0.907974,0.932037,1,1,0,8.15008,0.0874439 +-7.0191,0.992287,0.932037,1,3,0,7.97523,0.166261 +-7.38884,0.929413,0.932037,1,1,0,7.39423,0.128846 +-7.05345,0.945247,0.932037,1,3,0,8.00914,0.354999 +-7.88022,0.88235,0.932037,2,3,0,7.92302,0.460488 +-7.47896,1,0.932037,1,1,0,7.94438,0.41686 +-8.26848,0.902685,0.932037,2,3,0,8.45552,0.495858 +-8.36145,0.964836,0.932037,1,1,0,8.90958,0.503614 +-6.80918,1,0.932037,1,3,0,7.82987,0.295317 +-7.23868,0.600861,0.932037,2,3,0,8.89375,0.384993 +-6.89006,1,0.932037,1,1,0,7.13419,0.320205 +-6.8044,1,0.932037,2,3,0,6.86543,0.209671 +-6.86009,0.995405,0.932037,2,3,0,6.86567,0.194151 +-6.86009,0.799308,0.932037,1,3,0,7.97123,0.194151 +-8.99856,0.728419,0.932037,2,3,0,9.23129,0.0599642 +-9.09468,0.991837,0.932037,1,1,0,9.38997,0.0576457 +-8.73756,1,0.932037,1,1,0,9.24597,0.0668798 +-7.55986,0.937761,0.932037,1,3,0,8.57866,0.11679 +-7.99912,0.937675,0.932037,1,1,0,8.05117,0.0932182 +-7.76055,1,0.932037,1,1,0,8.08641,0.104958 +-8.28732,0.977606,0.932037,2,3,0,8.34339,0.0814724 +-6.82679,0.992827,0.932037,1,3,0,8.22618,0.202702 +-6.87274,0.996281,0.932037,2,3,0,6.88424,0.191288 +-6.78865,0.91873,0.932037,2,3,0,7.41091,0.286706 +-6.76058,1,0.932037,2,3,0,6.78115,0.230549 +-6.76058,0.44465,0.932037,2,3,0,10.1097,0.230549 +-8.19963,0.701948,0.932037,1,3,0,8.62984,0.0848102 +-6.87827,1,0.932037,1,3,0,8.08649,0.190089 +-6.90011,0.99488,0.932037,1,1,0,6.92793,0.185622 +-7.58846,0.835161,0.932037,1,3,0,7.98997,0.429714 +-6.84168,1,0.932037,2,3,0,7.32922,0.306509 +-6.79898,0.907476,0.932037,2,3,0,7.23342,0.291247 +-7.18968,0.940405,0.932037,2,3,0,7.1897,0.377657 +-7.30081,0.811278,0.932037,2,3,0,8.27114,0.136012 +-7.44395,0.975262,0.932037,1,1,0,7.52376,0.124721 +-7.10913,1,0.932037,1,1,0,7.3984,0.154957 +-6.74902,0.994264,0.932037,1,3,0,7.08219,0.24445 +-7.95169,0.736282,0.932037,1,3,0,8.05657,0.467411 +# +# Elapsed Time: 0.005 seconds (Warm-up) +# 0.012 seconds (Sampling) +# 0.017 seconds (Total) +# diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_thin.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_thin.csv new file mode 100644 index 0000000000..b0874d8ead --- /dev/null +++ b/src/test/unit/mcmc/test_csv_files/bernoulli_thin.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-07-23 15:13:19 UTC +# method = sample (Default) +# sample +# num_samples = 2000 +# num_warmup = 1000 (Default) +# save_warmup = false (Default) +# thin = 2 +# 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 = examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 3880845880 (Default) +# output +# file = bernoulli_thin.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.893542 +# Diagonal elements of inverse mass matrix: +# 0.483503 +-8.91945,1,0.893542,1,1,0,9.73374,0.0619604 +-8.90814,1,0.893542,1,1,0,9.95846,0.545008 +-7.21915,1,0.893542,1,1,0,7.56642,0.382112 +-6.99262,0.974315,0.893542,1,1,0,6.99262,0.170032 +-7.177,0.949564,0.893542,2,7,0,7.19028,0.147604 +-7.02071,0.934256,0.893542,2,3,0,7.30094,0.348894 +-6.75447,0.998729,0.893542,2,3,0,6.76944,0.264366 +-6.99389,0.954672,0.893542,1,3,0,7.04803,0.169846 +-8.10147,0.867196,0.893542,1,3,0,8.27154,0.0887819 +-7.83949,1,0.893542,1,1,0,8.36851,0.100831 +-7.20348,0.899977,0.893542,1,3,0,7.65125,0.379758 +-7.12214,0.820496,0.893542,1,3,0,8.08646,0.153481 +-6.75619,1,0.893542,2,3,0,7.17582,0.266194 +-6.80721,0.968917,0.893542,1,3,0,7.36674,0.294557 +-7.03198,1,0.893542,1,1,0,7.76254,0.351031 +-6.85284,0.960446,0.893542,1,3,0,7.15062,0.195876 +-6.77208,0.987924,0.893542,1,3,0,7.03182,0.278062 +-6.91359,1,0.893542,2,3,0,8.13328,0.18305 +-6.81561,0.956574,0.893542,2,7,0,7.45532,0.297719 +-6.76032,1,0.893542,2,7,0,6.80503,0.230743 +-6.76597,0.998846,0.893542,1,1,0,6.76725,0.22683 +-6.7594,0.993657,0.893542,1,3,0,6.82523,0.231466 +-7.25866,0.839089,0.893542,2,3,0,8.4433,0.139735 +-7.1134,0.971276,0.893542,1,1,0,7.1556,0.365446 +-7.52094,0.727841,0.893542,1,3,0,8.73414,0.11935 +-7.67112,0.993503,0.893542,1,1,0,7.78017,0.109972 +-6.75103,0.998383,0.893542,2,3,0,6.83417,0.259776 +-8.62702,0.934538,0.893542,2,3,0,9.21545,0.0701174 +-6.85649,0.909432,0.893542,1,3,0,8.95293,0.310994 +-6.87955,0.968041,0.893542,1,3,0,6.94534,0.317443 +-6.84001,0.965601,0.893542,1,3,0,7.07766,0.199102 +-7.88997,1,0.893542,2,3,0,8.09487,0.0983237 +-7.06055,0.900192,0.893542,1,3,0,8.68948,0.356282 +-6.74805,0.996745,0.893542,1,3,0,6.97881,0.250856 +-7.19725,1,0.893542,1,1,0,7.28556,0.145563 +-6.78602,0.995476,0.893542,1,1,0,6.78705,0.285469 +-6.79545,0.966991,0.893542,2,7,0,8.83762,0.289747 +-6.85701,0.986415,0.893542,2,3,0,6.9222,0.194874 +-8.13779,0.808085,0.893542,2,7,0,8.15821,0.0872819 +-6.77475,1,0.893542,2,3,0,6.80685,0.221869 +-6.755,1,0.893542,1,1,0,6.76348,0.235428 +-7.72282,0.995936,0.893542,2,3,0,7.81505,0.107027 +-6.85068,0.991723,0.893542,2,7,0,7.67011,0.309272 +-6.78351,0.96595,0.893542,1,3,0,7.29485,0.217724 +-7.01992,0.916257,0.893542,1,3,0,7.27688,0.166148 +-6.75058,0.983401,0.893542,1,3,0,7.38448,0.259018 +-8.06771,0.664252,0.893542,1,3,0,9.09338,0.0902102 +-6.82585,1,0.893542,2,3,0,7.7661,0.202972 +-7.00359,0.957838,0.893542,1,1,0,7.00467,0.345568 +-7.16065,0.965784,0.893542,2,7,0,7.16072,0.373134 +-6.74805,0.99626,0.893542,1,3,0,6.98927,0.24901 +-6.90231,1,0.893542,2,3,0,7.05968,0.185192 +-7.20636,0.93361,0.893542,1,3,0,9.402,0.144665 +-7.84106,1,0.893542,1,1,0,8.44831,0.456603 +-6.75385,0.986687,0.893542,1,3,0,7.15744,0.236668 +-7.73869,0.848859,0.893542,1,1,0,7.76537,0.446112 +-9.04616,0.923365,0.893542,2,3,0,9.28102,0.554505 +-7.16253,1,0.893542,1,1,0,7.26087,0.149103 +-6.75061,0.953379,0.893542,2,3,0,7.55278,0.241086 +-6.87201,0.983579,0.893542,2,3,0,6.89287,0.315394 +-8.37334,0.780237,0.893542,2,3,0,8.91045,0.504589 +-7.31022,1,0.893542,1,1,0,8.08813,0.39512 +-7.13369,0.836937,0.893542,1,3,0,7.87458,0.152199 +-7.55607,0.978527,0.893542,1,1,0,7.60506,0.117035 +-6.7799,0.995845,0.893542,2,3,0,6.81306,0.219357 +-6.87584,0.978011,0.893542,1,1,0,6.87584,0.316441 +-6.90665,1,0.893542,2,3,0,7.03415,0.184358 +-8.366,0.954237,0.893542,2,7,0,8.64308,0.503988 +-7.31371,1,0.893542,2,3,0,7.59964,0.395598 +-7.42729,1,0.893542,1,1,0,8.24438,0.410478 +-9.83769,0.367101,0.893542,1,3,0,12.9683,0.0429592 +-11.7092,0.971359,0.893542,1,1,0,11.7472,0.0215426 +-7.94546,0.93523,0.893542,2,7,0,11.9231,0.466816 +-7.74281,0.747755,0.893542,1,3,0,8.44191,0.105922 +-6.84047,0.920699,0.893542,2,3,0,7.68591,0.198981 +-8.60661,0.827904,0.893542,1,1,0,8.82479,0.522995 +-7.29777,1,0.893542,2,3,0,7.39398,0.136273 +-6.97269,1,0.893542,1,1,0,7.22693,0.339296 +-6.86249,1,0.893542,1,1,0,7.01724,0.312728 +-6.97125,0.913468,0.893542,1,3,0,7.58656,0.173264 +-7.8638,0.989915,0.893542,1,1,0,7.9762,0.0996114 +-6.86197,1,0.893542,2,3,0,7.63776,0.193713 +-7.22206,0.850919,0.893542,1,3,0,7.71338,0.143146 +-7.22681,0.99046,0.893542,1,1,0,7.27628,0.142693 +-7.09726,1,0.893542,1,1,0,7.36621,0.156335 +-9.96351,0.978531,0.893542,2,3,0,11.1987,0.0409345 +-7.34497,1,0.893542,2,3,0,10.5413,0.132321 +-6.81305,0.938689,0.893542,2,3,0,7.24819,0.206825 +-6.81323,0.996598,0.893542,1,1,0,6.81843,0.206767 +-6.83142,0.971003,0.893542,1,3,0,6.96602,0.201408 +-6.83125,1,0.893542,1,1,0,6.94813,0.30315 +-6.7882,0.950841,0.893542,2,3,0,7.15238,0.215732 +-9.17868,0.966705,0.893542,1,1,0,9.2473,0.0557102 +-10.1185,0.944434,0.893542,1,1,0,10.1239,0.0385895 +-7.53536,0.731681,0.893542,2,3,0,8.955,0.423587 +-7.17139,0.844452,0.893542,2,3,0,7.87684,0.148181 +-7.10769,0.986547,0.893542,1,1,0,7.17427,0.364485 +-6.94717,0.935748,0.893542,2,3,0,7.17961,0.17714 +-6.84534,0.989334,0.893542,1,1,0,6.84994,0.307647 +-6.8368,0.954327,0.893542,1,3,0,7.1096,0.304961 +-6.74879,0.996744,0.893542,1,3,0,6.85754,0.245111 +-6.99263,0.97013,0.893542,2,3,0,7.04979,0.170031 +-8.34668,1,0.893542,1,1,0,9.31823,0.502398 +-7.78992,0.97634,0.893542,1,1,0,7.8495,0.103392 +-6.96885,0.97489,0.893542,1,3,0,7.75062,0.173638 +-7.13219,0.920703,0.893542,1,3,0,7.2178,0.368554 +-6.74834,0.99754,0.893542,1,3,0,8.20523,0.246878 +-6.82781,0.98513,0.893542,1,3,0,6.83699,0.301999 +-8.51144,0.8241,0.893542,2,3,0,8.59822,0.0737269 +-6.8833,0.990012,0.893542,2,3,0,7.1302,0.189023 +-7.727,0.933842,0.893542,2,7,0,7.72929,0.444881 +-6.92808,1,0.893542,2,3,0,7.01247,0.180418 +-7.46481,0.853946,0.893542,1,3,0,7.74876,0.123222 +-7.52531,0.818528,0.893542,1,1,0,8.12529,0.422404 +-7.53784,1,0.893542,2,7,0,7.5663,0.118227 +-8.66406,0.93062,0.893542,1,1,0,8.66529,0.0690104 +-6.87277,0.98575,0.893542,1,3,0,7.37422,0.19128 +-6.74819,0.998319,0.893542,1,3,0,6.8526,0.247725 +-7.47646,0.972692,0.893542,2,3,0,7.5325,0.416555 +-6.82543,0.998174,0.893542,1,1,0,6.83612,0.203094 +-6.94406,0.988418,0.893542,1,1,0,6.95306,0.177661 +-7.50427,0.900985,0.893542,1,3,0,7.62359,0.120477 +-8.30957,0.959888,0.893542,1,1,0,8.34722,0.0806548 +-6.85627,0.480224,0.893542,2,3,0,11.4286,0.195052 +-7.8289,1,0.893542,1,1,0,8.32911,0.101369 +-6.82852,1,0.893542,1,1,0,6.94737,0.302239 +-6.94381,0.895885,0.893542,1,3,0,7.67155,0.177703 +-6.80431,0.871567,0.893542,2,3,0,8.18055,0.293417 +-7.84658,0.975609,0.893542,1,1,0,7.90755,0.100473 +-6.74811,1,0.893542,2,3,0,6.783,0.248387 +-7.37909,1,0.893542,1,1,0,7.56009,0.404317 +-7.36159,0.918547,0.893542,1,1,0,7.38981,0.402026 +-6.75283,0.999402,0.893542,1,3,0,6.79322,0.237882 +-6.97729,1,0.893542,2,7,0,6.98137,0.172332 +-6.91629,0.999631,0.893542,1,1,0,6.94684,0.182549 +-6.76816,0.999578,0.893542,2,7,0,6.917,0.275627 +-6.86094,0.941705,0.893542,2,3,0,8.84018,0.193952 +-7.25168,0.653707,0.893542,1,1,0,8.33062,0.38688 +-6.75039,0.96706,0.893542,2,3,0,6.98851,0.258663 +-6.77982,0.981375,0.893542,2,7,0,7.00643,0.28237 +-7.07903,0.897172,0.893542,1,3,0,7.42532,0.158511 +-10.6092,0.672748,0.893542,2,3,0,10.6214,0.0321139 +-6.83435,0.969853,0.893542,3,7,0,10.164,0.200606 +-6.95401,0.973201,0.893542,2,3,0,6.98236,0.176011 +-8.17193,0.985546,0.893542,2,3,0,8.19935,0.0859048 +-7.79192,1,0.893542,1,1,0,7.99394,0.103286 +-6.9427,0.999631,0.893542,2,3,0,6.97562,0.17789 +-7.30169,0.683894,0.893542,1,3,0,10.1795,0.135936 +-6.75912,0.99904,0.893542,1,1,0,6.75957,0.231693 +-6.84568,1,0.893542,2,3,0,7.73696,0.197646 +-7.3204,0.877816,0.893542,1,3,0,7.74699,0.396511 +-6.97797,0.950365,0.893542,2,3,0,7.16605,0.340394 +-7.11181,0.942572,0.893542,1,1,0,7.11617,0.365179 +-6.82789,0.978553,0.893542,1,3,0,6.87538,0.202392 +-7.12345,0.866388,0.893542,1,3,0,7.69739,0.153334 +-6.829,0.973881,0.893542,1,3,0,6.92137,0.202079 +-7.01343,0.888872,0.893542,2,3,0,7.92307,0.347493 +-6.83552,0.944714,0.893542,2,3,0,7.2674,0.200291 +-6.75229,1,0.893542,2,3,0,7.82173,0.238571 +-6.90581,0.939931,0.893542,1,3,0,7.83646,0.324177 +-7.3191,0.967991,0.893542,2,3,0,7.3193,0.396334 +-6.87495,0.933136,0.893542,1,3,0,7.38436,0.190804 +-6.83701,0.993074,0.893542,2,3,0,7.08813,0.199893 +-6.90181,0.937439,0.893542,1,3,0,7.90426,0.323187 +-7.50778,0.967637,0.893542,2,3,0,7.55018,0.420327 +-6.79785,0.95929,0.893542,1,3,0,7.32513,0.211991 +-6.76825,0.964756,0.893542,2,3,0,7.03183,0.225434 +-7.7663,0.813969,0.893542,1,3,0,8.14149,0.104648 +-8.28445,0.951373,0.893542,1,1,0,8.89219,0.0815789 +-6.798,1,0.893542,2,3,0,6.89971,0.290835 +-7.96471,0.624576,0.893542,1,3,0,10.1794,0.468651 +-6.84373,1,0.893542,1,1,0,7.0391,0.30715 +-6.88706,0.996501,0.893542,2,3,0,6.89105,0.188241 +-9.1298,0.958044,0.893542,1,1,0,9.17097,0.0568265 +-7.00325,0.956306,0.893542,1,3,0,8.44387,0.16849 +-6.7548,0.988382,0.893542,1,3,0,7.01503,0.235639 +-8.84044,0.809609,0.893542,1,3,0,9.23965,0.0640384 +-7.1499,0.984084,0.893542,2,3,0,10.9503,0.15044 +-7.36115,0.895032,0.893542,1,1,0,7.36506,0.401968 +-7.38921,0.997402,0.893542,2,3,0,7.54361,0.405629 +-6.91697,0.982646,0.893542,2,3,0,7.04653,0.182423 +-6.83026,1,0.893542,1,1,0,6.9702,0.30282 +-7.12517,0.852167,0.893542,2,3,0,7.99842,0.153142 +-7.22002,0.990319,0.893542,2,3,0,7.2282,0.143341 +-6.74851,0.999953,0.893542,2,3,0,6.74851,0.253933 +-7.87707,0.825783,0.893542,1,1,0,7.90574,0.460178 +-7.26136,0.729098,0.893542,1,1,0,8.07917,0.388273 +-6.81982,1,0.893542,1,1,0,6.93672,0.299233 +-6.83949,0.935179,0.893542,2,3,0,7.8525,0.30582 +-6.76306,0.982373,0.893542,1,3,0,7.06432,0.228751 +-7.51089,0.901172,0.893542,2,3,0,7.69551,0.420696 +-7.33103,0.965686,0.893542,1,1,0,7.59473,0.133464 +-6.77085,0.994129,0.893542,1,3,0,7.0468,0.223947 +-7.10471,1,0.893542,2,3,0,8.36342,0.155466 +-7.14708,0.852803,0.893542,2,3,0,9.73421,0.370969 +-7.35366,0.760265,0.893542,1,3,0,10.3121,0.131619 +-6.86726,0.984191,0.893542,2,3,0,6.88659,0.192506 +-6.84336,0.996219,0.893542,1,1,0,6.85278,0.198236 +-6.96117,0.97925,0.893542,1,1,0,6.96167,0.174854 +-6.88786,1,0.893542,2,3,0,6.96582,0.319635 +-6.77912,0.972048,0.893542,2,3,0,6.93624,0.219723 +-7.32871,0.886797,0.893542,1,3,0,7.42532,0.397639 +-7.42097,0.746871,0.893542,1,3,0,9.38528,0.12641 +-6.7719,0.997182,0.893542,2,3,0,6.87947,0.22337 +-8.08096,0.625553,0.893542,1,3,0,9.36703,0.0896459 +-8.40695,0.995314,0.893542,2,3,0,8.5388,0.077207 +-6.81602,1,0.893542,1,1,0,6.90342,0.205897 +-6.77417,0.989569,0.893542,1,3,0,6.91865,0.279283 +-6.7728,0.936876,0.893542,1,3,0,8.73462,0.27849 +-6.78713,0.95506,0.893542,2,3,0,7.09299,0.216174 +-6.8182,1,0.893542,1,1,0,6.84878,0.205228 +-6.93253,0.990489,0.893542,1,1,0,6.94376,0.179637 +-8.13445,0.925332,0.893542,2,3,0,8.1586,0.484232 +-8.04384,0.782521,0.893542,1,3,0,9.02872,0.476041 +-7.92031,0.949221,0.893542,1,1,0,8.44925,0.0968625 +-6.7646,0.953,0.893542,1,3,0,8.65462,0.273208 +-6.85695,0.934657,0.893542,1,3,0,7.49463,0.194889 +-6.79937,0.994631,0.893542,2,3,0,6.88504,0.211436 +-7.40222,0.635209,0.893542,1,3,0,10.5141,0.127821 +-6.79158,1,0.893542,2,3,0,7.28564,0.214371 +-6.75606,0.997124,0.893542,2,7,0,6.77186,0.266066 +-6.80144,0.954732,0.893542,1,3,0,8.03572,0.29226 +-6.84602,0.978431,0.893542,1,3,0,6.87719,0.19756 +-7.11836,0.881539,0.893542,2,3,0,7.76753,0.366272 +-6.86496,0.985804,0.893542,2,3,0,6.86533,0.193027 +-6.86828,0.96136,0.893542,2,7,0,7.20472,0.314361 +-7.53887,0.872829,0.893542,1,1,0,7.55208,0.423998 +-7.12425,0.94501,0.893542,1,3,0,7.17554,0.153245 +-8.27659,0.906837,0.893542,2,7,0,8.27726,0.496544 +-7.44597,0.988415,0.893542,2,3,0,8.53757,0.124574 +-6.99655,0.976035,0.893542,1,1,0,7.0165,0.344172 +-6.8392,1,0.893542,2,3,0,6.88655,0.199314 +-6.7546,0.990878,0.893542,2,3,0,6.88164,0.26452 +-6.77382,0.996327,0.893542,2,3,0,6.79403,0.222347 +-8.63218,1,0.893542,1,1,0,9.47983,0.069962 +-7.18774,0.943981,0.893542,1,3,0,8.8614,0.146514 +-7.06587,0.92559,0.893542,1,3,0,7.97096,0.357235 +-6.74806,0.999043,0.893542,1,3,0,8.19817,0.248862 +-6.79063,0.993948,0.893542,1,1,0,6.79094,0.287617 +-6.87918,0.919155,0.893542,1,3,0,7.7014,0.189894 +-6.75265,0.996916,0.893542,1,3,0,6.9244,0.238109 +-6.85385,0.986836,0.893542,1,1,0,6.85705,0.310215 +-6.74855,1,0.893542,2,3,0,7.20697,0.245955 +-6.7618,0.958406,0.893542,2,3,0,7.08051,0.271125 +-6.99502,1,0.893542,1,1,0,7.07013,0.343866 +-9.43658,0.876023,0.893542,2,3,0,9.52832,0.579686 +-9.28484,1,0.893542,2,7,0,9.2944,0.0533765 +-8.02321,0.95974,0.893542,1,1,0,8.05264,0.0921449 +-9.45372,0.9057,0.893542,2,3,0,9.89787,0.0499035 +-8.46252,1,0.893542,1,1,0,10.3979,0.511783 +-7.04689,1,0.893542,1,1,0,7.64587,0.353801 +-6.80889,0.994077,0.893542,1,1,0,6.8098,0.208166 +-6.7481,0.9982,0.893542,1,3,0,8.16179,0.248447 +-6.82272,0.989642,0.893542,2,3,0,6.83722,0.300254 +-6.79598,0.993073,0.893542,2,3,0,6.80704,0.289977 +-6.90826,1,0.893542,1,1,0,7.0259,0.324776 +-6.78732,0.996157,0.893542,2,3,0,6.78799,0.286083 +-6.7986,0.967615,0.893542,2,3,0,6.96113,0.211717 +-6.91191,1,0.893542,2,3,0,7.1293,0.325664 +-6.75031,0.99947,0.893542,2,3,0,6.75933,0.258512 +-8.18177,0.641915,0.893542,1,3,0,9.28973,0.0855138 +-6.82042,0.997665,0.893542,2,3,0,6.82485,0.299445 +-6.75572,0.992259,0.893542,1,3,0,6.92155,0.265721 +-6.75373,1,0.893542,1,1,0,6.75805,0.263508 +-6.85758,0.963908,0.893542,1,3,0,7.34118,0.311312 +-6.74802,0.999263,0.893542,1,3,0,6.78655,0.249988 +-6.75157,0.991344,0.893542,2,3,0,6.80921,0.239564 +-7.16221,0.966259,0.893542,2,3,0,7.40759,0.149136 +-7.24258,0.892908,0.893542,1,3,0,7.45016,0.385562 +-7.10664,0.945146,0.893542,1,1,0,7.31151,0.364308 +-6.80072,0.965216,0.893542,1,3,0,7.17102,0.210954 +-6.76875,0.851458,0.893542,1,3,0,7.67598,0.225141 +-6.9453,1,0.893542,2,3,0,8.16079,0.177453 +-6.91926,1,0.893542,1,1,0,6.98302,0.182005 +-7.35116,0.642892,0.893542,2,3,0,9.9814,0.13182 +-7.88205,1,0.893542,1,1,0,8.44908,0.0987105 +-7.11266,1,0.893542,1,1,0,7.40931,0.154553 +-6.76371,1,0.893542,1,3,0,7.21916,0.272567 +-6.90991,0.978864,0.893542,1,1,0,6.91453,0.325178 +-7.45634,0.98201,0.893542,1,1,0,7.50634,0.123827 +-6.90211,0.994983,0.893542,2,7,0,7.28155,0.323261 +-6.77947,0.962714,0.893542,2,3,0,7.08181,0.282188 +-6.75184,0.745155,0.893542,2,3,0,9.16661,0.239189 +-7.74147,0.947605,0.893542,1,1,0,7.74596,0.105996 +-6.87057,0.98642,0.893542,1,1,0,6.87654,0.314998 +-6.81201,1,0.893542,1,1,0,6.85755,0.296387 +-8.48038,0.929613,0.893542,1,1,0,8.48105,0.0747389 +-7.27352,0.903718,0.893542,1,1,0,7.27373,0.390004 +-6.86108,1,0.893542,1,1,0,6.90872,0.193919 +-6.86292,0.95982,0.893542,2,3,0,7.29784,0.31285 +-6.80992,0.965926,0.893542,2,3,0,7.33091,0.2956 +-6.79112,0.999876,0.893542,2,7,0,6.79116,0.28784 +-7.08836,0.942041,0.893542,2,3,0,7.43356,0.361185 +-6.88118,0.997365,0.893542,1,1,0,6.89963,0.18947 +-6.97256,0.982648,0.893542,2,7,0,6.97439,0.339268 +-7.27529,0.955698,0.893542,1,1,0,7.27532,0.138241 +-6.75145,0.983425,0.893542,2,3,0,6.87628,0.239743 +-6.94375,0.979415,0.893542,1,1,0,6.94384,0.177712 +-7.09367,0.887889,0.893542,2,7,0,7.49207,0.156758 +-7.89843,0.634589,0.893542,1,3,0,9.33682,0.0979129 +-7.81432,1,0.893542,1,1,0,8.42075,0.102118 +-7.57214,1,0.893542,1,1,0,8.15539,0.116002 +-6.878,0.93185,0.893542,2,3,0,7.1993,0.190146 +-6.75171,1,0.893542,2,3,0,6.77976,0.239369 +-6.78113,0.988946,0.893542,2,3,0,6.8319,0.21879 +-8.36477,1,0.893542,2,7,0,10.0364,0.078675 +-6.99272,0.984401,0.893542,2,7,0,7.67173,0.343404 +-6.75375,0.557799,0.893542,1,3,0,9.50201,0.263534 +-6.75413,0.809685,0.893542,2,3,0,8.35936,0.23636 +-6.86762,1,0.893542,1,1,0,6.92099,0.192425 +-6.83773,0.898375,0.893542,1,3,0,7.3829,0.30526 +-6.79931,1,0.893542,2,3,0,6.83336,0.291381 +-6.79902,0.998972,0.893542,2,7,0,6.9177,0.291261 +-6.95998,1,0.893542,2,3,0,7.00198,0.175044 +-7.17987,0.994049,0.893542,2,3,0,7.20337,0.147311 +-6.75535,0.975985,0.893542,1,3,0,8.19919,0.235075 +-6.74944,0.99847,0.893542,1,3,0,6.77479,0.24338 +-6.77564,0.99231,0.893542,1,3,0,6.79949,0.280116 +-7.75143,0.839023,0.893542,1,3,0,8.03776,0.105452 +-6.86844,1,0.893542,1,1,0,6.92052,0.314406 +-6.88032,0.83551,0.893542,2,3,0,9.32098,0.317648 +-6.75293,0.979421,0.893542,1,3,0,7.50434,0.262521 +-7.12738,0.997416,0.893542,2,3,0,8.35661,0.152896 +-8.84314,0.881472,0.893542,2,3,0,9.09551,0.063966 +-7.11276,0.765628,0.893542,1,1,0,7.81072,0.365337 +-9.46837,0.657186,0.893542,1,1,0,9.60993,0.581637 +-7.0764,0.964176,0.893542,2,3,0,7.19421,0.158831 +-8.49031,0.984236,0.893542,2,7,0,8.50354,0.513984 +-6.79304,1,0.893542,2,3,0,8.17491,0.213801 +-7.58137,0.995565,0.893542,2,7,0,7.62067,0.428906 +-6.75564,0.999575,0.893542,1,3,0,6.9606,0.265633 +-6.74894,0.999478,0.893542,1,3,0,6.75571,0.255388 +-7.29153,0.864424,0.893542,1,3,0,7.60725,0.136813 +-7.22414,0.9911,0.893542,1,1,0,7.33067,0.382853 +-6.80783,1,0.893542,2,7,0,6.97914,0.208515 +-7.80514,0.998119,0.893542,2,3,0,7.93082,0.102594 +-7.99254,0.735244,0.893542,2,7,0,8.82779,0.0935145 +-7.40497,1,0.893542,2,7,0,8.03465,0.127612 +-6.75591,1,0.893542,2,3,0,7.61009,0.234522 +-6.74827,0.992314,0.893542,1,3,0,7.08023,0.252773 +-6.89314,0.965703,0.893542,1,3,0,6.95528,0.320997 +-6.91042,0.975964,0.893542,1,3,0,6.92685,0.183642 +-6.89363,0.955246,0.893542,1,3,0,7.47727,0.321122 +-6.8912,1,0.893542,1,1,0,7.12263,0.320499 +-7.74459,0.875612,0.893542,2,3,0,7.78778,0.105825 +-7.01519,0.986086,0.893542,1,1,0,7.02849,0.166803 +-6.77371,0.997479,0.893542,2,3,0,6.93068,0.222405 +-6.90556,1,0.893542,1,1,0,6.94299,0.184565 +-7.04897,1,0.893542,1,1,0,7.13519,0.162276 +-7.00486,0.9046,0.893542,1,3,0,7.48598,0.168259 +-6.74844,0.994799,0.893542,1,3,0,6.95173,0.253614 +-8.28451,0.636553,0.893542,1,3,0,9.4636,0.0815767 +-7.70562,1,0.893542,1,1,0,7.90469,0.107992 +-6.99754,0.904112,0.893542,2,7,0,8.32984,0.34437 +-6.75476,0.996351,0.893542,1,3,0,6.79309,0.235681 +-6.76793,0.998723,0.893542,1,1,0,6.76994,0.275478 +-7.04686,0.967486,0.893542,2,7,0,8.24412,0.353795 +-6.74871,0.996331,0.893542,1,3,0,7.51065,0.254648 +-6.85681,0.987415,0.893542,1,1,0,6.86126,0.311086 +-6.75501,0.999328,0.893542,1,3,0,7.03588,0.264967 +-6.76255,1,0.893542,1,1,0,6.76578,0.229108 +-7.03963,0.941456,0.893542,1,3,0,7.12437,0.163494 +-6.76045,0.989536,0.893542,1,3,0,6.97861,0.270042 +-8.24567,0.636301,0.893542,2,7,0,9.5564,0.0830342 +-6.7695,0.982889,0.893542,1,3,0,8.70349,0.224711 +-6.80441,1,0.893542,1,1,0,6.85971,0.293456 +-6.9569,0.94763,0.893542,1,3,0,7.16463,0.335937 +-7.96674,0.865075,0.893542,1,1,0,8.07223,0.468843 +-7.07723,1,0.893542,2,3,0,7.22619,0.359246 +-6.86233,1,0.893542,2,3,0,6.89268,0.312683 +-6.92259,0.978676,0.893542,2,3,0,6.99573,0.1814 +-7.06071,0.972286,0.893542,1,1,0,7.09088,0.356311 +-6.76305,1,0.893542,2,3,0,7.057,0.228757 +-6.75928,0.995018,0.893542,1,3,0,6.80423,0.231561 +-6.75056,0.997648,0.893542,1,3,0,6.88611,0.241165 +-6.77377,0.997192,0.893542,1,1,0,6.77469,0.279055 +-6.88708,1,0.893542,1,1,0,7.03569,0.319432 +-7.03345,0.945507,0.893542,1,3,0,7.06905,0.351308 +-7.13459,0.848965,0.893542,2,3,0,8.3118,0.1521 +-9.70169,0.577917,0.893542,1,1,0,9.76496,0.595541 +-12.162,1,0.893542,1,1,0,12.6603,0.0183439 +-11.884,0.915672,0.893542,3,7,0,11.8859,0.0202423 +-11.1024,1,0.893542,1,1,0,12.0828,0.0268015 +-7.62519,1,0.893542,2,3,0,10.3134,0.112702 +-6.75409,0.999421,0.893542,1,3,0,6.79476,0.236399 +-6.78317,0.998359,0.893542,2,3,0,6.78344,0.284076 +-6.74925,0.995747,0.893542,1,3,0,6.87955,0.256235 +-7.11486,0.85724,0.893542,1,3,0,8.12899,0.154303 +-7.06062,0.910813,0.893542,1,3,0,7.29862,0.160789 +-6.84477,0.975241,0.893542,1,3,0,6.89426,0.197877 +-6.75078,0.992919,0.893542,2,3,0,6.79788,0.240788 +-7.10049,0.861908,0.893542,2,3,0,8.11541,0.155957 +-7.27713,0.932579,0.893542,2,3,0,7.38416,0.390515 +-7.36801,0.909021,0.893542,1,1,0,7.38609,0.402871 +-9.96712,0.760151,0.893542,1,3,0,10.7084,0.040878 +-6.77172,0.960459,0.893542,1,3,0,9.8645,0.223469 +-7.49083,0.924243,0.893542,2,3,0,7.57339,0.418295 +-7.41286,1,0.893542,1,1,0,8.27762,0.408656 +-6.75199,0.999971,0.893542,2,7,0,6.76174,0.261248 +-7.00309,0.689664,0.893542,1,3,0,8.84041,0.345471 +-6.89535,0.960323,0.893542,1,3,0,7.19016,0.32156 +-6.9776,0.879539,0.893542,1,3,0,7.77367,0.172285 +-6.75356,0.969982,0.893542,2,3,0,7.45002,0.263307 +-6.75126,0.988485,0.893542,2,3,0,6.84094,0.240032 +-6.76614,0.995264,0.893542,1,3,0,6.77583,0.226721 +-7.32114,0.958141,0.893542,2,3,0,7.33335,0.396611 +-6.89513,0.95682,0.893542,1,3,0,7.28053,0.321504 +-6.85419,0.930189,0.893542,2,3,0,7.89087,0.310316 +-6.7601,1,0.893542,2,3,0,7.03224,0.230914 +-7.00964,0.920915,0.893542,1,3,0,7.24297,0.167581 +-7.03245,0.889608,0.893542,2,7,0,7.5086,0.164448 +-7.88129,0.985932,0.893542,2,3,0,9.1198,0.0987477 +-6.75547,0.932937,0.893542,2,7,0,9.59677,0.234952 +-9.71787,0.981532,0.893542,1,1,0,9.8597,0.0449965 +-8.24704,1,0.893542,1,1,0,8.97084,0.0829825 +-8.45275,0.3072,0.893542,1,1,0,11.5949,0.511005 +-7.64205,0.990168,0.893542,2,3,0,8.97572,0.111687 +-7.06914,1,0.893542,1,1,0,7.24042,0.159725 +-7.25479,1,0.893542,2,7,0,8.19415,0.140087 +-6.7574,0.994406,0.893542,1,3,0,6.84551,0.267372 +-6.81942,0.98105,0.893542,1,3,0,6.86015,0.20486 +-6.99584,0.988209,0.893542,1,1,0,7.01084,0.16956 +-6.96395,0.946474,0.893542,1,3,0,7.33782,0.337451 +-6.7698,0.955675,0.893542,1,3,0,8.13848,0.276672 +-10.3624,0.999337,0.893542,2,3,0,10.6584,0.0352035 +-10.1644,0.947057,0.893542,1,1,0,10.1724,0.0379246 +-7.14963,0.933645,0.893542,1,3,0,9.51345,0.150469 +-7.28549,0.998403,0.893542,2,7,0,7.32436,0.39169 +-6.75483,1,0.893542,2,3,0,7.19038,0.264775 +-7.7652,0.803876,0.893542,1,3,0,8.05598,0.448878 +-7.01948,0.97881,0.893542,1,1,0,7.02291,0.166209 +-7.34297,0.931382,0.893542,1,3,0,7.40188,0.132484 +-6.75076,1,0.893542,2,3,0,7.1626,0.259333 +-6.77031,0.962803,0.893542,2,3,0,8.69741,0.224247 +-7.4592,0.852846,0.893542,1,3,0,7.80215,0.414444 +-6.75776,0.983389,0.893542,1,3,0,7.85554,0.232835 +-6.82804,0.980952,0.893542,1,3,0,6.86043,0.302076 +-6.75918,0.986538,0.893542,1,3,0,7.65035,0.231648 +-6.90429,0.998491,0.893542,2,3,0,6.92196,0.184809 +-6.76629,0.992922,0.893542,2,7,0,6.82205,0.274386 +-6.76466,0.996724,0.893542,2,3,0,6.79825,0.27325 +-7.36752,0.777891,0.893542,1,3,0,9.96554,0.130512 +-6.82028,1,0.893542,2,3,0,7.41596,0.204601 +-6.79702,1,0.893542,1,1,0,6.82605,0.212296 +-6.78727,0.985896,0.893542,1,3,0,6.91602,0.216116 +-6.75596,0.996972,0.893542,2,7,0,6.77539,0.265971 +-6.81085,0.993923,0.893542,1,1,0,6.8118,0.207529 +-7.89411,0.934237,0.893542,2,3,0,7.9135,0.46185 +-6.75231,0.997216,0.893542,1,3,0,6.79501,0.26169 +-8.78983,0.757752,0.893542,1,1,0,8.93818,0.536588 +-6.8495,0.858909,0.893542,1,3,0,7.64302,0.308917 +-7.16768,0.85654,0.893542,1,3,0,7.72511,0.148566 +-6.77385,0.99633,0.893542,1,1,0,6.77399,0.279101 +-9.27325,0.750085,0.893542,2,3,0,9.80726,0.569435 +-6.77718,1,0.893542,1,1,0,6.78438,0.280963 +-6.96174,0.997059,0.893542,2,3,0,6.97832,0.174762 +-6.82648,0.988643,0.893542,1,3,0,6.83246,0.202793 +-7.20825,1,0.893542,2,3,0,7.48866,0.14448 +-7.19776,1,0.893542,1,1,0,7.45566,0.378892 +-7.03861,0.889742,0.893542,1,3,0,7.64371,0.163629 +-6.78248,0.977119,0.893542,1,3,0,8.09464,0.218182 +-6.77452,0.996791,0.893542,2,3,0,6.77659,0.279486 +-7.22675,0.934431,0.893542,2,3,0,7.2279,0.142699 +-7.12753,0.873548,0.893542,2,3,0,9.07554,0.36779 +-6.92492,1,0.893542,1,1,0,7.03,0.328757 +-9.27743,0.872285,0.893542,2,3,0,9.38192,0.569703 +-8.93799,0.735248,0.893542,1,1,0,9.08599,0.547091 +-7.89761,0.862942,0.893542,1,1,0,7.98159,0.462193 +-8.26924,0.959606,0.893542,1,1,0,8.30529,0.0821452 +-9.69764,0.889658,0.893542,2,3,0,10.0493,0.0453516 +-6.77473,0.904585,0.893542,2,3,0,7.63132,0.279604 +-7.10456,0.957936,0.893542,1,3,0,8.33042,0.155484 +-7.634,0.938331,0.893542,1,1,0,7.76532,0.434823 +-7.66197,1,0.893542,1,1,0,8.99844,0.437899 +-6.93418,1,0.893542,2,3,0,7.07132,0.330893 +-7.0253,0.983173,0.893542,1,1,0,7.06402,0.349769 +-6.74802,0.774473,0.893542,1,3,0,7.96847,0.250278 +-6.74937,0.999988,0.893542,2,3,0,6.74958,0.243541 +-6.75221,1,0.893542,2,3,0,8.00855,0.261553 +-7.7963,0.962978,0.893542,1,1,0,7.82362,0.103056 +-6.88793,0.962184,0.893542,2,3,0,7.13982,0.319655 +-8.79515,0.999149,0.893542,2,3,0,9.01462,0.0652699 +-6.82066,0.988672,0.893542,2,7,0,8.03977,0.29953 +-7.26521,0.937608,0.893542,1,3,0,7.31682,0.139142 +-6.80124,0.999835,0.893542,2,7,0,6.80128,0.292178 +-7.3307,0.796511,0.893542,1,3,0,8.18101,0.133492 +-7.25921,0.98546,0.893542,2,3,0,7.25922,0.139685 +-6.75367,1,0.893542,2,3,0,7.06954,0.236868 +-7.27763,0.966213,0.893542,1,1,0,7.28368,0.138033 +-6.78897,0.998259,0.893542,2,7,0,7.10716,0.286854 +-7.38388,1,0.893542,1,1,0,7.57202,0.40494 +-7.19828,1,0.893542,1,1,0,7.46811,0.37897 +-6.78308,0.962502,0.893542,1,3,0,7.43531,0.217913 +-6.90393,0.998221,0.893542,1,1,0,6.93821,0.323712 +-7.10264,0.988971,0.893542,1,1,0,7.17218,0.363632 +-7.1463,0.884806,0.893542,2,3,0,8.62235,0.150826 +-6.77811,1,0.893542,1,1,0,6.80079,0.220204 +-6.81973,1,0.893542,1,1,0,6.84313,0.299201 +-7.09648,0.866786,0.893542,1,3,0,7.84853,0.156427 +-6.7487,0.994322,0.893542,1,3,0,7.11996,0.245426 +-7.20354,0.938578,0.893542,2,3,0,7.22393,0.144942 +-8.28102,0.945793,0.893542,2,7,0,8.43888,0.496919 +-7.00079,1,0.893542,2,3,0,7.06043,0.168843 +-8.31037,0.827102,0.893542,1,1,0,8.44743,0.499383 +-6.74809,0.97286,0.893542,2,3,0,7.04708,0.248522 +-7.84723,0.919234,0.893542,2,3,0,7.89835,0.457219 +-6.94864,1,0.893542,2,3,0,7.07359,0.334134 +-7.09511,0.726405,0.893542,1,3,0,10.157,0.156588 +-7.69435,0.917755,0.893542,2,3,0,7.86565,0.108632 +-7.6227,0.841363,0.893542,1,1,0,7.6244,0.433567 +-6.90388,0.992004,0.893542,1,1,0,6.91406,0.18489 +-9.01173,0.612419,0.893542,1,1,0,9.01523,0.552167 +-7.19,0.946856,0.893542,2,3,0,7.24767,0.146286 +-7.19517,0.977133,0.893542,1,1,0,7.26916,0.378497 +-7.91036,0.864506,0.893542,2,3,0,8.15791,0.463434 +-6.91814,1,0.893542,2,7,0,7.26427,0.182209 +-7.03319,0.980118,0.893542,1,1,0,7.03913,0.164348 +-7.44861,0.922691,0.893542,1,3,0,7.51616,0.124383 +-7.04902,1,0.893542,1,1,0,7.23086,0.16227 +-6.88083,0.994843,0.893542,2,3,0,7.41262,0.189543 +-6.92803,0.904079,0.893542,2,3,0,7.99236,0.180428 +-6.7499,0.99844,0.893542,1,3,0,6.9272,0.257704 +-8.50004,0.831237,0.893542,1,3,0,8.80634,0.0740961 +-6.8744,0.999199,0.893542,2,3,0,6.9,0.316051 +-6.76773,0.997706,0.893542,2,3,0,6.87983,0.225746 +-7.5917,0.992833,0.893542,2,3,0,7.6434,0.114767 +-9.11504,0.702585,0.893542,2,3,0,9.11572,0.0571691 +-8.53111,0.98624,0.893542,2,7,0,8.67576,0.517181 +-6.74905,0.985833,0.893542,2,3,0,7.3976,0.255709 +-7.26154,0.921447,0.893542,1,1,0,7.27192,0.388298 +-7.9014,0.947882,0.893542,1,1,0,8.12531,0.462562 +-9.51089,0.788191,0.893542,1,1,0,9.89938,0.584224 +-7.10478,1,0.893542,2,7,0,7.78298,0.155459 +-6.74916,0.974045,0.893542,2,3,0,6.93411,0.255994 +-6.84529,0.990083,0.893542,1,1,0,6.84596,0.197744 +-6.84122,0.96784,0.893542,1,3,0,6.98621,0.198786 +-6.75633,0.767931,0.893542,2,3,0,8.82708,0.23412 +-6.77814,0.877128,0.893542,1,3,0,7.4329,0.28148 +-6.86165,0.917524,0.893542,2,3,0,7.80688,0.312486 +-6.80486,0.99422,0.893542,2,3,0,6.89004,0.209515 +-9.1454,0.977445,0.893542,1,1,0,9.77837,0.561132 +-8.48933,1,0.893542,1,1,0,9.069,0.513907 +-6.76302,0.989133,0.893542,1,3,0,7.36265,0.228779 +-7.27007,0.88654,0.893542,1,3,0,7.5357,0.389515 +-6.83823,0.981783,0.893542,1,3,0,6.85989,0.199568 +-6.87479,0.964561,0.893542,1,3,0,6.96163,0.190839 +-7.02177,0.976272,0.893542,2,3,0,7.02958,0.349098 +-6.75672,0.978883,0.893542,2,3,0,6.91104,0.233758 +-6.84598,0.96544,0.893542,1,3,0,7.32987,0.307844 +-10.3709,0.591821,0.893542,2,7,0,10.4209,0.0350917 +-11.9315,0.965225,0.893542,1,1,0,11.9424,0.0199038 +-8.59499,0.907048,0.893542,3,7,0,11.4043,0.071094 +-10.1978,0.957745,0.893542,1,1,0,10.2262,0.0374494 +-6.75634,0.976621,0.893542,3,7,0,10.4651,0.234113 +-6.77791,0.992937,0.893542,1,3,0,6.78913,0.220301 +-7.69635,0.953407,0.893542,1,1,0,7.70522,0.108518 +-7.03621,0.999785,0.893542,1,1,0,7.08699,0.163947 +-7.61646,1,0.893542,2,7,0,7.66503,0.113234 +-7.09578,1,0.893542,1,1,0,7.29223,0.156509 +-6.84276,1,0.893542,2,3,0,6.88003,0.306848 +-6.83261,0.780933,0.893542,2,3,0,8.36156,0.201078 +-6.77696,0.954949,0.893542,2,3,0,7.10859,0.220761 +-6.80907,1,0.893542,1,1,0,6.82983,0.208106 +-6.97771,0.995645,0.893542,2,3,0,6.98818,0.172267 +-7.15318,0.900867,0.893542,1,3,0,7.36486,0.15009 +-6.81411,0.99824,0.893542,2,7,0,7.00992,0.297168 +-6.76667,0.992385,0.893542,2,3,0,6.90996,0.274643 +-6.891,0.976002,0.893542,1,3,0,6.91178,0.187435 +-7.67147,0.673351,0.893542,1,1,0,8.72389,0.438935 +-6.75544,0.984174,0.893542,1,3,0,7.24753,0.265425 +-6.85543,0.981929,0.893542,1,3,0,6.87018,0.195252 +-8.68825,1,0.893542,1,1,0,9.02023,0.0682997 +-10.3002,0.975713,0.893542,1,1,0,10.4014,0.036033 +-10.1524,1,0.893542,2,3,0,10.7075,0.0380976 +-6.75579,0.953157,0.893542,1,3,0,9.91194,0.234641 +-7.40503,0.750081,0.893542,1,3,0,8.94708,0.127608 +-7.54419,1,0.893542,1,1,0,7.9157,0.117809 +-7.54804,1,0.893542,1,1,0,7.73962,0.117557 +-7.63892,0.991006,0.893542,1,1,0,7.7352,0.111874 +-6.75294,0.987073,0.893542,1,3,0,7.21999,0.23774 +-6.76591,0.993895,0.893542,2,7,0,7.76004,0.274126 +-6.80772,0.981201,0.893542,1,3,0,7.0456,0.294754 +-6.86605,0.964344,0.893542,1,3,0,6.97044,0.192779 +-7.0157,0.974384,0.893542,1,1,0,7.01603,0.166732 +-6.7633,1,0.893542,1,1,0,6.77812,0.272265 +-7.52642,0.994605,0.893542,1,1,0,7.62445,0.118984 +-7.94448,0.62511,0.893542,2,7,0,9.50236,0.0957225 +-7.82429,1,0.893542,1,1,0,8.43156,0.101605 +-8.62635,0.949519,0.893542,1,1,0,8.64727,0.0701379 +-6.81512,0.963717,0.893542,1,3,0,7.1431,0.206176 +-6.85607,0.992454,0.893542,2,3,0,7.15585,0.195099 +-6.78478,0.987426,0.893542,1,3,0,6.84448,0.217173 +-6.93046,0.96955,0.893542,2,3,0,7.00447,0.33004 +-8.83794,0.875938,0.893542,2,3,0,8.94199,0.540045 +-7.54282,0.95619,0.893542,1,1,0,7.67827,0.424459 +-8.22271,0.775544,0.893542,1,1,0,8.26303,0.49195 +-7.8589,1,0.893542,2,3,0,8.35248,0.458381 +-6.95111,0.940377,0.893542,1,3,0,7.54648,0.334676 +-6.9784,0.997653,0.893542,2,3,0,7.02206,0.340483 +-7.0351,1,0.893542,1,1,0,7.13714,0.351617 +-7.41128,0.935339,0.893542,1,1,0,7.47617,0.408455 +-6.82044,0.979585,0.893542,1,3,0,6.93587,0.299453 +-6.90427,0.99184,0.893542,2,3,0,8.37955,0.184813 +-6.77021,0.990217,0.893542,1,3,0,6.9124,0.276928 +-6.78114,0.978468,0.893542,1,3,0,7.22751,0.28305 +-7.10992,0.979138,0.893542,2,3,0,7.11079,0.364861 +-6.82149,1,0.893542,1,1,0,6.84922,0.299825 +-6.94408,0.998736,0.893542,1,1,0,6.97678,0.177658 +-6.7781,0.989518,0.893542,1,3,0,6.89158,0.220209 +-9.16255,0.593199,0.893542,1,1,0,9.16714,0.562261 +-7.78084,1,0.893542,1,1,0,8.22956,0.450492 +-7.38587,0.955738,0.893542,1,1,0,7.47649,0.405197 +-6.99943,0.576743,0.893542,1,3,0,9.3436,0.344745 +-7.26806,0.872174,0.893542,2,3,0,7.75795,0.389229 +-6.84911,1,0.893542,2,3,0,7.54258,0.196788 +-7.28262,0.826643,0.893542,1,3,0,7.89461,0.137593 +-6.81228,0.963686,0.893542,1,3,0,7.15221,0.20707 +-7.10109,0.979002,0.893542,2,7,0,7.11233,0.363369 +-6.93568,0.928005,0.893542,2,3,0,7.56648,0.331234 +-7.8503,0.84918,0.893542,2,7,0,7.86288,0.100286 +-7.89618,1,0.893542,1,1,0,8.21196,0.462052 +-8.33624,0.880601,0.893542,1,1,0,8.56952,0.501535 +-8.57021,0.990647,0.893542,2,3,0,9.02886,0.520208 +-6.94485,0.926691,0.893542,2,7,0,7.25864,0.177528 +-6.77677,0.979375,0.893542,1,3,0,7.98376,0.220856 +-6.76036,0.980089,0.893542,2,3,0,7.15103,0.269966 +-6.79171,0.887418,0.893542,2,3,0,7.5698,0.214321 +-6.78602,0.984375,0.893542,1,3,0,6.8937,0.21664 +-6.76384,0.988043,0.893542,2,3,0,6.87371,0.228219 +-7.57391,0.792315,0.893542,1,3,0,8.11443,0.115889 +-10.4899,0.849165,0.893542,2,3,0,10.7302,0.0335673 +-7.15565,0.93317,0.893542,1,3,0,9.53461,0.149828 +-6.78663,0.985667,0.893542,1,3,0,7.43926,0.216384 +-7.11462,0.917627,0.893542,1,3,0,7.57004,0.365649 +-6.97076,1,0.893542,2,3,0,7.08546,0.338892 +-6.83667,0.961379,0.893542,2,7,0,7.26535,0.304921 +-6.87377,1,0.893542,1,1,0,6.94106,0.191062 +-7.50233,1,0.893542,1,1,0,7.63782,0.120609 +-7.02883,1,0.893542,2,3,0,8.11632,0.164934 +-8.17562,0.68016,0.893542,1,3,0,9.13707,0.0857578 +-6.81748,0.990579,0.893542,2,3,0,6.85324,0.205447 +-6.82329,0.961788,0.893542,1,3,0,10.5102,0.203714 +-7.80293,0.951123,0.893542,2,7,0,7.86236,0.452754 +-7.34351,0.966222,0.893542,2,3,0,7.34432,0.399627 +-7.05988,1,0.893542,1,1,0,7.14425,0.356161 +-6.81792,0.99057,0.893542,2,3,0,6.85572,0.205312 +-9.92437,0.908048,0.893542,2,7,0,10.35,0.608177 +-8.44095,1,0.893542,1,1,0,9.57837,0.510061 +-6.81172,0.998476,0.893542,2,3,0,6.81799,0.296279 +-7.04673,0.910845,0.893542,2,3,0,8.19125,0.353771 +-6.83782,0.995336,0.893542,1,1,0,6.84457,0.199678 +-6.84542,0.854434,0.893542,1,3,0,7.60991,0.307671 +-6.75174,0.999073,0.893542,1,3,0,6.75341,0.239322 +-7.05459,0.960812,0.893542,2,7,0,7.05521,0.161554 +-7.01357,1,0.893542,2,3,0,9.02084,0.167029 +-6.89215,1,0.893542,1,1,0,7.03196,0.187202 +-10.1185,1,0.893542,1,1,0,11.1643,0.0385897 +-6.9276,0.993916,0.893542,1,1,0,6.94527,0.180503 +-7.19672,0.97265,0.893542,2,7,0,7.20544,0.378733 +-6.87064,0.917391,0.893542,2,7,0,8.33936,0.315018 +-7.69122,0.589347,0.893542,1,3,0,9.81957,0.108811 +-6.92857,0.920063,0.893542,2,7,0,8.04444,0.329603 +-7.1012,1,0.893542,1,1,0,7.22484,0.363386 +-8.05846,0.812533,0.893542,1,1,0,8.11032,0.477382 +-6.74838,0.833086,0.893542,2,3,0,8.18868,0.246672 +-8.60253,0.75209,0.893542,2,3,0,8.60391,0.0708623 +-7.01141,0.935749,0.893542,1,3,0,9.76708,0.167332 +-7.50191,0.857684,0.893542,1,3,0,8.92516,0.419625 +-6.83485,1,0.893542,2,3,0,7.37018,0.200472 +-6.7966,0.94823,0.893542,1,3,0,8.12449,0.21245 +-6.75714,0.994852,0.893542,1,3,0,6.83489,0.267126 +-7.32383,0.994663,0.893542,1,1,0,7.39832,0.134063 +-6.75655,0.988431,0.893542,2,3,0,6.85434,0.233918 +-6.8346,1,0.893542,1,1,0,6.98102,0.304249 +-6.90563,1,0.893542,2,3,0,6.97224,0.184552 +-7.25743,1,0.893542,1,1,0,7.43218,0.387709 +-6.74924,0.964156,0.893542,3,7,0,9.54374,0.256216 +-6.96428,0.97917,0.893542,1,1,0,6.96487,0.174358 +-6.76864,1,0.893542,1,3,0,7.49997,0.275939 +-7.03377,0.979769,0.893542,1,1,0,7.03932,0.164271 +-7.07675,0.989457,0.893542,1,1,0,7.10477,0.158789 +-6.98645,0.915106,0.893542,2,7,0,7.32992,0.170947 +-7.38212,0.615363,0.893542,1,1,0,8.60694,0.404711 +-6.95854,1,0.893542,1,1,0,7.04715,0.336291 +-6.7508,0.999072,0.893542,1,3,0,6.87624,0.259389 +-6.77592,0.997232,0.893542,1,3,0,6.91911,0.221274 +-6.79303,0.980568,0.893542,2,3,0,7.083,0.288692 +-6.81311,0.99066,0.893542,1,1,0,6.81367,0.296799 +-6.93926,0.927597,0.893542,1,3,0,7.35988,0.178474 +-6.83139,1,0.893542,1,1,0,6.85332,0.201415 +-6.82883,0.685208,0.893542,2,3,0,9.21428,0.202126 +-7.36215,0.775143,0.893542,1,3,0,8.2297,0.130939 +-7.09564,1,0.893542,1,1,0,7.84254,0.362439 +-7.14343,1,0.893542,2,7,0,7.59016,0.151136 +-6.83573,1,0.893542,1,1,0,6.86892,0.304617 +-6.86139,0.987853,0.893542,2,3,0,6.963,0.193847 +-7.16699,0.902883,0.893542,2,3,0,7.52724,0.374133 +-7.47247,0.671449,0.893542,1,1,0,8.50035,0.416069 +-6.82289,0.945621,0.893542,2,3,0,7.70946,0.300312 +-6.88985,0.951437,0.893542,1,3,0,7.09162,0.187669 +-6.85422,0.888976,0.893542,2,3,0,7.6249,0.195542 +-6.74803,0.994868,0.893542,1,3,0,7.77254,0.249439 +-6.88339,1,0.893542,1,1,0,7.11009,0.318463 +-6.75913,0.983763,0.893542,2,3,0,7.04055,0.268933 +-7.16827,0.925431,0.893542,1,1,0,7.16883,0.374334 +-7.06615,1,0.893542,1,1,0,7.34574,0.357285 +-7.11094,0.919937,0.893542,1,3,0,7.62022,0.365032 +-7.14319,0.902825,0.893542,1,3,0,7.35137,0.151162 +-6.75349,0.976047,0.893542,2,3,0,7.14943,0.263223 +-7.569,0.844938,0.893542,1,3,0,7.695,0.42749 +-7.33587,0.989022,0.893542,1,1,0,7.46969,0.398604 +-7.10352,0.865095,0.893542,1,3,0,7.83405,0.155604 +-6.78975,0.978254,0.893542,1,3,0,7.23156,0.287214 +-6.79484,1,0.893542,1,1,0,6.81722,0.289484 +-6.74835,0.999897,0.893542,1,3,0,6.74905,0.246787 +-8.21726,0.717491,0.893542,2,3,0,9.07541,0.49148 +-6.79769,0.990292,0.893542,1,3,0,7.19916,0.212048 +-6.82711,0.974797,0.893542,1,3,0,7.06186,0.301764 +-6.74965,0.998881,0.893542,1,3,0,6.76635,0.257188 +-6.79743,0.973032,0.893542,2,3,0,7.03493,0.212145 +-7.63189,1,0.893542,1,1,0,7.98521,0.434589 +-6.76897,1,0.893542,2,3,0,6.77793,0.225015 +-6.79373,0.957867,0.893542,2,3,0,7.15594,0.288999 +-6.81114,0.972128,0.893542,1,3,0,7.00115,0.207435 +-6.74959,1,0.893542,1,1,0,6.75089,0.257052 +-7.10017,0.913201,0.893542,1,3,0,7.28317,0.155994 +-6.75159,0.988687,0.893542,1,3,0,7.38187,0.239538 +-7.7273,0.85674,0.893542,2,3,0,8.05937,0.444913 +-6.74893,0.985587,0.893542,2,3,0,7.85644,0.255366 +-6.95411,0.949027,0.893542,1,3,0,7.05467,0.175994 +-7.73178,0.744934,0.893542,1,3,0,8.45466,0.10653 +-7.3135,0.883075,0.893542,1,3,0,7.4736,0.395569 +-7.0887,0.953,0.893542,1,1,0,7.09914,0.361244 +-9.90789,0.493276,0.893542,1,1,0,9.90962,0.607262 +-6.90938,1,0.893542,2,3,0,6.95585,0.183839 +-7.15425,0.983141,0.893542,1,1,0,7.17717,0.149976 +-6.98329,1,0.893542,1,1,0,7.03062,0.17142 +-6.86378,0.97111,0.893542,1,3,0,6.93066,0.313094 +-6.75036,0.921868,0.893542,2,3,0,7.32095,0.241526 +-7.14161,0.946396,0.893542,2,3,0,7.14441,0.151334 +-6.90947,0.942899,0.893542,1,3,0,7.75047,0.325071 +-7.18366,0.987092,0.893542,2,3,0,7.22843,0.376731 +-7.75874,1,0.893542,1,1,0,8.31915,0.448207 +-7.51313,1,0.893542,2,7,0,8.20401,0.119876 +-6.77026,0.989154,0.893542,2,7,0,8.33786,0.276958 +-6.94043,0.921544,0.893542,1,3,0,7.31626,0.178275 +-6.74819,0.999876,0.893542,1,3,0,6.75002,0.252274 +-6.79789,1,0.893542,1,1,0,6.81157,0.211973 +-6.75331,1,0.893542,2,7,0,6.76546,0.237297 +-7.71003,0.891274,0.893542,2,3,0,7.88088,0.443082 +-8.54754,0.954579,0.893542,1,1,0,8.96942,0.518458 +-7.18567,1,0.893542,1,1,0,7.59237,0.37704 +-8.24221,0.783968,0.893542,1,1,0,8.29767,0.493622 +-7.07314,0.820854,0.893542,2,3,0,8.91068,0.358525 +-7.25379,1,0.893542,2,3,0,7.39282,0.140178 +-6.8448,0.983842,0.893542,1,3,0,7.434,0.197869 +-7.06036,1,0.893542,1,1,0,7.30734,0.356249 +-6.91919,0.974105,0.893542,1,1,0,6.92089,0.327408 +-7.25474,1,0.893542,1,1,0,7.54755,0.140092 +-7.7561,0.833786,0.893542,1,3,0,9.46022,0.447932 +-7.65705,1,0.893542,2,7,0,7.69934,0.110796 +-7.77692,0.968439,0.893542,1,1,0,7.815,0.10408 +-6.76783,0.965137,0.893542,1,3,0,8.79587,0.225687 +-6.9564,0.896249,0.893542,2,3,0,7.49084,0.175621 +-8.45413,0.848615,0.893542,2,3,0,8.58193,0.0756086 +-7.2217,0.969985,0.893542,2,7,0,7.23202,0.38249 +-6.77875,0.972311,0.893542,1,3,0,7.1642,0.219898 +-7.01865,0.941319,0.893542,1,3,0,7.09572,0.3485 +-8.76882,1,0.893542,1,1,0,9.65383,0.0659999 +-10.5334,0.941498,0.893542,1,1,0,10.5338,0.0330294 +-11.1091,0.964982,0.893542,1,1,0,11.1391,0.0267367 +-10.6324,0.993,0.893542,1,1,0,10.8746,0.0318388 +-8.28105,0.995216,0.893542,2,3,0,10.2984,0.0817049 +-6.78553,0.988216,0.893542,1,3,0,6.84026,0.216848 +-8.56603,0.966894,0.893542,1,1,0,8.62852,0.0719921 +-9.51213,0.732309,0.893542,1,1,0,9.79745,0.584299 +-9.78956,1,0.893542,2,7,0,9.93855,0.0437644 +-6.8626,0.957772,0.893542,1,3,0,7.09931,0.193569 +-7.1078,0.87978,0.893542,1,3,0,7.54941,0.155111 +-7.33884,0.981143,0.893542,1,1,0,7.52806,0.399002 +-6.88101,0.982907,0.893542,2,3,0,6.88299,0.189506 +-7.19094,0.968169,0.893542,1,1,0,7.19454,0.146192 +-7.52349,0.867009,0.893542,1,1,0,7.52926,0.42219 +-7.67752,1,0.893542,1,1,0,9.34744,0.43959 +-6.80364,0.953052,0.893542,1,3,0,7.4425,0.209932 +-6.90462,0.934191,0.893542,2,7,0,7.22018,0.184745 +-7.51051,0.882226,0.893542,1,3,0,7.68249,0.120053 +-8.28025,0.992075,0.893542,2,3,0,8.36561,0.0817348 +-6.75607,0.995905,0.893542,2,7,0,8.02875,0.266083 +-7.00286,1,0.893542,1,1,0,7.14237,0.345424 +-7.27697,0.992313,0.893542,2,3,0,7.37317,0.390492 +-8.40859,0.898781,0.893542,2,3,0,8.42763,0.507457 +-8.75879,0.967917,0.893542,2,3,0,9.15181,0.534335 +-7.22414,0.84046,0.893542,1,1,0,7.71002,0.382853 +-6.8529,0.947559,0.893542,1,3,0,7.23514,0.195861 +-7.12148,1,0.893542,1,1,0,7.47792,0.153555 +-6.94162,0.98788,0.893542,2,3,0,7.26372,0.178073 +-8.03763,0.988755,0.893542,2,7,0,8.04011,0.47547 +-9.28886,0.899027,0.893542,2,3,0,9.45707,0.570432 +-6.75869,0.957176,0.893542,2,3,0,8.30871,0.268549 +-6.7601,0.999206,0.893542,1,1,0,6.76125,0.269758 +-6.87367,0.960664,0.893542,1,3,0,7.25764,0.315851 +-6.74803,0.823037,0.893542,2,3,0,8.31941,0.249645 +-7.07178,0.947101,0.893542,2,3,0,9.78308,0.159399 +-7.07419,0.879406,0.893542,2,7,0,7.57606,0.159102 +-7.08305,0.897877,0.893542,1,3,0,8.68229,0.360263 +-8.88087,0.9488,0.893542,1,1,0,8.90153,0.0629641 +-6.94532,1,0.893542,2,3,0,7.17671,0.3334 +-6.81395,0.936564,0.893542,1,3,0,8.26763,0.20654 +-6.79206,0.998171,0.893542,1,1,0,6.79857,0.288258 +-6.75374,1,0.893542,1,1,0,6.75959,0.263526 +-7.83885,0.74952,0.893542,1,3,0,8.48334,0.100864 +-8.14782,0.956991,0.893542,1,1,0,8.17533,0.0868743 +-6.77015,1,0.893542,1,1,0,6.786,0.224338 +-7.26663,0.776222,0.893542,2,7,0,8.32087,0.139014 +-6.75038,0.999719,0.893542,1,3,0,6.7714,0.24149 +-6.79368,1,0.893542,1,1,0,6.81865,0.213555 +-7.91048,1,0.893542,2,3,0,8.21584,0.0973322 +-7.55512,1,0.893542,1,1,0,7.93949,0.117097 +-6.81043,0.974946,0.893542,2,3,0,7.04845,0.207662 +-6.93009,1,0.893542,1,1,0,7.10642,0.329955 +-6.94672,0.994348,0.893542,1,1,0,6.96831,0.177214 +-6.83557,0.958862,0.893542,1,3,0,7.55032,0.304566 +-6.75655,0.991688,0.893542,1,3,0,6.88023,0.233921 +-6.74888,0.996322,0.893542,1,3,0,7.21774,0.255194 +-6.79904,0.94668,0.893542,1,3,0,8.18517,0.211555 +-6.80716,0.978911,0.893542,1,3,0,6.92151,0.208738 +-6.75651,0.992159,0.893542,1,3,0,6.86927,0.233958 +-7.08698,0.922751,0.893542,1,3,0,7.25285,0.360946 +-7.29434,0.487347,0.893542,2,3,0,11.0485,0.13657 +-7.68817,0.985139,0.893542,1,1,0,7.76804,0.108986 +-7.8273,0.935324,0.893542,2,3,0,8.20529,0.101451 +-6.74902,1,0.893542,2,3,0,6.80752,0.255627 +-8.1087,0.79855,0.893542,2,3,0,9.9345,0.0884807 +-6.75571,0.999872,0.893542,2,3,0,6.7565,0.23472 +-6.96102,1,0.893542,1,1,0,7.02674,0.336824 +-6.92519,1,0.893542,1,1,0,6.99479,0.328819 +-6.86312,0.991273,0.893542,1,1,0,6.87457,0.312908 +-6.86312,0.957882,0.893542,1,1,0,6.99385,0.312908 +-6.82277,0.885321,0.893542,2,3,0,8.08602,0.300271 +-6.75832,0.988978,0.893542,1,3,0,7.43606,0.232356 +-6.75421,0.999448,0.893542,2,3,0,6.84171,0.236271 +-6.7802,0.962711,0.893542,1,3,0,7.51103,0.21922 +-7.19116,0.928613,0.893542,1,3,0,7.27488,0.146171 +-6.79023,0.980453,0.893542,2,3,0,6.95438,0.287434 +-7.10491,0.969998,0.893542,2,7,0,8.10814,0.364016 +-6.96849,0.708395,0.893542,1,3,0,8.67156,0.338413 +-7.00157,1,0.893542,1,1,0,7.10485,0.34517 +-6.83342,1,0.893542,1,1,0,6.96062,0.303864 +-6.7899,1,0.893542,1,1,0,6.86006,0.287284 +-6.76584,0.995209,0.893542,2,3,0,6.83156,0.274076 +-6.7481,0.999996,0.893542,1,3,0,6.7487,0.251594 +-7.69732,0.690304,0.893542,1,3,0,8.91128,0.108462 +-6.78666,0.768123,0.893542,1,3,0,8.29349,0.216368 +-6.8268,0.979145,0.893542,1,3,0,7.65751,0.2027 +-6.86763,0.948579,0.893542,1,3,0,7.15721,0.192424 +-6.78435,0.999599,0.893542,2,3,0,6.79025,0.284659 +-7.36262,0.825137,0.893542,1,3,0,7.89797,0.130901 +-6.94964,0.970875,0.893542,1,3,0,6.97002,0.176729 +-7.34661,0.974973,0.893542,2,7,0,7.3961,0.400041 +-8.25163,0.729915,0.893542,1,3,0,8.66381,0.494427 +-6.82345,1,0.893542,2,3,0,8.46039,0.203667 +-7.12807,0.875934,0.893542,1,3,0,7.56058,0.152819 +-6.87469,0.993329,0.893542,2,3,0,6.87516,0.31613 +-6.87026,0.941408,0.893542,1,3,0,7.2533,0.191835 +-6.9233,0.972337,0.893542,2,3,0,6.98259,0.328377 +-6.80795,1,0.893542,2,3,0,6.84327,0.294842 +-6.76557,1,0.893542,1,1,0,6.77939,0.273889 +-6.75773,0.95602,0.893542,2,3,0,7.07214,0.232855 +-6.76249,0.997445,0.893542,2,3,0,6.77302,0.271656 +-6.76281,0.986375,0.893542,2,3,0,6.86269,0.271897 +-6.76113,0.94439,0.893542,1,3,0,8.69857,0.270596 +-6.74805,1,0.893542,2,3,0,6.93295,0.250908 +-6.84782,0.893603,0.893542,1,3,0,7.41716,0.308405 +-6.77903,0.978878,0.893542,1,3,0,7.01391,0.219764 +-6.82158,0.979514,0.893542,2,3,0,7.02007,0.299854 +-6.91421,0.993684,0.893542,1,1,0,6.92934,0.182933 +-7.48992,0.864331,0.893542,1,3,0,7.56874,0.418185 +-6.81012,0.721139,0.893542,2,3,0,8.92433,0.207765 +-7.63103,0.878322,0.893542,2,7,0,7.63449,0.112349 +-6.77304,1,0.893542,2,3,0,7.67683,0.222757 +-6.78727,1,0.893542,1,1,0,6.79546,0.216114 +-6.74808,0.999236,0.893542,1,3,0,6.77739,0.251386 +-6.74974,0.999801,0.893542,2,3,0,6.74978,0.242718 +-7.38891,0.822956,0.893542,2,3,0,8.6674,0.12884 +-7.35687,1,0.893542,2,3,0,7.69302,0.131361 +-9.18298,0.902893,0.893542,1,1,0,9.69343,0.563599 +-8.05869,1,0.893542,1,1,0,10.1532,0.477404 +-6.96836,1,0.893542,1,1,0,7.10551,0.338386 +-6.9304,0.929449,0.893542,1,3,0,8.06547,0.330027 +-6.92115,0.891849,0.893542,1,3,0,7.51124,0.327871 +-8.02156,1,0.893542,2,3,0,8.24598,0.092218 +-6.75303,0.989588,0.893542,2,3,0,6.82494,0.262643 +-6.78272,0.990182,0.893542,1,3,0,6.81767,0.283853 +-6.85178,1,0.893542,1,1,0,6.90302,0.196133 +-6.77157,0.959899,0.893542,2,7,0,7.73313,0.277758 +-8.79178,0.746585,0.893542,2,7,0,8.79209,0.0653629 +-8.69829,1,0.893542,1,1,0,9.36877,0.0680073 +-6.84428,1,0.893542,1,1,0,6.88821,0.198 +-6.77692,1,0.893542,1,1,0,6.82237,0.28082 +-6.97366,0.966273,0.893542,1,1,0,6.97682,0.339498 +-7.88076,0.784993,0.893542,1,3,0,8.22929,0.460542 +-7.43284,0.950784,0.893542,1,1,0,7.52833,0.411174 +-6.76927,0.975413,0.893542,2,3,0,6.91779,0.224841 +-6.74956,0.997429,0.893542,1,3,0,6.90262,0.243101 +-6.8683,0.898813,0.893542,2,3,0,7.58552,0.192272 +-6.75019,0.998896,0.893542,2,3,0,6.81672,0.258297 +-7.21114,0.991312,0.893542,2,3,0,8.20783,0.144199 +-7.41832,0.991695,0.893542,2,3,0,7.44815,0.126608 +-6.77366,0.970497,0.893542,1,3,0,7.30196,0.222431 +-8.62779,0.777407,0.893542,1,3,0,9.15162,0.0700944 +-7.46165,0.997974,0.893542,2,3,0,9.16662,0.123447 +-7.61705,1,0.893542,1,1,0,7.78982,0.113198 +-6.94156,1,0.893542,1,1,0,7.0786,0.178083 +-7.21381,1,0.893542,1,1,0,7.32268,0.14394 +-7.7941,0.957178,0.893542,1,1,0,7.81119,0.103172 +-6.8825,0.968295,0.893542,1,3,0,8.06705,0.18919 +-6.89898,0.997095,0.893542,1,1,0,6.91975,0.185842 +-8.402,0.473448,0.893542,1,3,0,10.8502,0.0773773 +-6.90626,0.993071,0.893542,1,1,0,6.9189,0.184432 +-6.765,0.90538,0.893542,2,3,0,7.5821,0.27349 +-7.24796,0.90784,0.893542,1,3,0,7.29898,0.386343 +-6.76359,0.98534,0.893542,1,3,0,7.10915,0.272479 +-6.82288,0.987902,0.893542,1,3,0,6.83123,0.203833 +-6.79573,0.979377,0.893542,2,3,0,6.97307,0.289866 +-7.21368,0.925907,0.893542,2,3,0,7.71003,0.381294 +-10.7991,0.551071,0.893542,2,7,0,10.8421,0.652749 +-7.87546,1,0.893542,2,3,0,10.607,0.460019 +-7.92352,0.909597,0.893542,2,3,0,8.13781,0.0967101 +-6.93072,0.914194,0.893542,1,3,0,8.80891,0.330101 +-7.50376,0.94569,0.893542,2,3,0,7.50387,0.419846 +-7.01412,1,0.893542,1,1,0,7.28116,0.347627 +-7.00028,1,0.893542,1,1,0,7.05327,0.168916 +-7.73797,1,0.893542,2,7,0,7.73887,0.106188 +-7.42435,0.971265,0.893542,2,3,0,7.92836,0.126159 +-6.87293,0.921432,0.893542,2,3,0,8.33509,0.191245 +-7.03049,0.969451,0.893542,2,3,0,7.15523,0.16471 +-6.86372,0.984889,0.893542,2,3,0,6.9099,0.193311 +-7.44724,0.913212,0.893542,2,7,0,7.46305,0.124482 +-7.65473,1,0.893542,1,1,0,7.96582,0.110933 +-6.80383,0.970587,0.893542,2,3,0,6.94227,0.209867 +-7.00916,0.949675,0.893542,1,3,0,7.07523,0.167648 +-6.75061,0.850157,0.893542,1,3,0,7.49258,0.25906 +-7.18467,1,0.893542,1,1,0,7.5464,0.376886 +-6.75191,1,0.893542,1,1,0,6.75724,0.261132 +-6.85108,0.974373,0.893542,1,3,0,6.90736,0.30939 +-7.14776,0.926946,0.893542,1,1,0,7.1478,0.371079 +-7.06676,0.830396,0.893542,1,3,0,8.16796,0.160021 +-7.45,1,0.893542,1,1,0,8.49503,0.41331 +-6.7519,0.998251,0.893542,1,3,0,7.17837,0.26112 +-7.11035,0.951128,0.893542,2,3,0,7.12891,0.154817 +-7.39068,0.943243,0.893542,2,3,0,7.59531,0.128704 +-6.83562,0.923653,0.893542,2,7,0,8.32548,0.30458 +-7.07053,0.632118,0.893542,1,3,0,11.0542,0.159553 +-6.75061,0.910964,0.893542,2,3,0,7.46035,0.259059 +-6.75537,0.956651,0.893542,2,7,0,8.09543,0.265356 +-6.78308,0.98677,0.893542,1,3,0,7.39142,0.217913 +-7.38165,0.961921,0.893542,2,3,0,7.76363,0.129403 +-7.03142,0.898992,0.893542,1,3,0,8.98448,0.350926 +-7.04088,0.988893,0.893542,2,3,0,7.65163,0.16333 +-6.87095,0.915429,0.893542,2,3,0,7.45833,0.191681 +-7.15224,0.821483,0.893542,1,3,0,8.00485,0.150191 +-6.79186,0.972862,0.893542,1,3,0,7.43044,0.288168 +-6.99267,0.906552,0.893542,1,3,0,7.53875,0.170024 +-8.99067,0.95291,0.893542,1,1,0,9.01947,0.0601596 +-7.79631,0.994652,0.893542,2,3,0,7.8808,0.103056 +-6.82228,0.975544,0.893542,1,3,0,7.14406,0.300101 +-6.91394,0.90751,0.893542,2,3,0,7.60693,0.182984 +-6.87231,0.863358,0.893542,2,3,0,7.80616,0.191383 +-6.79566,0.972779,0.893542,2,3,0,7.03308,0.212802 +-6.90571,0.973746,0.893542,1,1,0,6.90591,0.32415 +-6.93631,0.927568,0.893542,1,3,0,7.4234,0.178981 +-6.75471,0.995231,0.893542,1,3,0,7.01688,0.235737 +-8.24271,0.656504,0.893542,2,7,0,9.44716,0.0831471 +-6.82097,1,0.893542,2,3,0,8.12546,0.204396 +-8.26863,0.91338,0.893542,1,1,0,8.5389,0.495871 +-6.74889,1,0.893542,2,3,0,8.03173,0.244801 +-6.76259,0.994378,0.893542,2,3,0,6.79049,0.229082 +-6.76152,1,0.893542,1,3,0,7.76237,0.270906 +-8.09911,0.825974,0.893542,2,3,0,8.12171,0.0888807 +-6.75364,0.997546,0.893542,1,3,0,6.88874,0.236906 +-6.85296,1,0.893542,2,7,0,7.20801,0.195847 +-6.74873,0.97661,0.893542,2,3,0,6.97191,0.245324 +-7.00005,0.941392,0.893542,1,3,0,7.11865,0.344869 +-7.15822,1,0.893542,1,1,0,7.29547,0.372747 +-7.02515,0.871237,0.893542,2,7,0,7.79766,0.165433 +-7.11869,0.861393,0.893542,1,3,0,7.82004,0.153869 +-6.82917,0.977344,0.893542,1,3,0,6.99035,0.302459 +-6.80347,0.973946,0.893542,1,3,0,7.00728,0.209993 +-6.75213,1,0.893542,2,3,0,6.78522,0.23878 +-6.79996,0.985858,0.893542,1,3,0,6.84375,0.291653 +-6.75831,0.997242,0.893542,1,3,0,6.76497,0.268206 +-6.75111,0.998343,0.893542,1,3,0,6.76907,0.24027 +-10.3308,0.549825,0.893542,2,7,0,10.5088,0.629819 +-10.5954,0.978406,0.893542,1,1,0,10.7078,0.0322776 +-9.03458,1,0.893542,1,1,0,10.0862,0.0590819 +-7.58478,0.886552,0.893542,1,3,0,7.73728,0.115201 +-9.91973,1,0.893542,1,1,0,10.5231,0.0416263 +-7.48944,1,0.893542,2,3,0,9.43402,0.121496 +-7.71315,0.865118,0.893542,2,7,0,7.71389,0.107568 +# +# Elapsed Time: 0.005 seconds (Warm-up) +# 0.015 seconds (Sampling) +# 0.02 seconds (Total) +# diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_warmup.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_warmup.csv new file mode 100644 index 0000000000..799f5c8260 --- /dev/null +++ b/src/test/unit/mcmc/test_csv_files/bernoulli_warmup.csv @@ -0,0 +1,2057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-07-22 12:26:39 UTC +# method = sample (Default) +# sample +# num_samples = 1000 (Default) +# num_warmup = 1000 (Default) +# save_warmup = true +# 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 = examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 3784445287 (Default) +# output +# file = output.csv (Default) +# 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-25-gbb9ce42 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,theta +-9.8506,1,0.5,1,1,0,11.6894,0.604056 +-9.8506,0,14.3855,0,1,1,9.9718,0.604056 +-9.8506,1.07054e-09,2.43117,1,1,0,10.1705,0.604056 +-8.24874,1,0.239791,2,3,0,9.78315,0.49418 +-8.54651,0.976787,0.324332,1,1,0,8.57154,0.518378 +-7.21218,0.977577,0.47329,2,3,0,8.85175,0.38107 +-6.74823,1,0.750786,1,3,0,7.08766,0.247464 +-6.74823,0.0568166,1.34037,1,1,0,7.21871,0.247464 +-6.88855,0.99524,0.127193,3,15,0,7.76928,0.319814 +-7.18954,0.980866,0.230706,3,9,0,7.91162,0.146333 +-7.00517,0.999406,0.406612,2,3,0,7.22475,0.168215 +-7.00517,0.908606,0.766132,1,3,0,7.56833,0.168215 +-6.75143,1,1.08692,1,1,0,6.86451,0.239771 +-6.87144,0.77589,2.05487,1,1,0,7.04035,0.191574 +-6.7634,0.633501,1.92269,1,3,0,6.7636,0.272338 +-6.76111,1,1.1598,1,3,0,6.76265,0.23015 +-6.80263,0.90372,2.17832,1,1,0,6.9112,0.210282 +-6.80263,0.0115697,3.02409,1,1,0,7.38493,0.210282 +-6.74812,0.999483,0.279874,2,7,0,6.83911,0.248267 +-6.79674,0.990221,0.524639,1,3,0,6.8362,0.2903 +-6.79674,0.70284,0.947731,1,1,0,7.09021,0.2903 +-6.79674,0.970796,0.725248,1,1,0,6.86262,0.2903 +-6.85069,0.950437,1.22339,1,1,0,6.91591,0.309273 +-6.85069,0.0172536,1.92853,1,1,0,7.04452,0.309273 +-8.64872,0.977805,0.204974,4,15,0,8.65035,0.0694662 +-6.76625,0.999785,0.352164,3,7,0,8.64791,0.226652 +-7.04444,0.971063,0.638147,2,3,0,7.06282,0.353351 +-9.92209,0.0721566,1.05618,2,3,0,10.5028,0.0415885 +-9.86371,1,0.141791,1,1,0,9.92203,0.0425312 +-7.89631,0.998185,0.255292,2,5,0,10.4841,0.0980156 +-8.58774,0.971383,0.452922,3,7,0,9.25298,0.0713172 +-8.34876,1,0.740085,1,1,0,8.76482,0.0792422 +-6.81748,1,1.29574,1,1,0,7.18455,0.298398 +-6.81748,2.00258e-21,2.24798,1,1,0,9.56968,0.298398 +-6.81248,0.991645,0.272988,2,7,0,7.15155,0.207006 +-6.85997,0.987319,0.46496,3,7,0,7.06891,0.312004 +-6.85997,0.220416,0.776452,1,3,0,9.96316,0.312004 +-7.79145,0.984064,0.176692,2,5,0,7.96719,0.451582 +-6.99048,0.972469,0.292427,1,3,0,8.47322,0.342953 +-7.06807,0.988568,0.466233,1,1,0,7.08132,0.357627 +-7.08394,0.993545,0.768751,1,1,0,7.20573,0.360419 +-7.26741,0.94431,1.27388,1,3,0,7.27623,0.138945 +-7.48585,0.77512,1.85318,1,1,0,8.38914,0.121745 +-7.48585,1.62756e-06,1.76397,1,1,0,7.58761,0.121745 +-7.10351,0.961717,0.250226,2,7,0,10.7736,0.363778 +-7.22772,0.995816,0.381071,2,3,0,7.23134,0.383382 +-7.22772,0.740624,0.626526,1,1,0,7.99246,0.383382 +-6.76514,0.9988,0.553652,3,7,0,7.23247,0.273593 +-7.24015,0.753856,0.908029,2,3,0,7.63644,0.141438 +-7.82255,0.843494,0.827165,2,3,0,8.8872,0.101695 +-8.86463,0.811428,0.931855,1,1,0,8.98534,0.063393 +-11.6045,0.716868,0.97225,1,1,0,11.627,0.0223639 +-12.6025,0.963255,0.813589,1,1,0,12.8485,0.015712 +-9.06531,1,1.20587,1,1,0,12.2187,0.0583422 +-9.06531,0.00836889,1.93475,1,3,0,9.22574,0.0583422 +-9.27905,0.996483,0.321074,1,1,0,9.28335,0.0535007 +-7.55918,1,0.512183,2,3,0,9.21965,0.116834 +-6.85233,1,0.818727,1,3,0,7.36428,0.196 +-6.85233,0.261701,1.30115,1,1,0,8.07242,0.196 +-6.75988,0.982676,0.397354,2,5,0,7.25685,0.269571 +-6.75307,0.870464,0.606899,2,3,0,7.74945,0.237579 +-6.83359,0.805991,0.720486,2,3,0,7.86816,0.200813 +-6.75042,0.994755,0.741288,2,3,0,6.86534,0.241401 +-8.55542,0.374605,1.14933,1,1,0,8.55542,0.0723249 +-8.22182,1,0.463832,1,1,0,8.55035,0.0839477 +-7.86203,1,0.72551,1,1,0,8.28083,0.0996991 +-7.86203,0.000595519,1.12906,1,1,0,11.1731,0.0996991 +-6.79482,0.998815,0.208853,3,11,0,7.93002,0.213117 +-9.08274,0.888926,0.3248,2,7,0,10.1982,0.556966 +-8.952,1,0.398939,2,3,0,9.27498,0.548062 +-9.18855,0.999125,0.616734,2,7,0,9.20778,0.0554879 +-7.24774,1,0.947222,1,1,0,8.69856,0.140734 +-7.24774,0.202087,1.45078,1,1,0,7.29856,0.140734 +-7.26566,0.998816,0.427919,1,1,0,7.29767,0.139102 +-6.91413,0.931556,0.65354,1,3,0,7.86673,0.3262 +-6.87128,1,0.86646,2,3,0,6.89856,0.19161 +-6.768,1,1.3159,1,1,0,6.78045,0.275525 +-6.768,8.67729e-08,1.98999,1,1,0,7.59461,0.275525 +-7.9148,0.904272,0.402673,2,5,0,8.38631,0.0971256 +-7.06381,0.980558,0.503805,2,3,0,8.46016,0.160389 +-7.39013,0.978768,0.731889,2,3,0,7.40663,0.128747 +-6.76543,1,1.05559,2,3,0,7.04327,0.273794 +-6.76543,0.159028,1.5818,1,1,0,7.09493,0.273794 +-6.91956,0.94612,0.454522,1,3,0,7.39536,0.181949 +-6.76739,0.950092,0.613207,2,3,0,7.38962,0.225951 +-6.85207,0.970879,0.831322,1,1,0,6.85346,0.196063 +-12.4758,0.00604068,1.16985,1,1,0,13.3062,0.721196 +-11.7387,1,0.2566,2,3,0,12.4659,0.693413 +-10.2243,1,0.382607,1,1,0,11.6102,0.624313 +-10.8714,0.865432,0.568409,1,1,0,11.5235,0.656119 +-8.28112,1,0.651815,2,7,0,10.3982,0.0817023 +-7.07017,1,0.962578,1,1,0,7.92797,0.159598 +-7.00702,1,1.41659,1,1,0,7.28115,0.167951 +-7.00702,0.0463564,2.07767,1,1,0,8.55227,0.167951 +-7.51448,0.811914,0.513168,2,5,0,9.45773,0.421124 +-6.80546,1,0.53134,3,7,0,7.47906,0.293871 +-6.75523,0.9975,0.778651,2,3,0,6.82148,0.2352 +-7.98668,0.510767,1.13214,1,1,0,7.99159,0.0937796 +-8.57516,0.940216,0.672299,1,1,0,8.61556,0.0717072 +-10.9654,0.756415,0.878176,1,1,0,10.9668,0.0281728 +-10.9654,2.39406e-53,3.2776,2,7,0,11.462,0.0281728 +-10.9654,0,7.65341,0,1,1,11.0171,0.0281728 +-11.2278,0.98842,0.754621,1,1,0,11.6163,0.0256105 +-9.18505,0.81209,0.762058,1,3,0,11.0807,0.0555666 +-7.31509,1,0.601188,2,3,0,9.13989,0.134796 +-7.37962,0.974851,0.917142,2,3,0,7.39422,0.404387 +-7.93864,0.71181,1.42246,2,3,0,7.93864,0.0959959 +-8.52121,0.863499,1.02619,2,3,0,8.52132,0.516409 +-8.72953,0.796954,1.21163,1,1,0,10.711,0.532192 +-8.45453,0.939049,1.18105,1,3,0,8.96188,0.0755954 +-8.45453,7.70205e-05,1.82485,1,1,0,8.45457,0.0755954 +-8.4329,1,0.146324,1,1,0,8.45775,0.0763223 +-7.88772,0.997901,0.279205,1,3,0,8.67514,0.0984334 +-7.99992,0.991886,0.530321,1,1,0,8.07295,0.0931822 +-7.99992,0.806095,0.986769,1,1,0,9.02499,0.0931822 +-7.07715,1,1.02804,2,3,0,7.56158,0.359232 +-7.07715,0.0190911,1.94843,1,1,0,7.0891,0.359232 +-7.03746,0.999725,0.183214,3,7,0,7.12685,0.352058 +-6.78668,0.989405,0.349377,1,3,0,7.2417,0.285783 +-6.78668,0.837206,0.640324,1,3,0,7.61899,0.285783 +-6.78668,0.696699,0.738967,1,3,0,8.10923,0.285783 +-6.79467,0.999661,0.562025,3,7,0,6.79516,0.213175 +-6.79467,0.825842,1.04443,1,1,0,7.01844,0.213175 +-7.04128,0.859579,1.1594,1,1,0,7.09141,0.163277 +-7.04128,0.00311898,1.41641,1,1,0,7.49714,0.163277 +-6.98948,0.999799,0.149292,1,3,0,7.07774,0.170496 +-6.77421,0.999153,0.275297,2,7,0,7.05016,0.222147 +-6.9597,0.96332,0.501603,3,7,0,7.28216,0.175088 +-6.76047,1,0.818903,1,3,0,6.89467,0.230627 +-7.86215,0.38986,1.46742,1,1,0,8.06479,0.0996932 +-6.89418,0.977312,0.489766,2,5,0,8.30684,0.186795 +-7.24801,0.905588,0.820767,1,1,0,7.25545,0.140709 +-7.24801,5.73273e-05,1.12424,1,1,0,11.1471,0.140709 +-6.77488,0.999486,0.1363,3,11,0,7.50969,0.221799 +-8.07343,0.966333,0.24168,2,5,0,8.46459,0.089966 +-8.50315,0.988445,0.389158,2,3,0,8.65588,0.073995 +-7.27865,0.952571,0.658812,1,3,0,8.40284,0.137943 +-6.78033,0.945742,1.00801,2,3,0,7.02599,0.282635 +-6.78033,0.170796,1.50545,1,1,0,7.14823,0.282635 +-6.87274,0.992034,0.30996,1,3,0,6.94809,0.315597 +-6.84201,0.944907,0.5218,1,3,0,7.37743,0.198582 +-6.79317,1,0.774259,2,3,0,6.82648,0.288752 +-6.79317,0.288506,1.31019,1,1,0,7.22034,0.288752 +-6.80905,0.998605,0.378264,2,3,0,6.82453,0.295267 +-6.79016,0.981791,0.636201,1,3,0,6.935,0.214934 +-6.79016,0.642352,1.01933,1,1,0,7.06832,0.214934 +-7.66864,0.46488,0.712906,2,3,0,10.856,0.110116 +-7.72237,0.991468,0.326922,2,3,0,8.1016,0.107052 +-7.79459,0.994268,0.533078,1,1,0,7.87047,0.103146 +-7.22594,1,0.869131,1,1,0,7.71076,0.142776 +-7.22594,0.0108391,1.42676,1,1,0,8.5702,0.142776 +-7.22594,0.00193366,3.39788,1,1,0,10.5016,0.142776 +-7.47969,0.996634,0.33853,3,7,0,7.5726,0.122174 +-8.38274,0.987808,0.350808,4,15,0,8.42442,0.078045 +-10.2384,0.96817,0.459075,2,7,0,10.2461,0.0368812 +-6.75251,0.966814,0.652699,3,7,0,11.0757,0.238289 +-7.1441,0.905508,1.0009,1,3,0,7.16579,0.151063 +-6.90412,0.995419,1.33008,2,3,0,6.9995,0.323759 +-6.90412,0.00671969,2.40241,1,1,0,7.12702,0.323759 +-6.86506,0.999986,0.194517,3,7,0,6.90964,0.313459 +-7.12146,0.97989,0.363933,1,3,0,7.29862,0.366788 +-6.91497,1,0.645063,1,1,0,7.0835,0.326401 +-7.48178,0.75299,1.22232,2,3,0,7.53647,0.417202 +-8.8953,0.452304,1.06633,1,1,0,9.34071,0.544107 +-8.87942,1,0.3658,1,1,0,9.02459,0.542988 +-8.41069,1,0.695663,1,1,0,9.0448,0.507627 +-6.75548,1,1.31445,1,1,0,7.29074,0.234945 +-6.75548,0.0112664,2.46428,1,1,0,6.83997,0.234945 +-6.99498,0.989316,0.228847,3,9,0,7.82244,0.343858 +-7.08385,0.993003,0.417936,1,1,0,7.08393,0.360404 +-6.78844,0.972642,0.764924,2,3,0,7.28196,0.286608 +-6.75421,1,1.30591,1,3,0,6.76671,0.236263 +-6.75421,3.36326e-16,2.39507,1,1,0,8.49247,0.236263 +-7.8723,0.978559,0.237722,3,11,0,8.63456,0.459708 +-7.93884,0.994433,0.411833,1,1,0,8.00271,0.466182 +-8.2301,0.923912,0.739826,1,1,0,8.47604,0.492585 +-6.85713,1,1.07778,1,1,0,7.56959,0.311181 +-6.92456,0.896758,1.93206,1,1,0,7.16373,0.328672 +-6.92456,0.0195762,2.57268,1,1,0,6.93496,0.328672 +-7.22529,0.980678,0.302429,1,3,0,7.51984,0.383023 +-7.48496,0.968117,0.512226,1,1,0,7.48771,0.417586 +-7.48496,0.344454,0.831192,1,1,0,9.59088,0.417586 +-7.46413,1,0.249391,1,1,0,7.49601,0.41505 +-6.91888,0.978553,0.439758,2,5,0,8.13601,0.182073 +-6.74818,0.992804,0.725899,1,3,0,6.98984,0.252246 +-6.82271,0.960237,1.23402,1,1,0,6.82272,0.203882 +-6.82271,2.19221e-09,1.91082,1,1,0,8.59472,0.203882 +-6.82147,1,0.24474,4,15,0,6.82365,0.204247 +-7.31223,0.982869,0.422064,2,7,0,7.35609,0.135038 +-7.11813,1,0.69094,1,1,0,7.29593,0.153933 +-6.78022,0.977587,1.17236,2,3,0,6.97914,0.21921 +-6.78022,0.168,1.86546,1,1,0,6.88787,0.21921 +-6.77574,0.988702,0.391851,3,7,0,7.20364,0.221368 +-6.75135,1,0.641567,2,3,0,6.77498,0.239892 +-7.23192,0.791731,1.07224,2,3,0,7.54791,0.384001 +-6.95922,1,1.07029,1,1,0,7.19665,0.336438 +-6.95922,8.40415e-07,1.76919,1,1,0,9.93139,0.336438 +-7.79887,0.985279,0.261998,3,11,0,7.86315,0.102922 +-7.93747,0.995638,0.419189,1,1,0,7.94158,0.0960509 +-7.65534,1,0.682935,2,3,0,7.93838,0.110897 +-7.30925,1,1.11668,1,1,0,7.69218,0.13529 +-7.30925,1.30105e-13,1.8139,1,1,0,12.3848,0.13529 +-8.64452,0.977531,0.285938,3,11,0,9.26445,0.0695915 +-6.74805,0.991255,0.442003,2,5,0,9.50712,0.250913 +-6.8988,0.964338,0.701126,1,3,0,7.00076,0.185877 +-6.99419,0.970382,1.03972,1,1,0,7.0327,0.169802 +-6.99419,0.0710815,1.55528,1,1,0,7.41411,0.169802 +-7.22893,0.990499,0.305007,1,3,0,7.4574,0.142492 +-7.286,0.998957,0.478424,2,3,0,7.29765,0.137296 +-7.26412,1,0.760476,1,1,0,7.36001,0.139241 +-6.82451,0.892055,1.2048,2,3,0,7.41198,0.300874 +-6.82451,0.298022,1.49695,1,1,0,7.29184,0.300874 +-8.52579,0.905464,0.505934,3,7,0,8.69389,0.0732656 +-8.45284,1,0.648743,1,1,0,8.64394,0.0756517 +-6.99536,0.990028,1.01753,1,3,0,8.12548,0.16963 +-6.99536,0.00203407,1.55404,1,1,0,8.05832,0.16963 +-6.88449,0.998629,0.285729,1,3,0,7.09267,0.188774 +-6.8913,0.998026,0.445412,3,7,0,7.00604,0.187375 +-7.15568,0.930495,0.690011,1,3,0,7.96102,0.372344 +-8.4228,0.592863,0.922939,1,1,0,8.51343,0.508604 +-8.21211,1,0.607291,1,1,0,8.57965,0.491035 +-6.83198,1,0.936263,1,1,0,7.6606,0.303392 +-6.83198,0.131297,1.43676,1,3,0,8.1814,0.303392 +-6.8276,1,0.36701,1,1,0,6.83437,0.30193 +-6.75121,0.98834,0.563355,1,3,0,6.96708,0.24011 +-7.31865,0.911872,0.840676,2,3,0,7.4022,0.134496 +-8.38848,0.783979,1.06993,2,3,0,9.32326,0.0778451 +-6.83081,1,1.04944,2,3,0,8.0055,0.303004 +-6.83081,0.340683,1.58828,1,1,0,7.14282,0.303004 +-6.91965,0.923001,0.641488,1,3,0,7.4917,0.181934 +-7.94709,0.873408,0.831625,2,3,0,8.21305,0.0956005 +-6.77631,0.94972,0.97487,1,3,0,7.73105,0.221082 +-6.96489,0.900023,1.32593,1,1,0,6.98827,0.174262 +-6.96489,0.854282,1.63124,1,1,0,7.25214,0.174262 +-7.14806,0.770181,1.83194,1,1,0,7.22608,0.371126 +-7.14806,0.0031644,1.74552,1,1,0,8.92904,0.371126 +-6.77142,0.999989,0.378044,2,7,0,7.17703,0.277665 +-6.81675,0.971998,0.564659,1,3,0,7.08832,0.205671 +-6.75356,0.904997,0.796431,2,3,0,7.64626,0.263304 +-7.2784,0.872578,0.985563,2,3,0,7.46481,0.137965 +-6.76248,0.781598,1.14462,2,3,0,7.99817,0.271645 +-7.23117,0.778639,1.11789,1,1,0,7.24522,0.383891 +-6.75808,1,1.08591,1,1,0,7.00082,0.268001 +-7.09085,0.695725,1.59698,1,1,0,7.23418,0.361615 +-6.81506,1,1.32727,1,1,0,6.91062,0.206194 +-6.81506,4.62622e-08,1.94365,1,1,0,8.02021,0.206194 +-7.03673,0.979539,0.446672,1,3,0,7.20857,0.163878 +-7.98963,0.919309,0.630735,3,7,0,8.65545,0.0936458 +-9.36533,0.903107,0.795204,2,3,0,9.95128,0.051686 +-7.40563,1,0.971428,2,3,0,8.63958,0.407736 +-7.29294,1,1.41292,2,3,0,7.35247,0.136691 +-7.29294,0,20.3256,0,1,1,7.31408,0.136691 +-7.29294,0.00102409,3.43506,2,3,0,7.63417,0.136691 +-6.86216,0.999987,0.339733,3,7,0,7.29744,0.19367 +-6.75147,0.986389,0.459583,2,5,0,7.43899,0.26047 +-6.74802,0.999724,0.690222,2,5,0,6.75478,0.249763 +-6.78879,0.810965,1.17273,2,3,0,7.33437,0.286771 +-6.9954,0.916271,1.16437,1,1,0,7.00411,0.343941 +-7.05383,0.949195,1.63802,1,1,0,7.28389,0.355067 +-6.84623,0.335649,2.59662,1,3,0,6.85431,0.197507 +-6.75487,0.984909,0.596575,1,3,0,7.13962,0.26482 +-6.81772,0.933489,1.0737,2,3,0,7.02443,0.298482 +-6.81772,0.186608,1.64748,1,3,0,7.97368,0.298482 +-7.51261,0.989408,0.243072,3,11,0,7.90681,0.119911 +-7.51261,0.97466,0.448653,1,3,0,8.5048,0.119911 +-6.91742,1,0.787738,2,3,0,7.51816,0.182341 +-7.23613,0.861756,1.48705,2,3,0,7.31041,0.141813 +-7.23613,0.581353,1.82589,1,1,0,8.14699,0.141813 +-6.75458,1,0.956324,2,3,0,7.19737,0.235873 +-6.75626,0.999527,1.78279,1,3,0,6.7563,0.26627 +-6.75626,1.00829e-16,3.28732,1,1,0,7.85025,0.26627 +-6.75073,0.99982,0.312566,3,9,0,6.77057,0.240877 +-6.78989,0.989386,0.579871,1,3,0,6.91501,0.287279 +-6.93801,0.95229,1.03322,1,1,0,6.94013,0.331763 +-6.93801,0.0100404,1.63865,1,1,0,8.75339,0.331763 +-6.8714,0.999959,0.174688,3,7,0,6.9535,0.315227 +-6.93435,0.990436,0.319542,3,11,0,7.40694,0.17932 +-6.76628,0.997749,0.563379,2,5,0,7.02159,0.27438 +-6.82214,0.993956,1.00416,2,3,0,6.82251,0.204049 +-7.17853,0.792371,1.75414,1,1,0,7.27203,0.147448 +-7.17853,7.5927e-05,1.74799,1,1,0,9.44342,0.147448 +-7.23242,0.999517,0.202535,1,3,0,7.25453,0.142162 +-7.79263,0.993788,0.358928,3,7,0,7.80564,0.103249 +-9.2434,0.945189,0.620605,2,3,0,9.26247,0.054273 +-10.3911,0.939688,0.935056,2,3,0,11.3288,0.0348271 +-6.7767,0.643589,1.3795,2,3,0,9.44039,0.220889 +-7.39925,0.927816,0.934249,2,3,0,7.5017,0.40692 +-7.90973,0.622518,1.32837,2,3,0,8.35126,0.463372 +-7.64748,1,0.857502,1,1,0,8.01047,0.436311 +-6.77137,1,1.45844,1,1,0,7.13795,0.277635 +-6.77137,0.588639,2.46058,1,1,0,6.89199,0.277635 +-6.87609,0.929517,1.46616,2,3,0,6.90175,0.31651 +-6.87609,0.325182,2.05878,1,1,0,7.0022,0.31651 +-6.7913,0.909849,0.644778,3,7,0,8.16085,0.214482 +-6.80475,0.985343,0.863434,1,3,0,6.95004,0.293591 +-7.11022,0.863001,1.38415,2,3,0,7.1539,0.154833 +-7.40786,0.81946,1.6388,1,3,0,7.41051,0.40802 +-6.74802,1,1.74314,1,1,0,6.92585,0.249856 +-6.74802,0.000866635,2.8514,1,1,0,6.983,0.249856 +-6.89065,0.996191,0.432741,3,7,0,6.90645,0.320358 +-6.76559,0.974566,0.703357,1,3,0,7.16614,0.227068 +-6.76559,0.600424,1.07968,1,3,0,8.20201,0.227068 +-6.96523,0.95123,0.690191,1,3,0,7.36175,0.337724 +-6.9768,0.99623,0.998219,1,1,0,7.04214,0.340151 +-6.9768,0.264,1.59321,1,1,0,7.74488,0.340151 +-6.77565,0.989801,0.475409,1,3,0,7.18711,0.280119 +-6.80826,0.994531,0.746758,2,3,0,6.83928,0.294961 +-7.15851,0.855497,1.17884,1,1,0,7.1747,0.372794 +-6.84362,1,1.35526,1,1,0,7.0448,0.307114 +-6.84362,0.0201974,2.14561,1,1,0,8.03985,0.307114 +-6.93172,0.992585,0.386302,2,7,0,7.16817,0.179778 +-6.85476,1,0.602788,3,7,0,6.92551,0.310483 +-7.13785,0.920392,0.950919,1,1,0,7.141,0.369477 +-7.60224,0.807161,1.25491,2,3,0,7.81935,0.431273 +-8.41928,0.804133,1.29225,2,3,0,8.5183,0.076785 +-7.37792,1,1.32154,2,3,0,8.22044,0.129694 +-7.02221,1,2.05369,1,1,0,7.023,0.349182 +-7.10486,0.322528,3.17571,2,3,0,7.40571,0.155449 +-7.10486,0.80407,1.16665,1,1,0,7.85445,0.155449 +-7.02644,1,1.19271,1,1,0,7.15699,0.165258 +-7.02644,0.752729,1.83645,1,1,0,7.06807,0.165258 +-7.07799,0.982021,1.68258,2,3,0,7.08188,0.158638 +-7.07799,0.0125229,2.47995,1,1,0,7.09086,0.158638 +-6.79012,0.988867,0.494628,1,3,0,7.45443,0.21495 +-6.81929,0.981187,0.740951,2,3,0,6.99712,0.204898 +-7.5239,0.697298,1.08812,2,3,0,8.64504,0.422238 +-7.04713,1,0.895125,1,1,0,7.40936,0.353845 +-6.78304,0.319808,1.35864,2,3,0,9.59313,0.217931 +-7.09158,0.963309,0.524274,1,3,0,7.4932,0.157005 +-7.00859,1,0.738335,1,1,0,7.09162,0.167729 +-7.33601,0.925761,1.11466,1,1,0,7.35526,0.133054 +-7.12807,1,1.4471,1,1,0,7.40865,0.152819 +-7.04855,0.458653,2.1688,1,3,0,7.07103,0.354104 +-7.75678,0.64961,1.12106,2,3,0,8.58485,0.105162 +-7.39311,1,0.846123,1,1,0,7.72512,0.128517 +-6.83023,1,1.2639,1,1,0,7.2051,0.201737 +-6.83023,0.27227,1.88088,1,1,0,7.90493,0.201737 +-6.85278,0.997511,0.688007,1,1,0,6.85595,0.195889 +-6.7616,0.991186,1.01803,1,3,0,6.88903,0.270969 +-7.18204,0.747124,1.48298,1,1,0,7.23241,0.376481 +-9.60511,0.202263,1.35496,1,1,0,10.1174,0.589871 +-9.75413,0.996584,0.442641,2,3,0,9.89446,0.59857 +-8.35333,1,0.650434,2,3,0,9.5437,0.502947 +-8.08554,1,0.958639,1,1,0,8.64873,0.479846 +-6.74818,1,1.4081,2,3,0,7.28297,0.247799 +-6.74818,0.0383244,2.06141,1,1,0,7.14754,0.247799 +-6.75791,0.998483,0.50837,1,3,0,6.77716,0.2327 +-6.83944,0.978142,0.742899,1,3,0,6.98845,0.305805 +-7.63491,0.722079,1.04253,2,3,0,8.43187,0.112115 +-7.18223,1,0.914081,1,1,0,7.57145,0.147071 +-7.26954,0.972699,1.32979,1,1,0,7.41898,0.138753 +-6.76771,1,1.83557,1,1,0,6.97848,0.225761 +-6.76771,0.0210355,2.65457,1,1,0,6.8501,0.225761 +-6.75606,0.994235,0.659516,1,3,0,6.8478,0.266065 +-6.77637,0.998256,0.945004,2,3,0,6.77643,0.280522 +-6.77637,0.242837,1.35989,2,3,0,10.186,0.280522 +-6.95681,0.983408,0.510448,2,7,0,7.10618,0.335918 +-7.10899,0.813387,0.715143,1,3,0,8.63469,0.154973 +-6.78582,0.954985,0.74067,1,3,0,7.75834,0.285369 +-6.92847,0.9585,0.983164,1,1,0,6.92878,0.329581 +-6.98233,0.989983,1.31022,2,3,0,7.01696,0.171565 +-6.75625,1,1.84042,1,1,0,6.84664,0.234193 +-6.75625,0.0121408,2.62374,1,1,0,6.89459,0.234193 +-6.76149,0.999374,0.676416,1,1,0,6.76151,0.229867 +-6.76229,0.999809,0.964252,1,1,0,6.7654,0.229293 +-7.8068,0.740596,1.37198,2,3,0,7.80921,0.453147 +-7.96957,0.911694,1.25003,1,1,0,8.54632,0.469111 +-7.63083,0.481645,1.52527,2,3,0,8.48927,0.434472 +-7.63083,0.731652,0.895654,1,1,0,8.48457,0.434472 +-6.80883,0.919732,0.805747,1,3,0,8.36552,0.208187 +-6.88641,0.982134,0.995923,1,1,0,6.88944,0.188376 +-7.10172,0.94622,1.36491,2,3,0,7.1462,0.155814 +-6.83147,1,1.75758,1,3,0,6.87856,0.303225 +-7.50567,0.409549,2.47118,1,1,0,7.73128,0.120382 +-8.25324,0.843034,1.2992,1,1,0,8.35498,0.0827475 +-6.84993,0.829984,1.4066,1,3,0,7.73522,0.196587 +-6.84993,0.103901,1.48958,1,1,0,7.94548,0.196587 +-6.80502,0.994552,0.477528,2,7,0,7.06874,0.293698 +-7.18808,0.843984,0.664448,1,3,0,8.49881,0.14648 +-6.89179,0.93084,0.721258,3,7,0,8.5122,0.320651 +-6.86539,1,0.901389,1,1,0,6.90806,0.313552 +-6.75536,1,1.25848,2,3,0,6.81594,0.265341 +-6.82578,0.93783,1.75317,1,1,0,6.8527,0.301309 +-6.82578,0.000567435,2.20449,2,3,0,9.73814,0.301309 +-7.59636,0.940935,0.613351,2,3,0,7.61689,0.43061 +-6.97402,1,0.776529,3,7,0,7.56934,0.172835 +-8.48721,0.697388,1.07875,1,3,0,8.94728,0.513739 +-7.59858,1,0.923596,1,1,0,8.33874,0.43086 +-7.5812,0.791208,1.27964,2,3,0,8.45732,0.115427 +-7.00623,1,1.27144,2,3,0,7.42922,0.346088 +-7.00623,0.41896,1.75618,2,3,0,7.36511,0.346088 +-7.12273,0.963863,0.970719,1,1,0,7.181,0.366998 +-7.24531,0.567376,1.26543,2,3,0,8.36931,0.140959 +-7.31564,0.990434,0.886145,1,1,0,7.37463,0.13475 +-6.74804,0.965218,1.20236,1,3,0,7.15969,0.250791 +-6.74804,0.00444574,1.56581,1,1,0,8.78306,0.250791 +-6.7483,0.999767,0.459591,3,7,0,6.75604,0.252976 +-6.8623,0.980171,0.632108,1,3,0,6.98863,0.312674 +-6.74814,0.997293,0.841927,1,3,0,6.88236,0.251957 +-7.06359,0.907847,1.1493,2,3,0,7.2361,0.160416 +-6.79178,0.985279,1.36559,2,3,0,6.95853,0.214293 +-6.79178,0.0003827,1.8243,1,1,0,8.24503,0.214293 +-7.0091,0.976692,0.543366,1,3,0,7.19593,0.167657 +-7.13497,0.995747,0.717164,2,3,0,7.13691,0.152057 +-6.77418,0.999428,0.972677,1,3,0,7.09313,0.222164 +-6.90281,0.947363,1.32425,1,1,0,6.90913,0.185095 +-7.10074,0.956428,1.6641,1,3,0,7.10074,0.363308 +-7.10074,0.08889,2.11705,1,1,0,7.33968,0.363308 +-6.81927,0.933017,0.734337,1,3,0,7.81515,0.204905 +-9.38168,0.55864,0.902955,1,3,0,10.8663,0.0513506 +-8.6742,0.993343,0.635296,3,7,0,10.3794,0.0687113 +-8.66486,1,0.853666,1,1,0,8.87915,0.0689868 +-8.40672,1,1.15656,1,1,0,8.8946,0.077215 +-7.1083,1,1.5643,1,1,0,8.0077,0.155053 +-7.1083,0.120689,2.11231,1,1,0,7.17524,0.155053 +-7.25922,0.982997,0.783209,1,1,0,7.26877,0.139683 +-7.34636,0.902176,1.0318,1,3,0,8.20679,0.400007 +-7.34636,0.306863,1.20618,2,3,0,9.3049,0.400007 +-6.76479,0.969951,0.592025,1,3,0,7.80469,0.273344 +-6.79324,0.954961,0.764141,2,3,0,7.17529,0.288782 +-6.89325,0.953593,0.963799,1,3,0,7.06735,0.186982 +-6.96817,0.976452,1.21173,1,1,0,7.00773,0.173745 +-6.79572,1,1.57258,2,3,0,6.85317,0.289863 +-6.74857,1,2.10828,1,1,0,6.76126,0.254158 +-6.74857,0.00195078,2.82219,1,1,0,8.27534,0.254158 +-7.1726,0.904406,0.905111,2,3,0,7.40294,0.148056 +-7.1766,0.999174,1.05782,1,1,0,7.27751,0.147645 +-7.23154,0.975042,1.41364,2,3,0,7.26916,0.383946 +-6.77855,1,1.82284,1,1,0,6.85604,0.219995 +-6.77855,0.00467261,2.43189,1,1,0,6.97473,0.219995 +-6.76921,0.990259,0.794411,1,3,0,6.87423,0.276301 +-7.41382,0.817284,1.04603,1,3,0,7.71976,0.126945 +-7.55796,0.974034,1.07864,1,1,0,7.67174,0.116913 +-7.38693,1,1.38539,1,1,0,7.72173,0.128994 +-10.3026,0.0504464,1.84288,1,1,0,10.8325,0.62837 +-8.99362,1,0.650921,2,3,0,10.1587,0.550929 +-8.30891,1,0.866235,2,3,0,9.08706,0.499261 +-6.83246,1,1.15117,1,3,0,7.92225,0.20112 +-6.83246,0.676659,1.52772,1,1,0,7.03695,0.20112 +-6.75126,0.908432,1.29519,2,3,0,7.04082,0.240031 +-6.75126,0.791472,1.51253,1,1,0,6.95569,0.240031 +-7.32341,0.673809,1.5028,1,1,0,7.34884,0.396921 +-6.78874,1,1.27058,1,3,0,7.10961,0.21551 +-6.78874,0.00336911,1.68009,1,1,0,8.29813,0.21551 +-6.80829,0.975863,0.568918,1,3,0,7.26111,0.294973 +-6.7772,1,0.72834,1,1,0,6.80337,0.280974 +-6.79558,0.979485,0.962419,2,3,0,6.90214,0.212832 +-6.83201,0.922293,1.23524,2,3,0,7.05216,0.303402 +-6.83201,0.868144,1.46564,1,1,0,6.97974,0.303402 +-8.46362,0.358122,1.61517,1,3,0,8.50996,0.0752926 +-8.46362,3.17802e-09,3.58046,2,3,0,8.72355,0.0752926 +-8.46362,1.57826e-169,8.3606,1,3,1,8.46972,0.0752926 +-8.23152,1,0.82435,1,1,0,8.50166,0.0835747 +-7.92495,1,0.858563,1,1,0,8.23828,0.0966421 +-6.74904,0.932659,1.16126,1,3,0,7.9964,0.255658 +-6.75259,0.998234,1.48569,1,1,0,6.75308,0.262072 +-6.75259,0.0408279,2.50175,1,1,0,7.09842,0.262072 +-6.82166,0.998536,0.225331,3,9,0,6.9988,0.299882 +-6.80838,0.990418,0.400446,3,7,0,7.30519,0.295008 +-6.83477,0.996683,0.714919,1,1,0,6.83587,0.304304 +-9.37957,0.290329,1.32438,1,1,0,9.41221,0.576151 +-9.25373,1,0.265748,1,1,0,9.38546,0.568184 +-10.0362,0.98145,0.506307,2,3,0,10.0403,0.614308 +-8.13931,1,0.911292,1,1,0,9.63,0.484663 +-7.79536,1,1.73477,2,3,0,7.88779,0.451981 +-7.79536,3.53082e-05,3.28589,1,1,0,7.85212,0.451981 +-6.9254,0.992879,0.285006,2,5,0,8.36817,0.328869 +-7.19441,0.98182,0.532381,2,5,0,7.42469,0.145845 +-6.87232,0.934972,0.954328,2,3,0,8.00286,0.191381 +-7.28382,0.891326,1.47416,2,3,0,7.35038,0.137488 +-6.86745,1,1.98693,1,1,0,7.15081,0.192463 +-6.86745,0.0092308,3.67688,1,1,0,8.2262,0.192463 +-7.19474,0.993498,0.369042,3,7,0,7.29931,0.145813 +-7.19397,1,0.673343,3,7,0,7.22904,0.145889 +-7.33357,0.970096,1.23958,1,1,0,7.41683,0.133255 +-6.77223,1,2.07401,1,1,0,6.89138,0.278152 +-6.76787,1,3.74462,1,1,0,6.834,0.27544 +-6.76787,2.93684e-08,6.6942,1,2,1,6.76806,0.27544 +-9.41182,0.730201,0.731548,2,5,0,10.1304,0.050739 +-6.84383,0.971126,0.623322,2,7,0,10.9914,0.307181 +-6.88287,0.989591,1.03015,1,1,0,6.89981,0.318325 +-6.88287,0.0460608,1.77527,2,3,0,8.53179,0.318325 +-6.78205,0.998282,0.238745,4,15,0,7.22623,0.218373 +-6.82863,0.997411,0.422346,1,3,0,6.87152,0.202184 +-6.76982,0.997827,0.738561,3,7,0,6.8853,0.276682 +-6.92953,0.967409,1.2814,2,3,0,6.93199,0.329826 +-8.12911,0.57814,2.03573,2,3,0,8.13129,0.0876369 +-6.85189,1,1.17221,1,3,0,7.98763,0.196107 +-6.87087,0.99523,2.0115,1,3,0,6.87094,0.315082 +-6.76399,1,3.3818,1,1,0,6.83837,0.272769 +-6.76399,6.66143e-11,5.70936,1,1,0,8.26727,0.272769 +-6.86714,0.989108,0.776408,3,7,0,6.91389,0.192534 +-7.09998,0.936658,1.27944,1,1,0,7.10897,0.156016 +-7.09998,0.180132,1.83815,1,1,0,7.65682,0.156016 +-6.86292,0.985963,0.409502,2,7,0,8.31199,0.31285 +-7.26014,0.921651,0.665312,2,3,0,7.86286,0.388097 +-7.53749,0.935905,0.918593,1,1,0,7.59603,0.423836 +-7.53749,0.819071,1.30652,2,3,0,8.20936,0.423836 +-9.1137,0.61434,1.39874,2,3,0,9.19922,0.0572002 +-10.957,0.940694,0.920305,2,3,0,11.3642,0.0282595 +-9.64341,1,1.31395,1,1,0,10.97,0.0463196 +-8.21599,1,2.14505,1,3,0,8.2555,0.49137 +-8.21599,3.81996e-11,3.47911,1,3,0,9.70706,0.49137 +-7.8375,1,0.555942,1,1,0,8.18666,0.456246 +-7.2451,1,0.903725,2,3,0,7.71771,0.385928 +-7.2451,0.0540314,1.4599,1,1,0,9.70113,0.385928 +-7.42862,0.996899,0.274368,2,3,0,7.42893,0.410645 +-7.47023,0.997699,0.440659,1,1,0,7.48973,0.415796 +-7.61826,0.957171,0.704812,2,3,0,8.17467,0.433072 +-7.61826,0.362439,1.02409,1,1,0,9.94805,0.433072 +-7.09233,0.988218,0.397179,1,3,0,8.02377,0.36187 +-7.07137,1,0.617111,1,1,0,7.11399,0.358213 +-7.07137,0.844883,0.97868,1,3,0,8.12573,0.358213 +-8.06652,0.711355,1.10169,1,1,0,8.09202,0.478118 +-6.78855,0.976265,0.927813,2,3,0,8.26813,0.286661 +-6.86873,0.742535,1.3836,2,3,0,7.6628,0.314488 +-6.76259,1,1.24613,1,1,0,6.82977,0.271729 +-6.76259,0.520631,1.94226,1,1,0,6.98724,0.271729 +-6.871,0.962993,1.09321,1,3,0,6.96032,0.191672 +-7.29352,0.86433,1.56959,2,3,0,7.32657,0.136641 +-7.11885,1,1.82606,1,1,0,7.42382,0.153851 +-7.11885,4.70968e-11,2.81254,1,1,0,7.81976,0.153851 +-7.14124,0.998991,0.544337,1,1,0,7.15183,0.151373 +-7.237,0.875666,0.838039,3,7,0,9.52947,0.141732 +-6.82525,0.952794,0.997663,1,3,0,7.72784,0.301128 +-6.88964,0.969306,1.38722,1,1,0,6.92431,0.320098 +-6.88964,0.170269,1.98776,1,3,0,7.86435,0.320098 +-7.86655,0.893497,0.566194,1,3,0,8.60822,0.459139 +-8.19645,0.954078,0.697285,1,1,0,8.25675,0.489679 +-6.91012,0.873736,0.96711,1,3,0,9.22966,0.183699 +-6.83724,1,1.13964,1,1,0,6.9023,0.199832 +-6.83724,0.0886807,1.72109,1,1,0,7.80781,0.199832 +-6.74839,0.998643,0.430501,2,7,0,6.93218,0.253381 +-7.23708,0.919343,0.648776,1,3,0,7.92881,0.384758 +-7.23708,0.89849,0.834344,1,1,0,7.67782,0.384758 +-8.00203,0.931235,1.02793,2,3,0,8.0476,0.472166 +-6.85405,1,1.34645,2,3,0,7.48148,0.310275 +-6.85405,0.467701,2.00794,1,1,0,7.21483,0.310275 +-6.78219,1,1.0768,2,3,0,6.83519,0.283584 +-6.78679,0.999044,1.60144,2,3,0,6.79297,0.285836 +-6.78679,0.0035304,2.36885,1,1,0,7.6308,0.285836 +-6.79576,0.999388,0.532524,1,1,0,6.79598,0.289883 +-6.92925,0.918663,0.789219,3,7,0,7.68998,0.32976 +-9.25331,0.649996,1.00206,2,7,0,9.34956,0.0540569 +-7.68633,0.979161,0.769331,2,5,0,9.20022,0.440542 +-7.43334,1,1.09066,1,1,0,7.78298,0.411236 +-6.83891,1,1.60207,1,1,0,7.15505,0.305635 +-7.37371,0.573191,2.34556,1,1,0,7.4255,0.130024 +-7.57757,0.935579,1.56531,2,3,0,7.58945,0.428473 +-7.16589,0.405655,2.03102,2,3,0,7.79815,0.37396 +-8.66253,0.649969,1.00331,1,1,0,8.66385,0.527219 +-7.24741,0.967448,0.775825,2,3,0,9.07593,0.386263 +-6.9917,1,1.06569,1,1,0,7.2042,0.343199 +-6.76997,1,1.54796,1,1,0,6.88375,0.276777 +-6.76997,0.195576,2.24172,1,1,0,7.10589,0.276777 +-6.74946,1,0.771847,2,3,0,6.76793,0.25675 +-6.74862,0.998889,1.11746,2,3,0,6.75596,0.245696 +-7.07558,0.815812,1.60994,1,1,0,7.08297,0.358955 +-6.76324,1,1.67531,1,1,0,6.8746,0.228625 +-6.76324,9.3106e-07,2.40762,1,1,0,8.12061,0.228625 +-8.10251,0.927194,0.600778,2,5,0,8.46554,0.0887387 +-8.18157,0.998573,0.761373,2,3,0,8.25593,0.0855218 +-6.84575,0.879332,1.0901,1,3,0,8.94167,0.307773 +-6.86391,0.992693,1.26663,1,1,0,6.90005,0.313131 +-7.32979,0.670999,1.78695,1,1,0,7.54808,0.397783 +-6.74889,0.726193,1.44793,2,3,0,7.88495,0.255233 +-6.78423,0.805101,1.29125,2,3,0,7.57207,0.284597 +-7.05099,0.927472,1.31822,2,3,0,7.14464,0.162015 +-7.05099,0.199756,1.6561,2,3,0,8.85894,0.162015 +-7.11269,0.994807,0.606666,3,7,0,7.35976,0.154549 +-6.79082,0.951595,0.854647,1,3,0,7.71614,0.287703 +-6.88368,0.906461,1.11697,2,3,0,7.24901,0.318541 +-7.38439,0.778207,1.35103,2,3,0,7.66072,0.12919 +-7.36649,1,1.31766,1,1,0,7.55021,0.130594 +-6.90168,1,1.8582,1,1,0,7.2283,0.185314 +-6.90168,0.423763,2.61424,1,1,0,7.45179,0.185314 +-7.5548,0.814737,1.41734,1,1,0,7.5598,0.117117 +-7.18956,0.811902,1.468,2,3,0,8.81046,0.146331 +-6.92067,0.979848,1.51301,2,3,0,7.17692,0.181747 +-6.92067,0.00771912,2.05142,1,1,0,7.66621,0.181747 +-7.21318,0.987284,0.569776,2,3,0,7.21429,0.144001 +-7.94718,0.909539,0.782802,2,3,0,8.64425,0.0955962 +-8.9338,0.956384,0.946334,3,7,0,8.96613,0.0615921 +-7.17155,1,1.23226,1,3,0,8.67584,0.148164 +-7.47954,0.923028,1.71814,2,3,0,7.50815,0.41693 +-7.47954,0.724364,2.11302,1,3,0,7.67004,0.41693 +-6.93859,1,1.88944,1,1,0,7.06328,0.178588 +-6.93859,0.0086327,2.62233,1,1,0,7.03052,0.178588 +-7.09826,0.893194,0.752759,1,3,0,8.58431,0.362886 +-7.75441,0.866713,0.882955,1,1,0,7.75456,0.447756 +-6.78007,1,0.992274,2,3,0,7.65702,0.219277 +-6.76133,0.667884,1.37416,2,3,0,7.84563,0.270752 +-6.75595,0.996766,1.12826,2,3,0,6.78414,0.234485 +-7.79085,0.737677,1.55081,2,3,0,7.79087,0.45152 +-8.54186,0.550146,1.4207,2,3,0,9.18126,0.518017 +-7.26968,1,0.973018,1,1,0,8.20273,0.389459 +-7.26968,0.875567,1.34078,1,1,0,7.64661,0.389459 +-6.77485,1,1.52154,2,3,0,7.01342,0.279671 +-6.77485,0.656001,2.08976,1,1,0,6.92825,0.279671 +-6.95197,0.881722,1.68927,1,1,0,6.99489,0.334866 +-7.16334,0.808949,1.93155,1,1,0,7.44962,0.373558 +-6.75138,1,1.9748,1,1,0,6.87793,0.260339 +-6.80426,0.92301,2.69999,1,1,0,6.83343,0.20972 +-6.80426,0.0452595,3.27842,1,1,0,6.8068,0.20972 +-7.02863,0.98235,1.05336,2,3,0,7.03097,0.350401 +-6.7481,0.67373,1.40098,2,3,0,7.97755,0.251554 +-7.0119,0.932224,1.16918,1,3,0,7.06962,0.167262 +-7.09371,0.992009,1.43955,2,3,0,7.31345,0.156753 +-7.47992,0.815121,1.936,1,1,0,7.71866,0.122158 +-7.08338,1,1.99628,1,3,0,7.12576,0.360322 +-7.83003,0.136707,2.70983,2,3,0,7.99001,0.101312 +-6.97094,0.995523,1.01981,2,3,0,7.91283,0.173312 +-7.96137,0.809058,1.37535,1,3,0,8.10647,0.468333 +-7.61534,1,1.40626,2,3,0,8.14742,0.113303 +-7.51732,1,1.90422,1,1,0,8.00168,0.119593 +-7.19157,1,2.57427,1,1,0,7.8504,0.146129 +-6.797,0.333333,3.4744,2,3,0,6.80502,0.29041 +-7.26098,0.684127,1.76861,1,1,0,7.39742,0.388218 +-7.191,1,1.50591,2,3,0,7.25073,0.146186 +-6.93246,1,2.03042,1,1,0,7.19908,0.179649 +-6.93246,0.0186402,2.73326,1,1,0,6.96838,0.179649 +-6.90408,0.9488,0.889743,1,3,0,7.57381,0.32375 +-7.38725,0.851478,1.11316,1,1,0,7.39743,0.405375 +-7.14792,1,1.20942,1,1,0,7.42239,0.371103 +-7.56096,0.735569,1.62514,1,1,0,7.92258,0.426564 +-6.7579,1,1.49382,2,3,0,7.12673,0.267835 +-6.7579,0.262032,2.00311,1,1,0,7.46367,0.267835 +-6.90246,0.978537,0.938483,2,3,0,6.95241,0.323346 +-9.97826,0.27634,1.22026,1,1,0,9.98302,0.611148 +-10.103,0.988125,0.58633,1,1,0,10.3714,0.617901 +-7.82849,1,0.772626,3,7,0,9.92641,0.10139 +-7.02567,0.974342,1.03385,1,3,0,7.74381,0.165362 +-6.94463,0.986985,1.33246,2,3,0,7.3844,0.177564 +-6.76073,0.997523,1.74581,1,3,0,6.8258,0.270273 +-6.75233,1,2.31824,1,1,0,6.76108,0.261726 +-6.75233,8.24592e-09,3.08472,1,1,0,7.61433,0.261726 +-6.82264,0.990869,1.01925,2,3,0,6.82365,0.203902 +-7.07326,0.858546,1.33992,2,3,0,7.56639,0.159217 +-6.88895,0.998821,1.46457,2,3,0,7.07988,0.319917 +-7.51219,0.324027,1.94232,2,3,0,7.90751,0.420851 +-7.34123,0.688073,1.01482,1,3,0,9.35197,0.132626 +-6.85842,0.994071,0.877393,3,7,0,7.32152,0.311557 +-7.37137,0.834098,1.15507,1,1,0,7.37749,0.40331 +-7.45896,0.987873,1.22001,2,3,0,7.6994,0.414415 +-7.76196,0.819365,1.58926,2,3,0,8.04508,0.104882 +-7.07717,0.953368,1.64357,2,3,0,7.72155,0.359236 +-6.76278,1,2.03895,1,1,0,6.81941,0.228942 +-6.76278,0.32532,2.69186,1,1,0,7.05414,0.228942 +-7.46584,0.809539,1.42462,1,3,0,7.47869,0.123149 +-7.46584,0.516789,1.4537,1,3,0,9.84413,0.123149 +-7.99756,0.939868,0.99992,1,1,0,8.00176,0.0932884 +-8.2749,0.962038,1.21646,1,1,0,8.4439,0.081934 +-8.93233,0.8868,1.52318,1,1,0,9.21844,0.0616297 +-6.75394,0.705825,1.72284,1,3,0,7.91684,0.236567 +-7.45415,0.801121,1.52962,2,3,0,7.45749,0.413823 +-6.86921,1,1.54264,1,1,0,7.20551,0.314622 +-6.76297,1,2.02631,1,1,0,6.81736,0.272015 +-7.55518,0.38294,2.65841,1,1,0,7.8038,0.117093 +-7.17626,1,1.5397,2,3,0,7.55399,0.14768 +-6.90303,1,2.01876,1,1,0,7.15262,0.185053 +-6.90303,2.82972e-06,2.64374,1,1,0,7.37654,0.185053 +-8.50684,0.770239,0.928835,2,3,0,9.20791,0.0738755 +-8.17674,0.935617,0.900309,2,3,0,10.3609,0.0857134 +-6.79355,1,1.08369,2,3,0,8.02191,0.213604 +-7.08318,0.773107,1.41772,2,3,0,7.66733,0.158009 +-7.46498,0.967026,1.3783,2,3,0,7.51662,0.123211 +-6.92783,0.861845,1.72455,1,3,0,7.13547,0.329433 +-9.13508,0.230605,1.88064,1,3,0,9.22254,0.0567046 +-8.19645,0.993503,0.905132,2,3,0,9.52626,0.0849351 +-7.7866,1,1.17127,1,1,0,8.23108,0.103567 +-7.21421,1,1.52676,1,1,0,7.715,0.143902 +-8.44697,0.571638,1.98794,1,1,0,8.70962,0.0758482 +-7.61349,1,1.49143,2,3,0,8.87705,0.432539 +-6.75298,1,1.93987,1,1,0,6.96177,0.237695 +-7.98777,0.299207,2.5204,1,1,0,8.29234,0.0937302 +-9.19704,0.834617,1.33711,1,1,0,9.2415,0.0552977 +-9.02199,1,1.40674,2,3,0,9.61969,0.0593886 +-7.06951,1,1.82594,1,1,0,8.3229,0.159679 +-6.78608,1,2.36755,1,1,0,6.80331,0.285497 +-6.78608,0.0919026,3.06658,1,1,0,6.88382,0.285497 +-6.79692,0.611755,1.25931,2,3,0,8.3687,0.290378 +-7.60172,0.88035,0.999779,2,7,0,7.60333,0.114142 +-6.74918,1,1.11405,2,3,0,7.45279,0.256053 +-6.74918,0.216805,1.44211,1,1,0,8.01429,0.256053 +-7.09127,0.944691,0.698496,1,3,0,7.44976,0.361687 +-7.53094,0.634699,0.843615,1,3,0,10.1851,0.118683 +-6.87559,0.985757,0.691279,1,3,0,7.92128,0.190666 +-7.47966,0.948858,0.878098,3,7,0,7.55501,0.416944 +-7.20551,1,1.06436,1,1,0,7.48757,0.380065 +-6.78678,1,1.37367,1,1,0,7.01846,0.285831 +-6.78678,0.350839,1.77113,1,3,0,7.55914,0.285831 +-6.74924,0.998981,1.02199,2,3,0,6.79405,0.25621 +-6.76597,0.682916,1.31547,2,3,0,7.80937,0.274164 +-8.08708,0.71241,1.14589,1,3,0,8.11963,0.479985 +-6.76212,0.993056,1.03557,1,3,0,8.14807,0.229414 +-6.77402,0.995731,1.32131,1,1,0,6.77791,0.222242 +-7.60086,0.669055,1.68987,1,1,0,7.60691,0.114196 +-9.07788,0.914183,1.44803,2,3,0,9.10437,0.0580428 +-8.71416,1,1.67459,2,3,0,8.95024,0.0675487 +-8.71416,0.768617,2.14889,1,1,0,10.2658,0.0675487 +-7.70675,1,2.07919,1,1,0,8.83737,0.107928 +-7.70675,0.0282609,2.66451,1,1,0,7.70789,0.107928 +-7.73998,0.995883,1.05085,1,1,0,7.88512,0.106078 +-7.49746,1,1.34042,1,1,0,7.83873,0.120943 +-6.98003,1,1.71676,1,1,0,7.37284,0.171914 +-6.7602,1,2.19677,1,1,0,6.85098,0.230836 +-6.7602,0.086185,2.80846,1,1,0,7.40909,0.230836 +-7.26941,0.780963,1.19727,2,3,0,8.08605,0.138765 +-6.76541,0.932801,1.17742,2,3,0,7.59281,0.273776 +-6.77198,0.999085,1.38865,2,3,0,6.7735,0.223325 +-6.77198,0.000309869,1.77166,1,1,0,9.73135,0.223325 +-6.77075,1,0.686461,1,1,0,6.77365,0.224002 +-7.48795,0.92341,0.877066,2,3,0,7.49436,0.121599 +-6.92649,0.748531,1.02223,3,7,0,12.3107,0.329122 +-6.86758,1,0.967727,1,1,0,6.92758,0.314166 +-6.86758,0.414583,1.23405,1,1,0,8.08214,0.314166 +-6.92722,0.996861,0.787157,2,3,0,6.93162,0.329291 +-7.12708,0.948339,0.999566,1,1,0,7.14178,0.367715 +-6.83472,1,1.19778,2,3,0,7.12491,0.200505 +-6.83472,0.288917,1.52422,1,1,0,7.80871,0.200505 +-6.77017,0.999926,0.841191,3,7,0,6.82527,0.276901 +-6.96407,0.959758,1.07009,1,3,0,6.96682,0.337476 +-6.77685,0.99486,1.29772,1,3,0,6.94465,0.220813 +-6.77685,0.537667,1.63853,1,1,0,7.12446,0.220813 +-6.84005,0.940515,1.21316,2,3,0,7.10915,0.305997 +-6.84005,0.0659272,1.43689,1,1,0,9.00809,0.305997 +-6.75452,0.990623,0.615747,3,7,0,7.0994,0.264432 +-6.78292,0.988157,0.773366,1,3,0,6.87635,0.217986 +-6.79717,0.997349,0.967812,1,1,0,6.80046,0.21224 +-6.777,1,1.22316,2,3,0,6.79698,0.220743 +-6.74843,0.845926,1.54938,2,3,0,7.01123,0.246432 +-6.90788,0.916458,1.6421,1,1,0,6.90892,0.184123 +-6.79943,1,1.88706,1,1,0,6.88735,0.211415 +-6.79943,0.0462437,2.38578,1,1,0,7.0017,0.211415 +-6.83115,0.993769,1.00991,1,1,0,6.83504,0.20148 +-6.74857,0.992043,1.26804,2,3,0,6.84421,0.254149 +-6.79414,0.973844,1.58783,1,1,0,6.79568,0.28918 +-6.79414,0.189659,1.94596,1,1,0,7.33704,0.28918 +-6.79705,0.990541,0.975622,2,3,0,6.88613,0.290433 +-6.75386,1,1.21873,1,1,0,6.78213,0.263663 +-6.75386,0.0287953,1.53774,1,1,0,8.95019,0.263663 +-6.98766,0.9808,0.644828,2,5,0,7.06282,0.170766 +-6.87616,0.997879,0.796331,3,7,0,7.04197,0.190543 +-7.57399,0.953323,1.00191,2,3,0,7.5791,0.428063 +-7.32533,0.763108,1.19787,1,3,0,8.57341,0.133937 +-7.55165,0.961542,1.15533,1,1,0,7.61883,0.117322 +-7.81486,0.942878,1.393,1,1,0,7.99189,0.102091 +-6.87294,1,1.64376,1,1,0,7.45,0.191243 +-6.87294,0.36075,2.06682,1,1,0,7.80223,0.191243 +-7.6178,0.883712,1.26981,1,3,0,7.62538,0.113152 +-6.79792,0.92215,1.40161,2,3,0,7.41993,0.290802 +-7.15025,0.724509,1.61438,2,3,0,7.38057,0.150403 +-7.15025,0.704481,1.49132,1,1,0,8.09192,0.150403 +-7.0734,1,1.34761,1,1,0,7.21888,0.1592 +-7.0734,0.0261695,1.6913,1,1,0,8.81565,0.1592 +-7.10242,0.99765,0.720457,1,1,0,7.12187,0.155732 +-6.8395,0.958321,0.902073,2,3,0,7.64369,0.199236 +-7.44768,0.902975,1.08067,1,3,0,7.49812,0.12445 +-6.77949,0.997102,1.21722,1,3,0,7.315,0.219547 +-6.77949,0.167586,1.52033,1,1,0,8.04246,0.219547 +-6.82266,0.975427,0.761688,1,3,0,7.09744,0.300234 +-7.18529,0.847897,0.928991,2,7,0,7.91857,0.146761 +-7.11956,1,0.984507,1,1,0,7.21857,0.153771 +-7.21292,0.979065,1.23228,1,1,0,7.28934,0.144026 +-8.25767,0.818296,1.50647,2,3,0,8.29812,0.08258 +-7.32219,0.990016,1.54416,2,3,0,8.08342,0.134199 +-7.32219,5.24525e-05,1.90861,1,1,0,10.1038,0.134199 +-7.68428,0.968255,0.802207,3,7,0,8.36698,0.440321 +-7.34117,1,0.968678,1,1,0,7.67831,0.399314 +-7.76758,0.836083,1.21003,1,1,0,7.96972,0.449124 +-6.84807,1,1.26458,1,1,0,7.38824,0.308483 +-6.86336,0.916861,1.57799,2,3,0,6.98778,0.193394 +-6.75364,1,1.79865,1,1,0,6.80417,0.236909 +-6.75364,0.0990549,2.24178,1,1,0,8.09162,0.236909 +-6.93719,0.968692,1.05737,2,3,0,7.01083,0.331577 +-6.91732,1,1.27436,1,1,0,6.9952,0.326963 +-8.09419,0.435308,1.58757,2,3,0,8.35869,0.480628 +-6.7737,0.956388,1.07822,2,3,0,8.45124,0.222411 +-6.81433,0.995006,1.28137,2,3,0,6.82517,0.297248 +-7.14705,0.874306,1.58625,2,3,0,7.1576,0.370964 +-8.55344,0.220432,1.72499,2,3,0,9.69143,0.0723872 +-7.02196,0.980525,0.933422,2,7,0,8.44237,0.349133 +-6.97674,0.911947,1.13728,1,3,0,7.47333,0.172415 +-7.20864,0.946862,1.28741,2,3,0,7.4607,0.380537 +-10.5995,0.107851,1.51191,1,1,0,11.2004,0.643217 +-8.80758,1,0.728639,1,1,0,10.3338,0.537869 +-7.73903,1,0.90556,2,3,0,8.60542,0.446148 +-7.73903,0.88095,1.12475,1,1,0,8.2587,0.446148 +-7.36408,1,1.23111,1,1,0,7.80347,0.402355 +-6.97283,1,1.5275,1,1,0,7.2893,0.339326 +-6.97283,0.04167,1.89409,1,1,0,8.24786,0.339326 +-6.79121,1,0.856321,3,7,0,6.95687,0.214516 +-6.90709,0.990557,1.06204,2,3,0,6.90712,0.324491 +-6.81854,1,1.30341,1,1,0,6.89295,0.298777 +-6.92902,0.929707,1.61463,1,1,0,6.98732,0.329708 +-6.83569,0.832566,1.85721,2,3,0,6.95123,0.304603 +-6.88862,0.951463,1.92928,1,1,0,6.98872,0.319833 +-6.74807,1,2.26865,1,1,0,6.77602,0.248788 +-6.74936,0.997739,2.80489,1,1,0,6.75039,0.256507 +-6.74936,0.00141296,3.45772,1,1,0,7.74218,0.256507 +-6.79615,0.975529,1.51249,1,1,0,6.79735,0.290048 +-6.79615,0.903322,1.82249,1,1,0,6.88728,0.290048 +-6.79615,0.00293215,2.03665,1,1,0,8.18723,0.290048 +-6.91199,0.935992,0.895874,1,3,0,7.26723,0.183347 +-8.06368,0.840001,1.0362,1,3,0,8.26525,0.0903831 +-7.95942,1,1.08499,1,1,0,8.21361,0.0950275 +-7.59628,1,1.33967,2,3,0,8.02873,0.114481 +-6.8158,1,1.6532,1,1,0,7.26343,0.205964 +-6.8158,0.563029,2.03896,1,1,0,7.25243,0.205964 +-6.74857,1,1.60458,1,1,0,6.78044,0.24588 +-9.716,0.364064,1.97795,1,3,0,9.71673,0.0450292 +-8.44877,1,1.27042,1,1,0,9.61484,0.0757881 +-7.88507,1,1.56565,1,1,0,8.58628,0.0985628 +-7.88507,0.363801,1.92842,1,1,0,8.36748,0.0985628 +-7.5181,1,1.24044,1,1,0,7.91125,0.11954 +-6.81305,0.950021,1.52747,2,3,0,7.23377,0.296777 +-6.78679,0.994223,1.78668,1,3,0,6.79856,0.216315 +-7.88986,0.446129,2.18501,1,1,0,8.05022,0.0983289 +-8.49936,0.875348,1.53119,1,1,0,8.73696,0.0741181 +-7.19182,1,1.65943,2,3,0,7.80623,0.377985 +-7.1728,0.999269,2.03987,1,1,0,7.19255,0.148036 +-7.1728,0.0122563,2.50434,1,1,0,7.26057,0.148036 +-6.75653,0.908989,1.13422,2,3,0,8.27084,0.233937 +-7.42982,0.850121,1.27157,1,3,0,7.49175,0.125754 +-7.75509,0.931608,1.34309,1,1,0,7.87574,0.105253 +-7.33516,1,1.53959,2,3,0,7.65651,0.398508 +-7.11673,1,1.88971,1,3,0,7.2009,0.15409 +-7.37947,0.700313,2.31826,1,1,0,7.47548,0.404367 +-6.81983,1,2.10507,1,1,0,6.89114,0.204736 +-6.75064,1,2.58075,1,1,0,6.77414,0.241036 +-6.75064,0.00950019,3.1623,1,1,0,6.87185,0.241036 +-7.65369,0.733861,1.44061,2,3,0,7.69363,0.110995 +-8.15417,0.90768,1.35406,1,1,0,8.28258,0.0866175 +-8.09871,1,1.51348,1,1,0,8.54627,0.0888976 +-7.47653,1,1.85386,1,3,0,7.63023,0.416564 +-7.7025,0.809183,2.26964,1,1,0,7.70322,0.108169 +-7.7025,0.000395313,2.2982,1,1,0,8.25892,0.108169 +-8.18509,0.982171,1.04399,2,3,0,8.21516,0.0853823 +-8.31434,0.725951,1.25571,2,3,0,12.7671,0.0804812 +-7.45889,1,1.17185,1,1,0,8.18731,0.123644 +-6.91275,1,1.43367,1,1,0,7.29659,0.183206 +-6.91275,0.42861,1.75311,1,1,0,7.27567,0.183206 +-6.78601,0.827798,1.22045,2,3,0,7.97382,0.285459 +-7.23752,0.511238,1.25943,2,3,0,9.19441,0.141683 +-7.60244,0.956169,0.952131,2,3,0,7.94956,0.114098 +-6.88852,0.961414,1.1147,2,3,0,8.10974,0.319808 +-6.8979,0.995876,1.31126,1,1,0,6.95649,0.322206 +-6.97331,0.951304,1.59478,1,1,0,7.07814,0.339425 +-7.37639,0.68344,1.85599,1,1,0,7.72528,0.403965 +-6.96036,1,1.66213,2,3,0,7.07149,0.336682 +-8.50842,0.163465,2.02764,1,1,0,9.54402,0.515408 +-8.50842,0.681823,1.09418,1,1,0,9.68349,0.515408 +-8.50842,0.450338,0.979333,1,3,0,13.441,0.515408 +-7.85295,1,0.700084,1,1,0,8.42888,0.45779 +-6.84296,0.899599,0.854091,2,3,0,9.11017,0.198338 +-6.94853,0.983042,0.944851,1,1,0,6.94876,0.176914 +-6.77905,0.989781,1.13298,2,3,0,7.03633,0.219754 +-6.78982,0.990629,1.36687,2,3,0,6.84136,0.215072 +-6.78982,0.404073,1.64966,1,1,0,7.26769,0.215072 +-8.07665,0.678368,1.1297,2,3,0,9.10376,0.47904 +-7.65007,1,1.00873,1,1,0,8.12835,0.436597 +-6.88985,0.74724,1.22808,2,3,0,8.72709,0.187669 +-6.88545,1,1.17186,1,1,0,6.92424,0.188575 +-6.80052,0.995121,1.42578,2,3,0,6.9106,0.211025 +-6.77061,1,1.72581,1,1,0,6.79918,0.224078 +-7.23425,0.699302,2.09785,1,1,0,7.32559,0.141991 +-7.23653,1,1.91122,1,3,0,7.24683,0.384677 +-7.23653,0.144318,2.3219,1,1,0,7.3518,0.384677 +-7.22264,1,1.24493,1,1,0,7.422,0.382629 +-6.74825,0.440398,1.5125,2,3,0,8.84505,0.252651 +-6.74804,1,1.07744,2,3,0,6.74821,0.249212 +-6.76258,0.995968,1.30863,1,3,0,6.76309,0.229089 +-7.25301,0.74868,1.58264,1,1,0,7.25448,0.387072 +-7.16935,1,1.51265,2,3,0,7.17106,0.148392 +-8.41652,0.608183,1.83529,1,1,0,8.56848,0.0768789 +-7.00114,0.815009,1.5353,2,3,0,8.08046,0.168792 +-6.84217,0.990977,1.56278,2,3,0,6.95892,0.198541 +-6.84217,0.404509,1.8787,1,1,0,7.82787,0.198541 +-6.94039,0.97058,1.29727,1,1,0,6.95774,0.178282 +-6.80878,0.958518,1.52946,2,3,0,7.01161,0.295163 +-8.66864,0.194504,1.78217,2,3,0,9.14873,0.527677 +-8.47087,1,1.01113,2,7,0,8.54032,0.0750524 +-8.41918,1,1.2252,1,1,0,8.76327,0.0767882 +-9.13498,0.827514,1.48397,2,3,0,9.38133,0.560444 +-12.1798,0.213718,1.52813,2,3,0,12.2185,0.018229 +-9.85181,1,0.885095,2,3,0,12.3842,0.0427264 +-9.53931,1,1.07172,1,1,0,10.0414,0.048247 +-6.75662,1,1.29715,2,3,0,8.87189,0.266622 +-6.75662,0.756034,1.56933,1,1,0,6.95586,0.266622 +-6.75662,0.44368,1.51138,2,3,0,7.65145,0.266622 +-6.77517,0.994904,1.08792,1,1,0,6.77546,0.279852 +-6.74805,1,1.3094,1,3,0,6.76586,0.249003 +-6.74805,0.113424,1.5828,1,1,0,7.97284,0.249003 +-7.16234,0.908305,0.839088,1,3,0,7.56325,0.149123 +-6.98451,1,0.93159,2,3,0,7.14011,0.171237 +-6.8722,1,1.12582,1,1,0,6.96933,0.191405 +-7.88344,0.811767,1.35998,1,3,0,7.89223,0.0986425 +-7.88344,0.816532,1.37969,1,1,0,8.9546,0.0986425 +-6.98315,1,1.40581,1,1,0,7.63125,0.171442 +-6.98315,0.550567,1.69677,1,1,0,8.00839,0.171442 +-7.67226,0.854391,1.35244,2,3,0,7.96121,0.439019 +-7.07249,1,1.4269,1,1,0,7.53185,0.358411 +-7.02832,1,1.72114,2,3,0,7.04016,0.350341 +-7.3588,0.675412,2.07523,1,1,0,7.87279,0.401658 +-6.88154,1,1.85642,1,1,0,7.19177,0.317974 +-6.88154,0.0655637,2.23726,1,1,0,7.62901,0.317974 +-6.7523,0.996864,1.14461,2,3,0,6.90418,0.238552 +-7.05926,0.918029,1.37562,1,3,0,7.06522,0.160962 +-6.78121,1,1.53766,1,1,0,6.94552,0.218754 +-8.29802,0.262734,1.852,1,1,0,8.50027,0.498349 +-7.00606,0.9098,1.1377,1,3,0,8.78363,0.168088 +-7.00606,0.873138,1.262,1,1,0,7.45042,0.168088 +-6.80354,1,1.35361,1,1,0,6.9424,0.209966 +-6.80354,0.515728,1.62927,1,3,0,7.80727,0.209966 +-7.20639,0.899272,1.26232,1,3,0,7.30351,0.380198 +-7.20639,0.397036,1.38615,1,1,0,8.2386,0.380198 +-7.19904,1,0.965008,1,1,0,7.31224,0.379085 +-6.93482,1,1.16103,1,1,0,7.14118,0.331039 +-6.78088,0.913092,1.39634,2,3,0,7.12696,0.282916 +-6.78162,1,1.55182,2,3,0,6.78261,0.21857 +-6.79632,0.990314,1.86506,1,3,0,6.79727,0.290121 +-6.84741,0.939725,2.22118,1,1,0,6.93733,0.308282 +-6.84741,0.535216,2.52647,1,1,0,7.13543,0.308282 +-6.80939,1,1.99582,1,1,0,6.81525,0.208003 +-6.76756,1,2.39625,1,1,0,6.80888,0.225851 +-6.76756,3.89157e-13,2.87596,1,1,0,8.4026,0.225851 +-6.76756,0.674256,1.40587,1,3,0,7.49116,0.225851 +-7.00934,0.761852,1.26002,2,3,0,7.82836,0.346697 +-6.80258,1,1.22178,1,1,0,6.93833,0.292721 +-6.80258,0.312425,1.46626,1,1,0,7.71506,0.292721 +-7.43459,0.775743,0.951136,1,3,0,8.3252,0.125403 +-6.96646,0.93852,0.934121,2,3,0,8.35991,0.174013 +-6.83063,1,1.06089,1,1,0,6.93907,0.201625 +-6.83063,0.508254,1.27241,1,3,0,8.67003,0.201625 +-6.74803,0.974972,0.984492,2,3,0,7.04448,0.249489 +-6.80755,0.984642,1.15444,1,3,0,6.81755,0.208607 +-7.7744,0.776023,1.36499,1,3,0,7.81929,0.449829 +-7.41117,1,1.34054,2,3,0,7.60025,0.127144 +-7.38908,0.536659,1.60599,2,3,0,9.4095,0.128827 +-7.89648,0.937493,1.27556,2,3,0,7.9149,0.462082 +-6.82848,0.86259,1.44542,2,3,0,8.07509,0.202226 +-6.92294,0.960261,1.5325,1,1,0,6.9554,0.181337 +-9.08089,0.420377,1.7711,1,1,0,9.08844,0.0579714 +-7.7972,1,1.27047,1,1,0,8.90103,0.103009 +-7.7972,0.582598,1.52048,1,3,0,10.5353,0.103009 +-9.22259,0.924955,1.25927,2,3,0,9.59913,0.566176 +-6.74921,1,1.41026,1,1,0,7.95113,0.243933 +-6.74921,0.044649,1.68672,1,1,0,8.07699,0.243933 +-6.75097,0.998963,0.871184,1,3,0,6.75836,0.259679 +-7.01139,0.961927,1.04114,2,3,0,7.02404,0.167334 +-7.01139,9.77232e-07,2.40814,1,1,0,7.27917,0.167334 +-7.01139,1.49439e-44,5.62316,3,7,0,7.77784,0.167334 +-6.75156,0.982944,0.55444,1,3,0,7.40547,0.239578 +-6.77728,0.991861,0.551794,1,3,0,6.88507,0.281016 +-6.74817,0.996958,0.726791,2,3,0,6.8114,0.24785 +-6.8036,0.786576,1.1228,2,3,0,7.44621,0.293132 +-6.79074,1,0.992049,1,1,0,6.81063,0.287666 +-7.3233,0.64901,1.75356,1,1,0,7.3318,0.134107 +-6.77341,0.946885,1.06379,2,3,0,7.38085,0.278844 +-6.77341,0.778125,1.66629,1,1,0,6.85511,0.278844 +-6.77341,0.285244,1.54917,1,3,0,7.76999,0.278844 +-7.00742,0.994722,0.305709,3,7,0,7.07776,0.346321 +-7.61178,0.905011,0.571915,2,5,0,8.38445,0.113521 +-7.88789,0.973185,0.808161,1,1,0,7.92185,0.098425 +-6.74802,0.839133,1.4129,1,3,0,7.34186,0.249735 +-6.74802,0.019038,1.62381,1,1,0,7.83785,0.249735 +-7.04733,0.99819,0.149643,4,17,0,7.28015,0.353881 +-6.97379,0.999392,0.284619,2,3,0,7.09005,0.339526 +-6.75817,0.958154,0.539063,3,7,0,7.91443,0.268085 +-7.84966,0.706258,0.894043,1,3,0,8.63394,0.100318 +-7.54416,1,0.694606,2,3,0,7.83114,0.117811 +-6.83714,0.923919,1.29244,2,3,0,7.33778,0.199858 +-6.76497,1,1.90508,1,1,0,6.7702,0.273467 +-6.76497,0.00990637,3.48137,1,1,0,6.82882,0.273467 +-6.75593,0.999896,0.363157,3,7,0,6.77347,0.265939 +-6.77034,0.991252,0.666331,1,3,0,6.84747,0.224229 +-6.89854,0.954395,1.18103,1,1,0,6.90001,0.185928 +-6.90408,0.993342,1.86945,1,1,0,6.90553,0.32375 +-6.90408,3.2414e-07,3.27297,1,1,0,8.81351,0.32375 +-6.78267,0.992059,0.365369,2,7,0,7.28203,0.218096 +-7.02553,0.934992,0.6402,1,3,0,7.67211,0.349814 +-7.34736,0.751705,0.951835,1,3,0,8.24653,0.132127 +-6.76578,0.97643,0.85813,1,3,0,7.70366,0.274034 +-6.74904,1,1.41262,1,1,0,6.7571,0.25567 +-6.74904,0.179609,2.45545,1,1,0,6.97005,0.25567 +-6.83527,0.997192,0.489298,3,7,0,6.83872,0.304467 +-6.76437,0.987046,0.843889,1,3,0,6.9229,0.227866 +-6.76063,1,1.40562,2,3,0,6.7628,0.270187 +-6.76063,0.0373894,2.40133,1,1,0,7.34929,0.270187 +-7.17198,0.973793,0.349823,2,7,0,7.96248,0.14812 +-9.3482,0.917021,0.560538,2,7,0,9.34831,0.574187 +-6.80829,0.985496,0.773305,2,3,0,9.51249,0.294975 +-8.54523,0.363664,1.25927,1,1,0,8.64001,0.518278 +-6.92636,0.960794,0.437023,2,7,0,10.1493,0.180724 +-6.94618,0.924621,0.667654,1,3,0,7.99729,0.333591 +-6.98445,0.988443,0.928133,1,1,0,7.03448,0.341727 +-6.98445,0.179842,1.49883,1,1,0,7.94419,0.341727 +-6.9788,1,0.343737,1,1,0,6.99099,0.340566 +-7.21715,0.945161,0.570638,3,7,0,8.05234,0.381813 +-7.21715,0.677044,0.825931,1,1,0,8.31299,0.381813 +# Adaptation terminated +# Step size = 0.83124 +# Diagonal elements of inverse mass matrix: +# 0.525769 +-6.77384,0.964073,0.83124,1,3,0,7.46753,0.222338 +-6.863,0.968947,0.83124,1,3,0,7.01137,0.312874 +-6.83479,0.964185,0.83124,1,3,0,7.16339,0.200486 +-6.80509,0.978314,0.83124,1,3,0,7.03713,0.293726 +-6.79148,0.786013,0.83124,2,3,0,8.42285,0.214411 +-6.79943,0.998548,0.83124,1,1,0,6.80547,0.211417 +-6.85456,0.967137,0.83124,2,3,0,7.15794,0.310427 +-7.11014,0.963078,0.83124,2,7,0,7.14083,0.154842 +-6.75222,0.990723,0.83124,1,3,0,7.18664,0.238666 +-7.40454,0.858025,0.83124,1,3,0,7.7421,0.127645 +-7.17574,0.883441,0.83124,1,3,0,8.96348,0.375502 +-7.6387,0.88609,0.83124,1,1,0,7.67194,0.435344 +-7.41421,0.638614,0.83124,1,3,0,10.1123,0.126916 +-7.80019,0.957369,0.83124,1,1,0,7.80975,0.102852 +-7.88627,0.991536,0.83124,1,1,0,7.99586,0.0985041 +-6.75872,1,0.83124,2,3,0,7.70683,0.232017 +-7.11378,0.930982,0.83124,1,3,0,7.23357,0.154425 +-7.78231,0.833848,0.83124,1,3,0,9.34305,0.450644 +-10.8458,0.737345,0.83124,2,3,0,10.8484,0.654932 +-8.70316,1,0.83124,1,1,0,10.4622,0.530246 +-8.46077,0.999442,0.83124,2,7,0,8.60336,0.0753873 +-6.75196,0.930715,0.83124,1,3,0,9.34507,0.239023 +-8.00242,0.761929,0.83124,2,7,0,8.83251,0.09307 +-6.83863,0.988684,0.83124,2,3,0,8.2073,0.199463 +-6.95273,0.980951,0.83124,1,1,0,6.95283,0.17622 +-7.02868,0.996107,0.83124,2,3,0,7.04407,0.164954 +-6.96996,1,0.83124,1,1,0,7.04111,0.173465 +-6.8514,1,0.83124,1,1,0,6.95057,0.196226 +-6.8514,0.833873,0.83124,1,3,0,8.14037,0.196226 +-6.78249,0.983889,0.83124,1,3,0,7.01443,0.283736 +-6.78375,0.999722,0.83124,1,1,0,6.79085,0.284361 +-6.80289,0.525311,0.83124,2,3,0,10.9828,0.210191 +-8.20043,0.750952,0.83124,1,3,0,8.99683,0.490024 +-7.53287,1,0.83124,1,1,0,8.10917,0.423294 +-7.36791,1,0.83124,1,1,0,7.6078,0.402857 +-6.9395,1,0.83124,1,1,0,7.26203,0.332098 +-6.95192,0.996996,0.83124,1,1,0,6.9929,0.334853 +-7.3959,0.894674,0.83124,1,1,0,7.39743,0.40649 +-7.11496,0.78561,0.83124,1,3,0,8.82366,0.154291 +-6.83712,0.958426,0.83124,1,3,0,7.62792,0.305062 +-6.8801,0.941281,0.83124,1,3,0,7.22037,0.189698 +-6.92991,0.991833,0.83124,1,1,0,6.94072,0.180096 +-8.34814,0.819711,0.83124,1,3,0,8.78677,0.0792645 +-6.84984,0.968149,0.83124,2,3,0,9.08518,0.196609 +-6.86277,0.999425,0.83124,2,7,0,6.86278,0.312809 +-6.94153,0.993821,0.83124,2,3,0,6.95258,0.332554 +-6.87269,0.932025,0.83124,1,3,0,7.39662,0.191298 +-6.7648,0.998233,0.83124,1,3,0,6.86398,0.227579 +-8.11991,0.757565,0.83124,1,3,0,8.69431,0.482936 +-8.1387,0.9983,0.83124,2,3,0,8.48925,0.484608 +-7.56635,1,0.83124,2,3,0,8.09196,0.427186 +-7.56635,0.557179,0.83124,1,3,0,10.7721,0.427186 +-7.56635,0.576829,0.83124,1,1,0,9.06079,0.427186 +-6.83021,0.947852,0.83124,2,3,0,7.96475,0.302806 +-7.30326,0.932308,0.83124,2,7,0,7.32215,0.135802 +-7.02293,1,0.83124,1,1,0,7.26355,0.165736 +-7.04935,0.93183,0.83124,1,3,0,7.9051,0.354252 +-7.04935,0.863194,0.83124,1,1,0,7.4807,0.354252 +-7.58697,0.871021,0.83124,1,1,0,7.59464,0.429545 +-7.13387,0.767791,0.83124,1,3,0,9.1847,0.152178 +-7.24792,0.88435,0.83124,2,3,0,8.88901,0.386338 +-8.00733,0.664207,0.83124,2,3,0,9.81879,0.47266 +-8.00733,0.699938,0.83124,1,1,0,9.09012,0.47266 +-7.7664,1,0.83124,2,3,0,8.15156,0.449002 +-7.28614,1,0.83124,2,7,0,7.82793,0.137284 +-7.28448,1,0.83124,2,3,0,7.36818,0.13743 +-6.86252,0.996117,0.83124,2,7,0,7.22775,0.312738 +-6.83745,0.963073,0.83124,1,3,0,7.16908,0.199775 +-6.87095,0.875028,0.83124,2,3,0,8.20001,0.315103 +-6.7494,0.994244,0.83124,1,3,0,6.91147,0.243467 +-6.75696,0.997363,0.83124,1,3,0,6.7673,0.266958 +-6.76021,0.999306,0.83124,1,1,0,6.76133,0.269844 +-7.33075,0.848267,0.83124,2,7,0,7.86167,0.133488 +-6.75574,0.966952,0.83124,2,7,0,7.6808,0.265745 +-6.76149,0.994652,0.83124,2,7,0,6.79199,0.229867 +-6.80994,0.992363,0.83124,2,3,0,6.8348,0.207822 +-6.8699,0.960605,0.83124,2,3,0,7.24602,0.314812 +-6.82221,1,0.83124,1,1,0,6.866,0.300076 +-6.82221,0.47126,0.83124,1,3,0,10.5373,0.300076 +-7.5445,0.733885,0.83124,1,3,0,8.6065,0.117789 +-6.78499,0.950683,0.83124,1,3,0,8.20955,0.28497 +-6.74822,0.999282,0.83124,1,3,0,6.78836,0.252517 +-6.75123,0.989824,0.83124,2,3,0,6.82353,0.260105 +-7.23127,0.870957,0.83124,1,3,0,7.59816,0.142271 +-7.76332,0.943719,0.83124,2,3,0,8.09691,0.104809 +-11.7433,0.652563,0.83124,1,3,0,13.6757,0.0212821 +-12.0315,0.993772,0.83124,1,1,0,12.2501,0.0192103 +-11.1836,1,0.83124,1,1,0,12.0617,0.0260228 +-8.21825,0.994196,0.83124,2,3,0,11.7239,0.0840855 +-7.66942,1,0.83124,2,3,0,8.16999,0.11007 +-6.91984,0.999109,0.83124,2,3,0,7.69374,0.181898 +-6.78687,0.978684,0.83124,1,3,0,7.14461,0.28587 +-6.78346,1,0.83124,1,1,0,6.79287,0.284218 +-7.27811,0.831927,0.83124,1,3,0,7.88547,0.137991 +-7.23536,1,0.83124,2,3,0,7.33423,0.141886 +-7.37743,0.981922,0.83124,1,1,0,7.41202,0.129733 +-6.81382,0.945983,0.83124,2,3,0,8.10266,0.206581 +-6.8553,0.976565,0.83124,1,3,0,7.09389,0.310644 +-6.92544,0.928885,0.83124,1,3,0,7.36104,0.180889 +-6.82435,1,0.83124,2,3,0,6.90815,0.203404 +-6.86948,0.973652,0.83124,1,3,0,7.14311,0.314697 +-6.90771,0.925607,0.83124,1,3,0,7.34968,0.184155 +-6.74802,0.994844,0.83124,1,3,0,6.95766,0.250139 +-6.75042,0.999458,0.83124,1,3,0,6.75137,0.25872 +-6.75028,1,0.83124,2,7,0,6.75039,0.241671 +-6.768,0.960202,0.83124,2,3,0,7.07186,0.275525 +-6.74936,0.998122,0.83124,1,3,0,6.78133,0.243572 +-6.85341,0.986672,0.83124,2,3,0,6.86337,0.195738 +-7.42954,0.865673,0.83124,1,3,0,8.10763,0.41076 +-6.76667,0.98275,0.83124,2,3,0,7.56304,0.274643 +-6.74976,0.999609,0.83124,2,3,0,6.77005,0.257422 +-6.85345,0.958802,0.83124,2,3,0,7.03239,0.195727 +-6.74802,1,0.83124,2,3,0,6.83724,0.250057 +-6.75667,0.957558,0.83124,2,3,0,7.07779,0.266674 +-6.75417,0.786511,0.83124,2,3,0,8.50589,0.236311 +-6.83211,0.986441,0.83124,1,3,0,6.8457,0.201216 +-6.92529,0.984261,0.83124,1,1,0,6.92579,0.180915 +-7.0946,0.991361,0.83124,2,3,0,7.09586,0.156647 +-6.76822,0.991666,0.83124,1,3,0,7.11608,0.225457 +-6.75063,0.985668,0.83124,2,3,0,6.88296,0.241038 +-6.75063,0.913898,0.83124,1,3,0,7.24494,0.241038 +-6.74919,0.999353,0.83124,2,7,0,6.75543,0.256082 +-6.74806,0.999186,0.83124,2,3,0,6.75537,0.248847 +-6.91536,0.963629,0.83124,1,3,0,6.97837,0.326496 +-6.91536,0.966256,0.83124,1,1,0,7.03575,0.326496 +-6.8701,0.814489,0.83124,2,3,0,8.28314,0.191871 +-7.34587,0.880152,0.83124,1,3,0,8.03065,0.399942 +-7.13938,1,0.83124,1,1,0,7.34728,0.369726 +-6.87923,0.91688,0.83124,1,3,0,7.73026,0.189883 +-7.28722,0.961855,0.83124,2,7,0,7.29556,0.391933 +-6.97949,1,0.83124,1,1,0,7.22073,0.340708 +-7.29622,0.923533,0.83124,1,1,0,7.30638,0.393187 +-7.18376,0.860064,0.83124,2,3,0,8.41749,0.376745 +-6.90516,0.945139,0.83124,2,3,0,7.64572,0.324015 +-6.75024,0.992254,0.83124,1,3,0,6.95933,0.241742 +-6.79811,0.993726,0.83124,2,3,0,6.80685,0.211895 +-6.87454,0.986471,0.83124,2,3,0,6.94309,0.190893 +-6.87066,1,0.83124,2,3,0,6.89482,0.191745 +-7.04939,0.889911,0.83124,2,3,0,7.88737,0.162222 +-7.10248,0.980136,0.83124,2,3,0,7.38285,0.155726 +-6.75701,0.959748,0.83124,2,3,0,7.5595,0.233497 +-6.7774,0.909653,0.83124,2,3,0,7.53683,0.281081 +-7.48854,0.775847,0.83124,1,3,0,8.28076,0.121558 +-6.9938,0.9085,0.83124,1,3,0,8.74034,0.343621 +-6.84898,1,0.83124,2,3,0,6.9622,0.308758 +-6.80491,1,0.83124,1,1,0,6.84326,0.293653 +-6.76831,0.963487,0.83124,2,3,0,7.08812,0.225403 +-7.1262,0.968645,0.83124,2,3,0,7.13483,0.367571 +-7.13882,0.996805,0.83124,1,1,0,7.22615,0.369634 +-6.9585,0.937061,0.83124,2,3,0,7.69631,0.336284 +-6.76349,0.99334,0.83124,2,3,0,7.01074,0.272405 +-7.3077,0.913449,0.83124,2,3,0,7.52301,0.394774 +-7.31914,1,0.83124,2,7,0,7.32605,0.134455 +-7.63764,0.962657,0.83124,1,1,0,7.64931,0.111951 +-6.81705,1,0.83124,2,3,0,7.57168,0.20558 +-6.83357,0.999029,0.83124,2,3,0,6.8419,0.200818 +-6.76289,0.989624,0.83124,1,3,0,6.93017,0.271959 +-6.76249,0.997774,0.83124,2,3,0,6.78677,0.271656 +-6.88637,0.955711,0.83124,1,3,0,7.04548,0.188384 +-7.05585,0.991078,0.83124,2,3,0,7.0559,0.161393 +-7.48388,0.863007,0.83124,1,3,0,8.72515,0.417456 +-7.57991,1,0.83124,2,7,0,7.58089,0.115509 +-7.22688,0.873432,0.83124,1,3,0,9.44486,0.383258 +-7.22688,0.792043,0.83124,1,3,0,8.71736,0.383258 +-7.75844,0.869436,0.83124,1,1,0,7.79558,0.448176 +-7.68603,1,0.83124,2,3,0,7.96018,0.44051 +-7.28797,1,0.83124,1,1,0,7.64492,0.392037 +-8.04273,0.818251,0.83124,1,1,0,8.07371,0.475939 +-8.82221,0.808887,0.83124,1,1,0,9.01829,0.538919 +-7.07998,1,0.83124,3,7,0,8.36851,0.359728 +-7.38081,0.825492,0.83124,2,3,0,8.40446,0.404541 +-6.76721,0.96623,0.83124,1,3,0,7.63037,0.226061 +-6.7649,0.775322,0.83124,2,3,0,8.94489,0.273422 +-7.01197,0.923279,0.83124,2,7,0,7.28761,0.167254 +-7.17433,0.900558,0.83124,1,3,0,8.10545,0.375282 +-7.1308,1,0.83124,2,7,0,7.15669,0.152517 +-7.31673,0.967825,0.83124,2,3,0,7.63974,0.134657 +-7.08262,1,0.83124,1,1,0,7.28998,0.158077 +-6.95789,0.989292,0.83124,2,3,0,7.27081,0.175381 +-7.15382,0.970885,0.83124,1,1,0,7.15518,0.150022 +-7.16743,0.998118,0.83124,1,1,0,7.228,0.148591 +-7.78568,0.950049,0.83124,2,7,0,7.86488,0.450991 +-6.79441,0.94168,0.83124,1,3,0,8.25052,0.213275 +-6.78609,0.987816,0.83124,1,3,0,6.91885,0.2855 +-7.03885,0.902658,0.83124,1,3,0,7.41969,0.163597 +-6.75408,1,0.83124,2,3,0,7.008,0.23641 +-6.92626,0.982871,0.83124,2,3,0,6.93174,0.329068 +-6.85272,1,0.83124,1,1,0,6.91861,0.30988 +-7.06749,0.931131,0.83124,2,3,0,7.40822,0.357524 +-6.75899,0.999194,0.83124,1,3,0,7.0446,0.268813 +-7.43537,0.907282,0.83124,2,3,0,7.43537,0.125346 +-7.12273,1,0.83124,1,1,0,7.39553,0.153414 +-8.80058,0.855819,0.83124,2,3,0,8.93794,0.0651208 +-6.79441,0.988156,0.83124,2,7,0,8.46303,0.289299 +-7.12951,0.954892,0.83124,2,7,0,7.13648,0.15266 +-7.04909,0.909301,0.83124,2,7,0,8.12986,0.354204 +-7.03487,1,0.83124,1,1,0,7.10954,0.351573 +-7.18092,0.987963,0.83124,2,3,0,7.21997,0.376307 +-6.7582,0.977551,0.83124,1,3,0,7.3415,0.232454 +-7.06299,0.928991,0.83124,1,3,0,7.25372,0.356721 +-6.81925,0.973163,0.83124,2,3,0,7.27878,0.299032 +-6.86807,0.952759,0.83124,1,3,0,7.15596,0.192324 +-6.77283,0.99799,0.83124,2,3,0,6.89196,0.222871 +-7.53588,0.930234,0.83124,2,3,0,7.58322,0.423647 +-7.10576,1,0.83124,2,7,0,7.53605,0.155346 +-6.75998,0.990989,0.83124,1,3,0,7.14958,0.231009 +-6.8546,0.985018,0.83124,1,3,0,6.86663,0.195449 +-6.86412,0.820813,0.83124,2,3,0,8.89141,0.313192 +-8.07684,0.733933,0.83124,2,3,0,9.01202,0.479057 +-8.79165,0.43458,0.83124,3,7,0,12.3811,0.53672 +-10.168,0.693618,0.83124,1,1,0,10.4608,0.621355 +-6.75099,1,0.83124,2,3,0,10.2624,0.240445 +-6.76743,0.994377,0.83124,1,3,0,6.78956,0.275152 +-6.74802,1,0.83124,2,3,0,6.76526,0.249906 +-7.26292,0.93715,0.83124,2,3,0,7.35514,0.388496 +-6.9598,1,0.83124,1,1,0,7.19535,0.336562 +-7.03347,0.881388,0.83124,1,3,0,7.83067,0.164311 +-7.12372,0.986908,0.83124,1,1,0,7.14639,0.153304 +-7.11126,1,0.83124,1,1,0,7.17697,0.154714 +-6.74882,0.967722,0.83124,2,3,0,7.49087,0.245016 +-9.87289,0.667865,0.83124,3,7,0,9.91668,0.0423813 +-7.37053,1,0.83124,2,3,0,9.71975,0.130274 +-7.51509,0.994287,0.83124,2,3,0,7.56352,0.119743 +-8.07113,0.942998,0.83124,1,1,0,8.07242,0.0900643 +-8.30409,0.980274,0.83124,1,1,0,8.39063,0.0808552 +-8.64005,0.974654,0.83124,1,1,0,8.71465,0.0697256 +-7.94544,1,0.83124,1,1,0,8.58389,0.0956776 +-7.56343,1,0.83124,1,1,0,7.92373,0.11656 +-7.53226,1,0.83124,1,1,0,7.66116,0.118596 +-7.7185,0.979788,0.83124,1,1,0,7.77244,0.107267 +-6.93088,0.991557,0.83124,2,7,0,7.61746,0.330137 +-6.84558,1,0.83124,1,1,0,6.91779,0.307721 +-6.78054,1,0.83124,1,1,0,6.831,0.282743 +-7.21002,0.941592,0.83124,2,7,0,7.21287,0.144308 +-7.07476,0.900529,0.83124,2,7,0,8.34915,0.358811 +-7.04526,1,0.83124,1,1,0,7.13043,0.353501 +-6.99076,1,0.83124,1,1,0,7.07607,0.343009 +-6.94969,1,0.83124,1,1,0,7.01782,0.334365 +-7.60817,0.899713,0.83124,2,7,0,7.68059,0.113743 +-7.2221,1,0.83124,1,1,0,7.56145,0.143142 +-7.47904,0.967914,0.83124,1,1,0,7.49182,0.12222 +-6.82308,0.943186,0.83124,1,3,0,8.24455,0.300378 +-7.6281,0.83076,0.83124,2,3,0,8.19849,0.434168 +-7.13111,1,0.83124,1,1,0,7.52116,0.368378 +-7.44047,0.804811,0.83124,2,3,0,8.61146,0.412127 +-7.42694,1,0.83124,1,1,0,7.60205,0.410434 +-6.82628,0.926955,0.83124,1,3,0,7.95012,0.20285 +-8.25298,0.747758,0.83124,1,3,0,9.16428,0.494542 +-6.76356,0.968814,0.83124,2,3,0,8.50658,0.272455 +-6.78746,0.985816,0.83124,1,3,0,6.86197,0.216038 +-8.00108,0.777665,0.83124,1,3,0,8.57395,0.0931302 +-8.43027,0.963892,0.83124,1,1,0,8.4665,0.0764114 +-6.92384,0.951086,0.83124,1,3,0,8.69294,0.181174 +-6.76339,0.996632,0.83124,1,3,0,6.92114,0.228523 +-6.78255,0.886053,0.83124,2,3,0,7.78492,0.283766 +-6.84807,0.963408,0.83124,1,3,0,7.03001,0.197046 +-6.94545,0.983824,0.83124,1,1,0,6.94662,0.177427 +-7.10754,0.991839,0.83124,2,3,0,7.11043,0.15514 +-6.75206,0.990792,0.83124,1,3,0,7.18406,0.23888 +-6.75206,0.749219,0.83124,1,3,0,8.35235,0.23888 +-8.79153,0.574896,0.83124,1,3,0,10.4533,0.0653696 +-6.76249,0.92029,0.83124,1,3,0,9.82805,0.229152 +-6.77931,0.996801,0.83124,1,1,0,6.7795,0.219631 +-6.78542,0.998865,0.83124,1,1,0,6.78975,0.216896 +-6.83156,0.976459,0.83124,2,3,0,7.03651,0.303253 +-6.84555,0.996772,0.83124,1,1,0,6.86066,0.30771 +-6.84555,0.728082,0.83124,1,3,0,8.40725,0.30771 +-7.01186,0.896194,0.83124,2,7,0,7.53061,0.167269 +-7.48511,0.958872,0.83124,2,7,0,7.52605,0.417605 +-7.48511,0.626343,0.83124,1,1,0,8.76138,0.417605 +-7.3994,0.655782,0.83124,1,3,0,9.79743,0.128036 +-7.62624,0.963981,0.83124,2,3,0,8.09082,0.112638 +-7.19593,1,0.83124,1,1,0,7.57189,0.145694 +-6.75175,0.97848,0.83124,2,3,0,7.50004,0.260893 +-6.77329,0.991969,0.83124,1,3,0,6.80402,0.222627 +-6.76699,0.751692,0.83124,2,3,0,9.24945,0.274858 +-7.44326,0.910622,0.83124,2,7,0,7.44387,0.124771 +-6.86973,0.938481,0.83124,2,3,0,8.30612,0.191954 +-6.74858,1,0.83124,2,3,0,6.85438,0.245841 +-6.76175,0.95756,0.83124,2,3,0,7.08443,0.271083 +-7.30166,0.915479,0.83124,2,3,0,7.50717,0.393941 +-7.46467,0.958138,0.83124,1,1,0,7.56648,0.415116 +-7.10025,1,0.83124,1,1,0,7.39828,0.363225 +-6.96184,1,0.83124,1,1,0,7.08981,0.336999 +-6.84422,0.972875,0.83124,2,3,0,7.19726,0.307302 +-7.008,0.987279,0.83124,2,3,0,7.00943,0.346435 +-6.9106,1,0.83124,1,1,0,7.00278,0.325347 +-7.09334,0.855476,0.83124,2,7,0,7.86711,0.156796 +-6.75359,0.991174,0.83124,1,3,0,7.15683,0.236964 +-8.06068,0.765804,0.83124,1,3,0,8.52946,0.477586 +-7.26799,1,0.83124,2,7,0,8.00849,0.138892 +-7.20104,1,0.83124,2,7,0,7.26635,0.37939 +-7.58599,0.904256,0.83124,1,1,0,7.63215,0.429432 +-6.97993,1,0.83124,1,1,0,7.43258,0.3408 +-6.95606,0.947196,0.83124,2,3,0,7.44203,0.335756 +-7.16938,0.810824,0.83124,1,3,0,8.14873,0.148389 +-6.80224,0.998185,0.83124,2,7,0,7.10378,0.292583 +-6.78255,1,0.83124,1,1,0,6.80126,0.283766 +-8.23019,0.807995,0.83124,2,7,0,8.24486,0.0836257 +-7.0982,0.983298,0.83124,2,7,0,8.14583,0.362876 +-7.08647,1,0.83124,1,1,0,7.17275,0.360858 +-6.75258,0.99775,0.83124,2,3,0,7.11018,0.262061 +-6.77851,0.990656,0.83124,2,3,0,6.81968,0.220013 +-8.41876,0.848758,0.83124,2,3,0,8.6108,0.508278 +-8.41876,0.911633,0.83124,1,1,0,9.03193,0.508278 +-7.22102,1,0.83124,2,3,0,8.10431,0.382389 +-7.38417,0.958484,0.83124,1,1,0,7.46554,0.404977 +-6.75199,0.996359,0.83124,2,3,0,7.42889,0.261251 +-6.75104,0.998738,0.83124,1,3,0,6.76224,0.240367 +-7.71922,0.892545,0.83124,2,3,0,7.87548,0.444057 +-6.86778,0.917679,0.83124,2,3,0,8.48586,0.192389 +-6.95126,0.956628,0.83124,2,3,0,7.40808,0.334709 +-8.96304,0.736422,0.83124,2,7,0,9.03682,0.548826 +-8.35895,1,0.83124,1,1,0,9.10177,0.503409 +-8.47509,0.96886,0.83124,1,1,0,8.86946,0.512781 +-7.32948,1,0.83124,1,1,0,8.18422,0.397743 +-7.30027,1,0.83124,1,1,0,7.45019,0.393749 +-7.59187,0.926039,0.83124,1,1,0,7.67276,0.430101 +-7.26753,0.998524,0.83124,2,7,0,7.70223,0.138934 +-6.76899,0.970545,0.83124,1,3,0,7.6577,0.27616 +-6.75171,0.999175,0.83124,2,3,0,6.77632,0.260835 +-6.81331,0.992529,0.83124,2,3,0,6.81333,0.206741 +-6.74809,0.998276,0.83124,1,3,0,6.82834,0.248545 +-6.81438,0.99156,0.83124,2,3,0,6.81864,0.206406 +-6.81163,0.982,0.83124,1,3,0,7.01108,0.296243 +-7.02836,0.945327,0.83124,2,3,0,7.26202,0.35035 +-6.94533,0.854683,0.83124,2,3,0,8.15538,0.177447 +-6.82795,0.95801,0.83124,2,7,0,7.2953,0.302047 +-6.84041,0.999043,0.83124,2,3,0,6.85504,0.306112 +-6.82322,0.984625,0.83124,2,3,0,6.98844,0.300428 +-6.76785,0.98604,0.83124,1,3,0,6.92197,0.225672 +-7.23958,0.912753,0.83124,1,3,0,7.39269,0.141491 +-7.61645,0.954382,0.83124,1,1,0,7.61899,0.113235 +-7.42711,1,0.83124,1,1,0,7.63783,0.125955 +-7.19589,0.907037,0.83124,2,3,0,8.81518,0.145698 +-7.01047,1,0.83124,1,1,0,7.17423,0.167464 +-6.74815,1,0.83124,2,3,0,6.9691,0.248011 +-6.75882,0.949563,0.83124,2,3,0,7.14567,0.26866 +-6.83891,0.970866,0.83124,1,3,0,6.94556,0.19939 +-6.77329,0.987181,0.83124,1,3,0,6.96876,0.278779 +-6.75123,0.996837,0.83124,1,3,0,6.79586,0.240082 +-6.80947,0.994089,0.83124,2,3,0,6.81015,0.295427 +-6.77308,0.983807,0.83124,2,3,0,6.95378,0.222737 +-6.78554,0.99767,0.83124,1,1,0,6.78752,0.216843 +-6.78568,0.98879,0.83124,1,3,0,6.90055,0.285303 +-6.88538,0.950348,0.83124,1,3,0,7.11342,0.188589 +-6.82178,1,0.83124,1,1,0,6.87608,0.204156 +-6.82736,0.999016,0.83124,1,1,0,6.83939,0.202541 +-6.89157,0.989011,0.83124,1,1,0,6.89373,0.18732 +-6.75901,0.989762,0.83124,2,3,0,7.01753,0.268825 +-6.80996,0.980821,0.83124,1,3,0,6.89298,0.207816 +-7.62764,0.868165,0.83124,1,3,0,7.87879,0.112554 +-6.83386,0.976113,0.83124,1,3,0,7.69414,0.200737 +-6.80187,1,0.83124,1,1,0,6.83123,0.21055 +-7.57988,0.871515,0.83124,1,3,0,7.82369,0.115511 +-6.77056,0.950889,0.83124,1,3,0,8.19634,0.277143 +-7.2632,0.589267,0.83124,3,7,0,9.8991,0.388535 +-6.76222,0.988918,0.83124,2,3,0,7.35072,0.27145 +-6.75441,0.828645,0.83124,2,3,0,8.11217,0.236052 +-6.75137,0.998602,0.83124,1,3,0,6.76732,0.26032 +-6.75119,1,0.83124,2,7,0,6.75134,0.240144 +-6.83777,0.977697,0.83124,1,3,0,6.89795,0.305273 +-7.05198,0.880242,0.83124,1,3,0,7.59803,0.161888 +-7.08906,0.909811,0.83124,1,3,0,8.04163,0.361307 +-6.9797,0.902237,0.83124,1,3,0,7.93237,0.171964 +-7.4862,0.944018,0.83124,2,3,0,7.68429,0.12172 +-6.82465,0.942357,0.83124,1,3,0,8.26316,0.300924 +-7.44841,0.760383,0.83124,1,3,0,8.40745,0.124397 +-8.00497,0.94107,0.83124,1,1,0,8.0053,0.092956 +-7.68538,1,0.83124,1,1,0,8.00992,0.109146 +-6.88754,0.97576,0.83124,1,3,0,7.70824,0.188142 +-7.04979,0.974365,0.83124,1,1,0,7.04997,0.16217 +-7.0781,0.995853,0.83124,1,1,0,7.11922,0.158625 +-6.98826,1,0.83124,1,1,0,7.0817,0.170676 +-6.89059,1,0.83124,2,3,0,6.97718,0.187519 +-6.91078,0.996679,0.83124,1,1,0,6.93017,0.183574 +-6.81655,1,0.83124,1,1,0,6.89449,0.205734 +-6.82246,0.971638,0.83124,2,7,0,7.03718,0.300165 +-6.77932,1,0.83124,1,1,0,6.81346,0.282107 +-6.75549,0.932426,0.83124,2,3,0,7.27781,0.234935 +-6.80928,0.992354,0.83124,2,3,0,6.82663,0.208039 +-6.74813,1,0.83124,2,3,0,6.79927,0.251869 +-6.8938,0.969146,0.83124,1,3,0,6.94097,0.321165 +-6.9363,0.910686,0.83124,1,3,0,7.46543,0.178982 +-6.75128,1,0.83124,2,3,0,6.90075,0.260184 +-6.75043,0.998985,0.83124,1,3,0,6.75953,0.241385 +-6.82389,0.981096,0.83124,1,3,0,6.87385,0.30066 +-6.79243,0.977277,0.83124,1,3,0,6.98931,0.214036 +-6.8333,0.918046,0.83124,2,3,0,7.59156,0.303827 +-6.76828,0.985022,0.83124,1,3,0,6.93845,0.225421 +-8.23007,0.858441,0.83124,2,3,0,8.41622,0.492582 +-8.07369,1,0.83124,1,1,0,8.49603,0.478771 +-6.91369,0.871004,0.83124,1,3,0,9.11615,0.18303 +-7.02274,0.982911,0.83124,1,1,0,7.02831,0.165762 +-8.57829,0.823075,0.83124,1,3,0,9.00592,0.0716101 +-9.18916,0.960411,0.83124,1,1,0,9.22074,0.0554741 +-6.93579,1,0.83124,2,3,0,8.91903,0.17907 +-6.84418,1,0.83124,1,1,0,6.92167,0.198025 +-7.36544,0.874983,0.83124,1,3,0,7.98564,0.402533 +-7.25144,1,0.83124,1,1,0,7.43375,0.386846 +-7.61039,0.910001,0.83124,1,1,0,7.67077,0.432191 +-7.68539,0.980101,0.83124,1,1,0,7.88577,0.44044 +-7.68539,0.740829,0.83124,1,1,0,8.56959,0.44044 +-7.61459,1,0.83124,2,3,0,7.86881,0.432662 +-7.61459,0.325198,0.83124,1,3,0,12.6633,0.432662 +-7.61459,0.824283,0.83124,1,1,0,8.23778,0.432662 +-7.28184,0.998587,0.83124,2,7,0,7.72852,0.137662 +-7.6469,0.954747,0.83124,2,3,0,8.03061,0.111398 +-7.33059,1,0.83124,2,3,0,7.62198,0.133501 +-6.81394,0.985851,0.83124,1,3,0,7.34163,0.206545 +-7.42402,0.863665,0.83124,1,3,0,7.976,0.410067 +-7.31989,1,0.83124,1,1,0,7.51429,0.396442 +-7.42367,0.973158,0.83124,1,1,0,7.54131,0.410023 +-6.74871,0.993336,0.83124,1,3,0,7.46265,0.25465 +-6.75426,0.998114,0.83124,1,3,0,6.76092,0.23621 +-6.82593,0.979598,0.83124,1,3,0,6.89302,0.30136 +-6.97612,0.909384,0.83124,1,3,0,7.40497,0.172511 +-6.9844,0.999099,0.83124,2,7,0,6.98905,0.341716 +-7.42223,0.670474,0.83124,3,7,0,9.28371,0.126316 +-7.10461,1,0.83124,2,3,0,7.38047,0.155478 +-7.10461,0.782705,0.83124,1,3,0,9.54674,0.155478 +-7.00188,1,0.83124,2,3,0,7.10561,0.168685 +-6.74806,0.992249,0.83124,1,3,0,7.08259,0.248939 +-7.08924,0.929186,0.83124,1,3,0,7.20661,0.361337 +-7.53961,0.96344,0.83124,2,3,0,7.55811,0.424084 +-7.53961,0.679531,0.83124,1,3,0,9.47386,0.424084 +-7.53961,0.761592,0.83124,1,1,0,8.33328,0.424084 +-7.4718,1,0.83124,1,1,0,7.68659,0.415988 +-6.97014,1,0.83124,2,3,0,7.34665,0.33876 +-6.97014,0.886425,0.83124,1,1,0,7.32969,0.33876 +-6.92333,1,0.83124,1,1,0,6.98846,0.328384 +-7.63824,0.666417,0.83124,1,3,0,9.16967,0.111915 +-6.77002,0.95385,0.83124,1,3,0,8.29479,0.276808 +-7.22734,0.864583,0.83124,2,7,0,7.72141,0.142643 +-7.00117,0.923013,0.83124,1,3,0,8.23168,0.34509 +-6.7669,0.975969,0.83124,1,3,0,7.164,0.226252 +-7.72183,0.908054,0.83124,2,3,0,7.81059,0.444334 +-6.99984,0.8392,0.83124,1,3,0,8.95765,0.16898 +-7.1022,0.984878,0.83124,1,1,0,7.1183,0.155758 +-7.12996,0.996062,0.83124,1,1,0,7.17868,0.15261 +-6.76356,0.979592,0.83124,1,3,0,7.40583,0.272452 +-8.38279,0.792121,0.83124,2,7,0,8.39169,0.0780431 +-6.97677,0.867392,0.83124,1,3,0,10.5448,0.340147 +-7.75945,0.615469,0.83124,1,3,0,9.62428,0.105017 +-7.80602,0.99843,0.83124,2,3,0,7.92568,0.102549 +-6.78105,0.971315,0.83124,1,3,0,8.06178,0.218825 +-6.98351,0.942457,0.83124,1,3,0,7.22232,0.341535 +-6.83545,1,0.83124,1,1,0,6.94979,0.304526 +-7.14087,0.851289,0.83124,1,3,0,7.7826,0.151413 +-7.60352,0.83851,0.83124,2,3,0,9.00236,0.114031 +-6.77286,0.940714,0.83124,2,7,0,8.25075,0.278522 +-6.77286,0.890756,0.83124,1,3,0,7.40339,0.278522 +-7.36896,0.826012,0.83124,2,7,0,8.01466,0.130398 +-8.1207,0.932646,0.83124,2,3,0,8.48115,0.0879831 +-8.93285,0.938257,0.83124,1,1,0,8.93377,0.0616164 +-8.02501,0.995976,0.83124,3,7,0,8.87805,0.0920654 +-6.74911,0.967012,0.83124,1,3,0,8.63806,0.244197 +-7.07113,0.930894,0.83124,1,3,0,7.204,0.35817 +-7.89567,0.807429,0.83124,1,1,0,7.897,0.462003 +-6.76236,1,0.83124,2,3,0,7.79892,0.229242 +-6.86448,0.937159,0.83124,2,3,0,7.23906,0.193138 +-7.13268,0.915204,0.83124,1,3,0,7.68429,0.368633 +-6.84688,0.930274,0.83124,1,3,0,7.62131,0.197344 +-6.79357,1,0.83124,1,1,0,6.83764,0.213594 +-7.08623,0.957889,0.83124,1,3,0,7.12656,0.157643 +-6.96553,1,0.83124,1,1,0,7.07713,0.17416 +-7.39033,0.843844,0.83124,2,3,0,8.525,0.128731 +-6.75045,0.983714,0.83124,1,3,0,7.60027,0.241349 +-7.4906,0.904785,0.83124,2,3,0,7.50392,0.121415 +-7.396,0.999851,0.83124,2,7,0,7.49189,0.406503 +-6.85681,1,0.83124,2,7,0,7.28796,0.194923 +-9.59079,0.548716,0.83124,1,3,0,11.3888,0.0472823 +-8.75304,0.98309,0.83124,3,7,0,9.60441,0.533915 +-7.84544,1,0.83124,1,1,0,8.63919,0.457041 +-6.75123,1,0.83124,2,3,0,7.80373,0.240084 +-6.76828,0.998145,0.83124,2,7,0,6.76839,0.275703 +-6.76889,0.996695,0.83124,2,3,0,6.8031,0.276096 +-11.4294,0.461439,0.83124,2,3,0,13.0472,0.680737 +-9.35255,1,0.83124,2,3,0,11.2183,0.574461 +-7.56067,1,0.83124,1,1,0,8.88487,0.426531 +-8.73551,0.727767,0.83124,1,1,0,8.78484,0.532631 +-7.28928,1,0.83124,1,1,0,8.35196,0.392221 +-7.28928,0.694436,0.83124,1,1,0,8.29393,0.392221 +-7.28928,0.802851,0.83124,1,3,0,8.48832,0.392221 +-7.06629,1,0.83124,1,1,0,7.26816,0.35731 +-7.17237,0.881171,0.83124,2,3,0,7.99775,0.374976 +-7.23357,0.984417,0.83124,1,1,0,7.32185,0.384243 +-7.08509,1,0.83124,1,1,0,7.24628,0.360618 +-6.78702,0.960694,0.83124,1,3,0,7.35343,0.216221 +-7.04316,0.968417,0.83124,2,3,0,7.1048,0.163032 +-7.13107,0.891141,0.83124,2,3,0,8.64503,0.36837 +-7.17285,1,0.83124,2,7,0,7.17311,0.148031 +-7.08326,0.985531,0.83124,2,3,0,7.45992,0.158 +-6.94166,1,0.83124,1,1,0,7.06592,0.178066 +-7.01249,0.928967,0.83124,1,3,0,7.66115,0.347309 +-7.04724,0.848178,0.83124,2,7,0,7.96848,0.162499 +-6.76062,0.979628,0.83124,1,3,0,7.25952,0.270185 +-6.7605,0.995253,0.83124,1,3,0,6.79978,0.230606 +-6.85203,0.985753,0.83124,1,3,0,6.86283,0.196071 +-6.75015,1,0.83124,2,3,0,6.83247,0.258223 +-6.82857,0.977493,0.83124,1,3,0,6.89113,0.202199 +-6.77998,1,0.83124,1,1,0,6.81968,0.219319 +-6.96696,0.973228,0.83124,1,3,0,6.98763,0.173935 +-6.97047,0.999285,0.83124,2,7,0,6.97664,0.33883 +-6.75603,0.984747,0.83124,1,3,0,7.0746,0.234404 +-7.09603,0.966221,0.83124,2,3,0,7.11519,0.362504 +-6.93133,0.618286,0.83124,3,7,0,9.46164,0.33024 +-6.85305,0.950931,0.83124,2,3,0,7.36418,0.195824 +-6.83247,1,0.83124,1,1,0,6.85938,0.201118 +-6.75124,1,0.83124,2,3,0,6.82916,0.240062 +-6.77024,0.946217,0.83124,2,3,0,7.19198,0.276946 +-7.95778,0.665628,0.83124,1,3,0,9.21451,0.0951035 +-8.07206,0.980713,0.83124,2,7,0,8.09834,0.478622 +-7.22031,1,0.83124,2,3,0,7.86168,0.382283 +-7.0186,1,0.83124,1,1,0,7.19746,0.34849 +-6.74803,1,0.83124,2,3,0,7.00358,0.250403 +-6.75627,0.962266,0.83124,2,3,0,7.03973,0.266281 +-7.11069,0.946682,0.83124,2,3,0,7.22869,0.364991 +-6.88617,1,0.83124,1,1,0,7.05917,0.319193 +-6.97035,0.979993,0.83124,1,1,0,6.98544,0.338805 +-6.86667,1,0.83124,2,3,0,6.95447,0.31391 +-6.86376,0.945028,0.83124,2,7,0,7.24053,0.193301 +-6.94577,0.957185,0.83124,2,3,0,7.39636,0.333499 +-7.34218,0.770921,0.83124,1,3,0,8.53308,0.132548 +-7.09224,1,0.83124,1,1,0,7.31269,0.156927 +-7.34785,0.875454,0.83124,1,3,0,8.58804,0.400206 +-7.34785,0.862311,0.83124,1,1,0,7.81582,0.400206 +-7.30385,0.769611,0.83124,1,3,0,9.27718,0.135751 +-7.42651,0.859869,0.83124,1,3,0,9.21224,0.41038 +-7.06748,1,0.83124,1,1,0,7.35632,0.357521 +-7.06748,0.807273,0.83124,1,1,0,7.68027,0.357521 +-7.76394,0.835162,0.83124,1,1,0,7.76777,0.448746 +-7.99916,0.938322,0.83124,1,1,0,8.209,0.471897 +-6.77872,1,0.83124,2,3,0,7.85984,0.21991 +-6.78562,0.998717,0.83124,1,1,0,6.78966,0.21681 +-6.77028,0.991468,0.83124,1,3,0,6.86769,0.276972 +-6.785,0.984903,0.83124,2,7,0,6.87204,0.217078 +-6.77969,1,0.83124,2,3,0,6.78861,0.219455 +-6.75449,0.996474,0.83124,1,3,0,6.81765,0.264395 +-6.95531,0.940138,0.83124,1,3,0,7.13377,0.175799 +-6.80022,0.972447,0.83124,1,3,0,7.243,0.29176 +-6.79534,1,0.83124,1,1,0,6.80816,0.289701 +-6.82896,0.99747,0.83124,2,3,0,6.83287,0.302387 +-6.83834,0.958323,0.83124,1,3,0,7.10873,0.199539 +-7.74959,0.937426,0.83124,2,3,0,7.76225,0.447253 +-7.16155,1,0.83124,1,1,0,7.61679,0.373275 +-7.06736,0.783818,0.83124,2,3,0,8.86614,0.159946 +-7.95082,0.821786,0.83124,1,3,0,9.47994,0.467328 +-6.7621,1,0.83124,2,7,0,7.88542,0.271359 +-6.74867,0.963377,0.83124,2,3,0,7.03305,0.245517 +-7.61253,0.798665,0.83124,1,3,0,8.16834,0.113475 +-8.13793,0.948335,0.83124,1,1,0,8.1434,0.0872762 +-8.12909,0.899391,0.83124,2,3,0,10.4073,0.0876381 +-8.29851,0.986636,0.83124,2,7,0,8.32014,0.49839 +-7.65135,1,0.83124,2,7,0,8.47551,0.111133 +-6.74805,0.968712,0.83124,2,7,0,8.08015,0.251015 +-7.35872,0.924625,0.83124,2,3,0,7.47891,0.401648 +-6.90838,0.740972,0.83124,3,7,0,8.80384,0.324807 +-7.1062,0.952787,0.83124,1,1,0,7.11379,0.364234 +-7.04657,0.838625,0.83124,1,3,0,8.14052,0.162587 +-6.95071,0.932467,0.83124,1,3,0,7.76085,0.334588 +-6.75722,0.999342,0.83124,1,3,0,6.93446,0.267202 +-7.33157,0.893368,0.83124,1,3,0,7.43378,0.398024 +-6.75394,0.994608,0.83124,2,3,0,7.3846,0.263755 +-6.75254,0.780504,0.83124,2,3,0,8.5811,0.238239 +-7.5464,0.826699,0.83124,1,3,0,7.98409,0.117665 +-6.88542,0.989494,0.83124,2,7,0,7.45093,0.318996 +-6.97985,0.947323,0.83124,2,3,0,7.32585,0.340783 +-7.47906,0.817247,0.83124,2,3,0,8.36651,0.416872 +-6.79989,1,0.83124,2,3,0,7.35448,0.211252 +-6.81061,0.979865,0.83124,1,3,0,6.97954,0.29586 +-7.09211,0.878605,0.83124,1,3,0,7.60631,0.156942 +-7.13247,0.994264,0.83124,1,1,0,7.1759,0.152332 +-9.21876,0.78164,0.83124,1,3,0,9.90391,0.0548146 +-9.29925,0.995532,0.83124,1,1,0,9.51404,0.053069 +-8.67842,1,0.83124,1,1,0,9.29343,0.0685871 +-6.99979,0.961642,0.83124,2,7,0,8.47008,0.344817 +-6.75547,1,0.83124,2,3,0,6.95919,0.234958 +-7.35044,0.877021,0.83124,1,3,0,7.62815,0.400551 +-7.35044,0.811523,0.83124,1,1,0,7.96359,0.400551 +-6.76757,1,0.83124,2,3,0,7.2615,0.225845 +-6.98987,0.962784,0.83124,1,3,0,7.03308,0.170437 +-6.76835,0.976692,0.83124,2,7,0,7.20115,0.275752 +-7.73534,0.722431,0.83124,1,3,0,8.72967,0.106333 +-6.78963,0.972833,0.83124,1,3,0,7.93075,0.215147 +-7.47849,0.882089,0.83124,1,3,0,7.69716,0.122258 +-9.97026,0.821727,0.83124,3,7,0,10.0986,0.0408291 +-10.0175,0.987818,0.83124,3,7,0,10.0487,0.0400998 +-12.7499,0.937823,0.83124,2,3,0,13.1189,0.0149227 +-7.94543,1,0.83124,2,3,0,12.4102,0.095678 +-7.63894,0.983286,0.83124,2,3,0,8.46491,0.111873 +-7.85792,0.96497,0.83124,2,3,0,8.43244,0.0999041 +-7.1518,0.871984,0.83124,1,3,0,9.88087,0.371725 +-6.74968,1,0.83124,2,3,0,7.11397,0.242839 +-6.75396,0.998179,0.83124,2,3,0,6.7648,0.263781 +-7.4993,0.796919,0.83124,1,3,0,8.12961,0.120816 +-7.75778,0.971947,0.83124,1,1,0,7.7925,0.105107 +-7.42799,1,0.83124,1,1,0,7.7378,0.12589 +-7.45318,0.977534,0.83124,2,3,0,7.96662,0.124054 +-6.83835,0.940137,0.83124,1,3,0,8.24865,0.305458 +-6.82157,0.766904,0.83124,2,3,0,8.58042,0.20422 +-6.81426,1,0.83124,1,1,0,6.83048,0.206444 +-6.75251,0.991602,0.83124,2,3,0,6.89959,0.261959 +-6.75888,0.996402,0.83124,1,3,0,6.7795,0.231887 +-6.78754,0.953952,0.83124,2,3,0,7.15557,0.28619 +-6.74802,0.999015,0.83124,1,3,0,6.79472,0.250144 +-6.76389,0.996244,0.83124,1,3,0,6.77126,0.228186 +-6.77363,0.993116,0.83124,1,3,0,6.83196,0.278972 +-7.17418,0.869724,0.83124,1,3,0,7.63572,0.147894 +-6.82074,0.940134,0.83124,2,3,0,7.88732,0.204466 +-6.79954,1,0.83124,1,1,0,6.82144,0.211377 +-6.84283,0.979552,0.83124,1,3,0,7.03936,0.306868 +-6.92713,0.922063,0.83124,2,7,0,7.33785,0.180587 +-6.76995,0.982303,0.83124,1,3,0,7.10509,0.276763 +-6.76995,0.771125,0.83124,2,7,0,8.24394,0.276763 +-6.88071,0.957005,0.83124,2,7,0,7.05959,0.189569 +-6.77031,0.999645,0.83124,2,7,0,6.86103,0.276991 +-7.28721,0.931056,0.83124,2,7,0,7.28806,0.13719 +-7.77884,0.942976,0.83124,1,1,0,7.77886,0.103978 +-8.47531,0.937876,0.83124,1,1,0,8.47596,0.0749059 +-6.84292,1,0.83124,2,3,0,8.26846,0.198349 +-6.75017,1,0.83124,2,3,0,6.82502,0.258255 +-6.96592,0.957215,0.83124,1,3,0,7.01598,0.337869 +-7.47073,0.960169,0.83124,2,3,0,7.47185,0.415858 +-7.52326,0.986161,0.83124,1,1,0,7.69125,0.422162 +-7.4362,0.721172,0.83124,1,3,0,9.97273,0.125285 +-7.18987,1,0.83124,1,1,0,7.41609,0.1463 +-6.94911,1,0.83124,1,1,0,7.15352,0.176816 +-6.84972,1,0.83124,2,3,0,6.93365,0.196638 +-6.75885,0.999353,0.83124,2,3,0,6.85668,0.231914 +-7.83083,0.763248,0.83124,3,7,0,8.86514,0.101271 +-6.84999,1,0.83124,2,3,0,7.75737,0.196572 +-7.5117,0.958354,0.83124,2,3,0,7.51226,0.420792 +-6.85261,0.910999,0.83124,1,3,0,8.15977,0.19593 +-6.88227,0.994982,0.83124,1,1,0,6.89327,0.18924 +-7.0631,0.926215,0.83124,1,3,0,7.61414,0.35674 +-6.80819,0.976188,0.83124,2,3,0,7.25217,0.294935 +-6.82499,0.966276,0.83124,2,7,0,7.03734,0.203218 +-6.8568,0.998159,0.83124,2,3,0,6.86317,0.194925 +-6.79677,0.980863,0.83124,1,3,0,7.05911,0.290314 +-6.84877,0.958249,0.83124,2,7,0,7.06491,0.196874 +-6.81614,1,0.83124,1,1,0,6.84798,0.205858 +-7.39174,0.936097,0.83124,2,3,0,7.47236,0.128623 +-6.7763,0.982848,0.83124,1,3,0,7.48359,0.221085 +-6.782,0.988793,0.83124,1,3,0,6.87443,0.28349 +-7.04337,0.903209,0.83124,1,3,0,7.41439,0.163003 +-7.06217,0.997224,0.83124,1,1,0,7.10535,0.160594 +-7.45079,0.866041,0.83124,1,3,0,8.68702,0.413408 +-7.72485,0.92952,0.83124,1,1,0,7.846,0.444654 +-6.75454,1,0.83124,2,3,0,7.65792,0.235912 +-7.33767,0.877162,0.83124,1,3,0,7.61019,0.132917 +-7.71528,0.956598,0.83124,1,1,0,7.72184,0.107448 +-7.51636,1,0.83124,1,1,0,7.74268,0.119657 +-6.74804,1,0.83124,2,3,0,7.38144,0.249241 +-6.79922,0.993505,0.83124,2,3,0,6.8024,0.211491 +-7.25447,0.930246,0.83124,1,3,0,7.34668,0.140117 +-7.30335,0.873825,0.83124,1,3,0,8.87988,0.394174 +-8.18192,0.791258,0.83124,1,1,0,8.20746,0.488413 +-9.4614,0.707113,0.83124,1,1,0,9.62793,0.58121 +-7.50685,1,0.83124,2,3,0,8.94062,0.420216 +-7.80349,0.923636,0.83124,1,1,0,7.93533,0.452811 +-7.06735,0.850334,0.83124,2,3,0,9.29779,0.159947 +-6.7585,0.992047,0.83124,1,3,0,7.10465,0.232203 +-7.43229,0.931952,0.83124,2,3,0,7.49373,0.411106 +-6.9972,1,0.83124,2,7,0,7.38847,0.169362 +-7.37383,0.966663,0.83124,2,7,0,7.42046,0.403632 +-6.95584,1,0.83124,1,1,0,7.27155,0.335708 +-6.9089,0.914492,0.83124,1,3,0,7.51473,0.183929 +-7.19728,0.973224,0.83124,2,7,0,7.22332,0.378818 +-7.18664,1,0.83124,2,7,0,7.19708,0.146625 +-6.82274,0.997532,0.83124,2,7,0,7.12798,0.300262 +-6.77496,1,0.83124,1,1,0,6.81222,0.279732 +-7.02746,0.911517,0.83124,1,3,0,7.35767,0.165119 +-7.03272,0.999211,0.83124,1,1,0,7.07802,0.164411 +-6.96591,0.930577,0.83124,1,3,0,7.76388,0.337868 +-7.44388,0.962192,0.83124,2,3,0,7.44556,0.412551 +-7.44388,0.584066,0.83124,1,1,0,8.90281,0.412551 +-6.77241,0.961055,0.83124,1,3,0,7.73354,0.223092 +-7.62061,0.921655,0.83124,2,3,0,7.68079,0.433335 +-7.09883,1,0.83124,1,1,0,7.50084,0.362983 +-7.00947,0.855858,0.83124,1,3,0,8.02898,0.167604 +-6.75096,0.993351,0.83124,1,3,0,7.05949,0.240498 +-8.32625,0.646282,0.83124,1,3,0,9.49443,0.0800494 +-8.40732,0.938118,0.83124,3,7,0,9.6866,0.0771942 +-6.9833,0.968064,0.83124,2,7,0,8.22593,0.341493 +-6.93729,1,0.83124,2,3,0,7.00523,0.3316 +-7.12342,0.985051,0.83124,2,3,0,7.1369,0.367112 +-6.86814,1,0.83124,1,1,0,7.06227,0.314323 +-7.07136,0.952222,0.83124,1,1,0,7.07345,0.35821 +-7.02361,0.860951,0.83124,2,7,0,8.01757,0.165643 +-7.31835,0.958896,0.83124,1,1,0,7.31841,0.134522 +-7.26371,1,0.83124,1,1,0,7.37285,0.139277 +-8.31056,0.921219,0.83124,2,7,0,8.37609,0.499399 +-8.09228,1,0.83124,2,7,0,8.2179,0.0891676 +-7.76792,1,0.83124,1,1,0,8.10286,0.104561 +-6.8205,0.971419,0.83124,1,3,0,7.90692,0.204536 +-6.86053,0.967509,0.83124,2,7,0,7.11817,0.312165 +-6.86053,0.839294,0.83124,1,3,0,7.7602,0.312165 +-7.07867,0.948921,0.83124,1,1,0,7.07961,0.359498 +-7.00135,0.859115,0.83124,2,7,0,7.97205,0.168761 +-7.10981,0.984021,0.83124,1,1,0,7.12497,0.154879 +-7.10981,0.799781,0.83124,1,3,0,9.27125,0.154879 +-7.20755,0.890858,0.83124,1,3,0,8.38441,0.380374 +-8.05737,0.798946,0.83124,1,1,0,8.07069,0.477283 +-6.78149,1,0.83124,2,3,0,7.91138,0.218625 +-7.00867,0.937334,0.83124,1,3,0,7.26203,0.346567 +-7.13676,0.96848,0.83124,1,1,0,7.17248,0.3693 +-7.56545,0.773819,0.83124,2,3,0,8.84473,0.427081 +-7.01862,1,0.83124,1,1,0,7.4298,0.348493 +-6.78407,1,0.83124,2,7,0,6.97067,0.217481 +-7.77478,0.882325,0.83124,2,3,0,7.81349,0.104194 +-6.74839,1,0.83124,2,3,0,7.59559,0.246611 +-6.74839,0.726857,0.83124,1,3,0,8.54148,0.246611 +-6.80284,0.986991,0.83124,1,3,0,6.83049,0.292828 +-6.79592,0.977392,0.83124,2,7,0,6.96043,0.212703 +-7.78115,0.828678,0.83124,1,3,0,8.16462,0.103855 +-6.87998,0.971912,0.83124,1,3,0,7.83885,0.189723 +-7.01664,0.976632,0.83124,2,3,0,7.16303,0.166601 +-6.94752,1,0.83124,1,1,0,7.02198,0.177081 +-6.94102,1,0.83124,1,1,0,6.97806,0.178174 +-6.77464,0.976443,0.83124,2,7,0,7.14348,0.279555 +-7.35069,0.816251,0.83124,1,3,0,7.98794,0.131858 +-7.05067,0.989381,0.83124,2,3,0,7.56562,0.162057 +-7.18936,0.98036,0.83124,1,1,0,7.20466,0.146351 +-7.32049,0.99428,0.83124,2,3,0,7.35251,0.134341 +-6.85082,0.939647,0.83124,1,3,0,8.04245,0.309312 +-6.86251,0.999855,0.83124,2,7,0,6.86251,0.193588 +-6.82918,0.975519,0.83124,1,3,0,7.14221,0.302461 +-6.86712,0.947414,0.83124,1,3,0,7.17472,0.192537 +-6.78356,0.999382,0.83124,2,7,0,6.85802,0.284269 +-6.79441,0.997586,0.83124,1,1,0,6.79954,0.289297 +-7.74251,0.697212,0.83124,1,3,0,8.9077,0.105939 +-7.81618,0.997515,0.83124,2,3,0,7.92448,0.102022 +-8.04743,0.992718,0.83124,2,3,0,8.11458,0.0910846 +-7.47052,1,0.83124,1,1,0,7.98547,0.122818 +-6.75093,0.967506,0.83124,1,3,0,7.8585,0.25961 +-7.17786,0.892908,0.83124,2,3,0,7.49873,0.147516 +-6.83257,0.997205,0.83124,2,3,0,7.22011,0.201091 +-8.45978,0.732752,0.83124,1,3,0,9.22622,0.0754204 +-7.77472,1,0.83124,2,3,0,8.39743,0.104197 +-6.97089,0.981411,0.83124,2,7,0,7.68748,0.338918 +-6.89245,0.920504,0.83124,1,3,0,7.49844,0.187143 +-6.77637,0.999491,0.83124,2,7,0,6.8732,0.280523 +-6.80294,0.978849,0.83124,1,3,0,6.92288,0.210174 +-6.78857,0.723063,0.83124,2,3,0,9.77278,0.286669 +-7.10029,0.958158,0.83124,2,7,0,7.10567,0.155981 +-6.88194,0.950123,0.83124,1,3,0,7.71381,0.31808 +-6.82045,0.929997,0.83124,2,3,0,7.42623,0.20455 +-6.82297,0.979869,0.83124,1,3,0,7.04615,0.30034 +-7.4118,0.918783,0.83124,2,7,0,7.43508,0.408521 +-6.74848,1,0.83124,2,3,0,7.41976,0.253791 +-6.75298,0.968355,0.83124,2,3,0,6.98876,0.262583 +-6.75298,0.694815,0.83124,1,3,0,8.62863,0.262583 +-8.19757,0.624714,0.83124,1,3,0,9.53347,0.0848908 +-8.03339,1,0.83124,1,1,0,8.28745,0.0916972 +-7.92155,1,0.83124,1,1,0,8.13494,0.0968037 +-8.29745,0.966992,0.83124,1,1,0,8.33907,0.0810988 +-8.53927,0.983302,0.83124,2,7,0,8.55352,0.517816 +-10.174,0.646003,0.83124,1,1,0,10.3778,0.621676 +-12.1144,0.810818,0.83124,3,7,0,13.039,0.0186551 +-7.07292,0.964563,0.83124,3,7,0,11.0927,0.358487 +-7.87087,0.873612,0.83124,2,7,0,8.00892,0.0992609 +-6.75866,0.972023,0.83124,1,3,0,8.26993,0.232066 +-6.99244,0.94289,0.83124,1,3,0,7.15606,0.343347 +-6.82029,0.951094,0.83124,1,3,0,7.33313,0.204598 +-6.79306,1,0.83124,1,1,0,6.81796,0.213791 +-6.93839,0.979303,0.83124,2,3,0,7.00466,0.178623 +-7.01481,0.912717,0.83124,2,3,0,8.13529,0.34776 +-6.74884,0.996134,0.83124,1,3,0,7.03237,0.25508 +-8.66191,0.774419,0.83124,3,7,0,8.66326,0.0690741 +-8.07898,1,0.83124,2,3,0,8.63117,0.0897297 +-8.72682,0.948904,0.83124,1,1,0,8.73669,0.0671859 +-7.03893,0.942942,0.83124,1,3,0,8.97917,0.163586 +-6.79153,0.965131,0.83124,2,7,0,7.36216,0.288022 +-6.78617,0.993208,0.83124,2,3,0,6.86016,0.285539 +-6.8071,0.995321,0.83124,1,1,0,6.81103,0.294512 +-6.80154,0.740376,0.83124,2,3,0,8.79928,0.210664 +-6.80946,0.998572,0.83124,1,1,0,6.81728,0.207979 +-6.78481,1,0.83124,1,1,0,6.80681,0.217159 +-7.0432,0.888958,0.83124,2,3,0,7.66922,0.163026 +-7.22803,0.973996,0.83124,1,1,0,7.23597,0.142578 +-7.5135,0.964663,0.83124,1,1,0,7.52318,0.119851 +-6.75175,0.964523,0.83124,2,7,0,7.93896,0.26089 +-6.75951,0.999109,0.83124,2,7,0,6.76029,0.231382 +-6.76189,0.999539,0.83124,1,1,0,6.76351,0.229577 +-6.78564,0.997277,0.83124,2,7,0,6.78845,0.285286 +-6.79213,0.992347,0.83124,2,3,0,6.86148,0.28829 +-6.77159,0.987572,0.83124,2,7,0,6.88243,0.223538 +-6.77159,0.970605,0.83124,1,3,0,6.983,0.223538 +-6.80634,0.982915,0.83124,2,3,0,6.94091,0.294219 +-6.75946,0.990818,0.83124,1,3,0,6.87112,0.23142 +-6.78335,0.917796,0.83124,2,3,0,7.4738,0.284165 +-6.78933,0.983866,0.83124,1,3,0,6.90817,0.215271 +-6.81092,0.996076,0.83124,1,1,0,6.81384,0.207504 +-7.1809,0.929503,0.83124,2,3,0,7.61169,0.376304 +-6.80722,1,0.83124,2,3,0,7.10483,0.208718 +-7.74538,0.780327,0.83124,2,3,0,8.6578,0.105782 +-7.46218,1,0.83124,1,1,0,7.74085,0.12341 +-7.20688,1,0.83124,1,1,0,7.44136,0.144614 +-7.44059,0.97043,0.83124,1,1,0,7.45542,0.124965 +-6.82406,0.982347,0.83124,1,3,0,7.46608,0.20349 +-7.07013,0.967894,0.83124,2,3,0,7.167,0.159602 +-7.4025,0.955293,0.83124,1,1,0,7.40256,0.1278 +-7.22459,0.872027,0.83124,2,7,0,9.05636,0.382919 +-7.11268,0.790561,0.83124,2,3,0,8.92476,0.154551 +-9.17948,0.781581,0.83124,1,3,0,9.86888,0.055692 +-9.2665,0.995104,0.83124,1,1,0,9.47647,0.053771 +-9.84074,0.967571,0.83124,2,7,0,9.85361,0.6035 +-7.60363,1,0.83124,2,3,0,9.24351,0.43143 +-6.8368,0.917004,0.83124,1,3,0,8.21727,0.199948 +-7.17099,0.907058,0.83124,1,3,0,7.67115,0.37476 +-6.80781,0.94595,0.83124,1,3,0,7.54445,0.208524 +-6.83785,0.879025,0.83124,2,3,0,8.03833,0.305298 +-6.75334,0.998324,0.83124,2,3,0,6.8517,0.263036 +-7.37368,0.848036,0.83124,2,7,0,7.88407,0.130027 +-6.79509,1,0.83124,2,3,0,7.33649,0.213017 +-7.16328,0.944717,0.83124,1,3,0,7.2271,0.149025 +-7.11417,0.886172,0.83124,3,7,0,8.41438,0.154382 +-6.95416,1,0.83124,1,1,0,7.0935,0.175987 +-6.76152,0.987523,0.83124,1,3,0,7.11694,0.270902 +-6.75,0.990996,0.83124,2,3,0,6.83039,0.242187 +-6.77672,0.997279,0.83124,2,3,0,6.77682,0.280713 +-6.75763,1,0.83124,1,1,0,6.7726,0.267585 +-7.35659,0.834836,0.83124,1,3,0,7.89133,0.131383 +-6.80053,0.952879,0.83124,1,3,0,7.94338,0.291887 +-6.98303,0.915992,0.83124,1,3,0,7.35216,0.17146 +-6.89083,0.925284,0.83124,2,3,0,7.79098,0.18747 +-6.88966,0.964241,0.83124,1,3,0,7.32194,0.320103 +-7.48835,0.733642,0.83124,2,7,0,8.71588,0.121571 +-6.87631,0.982988,0.83124,1,3,0,7.47694,0.19051 +-6.97848,0.983469,0.83124,1,1,0,6.98138,0.172149 +-7.07083,0.913498,0.83124,2,3,0,8.1609,0.358117 +-6.79558,0.956979,0.83124,1,3,0,7.36528,0.212832 +-6.91837,0.955744,0.83124,1,3,0,7.15979,0.327213 +-7.02487,0.974408,0.83124,1,1,0,7.04367,0.349688 +-6.84162,1,0.83124,1,1,0,6.98194,0.306492 +-7.1903,0.839686,0.83124,1,3,0,7.9069,0.146256 +-7.2047,0.99935,0.83124,2,3,0,7.26996,0.144828 +-7.49285,0.963893,0.83124,1,1,0,7.50077,0.12126 +-7.544,0.994932,0.83124,2,7,0,7.56004,0.424596 +-6.75436,0.980075,0.83124,1,3,0,7.72538,0.236101 +-7.04678,0.970576,0.83124,2,3,0,7.06325,0.35378 +-6.99502,1,0.83124,1,1,0,7.07984,0.343865 +-6.82382,1,0.83124,1,1,0,6.95483,0.300636 +-6.78357,0.985313,0.83124,1,3,0,6.96639,0.217696 +-7.2575,0.890842,0.83124,1,3,0,7.6326,0.38772 +-7.48017,0.943393,0.83124,1,1,0,7.5609,0.417006 +-6.90613,0.887572,0.83124,1,3,0,8.30596,0.184456 +-6.90613,0.870141,0.83124,1,3,0,8.24338,0.184456 +-6.76904,0.99968,0.83124,2,7,0,6.88027,0.27619 +-6.77656,0.998354,0.83124,1,1,0,6.77931,0.280626 +-7.28609,0.909846,0.83124,2,3,0,7.54284,0.391774 +-6.75187,0.984197,0.83124,1,3,0,7.41445,0.239149 +-7.12785,0.959934,0.83124,2,3,0,7.16083,0.367842 +-6.86855,1,0.83124,2,3,0,7.06565,0.314439 +-6.99134,0.971035,0.83124,1,1,0,6.99866,0.343127 +-7.34994,0.913492,0.83124,1,1,0,7.35921,0.400485 +-7.73719,0.902339,0.83124,1,1,0,7.81694,0.445955 +-8.17357,0.888476,0.83124,1,1,0,8.34249,0.487683 +-7.54992,1,0.83124,2,3,0,8.10298,0.425286 +-7.49625,1,0.83124,2,7,0,7.52846,0.121026 +-7.16931,0.987608,0.83124,2,3,0,7.77775,0.148397 +-7.09573,1,0.83124,1,1,0,7.19356,0.156515 +-6.89368,0.937414,0.83124,2,7,0,7.73271,0.321134 +-6.8188,1,0.83124,1,1,0,6.87987,0.298871 +-6.7771,0.983079,0.83124,1,3,0,6.94098,0.220694 +-6.96757,0.945957,0.83124,1,3,0,7.18569,0.338219 +-6.90748,1,0.83124,1,1,0,6.97661,0.324586 +-7.43703,0.745713,0.83124,1,3,0,8.65086,0.125224 +-6.76291,0.999948,0.83124,2,7,0,7.3071,0.271971 +-6.76164,0.994302,0.83124,1,3,0,6.80668,0.229761 +-6.7553,1,0.83124,2,3,0,6.76067,0.23513 +-6.77564,0.98544,0.83124,2,3,0,6.87926,0.280113 +-7.89026,0.668715,0.83124,1,3,0,9.11055,0.0983094 +-8.40043,0.95557,0.83124,1,1,0,8.41848,0.0774314 +-6.92864,0.951996,0.83124,1,3,0,8.64117,0.18032 +-6.80745,0.967917,0.83124,2,7,0,7.21467,0.294648 +-6.8125,0.970932,0.83124,1,3,0,7.00755,0.207001 +-7.27803,0.932836,0.83124,1,3,0,7.3605,0.137998 +-7.11244,0.872885,0.83124,3,7,0,8.59103,0.365284 +-6.77647,0.984971,0.83124,2,3,0,7.22712,0.280577 +-6.76764,0.990981,0.83124,1,3,0,6.84549,0.225801 +-6.98546,0.963687,0.83124,1,3,0,7.027,0.171095 +-6.75248,0.986453,0.83124,1,3,0,7.11882,0.261928 +-7.00721,0.96671,0.83124,2,3,0,7.00821,0.167924 +-6.77372,0.999672,0.83124,2,3,0,7.0112,0.222402 +-6.76803,0.971778,0.83124,2,3,0,7.00664,0.225565 +-7.27656,0.905319,0.83124,1,3,0,7.44861,0.138128 +-7.32837,0.887249,0.83124,1,3,0,8.97474,0.397592 +-6.97834,1,0.83124,1,1,0,7.24831,0.340471 +-6.85367,0.999899,0.83124,2,7,0,6.97919,0.195674 +-8.5941,0.701615,0.83124,2,3,0,9.62207,0.0711213 +-9.26932,0.956878,0.83124,1,1,0,9.29205,0.0537101 +-13.9248,0.83665,0.83124,2,3,0,13.9651,0.00993544 +-14.2366,0.996822,0.83124,1,1,0,14.4764,0.00892753 +-10.0466,1,0.83124,2,3,0,14.2137,0.0396581 +-10.0406,1,0.83124,1,1,0,10.3327,0.0397483 +-9.35124,1,0.83124,1,1,0,10.0503,0.0519773 +-10.0943,0.988232,0.83124,2,3,0,10.1286,0.038945 +-10.9778,0.968473,0.83124,1,1,0,11.0065,0.0280451 +-7.34479,1,0.83124,2,3,0,10.6346,0.132336 +-6.75637,0.968725,0.83124,1,3,0,7.7084,0.266382 +-7.4561,0.870982,0.83124,1,3,0,7.58688,0.414063 +-7.2022,1,0.83124,1,1,0,7.45269,0.379565 +-6.75588,0.998092,0.83124,1,3,0,7.1857,0.265886 +-6.75908,0.999318,0.83124,1,1,0,6.76,0.26889 +-6.89345,0.954925,0.83124,1,3,0,7.04542,0.186942 +-6.92397,0.948177,0.83124,1,3,0,7.39337,0.328533 +-6.88537,0.928021,0.83124,1,3,0,7.39835,0.188592 +-6.7886,0.999261,0.83124,2,7,0,6.87479,0.286684 +-6.8666,0.955599,0.83124,1,3,0,7.08277,0.192655 +-6.85166,0.964934,0.83124,1,3,0,7.19693,0.309565 +-6.95173,0.976564,0.83124,1,1,0,6.95832,0.334811 +-7.36767,0.967028,0.83124,2,3,0,7.36991,0.402826 +-7.53083,0.985944,0.83124,2,3,0,7.64959,0.423054 +-7.45387,1,0.83124,1,1,0,7.66871,0.413788 +-7.02225,1,0.83124,1,1,0,7.35336,0.34919 +-7.03738,0.996255,0.83124,1,1,0,7.09801,0.352041 +-7.75081,0.832258,0.83124,1,1,0,7.75217,0.44738 +-7.0847,1,0.83124,1,1,0,7.58462,0.36055 +-7.36635,0.930396,0.83124,1,1,0,7.39907,0.402653 +-7.30022,0.705985,0.83124,1,3,0,9.30071,0.136062 +-7.45316,0.969196,0.83124,2,3,0,7.87841,0.124055 +-7.46965,0.998056,0.83124,1,1,0,7.5672,0.122879 +-7.31408,1,0.83124,1,1,0,7.49037,0.134881 +-9.69549,0.86634,0.83124,2,7,0,9.69854,0.59518 +-11.3431,0.659407,0.83124,1,1,0,11.7996,0.677081 +-7.25606,1,0.83124,2,7,0,10.3442,0.387512 +-6.81282,0.939796,0.83124,1,3,0,7.67612,0.206899 +-6.81282,0.897486,0.83124,1,3,0,7.52703,0.206899 +-6.79345,0.683157,0.83124,2,3,0,10.3368,0.288875 +-6.90385,0.943246,0.83124,1,3,0,7.17124,0.184894 +-7.34743,0.959342,0.83124,2,7,0,7.35928,0.40015 +-6.99915,1,0.83124,1,1,0,7.2705,0.344689 +-8.45138,0.785349,0.83124,2,7,0,8.58478,0.0757005 +-9.71208,0.934067,0.83124,2,3,0,10.2656,0.0450978 +-6.80914,0.985533,0.83124,3,7,0,9.15788,0.295302 +-6.79341,0.792474,0.83124,2,3,0,8.37029,0.213657 +-6.75271,0.995332,0.83124,1,3,0,6.83329,0.262233 +-6.90784,0.970518,0.83124,1,3,0,6.93453,0.324675 +-7.12855,0.947402,0.83124,1,1,0,7.13449,0.367957 +-7.33571,0.758451,0.83124,1,3,0,8.93561,0.133078 +-7.43423,0.987969,0.83124,1,1,0,7.49126,0.12543 +-6.75288,0.965312,0.83124,2,7,0,7.8226,0.262459 +-7.15439,0.923116,0.83124,1,3,0,7.2363,0.372139 +-7.22444,0.758874,0.83124,1,3,0,8.69823,0.142919 +-7.36705,0.993916,0.83124,2,3,0,7.40034,0.13055 +-7.55388,0.859677,0.83124,2,3,0,9.81129,0.425745 +-8.17005,0.846915,0.83124,1,1,0,8.26941,0.487374 +-7.40868,1,0.83124,1,1,0,8.01893,0.408124 +-7.10702,1,0.83124,1,1,0,7.36627,0.364373 +-6.82314,0.970014,0.83124,2,3,0,7.34594,0.300399 +-6.93401,0.974417,0.83124,1,1,0,6.93572,0.330855 +-7.01947,0.979356,0.83124,1,1,0,7.0448,0.348656 +-6.87749,0.999868,0.83124,2,7,0,7.02398,0.190256 +-6.86677,0.960811,0.83124,1,3,0,7.24932,0.313938 +-6.76204,0.995345,0.83124,2,3,0,6.90455,0.271308 +-8.44141,0.570044,0.83124,1,3,0,10.1997,0.0760353 +-7.16128,0.999952,0.83124,2,3,0,8.4761,0.149235 +-6.76895,0.98964,0.83124,1,3,0,7.19817,0.225027 +-7.62677,0.792418,0.83124,2,3,0,8.40538,0.112606 +-8.66946,0.922448,0.83124,2,7,0,8.87914,0.527738 +-6.79039,0.946193,0.83124,2,7,0,9.22648,0.214843 +-6.82196,0.894113,0.83124,2,3,0,7.8172,0.299987 +-6.77883,0.971119,0.83124,2,3,0,7.06215,0.219861 +-7.59494,0.835256,0.83124,1,3,0,8.07914,0.430449 +-7.07867,0.876524,0.83124,2,3,0,8.65391,0.359498 +-7.05615,1,0.83124,1,1,0,7.14038,0.355488 +-6.74917,0.991113,0.83124,1,3,0,7.1252,0.24403 +-7.21295,0.940256,0.83124,2,3,0,7.22647,0.144023 +-7.76346,0.830358,0.83124,2,3,0,9.25552,0.104801 +-7.31789,1,0.83124,1,1,0,7.71239,0.13456 +-6.81238,0.986233,0.83124,1,3,0,7.32787,0.207037 +-6.95591,0.985919,0.83124,2,7,0,6.96476,0.335723 +-6.83467,1,0.83124,1,1,0,6.92981,0.304271 +-6.75378,0.991915,0.83124,1,3,0,6.89004,0.236752 +-6.77103,0.988181,0.83124,2,3,0,6.8529,0.277428 +-7.06634,0.906759,0.83124,2,7,0,7.41652,0.160073 +-6.94269,1,0.83124,1,1,0,7.05382,0.177892 +-6.97994,0.994153,0.83124,1,1,0,7.00279,0.171927 +-7.56881,0.937966,0.83124,2,3,0,7.75966,0.116215 +-8.10987,0.945818,0.83124,1,1,0,8.11305,0.0884317 +-7.95695,1,0.83124,1,1,0,8.19751,0.0951421 +-6.8685,0.965638,0.83124,1,3,0,8.09171,0.192228 +-6.76029,0.988392,0.83124,1,3,0,6.97736,0.269915 +-6.74891,0.911224,0.83124,2,3,0,7.43307,0.244756 +-7.42023,0.912902,0.83124,2,3,0,7.43121,0.126465 +-7.34223,0.999701,0.83124,2,7,0,7.4227,0.399457 +-6.75652,0.992019,0.83124,2,3,0,7.41195,0.266528 +-6.76283,0.994113,0.83124,2,7,0,6.7964,0.228913 +-6.80605,0.983335,0.83124,1,3,0,6.88718,0.294104 +-6.97427,0.917773,0.83124,1,3,0,7.34947,0.172796 +-6.78479,0.97611,0.83124,1,3,0,7.23119,0.284872 +-6.7651,1,0.83124,1,1,0,6.78103,0.273564 +-6.74958,1,0.83124,2,3,0,6.76193,0.243075 +-7.02863,0.969077,0.83124,2,3,0,7.05541,0.3504 +-6.91736,0.953693,0.83124,2,3,0,7.44255,0.326972 +-6.918,0.618501,0.83124,2,3,0,9.85086,0.182235 +-6.84677,1,0.83124,1,1,0,6.90933,0.197372 +-6.96252,0.980836,0.83124,1,1,0,6.96279,0.174638 +# +# Elapsed Time: 0.01 seconds (Warm-up) +# 0.008 seconds (Sampling) +# 0.018 seconds (Total) +# diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv new file mode 100644 index 0000000000..5688883ef0 --- /dev/null +++ b/src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv @@ -0,0 +1,1057 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = bernoulli_model +# start_datetime = 2024-07-20 18:56:30 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 = examples/bernoulli/bernoulli.data.json +# init = 2 (Default) +# random +# seed = 3635036313 (Default) +# output +# file = bernoulli_out.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-25-gbb9ce42 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,zeta +# Adaptation terminated +# Step size = 0.932037 +# Diagonal elements of inverse mass matrix: +# 0.591014 +-7.81355,0.761218,0.932037,1,3,0,8.13669,0.102158 +-8.71049,0.894869,0.932037,1,1,0,8.72268,0.0676546 +-7.3531,0.957519,0.932037,1,3,0,8.53469,0.131664 +-7.02007,1,0.932037,1,1,0,7.29505,0.166128 +-8.49033,0.716959,0.932037,1,3,0,9.20407,0.513986 +-7.18724,1,0.932037,1,1,0,8.06459,0.377282 +-10.0621,0.636916,0.932037,2,3,0,10.0852,0.615706 +-8.11851,1,0.932037,1,1,0,9.65805,0.482811 +-6.86936,0.948809,0.932037,2,3,0,8.60097,0.192035 +-7.13756,0.935492,0.932037,2,3,0,7.43717,0.151774 +-7.09122,1,0.932037,1,1,0,7.19518,0.157048 +-6.91669,1,0.932037,1,1,0,7.06383,0.182475 +-6.76371,0.840542,0.932037,2,3,0,8.08838,0.228308 +-6.84805,0.983351,0.932037,1,3,0,6.84861,0.197051 +-8.3727,0.653843,0.932037,2,3,0,9.53079,0.504537 +-7.25928,0.806553,0.932037,1,3,0,9.43963,0.139678 +-6.95987,0.853051,0.932037,2,3,0,9.71446,0.175062 +-6.95334,1,0.932037,1,1,0,7.00708,0.17612 +-6.98417,0.993206,0.932037,1,1,0,7.02663,0.171288 +-8.9535,0.727406,0.932037,1,3,0,9.27425,0.0610911 +-7.08162,0.995936,0.932037,2,3,0,9.00617,0.158197 +-7.16691,0.98306,0.932037,1,1,0,7.22238,0.148646 +-6.8898,1,0.932037,1,1,0,7.10684,0.18768 +-7.8902,0.846547,0.932037,1,3,0,7.96857,0.0983126 +-7.24239,1,0.932037,1,1,0,7.78446,0.14123 +-7.94748,0.888836,0.932037,1,1,0,7.94857,0.0955821 +-6.83694,0.864212,0.932037,2,3,0,8.91495,0.305006 +-6.83694,0.425574,0.932037,1,3,0,9.01249,0.305006 +-6.80131,0.985852,0.932037,1,3,0,6.93894,0.210747 +-6.74824,0.978446,0.932037,2,3,0,6.95179,0.252645 +-6.74832,0.945401,0.932037,2,3,0,7.0277,0.24694 +-6.85442,0.972221,0.932037,1,3,0,6.87104,0.310384 +-6.86406,0.996818,0.932037,1,1,0,6.89618,0.313175 +-7.11238,0.918504,0.932037,1,1,0,7.12695,0.365274 +-7.11238,0.431368,0.932037,1,1,0,8.53302,0.365274 +-6.79843,1,0.932037,1,1,0,7.00834,0.291015 +-6.74804,0.996585,0.932037,2,3,0,6.81732,0.249269 +-9.50952,0.509265,0.932037,1,3,0,9.67564,0.584141 +-8.27778,1,0.932037,1,1,0,9.48419,0.496645 +-7.2527,1,0.932037,2,3,0,8.04703,0.140278 +-6.75205,0.907555,0.932037,2,3,0,8.25548,0.238895 +-7.3411,0.857468,0.932037,1,3,0,7.42326,0.399305 +-7.07094,1,0.932037,1,1,0,7.32247,0.358137 +-7.04767,0.556206,0.932037,2,3,0,9.56585,0.353943 +-6.87625,1,0.932037,2,3,0,6.9975,0.190522 +-7.12535,0.945777,0.932037,1,1,0,7.12652,0.153122 +-7.12535,0.913353,0.932037,1,1,0,7.53634,0.153122 +-6.78755,1,0.932037,2,3,0,7.04258,0.286194 +-7.7545,0.780448,0.932037,1,3,0,7.76329,0.447766 +-6.77502,0.859809,0.932037,2,3,0,8.49845,0.221729 +-7.19668,0.726665,0.932037,2,3,0,8.64609,0.145619 +-9.64819,0.775506,0.932037,2,3,0,10.0305,0.0462333 +-6.86272,0.7808,0.932037,1,3,0,10.9403,0.312792 +-6.99329,0.696273,0.932037,2,3,0,8.30815,0.343519 +-6.99329,0.700745,0.932037,1,1,0,7.63428,0.343519 +-7.11558,0.957857,0.932037,1,1,0,7.18108,0.365809 +-6.80487,1,0.932037,2,3,0,7.09376,0.209509 +-6.97334,0.955154,0.932037,2,3,0,7.16146,0.17294 +-7.2664,0.98044,0.932037,2,3,0,7.27318,0.139035 +-7.06819,1,0.932037,2,3,0,7.25815,0.159843 +-6.74803,0.991749,0.932037,1,3,0,7.05576,0.250595 +-7.05542,0.823118,0.932037,2,3,0,7.78068,0.161448 +-6.89251,1,0.932037,1,1,0,7.02757,0.18713 +-6.76584,0.932575,0.932037,2,3,0,7.49343,0.22691 +-6.75064,0.997924,0.932037,2,3,0,6.78013,0.241023 +-6.91371,0.96173,0.932037,1,3,0,6.93351,0.183027 +-6.74953,0.994131,0.932037,1,3,0,6.91533,0.256915 +-8.33302,0.635332,0.932037,1,3,0,9.05105,0.0798054 +-8.04729,1,0.932037,1,1,0,8.43889,0.0910907 +-8.42015,0.956552,0.932037,1,1,0,8.53727,0.0767553 +-7.91154,1,0.932037,1,1,0,8.4304,0.0972813 +-7.65791,1,0.932037,1,1,0,7.97836,0.110745 +-7.97869,0.955317,0.932037,1,1,0,8.06587,0.0941427 +-6.81845,1,0.932037,1,3,0,7.88771,0.205153 +-6.76575,0.914099,0.932037,2,3,0,7.34829,0.274011 +-6.74964,0.996733,0.932037,2,3,0,6.78491,0.257167 +-6.77106,0.99494,0.932037,1,3,0,6.77141,0.27745 +-6.77106,0.945747,0.932037,1,3,0,6.92649,0.27745 +-6.77106,0.856062,0.932037,1,3,0,7.35372,0.27745 +-6.88028,0.948865,0.932037,2,3,0,7.03829,0.18966 +-7.33958,0.635769,0.932037,2,3,0,9.861,0.132761 +-8.06974,0.890942,0.932037,1,1,0,8.07292,0.0901234 +-6.97186,0.998838,0.932037,1,3,0,7.91764,0.173168 +-6.76939,0.981956,0.932037,1,3,0,7.03238,0.276417 +-7.44177,0.80944,0.932037,1,3,0,7.79154,0.124879 +-8.01591,0.972061,0.932037,2,3,0,8.03736,0.0924685 +-9.92045,0.865258,0.932037,2,3,0,9.92397,0.607959 +-7.31963,1,0.932037,2,3,0,10.3209,0.134414 +-6.9789,1,0.932037,1,1,0,7.25409,0.172086 +-7.21981,0.951312,0.932037,1,1,0,7.23197,0.143362 +-7.47612,0.930523,0.932037,2,3,0,8.12075,0.122424 +-6.81131,0.990375,0.932037,2,3,0,7.55719,0.207381 +-6.80278,0.920389,0.932037,2,3,0,7.43635,0.210229 +-6.88803,0.979103,0.932037,1,1,0,6.89063,0.188041 +-7.02902,0.795987,0.932037,2,3,0,8.6993,0.164908 +-6.74805,0.993012,0.932037,1,3,0,7.01716,0.250947 +-6.93322,0.952905,0.932037,1,3,0,6.95228,0.330673 +-6.76781,0.904559,0.932037,2,3,0,7.33629,0.275396 +-6.76232,0.985564,0.932037,2,3,0,6.83656,0.271521 +-6.87137,0.974516,0.932037,1,3,0,6.87148,0.31522 +-7.21556,0.953187,0.932037,2,3,0,7.22785,0.381575 +-6.76367,0.998041,0.932037,1,3,0,7.1984,0.228336 +-6.82308,0.981349,0.932037,1,3,0,6.86896,0.30038 +-6.82308,0.352125,0.932037,1,3,0,10.8402,0.30038 +-6.99474,0.738309,0.932037,2,3,0,8.0486,0.34381 +-6.99474,0.963463,0.932037,1,1,0,7.1311,0.34381 +-6.8637,0.713515,0.932037,2,3,0,8.29356,0.313071 +-6.94178,0.974091,0.932037,1,1,0,6.96832,0.332611 +-6.80481,1,0.932037,2,3,0,6.9081,0.209531 +-6.92327,0.971351,0.932037,1,1,0,6.92425,0.181278 +-7.1233,0.957499,0.932037,1,1,0,7.13244,0.153351 +-6.76778,0.973133,0.932037,1,3,0,7.19571,0.275378 +-6.90939,0.888041,0.932037,2,3,0,7.29419,0.325052 +-7.3757,0.927908,0.932037,2,3,0,7.37586,0.129868 +-7.33194,1,0.932037,1,1,0,7.48008,0.133389 +-6.86262,0.893077,0.932037,2,3,0,9.38827,0.193563 +-6.74929,0.996117,0.932037,1,3,0,6.86347,0.256335 +-6.74964,0.943201,0.932037,2,3,0,7.03592,0.242941 +-6.9015,0.968295,0.932037,2,3,0,6.96204,0.18535 +-7.81106,0.864491,0.932037,1,3,0,7.86554,0.102287 +-8.616,0.90424,0.932037,1,1,0,8.63659,0.0704513 +-8.16761,1,0.932037,1,1,0,8.67561,0.0860773 +-6.96545,1,0.932037,1,3,0,8.01828,0.174173 +-6.75813,1,0.932037,1,3,0,6.92669,0.232517 +-6.75424,1,0.932037,1,1,0,6.75812,0.236232 +-7.76056,0.503853,0.932037,2,3,0,10.2889,0.104957 +-7.12518,1,0.932037,1,1,0,7.64631,0.153141 +-7.67249,0.905419,0.932037,1,1,0,7.67491,0.109892 +-7.63881,1,0.932037,1,1,0,7.83222,0.11188 +-7.3844,0.889767,0.932037,1,3,0,8.80917,0.405007 +-6.76719,1,0.932037,1,3,0,7.348,0.226074 +-7.47953,0.852161,0.932037,1,3,0,7.59716,0.122185 +-7.42386,1,0.932037,2,3,0,7.59422,0.126195 +-7.91668,0.975432,0.932037,2,3,0,7.94672,0.0970356 +-6.83066,1,0.932037,2,3,0,7.62924,0.302955 +-6.96269,0.956934,0.932037,1,1,0,6.97473,0.337182 +-6.74847,0.963031,0.932037,2,3,0,7.15706,0.253745 +-6.80708,0.988647,0.932037,2,3,0,6.82289,0.208765 +-6.91792,0.9732,0.932037,1,1,0,6.91947,0.18225 +-6.84983,1,0.932037,2,3,0,6.91467,0.196611 +-6.88905,0.990653,0.932037,1,1,0,6.90679,0.187834 +-7.15463,0.975663,0.932037,2,3,0,7.16,0.372177 +-6.9586,1,0.932037,1,1,0,7.13267,0.336303 +-7.56708,0.803851,0.932037,1,1,0,7.59178,0.42727 +-6.76736,1,0.932037,1,3,0,7.31987,0.275105 +-6.80123,0.959699,0.932037,2,3,0,6.95431,0.292173 +-6.80123,0.759564,0.932037,1,3,0,7.84546,0.292173 +-6.80123,0.902778,0.932037,1,3,0,7.20675,0.292173 +-6.80123,0.96482,0.932037,1,1,0,6.88076,0.292173 +-6.78299,0.988689,0.932037,2,3,0,6.88032,0.217954 +-7.1107,0.936673,0.932037,1,3,0,7.12632,0.154778 +-7.31567,0.961429,0.932037,1,1,0,7.35195,0.134747 +-7.07455,0.968694,0.932037,2,3,0,7.7776,0.159058 +-6.74831,0.993779,0.932037,1,3,0,7.05357,0.247022 +-6.84249,0.975275,0.932037,1,3,0,6.85756,0.306763 +-6.88224,0.995647,0.932037,2,3,0,6.90622,0.31816 +-8.68021,0.668585,0.932037,2,3,0,8.68611,0.0685348 +-7.80603,1,0.932037,1,1,0,8.5851,0.102548 +-7.27572,1,0.932037,1,1,0,7.73044,0.138203 +-8.91337,0.902662,0.932037,2,3,0,9.15324,0.545374 +-7.22471,0.840347,0.932037,1,3,0,9.85532,0.142893 +-7.57214,0.980256,0.932037,2,3,0,7.60142,0.116002 +-7.46188,1,0.932037,1,1,0,7.66831,0.123431 +-7.21293,1,0.932037,1,1,0,7.46083,0.144026 +-7.27196,0.911127,0.932037,1,3,0,8.06683,0.389783 +-6.99285,1,0.932037,1,1,0,7.22442,0.343431 +-7.64686,0.789204,0.932037,1,1,0,7.67915,0.436243 +-7.64686,0.588674,0.932037,1,1,0,8.70948,0.436243 +-6.76317,0.84811,0.932037,2,3,0,8.40171,0.228672 +-6.75852,0.995961,0.932037,2,3,0,6.79457,0.232184 +-6.96185,0.956175,0.932037,2,3,0,7.06538,0.174745 +-6.7597,0.95957,0.932037,2,3,0,7.23201,0.269421 +-6.95356,0.940807,0.932037,1,3,0,7.05195,0.176085 +-6.74802,0.995879,0.932037,1,3,0,6.94105,0.250316 +-6.80409,0.985416,0.932037,1,3,0,6.81492,0.209778 +-6.78431,0.93291,0.932037,2,3,0,7.30965,0.217376 +-6.85124,0.98309,0.932037,1,1,0,6.85256,0.196264 +-6.91874,0.970098,0.932037,1,3,0,7.11707,0.327302 +-6.91874,0.434093,0.932037,1,3,0,9.39656,0.327302 +-6.92998,0.940657,0.932037,2,3,0,7.25758,0.180084 +-6.7616,0.987015,0.932037,1,3,0,6.96899,0.270965 +-6.77385,0.996249,0.932037,1,1,0,6.77617,0.279101 +-7.11956,0.891801,0.932037,1,3,0,7.32561,0.153771 +-7.10361,0.938678,0.932037,1,3,0,7.72046,0.363797 +-7.10361,0.642361,0.932037,1,1,0,7.89438,0.363797 +-8.5001,0.593919,0.932037,1,1,0,8.53813,0.514754 +-7.1692,1,0.932037,2,3,0,8.39313,0.148408 +-6.99964,1,0.932037,2,3,0,7.15856,0.169008 +-6.82605,1,0.932037,1,1,0,6.95904,0.202915 +-6.80069,1,0.932037,1,1,0,6.8286,0.210965 +-6.80069,0.826864,0.932037,1,3,0,7.56839,0.210965 +-6.80069,0.712989,0.932037,1,3,0,8.08135,0.210965 +-6.79864,1,0.932037,1,1,0,6.81323,0.211702 +-7.21975,0.922333,0.932037,1,3,0,7.24006,0.143367 +-6.75061,0.978686,0.932037,1,3,0,7.23991,0.259057 +-8.50882,0.710206,0.932037,2,3,0,8.58833,0.0738116 +-6.98994,1,0.932037,1,3,0,8.37388,0.170428 +-8.68191,0.796805,0.932037,2,3,0,9.47091,0.528667 +-7.31609,1,0.932037,2,3,0,8.2644,0.395923 +-7.14381,1,0.932037,1,1,0,7.36712,0.370442 +-7.14381,0.475525,0.932037,1,1,0,8.41075,0.370442 +-7.29505,0.813437,0.932037,2,3,0,8.20133,0.136508 +-7.97276,0.895575,0.932037,1,1,0,7.97663,0.0944136 +-9.00874,0.888587,0.932037,1,1,0,9.0167,0.0597133 +-8.5484,1,0.932037,1,1,0,9.10361,0.0725465 +-7.88735,1,0.932037,1,1,0,8.51142,0.0984513 +-7.36782,1,0.932037,1,1,0,7.8262,0.130489 +-7.34887,1,0.932037,1,1,0,7.48713,0.132005 +-6.81839,0.987631,0.932037,2,3,0,7.46646,0.205169 +-6.81839,0.712592,0.932037,1,3,0,8.16085,0.205169 +-6.74807,0.998893,0.932037,1,3,0,6.81316,0.251268 +-6.87013,0.959268,0.932037,2,3,0,6.97825,0.314875 +-6.76585,1,0.932037,1,1,0,6.83725,0.274086 +-6.7566,0.994396,0.932037,2,3,0,6.80045,0.233869 +-6.7566,0.628726,0.932037,1,3,0,8.7002,0.233869 +-6.82277,0.986161,0.932037,1,3,0,6.82387,0.203864 +-7.3013,0.877627,0.932037,1,3,0,7.5333,0.393891 +-8.78447,0.79108,0.932037,2,3,0,8.87542,0.536201 +-7.50584,1,0.932037,1,1,0,8.46306,0.420094 +-7.15669,1,0.932037,1,1,0,7.48033,0.372505 +-7.43591,0.967588,0.932037,2,3,0,7.54437,0.411558 +-6.96987,0.913229,0.932037,1,3,0,7.88228,0.173478 +-6.89773,1,0.932037,1,1,0,6.97541,0.186089 +-7.36158,0.930716,0.932037,1,3,0,7.36402,0.130984 +-7.16589,1,0.932037,1,1,0,7.37174,0.148752 +-6.95869,1,0.932037,1,1,0,7.13528,0.175252 +-7.16168,0.929564,0.932037,1,3,0,7.57434,0.373296 +-8.02154,0.725795,0.932037,1,1,0,8.09574,0.473982 +-8.63423,0.930003,0.932037,2,3,0,9.03662,0.52509 +-6.93887,1,0.932037,1,1,0,8.0172,0.331956 +-6.87271,1,0.932037,1,1,0,6.94734,0.315589 +-6.77339,1,0.932037,2,3,0,6.85408,0.222571 +-6.98298,0.942095,0.932037,1,3,0,7.07789,0.341427 +-6.75868,1,0.932037,1,3,0,6.91623,0.268536 +-6.7906,0.973381,0.932037,2,3,0,6.88716,0.2876 +-7.56742,0.820209,0.932037,1,3,0,7.57193,0.427309 +-6.75108,1,0.932037,1,3,0,7.35001,0.259868 +-6.80655,0.983396,0.932037,1,3,0,6.83092,0.208942 +-6.91728,0.973208,0.932037,1,1,0,6.91879,0.182366 +-7.7691,0.915431,0.932037,2,3,0,7.98664,0.449282 +-6.765,1,0.932037,1,3,0,7.46164,0.273492 +-7.37311,0.856184,0.932037,1,3,0,7.3856,0.403538 +-7.3305,1,0.932037,1,1,0,7.55404,0.39788 +-7.3305,0.663523,0.932037,1,1,0,8.12143,0.39788 +-7.12567,0.837343,0.932037,1,3,0,8.09517,0.153086 +-7.15885,0.957841,0.932037,2,3,0,7.71194,0.149489 +-6.75049,0.994782,0.932037,1,3,0,7.12461,0.241282 +-6.81461,0.982255,0.932037,1,3,0,6.83366,0.297352 +-6.75614,0.996516,0.932037,1,3,0,6.83027,0.234298 +-6.74853,0.904663,0.932037,2,3,0,7.2911,0.246039 +-7.01677,0.911602,0.932037,2,3,0,7.26139,0.348138 +-6.92929,0.642216,0.932037,2,3,0,8.77716,0.32977 +-7.65529,0.771289,0.932037,1,1,0,7.66932,0.43717 +-7.01834,1,0.932037,1,1,0,7.46402,0.348441 +-6.74897,1,0.932037,1,3,0,6.95557,0.255474 +-9.81129,0.348606,0.932037,1,3,0,11.6845,0.0433987 +-10.4379,0.964322,0.932037,1,1,0,10.6078,0.0342236 +-12.3737,0.923455,0.932037,1,1,0,12.3737,0.0170254 +-8.6914,0.906628,0.932037,1,3,0,12.5921,0.0682079 +-7.8205,1,0.932037,1,1,0,8.59832,0.1018 +-6.76573,0.925015,0.932037,1,3,0,8.00716,0.274002 +-7.18424,0.803585,0.932037,2,3,0,7.86457,0.146867 +-6.74867,0.98391,0.932037,1,3,0,7.18696,0.254535 +-6.74867,0.809678,0.932037,1,3,0,7.5541,0.254535 +-6.78928,0.864392,0.932037,2,3,0,7.45892,0.21529 +-7.73008,0.857073,0.932037,2,3,0,7.95215,0.106623 +-6.90924,0.999548,0.932037,1,3,0,7.59486,0.183866 +-6.83204,1,0.932037,1,1,0,6.89889,0.201236 +-6.92095,0.978894,0.932037,1,1,0,6.92784,0.181697 +-6.84946,1,0.932037,1,1,0,6.91633,0.196703 +-6.87329,0.97872,0.932037,1,3,0,7.05429,0.315746 +-7.77797,0.726161,0.932037,1,1,0,7.77978,0.450197 +-7.91451,0.983052,0.932037,2,3,0,8.2695,0.463836 +-6.99541,0.905965,0.932037,1,3,0,8.38798,0.169623 +-6.76541,0.9819,0.932037,1,3,0,7.04888,0.273777 +-6.75969,1,0.932037,1,1,0,6.76622,0.269411 +-6.88511,0.980043,0.932037,2,3,0,6.89657,0.188645 +-6.77682,0.92494,0.932037,2,3,0,7.55206,0.220831 +-7.22693,0.885941,0.932037,1,3,0,7.36359,0.383265 +-7.08301,1,0.932037,2,3,0,7.27,0.360257 +-6.74807,1,0.932037,1,3,0,7.01313,0.251185 +-6.78184,0.991048,0.932037,1,3,0,6.7889,0.218469 +-7.7414,0.782413,0.932037,1,3,0,7.94246,0.446396 +-8.34868,0.79224,0.932037,1,1,0,8.64598,0.502563 +-6.96656,1,0.932037,1,1,0,7.85206,0.338006 +-8.55062,0.559382,0.932037,1,1,0,8.55696,0.518696 +-8.71259,0.939683,0.932037,1,1,0,9.36157,0.530944 +-7.02011,1,0.932037,1,1,0,8.0992,0.34878 +-7.73032,0.771978,0.932037,1,1,0,7.7681,0.445231 +-7.58699,1,0.932037,1,1,0,7.95753,0.429546 +-10.1664,0.37457,0.932037,1,1,0,10.2962,0.621272 +-9.05941,1,0.932037,2,3,0,10.4928,0.555399 +-6.95163,0.994678,0.932037,1,3,0,9.25144,0.176401 +-6.991,0.991344,0.932037,1,1,0,7.03106,0.170271 +-6.93665,1,0.932037,1,1,0,7.01246,0.178921 +-7.53693,0.951931,0.932037,2,3,0,7.60421,0.42377 +-7.35042,1,0.932037,1,1,0,7.65542,0.400548 +-6.74833,1,0.932037,1,3,0,7.21002,0.253091 +-7.30096,0.866757,0.932037,1,3,0,7.34306,0.393844 +-7.33424,0.995938,0.932037,2,3,0,7.52117,0.398384 +-7.00834,1,0.932037,1,1,0,7.27119,0.346501 +-7.00834,0.750927,0.932037,1,3,0,7.93882,0.346501 +-6.85276,0.717415,0.932037,2,3,0,8.2801,0.309891 +-6.88149,0.915088,0.932037,2,3,0,7.26489,0.189404 +-7.01531,0.954346,0.932037,2,3,0,7.30842,0.166787 +-8.49716,0.821021,0.932037,2,3,0,8.90444,0.0741898 +-7.75198,1,0.932037,2,3,0,8.42455,0.105422 +-6.78374,0.995713,0.932037,1,3,0,7.67855,0.217625 +-6.78319,0.955918,0.932037,2,3,0,7.05067,0.284087 +-6.76877,0.993356,0.932037,2,3,0,6.83116,0.225131 +-6.76604,1,0.932037,2,3,0,6.77242,0.226786 +-6.80257,0.828664,0.932037,2,3,0,7.81548,0.210302 +-6.7921,0.928548,0.932037,2,3,0,7.34502,0.214164 +-6.7921,0.869785,0.932037,1,3,0,7.3846,0.214164 +-6.78247,1,0.932037,1,1,0,6.7969,0.218184 +-6.77338,0.944315,0.932037,2,3,0,7.11056,0.278828 +-6.88767,0.984579,0.932037,2,3,0,6.89149,0.188115 +-6.87758,1,0.932037,1,1,0,6.91573,0.190237 +-6.98427,0.975828,0.932037,1,1,0,6.997,0.171274 +-8.16006,0.847199,0.932037,1,3,0,8.23533,0.0863802 +-6.92926,1,0.932037,1,3,0,8.02086,0.180209 +-6.75334,1,0.932037,1,3,0,6.89875,0.237258 +-6.76157,0.984481,0.932037,2,3,0,6.84166,0.270942 +-6.77437,0.916298,0.932037,2,3,0,7.16943,0.222065 +-6.89883,0.966797,0.932037,2,3,0,7.01941,0.185873 +-7.61554,0.929243,0.932037,2,3,0,7.77465,0.432768 +-6.74865,1,0.932037,1,3,0,7.4327,0.2456 +-7.90889,0.736401,0.932037,1,3,0,8.30046,0.0974084 +-7.36433,1,0.932037,1,1,0,7.84078,0.130766 +-6.7517,1,0.932037,2,3,0,7.32628,0.239385 +-7.47731,0.835796,0.932037,1,3,0,7.65004,0.122341 +-6.82682,1,0.932037,1,3,0,7.36972,0.202696 +-6.75257,1,0.932037,1,3,0,6.81023,0.238212 +-6.74814,0.924039,0.932037,2,3,0,7.16556,0.251902 +-6.77547,0.992637,0.932037,1,3,0,6.7818,0.221503 +-6.77883,0.96017,0.932037,2,3,0,7.01271,0.281846 +-6.83214,0.92718,0.932037,2,3,0,7.10706,0.303446 +-6.74855,0.999857,0.932037,1,3,0,6.82323,0.245948 +-6.75208,0.991977,0.932037,2,3,0,6.79074,0.261375 +-6.74875,1,0.932037,2,3,0,6.7511,0.254796 +-6.76331,0.987877,0.932037,2,3,0,6.81164,0.228577 +-7.11253,0.925924,0.932037,1,3,0,7.14728,0.154568 +-7.33832,0.934594,0.932037,2,3,0,7.89183,0.132864 +-7.40317,0.891695,0.932037,1,3,0,8.40906,0.407422 +-6.83199,1,0.932037,2,3,0,7.43757,0.20125 +-6.83199,0.774019,0.932037,1,3,0,8.04658,0.20125 +-6.99888,0.961352,0.932037,1,1,0,7.00012,0.169119 +-6.76802,0.991205,0.932037,2,3,0,7.06627,0.225576 +-7.1899,0.912501,0.932037,1,3,0,7.23327,0.146297 +-7.0344,0.951025,0.932037,1,3,0,7.71962,0.351486 +-6.74861,0.964191,0.932037,2,3,0,7.23266,0.245744 +-6.9356,0.954146,0.932037,1,3,0,6.96807,0.179103 +-6.8766,1,0.932037,1,1,0,6.94182,0.190446 +-6.86303,0.963467,0.932037,2,3,0,7.17361,0.312881 +-6.89691,0.996253,0.932037,2,3,0,6.92839,0.321957 +-6.74898,0.989445,0.932037,2,3,0,6.95643,0.244562 +-6.75192,0.906807,0.932037,2,3,0,7.25324,0.239077 +-6.89356,0.962004,0.932037,1,3,0,6.92873,0.321106 +-6.8915,1,0.932037,1,1,0,6.93856,0.320577 +-8.04782,0.661095,0.932037,1,1,0,8.04944,0.476407 +-6.96778,1,0.932037,2,3,0,8.10818,0.173806 +-6.94531,0.967319,0.932037,1,3,0,7.30665,0.333397 +-6.79303,1,0.932037,1,1,0,6.89785,0.28869 +-6.75073,0.998473,0.932037,1,3,0,6.79703,0.240873 +-6.74807,0.922346,0.932037,2,3,0,7.17097,0.248807 +-6.79664,0.986959,0.932037,2,3,0,6.82676,0.290259 +-7.42084,0.890966,0.932037,2,3,0,7.44601,0.12642 +-7.07938,1,0.932037,1,1,0,7.36895,0.158469 +-6.76996,0.975074,0.932037,1,3,0,7.1524,0.27677 +-6.97097,0.781354,0.932037,2,3,0,7.8694,0.173307 +-7.45672,0.874497,0.932037,1,3,0,7.94747,0.41414 +-7.73982,0.898709,0.932037,1,1,0,7.95818,0.446231 +-6.75761,1,0.932037,1,3,0,7.45331,0.267571 +-6.75128,1,0.932037,2,3,0,6.75597,0.26018 +-6.74857,0.969275,0.932037,2,3,0,6.90378,0.245862 +-6.78162,0.964009,0.932037,2,3,0,6.94604,0.218566 +-6.94452,0.969782,0.932037,1,3,0,6.94577,0.177582 +-6.83464,1,0.932037,1,1,0,6.92359,0.200526 +-6.85125,0.978801,0.932037,2,3,0,7.03988,0.196263 +-8.70862,0.498506,0.932037,2,3,0,10.892,0.0677086 +-7.14422,0.988771,0.932037,1,3,0,8.54862,0.151051 +-8.22719,0.86569,0.932037,1,3,0,8.25029,0.083741 +-7.98302,1,0.932037,1,1,0,8.34174,0.0939456 +-7.66766,1,0.932037,1,1,0,8.02784,0.110173 +-8.24143,0.924458,0.932037,1,1,0,8.28161,0.0831957 +-7.67998,1,0.932037,1,1,0,8.20801,0.109457 +-7.87681,0.972029,0.932037,1,1,0,7.99803,0.0989677 +-6.74849,0.941373,0.932037,1,3,0,7.96721,0.253832 +-7.11836,0.837369,0.932037,2,3,0,7.62397,0.366273 +-6.79142,1,0.932037,2,3,0,7.01021,0.287974 +-6.77524,1,0.932037,1,1,0,6.79217,0.279893 +-6.79636,0.997801,0.932037,2,3,0,6.8016,0.290137 +-6.79636,0.948581,0.932037,1,1,0,6.90729,0.290137 +-6.87559,0.872276,0.932037,2,3,0,7.36427,0.316373 +-7.91757,0.674512,0.932037,1,3,0,8.87065,0.0969933 +-6.74935,0.935438,0.932037,1,3,0,8.03013,0.256485 +-6.74803,0.97594,0.932037,2,3,0,6.86976,0.250537 +-6.81513,0.982667,0.932037,1,3,0,6.82306,0.297542 +-7.49872,0.879887,0.932037,2,3,0,7.51782,0.120857 +-7.49872,0.948913,0.932037,1,1,0,7.85236,0.120857 +-8.04293,0.922216,0.932037,1,1,0,8.07282,0.0912801 +-7.35293,1,0.932037,2,3,0,7.93996,0.131677 +-7.35293,0.883408,0.932037,1,1,0,8.02395,0.131677 +-6.80493,1,0.932037,1,3,0,7.25923,0.209492 +-6.82698,0.998151,0.932037,2,3,0,6.83752,0.202651 +-6.88114,0.986899,0.932037,1,1,0,6.89144,0.189478 +-6.74827,0.964042,0.932037,2,3,0,7.17919,0.25277 +-6.93633,0.882605,0.932037,2,3,0,7.40536,0.178978 +-8.02922,0.766313,0.932037,1,3,0,8.54794,0.474694 +-6.88064,1,0.932037,1,1,0,7.62039,0.317732 +-6.99856,0.960668,0.932037,1,1,0,7.02674,0.344573 +-6.9205,1,0.932037,1,1,0,7.0171,0.327717 +-7.23497,0.895629,0.932037,1,1,0,7.26191,0.384449 +-6.81255,0.65863,0.932037,2,3,0,8.81442,0.296589 +-6.8557,0.986062,0.932037,1,1,0,6.86976,0.310763 +-6.8557,0.724177,0.932037,1,3,0,7.66358,0.310763 +-6.75301,0.997497,0.932037,1,3,0,6.85969,0.23766 +-9.62741,0.500859,0.932037,1,3,0,9.855,0.591191 +-7.2064,1,0.932037,2,3,0,8.74926,0.3802 +-6.75431,0.815869,0.932037,2,3,0,7.99167,0.264191 +-6.77251,0.990864,0.932037,2,3,0,6.80395,0.22304 +-7.81008,0.844756,0.932037,2,3,0,8.00316,0.102338 +-8.11847,0.959711,0.932037,1,1,0,8.22643,0.0880753 +-9.24757,0.890376,0.932037,2,3,0,10.2168,0.0541819 +-6.88942,0.799493,0.932037,1,3,0,10.3695,0.320039 +-6.88942,0.261019,0.932037,1,3,0,10.9724,0.320039 +-6.80124,0.870892,0.932037,2,3,0,7.43049,0.29218 +-6.74978,0.998863,0.932037,1,3,0,6.80164,0.242642 +-7.17245,0.854684,0.932037,2,3,0,7.6,0.374989 +-8.81972,0.538088,0.932037,1,1,0,8.86828,0.538741 +-7.40622,1,0.932037,2,3,0,8.5393,0.127518 +-7.26318,0.961918,0.932037,2,3,0,8.05474,0.139325 +-7.34728,0.984906,0.932037,1,1,0,7.43596,0.132134 +-6.86243,0.997387,0.932037,1,3,0,7.24798,0.193608 +-6.89308,0.975225,0.932037,1,3,0,7.09809,0.320982 +-7.32886,0.939094,0.932037,2,3,0,7.34307,0.397658 +-7.57152,0.913466,0.932037,1,1,0,7.74604,0.427779 +-6.94728,1,0.932037,1,1,0,7.36923,0.333835 +-6.81842,1,0.932037,1,1,0,6.91356,0.298735 +-6.76216,1,0.932037,2,3,0,6.80728,0.229381 +-6.85768,0.974601,0.932037,2,3,0,6.94204,0.194717 +-6.77062,0.988638,0.932037,1,3,0,6.90934,0.277178 +-6.91451,0.978923,0.932037,2,3,0,6.91452,0.326292 +-6.78227,1,0.932037,1,1,0,6.87294,0.283622 +-7.62346,0.806356,0.932037,1,3,0,7.63204,0.433652 +-6.83206,1,0.932037,1,1,0,7.34914,0.303417 +-7.29941,0.815839,0.932037,2,3,0,7.843,0.136132 +-7.31671,0.996885,0.932037,1,1,0,7.4311,0.134659 +-6.78343,0.991818,0.932037,2,3,0,7.37529,0.21776 +-6.86006,0.980687,0.932037,1,1,0,6.8608,0.194157 +-6.77605,1,0.932037,1,1,0,6.83853,0.221209 +-6.86042,0.973286,0.932037,1,3,0,6.93518,0.312134 +-6.75338,0.997358,0.932037,1,3,0,6.86494,0.237216 +-6.83799,0.976298,0.932037,1,3,0,6.868,0.305342 +-7.00374,0.713633,0.932037,2,3,0,8.19304,0.345598 +-6.75259,0.98344,0.932037,2,3,0,7.10169,0.238182 +-6.79496,0.987555,0.932037,1,3,0,6.81495,0.289538 +-6.9391,0.981259,0.932037,2,3,0,6.94195,0.332008 +-7.22517,0.904285,0.932037,1,1,0,7.25937,0.383004 +-7.21052,1,0.932037,1,1,0,7.37602,0.38082 +-6.75985,0.787087,0.932037,2,3,0,8.11836,0.269544 +-6.86031,0.946513,0.932037,2,3,0,7.03793,0.194099 +-8.19403,0.780681,0.932037,1,3,0,8.38612,0.0850298 +-6.7609,1,0.932037,2,3,0,7.87703,0.270409 +-6.95309,0.78127,0.932037,2,3,0,7.88077,0.176161 +-9.56705,0.565191,0.932037,1,3,0,10.2818,0.587604 +-6.75776,1,0.932037,1,3,0,8.93023,0.232834 +-6.77632,0.994978,0.932037,1,1,0,6.77679,0.221079 +-6.82265,0.996019,0.932037,2,3,0,6.82416,0.203899 +-6.89139,0.983404,0.932037,1,1,0,6.89889,0.187357 +-6.89139,0.777655,0.932037,1,3,0,8.12126,0.187357 +-7.13161,0.926877,0.932037,1,3,0,7.44089,0.36846 +-8.35546,0.633109,0.932037,1,1,0,8.40627,0.503122 +-7.06834,0.886614,0.932037,1,3,0,8.96147,0.159824 +-7.28399,0.958522,0.932037,1,1,0,7.31204,0.137472 +-7.28327,1,0.932037,1,1,0,7.40052,0.137535 +-7.93284,0.898826,0.932037,1,1,0,7.93762,0.0962692 +-7.81694,1,0.932037,1,1,0,8.08024,0.101983 +-7.6919,1,0.932037,1,1,0,7.94232,0.108772 +-6.76979,0.932315,0.932037,1,3,0,7.86435,0.276668 +-6.97696,0.966811,0.932037,2,3,0,6.99094,0.172382 +-7.49857,0.902721,0.932037,2,3,0,7.93254,0.120867 +-7.50324,0.999237,0.932037,1,1,0,7.65578,0.120547 +-6.91611,1,0.932037,2,3,0,7.33316,0.326673 +-6.74956,1,0.932037,1,3,0,6.89861,0.243108 +-8.35635,0.667972,0.932037,1,3,0,8.48862,0.503195 +-8.35709,0.999715,0.932037,1,1,0,8.94945,0.503256 +-7.01492,1,0.932037,2,3,0,8.49553,0.16684 +-7.08433,0.985549,0.932037,1,1,0,7.13054,0.157871 +-7.29556,0.986569,0.932037,2,3,0,7.32674,0.136464 +-6.82002,1,0.932037,2,3,0,7.16863,0.299304 +-6.82002,0.827599,0.932037,1,1,0,7.18527,0.299304 +-6.96415,0.766705,0.932037,2,3,0,7.8936,0.337494 +-7.10108,0.953204,0.932037,1,1,0,7.15511,0.363367 +-7.08567,1,0.932037,1,1,0,7.2067,0.36072 +-8.18465,0.665208,0.932037,1,1,0,8.22692,0.488652 +-6.98816,1,0.932037,2,3,0,8.27915,0.170692 +-6.9991,0.951104,0.932037,2,3,0,7.40622,0.344679 +-6.87003,0.959893,0.932037,1,3,0,7.2399,0.191886 +-8.86597,0.67165,0.932037,1,3,0,9.3173,0.0633574 +-9.22117,0.969943,0.932037,1,1,0,9.41531,0.0547614 +-10.3294,0.926924,0.932037,1,1,0,10.3727,0.0356412 +-8.32325,0.989504,0.932037,2,3,0,10.9313,0.0801578 +-8.85098,0.946649,0.932037,1,1,0,8.95519,0.0637563 +-9.31959,0.960963,0.932037,1,1,0,9.47897,0.0526385 +-10.3022,0.93649,0.932037,1,1,0,10.3691,0.0360059 +-10.3363,0.998194,0.932037,1,1,0,10.7444,0.0355494 +-7.06812,1,0.932037,2,3,0,10.0104,0.159851 +-7.09449,0.998201,0.932037,2,3,0,7.16215,0.156661 +-7.41044,0.941678,0.932037,1,1,0,7.42835,0.127199 +-6.74954,0.897451,0.932037,2,3,0,8.358,0.256927 +-7.01483,0.952044,0.932037,2,3,0,7.06471,0.166853 +-7.04361,0.949288,0.932037,1,3,0,7.50082,0.353197 +-6.84344,1,0.932037,1,1,0,6.98754,0.30706 +-6.76346,1,0.932037,1,1,0,6.81845,0.272378 +-6.77171,0.981093,0.932037,2,3,0,6.85292,0.277844 +-6.84864,0.975946,0.932037,1,1,0,6.84963,0.308656 +-6.79009,1,0.932037,1,1,0,6.8359,0.287368 +-7.3603,0.823525,0.932037,1,3,0,7.7309,0.131086 +-7.81047,0.929962,0.932037,1,1,0,7.84015,0.102318 +-7.78154,1,0.932037,1,1,0,7.99363,0.103835 +-6.7517,1,0.932037,2,3,0,7.65292,0.239378 +-6.78798,0.848042,0.932037,2,3,0,7.61324,0.21582 +-6.76,0.921142,0.932037,2,3,0,7.25211,0.269673 +-6.79557,0.983288,0.932037,2,3,0,6.85013,0.212834 +-7.19183,0.926349,0.932037,1,3,0,7.21025,0.146103 +-7.38792,0.988215,0.932037,2,3,0,7.43851,0.128917 +-6.96601,1,0.932037,2,3,0,7.30212,0.174084 +-7.05786,0.980406,0.932037,1,1,0,7.08973,0.161138 +-7.16196,0.993052,0.932037,2,3,0,7.20877,0.149163 +-6.77281,0.912405,0.932037,2,3,0,8.28922,0.22288 +-6.75974,1,0.932037,1,1,0,6.77054,0.2312 +-6.74904,0.896827,0.932037,2,3,0,7.34903,0.244397 +-6.99017,0.938166,0.932037,1,3,0,7.02613,0.342891 +-9.18272,0.444151,0.932037,1,1,0,9.18621,0.563582 +-7.27998,1,0.932037,1,1,0,8.53072,0.390916 +-6.81588,0.976625,0.932037,1,3,0,7.39388,0.205939 +-6.85158,0.981914,0.932037,1,3,0,6.98055,0.309541 +-7.61781,0.765141,0.932037,1,1,0,7.61874,0.433021 +-6.79258,0.997137,0.932037,1,3,0,7.61795,0.21398 +-8.09444,0.722711,0.932037,1,3,0,8.35089,0.48065 +-8.09444,0.731058,0.932037,1,1,0,9.00859,0.48065 +-8.96537,0.715603,0.932037,1,1,0,9.37304,0.548986 +-8.78035,1,0.932037,1,1,0,9.62889,0.535902 +-7.21874,0.836764,0.932037,1,3,0,9.71962,0.143465 +-6.75061,0.911636,0.932037,2,3,0,8.14176,0.241082 +-7.65204,0.639147,0.932037,2,3,0,8.88575,0.436812 +-6.95151,1,0.932037,1,1,0,7.42019,0.334765 +-7.03245,0.89047,0.932037,2,3,0,7.4925,0.164448 +-6.93323,1,0.932037,1,1,0,7.03482,0.179514 +-6.93323,0.839701,0.932037,1,3,0,7.95662,0.179514 +-6.8181,1,0.932037,1,1,0,6.90794,0.205258 +-6.96817,0.964576,0.932037,1,1,0,6.96901,0.173744 +-6.75177,1,0.932037,2,3,0,6.94088,0.260926 +-6.75748,0.994596,0.932037,2,3,0,6.77947,0.267449 +-6.75598,1,0.932037,2,3,0,6.75911,0.265983 +-7.35596,0.838068,0.932037,1,3,0,7.60728,0.131434 +-6.75779,0.906448,0.932037,2,3,0,8.09794,0.267737 +-6.83162,0.952059,0.932037,2,3,0,6.9908,0.303273 +-7.67816,0.806003,0.932037,1,3,0,7.67819,0.43966 +-6.92603,0.932427,0.932037,1,3,0,8.01057,0.180783 +-7.07054,0.950192,0.932037,2,3,0,7.4224,0.159552 +-6.7484,0.994215,0.932037,1,3,0,7.0485,0.246555 +-7.08258,0.918347,0.932037,1,3,0,7.15481,0.158082 +-7.08258,0.737878,0.932037,1,3,0,9.18161,0.158082 +-7.35202,0.949338,0.932037,1,1,0,7.3743,0.131751 +-6.74881,0.983413,0.932037,1,3,0,7.33477,0.245074 +-6.95539,0.949695,0.932037,1,3,0,6.9911,0.175786 +-7.15608,0.958335,0.932037,1,1,0,7.16954,0.149783 +-6.83348,0.99773,0.932037,1,3,0,7.08351,0.200841 +-7.24483,0.931935,0.932037,1,3,0,7.25275,0.141003 +-6.98535,1,0.932037,1,1,0,7.20252,0.171111 +-6.79714,0.986131,0.932037,2,3,0,7.11242,0.212252 +-6.75975,0.994219,0.932037,2,3,0,6.84154,0.231186 +-7.85764,0.768175,0.932037,1,3,0,8.13554,0.0999182 +-7.75607,1,0.932037,2,3,0,8.00291,0.1052 +-7.45436,1,0.932037,1,1,0,7.77479,0.123968 +-6.75812,0.956844,0.932037,1,3,0,7.53861,0.268042 +-6.78653,0.996723,0.932037,2,3,0,6.78699,0.285711 +-6.78653,0.689753,0.932037,1,3,0,7.7558,0.285711 +-7.13767,0.941965,0.932037,2,3,0,7.15428,0.151762 +-6.8166,0.824152,0.932037,2,3,0,8.71226,0.205717 +-6.79612,1,0.932037,1,1,0,6.82009,0.21263 +-7.16066,0.926371,0.932037,2,3,0,7.36744,0.149299 +-6.7485,0.867631,0.932037,2,3,0,8.25218,0.253873 +-6.7485,0.374064,0.932037,1,3,0,9.69677,0.253873 +-6.906,0.899506,0.932037,2,3,0,7.30301,0.184481 +-6.97495,0.960716,0.932037,1,3,0,7.26467,0.339768 +-6.87784,0.957976,0.932037,1,3,0,7.22871,0.190181 +-6.76764,1,0.932037,1,3,0,6.85023,0.225799 +-7.06045,0.939987,0.932037,2,3,0,7.20313,0.160811 +-7.56678,0.90837,0.932037,1,1,0,7.56807,0.116345 +-8.21909,0.9114,0.932037,1,1,0,8.24106,0.0840531 +-7.1694,0.972439,0.932037,1,3,0,8.05615,0.148387 +-7.51659,0.939017,0.932037,1,1,0,7.53941,0.119642 +-6.80441,1,0.932037,2,3,0,7.33714,0.293457 +-6.84769,0.986098,0.932037,1,1,0,6.85924,0.308366 +-6.75447,1,0.932037,1,3,0,6.82024,0.264369 +-6.75447,0.941471,0.932037,1,3,0,6.92636,0.264369 +-7.31897,0.848317,0.932037,1,3,0,7.54592,0.134469 +-7.51256,0.936742,0.932037,2,3,0,8.23518,0.119914 +-7.00844,1,0.932037,1,1,0,7.41354,0.16775 +-6.81721,1,0.932037,2,3,0,6.95395,0.298298 +-7.45194,0.852204,0.932037,1,3,0,7.45194,0.413549 +-6.87259,1,0.932037,2,3,0,7.42285,0.191321 +-6.75616,1,0.932037,1,3,0,6.8471,0.234287 +-6.89502,0.961898,0.932037,1,3,0,6.94092,0.321477 +-6.77836,1,0.932037,2,3,0,6.87334,0.220083 +-6.79421,0.982898,0.932037,2,3,0,6.9004,0.28921 +-7.26621,0.798873,0.932037,2,3,0,7.90837,0.139052 +-6.86681,0.892468,0.932037,2,3,0,9.22078,0.192607 +-6.79361,1,0.932037,1,1,0,6.85058,0.213582 +-6.77748,1,0.932037,2,3,0,6.79435,0.220507 +-6.77887,0.999632,0.932037,1,1,0,6.78659,0.21984 +-6.78375,0.998717,0.932037,1,1,0,6.79108,0.217619 +-6.74954,0.987641,0.932037,2,3,0,6.86737,0.256925 +-7.83854,0.756676,0.932037,1,3,0,7.90005,0.456351 +-7.50039,1,0.932037,1,1,0,7.94015,0.419443 +-6.7491,1,0.932037,1,3,0,7.35194,0.244238 +-6.7636,0.996702,0.932037,1,3,0,6.76405,0.228378 +-6.78205,0.845782,0.932037,2,3,0,7.69714,0.218372 +-6.75014,0.997559,0.932037,2,3,0,6.79806,0.241923 +-8.34122,0.670679,0.932037,1,3,0,8.47733,0.501947 +-7.99963,1,0.932037,1,1,0,8.62888,0.471941 +-8.76385,0.745363,0.932037,1,1,0,9.14503,0.534703 +-7.04418,1,0.932037,1,1,0,8.14217,0.353302 +-7.43305,0.868749,0.932037,1,1,0,7.49441,0.4112 +-7.43305,0.297658,0.932037,1,1,0,9.48457,0.4112 +-6.83865,0.968461,0.932037,1,3,0,7.58424,0.199459 +-7.53033,0.883514,0.932037,1,3,0,7.57348,0.118724 +-6.96261,0.979104,0.932037,2,3,0,7.81614,0.174624 +-7.0999,0.990364,0.932037,2,3,0,7.12317,0.156026 +-8.07438,0.928426,0.932037,2,3,0,8.16995,0.478833 +-7.08332,1,0.932037,1,1,0,7.75278,0.36031 +-6.82918,1,0.932037,1,1,0,7.0036,0.302462 +-7.53288,0.784396,0.932037,1,1,0,7.53294,0.423295 +-7.05091,1,0.932037,2,3,0,7.39902,0.162026 +-7.40251,0.977978,0.932037,2,3,0,7.41207,0.127799 +-6.82898,1,0.932037,2,3,0,7.24836,0.302395 +-6.79153,1,0.932037,1,1,0,6.8253,0.288021 +-6.79153,0.459704,0.932037,1,3,0,9.85444,0.288021 +-6.76756,1,0.932037,1,1,0,6.7869,0.275233 +-6.97728,0.932763,0.932037,1,3,0,7.10469,0.172333 +-6.95157,1,0.932037,1,1,0,7.01491,0.17641 +-6.75905,0.960947,0.932037,2,3,0,7.21354,0.26886 +-6.7615,0.936647,0.932037,2,3,0,7.06828,0.229862 +-6.89331,0.972573,0.932037,1,3,0,6.89762,0.18697 +-6.77722,0.906489,0.932037,2,3,0,7.52048,0.280983 +-7.05175,0.910169,0.932037,1,3,0,7.23443,0.161917 +-6.92365,1,0.932037,1,1,0,7.04143,0.18121 +-6.92285,1,0.932037,2,3,0,6.9668,0.181353 +-7.13379,0.955304,0.932037,1,1,0,7.14184,0.152188 +-7.4804,0.884188,0.932037,1,3,0,8.21421,0.417034 +-7.40948,1,0.932037,1,1,0,7.67663,0.408227 +-6.7729,0.94969,0.932037,2,3,0,7.7319,0.222833 +-6.88124,0.967448,0.932037,1,3,0,6.95576,0.317894 +-8.24949,0.746027,0.932037,2,3,0,8.25756,0.0828895 +-6.96905,1,0.932037,1,3,0,8.10239,0.173607 +-7.27306,0.939109,0.932037,1,1,0,7.27863,0.138439 +-7.00308,0.956818,0.932037,1,3,0,7.78354,0.345468 +-6.75472,0.998187,0.932037,1,3,0,6.9917,0.235716 +-6.75494,0.999941,0.932037,1,1,0,6.75678,0.235495 +-6.87358,0.96725,0.932037,1,3,0,6.91321,0.315825 +-6.88529,0.996099,0.932037,1,1,0,6.92345,0.318963 +-8.16803,0.810902,0.932037,2,3,0,8.16856,0.487197 +-8.16803,0.500501,0.932037,1,1,0,9.65653,0.487197 +-6.84099,0.909134,0.932037,2,3,0,8.86386,0.198846 +-6.7482,0.97014,0.932037,2,3,0,7.07304,0.252336 +-6.88126,0.965042,0.932037,1,3,0,6.91312,0.189453 +-6.91537,0.971395,0.932037,1,3,0,7.15288,0.326496 +-6.74803,1,0.932037,1,3,0,6.88372,0.250563 +-6.78862,0.991449,0.932037,2,3,0,6.8033,0.215557 +-6.75166,1,0.932037,1,3,0,6.77932,0.239445 +-7.64177,0.652534,0.932037,2,3,0,8.81793,0.435682 +-7.39307,1,0.932037,1,1,0,7.74629,0.406126 +-7.39307,0.385651,0.932037,1,1,0,9.0256,0.406126 +-6.79731,0.988358,0.932037,1,3,0,7.44468,0.212186 +-7.26742,0.912562,0.932037,1,3,0,7.29563,0.138943 +-8.03606,0.881597,0.932037,1,1,0,8.03636,0.0915803 +-7.18684,0.969203,0.932037,1,3,0,7.89297,0.146604 +-7.82185,0.895632,0.932037,1,1,0,7.82342,0.10173 +-6.9258,0.999365,0.932037,1,3,0,7.68077,0.180825 +-6.84345,1,0.932037,1,1,0,6.91592,0.198213 +-8.02819,0.799375,0.932037,1,3,0,8.18865,0.0919253 +-9.74173,0.805241,0.932037,1,3,0,9.76127,0.0445821 +-8.33143,1,0.932037,1,1,0,9.60755,0.0798627 +-7.18582,0.972127,0.932037,1,3,0,8.16309,0.146708 +-6.92783,1,0.932037,1,1,0,7.13538,0.180463 +-7.11005,0.961217,0.932037,1,1,0,7.12168,0.154851 +-6.79373,1,0.932037,1,3,0,7.04271,0.213532 +-7.11956,0.955726,0.932037,2,3,0,7.20271,0.366472 +-7.48398,0.958399,0.932037,2,3,0,7.57261,0.417468 +-7.05344,1,0.932037,2,3,0,7.38948,0.354998 +-6.89526,1,0.932037,1,1,0,7.02854,0.321538 +-6.75297,0.996542,0.932037,2,3,0,6.92061,0.237701 +-6.83977,0.975809,0.932037,1,3,0,6.86918,0.305909 +-6.8251,1,0.932037,2,3,0,6.85672,0.301077 +-6.76932,1,0.932037,1,1,0,6.8089,0.276371 +-7.2411,0.887441,0.932037,1,3,0,7.24713,0.385345 +-6.77198,0.978158,0.932037,2,3,0,7.39681,0.223328 +-6.91344,0.959133,0.932037,1,3,0,6.99309,0.326033 +-7.04881,0.85015,0.932037,2,3,0,7.62026,0.162296 +-7.60525,0.863371,0.932037,1,3,0,8.23873,0.431613 +-6.78473,0.999819,0.932037,1,3,0,7.58373,0.217191 +-6.78473,0.898858,0.932037,1,3,0,7.22409,0.217191 +-7.78377,0.579188,0.932037,2,3,0,9.7066,0.103716 +-7.70743,1,0.932037,1,1,0,7.93357,0.10789 +-7.96247,0.96471,0.932037,1,1,0,8.07171,0.0948869 +-7.12674,0.974601,0.932037,1,3,0,7.81844,0.152967 +-6.75681,1,0.932037,1,3,0,7.07784,0.233681 +-6.74929,0.899259,0.932037,2,3,0,7.32696,0.243745 +-6.74929,0.646445,0.932037,1,3,0,8.08205,0.243745 +-7.15628,0.857788,0.932037,2,3,0,7.57467,0.372439 +-7.75903,0.923317,0.932037,2,3,0,7.84476,0.448237 +-6.85106,0.987384,0.932037,2,3,0,7.98227,0.19631 +-8.0294,0.746944,0.932037,1,3,0,8.39902,0.474711 +-6.8022,0.859301,0.932037,2,3,0,8.84948,0.210434 +-6.77032,1,0.932037,1,1,0,6.79542,0.22424 +-7.64151,0.740592,0.932037,2,3,0,8.46249,0.435654 +-8.37811,0.917274,0.932037,2,3,0,8.62816,0.504979 +-7.49482,1,0.932037,1,1,0,8.22793,0.418775 +-9.18827,0.523755,0.932037,1,1,0,9.33046,0.563944 +-7.76093,1,0.932037,1,1,0,8.88732,0.448435 +-6.97798,1,0.932037,1,1,0,7.50122,0.340396 +-7.35575,0.873861,0.932037,1,1,0,7.39654,0.401255 +-7.35575,0.110444,0.932037,1,1,0,11.0745,0.401255 +-7.35575,0.0800688,0.932037,1,3,0,15.4327,0.401255 +-7.48223,0.672997,0.932037,1,3,0,8.8362,0.121997 +-6.78001,0.901552,0.932037,2,3,0,8.42084,0.28247 +-7.27496,0.91456,0.932037,2,3,0,7.304,0.13827 +-7.27496,0.889573,0.932037,1,1,0,7.87313,0.13827 +-6.74818,0.981145,0.932037,1,3,0,7.27579,0.252199 +-6.74818,0.540736,0.932037,1,3,0,8.56126,0.252199 +-6.84577,0.975084,0.932037,1,3,0,6.8552,0.307778 +-6.84577,0.460221,0.932037,1,3,0,8.80117,0.307778 +-7.22623,0.87774,0.932037,1,1,0,7.23183,0.383162 +-6.86085,0.957571,0.932037,1,3,0,7.44679,0.193973 +-6.84216,1,0.932037,1,1,0,6.8764,0.198544 +-6.82726,0.902432,0.932037,2,3,0,7.67881,0.202571 +-7.01244,0.957121,0.932037,1,1,0,7.01282,0.167187 +-6.753,0.947388,0.932037,2,3,0,7.40574,0.262602 +-6.75612,0.999688,0.932037,2,3,0,6.75709,0.266127 +-7.10487,0.901325,0.932037,1,3,0,7.25063,0.155448 +-6.75288,0.934052,0.932037,2,3,0,7.61355,0.262456 +-6.75911,0.998131,0.932037,1,1,0,6.75973,0.268918 +-6.97448,0.935151,0.932037,1,3,0,7.07933,0.172763 +-8.33687,0.727783,0.932037,1,3,0,8.95629,0.501587 +-7.19311,1,0.932037,1,1,0,7.97929,0.378182 +-6.86239,0.957299,0.932037,1,3,0,7.41859,0.193617 +-8.81489,0.675307,0.932037,1,3,0,9.25628,0.0647295 +-9.08174,0.976561,0.932037,1,1,0,9.30033,0.0579512 +-8.72465,1,0.932037,2,3,0,9.23184,0.067248 +-9.02058,0.973248,0.932037,1,1,0,9.2222,0.059423 +-6.75096,0.87105,0.932037,1,3,0,9.3739,0.240494 +-6.77061,0.8673,0.932037,2,3,0,7.49474,0.224077 +-7.18049,0.687335,0.932037,2,3,0,8.77168,0.147248 +-6.83677,0.997719,0.932037,1,3,0,7.10412,0.199956 +-7.0242,0.942244,0.932037,1,3,0,7.2293,0.349561 +-6.75027,1,0.932037,1,3,0,6.95554,0.258452 +-7.19098,0.922423,0.932037,2,3,0,7.25741,0.146188 +-6.75095,0.998409,0.932037,2,3,0,7.18042,0.240521 +-6.87936,0.965588,0.932037,1,3,0,6.90968,0.31739 +-6.78928,1,0.932037,2,3,0,6.85581,0.215288 +-7.24713,0.912602,0.932037,1,3,0,7.27833,0.14079 +-7.64349,0.933948,0.932037,1,1,0,7.6686,0.111601 +-7.89818,0.963732,0.932037,1,1,0,7.99945,0.0979248 +-9.96894,0.866816,0.932037,2,3,0,10.0037,0.610637 +-8.27408,1,0.932037,1,1,0,9.73188,0.496333 +-8.97796,0.763178,0.932037,1,1,0,9.46742,0.549854 +-7.07994,1,0.932037,2,3,0,9.38837,0.158401 +-6.75736,0.879611,0.932037,2,3,0,8.01228,0.267336 +-6.7519,1,0.932037,1,1,0,6.75617,0.261115 +-6.78524,0.992274,0.932037,1,3,0,6.78539,0.285089 +-7.86462,0.758008,0.932037,1,3,0,7.87664,0.458948 +-7.97349,0.959152,0.932037,1,1,0,8.36464,0.469482 +-7.11236,1,0.932037,2,3,0,7.71314,0.365271 +-7.71805,0.799983,0.932037,1,1,0,7.78908,0.443934 +-9.81575,0.716945,0.932037,2,3,0,10.0088,0.602086 +-7.32169,1,0.932037,1,1,0,8.93058,0.396686 +-6.74807,0.833534,0.932037,2,3,0,8.05557,0.251241 +-6.74803,1,0.932037,2,3,0,6.74806,0.250572 +-6.75538,0.991246,0.932037,2,3,0,6.79373,0.235049 +-6.93792,0.962649,0.932037,2,3,0,7.01983,0.331741 +-7.2862,0.88434,0.932037,1,1,0,7.31645,0.391789 +-6.99084,1,0.932037,2,3,0,7.19845,0.170294 +-7.65042,0.905856,0.932037,2,3,0,8.20379,0.436635 +-7.41337,1,0.932037,1,1,0,7.7679,0.40872 +-8.85702,0.576942,0.932037,1,1,0,8.98493,0.541403 +-6.78589,1,0.932037,1,3,0,8.17164,0.285406 +-6.90223,0.954007,0.932037,1,3,0,7.03131,0.185207 +-8.14191,0.811993,0.932037,1,3,0,8.27248,0.0871143 +-8.10592,1,0.932037,1,1,0,8.36491,0.0885962 +-8.2689,0.993522,0.932037,2,3,0,8.4528,0.0821583 +-9.32894,0.899169,0.932037,1,1,0,9.34484,0.0524422 +-8.02809,1,0.932037,1,1,0,9.18688,0.0919298 +-6.99166,0.993898,0.932037,1,3,0,7.87392,0.170173 +-8.06441,0.911089,0.932037,2,3,0,8.31617,0.477926 +-8.7506,0.922675,0.932037,2,3,0,9.16274,0.533736 +-7.8978,1,0.932037,1,1,0,8.75888,0.462211 +-6.94446,1,0.932037,1,1,0,7.56554,0.333209 +-8.54285,0.771096,0.932037,2,3,0,8.54633,0.518094 +-6.78594,1,0.932037,1,3,0,7.9627,0.285428 +-6.78594,0.906519,0.932037,1,3,0,7.16707,0.285428 +-6.92112,0.942672,0.932037,2,3,0,7.08892,0.181666 +-6.87261,0.875781,0.932037,2,3,0,8.17854,0.191316 +-7.08975,0.952205,0.932037,1,1,0,7.09201,0.157223 +-7.02149,1,0.932037,2,3,0,7.12326,0.165933 +-7.04584,0.998287,0.932037,2,3,0,7.10444,0.162681 +-7.04584,0.672299,0.932037,1,3,0,9.55749,0.162681 +-7.77921,0.832639,0.932037,1,3,0,8.43718,0.450325 +-6.93132,0.932106,0.932037,1,3,0,8.11383,0.179848 +-7.37155,0.932331,0.932037,1,3,0,7.37171,0.130194 +-6.74802,0.977866,0.932037,1,3,0,7.37247,0.250051 +-6.90501,0.947815,0.932037,2,3,0,7.04469,0.32398 +-6.90501,0.515929,0.932037,1,1,0,8.06608,0.32398 +-7.26517,0.747153,0.932037,2,3,0,8.10285,0.139146 +-6.77759,0.959776,0.932037,1,3,0,7.38193,0.281187 +-6.75799,1,0.932037,1,1,0,6.77244,0.267921 +-6.79277,0.99575,0.932037,2,3,0,6.79381,0.213903 +-6.76109,1,0.932037,1,1,0,6.78457,0.230166 +-6.7596,0.969448,0.932037,2,3,0,6.95304,0.231305 +-6.79156,0.988014,0.932037,2,3,0,6.84381,0.214376 +-6.78312,1,0.932037,1,1,0,6.79707,0.217895 +-6.77762,0.949288,0.932037,2,3,0,7.08484,0.2812 +-7.09494,0.924565,0.932037,1,3,0,7.09566,0.362318 +-6.95426,1,0.932037,2,3,0,7.09613,0.335364 +-7.28442,0.889685,0.932037,1,1,0,7.32064,0.391541 +-6.79484,0.997398,0.932037,2,3,0,7.36362,0.213111 +-6.81648,0.99449,0.932037,1,1,0,6.8247,0.205753 +-6.84974,0.991789,0.932037,1,1,0,6.86103,0.196633 +-6.74879,0.865097,0.932037,2,3,0,7.74614,0.245131 +-6.88211,0.967449,0.932037,1,3,0,6.902,0.189273 +-6.74845,0.957844,0.932037,2,3,0,7.24214,0.246361 +-7.20685,0.887254,0.932037,1,3,0,7.25766,0.380267 +-7.20685,0.564767,0.932037,1,3,0,8.81898,0.380267 +-7.20685,0.320306,0.932037,1,3,0,12.13,0.380267 +-6.97752,0.935114,0.932037,2,3,0,7.66742,0.172296 +-6.87049,1,0.932037,1,1,0,6.96427,0.191784 +-6.74837,0.966424,0.932037,2,3,0,7.14605,0.253312 +-6.98253,0.907073,0.932037,2,3,0,7.2529,0.341334 +-7.79349,0.745081,0.932037,1,1,0,7.81771,0.451791 +-6.77388,1,0.932037,1,3,0,7.46942,0.279119 +-6.90086,0.954561,0.932037,1,3,0,7.00827,0.185473 +-6.79914,1,0.932037,2,3,0,6.8716,0.291311 +-8.11178,0.713466,0.932037,1,3,0,8.12201,0.482208 +-8.11178,0.190125,0.932037,1,1,0,11.1441,0.482208 +-7.24841,1,0.932037,1,1,0,7.88964,0.386408 +-7.23081,1,0.932037,1,1,0,7.40517,0.383837 +-6.80377,1,0.932037,2,3,0,7.08741,0.293202 +-6.85418,0.994603,0.932037,2,3,0,6.86482,0.310312 +-6.74965,0.98222,0.932037,2,3,0,6.95136,0.257173 +-7.03844,0.928412,0.932037,1,3,0,7.0566,0.352239 +-7.22621,0.808036,0.932037,1,3,0,7.93488,0.14275 +-6.77583,0.927823,0.932037,2,3,0,7.69178,0.280224 +-6.86535,0.971878,0.932037,1,1,0,6.86662,0.313541 +-6.77928,0.990027,0.932037,1,3,0,6.92787,0.219648 +-6.78451,0.998625,0.932037,1,1,0,6.79187,0.217287 +-6.78451,0.773207,0.932037,1,3,0,7.90069,0.217287 +-6.75189,0.967957,0.932037,2,3,0,6.99818,0.23911 +-6.88731,0.96889,0.932037,1,3,0,6.89993,0.18819 +-6.83332,1,0.932037,1,1,0,6.8859,0.200884 +-6.96445,0.969353,0.932037,1,1,0,6.9678,0.174331 +-6.74853,0.993691,0.932037,1,3,0,6.95955,0.253983 +-6.79227,0.98474,0.932037,2,3,0,6.83336,0.288352 +-6.78141,0.965461,0.932037,2,3,0,6.96936,0.218663 +-6.75837,0.995995,0.932037,1,3,0,6.80286,0.268259 +-6.80841,0.982527,0.932037,1,3,0,6.84862,0.208324 +-6.92145,0.989324,0.932037,2,3,0,6.92312,0.327942 +-6.94393,0.992369,0.932037,1,1,0,6.99666,0.33309 +-8.0719,0.66438,0.932037,1,1,0,8.0808,0.478608 +-8.30789,0.913191,0.932037,1,1,0,8.7652,0.499176 +-6.88395,1,0.932037,2,3,0,7.79691,0.318612 +-6.88395,0.525809,0.932037,1,3,0,8.46396,0.318612 +-7.66074,0.862122,0.932037,2,3,0,7.66587,0.110579 +-7.48718,1,0.932037,1,1,0,7.73391,0.121652 +-7.24771,1,0.932037,1,1,0,7.49536,0.140737 +-6.75294,0.907734,0.932037,2,3,0,8.2612,0.23774 +-6.75294,0.882023,0.932037,1,3,0,7.23222,0.23774 +-6.75294,0.648763,0.932037,1,3,0,8.1161,0.23774 +-6.75671,0.998954,0.932037,1,1,0,6.75747,0.233769 +-7.51733,0.821118,0.932037,1,3,0,7.63136,0.421461 +-7.23718,1,0.932037,2,3,0,7.55107,0.384773 +-7.23718,0.584164,0.932037,1,1,0,8.1976,0.384773 +-6.75151,1,0.932037,1,3,0,7.10952,0.260533 +-6.76119,0.993068,0.932037,2,3,0,6.78713,0.270643 +-6.79508,0.984853,0.932037,2,3,0,6.84415,0.213018 +-8.30022,0.789495,0.932037,2,3,0,8.51335,0.0809972 +-7.08882,0.985416,0.932037,1,3,0,8.13433,0.157333 +-6.74804,0.991804,0.932037,1,3,0,7.07332,0.249263 +-6.76797,0.994746,0.932037,1,3,0,6.77114,0.275501 +-6.87611,0.984786,0.932037,2,3,0,6.88112,0.190553 +-7.10363,0.930507,0.932037,1,3,0,7.38443,0.3638 +-7.1931,0.968366,0.932037,1,1,0,7.30124,0.378181 +-7.02744,1,0.932037,1,1,0,7.20716,0.350175 +-7.47087,0.716122,0.932037,1,3,0,8.36114,0.122794 +-7.77445,0.953734,0.932037,1,1,0,7.84235,0.104212 +-7.10232,0.976364,0.932037,1,3,0,7.65215,0.155744 +-6.89247,0.977052,0.932037,2,3,0,7.36801,0.187138 +-6.88406,1,0.932037,2,3,0,6.92287,0.188864 +-7.00739,0.972361,0.932037,1,1,0,7.01912,0.167899 +-7.4581,0.959878,0.932037,2,3,0,7.46539,0.414309 +-7.4581,0.358894,0.932037,1,1,0,9.21803,0.414309 +-8.39486,0.699937,0.932037,1,1,0,8.5651,0.506344 +-6.98009,0.931934,0.932037,1,3,0,8.77344,0.171904 +-7.75622,0.895607,0.932037,2,3,0,8.30908,0.447944 +-7.45294,1,0.932037,1,1,0,7.85686,0.413673 +-7.81191,0.87317,0.932037,1,1,0,8.02199,0.453667 +-7.07889,1,0.932037,2,3,0,7.65163,0.158528 +-8.02018,0.93056,0.932037,2,3,0,8.11738,0.473856 +-7.32245,1,0.932037,1,1,0,7.89443,0.396789 +-7.11924,1,0.932037,2,3,0,7.35057,0.366419 +-7.13426,0.994637,0.932037,1,1,0,7.25741,0.368892 +-6.81324,1,0.932037,1,1,0,7.02809,0.296845 +-7.90962,0.554652,0.932037,2,3,0,9.26763,0.0973734 +-10.1284,0.790216,0.932037,1,3,0,10.2416,0.0384446 +-8.90062,1,0.932037,1,1,0,10.0537,0.0624477 +-6.80723,1,0.932037,2,3,0,8.62687,0.208714 +-6.86729,0.973895,0.932037,2,3,0,7.02735,0.192499 +-6.79392,1,0.932037,1,1,0,6.85106,0.213461 +-7.40012,0.888235,0.932037,2,3,0,7.70807,0.407031 +-6.93792,1,0.932037,2,3,0,7.29993,0.178704 +-7.00949,0.984312,0.932037,1,1,0,7.03975,0.167602 +-7.13808,0.973678,0.932037,1,1,0,7.17115,0.151717 +-6.78692,0.965669,0.932037,1,3,0,7.25761,0.285893 +-6.87345,0.885758,0.932037,2,3,0,7.29989,0.315791 +-7.7385,0.869841,0.932037,2,3,0,7.74068,0.446092 +-7.7385,0.102215,0.932037,1,1,0,11.7215,0.446092 +-8.03266,0.893586,0.932037,1,1,0,8.35655,0.475011 +-8.22194,0.92979,0.932037,1,1,0,8.66902,0.491883 +-7.3561,1,0.932037,2,3,0,7.97443,0.131423 +-6.78127,1,0.932037,1,3,0,7.27452,0.218728 +-6.82275,0.984055,0.932037,1,3,0,6.89491,0.300263 +-7.6571,0.742126,0.932037,1,3,0,8.29259,0.110793 +-8.03026,0.829375,0.932037,1,3,0,9.64909,0.47479 +-7.37223,1,0.932037,1,1,0,7.93907,0.403423 +-6.79515,0.988926,0.932037,1,3,0,7.42116,0.212995 +-6.82487,0.992469,0.932037,1,1,0,6.83189,0.203253 +-7.12496,0.969767,0.932037,2,3,0,7.16248,0.367365 +-8.26834,0.652897,0.932037,1,1,0,8.32004,0.495847 +-8.67193,0.856184,0.932037,1,1,0,9.18766,0.527922 +-6.90442,1,0.932037,1,1,0,8.03082,0.323833 +-7.94108,0.68975,0.932037,1,1,0,7.94519,0.466396 +-7.78516,0.528351,0.932037,1,3,0,10.1916,0.103643 +-7.48177,1,0.932037,1,1,0,7.8074,0.122029 +-6.80338,0.90422,0.932037,2,3,0,8.07863,0.293044 +-6.89878,0.96934,0.932037,1,1,0,6.90583,0.322427 +-7.30937,0.866085,0.932037,1,1,0,7.32592,0.395003 +-6.85274,1,0.932037,1,1,0,7.15684,0.309887 +-6.85274,0.743543,0.932037,1,3,0,7.59752,0.309887 +-6.85274,0.563681,0.932037,1,3,0,9.12334,0.309887 +-7.14252,0.905701,0.932037,1,1,0,7.15244,0.370233 +-6.88606,1,0.932037,1,1,0,7.07414,0.319166 +-6.81352,1,0.932037,1,1,0,6.87385,0.296952 +-7.22426,0.603012,0.932037,2,3,0,8.88007,0.382871 +-6.75466,1,0.932037,1,3,0,7.17215,0.235789 +-6.77207,0.962029,0.932037,2,3,0,6.97984,0.223275 +-7.20122,0.9126,0.932037,1,3,0,7.2415,0.145171 +-7.97419,0.889846,0.932037,1,3,0,7.97427,0.0943483 +-7.1089,0.976552,0.932037,1,3,0,7.82637,0.154983 +-7.1089,0.884111,0.932037,1,3,0,7.82698,0.154983 +-6.98201,0.835391,0.932037,2,3,0,9.32581,0.171614 +-7.4823,0.923908,0.932037,1,3,0,7.48233,0.121992 +-8.13382,0.907974,0.932037,1,1,0,8.15008,0.0874439 +-7.0191,0.992287,0.932037,1,3,0,7.97523,0.166261 +-7.38884,0.929413,0.932037,1,1,0,7.39423,0.128846 +-7.05345,0.945247,0.932037,1,3,0,8.00914,0.354999 +-7.88022,0.88235,0.932037,2,3,0,7.92302,0.460488 +-7.47896,1,0.932037,1,1,0,7.94438,0.41686 +-8.26848,0.902685,0.932037,2,3,0,8.45552,0.495858 +-8.36145,0.964836,0.932037,1,1,0,8.90958,0.503614 +-6.80918,1,0.932037,1,3,0,7.82987,0.295317 +-7.23868,0.600861,0.932037,2,3,0,8.89375,0.384993 +-6.89006,1,0.932037,1,1,0,7.13419,0.320205 +-6.8044,1,0.932037,2,3,0,6.86543,0.209671 +-6.86009,0.995405,0.932037,2,3,0,6.86567,0.194151 +-6.86009,0.799308,0.932037,1,3,0,7.97123,0.194151 +-8.99856,0.728419,0.932037,2,3,0,9.23129,0.0599642 +-9.09468,0.991837,0.932037,1,1,0,9.38997,0.0576457 +-8.73756,1,0.932037,1,1,0,9.24597,0.0668798 +-7.55986,0.937761,0.932037,1,3,0,8.57866,0.11679 +-7.99912,0.937675,0.932037,1,1,0,8.05117,0.0932182 +-7.76055,1,0.932037,1,1,0,8.08641,0.104958 +-8.28732,0.977606,0.932037,2,3,0,8.34339,0.0814724 +-6.82679,0.992827,0.932037,1,3,0,8.22618,0.202702 +-6.87274,0.996281,0.932037,2,3,0,6.88424,0.191288 +-6.78865,0.91873,0.932037,2,3,0,7.41091,0.286706 +-6.76058,1,0.932037,2,3,0,6.78115,0.230549 +-6.76058,0.44465,0.932037,2,3,0,10.1097,0.230549 +-8.19963,0.701948,0.932037,1,3,0,8.62984,0.0848102 +-6.87827,1,0.932037,1,3,0,8.08649,0.190089 +-6.90011,0.99488,0.932037,1,1,0,6.92793,0.185622 +-7.58846,0.835161,0.932037,1,3,0,7.98997,0.429714 +-6.84168,1,0.932037,2,3,0,7.32922,0.306509 +-6.79898,0.907476,0.932037,2,3,0,7.23342,0.291247 +-7.18968,0.940405,0.932037,2,3,0,7.1897,0.377657 +-7.30081,0.811278,0.932037,2,3,0,8.27114,0.136012 +-7.44395,0.975262,0.932037,1,1,0,7.52376,0.124721 +-7.10913,1,0.932037,1,1,0,7.3984,0.154957 +-6.74902,0.994264,0.932037,1,3,0,7.08219,0.24445 +-7.95169,0.736282,0.932037,1,3,0,8.05657,0.467411 +# +# Elapsed Time: 0.005 seconds (Warm-up) +# 0.012 seconds (Sampling) +# 0.017 seconds (Total) +# diff --git a/src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv b/src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv new file mode 100644 index 0000000000..1e93414470 --- /dev/null +++ b/src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv @@ -0,0 +1,57 @@ +# stan_version_major = 2 +# stan_version_minor = 35 +# stan_version_patch = 0 +# model = eight_schools_model +# start_datetime = 2024-07-20 18:52:24 UTC +# method = sample (Default) +# sample +# num_samples = 0 +# 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 = examples/eight_schools/eight_schools.data.json +# init = 2 (Default) +# random +# seed = 3634790287 (Default) +# output +# file = eight_schools_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-25-gbb9ce42 +# stancflags = +lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,mu,theta.1,theta.2,theta.3,theta.4,theta.5,theta.6,theta.7,theta.8,tau +# Adaptation terminated +# Step size = 0.21285 +# Diagonal elements of inverse mass matrix: +# 22.9615, 70.1007, 38.6355, 46.2857, 44.7487, 36.401, 46.9537, 45.2008, 61.2207, 0.755335 +# +# Elapsed Time: 0.046 seconds (Warm-up) +# 0.023 seconds (Sampling) +# 0.069 seconds (Total) +# From 35bdb07570910d0ef59e11861c966f4f83077404 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Fri, 11 Oct 2024 17:15:53 -0400 Subject: [PATCH 02/40] basic_ess needed for mcse --- .../mcmc/split_rank_normalized_ess.hpp | 27 +++++++++++++++++-- src/stan/io/stan_csv_reader.hpp | 2 +- src/stan/mcmc/chainset.hpp | 4 +-- 3 files changed, 28 insertions(+), 5 deletions(-) diff --git a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp index 6a26490147..4087e497f7 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp @@ -103,7 +103,8 @@ double ess(const Eigen::MatrixXd& chains) { /** * Computes the split effective sample size (split ESS) using rank based * diagnostic for a set of per-chain draws. Based on paper - * https://arxiv.org/abs/1903.08008 + * https://arxiv.org/abs/1903.08008 Computes bulk ESS over entire sample, + * and tail ESS over the 0.05 and 0.95 quantiles. * * When the number of total draws N is odd, the last draw is ignored. * @@ -111,7 +112,7 @@ double ess(const Eigen::MatrixXd& chains) { * Scale Reduction". http://mc-stan.org/users/documentation * @param chains matrix of per-chain draws, num_iters X chain - * @return potential scale reduction + * @return pair ESS_bulk, ESS_tail */ inline std::pair split_rank_normalized_ess( const Eigen::MatrixXd& chains) { @@ -142,6 +143,28 @@ inline std::pair split_rank_normalized_ess( return std::make_pair(ess_bulk, ess_tail); } +/** + * Computes the split effective sample size (split ESS) + * diagnostic for a set of per-chain draws. + * + * When the number of total draws N is odd, the last draw is ignored. + * + * See more details in Stan reference manual section "Potential + * Scale Reduction". http://mc-stan.org/users/documentation + + * @param chains matrix of per-chain draws, num_iters X chain + * @return potential scale reduction + */ +inline double split_basic_ess( + const Eigen::MatrixXd& chains) { + Eigen::MatrixXd split_draws_matrix = split_chains(chains); + if (!is_finite_and_varies(split_draws_matrix) + || split_draws_matrix.rows() < 4) { + return std::numeric_limits::quiet_NaN(); + } + return ess(split_draws_matrix); +} + } // namespace analyze } // namespace stan diff --git a/src/stan/io/stan_csv_reader.hpp b/src/stan/io/stan_csv_reader.hpp index a5dfc9f0d0..459ee456f1 100644 --- a/src/stan/io/stan_csv_reader.hpp +++ b/src/stan/io/stan_csv_reader.hpp @@ -377,7 +377,7 @@ class stan_csv_reader { if (!read_samples(in, data.samples, data.timing)) { if (out) - *out << "Unable to parse sample" << std::endl; + *out << "no draws found" << std::endl; } return data; } diff --git a/src/stan/mcmc/chainset.hpp b/src/stan/mcmc/chainset.hpp index 3846212e95..eb33837619 100644 --- a/src/stan/mcmc/chainset.hpp +++ b/src/stan/mcmc/chainset.hpp @@ -420,8 +420,8 @@ class chainset { * @return pair (bulk_ess, tail_ess) */ double mcse_mean(const int index) const { - double ess_bulk = analyze::split_rank_normalized_ess(samples(index)).first; - return sd(index) / std::sqrt(ess_bulk); + double ess_basic = analyze::split_basic_ess(samples(index)); + return sd(index) / std::sqrt(ess_basic); } /** From 12811f2c355e41cf5b7e544f5b43b7e0cb378f59 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Fri, 11 Oct 2024 17:16:26 -0400 Subject: [PATCH 03/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/stan/analyze/mcmc/split_rank_normalized_ess.hpp | 7 +++---- 1 file changed, 3 insertions(+), 4 deletions(-) diff --git a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp index 4087e497f7..4954bc4580 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp @@ -144,7 +144,7 @@ inline std::pair split_rank_normalized_ess( } /** - * Computes the split effective sample size (split ESS) + * Computes the split effective sample size (split ESS) * diagnostic for a set of per-chain draws. * * When the number of total draws N is odd, the last draw is ignored. @@ -155,8 +155,7 @@ inline std::pair split_rank_normalized_ess( * @param chains matrix of per-chain draws, num_iters X chain * @return potential scale reduction */ -inline double split_basic_ess( - const Eigen::MatrixXd& chains) { +inline double split_basic_ess(const Eigen::MatrixXd& chains) { Eigen::MatrixXd split_draws_matrix = split_chains(chains); if (!is_finite_and_varies(split_draws_matrix) || split_draws_matrix.rows() < 4) { @@ -164,7 +163,7 @@ inline double split_basic_ess( } return ess(split_draws_matrix); } - + } // namespace analyze } // namespace stan From 7b4843ffedd1c8ea0cbdae716e04d3e4abb1e397 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Fri, 11 Oct 2024 19:12:45 -0400 Subject: [PATCH 04/40] added ess_basic, unit tests --- src/stan/io/stan_csv_reader.hpp | 2 +- .../unit/analyze/mcmc/split_rank_normalized_ess_test.cpp | 9 ++++++++- src/test/unit/io/stan_csv_reader_test.cpp | 2 +- 3 files changed, 10 insertions(+), 3 deletions(-) diff --git a/src/stan/io/stan_csv_reader.hpp b/src/stan/io/stan_csv_reader.hpp index 459ee456f1..22a11947a4 100644 --- a/src/stan/io/stan_csv_reader.hpp +++ b/src/stan/io/stan_csv_reader.hpp @@ -377,7 +377,7 @@ class stan_csv_reader { if (!read_samples(in, data.samples, data.timing)) { if (out) - *out << "no draws found" << std::endl; + *out << "No draws found" << std::endl; } return data; } diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 654a2fd168..9c63f0fcdb 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -6,7 +6,7 @@ #include #include -TEST(RankNormalizedEss, compute_split_rank_normalized_ess) { +TEST(RankNormalizedEss, test_bulk_tail_basic_ess) { std::stringstream out; std::ifstream eight_schools_1_stream, eight_schools_2_stream; stan::io::stan_csv eight_schools_1, eight_schools_2; @@ -29,6 +29,8 @@ TEST(RankNormalizedEss, compute_split_rank_normalized_ess) { ess_8_schools_bulk << 348, 370, 600, 638, 765, 608, 629, 274, 517, 112; Eigen::VectorXd ess_8_schools_tail(10); ess_8_schools_tail << 845, 858, 874, 726, 620, 753, 826, 628, 587, 108; + Eigen::VectorXd ess_8_schools_basic(10); + ess_8_schools_basic << 361, 407, 624, 649, 779, 607, 643, 267, 537, 208; Eigen::MatrixXd chains(eight_schools_1.samples.rows(), 2); for (size_t i = 0; i < 10; ++i) { @@ -37,6 +39,8 @@ TEST(RankNormalizedEss, compute_split_rank_normalized_ess) { auto ess = stan::analyze::split_rank_normalized_ess(chains); EXPECT_NEAR(ess.first, ess_8_schools_bulk(i), 5); EXPECT_NEAR(ess.second, ess_8_schools_tail(i), 5); + auto ess_basic = stan::analyze::split_basic_ess(chains); + EXPECT_NEAR(ess_basic, ess_8_schools_basic(i), 5); } } @@ -62,7 +66,10 @@ TEST(RankNormalizedEss, short_chains_fail) { chains.col(0) = eight_schools_5iters_1.samples.col(i + 7); chains.col(1) = eight_schools_5iters_2.samples.col(i + 7); auto ess = stan::analyze::split_rank_normalized_ess(chains); + auto ess_basic = stan::analyze::split_basic_ess(chains); EXPECT_TRUE(std::isnan(ess.first)); EXPECT_TRUE(std::isnan(ess.second)); + EXPECT_TRUE(std::isnan(ess_basic)); } } + diff --git a/src/test/unit/io/stan_csv_reader_test.cpp b/src/test/unit/io/stan_csv_reader_test.cpp index ec91cf8684..864bd1512e 100644 --- a/src/test/unit/io/stan_csv_reader_test.cpp +++ b/src/test/unit/io/stan_csv_reader_test.cpp @@ -578,7 +578,7 @@ TEST_F(StanIoStanCsvReader, no_samples) { stan::io::stan_csv no_samples = stan::io::stan_csv_reader::parse(no_samples_stream, &out); no_samples_stream.close(); - ASSERT_EQ(out.str(), "Unable to parse sample\n"); + ASSERT_EQ(out.str(), "No draws found\n"); } TEST_F(StanIoStanCsvReader, variational) { From da1b6c508af7acdb14bfb74fe5285648071926d7 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Fri, 11 Oct 2024 19:13:26 -0400 Subject: [PATCH 05/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp | 1 - 1 file changed, 1 deletion(-) diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 9c63f0fcdb..e290bd5c56 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -72,4 +72,3 @@ TEST(RankNormalizedEss, short_chains_fail) { EXPECT_TRUE(std::isnan(ess_basic)); } } - From 6cba5df65af00c389e3c0b69990369cd3b65d2f8 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Fri, 11 Oct 2024 20:12:04 -0400 Subject: [PATCH 06/40] mcse, mcse_sd match posterior implementation --- .../mcmc/split_rank_normalized_ess.hpp | 21 ------------------ src/stan/mcmc/chainset.hpp | 22 ++++++++++++------- .../mcmc/split_rank_normalized_ess_test.cpp | 6 ++--- 3 files changed, 16 insertions(+), 33 deletions(-) diff --git a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp index 4954bc4580..916b01369c 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp @@ -143,27 +143,6 @@ inline std::pair split_rank_normalized_ess( return std::make_pair(ess_bulk, ess_tail); } -/** - * Computes the split effective sample size (split ESS) - * diagnostic for a set of per-chain draws. - * - * When the number of total draws N is odd, the last draw is ignored. - * - * See more details in Stan reference manual section "Potential - * Scale Reduction". http://mc-stan.org/users/documentation - - * @param chains matrix of per-chain draws, num_iters X chain - * @return potential scale reduction - */ -inline double split_basic_ess(const Eigen::MatrixXd& chains) { - Eigen::MatrixXd split_draws_matrix = split_chains(chains); - if (!is_finite_and_varies(split_draws_matrix) - || split_draws_matrix.rows() < 4) { - return std::numeric_limits::quiet_NaN(); - } - return ess(split_draws_matrix); -} - } // namespace analyze } // namespace stan diff --git a/src/stan/mcmc/chainset.hpp b/src/stan/mcmc/chainset.hpp index eb33837619..671d1f7000 100644 --- a/src/stan/mcmc/chainset.hpp +++ b/src/stan/mcmc/chainset.hpp @@ -417,11 +417,14 @@ class chainset { * Follows implementation in the R posterior package * * @param index parameter index - * @return pair (bulk_ess, tail_ess) + * @return mcse */ double mcse_mean(const int index) const { - double ess_basic = analyze::split_basic_ess(samples(index)); - return sd(index) / std::sqrt(ess_basic); + if (num_samples() < 4 + || !stan::analyze::is_finite_and_varies(samples(index))) + return std::numeric_limits::quiet_NaN(); + double ess = analyze::ess(samples(index)); + return sd(index) / std::sqrt(ess); } /** @@ -430,7 +433,7 @@ class chainset { * Follows implementation in the R posterior package. * * @param name parameter name - * @return pair (bulk_ess, tail_ess) + * @return mcse */ double mcse_mean(const std::string& name) const { return mcse_mean(index(name)); @@ -442,13 +445,16 @@ class chainset { * Follows implementation in the R posterior package. * * @param index parameter index - * @return pair (bulk_ess, tail_ess) + * @return mcse_sd */ double mcse_sd(const int index) const { + if (num_samples() < 4 + || !stan::analyze::is_finite_and_varies(samples(index))) + return std::numeric_limits::quiet_NaN(); Eigen::MatrixXd s = samples(index); Eigen::MatrixXd s2 = s.array().square(); - double ess_s = analyze::split_rank_normalized_ess(s).first; - double ess_s2 = analyze::split_rank_normalized_ess(s2).first; + double ess_s = analyze::ess(s); + double ess_s2 = analyze::ess(s2); double ess_sd = std::min(ess_s, ess_s2); return sd(index) * std::sqrt(stan::math::e() * std::pow(1 - 1 / ess_sd, ess_sd - 1) @@ -461,7 +467,7 @@ class chainset { * Follows implementation in the R posterior package * * @param name parameter name - * @return pair (bulk_ess, tail_ess) + * @return mcse_sd */ double mcse_sd(const std::string& name) const { return mcse_sd(index(name)); } diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 9c63f0fcdb..8668999f1f 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -30,7 +30,7 @@ TEST(RankNormalizedEss, test_bulk_tail_basic_ess) { Eigen::VectorXd ess_8_schools_tail(10); ess_8_schools_tail << 845, 858, 874, 726, 620, 753, 826, 628, 587, 108; Eigen::VectorXd ess_8_schools_basic(10); - ess_8_schools_basic << 361, 407, 624, 649, 779, 607, 643, 267, 537, 208; + ess_8_schools_basic << 351, 403, 569, 646, 788, 602, 634, 262, 520, 223; Eigen::MatrixXd chains(eight_schools_1.samples.rows(), 2); for (size_t i = 0; i < 10; ++i) { @@ -39,7 +39,7 @@ TEST(RankNormalizedEss, test_bulk_tail_basic_ess) { auto ess = stan::analyze::split_rank_normalized_ess(chains); EXPECT_NEAR(ess.first, ess_8_schools_bulk(i), 5); EXPECT_NEAR(ess.second, ess_8_schools_tail(i), 5); - auto ess_basic = stan::analyze::split_basic_ess(chains); + auto ess_basic = stan::analyze::ess(chains); EXPECT_NEAR(ess_basic, ess_8_schools_basic(i), 5); } } @@ -66,10 +66,8 @@ TEST(RankNormalizedEss, short_chains_fail) { chains.col(0) = eight_schools_5iters_1.samples.col(i + 7); chains.col(1) = eight_schools_5iters_2.samples.col(i + 7); auto ess = stan::analyze::split_rank_normalized_ess(chains); - auto ess_basic = stan::analyze::split_basic_ess(chains); EXPECT_TRUE(std::isnan(ess.first)); EXPECT_TRUE(std::isnan(ess.second)); - EXPECT_TRUE(std::isnan(ess_basic)); } } From 345fceaf00828a75f89128f3ec2350ec55418f98 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Fri, 11 Oct 2024 20:12:46 -0400 Subject: [PATCH 07/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/stan/mcmc/chainset.hpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/stan/mcmc/chainset.hpp b/src/stan/mcmc/chainset.hpp index 671d1f7000..264becb7f5 100644 --- a/src/stan/mcmc/chainset.hpp +++ b/src/stan/mcmc/chainset.hpp @@ -421,7 +421,7 @@ class chainset { */ double mcse_mean(const int index) const { if (num_samples() < 4 - || !stan::analyze::is_finite_and_varies(samples(index))) + || !stan::analyze::is_finite_and_varies(samples(index))) return std::numeric_limits::quiet_NaN(); double ess = analyze::ess(samples(index)); return sd(index) / std::sqrt(ess); @@ -449,7 +449,7 @@ class chainset { */ double mcse_sd(const int index) const { if (num_samples() < 4 - || !stan::analyze::is_finite_and_varies(samples(index))) + || !stan::analyze::is_finite_and_varies(samples(index))) return std::numeric_limits::quiet_NaN(); Eigen::MatrixXd s = samples(index); Eigen::MatrixXd s2 = s.array().square(); From 79c675a6a6df12c7848211c7d322841926b5850a Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Wed, 16 Oct 2024 14:40:13 -0400 Subject: [PATCH 08/40] changes per code review --- src/stan/analyze/mcmc/mcse.hpp | 56 ++++++++++++++++++++++++++++ src/stan/mcmc/chainset.hpp | 54 ++++++++++++--------------- src/test/unit/mcmc/chainset_test.cpp | 10 ++--- 3 files changed, 84 insertions(+), 36 deletions(-) create mode 100644 src/stan/analyze/mcmc/mcse.hpp diff --git a/src/stan/analyze/mcmc/mcse.hpp b/src/stan/analyze/mcmc/mcse.hpp new file mode 100644 index 0000000000..9bd9aa8341 --- /dev/null +++ b/src/stan/analyze/mcmc/mcse.hpp @@ -0,0 +1,56 @@ +#ifndef STAN_ANALYZE_MCMC_MCSE_HPP +#define STAN_ANALYZE_MCMC_MCSE_HPP + +#include +#include +#include +#include +#include +#include + +namespace stan { +namespace analyze { + + + /** + * Computes the mean Monte Carlo error estimate for the central 90% interval. + * See https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package. + * + * @param chains matrix of draws across all chains + * @return mcse + */ + inline double mcse_mean(const Eigen::MatrixXd& chains) { + const Eigen::Index num_draws = chains.rows(); + if (chains.rows() < 4 + || !is_finite_and_varies(chains)) + return std::numeric_limits::quiet_NaN(); + + double sd = (chains.array() - chains.mean()).square().sum() / (chains.size() - 1); + return std::sqrt(sd / ess(chains)); + } + + /** + * Computes the standard deviation of the Monte Carlo error estimate + * https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package: + * https://github.com/stan-dev/posterior/blob/98bf52329d68f3307ac4ecaaea659276ee1de8df/R/convergence.R#L478-L496 + * + * @param chains matrix of draws across all chains + * @return mcse + */ + inline double mcse_sd(const Eigen::MatrixXd& chains) { + if (chains.rows() < 4 + || !is_finite_and_varies(chains)) + return std::numeric_limits::quiet_NaN(); + + Eigen::MatrixXd diffs = (chains.array() - chains.mean()).matrix(); + double Evar = diffs.array().square().mean(); + double varvar = (math::mean(diffs.array().pow(4) - Evar * Evar)) / ess(diffs.array().abs().matrix()); + return std::sqrt(varvar / Evar / 4); + } + +} // namespace analyze +} // namespace stan + +#endif diff --git a/src/stan/mcmc/chainset.hpp b/src/stan/mcmc/chainset.hpp index 264becb7f5..b1f735d344 100644 --- a/src/stan/mcmc/chainset.hpp +++ b/src/stan/mcmc/chainset.hpp @@ -7,6 +7,7 @@ #include #include #include +#include #include #include #include @@ -20,10 +21,9 @@ namespace stan { namespace mcmc { -using Eigen::Dynamic; /** - * An mcmc::chainset object manages the post-warmup draws + * A mcmc::chainset object manages the post-warmup draws * across a set of MCMC chains, which all have the same number of samples. * * @note samples are stored in column major, i.e., each column corresponds to @@ -290,7 +290,9 @@ class chainset { * Compute the quantile value of the specified parameter * at the specified probability. * - * Throws exception if specified probability is not between 0 and 1. + * Calls stan::math::quantile which throws + * std::invalid_argument If any element of samples_vec is NaN, or size 0. + * and std::domain_error If `p<0` or `p>1`. * * @param index parameter index * @param prob probability @@ -298,9 +300,6 @@ class chainset { */ double quantile(const int index, const double prob) const { // Ensure the probability is within [0, 1] - if (prob <= 0.0 || prob >= 1.0) { - throw std::out_of_range("Probability must be between 0 and 1."); - } Eigen::MatrixXd draws = samples(index); Eigen::Map map(draws.data(), draws.size()); return stan::math::quantile(map, prob); @@ -310,8 +309,6 @@ class chainset { * Compute the quantile value of the specified parameter * at the specified probability. * - * Throws exception if specified probability is not between 0 and 1. - * * @param name parameter name * @param prob probability * @return parameter value at quantile @@ -324,8 +321,6 @@ class chainset { * Compute the quantile values of the specified parameter * for a set of specified probabilities. * - * Throws exception if any probability is not between 0 and 1. - * * @param index parameter index * @param probs vector of probabilities * @return vector of parameter values for quantiles @@ -334,9 +329,6 @@ class chainset { const Eigen::VectorXd& probs) const { if (probs.size() == 0) return Eigen::VectorXd::Zero(0); - if (probs.minCoeff() <= 0.0 || probs.maxCoeff() >= 1.0) { - throw std::out_of_range("Probabilities must be between 0 and 1."); - } Eigen::MatrixXd draws = samples(index); Eigen::Map map(draws.data(), draws.size()); std::vector probs_vec(probs.data(), probs.data() + probs.size()); @@ -348,8 +340,6 @@ class chainset { * Compute the quantile values of the specified parameter * for a set of specified probabilities. * - * Throws exception if any probability is not between 0 and 1. - * * @param name parameter name * @param probs vector of probabilities * @return vector of parameter values for quantiles @@ -420,11 +410,12 @@ class chainset { * @return mcse */ double mcse_mean(const int index) const { - if (num_samples() < 4 - || !stan::analyze::is_finite_and_varies(samples(index))) - return std::numeric_limits::quiet_NaN(); - double ess = analyze::ess(samples(index)); - return sd(index) / std::sqrt(ess); + return analyze::mcse_mean(samples(index)); + // if (num_samples() < 4 + // || !stan::analyze::is_finite_and_varies(samples(index))) + // return std::numeric_limits::quiet_NaN(); + // double ess = analyze::ess(samples(index)); + // return sd(index) / std::sqrt(ess); } /** @@ -448,17 +439,18 @@ class chainset { * @return mcse_sd */ double mcse_sd(const int index) const { - if (num_samples() < 4 - || !stan::analyze::is_finite_and_varies(samples(index))) - return std::numeric_limits::quiet_NaN(); - Eigen::MatrixXd s = samples(index); - Eigen::MatrixXd s2 = s.array().square(); - double ess_s = analyze::ess(s); - double ess_s2 = analyze::ess(s2); - double ess_sd = std::min(ess_s, ess_s2); - return sd(index) - * std::sqrt(stan::math::e() * std::pow(1 - 1 / ess_sd, ess_sd - 1) - - 1); + return analyze::mcse_sd(samples(index)); + // if (num_samples() < 4 + // || !stan::analyze::is_finite_and_varies(samples(index))) + // return std::numeric_limits::quiet_NaN(); + // Eigen::MatrixXd s = samples(index); + // Eigen::MatrixXd s2 = s.array().square(); + // double ess_s = analyze::ess(s); + // double ess_s2 = analyze::ess(s2); + // double ess_sd = std::min(ess_s, ess_s2); + // return sd(index) + // * std::sqrt(stan::math::e() * std::pow(1 - 1 / ess_sd, ess_sd - 1) + // - 1); } /** diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 9662c3159c..5b8a371f94 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -189,8 +189,8 @@ TEST_F(McmcChains, split_rank_normalized_rhat) { for (size_t i = 0; i < 10; ++i) { auto rhats = chain_1.split_rank_normalized_rhat(i + 7); - EXPECT_NEAR(rhats.first, rhat_8_schools_1_bulk(i), 0.05); - EXPECT_NEAR(rhats.second, rhat_8_schools_1_tail(i), 0.05); + EXPECT_NEAR(rhats.first, rhat_8_schools_1_bulk(i), 0.04); + EXPECT_NEAR(rhats.second, rhat_8_schools_1_tail(i), 0.04); } } @@ -285,9 +285,9 @@ TEST_F(McmcChains, mcse) { for (size_t i = 0; i < 10; ++i) { auto mcse_mean = chain_2.mcse_mean(i + 7); - EXPECT_NEAR(mcse_mean, s8_mcse_mean(i), 0.5); auto mcse_sd = chain_2.mcse_sd(i + 7); - EXPECT_NEAR(mcse_sd, s8_mcse_sd(i), 0.7); + EXPECT_NEAR(mcse_mean, s8_mcse_mean(i), 0.05); + EXPECT_NEAR(mcse_sd, s8_mcse_sd(i), 0.09); } } @@ -329,6 +329,6 @@ TEST_F(McmcChains, autocorrelation) { 0.01791577080, 0.01245035817; auto mu_ac = chain_1.autocorrelation(0, "mu"); for (size_t i = 0; i < 10; ++i) { - EXPECT_NEAR(mu_ac_posterior(i), mu_ac(i), 0.05); + EXPECT_NEAR(mu_ac_posterior(i), mu_ac(i), 0.0005); } } From ead22cc6bfa256597db4d1d3ba2fac1a50133b24 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Wed, 16 Oct 2024 14:40:45 -0400 Subject: [PATCH 09/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/stan/analyze/mcmc/mcse.hpp | 75 +++++++++++++++++----------------- 1 file changed, 37 insertions(+), 38 deletions(-) diff --git a/src/stan/analyze/mcmc/mcse.hpp b/src/stan/analyze/mcmc/mcse.hpp index 9bd9aa8341..5584e9a7d7 100644 --- a/src/stan/analyze/mcmc/mcse.hpp +++ b/src/stan/analyze/mcmc/mcse.hpp @@ -11,44 +11,43 @@ namespace stan { namespace analyze { - - /** - * Computes the mean Monte Carlo error estimate for the central 90% interval. - * See https://arxiv.org/abs/1903.08008, section 4.4. - * Follows implementation in the R posterior package. - * - * @param chains matrix of draws across all chains - * @return mcse - */ - inline double mcse_mean(const Eigen::MatrixXd& chains) { - const Eigen::Index num_draws = chains.rows(); - if (chains.rows() < 4 - || !is_finite_and_varies(chains)) - return std::numeric_limits::quiet_NaN(); - - double sd = (chains.array() - chains.mean()).square().sum() / (chains.size() - 1); - return std::sqrt(sd / ess(chains)); - } - - /** - * Computes the standard deviation of the Monte Carlo error estimate - * https://arxiv.org/abs/1903.08008, section 4.4. - * Follows implementation in the R posterior package: - * https://github.com/stan-dev/posterior/blob/98bf52329d68f3307ac4ecaaea659276ee1de8df/R/convergence.R#L478-L496 - * - * @param chains matrix of draws across all chains - * @return mcse - */ - inline double mcse_sd(const Eigen::MatrixXd& chains) { - if (chains.rows() < 4 - || !is_finite_and_varies(chains)) - return std::numeric_limits::quiet_NaN(); - - Eigen::MatrixXd diffs = (chains.array() - chains.mean()).matrix(); - double Evar = diffs.array().square().mean(); - double varvar = (math::mean(diffs.array().pow(4) - Evar * Evar)) / ess(diffs.array().abs().matrix()); - return std::sqrt(varvar / Evar / 4); - } +/** + * Computes the mean Monte Carlo error estimate for the central 90% interval. + * See https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package. + * + * @param chains matrix of draws across all chains + * @return mcse + */ +inline double mcse_mean(const Eigen::MatrixXd& chains) { + const Eigen::Index num_draws = chains.rows(); + if (chains.rows() < 4 || !is_finite_and_varies(chains)) + return std::numeric_limits::quiet_NaN(); + + double sd + = (chains.array() - chains.mean()).square().sum() / (chains.size() - 1); + return std::sqrt(sd / ess(chains)); +} + +/** + * Computes the standard deviation of the Monte Carlo error estimate + * https://arxiv.org/abs/1903.08008, section 4.4. + * Follows implementation in the R posterior package: + * https://github.com/stan-dev/posterior/blob/98bf52329d68f3307ac4ecaaea659276ee1de8df/R/convergence.R#L478-L496 + * + * @param chains matrix of draws across all chains + * @return mcse + */ +inline double mcse_sd(const Eigen::MatrixXd& chains) { + if (chains.rows() < 4 || !is_finite_and_varies(chains)) + return std::numeric_limits::quiet_NaN(); + + Eigen::MatrixXd diffs = (chains.array() - chains.mean()).matrix(); + double Evar = diffs.array().square().mean(); + double varvar = (math::mean(diffs.array().pow(4) - Evar * Evar)) + / ess(diffs.array().abs().matrix()); + return std::sqrt(varvar / Evar / 4); +} } // namespace analyze } // namespace stan From 3534106d85e4e5f5b03b96ffd5454ead3238687f Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Wed, 16 Oct 2024 15:10:10 -0400 Subject: [PATCH 10/40] changes per code review --- src/test/unit/mcmc/chainset_test.cpp | 27 +++++++++++++-------------- 1 file changed, 13 insertions(+), 14 deletions(-) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 5b8a371f94..27b2cc52c0 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -238,34 +238,33 @@ TEST_F(McmcChains, summary_stats) { // test against R implementation in pkg posterior (via cmdstanr) Eigen::VectorXd s8_mean(10), s8_median(10), s8_sd(10), s8_mad(10), s8_q5(10), s8_q95(10); - s8_mean << 7.95, 12.54, 7.82, 5.33, 7.09, 4.12, 5.72, 11.65, 8.80, 8.26; - s8_median << 8.00, 11.27, 7.39, 5.44, 6.64, 4.54, 5.93, 11.38, 8.28, 7.05; - s8_sd << 5.48, 9.57, 6.85, 8.39, 6.91, 6.57, 6.85, 7.76, 8.40, 5.53; - s8_mad << 5.49, 8.79, 6.39, 7.38, 5.98, 6.25, 6.59, 7.79, 7.59, 4.66; - s8_q5 << -0.46, -0.39, -3.04, -8.90, -3.31, -7.58, -5.84, 0.10, -4.15, 2.08; - s8_q95 << 17.01, 30.47, 19.25, 19.02, 18.72, 14.49, 16.04, 25.77, 22.71, - 18.74; + s8_mean << 7.9521, 12.5353, 7.8192, 5.3280, 7.0912, 4.1186, 5.7168, 11.6524, 8.7999, 8.2576; + s8_median << 8.0022, 11.2668, 7.3903, 5.4445, 6.6407, 4.5394, 5.9275, 11.3828, 8.2815, 7.0482; + s8_sd << 5.4815, 9.5707, 6.8468, 8.3925, 6.9054, 6.5684, 6.8479, 7.7581, 8.3962, 5.5285; + s8_mad << 5.4883, 8.7866, 6.3884, 7.3821, 5.9796, 6.2451, 6.5869, 7.7937, 7.5919, 4.6552; + s8_q5 << -0.46348, -0.39469, -3.03780, -8.90229, -3.30596, -7.58377, -5.84182, 0.10131, -4.15281, 2.08010; + s8_q95 << 17.010, 30.466, 19.249, 19.018, 18.724, 14.486, 16.042, 25.769, 22.705, 18.742; Eigen::VectorXd probs(3); probs << 0.05, 0.5, 0.95; for (size_t i = 0; i < 10; ++i) { auto mean = chain_2.mean(i + 7); - EXPECT_NEAR(mean, s8_mean(i), 0.05); + EXPECT_NEAR(mean, s8_mean(i), 0.001); auto median = chain_2.median(i + 7); - EXPECT_NEAR(median, s8_median(i), 0.05); + EXPECT_NEAR(median, s8_median(i), 0.001); auto sd = chain_2.sd(i + 7); - EXPECT_NEAR(sd, s8_sd(i), 0.05); + EXPECT_NEAR(sd, s8_sd(i), 0.001); auto mad = chain_2.max_abs_deviation(i + 7); - EXPECT_NEAR(mad, s8_mad(i), 0.05); + EXPECT_NEAR(mad, s8_mad(i), 0.001); auto q_5 = chain_2.quantile(i + 7, 0.05); EXPECT_NEAR(q_5, s8_q5(i), 0.5); auto q_95 = chain_2.quantile(i + 7, 0.95); EXPECT_NEAR(q_95, s8_q95(i), 0.5); auto qs_5_50_95 = chain_2.quantiles(i + 7, probs); EXPECT_EQ(3, qs_5_50_95.size()); - EXPECT_NEAR(qs_5_50_95(0), s8_q5(i), 0.5); - EXPECT_NEAR(qs_5_50_95(1), s8_median(i), 0.05); - EXPECT_NEAR(qs_5_50_95(2), s8_q95(i), 0.5); + EXPECT_NEAR(qs_5_50_95(0), s8_q5(i), 0.001); + EXPECT_NEAR(qs_5_50_95(1), s8_median(i), 0.001); + EXPECT_NEAR(qs_5_50_95(2), s8_q95(i), 0.001); } } From 210ac05b4a9ad66360ff175836350c6539d8a89c Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Wed, 16 Oct 2024 15:10:51 -0400 Subject: [PATCH 11/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/mcmc/chainset_test.cpp | 18 ++++++++++++------ 1 file changed, 12 insertions(+), 6 deletions(-) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 27b2cc52c0..c334870899 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -238,12 +238,18 @@ TEST_F(McmcChains, summary_stats) { // test against R implementation in pkg posterior (via cmdstanr) Eigen::VectorXd s8_mean(10), s8_median(10), s8_sd(10), s8_mad(10), s8_q5(10), s8_q95(10); - s8_mean << 7.9521, 12.5353, 7.8192, 5.3280, 7.0912, 4.1186, 5.7168, 11.6524, 8.7999, 8.2576; - s8_median << 8.0022, 11.2668, 7.3903, 5.4445, 6.6407, 4.5394, 5.9275, 11.3828, 8.2815, 7.0482; - s8_sd << 5.4815, 9.5707, 6.8468, 8.3925, 6.9054, 6.5684, 6.8479, 7.7581, 8.3962, 5.5285; - s8_mad << 5.4883, 8.7866, 6.3884, 7.3821, 5.9796, 6.2451, 6.5869, 7.7937, 7.5919, 4.6552; - s8_q5 << -0.46348, -0.39469, -3.03780, -8.90229, -3.30596, -7.58377, -5.84182, 0.10131, -4.15281, 2.08010; - s8_q95 << 17.010, 30.466, 19.249, 19.018, 18.724, 14.486, 16.042, 25.769, 22.705, 18.742; + s8_mean << 7.9521, 12.5353, 7.8192, 5.3280, 7.0912, 4.1186, 5.7168, 11.6524, + 8.7999, 8.2576; + s8_median << 8.0022, 11.2668, 7.3903, 5.4445, 6.6407, 4.5394, 5.9275, 11.3828, + 8.2815, 7.0482; + s8_sd << 5.4815, 9.5707, 6.8468, 8.3925, 6.9054, 6.5684, 6.8479, 7.7581, + 8.3962, 5.5285; + s8_mad << 5.4883, 8.7866, 6.3884, 7.3821, 5.9796, 6.2451, 6.5869, 7.7937, + 7.5919, 4.6552; + s8_q5 << -0.46348, -0.39469, -3.03780, -8.90229, -3.30596, -7.58377, -5.84182, + 0.10131, -4.15281, 2.08010; + s8_q95 << 17.010, 30.466, 19.249, 19.018, 18.724, 14.486, 16.042, 25.769, + 22.705, 18.742; Eigen::VectorXd probs(3); probs << 0.05, 0.5, 0.95; From ada840722a41530e896669e790343fe0fd578534 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Thu, 17 Oct 2024 19:48:27 -0400 Subject: [PATCH 12/40] ess use stan::analyze::autocovariance, not stan::math --- .../mcmc/split_rank_normalized_ess.hpp | 15 +- .../mcmc/split_rank_normalized_ess_test.cpp | 79 +- .../analyze/mcmc/test_csv_files/bern1.csv | 1057 +++++++++++++++++ .../analyze/mcmc/test_csv_files/bern2.csv | 1057 +++++++++++++++++ .../analyze/mcmc/test_csv_files/bern3.csv | 1057 +++++++++++++++++ .../analyze/mcmc/test_csv_files/bern4.csv | 1057 +++++++++++++++++ 6 files changed, 4285 insertions(+), 37 deletions(-) create mode 100644 src/test/unit/analyze/mcmc/test_csv_files/bern1.csv create mode 100644 src/test/unit/analyze/mcmc/test_csv_files/bern2.csv create mode 100644 src/test/unit/analyze/mcmc/test_csv_files/bern3.csv create mode 100644 src/test/unit/analyze/mcmc/test_csv_files/bern4.csv diff --git a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp index 916b01369c..f13b73d69f 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp @@ -2,6 +2,7 @@ #define STAN_ANALYZE_MCMC_SPLIT_RANK_NORMALIZED_ESS_HPP #include +#include #include #include #include @@ -38,11 +39,12 @@ double ess(const Eigen::MatrixXd& chains) { // compute the per-chain autocovariance for (size_t i = 0; i < num_chains; ++i) { - Eigen::Map chain_col(chains.col(i).data(), + chain_mean(i) = chains.col(i).mean(); + Eigen::Map draw_col(chains.col(i).data(), num_draws); - Eigen::Map cov_col(acov.col(i).data(), num_draws); - stan::math::autocovariance(chain_col, cov_col); - chain_mean(i) = chain_col.mean(); + Eigen::VectorXd cov_col(num_draws); + autocovariance(draw_col, cov_col); + acov.col(i) = cov_col; chain_var(i) = cov_col(0) * num_draws / (num_draws - 1); } @@ -56,9 +58,12 @@ double ess(const Eigen::MatrixXd& chains) { // Geyer's initial positive sequence, eqn (11) Eigen::VectorXd rho_hat_t = Eigen::VectorXd::Zero(num_draws); Eigen::VectorXd acov_t(num_chains); + for (size_t i = 0; i < num_chains; ++i) { + acov_t(i) = acov(1, i); + } double rho_hat_even = 1.0; rho_hat_t(0) = rho_hat_even; // lag 0 - double rho_hat_odd = 1 - (w_chain_var - acov.row(1).mean()) / var_plus; + double rho_hat_odd = 1 - (w_chain_var - acov_t.mean()) / var_plus; rho_hat_t(1) = rho_hat_odd; // lag 1 // compute autocorrelation at lag t for pair (t, t+1) diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index a0fdf83cde..fa7cb42c94 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -1,3 +1,4 @@ +#include #include #include #include @@ -6,44 +7,58 @@ #include #include -TEST(RankNormalizedEss, test_bulk_tail_basic_ess) { - std::stringstream out; - std::ifstream eight_schools_1_stream, eight_schools_2_stream; - stan::io::stan_csv eight_schools_1, eight_schools_2; - eight_schools_1_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_1.csv", - std::ifstream::in); - eight_schools_1 - = stan::io::stan_csv_reader::parse(eight_schools_1_stream, &out); - eight_schools_1_stream.close(); - eight_schools_2_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_2.csv", - std::ifstream::in); - eight_schools_2 - = stan::io::stan_csv_reader::parse(eight_schools_2_stream, &out); - eight_schools_2_stream.close(); +TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { + std::stringstream out; + Eigen::MatrixXd chains_lp(1000, 4); + Eigen::MatrixXd chains_theta(1000, 4); - // test against R implementation in pkg posterior (via cmdstanr) - Eigen::VectorXd ess_8_schools_bulk(10); - ess_8_schools_bulk << 348, 370, 600, 638, 765, 608, 629, 274, 517, 112; - Eigen::VectorXd ess_8_schools_tail(10); - ess_8_schools_tail << 845, 858, 874, 726, 620, 753, 826, 628, 587, 108; - Eigen::VectorXd ess_8_schools_basic(10); - ess_8_schools_basic << 351, 403, 569, 646, 788, 602, 634, 262, 520, 223; + std::vector draws_theta(4); + std::vector draws_lp(4); + std::vector sizes(4); - Eigen::MatrixXd chains(eight_schools_1.samples.rows(), 2); - for (size_t i = 0; i < 10; ++i) { - chains.col(0) = eight_schools_1.samples.col(i + 7); - chains.col(1) = eight_schools_2.samples.col(i + 7); - auto ess = stan::analyze::split_rank_normalized_ess(chains); - EXPECT_NEAR(ess.first, ess_8_schools_bulk(i), 5); - EXPECT_NEAR(ess.second, ess_8_schools_tail(i), 5); - auto ess_basic = stan::analyze::ess(chains); - EXPECT_NEAR(ess_basic, ess_8_schools_basic(i), 5); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + draws_lp[i] = chains_lp.col(i).data(); + draws_theta[i] = chains_theta.col(i).data(); + sizes[i] = 1000; } + double ess_lp_expect = 1335.4137; + double ess_lp_bulk_expect = 1512.7684; + double ess_lp_tail_expect = 1591.9707; + + double ess_theta_expect = 1377.503; + double ess_theta_bulk_expect = 1407.5124; + double ess_theta_tail_expect = 1291.7131; + + auto ess_basic_lp = stan::analyze::ess(chains_lp); + auto old_ess_basic_lp = stan::analyze::compute_effective_sample_size(draws_lp, sizes); + auto ess_lp = stan::analyze::split_rank_normalized_ess(chains_lp); + + auto ess_basic_theta = stan::analyze::ess(chains_theta); + auto old_ess_basic_theta = stan::analyze::compute_effective_sample_size(draws_theta, sizes); + auto ess_theta = stan::analyze::split_rank_normalized_ess(chains_theta); + + EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 0.001); + EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 0.001); + + EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 0.00001); + EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 0.00001); + + EXPECT_NEAR(ess_lp_bulk_expect, ess_lp.first, 0.001); + EXPECT_NEAR(ess_lp_tail_expect, ess_lp.second, 0.001); + + EXPECT_NEAR(ess_theta_bulk_expect, ess_theta.first, 0.001); + EXPECT_NEAR(ess_theta_tail_expect, ess_theta.second, 0.001); } + TEST(RankNormalizedEss, short_chains_fail) { std::stringstream out; std::ifstream eight_schools_5iters_1_stream, eight_schools_5iters_2_stream; diff --git a/src/test/unit/analyze/mcmc/test_csv_files/bern1.csv b/src/test/unit/analyze/mcmc/test_csv_files/bern1.csv new file mode 100644 index 0000000000..4daa3fc0f7 --- /dev/null +++ b/src/test/unit/analyze/mcmc/test_csv_files/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/unit/analyze/mcmc/test_csv_files/bern2.csv b/src/test/unit/analyze/mcmc/test_csv_files/bern2.csv new file mode 100644 index 0000000000..a92c9624ac --- /dev/null +++ b/src/test/unit/analyze/mcmc/test_csv_files/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/unit/analyze/mcmc/test_csv_files/bern3.csv b/src/test/unit/analyze/mcmc/test_csv_files/bern3.csv new file mode 100644 index 0000000000..0f79beab7b --- /dev/null +++ b/src/test/unit/analyze/mcmc/test_csv_files/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/unit/analyze/mcmc/test_csv_files/bern4.csv b/src/test/unit/analyze/mcmc/test_csv_files/bern4.csv new file mode 100644 index 0000000000..0067fcc7e5 --- /dev/null +++ b/src/test/unit/analyze/mcmc/test_csv_files/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) +# From 9fed1913ecd0e8a5e5b2d6888fbf8d711bba9c1e Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Thu, 17 Oct 2024 19:49:11 -0400 Subject: [PATCH 13/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- .../analyze/mcmc/split_rank_normalized_ess.hpp | 3 +-- .../mcmc/split_rank_normalized_ess_test.cpp | 16 +++++++++------- 2 files changed, 10 insertions(+), 9 deletions(-) diff --git a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp index f13b73d69f..fc9fbea9e0 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp @@ -40,8 +40,7 @@ double ess(const Eigen::MatrixXd& chains) { // compute the per-chain autocovariance for (size_t i = 0; i < num_chains; ++i) { chain_mean(i) = chains.col(i).mean(); - Eigen::Map draw_col(chains.col(i).data(), - num_draws); + Eigen::Map draw_col(chains.col(i).data(), num_draws); Eigen::VectorXd cov_col(num_draws); autocovariance(draw_col, cov_col); acov.col(i) = cov_col; diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index fa7cb42c94..c3e28ae3d1 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -7,7 +7,6 @@ #include #include - TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { std::stringstream out; Eigen::MatrixXd chains_lp(1000, 4); @@ -19,9 +18,11 @@ TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; - fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) << ".csv"; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); - stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -36,13 +37,15 @@ TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { double ess_theta_expect = 1377.503; double ess_theta_bulk_expect = 1407.5124; double ess_theta_tail_expect = 1291.7131; - + auto ess_basic_lp = stan::analyze::ess(chains_lp); - auto old_ess_basic_lp = stan::analyze::compute_effective_sample_size(draws_lp, sizes); + auto old_ess_basic_lp + = stan::analyze::compute_effective_sample_size(draws_lp, sizes); auto ess_lp = stan::analyze::split_rank_normalized_ess(chains_lp); auto ess_basic_theta = stan::analyze::ess(chains_theta); - auto old_ess_basic_theta = stan::analyze::compute_effective_sample_size(draws_theta, sizes); + auto old_ess_basic_theta + = stan::analyze::compute_effective_sample_size(draws_theta, sizes); auto ess_theta = stan::analyze::split_rank_normalized_ess(chains_theta); EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 0.001); @@ -58,7 +61,6 @@ TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { EXPECT_NEAR(ess_theta_tail_expect, ess_theta.second, 0.001); } - TEST(RankNormalizedEss, short_chains_fail) { std::stringstream out; std::ifstream eight_schools_5iters_1_stream, eight_schools_5iters_2_stream; From 65f1c5719a0ac60173ac62b0b95a09c24fdd50bd Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Thu, 17 Oct 2024 21:53:21 -0400 Subject: [PATCH 14/40] update rhat test --- .../mcmc/split_rank_normalized_rhat_test.cpp | 66 ++++++++++++------- 1 file changed, 41 insertions(+), 25 deletions(-) diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp index f0a46f2530..e366d2bde4 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp @@ -1,40 +1,56 @@ +#include #include #include #include +#include #include #include #include #include -TEST(RankNormalizedRhat, compute_split_rank_normalized_rhat) { +TEST(RankNormalizedRhat, test_basic_bulk_tail_rhat) { std::stringstream out; - std::ifstream eight_schools_1_stream; - stan::io::stan_csv eight_schools_1; - eight_schools_1_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_1.csv", - std::ifstream::in); - eight_schools_1 - = stan::io::stan_csv_reader::parse(eight_schools_1_stream, &out); - eight_schools_1_stream.close(); - - // test against R implementation in pkg posterior - Eigen::VectorXd rhat_8_schools_1_bulk(10); - rhat_8_schools_1_bulk << 1.0012958313, 1.0046136496, 1.0085723580, - 1.0248629375, 1.0111456620, 1.0004458336, 0.9987162973, 1.0339773469, - 0.9985612618, 1.0281667351; + Eigen::MatrixXd chains_lp(1000, 4); + Eigen::MatrixXd chains_theta(1000, 4); - Eigen::VectorXd rhat_8_schools_1_tail(10); - rhat_8_schools_1_tail << 1.005676523, 1.009670999, 1.00184184, 1.002222679, - 1.004148161, 1.003218528, 1.009195353, 1.001426744, 1.003984381, - 1.025817745; + std::vector draws_theta(4); + std::vector draws_lp(4); + std::vector sizes(4); - Eigen::MatrixXd chains(eight_schools_1.samples.rows(), 1); - for (size_t i = 0; i < 10; ++i) { - chains.col(0) = eight_schools_1.samples.col(i + 7); - auto rhats = stan::analyze::split_rank_normalized_rhat(chains); - EXPECT_NEAR(rhats.first, rhat_8_schools_1_bulk(i), 0.05); - EXPECT_NEAR(rhats.second, rhat_8_schools_1_tail(i), 0.05); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + draws_lp[i] = chains_lp.col(i).data(); + draws_theta[i] = chains_theta.col(i).data(); + sizes[i] = 1000; } + double rhat_lp_basic_expect = 1.0001296; + double rhat_lp_new_expect = 1.0007301; + + double rhat_theta_basic_expect = 1.0029197; + double rhat_theta_new_expect = 1.0067897; + + auto rhat_basic_lp = stan::analyze::rhat(chains_lp); + auto old_rhat_basic_lp = stan::analyze::compute_potential_scale_reduction(draws_lp, sizes); + auto rhat_lp = stan::analyze::split_rank_normalized_rhat(chains_lp); + + auto rhat_basic_theta = stan::analyze::rhat(chains_theta); + auto old_rhat_basic_theta = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); + auto rhat_theta = stan::analyze::split_rank_normalized_rhat(chains_theta); + + EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 0.00001); + EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 0.00001); + + EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 0.00001); + EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 0.00001); + + EXPECT_NEAR(rhat_lp_new_expect, std::max(rhat_lp.first, rhat_lp.second), 0.00001); + EXPECT_NEAR(rhat_theta_new_expect, std::max(rhat_theta.first, rhat_theta.second), 0.00001); } TEST(RankNormalizedRhat, const_fail) { From c5e8934084dd622836d190d98e7fa892d43e5d7d Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Thu, 17 Oct 2024 21:54:00 -0400 Subject: [PATCH 15/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- .../mcmc/split_rank_normalized_rhat_test.cpp | 20 ++++++++++++------- 1 file changed, 13 insertions(+), 7 deletions(-) diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp index e366d2bde4..a1ca5629c4 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp @@ -19,9 +19,11 @@ TEST(RankNormalizedRhat, test_basic_bulk_tail_rhat) { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; - fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) << ".csv"; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); - stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -34,13 +36,15 @@ TEST(RankNormalizedRhat, test_basic_bulk_tail_rhat) { double rhat_theta_basic_expect = 1.0029197; double rhat_theta_new_expect = 1.0067897; - + auto rhat_basic_lp = stan::analyze::rhat(chains_lp); - auto old_rhat_basic_lp = stan::analyze::compute_potential_scale_reduction(draws_lp, sizes); + auto old_rhat_basic_lp + = stan::analyze::compute_potential_scale_reduction(draws_lp, sizes); auto rhat_lp = stan::analyze::split_rank_normalized_rhat(chains_lp); auto rhat_basic_theta = stan::analyze::rhat(chains_theta); - auto old_rhat_basic_theta = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); + auto old_rhat_basic_theta + = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); auto rhat_theta = stan::analyze::split_rank_normalized_rhat(chains_theta); EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 0.00001); @@ -49,8 +53,10 @@ TEST(RankNormalizedRhat, test_basic_bulk_tail_rhat) { EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 0.00001); EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 0.00001); - EXPECT_NEAR(rhat_lp_new_expect, std::max(rhat_lp.first, rhat_lp.second), 0.00001); - EXPECT_NEAR(rhat_theta_new_expect, std::max(rhat_theta.first, rhat_theta.second), 0.00001); + EXPECT_NEAR(rhat_lp_new_expect, std::max(rhat_lp.first, rhat_lp.second), + 0.00001); + EXPECT_NEAR(rhat_theta_new_expect, + std::max(rhat_theta.first, rhat_theta.second), 0.00001); } TEST(RankNormalizedRhat, const_fail) { From 3981d4c8f7f6689b5988cfb3c7704cbb806ccab8 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Fri, 18 Oct 2024 19:15:57 -0400 Subject: [PATCH 16/40] checkpointing --- src/stan/analyze/mcmc/ess.hpp | 103 ++++++++++++ src/stan/analyze/mcmc/mcse.hpp | 6 +- src/stan/analyze/mcmc/rhat.hpp | 50 ++++++ .../mcmc/split_rank_normalized_ess.hpp | 95 +---------- .../mcmc/split_rank_normalized_rhat.hpp | 45 +---- src/test/unit/analyze/mcmc/ess_basic_test.cpp | 49 ++++++ .../mcmc/split_rank_normalized_ess_test.cpp | 45 +++-- src/test/unit/mcmc/chainset_test.cpp | 155 ++++-------------- 8 files changed, 267 insertions(+), 281 deletions(-) create mode 100644 src/stan/analyze/mcmc/ess.hpp create mode 100644 src/stan/analyze/mcmc/rhat.hpp create mode 100644 src/test/unit/analyze/mcmc/ess_basic_test.cpp diff --git a/src/stan/analyze/mcmc/ess.hpp b/src/stan/analyze/mcmc/ess.hpp new file mode 100644 index 0000000000..ff2639c312 --- /dev/null +++ b/src/stan/analyze/mcmc/ess.hpp @@ -0,0 +1,103 @@ +#ifndef STAN_ANALYZE_MCMC_ESS_HPP +#define STAN_ANALYZE_MCMC_ESS_HPP + +#include +#include +#include +#include +#include +#include + +namespace stan { +namespace analyze { + +/** + * Computes the effective sample size (ESS) for the specified + * parameter across all chains. The number of draws per chain must be > 3, + * and the values across all draws must be finite and not constant. + * The value returned is the minimum of ESS and (sample_sz * log10(sample_sz). + * Sample autocovariance is computed using Stan math library implmentation. + * See https://arxiv.org/abs/1903.08008, section 3.2 for discussion. + * + * @param chains matrix of draws across all chains + * @return effective sample size for the specified parameter + */ +double ess(const Eigen::MatrixXd& chains) { + const Eigen::Index num_chains = chains.cols(); + const Eigen::Index draws_per_chain = chains.rows(); + Eigen::MatrixXd acov(draws_per_chain, num_chains); + Eigen::VectorXd chain_mean(num_chains); + Eigen::VectorXd chain_var(num_chains); + + // compute the per-chain autocovariance + for (size_t i = 0; i < num_chains; ++i) { + chain_mean(i) = chains.col(i).mean(); + Eigen::Map draw_col(chains.col(i).data(), draws_per_chain); + Eigen::VectorXd cov_col(draws_per_chain); + autocovariance(draw_col, cov_col); + acov.col(i) = cov_col; + chain_var(i) = cov_col(0) * draws_per_chain / (draws_per_chain - 1); + } + + // compute var_plus, eqn (3) + double w_chain_var = math::mean(chain_var); // W (within chain var) + double var_plus = w_chain_var * (draws_per_chain - 1) / draws_per_chain; // \hat{var}^{+} + if (num_chains > 1) { + var_plus += math::variance(chain_mean); // B (between chain var) + } + + // Geyer's initial positive sequence, eqn (11) + Eigen::VectorXd rho_hat_t = Eigen::VectorXd::Zero(draws_per_chain); + double rho_hat_even = 1.0; + rho_hat_t(0) = rho_hat_even; // lag 0 + + Eigen::VectorXd acov_t(num_chains); + for (size_t i = 0; i < num_chains; ++i) { + acov_t(i) = acov(1, i); + } + double rho_hat_odd = 1 - (w_chain_var - acov_t.mean()) / var_plus; + rho_hat_t(1) = rho_hat_odd; // lag 1 + + // compute autocorrelation at lag t for pair (t, t+1) + // paired autocorrelation is guaranteed to be positive, monotone and convex + size_t t = 1; + while (t < draws_per_chain - 4 && (rho_hat_even + rho_hat_odd > 0) + && !std::isnan(rho_hat_even + rho_hat_odd)) { + for (size_t i = 0; i < num_chains; ++i) { + acov_t(i) = acov.col(i)(t + 1); + } + rho_hat_even = 1 - (w_chain_var - acov_t.mean()) / var_plus; + for (size_t i = 0; i < num_chains; ++i) { + acov_t(i) = acov.col(i)(t + 2); + } + rho_hat_odd = 1 - (w_chain_var - acov_t.mean()) / var_plus; + if ((rho_hat_even + rho_hat_odd) >= 0) { + rho_hat_t(t + 1) = rho_hat_even; + rho_hat_t(t + 2) = rho_hat_odd; + } + // convert initial positive sequence into an initial monotone sequence + if (rho_hat_t(t + 1) + rho_hat_t(t + 2) > rho_hat_t(t - 1) + rho_hat_t(t)) { + rho_hat_t(t + 1) = (rho_hat_t(t - 1) + rho_hat_t(t)) / 2; + rho_hat_t(t + 2) = rho_hat_t(t + 1); + } + t += 2; + } + + auto max_t = t; // max lag, used for truncation + // see discussion p. 8, par "In extreme antithetic cases, " + if (rho_hat_even > 0) { + rho_hat_t(max_t + 1) = rho_hat_even; + } + + double draws_total = num_chains * draws_per_chain; + // eqn (13): Geyer's truncation rule, w/ modification + double tau_hat = -1 + 2 * rho_hat_t.head(max_t).sum() + rho_hat_t(max_t + 1); + // safety check for negative values and with max ess equal to ess*log10(ess) + tau_hat = std::max(tau_hat, 1 / std::log10(draws_total)); + return (draws_total / tau_hat); +} + +} // namespace analyze +} // namespace stan + +#endif diff --git a/src/stan/analyze/mcmc/mcse.hpp b/src/stan/analyze/mcmc/mcse.hpp index 5584e9a7d7..6481796b72 100644 --- a/src/stan/analyze/mcmc/mcse.hpp +++ b/src/stan/analyze/mcmc/mcse.hpp @@ -2,11 +2,11 @@ #define STAN_ANALYZE_MCMC_MCSE_HPP #include -#include +#include #include #include -#include -#include +#include +#include namespace stan { namespace analyze { diff --git a/src/stan/analyze/mcmc/rhat.hpp b/src/stan/analyze/mcmc/rhat.hpp new file mode 100644 index 0000000000..ed5ed5cfc7 --- /dev/null +++ b/src/stan/analyze/mcmc/rhat.hpp @@ -0,0 +1,50 @@ +#ifndef STAN_ANALYZE_MCMC_RHAT_HPP +#define STAN_ANALYZE_MCMC_RHAT_HPP + +#include +#include +#include +#include +#include + +namespace stan { +namespace analyze { + +/** + * Computes square root of marginal posterior variance of the estimand by the + * weighted average of within-chain variance W and between-chain variance B. + * + * @param chains stores chains in columns + * @return square root of ((N-1)/N)W + B/N + */ +inline double rhat(const Eigen::MatrixXd& chains) { + const Eigen::Index num_chains = chains.cols(); + const Eigen::Index num_draws = chains.rows(); + + Eigen::RowVectorXd within_chain_means = chains.colwise().mean(); + double across_chain_mean = within_chain_means.mean(); + double between_variance + = num_draws + * (within_chain_means.array() - across_chain_mean).square().sum() + / (num_chains - 1); + double within_variance = + // Divide each row by chains and get sum of squares for each chain + // (getting a vector back) + ((chains.rowwise() - within_chain_means) + .array() + .square() + .colwise() + // divide each sum of square by num_draws, sum the sum of squares, + // and divide by num chains + .sum() + / (num_draws - 1.0)) + .sum() + / num_chains; + + return sqrt((between_variance / within_variance + num_draws - 1) / num_draws); +} + +} // namespace analyze +} // namespace stan + +#endif diff --git a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp index fc9fbea9e0..e0c6316cc7 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_ess.hpp @@ -2,108 +2,15 @@ #define STAN_ANALYZE_MCMC_SPLIT_RANK_NORMALIZED_ESS_HPP #include -#include +#include #include #include #include -#include -#include -#include -#include -#include -#include -#include #include -#include namespace stan { namespace analyze { -/** - * Computes the effective sample size (ESS) for the specified - * parameter across all chains. The number of draws per chain must be > 3, - * and the values across all draws must be finite and not constant. - * The value returned is the minimum of ESS and (sample_sz * log10(sample_sz). - * Sample autocovariance is computed using Stan math library implmentation. - * See https://arxiv.org/abs/1903.08008, section 3.2 for discussion. - * - * @param chains matrix of draws across all chains - * @return effective sample size for the specified parameter - */ -double ess(const Eigen::MatrixXd& chains) { - const Eigen::Index num_chains = chains.cols(); - const Eigen::Index num_draws = chains.rows(); - Eigen::MatrixXd acov(num_draws, num_chains); - Eigen::VectorXd chain_mean(num_chains); - Eigen::VectorXd chain_var(num_chains); - - // compute the per-chain autocovariance - for (size_t i = 0; i < num_chains; ++i) { - chain_mean(i) = chains.col(i).mean(); - Eigen::Map draw_col(chains.col(i).data(), num_draws); - Eigen::VectorXd cov_col(num_draws); - autocovariance(draw_col, cov_col); - acov.col(i) = cov_col; - chain_var(i) = cov_col(0) * num_draws / (num_draws - 1); - } - - // compute var_plus, eqn (3) - double w_chain_var = math::mean(chain_var); // W (within chain var) - double var_plus = w_chain_var * (num_draws - 1) / num_draws; // \hat{var}^{+} - if (num_chains > 1) { - var_plus += math::variance(chain_mean); // B (between chain var) - } - - // Geyer's initial positive sequence, eqn (11) - Eigen::VectorXd rho_hat_t = Eigen::VectorXd::Zero(num_draws); - Eigen::VectorXd acov_t(num_chains); - for (size_t i = 0; i < num_chains; ++i) { - acov_t(i) = acov(1, i); - } - double rho_hat_even = 1.0; - rho_hat_t(0) = rho_hat_even; // lag 0 - double rho_hat_odd = 1 - (w_chain_var - acov_t.mean()) / var_plus; - rho_hat_t(1) = rho_hat_odd; // lag 1 - - // compute autocorrelation at lag t for pair (t, t+1) - // paired autocorrelation is guaranteed to be positive, monotone and convex - size_t t = 1; - while (t < num_draws - 4 && (rho_hat_even + rho_hat_odd > 0) - && !std::isnan(rho_hat_even + rho_hat_odd)) { - for (size_t i = 0; i < num_chains; ++i) { - acov_t(i) = acov.col(i)(t + 1); - } - rho_hat_even = 1 - (w_chain_var - acov_t.mean()) / var_plus; - for (size_t i = 0; i < num_chains; ++i) { - acov_t(i) = acov.col(i)(t + 2); - } - rho_hat_odd = 1 - (w_chain_var - acov_t.mean()) / var_plus; - if ((rho_hat_even + rho_hat_odd) >= 0) { - rho_hat_t(t + 1) = rho_hat_even; - rho_hat_t(t + 2) = rho_hat_odd; - } - // convert initial positive sequence into an initial monotone sequence - if (rho_hat_t(t + 1) + rho_hat_t(t + 2) > rho_hat_t(t - 1) + rho_hat_t(t)) { - rho_hat_t(t + 1) = (rho_hat_t(t - 1) + rho_hat_t(t)) / 2; - rho_hat_t(t + 2) = rho_hat_t(t + 1); - } - t += 2; - } - - auto max_t = t; // max lag, used for truncation - // see discussion p. 8, par "In extreme antithetic cases, " - if (rho_hat_even > 0) { - rho_hat_t(max_t + 1) = rho_hat_even; - } - - double num_samples = num_chains * num_draws; - // eqn (13): Geyer's truncation rule, w/ modification - double tau_hat = -1 + 2 * rho_hat_t.head(max_t).sum() + rho_hat_t(max_t + 1); - // safety check for negative values and with max ess equal to ess*log10(ess) - tau_hat = std::max(tau_hat, 1 / std::log10(num_samples)); - return (num_samples / tau_hat); -} - /** * Computes the split effective sample size (split ESS) using rank based * diagnostic for a set of per-chain draws. Based on paper diff --git a/src/stan/analyze/mcmc/split_rank_normalized_rhat.hpp b/src/stan/analyze/mcmc/split_rank_normalized_rhat.hpp index b071668801..50cce0b64d 100644 --- a/src/stan/analyze/mcmc/split_rank_normalized_rhat.hpp +++ b/src/stan/analyze/mcmc/split_rank_normalized_rhat.hpp @@ -1,56 +1,17 @@ #ifndef STAN_ANALYZE_MCMC_SPLIT_RANK_NORMALIZED_RHAT_HPP #define STAN_ANALYZE_MCMC_SPLIT_RANK_NORMALIZED_RHAT_HPP -#include #include #include +#include #include -#include -#include -#include -#include -#include -#include -#include +#include #include +#include namespace stan { namespace analyze { -/** - * Computes square root of marginal posterior variance of the estimand by the - * weighted average of within-chain variance W and between-chain variance B. - * - * @param chains stores chains in columns - * @return square root of ((N-1)/N)W + B/N - */ -inline double rhat(const Eigen::MatrixXd& chains) { - const Eigen::Index num_chains = chains.cols(); - const Eigen::Index num_draws = chains.rows(); - - Eigen::RowVectorXd within_chain_means = chains.colwise().mean(); - double across_chain_mean = within_chain_means.mean(); - double between_variance - = num_draws - * (within_chain_means.array() - across_chain_mean).square().sum() - / (num_chains - 1); - double within_variance = - // Divide each row by chains and get sum of squares for each chain - // (getting a vector back) - ((chains.rowwise() - within_chain_means) - .array() - .square() - .colwise() - // divide each sum of square by num_draws, sum the sum of squares, - // and divide by num chains - .sum() - / (num_draws - 1.0)) - .sum() - / num_chains; - - return sqrt((between_variance / within_variance + num_draws - 1) / num_draws); -} - /** * Computes the split potential scale reduction (split Rhat) using rank based * diagnostic for a set of per-chain draws. Based on paper diff --git a/src/test/unit/analyze/mcmc/ess_basic_test.cpp b/src/test/unit/analyze/mcmc/ess_basic_test.cpp new file mode 100644 index 0000000000..8d43ce9217 --- /dev/null +++ b/src/test/unit/analyze/mcmc/ess_basic_test.cpp @@ -0,0 +1,49 @@ +#include +#include +#include +#include +#include +#include +#include +#include + +TEST(RankNormalizedEss, test_basic_ess) { + std::stringstream out; + Eigen::MatrixXd chains_lp(1000, 4); + Eigen::MatrixXd chains_theta(1000, 4); + + std::vector draws_theta(4); + std::vector draws_lp(4); + std::vector sizes(4); + + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + draws_lp[i] = chains_lp.col(i).data(); + draws_theta[i] = chains_theta.col(i).data(); + sizes[i] = 1000; + } + double ess_lp_expect = 1335.4137; + double ess_theta_expect = 1377.503; + + auto ess_basic_lp = stan::analyze::ess(chains_lp); + auto old_ess_basic_lp + = stan::analyze::compute_effective_sample_size(draws_lp, sizes); + + auto ess_basic_theta = stan::analyze::ess(chains_theta); + auto old_ess_basic_theta + = stan::analyze::compute_effective_sample_size(draws_theta, sizes); + + EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 0.0001); + EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 0.0001); + + EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 0.00001); + EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 0.00001); +} diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index c3e28ae3d1..ac52cf99db 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -1,4 +1,3 @@ -#include #include #include #include @@ -7,7 +6,7 @@ #include #include -TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { +TEST(RankNormalizedEss, test_bulk_tail_ess) { std::stringstream out; Eigen::MatrixXd chains_lp(1000, 4); Eigen::MatrixXd chains_theta(1000, 4); @@ -30,30 +29,15 @@ TEST(RankNormalizedEss, test_basic_bulk_tail_ess) { draws_theta[i] = chains_theta.col(i).data(); sizes[i] = 1000; } - double ess_lp_expect = 1335.4137; double ess_lp_bulk_expect = 1512.7684; double ess_lp_tail_expect = 1591.9707; - double ess_theta_expect = 1377.503; double ess_theta_bulk_expect = 1407.5124; double ess_theta_tail_expect = 1291.7131; - auto ess_basic_lp = stan::analyze::ess(chains_lp); - auto old_ess_basic_lp - = stan::analyze::compute_effective_sample_size(draws_lp, sizes); auto ess_lp = stan::analyze::split_rank_normalized_ess(chains_lp); - - auto ess_basic_theta = stan::analyze::ess(chains_theta); - auto old_ess_basic_theta - = stan::analyze::compute_effective_sample_size(draws_theta, sizes); auto ess_theta = stan::analyze::split_rank_normalized_ess(chains_theta); - EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 0.001); - EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 0.001); - - EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 0.00001); - EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 0.00001); - EXPECT_NEAR(ess_lp_bulk_expect, ess_lp.first, 0.001); EXPECT_NEAR(ess_lp_tail_expect, ess_lp.second, 0.001); @@ -87,3 +71,30 @@ TEST(RankNormalizedEss, short_chains_fail) { EXPECT_TRUE(std::isnan(ess.second)); } } + +TEST(RankNormalizedEss, const_fail) { + std::stringstream out; + std::ifstream bernoulli_const_1_stream, bernoulli_const_2_stream; + stan::io::stan_csv bernoulli_const_1, bernoulli_const_2; + bernoulli_const_1_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv", + std::ifstream::in); + bernoulli_const_1 + = stan::io::stan_csv_reader::parse(bernoulli_const_1_stream, &out); + bernoulli_const_1_stream.close(); + bernoulli_const_2_stream.open( + "src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv", + std::ifstream::in); + bernoulli_const_2 + = stan::io::stan_csv_reader::parse(bernoulli_const_2_stream, &out); + bernoulli_const_2_stream.close(); + + Eigen::MatrixXd chains(bernoulli_const_1.samples.rows(), 2); + chains.col(0) + = bernoulli_const_1.samples.col(bernoulli_const_1.samples.cols() - 1); + chains.col(1) + = bernoulli_const_2.samples.col(bernoulli_const_2.samples.cols() - 1); + auto ess = stan::analyze::split_rank_normalized_ess(chains); + EXPECT_TRUE(std::isnan(ess.first)); + EXPECT_TRUE(std::isnan(ess.second)); +} diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index c334870899..05e1f40979 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -172,106 +172,38 @@ TEST_F(McmcChains, eight_schools_samples) { EXPECT_THROW(chain_2.samples("foo"), std::invalid_argument); } -TEST_F(McmcChains, split_rank_normalized_rhat) { - stan::mcmc::chainset chain_1(eight_schools_1); - EXPECT_EQ(1, chain_1.num_chains()); - - // test against R implementation in pkg posterior - Eigen::VectorXd rhat_8_schools_1_bulk(10); - rhat_8_schools_1_bulk << 1.0012958313, 1.0046136496, 1.0085723580, - 1.0248629375, 1.0111456620, 1.0004458336, 0.9987162973, 1.0339773469, - 0.9985612618, 1.0281667351; - - Eigen::VectorXd rhat_8_schools_1_tail(10); - rhat_8_schools_1_tail << 1.005676523, 1.009670999, 1.00184184, 1.002222679, - 1.004148161, 1.003218528, 1.009195353, 1.001426744, 1.003984381, - 1.025817745; - - for (size_t i = 0; i < 10; ++i) { - auto rhats = chain_1.split_rank_normalized_rhat(i + 7); - EXPECT_NEAR(rhats.first, rhat_8_schools_1_bulk(i), 0.04); - EXPECT_NEAR(rhats.second, rhat_8_schools_1_tail(i), 0.04); - } -} - -TEST_F(McmcChains, split_rank_normalized_ess) { - std::vector eight_schools; - eight_schools.push_back(eight_schools_1); - eight_schools.push_back(eight_schools_2); - stan::mcmc::chainset chain_2(eight_schools); - EXPECT_EQ(2, chain_2.num_chains()); - - // test against R implementation in pkg posterior (via cmdstanr) - Eigen::VectorXd ess_8_schools_bulk(10); - ess_8_schools_bulk << 348, 370, 600, 638, 765, 608, 629, 274, 517, 112; - Eigen::VectorXd ess_8_schools_tail(10); - ess_8_schools_tail << 845, 858, 874, 726, 620, 753, 826, 628, 587, 108; - - for (size_t i = 0; i < 10; ++i) { - auto ess = chain_2.split_rank_normalized_ess(i + 7); - EXPECT_NEAR(ess.first, ess_8_schools_bulk(i), 5); - EXPECT_NEAR(ess.second, ess_8_schools_tail(i), 5); - } -} - -TEST_F(McmcChains, ess_short_chains) { - std::vector eight_schools_5iters; - eight_schools_5iters.push_back(eight_schools_5iters_1); - eight_schools_5iters.push_back(eight_schools_5iters_2); - stan::mcmc::chainset chain_2(eight_schools_5iters); - EXPECT_EQ(2, chain_2.num_chains()); - - for (size_t i = 0; i < 10; ++i) { - auto ess = chain_2.split_rank_normalized_ess(i + 7); - EXPECT_TRUE(std::isnan(ess.first)); - EXPECT_TRUE(std::isnan(ess.second)); - } -} - TEST_F(McmcChains, summary_stats) { - std::vector eight_schools; - eight_schools.push_back(eight_schools_1); - eight_schools.push_back(eight_schools_2); - stan::mcmc::chainset chain_2(eight_schools); - EXPECT_EQ(2, chain_2.num_chains()); - - // test against R implementation in pkg posterior (via cmdstanr) - Eigen::VectorXd s8_mean(10), s8_median(10), s8_sd(10), s8_mad(10), s8_q5(10), - s8_q95(10); - s8_mean << 7.9521, 12.5353, 7.8192, 5.3280, 7.0912, 4.1186, 5.7168, 11.6524, - 8.7999, 8.2576; - s8_median << 8.0022, 11.2668, 7.3903, 5.4445, 6.6407, 4.5394, 5.9275, 11.3828, - 8.2815, 7.0482; - s8_sd << 5.4815, 9.5707, 6.8468, 8.3925, 6.9054, 6.5684, 6.8479, 7.7581, - 8.3962, 5.5285; - s8_mad << 5.4883, 8.7866, 6.3884, 7.3821, 5.9796, 6.2451, 6.5869, 7.7937, - 7.5919, 4.6552; - s8_q5 << -0.46348, -0.39469, -3.03780, -8.90229, -3.30596, -7.58377, -5.84182, - 0.10131, -4.15281, 2.08010; - s8_q95 << 17.010, 30.466, 19.249, 19.018, 18.724, 14.486, 16.042, 25.769, - 22.705, 18.742; - Eigen::VectorXd probs(3); - probs << 0.05, 0.5, 0.95; - - for (size_t i = 0; i < 10; ++i) { - auto mean = chain_2.mean(i + 7); - EXPECT_NEAR(mean, s8_mean(i), 0.001); - auto median = chain_2.median(i + 7); - EXPECT_NEAR(median, s8_median(i), 0.001); - auto sd = chain_2.sd(i + 7); - EXPECT_NEAR(sd, s8_sd(i), 0.001); - auto mad = chain_2.max_abs_deviation(i + 7); - EXPECT_NEAR(mad, s8_mad(i), 0.001); - auto q_5 = chain_2.quantile(i + 7, 0.05); - EXPECT_NEAR(q_5, s8_q5(i), 0.5); - auto q_95 = chain_2.quantile(i + 7, 0.95); - EXPECT_NEAR(q_95, s8_q95(i), 0.5); - auto qs_5_50_95 = chain_2.quantiles(i + 7, probs); - EXPECT_EQ(3, qs_5_50_95.size()); - EXPECT_NEAR(qs_5_50_95(0), s8_q5(i), 0.001); - EXPECT_NEAR(qs_5_50_95(1), s8_median(i), 0.001); - EXPECT_NEAR(qs_5_50_95(2), s8_q95(i), 0.001); + std::stringstream out; + std::vector bern_csvs(4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + bern_csvs[i] = bern_csv; } + stan::mcmc::chainset bern_chains(bern_csvs); + EXPECT_EQ(4, bern_chains.num_chains()); + // mean + // median + // sd + // max abs deviation + // mcse_mean + // mcse_sd + // q1 + // q5 + // q95 + // q99 + // q0 + // q100 + // rhat + // rhat_basic + // ess_bulk, tail + // ess_basic + // autocovariance } TEST_F(McmcChains, mcse) { @@ -296,33 +228,6 @@ TEST_F(McmcChains, mcse) { } } -TEST_F(McmcChains, const_fail) { - std::ifstream bernoulli_const_1_stream, bernoulli_const_2_stream; - stan::io::stan_csv bernoulli_const_1, bernoulli_const_2; - bernoulli_const_1_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv", - std::ifstream::in); - bernoulli_const_1 - = stan::io::stan_csv_reader::parse(bernoulli_const_1_stream, &out); - bernoulli_const_1_stream.close(); - bernoulli_const_2_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv", - std::ifstream::in); - bernoulli_const_2 - = stan::io::stan_csv_reader::parse(bernoulli_const_2_stream, &out); - bernoulli_const_2_stream.close(); - std::vector bernoulli_const; - bernoulli_const.push_back(bernoulli_const_1); - bernoulli_const.push_back(bernoulli_const_2); - stan::mcmc::chainset chain_2(bernoulli_const); - EXPECT_EQ(2, chain_2.num_chains()); - auto rhat = chain_2.split_rank_normalized_rhat("zeta"); - EXPECT_TRUE(std::isnan(rhat.first)); - EXPECT_TRUE(std::isnan(rhat.second)); - auto ess = chain_2.split_rank_normalized_ess("zeta"); - EXPECT_TRUE(std::isnan(ess.first)); - EXPECT_TRUE(std::isnan(ess.second)); -} TEST_F(McmcChains, autocorrelation) { stan::mcmc::chainset chain_1(eight_schools_1); From d29e5f933bf41981f9c4fb3a3bcc7f1ea8c44215 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Fri, 18 Oct 2024 19:16:31 -0400 Subject: [PATCH 17/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/stan/analyze/mcmc/ess.hpp | 6 ++++-- src/test/unit/mcmc/chainset_test.cpp | 1 - 2 files changed, 4 insertions(+), 3 deletions(-) diff --git a/src/stan/analyze/mcmc/ess.hpp b/src/stan/analyze/mcmc/ess.hpp index ff2639c312..49070894ba 100644 --- a/src/stan/analyze/mcmc/ess.hpp +++ b/src/stan/analyze/mcmc/ess.hpp @@ -32,7 +32,8 @@ double ess(const Eigen::MatrixXd& chains) { // compute the per-chain autocovariance for (size_t i = 0; i < num_chains; ++i) { chain_mean(i) = chains.col(i).mean(); - Eigen::Map draw_col(chains.col(i).data(), draws_per_chain); + Eigen::Map draw_col(chains.col(i).data(), + draws_per_chain); Eigen::VectorXd cov_col(draws_per_chain); autocovariance(draw_col, cov_col); acov.col(i) = cov_col; @@ -41,7 +42,8 @@ double ess(const Eigen::MatrixXd& chains) { // compute var_plus, eqn (3) double w_chain_var = math::mean(chain_var); // W (within chain var) - double var_plus = w_chain_var * (draws_per_chain - 1) / draws_per_chain; // \hat{var}^{+} + double var_plus + = w_chain_var * (draws_per_chain - 1) / draws_per_chain; // \hat{var}^{+} if (num_chains > 1) { var_plus += math::variance(chain_mean); // B (between chain var) } diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 05e1f40979..451b39cc9c 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -228,7 +228,6 @@ TEST_F(McmcChains, mcse) { } } - TEST_F(McmcChains, autocorrelation) { stan::mcmc::chainset chain_1(eight_schools_1); EXPECT_EQ(1, chain_1.num_chains()); From 99e8f71ba62d15fea66324722eb41d6ea7abebb9 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Sat, 19 Oct 2024 14:57:01 -0400 Subject: [PATCH 18/40] refactored analyze/mcmc fns and unit tests --- src/stan/analyze/mcmc/mcse.hpp | 22 +++- src/test/unit/analyze/mcmc/ess_basic_test.cpp | 55 ++++++---- src/test/unit/analyze/mcmc/mcse_test.cpp | 72 ++++++++++++ .../unit/analyze/mcmc/rhat_basic_test.cpp | 61 +++++++++++ .../mcmc/split_rank_normalized_ess_test.cpp | 90 +++++++-------- .../mcmc/split_rank_normalized_rhat_test.cpp | 103 +++++++----------- 6 files changed, 266 insertions(+), 137 deletions(-) create mode 100644 src/test/unit/analyze/mcmc/mcse_test.cpp create mode 100644 src/test/unit/analyze/mcmc/rhat_basic_test.cpp diff --git a/src/stan/analyze/mcmc/mcse.hpp b/src/stan/analyze/mcmc/mcse.hpp index 6481796b72..f8789fb670 100644 --- a/src/stan/analyze/mcmc/mcse.hpp +++ b/src/stan/analyze/mcmc/mcse.hpp @@ -2,6 +2,7 @@ #define STAN_ANALYZE_MCMC_MCSE_HPP #include +#include #include #include #include @@ -42,11 +43,22 @@ inline double mcse_sd(const Eigen::MatrixXd& chains) { if (chains.rows() < 4 || !is_finite_and_varies(chains)) return std::numeric_limits::quiet_NaN(); - Eigen::MatrixXd diffs = (chains.array() - chains.mean()).matrix(); - double Evar = diffs.array().square().mean(); - double varvar = (math::mean(diffs.array().pow(4) - Evar * Evar)) - / ess(diffs.array().abs().matrix()); - return std::sqrt(varvar / Evar / 4); + // center the data, take abs value + Eigen::MatrixXd draws_ctr = (chains.array() - chains.mean()).abs().matrix(); + + // posterior pkg fn `ess_mean` computes on split chains + double ess_mean = ess(split_chains(draws_ctr)); + + // estimated variance (2nd moment) + double Evar = draws_ctr.array().square().mean(); + + // variance of variance, adjusted for ESS + double fourth_moment = draws_ctr.array().pow(4).mean(); + double varvar = (fourth_moment - std::pow(Evar, 2)) / ess_mean; + + // variance of standard deviation - use Taylor series approximation + double varsd = varvar / Evar / 4.0; + return std::sqrt(varsd); } } // namespace analyze diff --git a/src/test/unit/analyze/mcmc/ess_basic_test.cpp b/src/test/unit/analyze/mcmc/ess_basic_test.cpp index 8d43ce9217..d02c91d41d 100644 --- a/src/test/unit/analyze/mcmc/ess_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/ess_basic_test.cpp @@ -7,29 +7,42 @@ #include #include -TEST(RankNormalizedEss, test_basic_ess) { - std::stringstream out; - Eigen::MatrixXd chains_lp(1000, 4); - Eigen::MatrixXd chains_theta(1000, 4); - - std::vector draws_theta(4); - std::vector draws_lp(4); - std::vector sizes(4); - - for (size_t i = 0; i < 4; ++i) { - std::stringstream fname; - fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; - std::ifstream bern_stream(fname.str(), std::ifstream::in); - stan::io::stan_csv bern_csv +class EssBasic : public testing::Test { +public: + void SetUp() { + chains_lp.resize(1000, 4); + chains_theta.resize(1000, 4); + draws_theta.resize(4); + draws_lp.resize(4); + sizes.resize(4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); - bern_stream.close(); - chains_lp.col(i) = bern_csv.samples.col(0); - chains_theta.col(i) = bern_csv.samples.col(7); - draws_lp[i] = chains_lp.col(i).data(); - draws_theta[i] = chains_theta.col(i).data(); - sizes[i] = 1000; + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + draws_lp[i] = chains_lp.col(i).data(); + draws_theta[i] = chains_theta.col(i).data(); + sizes[i] = 1000; + } + } + + void TearDown() { } + + std::stringstream out; + Eigen::MatrixXd chains_lp; + Eigen::MatrixXd chains_theta; + std::vector draws_theta; + std::vector draws_lp; + std::vector sizes; +}; + +TEST_F(EssBasic, test_basic_ess) { double ess_lp_expect = 1335.4137; double ess_theta_expect = 1377.503; diff --git a/src/test/unit/analyze/mcmc/mcse_test.cpp b/src/test/unit/analyze/mcmc/mcse_test.cpp new file mode 100644 index 0000000000..1fffd81fe9 --- /dev/null +++ b/src/test/unit/analyze/mcmc/mcse_test.cpp @@ -0,0 +1,72 @@ +#include +#include +#include +#include +#include +#include +#include + +class MonteCarloStandardError : public testing::Test { +public: + void SetUp() { + chains_lp.resize(1000, 4); + chains_theta.resize(1000, 4); + chains_divergent.resize(1000, 4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + chains_divergent.col(i) = bern_csv.samples.col(5); + } + } + + void TearDown() { + } + + std::stringstream out; + Eigen::MatrixXd chains_lp; + Eigen::MatrixXd chains_theta; + Eigen::MatrixXd chains_divergent; +}; + +TEST_F(MonteCarloStandardError, test_mcse) { + double mcse_mean_lp_expect = 0.020164778; + double mcse_mean_theta_expect = 0.0032339916; + + double mcse_sd_lp_expect = 0.0355305; + double mcse_sd_theta_expect = 0.0021642137; + EXPECT_NEAR(mcse_mean_lp_expect, stan::analyze::mcse_mean(chains_lp), 0.0001); + EXPECT_NEAR(mcse_mean_theta_expect, stan::analyze::mcse_mean(chains_theta), 0.0001); + + EXPECT_NEAR(mcse_sd_lp_expect, stan::analyze::mcse_sd(chains_lp), 0.0001); + EXPECT_NEAR(mcse_sd_theta_expect, stan::analyze::mcse_sd(chains_theta), 0.0001); +} + +TEST_F(MonteCarloStandardError, const_fail) { + auto mcse_mean = stan::analyze::mcse_mean(chains_divergent); + auto mcse_sd = stan::analyze::mcse_sd(chains_divergent); + EXPECT_TRUE(std::isnan(mcse_mean)); + EXPECT_TRUE(std::isnan(mcse_sd)); +} + +TEST_F(MonteCarloStandardError, inf_fail) { + chains_theta(0,0) = std::numeric_limits::infinity(); + auto mcse_mean = stan::analyze::mcse_mean(chains_theta); + auto mcse_sd = stan::analyze::mcse_sd(chains_theta); + EXPECT_TRUE(std::isnan(mcse_mean)); + EXPECT_TRUE(std::isnan(mcse_sd)); +} + +TEST_F(MonteCarloStandardError, short_chains_fail) { + chains_theta.resize(3, 4); + auto mcse_mean = stan::analyze::mcse_mean(chains_theta); + auto mcse_sd = stan::analyze::mcse_sd(chains_theta); + EXPECT_TRUE(std::isnan(mcse_mean)); + EXPECT_TRUE(std::isnan(mcse_sd)); +} diff --git a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp new file mode 100644 index 0000000000..15db985030 --- /dev/null +++ b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp @@ -0,0 +1,61 @@ +#include +#include +#include +#include +#include +#include + +class RhatBasic : public testing::Test { +public: + void SetUp() { + chains_lp.resize(1000, 4); + chains_theta.resize(1000, 4); + draws_theta.resize(4); + draws_lp.resize(4); + sizes.resize(4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + draws_lp[i] = chains_lp.col(i).data(); + draws_theta[i] = chains_theta.col(i).data(); + sizes[i] = 1000; + } + } + + void TearDown() { + } + + std::stringstream out; + Eigen::MatrixXd chains_lp; + Eigen::MatrixXd chains_theta; + std::vector draws_theta; + std::vector draws_lp; + std::vector sizes; +}; + +TEST_F(RhatBasic, test_basic_rhat) { + double rhat_lp_basic_expect = 1.0001296; + double rhat_theta_basic_expect = 1.0029197; + + auto rhat_basic_lp = stan::analyze::rhat(chains_lp); + auto old_rhat_basic_lp + = stan::analyze::compute_potential_scale_reduction(draws_lp, sizes); + + auto rhat_basic_theta = stan::analyze::rhat(chains_theta); + auto old_rhat_basic_theta + = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); + + EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 0.00001); + EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 0.00001); + + EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 0.00001); + EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 0.00001); +} + diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index ac52cf99db..0b4ecb6d25 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -6,29 +6,36 @@ #include #include -TEST(RankNormalizedEss, test_bulk_tail_ess) { - std::stringstream out; - Eigen::MatrixXd chains_lp(1000, 4); - Eigen::MatrixXd chains_theta(1000, 4); - - std::vector draws_theta(4); - std::vector draws_lp(4); - std::vector sizes(4); - - for (size_t i = 0; i < 4; ++i) { - std::stringstream fname; - fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; - std::ifstream bern_stream(fname.str(), std::ifstream::in); - stan::io::stan_csv bern_csv +class RankNormalizedEss : public testing::Test { +public: + void SetUp() { + chains_lp.resize(1000, 4); + chains_theta.resize(1000, 4); + chains_divergent.resize(1000, 4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); - bern_stream.close(); - chains_lp.col(i) = bern_csv.samples.col(0); - chains_theta.col(i) = bern_csv.samples.col(7); - draws_lp[i] = chains_lp.col(i).data(); - draws_theta[i] = chains_theta.col(i).data(); - sizes[i] = 1000; + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + chains_divergent.col(i) = bern_csv.samples.col(5); + } } + + void TearDown() { + } + + std::stringstream out; + Eigen::MatrixXd chains_lp; + Eigen::MatrixXd chains_theta; + Eigen::MatrixXd chains_divergent; +}; + +TEST_F(RankNormalizedEss, test_bulk_tail_ess) { double ess_lp_bulk_expect = 1512.7684; double ess_lp_tail_expect = 1591.9707; @@ -45,7 +52,20 @@ TEST(RankNormalizedEss, test_bulk_tail_ess) { EXPECT_NEAR(ess_theta_tail_expect, ess_theta.second, 0.001); } -TEST(RankNormalizedEss, short_chains_fail) { +TEST_F(RankNormalizedEss, const_fail) { + auto ess = stan::analyze::split_rank_normalized_ess(chains_divergent); + EXPECT_TRUE(std::isnan(ess.first)); + EXPECT_TRUE(std::isnan(ess.second)); +} + +TEST_F(RankNormalizedEss, inf_fail) { + chains_theta(0,0) = std::numeric_limits::infinity(); + auto ess = stan::analyze::split_rank_normalized_ess(chains_theta); + EXPECT_TRUE(std::isnan(ess.first)); + EXPECT_TRUE(std::isnan(ess.second)); +} + +TEST_F(RankNormalizedEss, short_chains_fail) { std::stringstream out; std::ifstream eight_schools_5iters_1_stream, eight_schools_5iters_2_stream; stan::io::stan_csv eight_schools_5iters_1, eight_schools_5iters_2; @@ -72,29 +92,3 @@ TEST(RankNormalizedEss, short_chains_fail) { } } -TEST(RankNormalizedEss, const_fail) { - std::stringstream out; - std::ifstream bernoulli_const_1_stream, bernoulli_const_2_stream; - stan::io::stan_csv bernoulli_const_1, bernoulli_const_2; - bernoulli_const_1_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv", - std::ifstream::in); - bernoulli_const_1 - = stan::io::stan_csv_reader::parse(bernoulli_const_1_stream, &out); - bernoulli_const_1_stream.close(); - bernoulli_const_2_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv", - std::ifstream::in); - bernoulli_const_2 - = stan::io::stan_csv_reader::parse(bernoulli_const_2_stream, &out); - bernoulli_const_2_stream.close(); - - Eigen::MatrixXd chains(bernoulli_const_1.samples.rows(), 2); - chains.col(0) - = bernoulli_const_1.samples.col(bernoulli_const_1.samples.cols() - 1); - chains.col(1) - = bernoulli_const_2.samples.col(bernoulli_const_2.samples.cols() - 1); - auto ess = stan::analyze::split_rank_normalized_ess(chains); - EXPECT_TRUE(std::isnan(ess.first)); - EXPECT_TRUE(std::isnan(ess.second)); -} diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp index a1ca5629c4..6cdc16c2e1 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp @@ -1,4 +1,3 @@ -#include #include #include #include @@ -7,81 +6,59 @@ #include #include #include +#include -TEST(RankNormalizedRhat, test_basic_bulk_tail_rhat) { - std::stringstream out; - Eigen::MatrixXd chains_lp(1000, 4); - Eigen::MatrixXd chains_theta(1000, 4); - - std::vector draws_theta(4); - std::vector draws_lp(4); - std::vector sizes(4); - - for (size_t i = 0; i < 4; ++i) { - std::stringstream fname; - fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; - std::ifstream bern_stream(fname.str(), std::ifstream::in); - stan::io::stan_csv bern_csv +class RankNormalizedRhat : public testing::Test { +public: + void SetUp() { + chains_lp.resize(1000, 4); + chains_theta.resize(1000, 4); + chains_divergent.resize(1000, 4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv = stan::io::stan_csv_reader::parse(bern_stream, &out); - bern_stream.close(); - chains_lp.col(i) = bern_csv.samples.col(0); - chains_theta.col(i) = bern_csv.samples.col(7); - draws_lp[i] = chains_lp.col(i).data(); - draws_theta[i] = chains_theta.col(i).data(); - sizes[i] = 1000; + bern_stream.close(); + chains_lp.col(i) = bern_csv.samples.col(0); + chains_theta.col(i) = bern_csv.samples.col(7); + chains_divergent.col(i) = bern_csv.samples.col(5); + } } - double rhat_lp_basic_expect = 1.0001296; - double rhat_lp_new_expect = 1.0007301; - - double rhat_theta_basic_expect = 1.0029197; - double rhat_theta_new_expect = 1.0067897; - auto rhat_basic_lp = stan::analyze::rhat(chains_lp); - auto old_rhat_basic_lp - = stan::analyze::compute_potential_scale_reduction(draws_lp, sizes); - auto rhat_lp = stan::analyze::split_rank_normalized_rhat(chains_lp); + void TearDown() { + } - auto rhat_basic_theta = stan::analyze::rhat(chains_theta); - auto old_rhat_basic_theta - = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); - auto rhat_theta = stan::analyze::split_rank_normalized_rhat(chains_theta); + std::stringstream out; + Eigen::MatrixXd chains_lp; + Eigen::MatrixXd chains_theta; + Eigen::MatrixXd chains_divergent; +}; - EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 0.00001); - EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 0.00001); +TEST_F(RankNormalizedRhat, test_bulk_tail_rhat) { + double rhat_lp_expect = 1.0007301; + double rhat_theta_expect = 1.0067897; - EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 0.00001); - EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 0.00001); + auto rhat_lp = stan::analyze::split_rank_normalized_rhat(chains_lp); + auto rhat_theta = stan::analyze::split_rank_normalized_rhat(chains_theta); - EXPECT_NEAR(rhat_lp_new_expect, std::max(rhat_lp.first, rhat_lp.second), + EXPECT_NEAR(rhat_lp_expect, std::max(rhat_lp.first, rhat_lp.second), 0.00001); - EXPECT_NEAR(rhat_theta_new_expect, + EXPECT_NEAR(rhat_theta_expect, std::max(rhat_theta.first, rhat_theta.second), 0.00001); } -TEST(RankNormalizedRhat, const_fail) { - std::stringstream out; - std::ifstream bernoulli_const_1_stream, bernoulli_const_2_stream; - stan::io::stan_csv bernoulli_const_1, bernoulli_const_2; - bernoulli_const_1_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv", - std::ifstream::in); - bernoulli_const_1 - = stan::io::stan_csv_reader::parse(bernoulli_const_1_stream, &out); - bernoulli_const_1_stream.close(); - bernoulli_const_2_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv", - std::ifstream::in); - bernoulli_const_2 - = stan::io::stan_csv_reader::parse(bernoulli_const_2_stream, &out); - bernoulli_const_2_stream.close(); +TEST_F(RankNormalizedRhat, const_fail) { + auto rhat = stan::analyze::split_rank_normalized_rhat(chains_divergent); + EXPECT_TRUE(std::isnan(rhat.first)); + EXPECT_TRUE(std::isnan(rhat.second)); +} - Eigen::MatrixXd chains(bernoulli_const_1.samples.rows(), 2); - chains.col(0) - = bernoulli_const_1.samples.col(bernoulli_const_1.samples.cols() - 1); - chains.col(1) - = bernoulli_const_2.samples.col(bernoulli_const_2.samples.cols() - 1); - auto rhat = stan::analyze::split_rank_normalized_rhat(chains); +TEST_F(RankNormalizedRhat, inf_fail) { + chains_theta(0,0) = std::numeric_limits::infinity(); + auto rhat = stan::analyze::split_rank_normalized_rhat(chains_theta); EXPECT_TRUE(std::isnan(rhat.first)); EXPECT_TRUE(std::isnan(rhat.second)); } From 5448680c4736f67bbfbc531ec545e85eaa454b4c Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Sat, 19 Oct 2024 14:57:35 -0400 Subject: [PATCH 19/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/stan/analyze/mcmc/mcse.hpp | 2 +- src/test/unit/analyze/mcmc/ess_basic_test.cpp | 9 ++++----- src/test/unit/analyze/mcmc/mcse_test.cpp | 17 +++++++++-------- src/test/unit/analyze/mcmc/rhat_basic_test.cpp | 10 ++++------ .../mcmc/split_rank_normalized_ess_test.cpp | 12 +++++------- .../mcmc/split_rank_normalized_rhat_test.cpp | 16 +++++++--------- 6 files changed, 30 insertions(+), 36 deletions(-) diff --git a/src/stan/analyze/mcmc/mcse.hpp b/src/stan/analyze/mcmc/mcse.hpp index f8789fb670..93292a0cf3 100644 --- a/src/stan/analyze/mcmc/mcse.hpp +++ b/src/stan/analyze/mcmc/mcse.hpp @@ -43,7 +43,7 @@ inline double mcse_sd(const Eigen::MatrixXd& chains) { if (chains.rows() < 4 || !is_finite_and_varies(chains)) return std::numeric_limits::quiet_NaN(); - // center the data, take abs value + // center the data, take abs value Eigen::MatrixXd draws_ctr = (chains.array() - chains.mean()).abs().matrix(); // posterior pkg fn `ess_mean` computes on split chains diff --git a/src/test/unit/analyze/mcmc/ess_basic_test.cpp b/src/test/unit/analyze/mcmc/ess_basic_test.cpp index d02c91d41d..a010909140 100644 --- a/src/test/unit/analyze/mcmc/ess_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/ess_basic_test.cpp @@ -8,7 +8,7 @@ #include class EssBasic : public testing::Test { -public: + public: void SetUp() { chains_lp.resize(1000, 4); chains_theta.resize(1000, 4); @@ -18,10 +18,10 @@ class EssBasic : public testing::Test { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); stan::io::stan_csv bern_csv - = stan::io::stan_csv_reader::parse(bern_stream, &out); + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -31,8 +31,7 @@ class EssBasic : public testing::Test { } } - void TearDown() { - } + void TearDown() {} std::stringstream out; Eigen::MatrixXd chains_lp; diff --git a/src/test/unit/analyze/mcmc/mcse_test.cpp b/src/test/unit/analyze/mcmc/mcse_test.cpp index 1fffd81fe9..45f4ce6ccc 100644 --- a/src/test/unit/analyze/mcmc/mcse_test.cpp +++ b/src/test/unit/analyze/mcmc/mcse_test.cpp @@ -7,7 +7,7 @@ #include class MonteCarloStandardError : public testing::Test { -public: + public: void SetUp() { chains_lp.resize(1000, 4); chains_theta.resize(1000, 4); @@ -15,10 +15,10 @@ class MonteCarloStandardError : public testing::Test { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); stan::io::stan_csv bern_csv - = stan::io::stan_csv_reader::parse(bern_stream, &out); + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -26,8 +26,7 @@ class MonteCarloStandardError : public testing::Test { } } - void TearDown() { - } + void TearDown() {} std::stringstream out; Eigen::MatrixXd chains_lp; @@ -42,10 +41,12 @@ TEST_F(MonteCarloStandardError, test_mcse) { double mcse_sd_lp_expect = 0.0355305; double mcse_sd_theta_expect = 0.0021642137; EXPECT_NEAR(mcse_mean_lp_expect, stan::analyze::mcse_mean(chains_lp), 0.0001); - EXPECT_NEAR(mcse_mean_theta_expect, stan::analyze::mcse_mean(chains_theta), 0.0001); + EXPECT_NEAR(mcse_mean_theta_expect, stan::analyze::mcse_mean(chains_theta), + 0.0001); EXPECT_NEAR(mcse_sd_lp_expect, stan::analyze::mcse_sd(chains_lp), 0.0001); - EXPECT_NEAR(mcse_sd_theta_expect, stan::analyze::mcse_sd(chains_theta), 0.0001); + EXPECT_NEAR(mcse_sd_theta_expect, stan::analyze::mcse_sd(chains_theta), + 0.0001); } TEST_F(MonteCarloStandardError, const_fail) { @@ -56,7 +57,7 @@ TEST_F(MonteCarloStandardError, const_fail) { } TEST_F(MonteCarloStandardError, inf_fail) { - chains_theta(0,0) = std::numeric_limits::infinity(); + chains_theta(0, 0) = std::numeric_limits::infinity(); auto mcse_mean = stan::analyze::mcse_mean(chains_theta); auto mcse_sd = stan::analyze::mcse_sd(chains_theta); EXPECT_TRUE(std::isnan(mcse_mean)); diff --git a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp index 15db985030..4e15262000 100644 --- a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp @@ -6,7 +6,7 @@ #include class RhatBasic : public testing::Test { -public: + public: void SetUp() { chains_lp.resize(1000, 4); chains_theta.resize(1000, 4); @@ -16,10 +16,10 @@ class RhatBasic : public testing::Test { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); stan::io::stan_csv bern_csv - = stan::io::stan_csv_reader::parse(bern_stream, &out); + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -29,8 +29,7 @@ class RhatBasic : public testing::Test { } } - void TearDown() { - } + void TearDown() {} std::stringstream out; Eigen::MatrixXd chains_lp; @@ -58,4 +57,3 @@ TEST_F(RhatBasic, test_basic_rhat) { EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 0.00001); EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 0.00001); } - diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 0b4ecb6d25..21a5dec8a1 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -7,7 +7,7 @@ #include class RankNormalizedEss : public testing::Test { -public: + public: void SetUp() { chains_lp.resize(1000, 4); chains_theta.resize(1000, 4); @@ -15,10 +15,10 @@ class RankNormalizedEss : public testing::Test { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); stan::io::stan_csv bern_csv - = stan::io::stan_csv_reader::parse(bern_stream, &out); + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -26,8 +26,7 @@ class RankNormalizedEss : public testing::Test { } } - void TearDown() { - } + void TearDown() {} std::stringstream out; Eigen::MatrixXd chains_lp; @@ -59,7 +58,7 @@ TEST_F(RankNormalizedEss, const_fail) { } TEST_F(RankNormalizedEss, inf_fail) { - chains_theta(0,0) = std::numeric_limits::infinity(); + chains_theta(0, 0) = std::numeric_limits::infinity(); auto ess = stan::analyze::split_rank_normalized_ess(chains_theta); EXPECT_TRUE(std::isnan(ess.first)); EXPECT_TRUE(std::isnan(ess.second)); @@ -91,4 +90,3 @@ TEST_F(RankNormalizedEss, short_chains_fail) { EXPECT_TRUE(std::isnan(ess.second)); } } - diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp index 6cdc16c2e1..f043b9c96e 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp @@ -9,7 +9,7 @@ #include class RankNormalizedRhat : public testing::Test { -public: + public: void SetUp() { chains_lp.resize(1000, 4); chains_theta.resize(1000, 4); @@ -17,10 +17,10 @@ class RankNormalizedRhat : public testing::Test { for (size_t i = 0; i < 4; ++i) { std::stringstream fname; fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) - << ".csv"; + << ".csv"; std::ifstream bern_stream(fname.str(), std::ifstream::in); stan::io::stan_csv bern_csv - = stan::io::stan_csv_reader::parse(bern_stream, &out); + = stan::io::stan_csv_reader::parse(bern_stream, &out); bern_stream.close(); chains_lp.col(i) = bern_csv.samples.col(0); chains_theta.col(i) = bern_csv.samples.col(7); @@ -28,8 +28,7 @@ class RankNormalizedRhat : public testing::Test { } } - void TearDown() { - } + void TearDown() {} std::stringstream out; Eigen::MatrixXd chains_lp; @@ -44,10 +43,9 @@ TEST_F(RankNormalizedRhat, test_bulk_tail_rhat) { auto rhat_lp = stan::analyze::split_rank_normalized_rhat(chains_lp); auto rhat_theta = stan::analyze::split_rank_normalized_rhat(chains_theta); - EXPECT_NEAR(rhat_lp_expect, std::max(rhat_lp.first, rhat_lp.second), + EXPECT_NEAR(rhat_lp_expect, std::max(rhat_lp.first, rhat_lp.second), 0.00001); + EXPECT_NEAR(rhat_theta_expect, std::max(rhat_theta.first, rhat_theta.second), 0.00001); - EXPECT_NEAR(rhat_theta_expect, - std::max(rhat_theta.first, rhat_theta.second), 0.00001); } TEST_F(RankNormalizedRhat, const_fail) { @@ -57,7 +55,7 @@ TEST_F(RankNormalizedRhat, const_fail) { } TEST_F(RankNormalizedRhat, inf_fail) { - chains_theta(0,0) = std::numeric_limits::infinity(); + chains_theta(0, 0) = std::numeric_limits::infinity(); auto rhat = stan::analyze::split_rank_normalized_rhat(chains_theta); EXPECT_TRUE(std::isnan(rhat.first)); EXPECT_TRUE(std::isnan(rhat.second)); From 368a7a2c476ac391ed65f20a5d61d342e900b7cb Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Sat, 19 Oct 2024 14:59:06 -0400 Subject: [PATCH 20/40] refactored analyze/mcmc fns and unit tests --- .../mcmc/split_rank_normalized_ess_test.cpp | 28 +++---------------- 1 file changed, 4 insertions(+), 24 deletions(-) diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 0b4ecb6d25..567e8564c7 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -66,29 +66,9 @@ TEST_F(RankNormalizedEss, inf_fail) { } TEST_F(RankNormalizedEss, short_chains_fail) { - std::stringstream out; - std::ifstream eight_schools_5iters_1_stream, eight_schools_5iters_2_stream; - stan::io::stan_csv eight_schools_5iters_1, eight_schools_5iters_2; - eight_schools_5iters_1_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv", - std::ifstream::in); - eight_schools_5iters_1 - = stan::io::stan_csv_reader::parse(eight_schools_5iters_1_stream, &out); - eight_schools_5iters_1_stream.close(); - eight_schools_5iters_2_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv", - std::ifstream::in); - eight_schools_5iters_2 - = stan::io::stan_csv_reader::parse(eight_schools_5iters_2_stream, &out); - eight_schools_5iters_2_stream.close(); - - Eigen::MatrixXd chains(eight_schools_5iters_1.samples.rows(), 2); - for (size_t i = 0; i < 10; ++i) { - chains.col(0) = eight_schools_5iters_1.samples.col(i + 7); - chains.col(1) = eight_schools_5iters_2.samples.col(i + 7); - auto ess = stan::analyze::split_rank_normalized_ess(chains); - EXPECT_TRUE(std::isnan(ess.first)); - EXPECT_TRUE(std::isnan(ess.second)); - } + chains_theta.resize(3, 4); + auto ess = stan::analyze::split_rank_normalized_ess(chains_theta); + EXPECT_TRUE(std::isnan(ess.first)); + EXPECT_TRUE(std::isnan(ess.second)); } From f268f546eb76d0e3e530b8e166e9e4858ce11454 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Sat, 19 Oct 2024 21:45:50 -0400 Subject: [PATCH 21/40] chainset test cleanup --- src/test/unit/mcmc/chainset_test.cpp | 82 ++++++++++++---------------- 1 file changed, 36 insertions(+), 46 deletions(-) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 451b39cc9c..4e3e191f8f 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -187,57 +187,47 @@ TEST_F(McmcChains, summary_stats) { } stan::mcmc::chainset bern_chains(bern_csvs); EXPECT_EQ(4, bern_chains.num_chains()); - // mean - // median - // sd - // max abs deviation - // mcse_mean - // mcse_sd - // q1 - // q5 - // q95 - // q99 - // q0 - // q100 - // rhat - // rhat_basic - // ess_bulk, tail - // ess_basic - // autocovariance -} -TEST_F(McmcChains, mcse) { - std::vector eight_schools; - eight_schools.push_back(eight_schools_1); - eight_schools.push_back(eight_schools_2); - stan::mcmc::chainset chain_2(eight_schools); - EXPECT_EQ(2, chain_2.num_chains()); + Eigen::MatrixXd theta = bern_chains.samples("theta"); + // default summary statistics - via R pkg posterior + double theta_mean_expect = 0.2512974105; + EXPECT_NEAR(theta_mean_expect, bern_chains.mean("theta"), 0.00001); - // test against R implementation in pkg posterior - Eigen::VectorXd s8_mcse_mean(10), s8_mcse_sd(10); - s8_mcse_mean << 0.288379, 0.4741815, 0.2741001, 0.3294614, 0.2473758, - 0.2665048, 0.2701363, 0.4740092, 0.3621771, 0.3832464; - s8_mcse_sd << 0.1841825, 0.2854258, 0.192332, 0.2919369, 0.2478025, 0.2207478, - 0.2308452, 0.2522107, 0.2946896, 0.3184745; + double theta_median_expect = 0.237476; + EXPECT_NEAR(theta_median_expect, bern_chains.median("theta"), 0.00001); - for (size_t i = 0; i < 10; ++i) { - auto mcse_mean = chain_2.mcse_mean(i + 7); - auto mcse_sd = chain_2.mcse_sd(i + 7); - EXPECT_NEAR(mcse_mean, s8_mcse_mean(i), 0.05); - EXPECT_NEAR(mcse_sd, s8_mcse_sd(i), 0.09); - } -} + double theta_sd_expect = 0.1215466867; + EXPECT_NEAR(theta_sd_expect, bern_chains.sd("theta"), 0.00001); -TEST_F(McmcChains, autocorrelation) { - stan::mcmc::chainset chain_1(eight_schools_1); - EXPECT_EQ(1, chain_1.num_chains()); + double theta_mad_expect = 0.1230906411; + EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), 0.00001); + + Eigen::VectorXd probs(6); + probs << 0.0, 0.01, 0.05, 0.95, 0.99, 1.0; + Eigen::VectorXd quantiles_expect(6); + quantiles_expect << 0.004072430, 0.046281211, 0.07716935, 0.47388505, 0.574524110, 0.698401000; + Eigen::VectorXd theta_quantiles = bern_chains.quantiles("theta", probs); + for (size_t i=0; i < probs.size(); ++i) { + EXPECT_NEAR(quantiles_expect(i), theta_quantiles(i), 0.00001); + } - Eigen::VectorXd mu_ac_posterior(10); - mu_ac_posterior << 1.00000000000, 0.19487668999, 0.05412049365, 0.07834048575, - 0.04145609855, 0.04353962161, -0.00977255885, 0.00005175308, - 0.01791577080, 0.01245035817; - auto mu_ac = chain_1.autocorrelation(0, "mu"); + double theta_rhat_expect = 1.0067897; + auto rhat = bern_chains.split_rank_normalized_rhat("theta"); + EXPECT_NEAR(theta_rhat_expect, std::max(rhat.first, rhat.second), 0.00001); + + double theta_ess_bulk_expect = 1407.5124; + double theta_ess_tail_expect = 1291.7131; + auto ess = bern_chains.split_rank_normalized_ess("theta"); + EXPECT_NEAR(theta_ess_bulk_expect, ess.first, 0.0001); + EXPECT_NEAR(theta_ess_tail_expect, ess.second, 0.0001); + + // autocorrelation - first 10 lags + Eigen::VectorXd theta_ac_expect(10); + theta_ac_expect << 1.000000000000, 0.422042451075, 0.206832857945, + 0.083833599168, 0.037326065784, 0.025076266911, 0.020038613922, + 0.013467409681, 0.004762861453, 0.029494701819; + auto theta_ac = bern_chains.autocorrelation(0, "theta"); for (size_t i = 0; i < 10; ++i) { - EXPECT_NEAR(mu_ac_posterior(i), mu_ac(i), 0.0005); + EXPECT_NEAR(theta_ac(i), theta_ac_expect(i), 0.0005); } } From 5e1739c4f0dbd2ee9a78b4219f4d3120e5a24c02 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Sat, 19 Oct 2024 21:46:21 -0400 Subject: [PATCH 22/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/mcmc/chainset_test.cpp | 14 ++++++++------ 1 file changed, 8 insertions(+), 6 deletions(-) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 4e3e191f8f..8ac48d6dd6 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -200,14 +200,16 @@ TEST_F(McmcChains, summary_stats) { EXPECT_NEAR(theta_sd_expect, bern_chains.sd("theta"), 0.00001); double theta_mad_expect = 0.1230906411; - EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), 0.00001); + EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), + 0.00001); Eigen::VectorXd probs(6); probs << 0.0, 0.01, 0.05, 0.95, 0.99, 1.0; Eigen::VectorXd quantiles_expect(6); - quantiles_expect << 0.004072430, 0.046281211, 0.07716935, 0.47388505, 0.574524110, 0.698401000; + quantiles_expect << 0.004072430, 0.046281211, 0.07716935, 0.47388505, + 0.574524110, 0.698401000; Eigen::VectorXd theta_quantiles = bern_chains.quantiles("theta", probs); - for (size_t i=0; i < probs.size(); ++i) { + for (size_t i = 0; i < probs.size(); ++i) { EXPECT_NEAR(quantiles_expect(i), theta_quantiles(i), 0.00001); } @@ -216,7 +218,7 @@ TEST_F(McmcChains, summary_stats) { EXPECT_NEAR(theta_rhat_expect, std::max(rhat.first, rhat.second), 0.00001); double theta_ess_bulk_expect = 1407.5124; - double theta_ess_tail_expect = 1291.7131; + double theta_ess_tail_expect = 1291.7131; auto ess = bern_chains.split_rank_normalized_ess("theta"); EXPECT_NEAR(theta_ess_bulk_expect, ess.first, 0.0001); EXPECT_NEAR(theta_ess_tail_expect, ess.second, 0.0001); @@ -224,8 +226,8 @@ TEST_F(McmcChains, summary_stats) { // autocorrelation - first 10 lags Eigen::VectorXd theta_ac_expect(10); theta_ac_expect << 1.000000000000, 0.422042451075, 0.206832857945, - 0.083833599168, 0.037326065784, 0.025076266911, 0.020038613922, - 0.013467409681, 0.004762861453, 0.029494701819; + 0.083833599168, 0.037326065784, 0.025076266911, 0.020038613922, + 0.013467409681, 0.004762861453, 0.029494701819; auto theta_ac = bern_chains.autocorrelation(0, "theta"); for (size_t i = 0; i < 10; ++i) { EXPECT_NEAR(theta_ac(i), theta_ac_expect(i), 0.0005); From 1eda26330d298d81212e4884cf1b83c21327ec8f Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Sat, 19 Oct 2024 21:51:49 -0400 Subject: [PATCH 23/40] chainset test all functions --- src/test/unit/mcmc/chainset_test.cpp | 6 ++++++ 1 file changed, 6 insertions(+) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 4e3e191f8f..ff1e3570fc 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -202,6 +202,12 @@ TEST_F(McmcChains, summary_stats) { double theta_mad_expect = 0.1230906411; EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), 0.00001); + double theta_mcse_mean_expect = 0.0032339916; + EXPECT_NEAR(theta_mcse_mean_expect, bern_chains.mcse_mean("theta"), 0.0001); + + double theta_mcse_sd_expect = 0.0021642137; + EXPECT_NEAR(theta_mcse_sd_expect, bern_chains.mcse_sd("theta"), 0.0001); + Eigen::VectorXd probs(6); probs << 0.0, 0.01, 0.05, 0.95, 0.99, 1.0; Eigen::VectorXd quantiles_expect(6); From b47a261bdaf78cd281be98945d30fc7ebcbea971 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Sat, 19 Oct 2024 21:52:48 -0400 Subject: [PATCH 24/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/mcmc/chainset_test.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 6bd5a95590..921f960a18 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -208,7 +208,7 @@ TEST_F(McmcChains, summary_stats) { double theta_mcse_sd_expect = 0.0021642137; EXPECT_NEAR(theta_mcse_sd_expect, bern_chains.mcse_sd("theta"), 0.0001); - + Eigen::VectorXd probs(6); probs << 0.0, 0.01, 0.05, 0.95, 0.99, 1.0; Eigen::VectorXd quantiles_expect(6); From cb1349d7998e1d076bc8348a0c7e6346b236924a Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Sat, 19 Oct 2024 22:14:22 -0400 Subject: [PATCH 25/40] cleanup --- src/test/unit/mcmc/chainset_test.cpp | 38 +- .../mcmc/test_csv_files/bernoulli_const_1.csv | 1057 ----------------- .../mcmc/test_csv_files/bernoulli_const_2.csv | 1057 ----------------- .../mcmc/test_csv_files/bernoulli_zeta.csv | 1057 ----------------- .../test_csv_files/eight_schools_5iters_1.csv | 62 - .../test_csv_files/eight_schools_5iters_2.csv | 62 - .../test_csv_files/eight_schools_empty.csv | 57 - 7 files changed, 4 insertions(+), 3386 deletions(-) delete mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv delete mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv delete mode 100644 src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv delete mode 100644 src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv delete mode 100644 src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv delete mode 100644 src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 6bd5a95590..ff378b5825 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -24,38 +24,24 @@ class McmcChains : public testing::Test { bernoulli_warmup_stream.open( "src/test/unit/mcmc/test_csv_files/bernoulli_warmup.csv", std::ifstream::in); - bernoulli_zeta_stream.open( - "src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv", - std::ifstream::in); eight_schools_1_stream.open( "src/test/unit/mcmc/test_csv_files/eight_schools_1.csv", std::ifstream::in); eight_schools_2_stream.open( "src/test/unit/mcmc/test_csv_files/eight_schools_2.csv", std::ifstream::in); - eight_schools_5iters_1_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv", - std::ifstream::in); - eight_schools_5iters_2_stream.open( - "src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv", - std::ifstream::in); if (!bernoulli_500_stream || !bernoulli_default_stream || !bernoulli_thin_stream || !bernoulli_warmup_stream - || !bernoulli_zeta_stream || !eight_schools_1_stream - || !eight_schools_2_stream || !eight_schools_5iters_1_stream - || !eight_schools_5iters_2_stream) { + || !eight_schools_1_stream || !eight_schools_2_stream) { FAIL() << "Failed to open one or more test files"; } bernoulli_500_stream.seekg(0, std::ios::beg); bernoulli_default_stream.seekg(0, std::ios::beg); bernoulli_thin_stream.seekg(0, std::ios::beg); bernoulli_warmup_stream.seekg(0, std::ios::beg); - bernoulli_zeta_stream.seekg(0, std::ios::beg); eight_schools_1_stream.seekg(0, std::ios::beg); eight_schools_2_stream.seekg(0, std::ios::beg); - eight_schools_5iters_1_stream.seekg(0, std::ios::beg); - eight_schools_5iters_2_stream.seekg(0, std::ios::beg); bernoulli_500 = stan::io::stan_csv_reader::parse(bernoulli_500_stream, &out); @@ -65,16 +51,10 @@ class McmcChains : public testing::Test { = stan::io::stan_csv_reader::parse(bernoulli_thin_stream, &out); bernoulli_warmup = stan::io::stan_csv_reader::parse(bernoulli_warmup_stream, &out); - bernoulli_zeta - = stan::io::stan_csv_reader::parse(bernoulli_zeta_stream, &out); eight_schools_1 = stan::io::stan_csv_reader::parse(eight_schools_1_stream, &out); eight_schools_2 = stan::io::stan_csv_reader::parse(eight_schools_2_stream, &out); - eight_schools_5iters_1 - = stan::io::stan_csv_reader::parse(eight_schools_5iters_1_stream, &out); - eight_schools_5iters_2 - = stan::io::stan_csv_reader::parse(eight_schools_5iters_2_stream, &out); } void TearDown() override { @@ -82,23 +62,18 @@ class McmcChains : public testing::Test { bernoulli_default_stream.close(); bernoulli_thin_stream.close(); bernoulli_warmup_stream.close(); - bernoulli_zeta_stream.close(); eight_schools_1_stream.close(); eight_schools_2_stream.close(); - eight_schools_5iters_1_stream.close(); - eight_schools_5iters_2_stream.close(); } std::stringstream out; std::ifstream bernoulli_500_stream, bernoulli_default_stream, - bernoulli_thin_stream, bernoulli_warmup_stream, bernoulli_zeta_stream, - eight_schools_1_stream, eight_schools_2_stream, - eight_schools_5iters_1_stream, eight_schools_5iters_2_stream; + bernoulli_thin_stream, bernoulli_warmup_stream, + eight_schools_1_stream, eight_schools_2_stream; stan::io::stan_csv bernoulli_500, bernoulli_default, bernoulli_thin, - bernoulli_warmup, bernoulli_zeta, eight_schools_1, eight_schools_2, - eight_schools_5iters_1, eight_schools_5iters_2; + bernoulli_warmup, eight_schools_1, eight_schools_2; }; TEST_F(McmcChains, constructor) { @@ -139,11 +114,6 @@ TEST_F(McmcChains, addFail) { bad.push_back(bernoulli_default); bad.push_back(eight_schools_1); EXPECT_THROW(stan::mcmc::chainset fail(bad), std::invalid_argument); - - bad.clear(); - bad.push_back(bernoulli_default); - bad.push_back(bernoulli_zeta); - EXPECT_THROW(stan::mcmc::chainset fail(bad), std::invalid_argument); } TEST_F(McmcChains, paramNameIndex) { diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv deleted file mode 100644 index b4a727ec85..0000000000 --- a/src/test/unit/mcmc/test_csv_files/bernoulli_const_1.csv +++ /dev/null @@ -1,1057 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 35 -# stan_version_patch = 0 -# model = bernoulli_model -# start_datetime = 2024-07-20 18:56:30 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 = examples/bernoulli/bernoulli.data.json -# init = 2 (Default) -# random -# seed = 3635036313 (Default) -# output -# file = bernoulli_out.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-25-gbb9ce42 -# stancflags = -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,zeta -# Adaptation terminated -# Step size = 0.932037 -# Diagonal elements of inverse mass matrix: -# 0.591014 --7.81355,0.761218,0.932037,1,3,0,8.13669,0.15 --8.71049,0.894869,0.932037,1,1,0,8.72268,0.15 --7.3531,0.957519,0.932037,1,3,0,8.53469,0.15 --7.02007,1,0.932037,1,1,0,7.29505,0.15 --8.49033,0.716959,0.932037,1,3,0,9.20407,0.15 --7.18724,1,0.932037,1,1,0,8.06459,0.15 --10.0621,0.636916,0.932037,2,3,0,10.0852,0.15 --8.11851,1,0.932037,1,1,0,9.65805,0.15 --6.86936,0.948809,0.932037,2,3,0,8.60097,0.15 --7.13756,0.935492,0.932037,2,3,0,7.43717,0.15 --7.09122,1,0.932037,1,1,0,7.19518,0.15 --6.91669,1,0.932037,1,1,0,7.06383,0.15 --6.76371,0.840542,0.932037,2,3,0,8.08838,0.15 --6.84805,0.983351,0.932037,1,3,0,6.84861,0.15 --8.3727,0.653843,0.932037,2,3,0,9.53079,0.15 --7.25928,0.806553,0.932037,1,3,0,9.43963,0.15 --6.95987,0.853051,0.932037,2,3,0,9.71446,0.15 --6.95334,1,0.932037,1,1,0,7.00708,0.15 --6.98417,0.993206,0.932037,1,1,0,7.02663,0.15 --8.9535,0.727406,0.932037,1,3,0,9.27425,0.15 --7.08162,0.995936,0.932037,2,3,0,9.00617,0.15 --7.16691,0.98306,0.932037,1,1,0,7.22238,0.15 --6.8898,1,0.932037,1,1,0,7.10684,0.15 --7.8902,0.846547,0.932037,1,3,0,7.96857,0.15 --7.24239,1,0.932037,1,1,0,7.78446,0.15 --7.94748,0.888836,0.932037,1,1,0,7.94857,0.15 --6.83694,0.864212,0.932037,2,3,0,8.91495,0.15 --6.83694,0.425574,0.932037,1,3,0,9.01249,0.15 --6.80131,0.985852,0.932037,1,3,0,6.93894,0.15 --6.74824,0.978446,0.932037,2,3,0,6.95179,0.15 --6.74832,0.945401,0.932037,2,3,0,7.0277,0.15 --6.85442,0.972221,0.932037,1,3,0,6.87104,0.15 --6.86406,0.996818,0.932037,1,1,0,6.89618,0.15 --7.11238,0.918504,0.932037,1,1,0,7.12695,0.15 --7.11238,0.431368,0.932037,1,1,0,8.53302,0.15 --6.79843,1,0.932037,1,1,0,7.00834,0.15 --6.74804,0.996585,0.932037,2,3,0,6.81732,0.15 --9.50952,0.509265,0.932037,1,3,0,9.67564,0.15 --8.27778,1,0.932037,1,1,0,9.48419,0.15 --7.2527,1,0.932037,2,3,0,8.04703,0.15 --6.75205,0.907555,0.932037,2,3,0,8.25548,0.15 --7.3411,0.857468,0.932037,1,3,0,7.42326,0.15 --7.07094,1,0.932037,1,1,0,7.32247,0.15 --7.04767,0.556206,0.932037,2,3,0,9.56585,0.15 --6.87625,1,0.932037,2,3,0,6.9975,0.15 --7.12535,0.945777,0.932037,1,1,0,7.12652,0.15 --7.12535,0.913353,0.932037,1,1,0,7.53634,0.15 --6.78755,1,0.932037,2,3,0,7.04258,0.15 --7.7545,0.780448,0.932037,1,3,0,7.76329,0.15 --6.77502,0.859809,0.932037,2,3,0,8.49845,0.15 --7.19668,0.726665,0.932037,2,3,0,8.64609,0.15 --9.64819,0.775506,0.932037,2,3,0,10.0305,0.15 --6.86272,0.7808,0.932037,1,3,0,10.9403,0.15 --6.99329,0.696273,0.932037,2,3,0,8.30815,0.15 --6.99329,0.700745,0.932037,1,1,0,7.63428,0.15 --7.11558,0.957857,0.932037,1,1,0,7.18108,0.15 --6.80487,1,0.932037,2,3,0,7.09376,0.15 --6.97334,0.955154,0.932037,2,3,0,7.16146,0.15 --7.2664,0.98044,0.932037,2,3,0,7.27318,0.15 --7.06819,1,0.932037,2,3,0,7.25815,0.15 --6.74803,0.991749,0.932037,1,3,0,7.05576,0.15 --7.05542,0.823118,0.932037,2,3,0,7.78068,0.15 --6.89251,1,0.932037,1,1,0,7.02757,0.15 --6.76584,0.932575,0.932037,2,3,0,7.49343,0.15 --6.75064,0.997924,0.932037,2,3,0,6.78013,0.15 --6.91371,0.96173,0.932037,1,3,0,6.93351,0.15 --6.74953,0.994131,0.932037,1,3,0,6.91533,0.15 --8.33302,0.635332,0.932037,1,3,0,9.05105,0.15 --8.04729,1,0.932037,1,1,0,8.43889,0.15 --8.42015,0.956552,0.932037,1,1,0,8.53727,0.15 --7.91154,1,0.932037,1,1,0,8.4304,0.15 --7.65791,1,0.932037,1,1,0,7.97836,0.15 --7.97869,0.955317,0.932037,1,1,0,8.06587,0.15 --6.81845,1,0.932037,1,3,0,7.88771,0.15 --6.76575,0.914099,0.932037,2,3,0,7.34829,0.15 --6.74964,0.996733,0.932037,2,3,0,6.78491,0.15 --6.77106,0.99494,0.932037,1,3,0,6.77141,0.15 --6.77106,0.945747,0.932037,1,3,0,6.92649,0.15 --6.77106,0.856062,0.932037,1,3,0,7.35372,0.15 --6.88028,0.948865,0.932037,2,3,0,7.03829,0.15 --7.33958,0.635769,0.932037,2,3,0,9.861,0.15 --8.06974,0.890942,0.932037,1,1,0,8.07292,0.15 --6.97186,0.998838,0.932037,1,3,0,7.91764,0.15 --6.76939,0.981956,0.932037,1,3,0,7.03238,0.15 --7.44177,0.80944,0.932037,1,3,0,7.79154,0.15 --8.01591,0.972061,0.932037,2,3,0,8.03736,0.15 --9.92045,0.865258,0.932037,2,3,0,9.92397,0.15 --7.31963,1,0.932037,2,3,0,10.3209,0.15 --6.9789,1,0.932037,1,1,0,7.25409,0.15 --7.21981,0.951312,0.932037,1,1,0,7.23197,0.15 --7.47612,0.930523,0.932037,2,3,0,8.12075,0.15 --6.81131,0.990375,0.932037,2,3,0,7.55719,0.15 --6.80278,0.920389,0.932037,2,3,0,7.43635,0.15 --6.88803,0.979103,0.932037,1,1,0,6.89063,0.15 --7.02902,0.795987,0.932037,2,3,0,8.6993,0.15 --6.74805,0.993012,0.932037,1,3,0,7.01716,0.15 --6.93322,0.952905,0.932037,1,3,0,6.95228,0.15 --6.76781,0.904559,0.932037,2,3,0,7.33629,0.15 --6.76232,0.985564,0.932037,2,3,0,6.83656,0.15 --6.87137,0.974516,0.932037,1,3,0,6.87148,0.15 --7.21556,0.953187,0.932037,2,3,0,7.22785,0.15 --6.76367,0.998041,0.932037,1,3,0,7.1984,0.15 --6.82308,0.981349,0.932037,1,3,0,6.86896,0.15 --6.82308,0.352125,0.932037,1,3,0,10.8402,0.15 --6.99474,0.738309,0.932037,2,3,0,8.0486,0.15 --6.99474,0.963463,0.932037,1,1,0,7.1311,0.15 --6.8637,0.713515,0.932037,2,3,0,8.29356,0.15 --6.94178,0.974091,0.932037,1,1,0,6.96832,0.15 --6.80481,1,0.932037,2,3,0,6.9081,0.15 --6.92327,0.971351,0.932037,1,1,0,6.92425,0.15 --7.1233,0.957499,0.932037,1,1,0,7.13244,0.15 --6.76778,0.973133,0.932037,1,3,0,7.19571,0.15 --6.90939,0.888041,0.932037,2,3,0,7.29419,0.15 --7.3757,0.927908,0.932037,2,3,0,7.37586,0.15 --7.33194,1,0.932037,1,1,0,7.48008,0.15 --6.86262,0.893077,0.932037,2,3,0,9.38827,0.15 --6.74929,0.996117,0.932037,1,3,0,6.86347,0.15 --6.74964,0.943201,0.932037,2,3,0,7.03592,0.15 --6.9015,0.968295,0.932037,2,3,0,6.96204,0.15 --7.81106,0.864491,0.932037,1,3,0,7.86554,0.15 --8.616,0.90424,0.932037,1,1,0,8.63659,0.15 --8.16761,1,0.932037,1,1,0,8.67561,0.15 --6.96545,1,0.932037,1,3,0,8.01828,0.15 --6.75813,1,0.932037,1,3,0,6.92669,0.15 --6.75424,1,0.932037,1,1,0,6.75812,0.15 --7.76056,0.503853,0.932037,2,3,0,10.2889,0.15 --7.12518,1,0.932037,1,1,0,7.64631,0.15 --7.67249,0.905419,0.932037,1,1,0,7.67491,0.15 --7.63881,1,0.932037,1,1,0,7.83222,0.15 --7.3844,0.889767,0.932037,1,3,0,8.80917,0.15 --6.76719,1,0.932037,1,3,0,7.348,0.15 --7.47953,0.852161,0.932037,1,3,0,7.59716,0.15 --7.42386,1,0.932037,2,3,0,7.59422,0.15 --7.91668,0.975432,0.932037,2,3,0,7.94672,0.15 --6.83066,1,0.932037,2,3,0,7.62924,0.15 --6.96269,0.956934,0.932037,1,1,0,6.97473,0.15 --6.74847,0.963031,0.932037,2,3,0,7.15706,0.15 --6.80708,0.988647,0.932037,2,3,0,6.82289,0.15 --6.91792,0.9732,0.932037,1,1,0,6.91947,0.15 --6.84983,1,0.932037,2,3,0,6.91467,0.15 --6.88905,0.990653,0.932037,1,1,0,6.90679,0.15 --7.15463,0.975663,0.932037,2,3,0,7.16,0.15 --6.9586,1,0.932037,1,1,0,7.13267,0.15 --7.56708,0.803851,0.932037,1,1,0,7.59178,0.15 --6.76736,1,0.932037,1,3,0,7.31987,0.15 --6.80123,0.959699,0.932037,2,3,0,6.95431,0.15 --6.80123,0.759564,0.932037,1,3,0,7.84546,0.15 --6.80123,0.902778,0.932037,1,3,0,7.20675,0.15 --6.80123,0.96482,0.932037,1,1,0,6.88076,0.15 --6.78299,0.988689,0.932037,2,3,0,6.88032,0.15 --7.1107,0.936673,0.932037,1,3,0,7.12632,0.15 --7.31567,0.961429,0.932037,1,1,0,7.35195,0.15 --7.07455,0.968694,0.932037,2,3,0,7.7776,0.15 --6.74831,0.993779,0.932037,1,3,0,7.05357,0.15 --6.84249,0.975275,0.932037,1,3,0,6.85756,0.15 --6.88224,0.995647,0.932037,2,3,0,6.90622,0.15 --8.68021,0.668585,0.932037,2,3,0,8.68611,0.15 --7.80603,1,0.932037,1,1,0,8.5851,0.15 --7.27572,1,0.932037,1,1,0,7.73044,0.15 --8.91337,0.902662,0.932037,2,3,0,9.15324,0.15 --7.22471,0.840347,0.932037,1,3,0,9.85532,0.15 --7.57214,0.980256,0.932037,2,3,0,7.60142,0.15 --7.46188,1,0.932037,1,1,0,7.66831,0.15 --7.21293,1,0.932037,1,1,0,7.46083,0.15 --7.27196,0.911127,0.932037,1,3,0,8.06683,0.15 --6.99285,1,0.932037,1,1,0,7.22442,0.15 --7.64686,0.789204,0.932037,1,1,0,7.67915,0.15 --7.64686,0.588674,0.932037,1,1,0,8.70948,0.15 --6.76317,0.84811,0.932037,2,3,0,8.40171,0.15 --6.75852,0.995961,0.932037,2,3,0,6.79457,0.15 --6.96185,0.956175,0.932037,2,3,0,7.06538,0.15 --6.7597,0.95957,0.932037,2,3,0,7.23201,0.15 --6.95356,0.940807,0.932037,1,3,0,7.05195,0.15 --6.74802,0.995879,0.932037,1,3,0,6.94105,0.15 --6.80409,0.985416,0.932037,1,3,0,6.81492,0.15 --6.78431,0.93291,0.932037,2,3,0,7.30965,0.15 --6.85124,0.98309,0.932037,1,1,0,6.85256,0.15 --6.91874,0.970098,0.932037,1,3,0,7.11707,0.15 --6.91874,0.434093,0.932037,1,3,0,9.39656,0.15 --6.92998,0.940657,0.932037,2,3,0,7.25758,0.15 --6.7616,0.987015,0.932037,1,3,0,6.96899,0.15 --6.77385,0.996249,0.932037,1,1,0,6.77617,0.15 --7.11956,0.891801,0.932037,1,3,0,7.32561,0.15 --7.10361,0.938678,0.932037,1,3,0,7.72046,0.15 --7.10361,0.642361,0.932037,1,1,0,7.89438,0.15 --8.5001,0.593919,0.932037,1,1,0,8.53813,0.15 --7.1692,1,0.932037,2,3,0,8.39313,0.15 --6.99964,1,0.932037,2,3,0,7.15856,0.15 --6.82605,1,0.932037,1,1,0,6.95904,0.15 --6.80069,1,0.932037,1,1,0,6.8286,0.15 --6.80069,0.826864,0.932037,1,3,0,7.56839,0.15 --6.80069,0.712989,0.932037,1,3,0,8.08135,0.15 --6.79864,1,0.932037,1,1,0,6.81323,0.15 --7.21975,0.922333,0.932037,1,3,0,7.24006,0.15 --6.75061,0.978686,0.932037,1,3,0,7.23991,0.15 --8.50882,0.710206,0.932037,2,3,0,8.58833,0.15 --6.98994,1,0.932037,1,3,0,8.37388,0.15 --8.68191,0.796805,0.932037,2,3,0,9.47091,0.15 --7.31609,1,0.932037,2,3,0,8.2644,0.15 --7.14381,1,0.932037,1,1,0,7.36712,0.15 --7.14381,0.475525,0.932037,1,1,0,8.41075,0.15 --7.29505,0.813437,0.932037,2,3,0,8.20133,0.15 --7.97276,0.895575,0.932037,1,1,0,7.97663,0.15 --9.00874,0.888587,0.932037,1,1,0,9.0167,0.15 --8.5484,1,0.932037,1,1,0,9.10361,0.15 --7.88735,1,0.932037,1,1,0,8.51142,0.15 --7.36782,1,0.932037,1,1,0,7.8262,0.15 --7.34887,1,0.932037,1,1,0,7.48713,0.15 --6.81839,0.987631,0.932037,2,3,0,7.46646,0.15 --6.81839,0.712592,0.932037,1,3,0,8.16085,0.15 --6.74807,0.998893,0.932037,1,3,0,6.81316,0.15 --6.87013,0.959268,0.932037,2,3,0,6.97825,0.15 --6.76585,1,0.932037,1,1,0,6.83725,0.15 --6.7566,0.994396,0.932037,2,3,0,6.80045,0.15 --6.7566,0.628726,0.932037,1,3,0,8.7002,0.15 --6.82277,0.986161,0.932037,1,3,0,6.82387,0.15 --7.3013,0.877627,0.932037,1,3,0,7.5333,0.15 --8.78447,0.79108,0.932037,2,3,0,8.87542,0.15 --7.50584,1,0.932037,1,1,0,8.46306,0.15 --7.15669,1,0.932037,1,1,0,7.48033,0.15 --7.43591,0.967588,0.932037,2,3,0,7.54437,0.15 --6.96987,0.913229,0.932037,1,3,0,7.88228,0.15 --6.89773,1,0.932037,1,1,0,6.97541,0.15 --7.36158,0.930716,0.932037,1,3,0,7.36402,0.15 --7.16589,1,0.932037,1,1,0,7.37174,0.15 --6.95869,1,0.932037,1,1,0,7.13528,0.15 --7.16168,0.929564,0.932037,1,3,0,7.57434,0.15 --8.02154,0.725795,0.932037,1,1,0,8.09574,0.15 --8.63423,0.930003,0.932037,2,3,0,9.03662,0.15 --6.93887,1,0.932037,1,1,0,8.0172,0.15 --6.87271,1,0.932037,1,1,0,6.94734,0.15 --6.77339,1,0.932037,2,3,0,6.85408,0.15 --6.98298,0.942095,0.932037,1,3,0,7.07789,0.15 --6.75868,1,0.932037,1,3,0,6.91623,0.15 --6.7906,0.973381,0.932037,2,3,0,6.88716,0.15 --7.56742,0.820209,0.932037,1,3,0,7.57193,0.15 --6.75108,1,0.932037,1,3,0,7.35001,0.15 --6.80655,0.983396,0.932037,1,3,0,6.83092,0.15 --6.91728,0.973208,0.932037,1,1,0,6.91879,0.15 --7.7691,0.915431,0.932037,2,3,0,7.98664,0.15 --6.765,1,0.932037,1,3,0,7.46164,0.15 --7.37311,0.856184,0.932037,1,3,0,7.3856,0.15 --7.3305,1,0.932037,1,1,0,7.55404,0.15 --7.3305,0.663523,0.932037,1,1,0,8.12143,0.15 --7.12567,0.837343,0.932037,1,3,0,8.09517,0.15 --7.15885,0.957841,0.932037,2,3,0,7.71194,0.15 --6.75049,0.994782,0.932037,1,3,0,7.12461,0.15 --6.81461,0.982255,0.932037,1,3,0,6.83366,0.15 --6.75614,0.996516,0.932037,1,3,0,6.83027,0.15 --6.74853,0.904663,0.932037,2,3,0,7.2911,0.15 --7.01677,0.911602,0.932037,2,3,0,7.26139,0.15 --6.92929,0.642216,0.932037,2,3,0,8.77716,0.15 --7.65529,0.771289,0.932037,1,1,0,7.66932,0.15 --7.01834,1,0.932037,1,1,0,7.46402,0.15 --6.74897,1,0.932037,1,3,0,6.95557,0.15 --9.81129,0.348606,0.932037,1,3,0,11.6845,0.15 --10.4379,0.964322,0.932037,1,1,0,10.6078,0.15 --12.3737,0.923455,0.932037,1,1,0,12.3737,0.15 --8.6914,0.906628,0.932037,1,3,0,12.5921,0.15 --7.8205,1,0.932037,1,1,0,8.59832,0.15 --6.76573,0.925015,0.932037,1,3,0,8.00716,0.15 --7.18424,0.803585,0.932037,2,3,0,7.86457,0.15 --6.74867,0.98391,0.932037,1,3,0,7.18696,0.15 --6.74867,0.809678,0.932037,1,3,0,7.5541,0.15 --6.78928,0.864392,0.932037,2,3,0,7.45892,0.15 --7.73008,0.857073,0.932037,2,3,0,7.95215,0.15 --6.90924,0.999548,0.932037,1,3,0,7.59486,0.15 --6.83204,1,0.932037,1,1,0,6.89889,0.15 --6.92095,0.978894,0.932037,1,1,0,6.92784,0.15 --6.84946,1,0.932037,1,1,0,6.91633,0.15 --6.87329,0.97872,0.932037,1,3,0,7.05429,0.15 --7.77797,0.726161,0.932037,1,1,0,7.77978,0.15 --7.91451,0.983052,0.932037,2,3,0,8.2695,0.15 --6.99541,0.905965,0.932037,1,3,0,8.38798,0.15 --6.76541,0.9819,0.932037,1,3,0,7.04888,0.15 --6.75969,1,0.932037,1,1,0,6.76622,0.15 --6.88511,0.980043,0.932037,2,3,0,6.89657,0.15 --6.77682,0.92494,0.932037,2,3,0,7.55206,0.15 --7.22693,0.885941,0.932037,1,3,0,7.36359,0.15 --7.08301,1,0.932037,2,3,0,7.27,0.15 --6.74807,1,0.932037,1,3,0,7.01313,0.15 --6.78184,0.991048,0.932037,1,3,0,6.7889,0.15 --7.7414,0.782413,0.932037,1,3,0,7.94246,0.15 --8.34868,0.79224,0.932037,1,1,0,8.64598,0.15 --6.96656,1,0.932037,1,1,0,7.85206,0.15 --8.55062,0.559382,0.932037,1,1,0,8.55696,0.15 --8.71259,0.939683,0.932037,1,1,0,9.36157,0.15 --7.02011,1,0.932037,1,1,0,8.0992,0.15 --7.73032,0.771978,0.932037,1,1,0,7.7681,0.15 --7.58699,1,0.932037,1,1,0,7.95753,0.15 --10.1664,0.37457,0.932037,1,1,0,10.2962,0.15 --9.05941,1,0.932037,2,3,0,10.4928,0.15 --6.95163,0.994678,0.932037,1,3,0,9.25144,0.15 --6.991,0.991344,0.932037,1,1,0,7.03106,0.15 --6.93665,1,0.932037,1,1,0,7.01246,0.15 --7.53693,0.951931,0.932037,2,3,0,7.60421,0.15 --7.35042,1,0.932037,1,1,0,7.65542,0.15 --6.74833,1,0.932037,1,3,0,7.21002,0.15 --7.30096,0.866757,0.932037,1,3,0,7.34306,0.15 --7.33424,0.995938,0.932037,2,3,0,7.52117,0.15 --7.00834,1,0.932037,1,1,0,7.27119,0.15 --7.00834,0.750927,0.932037,1,3,0,7.93882,0.15 --6.85276,0.717415,0.932037,2,3,0,8.2801,0.15 --6.88149,0.915088,0.932037,2,3,0,7.26489,0.15 --7.01531,0.954346,0.932037,2,3,0,7.30842,0.15 --8.49716,0.821021,0.932037,2,3,0,8.90444,0.15 --7.75198,1,0.932037,2,3,0,8.42455,0.15 --6.78374,0.995713,0.932037,1,3,0,7.67855,0.15 --6.78319,0.955918,0.932037,2,3,0,7.05067,0.15 --6.76877,0.993356,0.932037,2,3,0,6.83116,0.15 --6.76604,1,0.932037,2,3,0,6.77242,0.15 --6.80257,0.828664,0.932037,2,3,0,7.81548,0.15 --6.7921,0.928548,0.932037,2,3,0,7.34502,0.15 --6.7921,0.869785,0.932037,1,3,0,7.3846,0.15 --6.78247,1,0.932037,1,1,0,6.7969,0.15 --6.77338,0.944315,0.932037,2,3,0,7.11056,0.15 --6.88767,0.984579,0.932037,2,3,0,6.89149,0.15 --6.87758,1,0.932037,1,1,0,6.91573,0.15 --6.98427,0.975828,0.932037,1,1,0,6.997,0.15 --8.16006,0.847199,0.932037,1,3,0,8.23533,0.15 --6.92926,1,0.932037,1,3,0,8.02086,0.15 --6.75334,1,0.932037,1,3,0,6.89875,0.15 --6.76157,0.984481,0.932037,2,3,0,6.84166,0.15 --6.77437,0.916298,0.932037,2,3,0,7.16943,0.15 --6.89883,0.966797,0.932037,2,3,0,7.01941,0.15 --7.61554,0.929243,0.932037,2,3,0,7.77465,0.15 --6.74865,1,0.932037,1,3,0,7.4327,0.15 --7.90889,0.736401,0.932037,1,3,0,8.30046,0.15 --7.36433,1,0.932037,1,1,0,7.84078,0.15 --6.7517,1,0.932037,2,3,0,7.32628,0.15 --7.47731,0.835796,0.932037,1,3,0,7.65004,0.15 --6.82682,1,0.932037,1,3,0,7.36972,0.15 --6.75257,1,0.932037,1,3,0,6.81023,0.15 --6.74814,0.924039,0.932037,2,3,0,7.16556,0.15 --6.77547,0.992637,0.932037,1,3,0,6.7818,0.15 --6.77883,0.96017,0.932037,2,3,0,7.01271,0.15 --6.83214,0.92718,0.932037,2,3,0,7.10706,0.15 --6.74855,0.999857,0.932037,1,3,0,6.82323,0.15 --6.75208,0.991977,0.932037,2,3,0,6.79074,0.15 --6.74875,1,0.932037,2,3,0,6.7511,0.15 --6.76331,0.987877,0.932037,2,3,0,6.81164,0.15 --7.11253,0.925924,0.932037,1,3,0,7.14728,0.15 --7.33832,0.934594,0.932037,2,3,0,7.89183,0.15 --7.40317,0.891695,0.932037,1,3,0,8.40906,0.15 --6.83199,1,0.932037,2,3,0,7.43757,0.15 --6.83199,0.774019,0.932037,1,3,0,8.04658,0.15 --6.99888,0.961352,0.932037,1,1,0,7.00012,0.15 --6.76802,0.991205,0.932037,2,3,0,7.06627,0.15 --7.1899,0.912501,0.932037,1,3,0,7.23327,0.15 --7.0344,0.951025,0.932037,1,3,0,7.71962,0.15 --6.74861,0.964191,0.932037,2,3,0,7.23266,0.15 --6.9356,0.954146,0.932037,1,3,0,6.96807,0.15 --6.8766,1,0.932037,1,1,0,6.94182,0.15 --6.86303,0.963467,0.932037,2,3,0,7.17361,0.15 --6.89691,0.996253,0.932037,2,3,0,6.92839,0.15 --6.74898,0.989445,0.932037,2,3,0,6.95643,0.15 --6.75192,0.906807,0.932037,2,3,0,7.25324,0.15 --6.89356,0.962004,0.932037,1,3,0,6.92873,0.15 --6.8915,1,0.932037,1,1,0,6.93856,0.15 --8.04782,0.661095,0.932037,1,1,0,8.04944,0.15 --6.96778,1,0.932037,2,3,0,8.10818,0.15 --6.94531,0.967319,0.932037,1,3,0,7.30665,0.15 --6.79303,1,0.932037,1,1,0,6.89785,0.15 --6.75073,0.998473,0.932037,1,3,0,6.79703,0.15 --6.74807,0.922346,0.932037,2,3,0,7.17097,0.15 --6.79664,0.986959,0.932037,2,3,0,6.82676,0.15 --7.42084,0.890966,0.932037,2,3,0,7.44601,0.15 --7.07938,1,0.932037,1,1,0,7.36895,0.15 --6.76996,0.975074,0.932037,1,3,0,7.1524,0.15 --6.97097,0.781354,0.932037,2,3,0,7.8694,0.15 --7.45672,0.874497,0.932037,1,3,0,7.94747,0.15 --7.73982,0.898709,0.932037,1,1,0,7.95818,0.15 --6.75761,1,0.932037,1,3,0,7.45331,0.15 --6.75128,1,0.932037,2,3,0,6.75597,0.15 --6.74857,0.969275,0.932037,2,3,0,6.90378,0.15 --6.78162,0.964009,0.932037,2,3,0,6.94604,0.15 --6.94452,0.969782,0.932037,1,3,0,6.94577,0.15 --6.83464,1,0.932037,1,1,0,6.92359,0.15 --6.85125,0.978801,0.932037,2,3,0,7.03988,0.15 --8.70862,0.498506,0.932037,2,3,0,10.892,0.15 --7.14422,0.988771,0.932037,1,3,0,8.54862,0.15 --8.22719,0.86569,0.932037,1,3,0,8.25029,0.15 --7.98302,1,0.932037,1,1,0,8.34174,0.15 --7.66766,1,0.932037,1,1,0,8.02784,0.15 --8.24143,0.924458,0.932037,1,1,0,8.28161,0.15 --7.67998,1,0.932037,1,1,0,8.20801,0.15 --7.87681,0.972029,0.932037,1,1,0,7.99803,0.15 --6.74849,0.941373,0.932037,1,3,0,7.96721,0.15 --7.11836,0.837369,0.932037,2,3,0,7.62397,0.15 --6.79142,1,0.932037,2,3,0,7.01021,0.15 --6.77524,1,0.932037,1,1,0,6.79217,0.15 --6.79636,0.997801,0.932037,2,3,0,6.8016,0.15 --6.79636,0.948581,0.932037,1,1,0,6.90729,0.15 --6.87559,0.872276,0.932037,2,3,0,7.36427,0.15 --7.91757,0.674512,0.932037,1,3,0,8.87065,0.15 --6.74935,0.935438,0.932037,1,3,0,8.03013,0.15 --6.74803,0.97594,0.932037,2,3,0,6.86976,0.15 --6.81513,0.982667,0.932037,1,3,0,6.82306,0.15 --7.49872,0.879887,0.932037,2,3,0,7.51782,0.15 --7.49872,0.948913,0.932037,1,1,0,7.85236,0.15 --8.04293,0.922216,0.932037,1,1,0,8.07282,0.15 --7.35293,1,0.932037,2,3,0,7.93996,0.15 --7.35293,0.883408,0.932037,1,1,0,8.02395,0.15 --6.80493,1,0.932037,1,3,0,7.25923,0.15 --6.82698,0.998151,0.932037,2,3,0,6.83752,0.15 --6.88114,0.986899,0.932037,1,1,0,6.89144,0.15 --6.74827,0.964042,0.932037,2,3,0,7.17919,0.15 --6.93633,0.882605,0.932037,2,3,0,7.40536,0.15 --8.02922,0.766313,0.932037,1,3,0,8.54794,0.15 --6.88064,1,0.932037,1,1,0,7.62039,0.15 --6.99856,0.960668,0.932037,1,1,0,7.02674,0.15 --6.9205,1,0.932037,1,1,0,7.0171,0.15 --7.23497,0.895629,0.932037,1,1,0,7.26191,0.15 --6.81255,0.65863,0.932037,2,3,0,8.81442,0.15 --6.8557,0.986062,0.932037,1,1,0,6.86976,0.15 --6.8557,0.724177,0.932037,1,3,0,7.66358,0.15 --6.75301,0.997497,0.932037,1,3,0,6.85969,0.15 --9.62741,0.500859,0.932037,1,3,0,9.855,0.15 --7.2064,1,0.932037,2,3,0,8.74926,0.15 --6.75431,0.815869,0.932037,2,3,0,7.99167,0.15 --6.77251,0.990864,0.932037,2,3,0,6.80395,0.15 --7.81008,0.844756,0.932037,2,3,0,8.00316,0.15 --8.11847,0.959711,0.932037,1,1,0,8.22643,0.15 --9.24757,0.890376,0.932037,2,3,0,10.2168,0.15 --6.88942,0.799493,0.932037,1,3,0,10.3695,0.15 --6.88942,0.261019,0.932037,1,3,0,10.9724,0.15 --6.80124,0.870892,0.932037,2,3,0,7.43049,0.15 --6.74978,0.998863,0.932037,1,3,0,6.80164,0.15 --7.17245,0.854684,0.932037,2,3,0,7.6,0.15 --8.81972,0.538088,0.932037,1,1,0,8.86828,0.15 --7.40622,1,0.932037,2,3,0,8.5393,0.15 --7.26318,0.961918,0.932037,2,3,0,8.05474,0.15 --7.34728,0.984906,0.932037,1,1,0,7.43596,0.15 --6.86243,0.997387,0.932037,1,3,0,7.24798,0.15 --6.89308,0.975225,0.932037,1,3,0,7.09809,0.15 --7.32886,0.939094,0.932037,2,3,0,7.34307,0.15 --7.57152,0.913466,0.932037,1,1,0,7.74604,0.15 --6.94728,1,0.932037,1,1,0,7.36923,0.15 --6.81842,1,0.932037,1,1,0,6.91356,0.15 --6.76216,1,0.932037,2,3,0,6.80728,0.15 --6.85768,0.974601,0.932037,2,3,0,6.94204,0.15 --6.77062,0.988638,0.932037,1,3,0,6.90934,0.15 --6.91451,0.978923,0.932037,2,3,0,6.91452,0.15 --6.78227,1,0.932037,1,1,0,6.87294,0.15 --7.62346,0.806356,0.932037,1,3,0,7.63204,0.15 --6.83206,1,0.932037,1,1,0,7.34914,0.15 --7.29941,0.815839,0.932037,2,3,0,7.843,0.15 --7.31671,0.996885,0.932037,1,1,0,7.4311,0.15 --6.78343,0.991818,0.932037,2,3,0,7.37529,0.15 --6.86006,0.980687,0.932037,1,1,0,6.8608,0.15 --6.77605,1,0.932037,1,1,0,6.83853,0.15 --6.86042,0.973286,0.932037,1,3,0,6.93518,0.15 --6.75338,0.997358,0.932037,1,3,0,6.86494,0.15 --6.83799,0.976298,0.932037,1,3,0,6.868,0.15 --7.00374,0.713633,0.932037,2,3,0,8.19304,0.15 --6.75259,0.98344,0.932037,2,3,0,7.10169,0.15 --6.79496,0.987555,0.932037,1,3,0,6.81495,0.15 --6.9391,0.981259,0.932037,2,3,0,6.94195,0.15 --7.22517,0.904285,0.932037,1,1,0,7.25937,0.15 --7.21052,1,0.932037,1,1,0,7.37602,0.15 --6.75985,0.787087,0.932037,2,3,0,8.11836,0.15 --6.86031,0.946513,0.932037,2,3,0,7.03793,0.15 --8.19403,0.780681,0.932037,1,3,0,8.38612,0.15 --6.7609,1,0.932037,2,3,0,7.87703,0.15 --6.95309,0.78127,0.932037,2,3,0,7.88077,0.15 --9.56705,0.565191,0.932037,1,3,0,10.2818,0.15 --6.75776,1,0.932037,1,3,0,8.93023,0.15 --6.77632,0.994978,0.932037,1,1,0,6.77679,0.15 --6.82265,0.996019,0.932037,2,3,0,6.82416,0.15 --6.89139,0.983404,0.932037,1,1,0,6.89889,0.15 --6.89139,0.777655,0.932037,1,3,0,8.12126,0.15 --7.13161,0.926877,0.932037,1,3,0,7.44089,0.15 --8.35546,0.633109,0.932037,1,1,0,8.40627,0.15 --7.06834,0.886614,0.932037,1,3,0,8.96147,0.15 --7.28399,0.958522,0.932037,1,1,0,7.31204,0.15 --7.28327,1,0.932037,1,1,0,7.40052,0.15 --7.93284,0.898826,0.932037,1,1,0,7.93762,0.15 --7.81694,1,0.932037,1,1,0,8.08024,0.15 --7.6919,1,0.932037,1,1,0,7.94232,0.15 --6.76979,0.932315,0.932037,1,3,0,7.86435,0.15 --6.97696,0.966811,0.932037,2,3,0,6.99094,0.15 --7.49857,0.902721,0.932037,2,3,0,7.93254,0.15 --7.50324,0.999237,0.932037,1,1,0,7.65578,0.15 --6.91611,1,0.932037,2,3,0,7.33316,0.15 --6.74956,1,0.932037,1,3,0,6.89861,0.15 --8.35635,0.667972,0.932037,1,3,0,8.48862,0.15 --8.35709,0.999715,0.932037,1,1,0,8.94945,0.15 --7.01492,1,0.932037,2,3,0,8.49553,0.15 --7.08433,0.985549,0.932037,1,1,0,7.13054,0.15 --7.29556,0.986569,0.932037,2,3,0,7.32674,0.15 --6.82002,1,0.932037,2,3,0,7.16863,0.15 --6.82002,0.827599,0.932037,1,1,0,7.18527,0.15 --6.96415,0.766705,0.932037,2,3,0,7.8936,0.15 --7.10108,0.953204,0.932037,1,1,0,7.15511,0.15 --7.08567,1,0.932037,1,1,0,7.2067,0.15 --8.18465,0.665208,0.932037,1,1,0,8.22692,0.15 --6.98816,1,0.932037,2,3,0,8.27915,0.15 --6.9991,0.951104,0.932037,2,3,0,7.40622,0.15 --6.87003,0.959893,0.932037,1,3,0,7.2399,0.15 --8.86597,0.67165,0.932037,1,3,0,9.3173,0.15 --9.22117,0.969943,0.932037,1,1,0,9.41531,0.15 --10.3294,0.926924,0.932037,1,1,0,10.3727,0.15 --8.32325,0.989504,0.932037,2,3,0,10.9313,0.15 --8.85098,0.946649,0.932037,1,1,0,8.95519,0.15 --9.31959,0.960963,0.932037,1,1,0,9.47897,0.15 --10.3022,0.93649,0.932037,1,1,0,10.3691,0.15 --10.3363,0.998194,0.932037,1,1,0,10.7444,0.15 --7.06812,1,0.932037,2,3,0,10.0104,0.15 --7.09449,0.998201,0.932037,2,3,0,7.16215,0.15 --7.41044,0.941678,0.932037,1,1,0,7.42835,0.15 --6.74954,0.897451,0.932037,2,3,0,8.358,0.15 --7.01483,0.952044,0.932037,2,3,0,7.06471,0.15 --7.04361,0.949288,0.932037,1,3,0,7.50082,0.15 --6.84344,1,0.932037,1,1,0,6.98754,0.15 --6.76346,1,0.932037,1,1,0,6.81845,0.15 --6.77171,0.981093,0.932037,2,3,0,6.85292,0.15 --6.84864,0.975946,0.932037,1,1,0,6.84963,0.15 --6.79009,1,0.932037,1,1,0,6.8359,0.15 --7.3603,0.823525,0.932037,1,3,0,7.7309,0.15 --7.81047,0.929962,0.932037,1,1,0,7.84015,0.15 --7.78154,1,0.932037,1,1,0,7.99363,0.15 --6.7517,1,0.932037,2,3,0,7.65292,0.15 --6.78798,0.848042,0.932037,2,3,0,7.61324,0.15 --6.76,0.921142,0.932037,2,3,0,7.25211,0.15 --6.79557,0.983288,0.932037,2,3,0,6.85013,0.15 --7.19183,0.926349,0.932037,1,3,0,7.21025,0.15 --7.38792,0.988215,0.932037,2,3,0,7.43851,0.15 --6.96601,1,0.932037,2,3,0,7.30212,0.15 --7.05786,0.980406,0.932037,1,1,0,7.08973,0.15 --7.16196,0.993052,0.932037,2,3,0,7.20877,0.15 --6.77281,0.912405,0.932037,2,3,0,8.28922,0.15 --6.75974,1,0.932037,1,1,0,6.77054,0.15 --6.74904,0.896827,0.932037,2,3,0,7.34903,0.15 --6.99017,0.938166,0.932037,1,3,0,7.02613,0.15 --9.18272,0.444151,0.932037,1,1,0,9.18621,0.15 --7.27998,1,0.932037,1,1,0,8.53072,0.15 --6.81588,0.976625,0.932037,1,3,0,7.39388,0.15 --6.85158,0.981914,0.932037,1,3,0,6.98055,0.15 --7.61781,0.765141,0.932037,1,1,0,7.61874,0.15 --6.79258,0.997137,0.932037,1,3,0,7.61795,0.15 --8.09444,0.722711,0.932037,1,3,0,8.35089,0.15 --8.09444,0.731058,0.932037,1,1,0,9.00859,0.15 --8.96537,0.715603,0.932037,1,1,0,9.37304,0.15 --8.78035,1,0.932037,1,1,0,9.62889,0.15 --7.21874,0.836764,0.932037,1,3,0,9.71962,0.15 --6.75061,0.911636,0.932037,2,3,0,8.14176,0.15 --7.65204,0.639147,0.932037,2,3,0,8.88575,0.15 --6.95151,1,0.932037,1,1,0,7.42019,0.15 --7.03245,0.89047,0.932037,2,3,0,7.4925,0.15 --6.93323,1,0.932037,1,1,0,7.03482,0.15 --6.93323,0.839701,0.932037,1,3,0,7.95662,0.15 --6.8181,1,0.932037,1,1,0,6.90794,0.15 --6.96817,0.964576,0.932037,1,1,0,6.96901,0.15 --6.75177,1,0.932037,2,3,0,6.94088,0.15 --6.75748,0.994596,0.932037,2,3,0,6.77947,0.15 --6.75598,1,0.932037,2,3,0,6.75911,0.15 --7.35596,0.838068,0.932037,1,3,0,7.60728,0.15 --6.75779,0.906448,0.932037,2,3,0,8.09794,0.15 --6.83162,0.952059,0.932037,2,3,0,6.9908,0.15 --7.67816,0.806003,0.932037,1,3,0,7.67819,0.15 --6.92603,0.932427,0.932037,1,3,0,8.01057,0.15 --7.07054,0.950192,0.932037,2,3,0,7.4224,0.15 --6.7484,0.994215,0.932037,1,3,0,7.0485,0.15 --7.08258,0.918347,0.932037,1,3,0,7.15481,0.15 --7.08258,0.737878,0.932037,1,3,0,9.18161,0.15 --7.35202,0.949338,0.932037,1,1,0,7.3743,0.15 --6.74881,0.983413,0.932037,1,3,0,7.33477,0.15 --6.95539,0.949695,0.932037,1,3,0,6.9911,0.15 --7.15608,0.958335,0.932037,1,1,0,7.16954,0.15 --6.83348,0.99773,0.932037,1,3,0,7.08351,0.15 --7.24483,0.931935,0.932037,1,3,0,7.25275,0.15 --6.98535,1,0.932037,1,1,0,7.20252,0.15 --6.79714,0.986131,0.932037,2,3,0,7.11242,0.15 --6.75975,0.994219,0.932037,2,3,0,6.84154,0.15 --7.85764,0.768175,0.932037,1,3,0,8.13554,0.15 --7.75607,1,0.932037,2,3,0,8.00291,0.15 --7.45436,1,0.932037,1,1,0,7.77479,0.15 --6.75812,0.956844,0.932037,1,3,0,7.53861,0.15 --6.78653,0.996723,0.932037,2,3,0,6.78699,0.15 --6.78653,0.689753,0.932037,1,3,0,7.7558,0.15 --7.13767,0.941965,0.932037,2,3,0,7.15428,0.15 --6.8166,0.824152,0.932037,2,3,0,8.71226,0.15 --6.79612,1,0.932037,1,1,0,6.82009,0.15 --7.16066,0.926371,0.932037,2,3,0,7.36744,0.15 --6.7485,0.867631,0.932037,2,3,0,8.25218,0.15 --6.7485,0.374064,0.932037,1,3,0,9.69677,0.15 --6.906,0.899506,0.932037,2,3,0,7.30301,0.15 --6.97495,0.960716,0.932037,1,3,0,7.26467,0.15 --6.87784,0.957976,0.932037,1,3,0,7.22871,0.15 --6.76764,1,0.932037,1,3,0,6.85023,0.15 --7.06045,0.939987,0.932037,2,3,0,7.20313,0.15 --7.56678,0.90837,0.932037,1,1,0,7.56807,0.15 --8.21909,0.9114,0.932037,1,1,0,8.24106,0.15 --7.1694,0.972439,0.932037,1,3,0,8.05615,0.15 --7.51659,0.939017,0.932037,1,1,0,7.53941,0.15 --6.80441,1,0.932037,2,3,0,7.33714,0.15 --6.84769,0.986098,0.932037,1,1,0,6.85924,0.15 --6.75447,1,0.932037,1,3,0,6.82024,0.15 --6.75447,0.941471,0.932037,1,3,0,6.92636,0.15 --7.31897,0.848317,0.932037,1,3,0,7.54592,0.15 --7.51256,0.936742,0.932037,2,3,0,8.23518,0.15 --7.00844,1,0.932037,1,1,0,7.41354,0.15 --6.81721,1,0.932037,2,3,0,6.95395,0.15 --7.45194,0.852204,0.932037,1,3,0,7.45194,0.15 --6.87259,1,0.932037,2,3,0,7.42285,0.15 --6.75616,1,0.932037,1,3,0,6.8471,0.15 --6.89502,0.961898,0.932037,1,3,0,6.94092,0.15 --6.77836,1,0.932037,2,3,0,6.87334,0.15 --6.79421,0.982898,0.932037,2,3,0,6.9004,0.15 --7.26621,0.798873,0.932037,2,3,0,7.90837,0.15 --6.86681,0.892468,0.932037,2,3,0,9.22078,0.15 --6.79361,1,0.932037,1,1,0,6.85058,0.15 --6.77748,1,0.932037,2,3,0,6.79435,0.15 --6.77887,0.999632,0.932037,1,1,0,6.78659,0.15 --6.78375,0.998717,0.932037,1,1,0,6.79108,0.15 --6.74954,0.987641,0.932037,2,3,0,6.86737,0.15 --7.83854,0.756676,0.932037,1,3,0,7.90005,0.15 --7.50039,1,0.932037,1,1,0,7.94015,0.15 --6.7491,1,0.932037,1,3,0,7.35194,0.15 --6.7636,0.996702,0.932037,1,3,0,6.76405,0.15 --6.78205,0.845782,0.932037,2,3,0,7.69714,0.15 --6.75014,0.997559,0.932037,2,3,0,6.79806,0.15 --8.34122,0.670679,0.932037,1,3,0,8.47733,0.15 --7.99963,1,0.932037,1,1,0,8.62888,0.15 --8.76385,0.745363,0.932037,1,1,0,9.14503,0.15 --7.04418,1,0.932037,1,1,0,8.14217,0.15 --7.43305,0.868749,0.932037,1,1,0,7.49441,0.15 --7.43305,0.297658,0.932037,1,1,0,9.48457,0.15 --6.83865,0.968461,0.932037,1,3,0,7.58424,0.15 --7.53033,0.883514,0.932037,1,3,0,7.57348,0.15 --6.96261,0.979104,0.932037,2,3,0,7.81614,0.15 --7.0999,0.990364,0.932037,2,3,0,7.12317,0.15 --8.07438,0.928426,0.932037,2,3,0,8.16995,0.15 --7.08332,1,0.932037,1,1,0,7.75278,0.15 --6.82918,1,0.932037,1,1,0,7.0036,0.15 --7.53288,0.784396,0.932037,1,1,0,7.53294,0.15 --7.05091,1,0.932037,2,3,0,7.39902,0.15 --7.40251,0.977978,0.932037,2,3,0,7.41207,0.15 --6.82898,1,0.932037,2,3,0,7.24836,0.15 --6.79153,1,0.932037,1,1,0,6.8253,0.15 --6.79153,0.459704,0.932037,1,3,0,9.85444,0.15 --6.76756,1,0.932037,1,1,0,6.7869,0.15 --6.97728,0.932763,0.932037,1,3,0,7.10469,0.15 --6.95157,1,0.932037,1,1,0,7.01491,0.15 --6.75905,0.960947,0.932037,2,3,0,7.21354,0.15 --6.7615,0.936647,0.932037,2,3,0,7.06828,0.15 --6.89331,0.972573,0.932037,1,3,0,6.89762,0.15 --6.77722,0.906489,0.932037,2,3,0,7.52048,0.15 --7.05175,0.910169,0.932037,1,3,0,7.23443,0.15 --6.92365,1,0.932037,1,1,0,7.04143,0.15 --6.92285,1,0.932037,2,3,0,6.9668,0.15 --7.13379,0.955304,0.932037,1,1,0,7.14184,0.15 --7.4804,0.884188,0.932037,1,3,0,8.21421,0.15 --7.40948,1,0.932037,1,1,0,7.67663,0.15 --6.7729,0.94969,0.932037,2,3,0,7.7319,0.15 --6.88124,0.967448,0.932037,1,3,0,6.95576,0.15 --8.24949,0.746027,0.932037,2,3,0,8.25756,0.15 --6.96905,1,0.932037,1,3,0,8.10239,0.15 --7.27306,0.939109,0.932037,1,1,0,7.27863,0.15 --7.00308,0.956818,0.932037,1,3,0,7.78354,0.15 --6.75472,0.998187,0.932037,1,3,0,6.9917,0.15 --6.75494,0.999941,0.932037,1,1,0,6.75678,0.15 --6.87358,0.96725,0.932037,1,3,0,6.91321,0.15 --6.88529,0.996099,0.932037,1,1,0,6.92345,0.15 --8.16803,0.810902,0.932037,2,3,0,8.16856,0.15 --8.16803,0.500501,0.932037,1,1,0,9.65653,0.15 --6.84099,0.909134,0.932037,2,3,0,8.86386,0.15 --6.7482,0.97014,0.932037,2,3,0,7.07304,0.15 --6.88126,0.965042,0.932037,1,3,0,6.91312,0.15 --6.91537,0.971395,0.932037,1,3,0,7.15288,0.15 --6.74803,1,0.932037,1,3,0,6.88372,0.15 --6.78862,0.991449,0.932037,2,3,0,6.8033,0.15 --6.75166,1,0.932037,1,3,0,6.77932,0.15 --7.64177,0.652534,0.932037,2,3,0,8.81793,0.15 --7.39307,1,0.932037,1,1,0,7.74629,0.15 --7.39307,0.385651,0.932037,1,1,0,9.0256,0.15 --6.79731,0.988358,0.932037,1,3,0,7.44468,0.15 --7.26742,0.912562,0.932037,1,3,0,7.29563,0.15 --8.03606,0.881597,0.932037,1,1,0,8.03636,0.15 --7.18684,0.969203,0.932037,1,3,0,7.89297,0.15 --7.82185,0.895632,0.932037,1,1,0,7.82342,0.15 --6.9258,0.999365,0.932037,1,3,0,7.68077,0.15 --6.84345,1,0.932037,1,1,0,6.91592,0.15 --8.02819,0.799375,0.932037,1,3,0,8.18865,0.15 --9.74173,0.805241,0.932037,1,3,0,9.76127,0.15 --8.33143,1,0.932037,1,1,0,9.60755,0.15 --7.18582,0.972127,0.932037,1,3,0,8.16309,0.15 --6.92783,1,0.932037,1,1,0,7.13538,0.15 --7.11005,0.961217,0.932037,1,1,0,7.12168,0.15 --6.79373,1,0.932037,1,3,0,7.04271,0.15 --7.11956,0.955726,0.932037,2,3,0,7.20271,0.15 --7.48398,0.958399,0.932037,2,3,0,7.57261,0.15 --7.05344,1,0.932037,2,3,0,7.38948,0.15 --6.89526,1,0.932037,1,1,0,7.02854,0.15 --6.75297,0.996542,0.932037,2,3,0,6.92061,0.15 --6.83977,0.975809,0.932037,1,3,0,6.86918,0.15 --6.8251,1,0.932037,2,3,0,6.85672,0.15 --6.76932,1,0.932037,1,1,0,6.8089,0.15 --7.2411,0.887441,0.932037,1,3,0,7.24713,0.15 --6.77198,0.978158,0.932037,2,3,0,7.39681,0.15 --6.91344,0.959133,0.932037,1,3,0,6.99309,0.15 --7.04881,0.85015,0.932037,2,3,0,7.62026,0.15 --7.60525,0.863371,0.932037,1,3,0,8.23873,0.15 --6.78473,0.999819,0.932037,1,3,0,7.58373,0.15 --6.78473,0.898858,0.932037,1,3,0,7.22409,0.15 --7.78377,0.579188,0.932037,2,3,0,9.7066,0.15 --7.70743,1,0.932037,1,1,0,7.93357,0.15 --7.96247,0.96471,0.932037,1,1,0,8.07171,0.15 --7.12674,0.974601,0.932037,1,3,0,7.81844,0.15 --6.75681,1,0.932037,1,3,0,7.07784,0.15 --6.74929,0.899259,0.932037,2,3,0,7.32696,0.15 --6.74929,0.646445,0.932037,1,3,0,8.08205,0.15 --7.15628,0.857788,0.932037,2,3,0,7.57467,0.15 --7.75903,0.923317,0.932037,2,3,0,7.84476,0.15 --6.85106,0.987384,0.932037,2,3,0,7.98227,0.15 --8.0294,0.746944,0.932037,1,3,0,8.39902,0.15 --6.8022,0.859301,0.932037,2,3,0,8.84948,0.15 --6.77032,1,0.932037,1,1,0,6.79542,0.15 --7.64151,0.740592,0.932037,2,3,0,8.46249,0.15 --8.37811,0.917274,0.932037,2,3,0,8.62816,0.15 --7.49482,1,0.932037,1,1,0,8.22793,0.15 --9.18827,0.523755,0.932037,1,1,0,9.33046,0.15 --7.76093,1,0.932037,1,1,0,8.88732,0.15 --6.97798,1,0.932037,1,1,0,7.50122,0.15 --7.35575,0.873861,0.932037,1,1,0,7.39654,0.15 --7.35575,0.110444,0.932037,1,1,0,11.0745,0.15 --7.35575,0.0800688,0.932037,1,3,0,15.4327,0.15 --7.48223,0.672997,0.932037,1,3,0,8.8362,0.15 --6.78001,0.901552,0.932037,2,3,0,8.42084,0.15 --7.27496,0.91456,0.932037,2,3,0,7.304,0.15 --7.27496,0.889573,0.932037,1,1,0,7.87313,0.15 --6.74818,0.981145,0.932037,1,3,0,7.27579,0.15 --6.74818,0.540736,0.932037,1,3,0,8.56126,0.15 --6.84577,0.975084,0.932037,1,3,0,6.8552,0.15 --6.84577,0.460221,0.932037,1,3,0,8.80117,0.15 --7.22623,0.87774,0.932037,1,1,0,7.23183,0.15 --6.86085,0.957571,0.932037,1,3,0,7.44679,0.15 --6.84216,1,0.932037,1,1,0,6.8764,0.15 --6.82726,0.902432,0.932037,2,3,0,7.67881,0.15 --7.01244,0.957121,0.932037,1,1,0,7.01282,0.15 --6.753,0.947388,0.932037,2,3,0,7.40574,0.15 --6.75612,0.999688,0.932037,2,3,0,6.75709,0.15 --7.10487,0.901325,0.932037,1,3,0,7.25063,0.15 --6.75288,0.934052,0.932037,2,3,0,7.61355,0.15 --6.75911,0.998131,0.932037,1,1,0,6.75973,0.15 --6.97448,0.935151,0.932037,1,3,0,7.07933,0.15 --8.33687,0.727783,0.932037,1,3,0,8.95629,0.15 --7.19311,1,0.932037,1,1,0,7.97929,0.15 --6.86239,0.957299,0.932037,1,3,0,7.41859,0.15 --8.81489,0.675307,0.932037,1,3,0,9.25628,0.15 --9.08174,0.976561,0.932037,1,1,0,9.30033,0.15 --8.72465,1,0.932037,2,3,0,9.23184,0.15 --9.02058,0.973248,0.932037,1,1,0,9.2222,0.15 --6.75096,0.87105,0.932037,1,3,0,9.3739,0.15 --6.77061,0.8673,0.932037,2,3,0,7.49474,0.15 --7.18049,0.687335,0.932037,2,3,0,8.77168,0.15 --6.83677,0.997719,0.932037,1,3,0,7.10412,0.15 --7.0242,0.942244,0.932037,1,3,0,7.2293,0.15 --6.75027,1,0.932037,1,3,0,6.95554,0.15 --7.19098,0.922423,0.932037,2,3,0,7.25741,0.15 --6.75095,0.998409,0.932037,2,3,0,7.18042,0.15 --6.87936,0.965588,0.932037,1,3,0,6.90968,0.15 --6.78928,1,0.932037,2,3,0,6.85581,0.15 --7.24713,0.912602,0.932037,1,3,0,7.27833,0.15 --7.64349,0.933948,0.932037,1,1,0,7.6686,0.15 --7.89818,0.963732,0.932037,1,1,0,7.99945,0.15 --9.96894,0.866816,0.932037,2,3,0,10.0037,0.15 --8.27408,1,0.932037,1,1,0,9.73188,0.15 --8.97796,0.763178,0.932037,1,1,0,9.46742,0.15 --7.07994,1,0.932037,2,3,0,9.38837,0.15 --6.75736,0.879611,0.932037,2,3,0,8.01228,0.15 --6.7519,1,0.932037,1,1,0,6.75617,0.15 --6.78524,0.992274,0.932037,1,3,0,6.78539,0.15 --7.86462,0.758008,0.932037,1,3,0,7.87664,0.15 --7.97349,0.959152,0.932037,1,1,0,8.36464,0.15 --7.11236,1,0.932037,2,3,0,7.71314,0.15 --7.71805,0.799983,0.932037,1,1,0,7.78908,0.15 --9.81575,0.716945,0.932037,2,3,0,10.0088,0.15 --7.32169,1,0.932037,1,1,0,8.93058,0.15 --6.74807,0.833534,0.932037,2,3,0,8.05557,0.15 --6.74803,1,0.932037,2,3,0,6.74806,0.15 --6.75538,0.991246,0.932037,2,3,0,6.79373,0.15 --6.93792,0.962649,0.932037,2,3,0,7.01983,0.15 --7.2862,0.88434,0.932037,1,1,0,7.31645,0.15 --6.99084,1,0.932037,2,3,0,7.19845,0.15 --7.65042,0.905856,0.932037,2,3,0,8.20379,0.15 --7.41337,1,0.932037,1,1,0,7.7679,0.15 --8.85702,0.576942,0.932037,1,1,0,8.98493,0.15 --6.78589,1,0.932037,1,3,0,8.17164,0.15 --6.90223,0.954007,0.932037,1,3,0,7.03131,0.15 --8.14191,0.811993,0.932037,1,3,0,8.27248,0.15 --8.10592,1,0.932037,1,1,0,8.36491,0.15 --8.2689,0.993522,0.932037,2,3,0,8.4528,0.15 --9.32894,0.899169,0.932037,1,1,0,9.34484,0.15 --8.02809,1,0.932037,1,1,0,9.18688,0.15 --6.99166,0.993898,0.932037,1,3,0,7.87392,0.15 --8.06441,0.911089,0.932037,2,3,0,8.31617,0.15 --8.7506,0.922675,0.932037,2,3,0,9.16274,0.15 --7.8978,1,0.932037,1,1,0,8.75888,0.15 --6.94446,1,0.932037,1,1,0,7.56554,0.15 --8.54285,0.771096,0.932037,2,3,0,8.54633,0.15 --6.78594,1,0.932037,1,3,0,7.9627,0.15 --6.78594,0.906519,0.932037,1,3,0,7.16707,0.15 --6.92112,0.942672,0.932037,2,3,0,7.08892,0.15 --6.87261,0.875781,0.932037,2,3,0,8.17854,0.15 --7.08975,0.952205,0.932037,1,1,0,7.09201,0.15 --7.02149,1,0.932037,2,3,0,7.12326,0.15 --7.04584,0.998287,0.932037,2,3,0,7.10444,0.15 --7.04584,0.672299,0.932037,1,3,0,9.55749,0.15 --7.77921,0.832639,0.932037,1,3,0,8.43718,0.15 --6.93132,0.932106,0.932037,1,3,0,8.11383,0.15 --7.37155,0.932331,0.932037,1,3,0,7.37171,0.15 --6.74802,0.977866,0.932037,1,3,0,7.37247,0.15 --6.90501,0.947815,0.932037,2,3,0,7.04469,0.15 --6.90501,0.515929,0.932037,1,1,0,8.06608,0.15 --7.26517,0.747153,0.932037,2,3,0,8.10285,0.15 --6.77759,0.959776,0.932037,1,3,0,7.38193,0.15 --6.75799,1,0.932037,1,1,0,6.77244,0.15 --6.79277,0.99575,0.932037,2,3,0,6.79381,0.15 --6.76109,1,0.932037,1,1,0,6.78457,0.15 --6.7596,0.969448,0.932037,2,3,0,6.95304,0.15 --6.79156,0.988014,0.932037,2,3,0,6.84381,0.15 --6.78312,1,0.932037,1,1,0,6.79707,0.15 --6.77762,0.949288,0.932037,2,3,0,7.08484,0.15 --7.09494,0.924565,0.932037,1,3,0,7.09566,0.15 --6.95426,1,0.932037,2,3,0,7.09613,0.15 --7.28442,0.889685,0.932037,1,1,0,7.32064,0.15 --6.79484,0.997398,0.932037,2,3,0,7.36362,0.15 --6.81648,0.99449,0.932037,1,1,0,6.8247,0.15 --6.84974,0.991789,0.932037,1,1,0,6.86103,0.15 --6.74879,0.865097,0.932037,2,3,0,7.74614,0.15 --6.88211,0.967449,0.932037,1,3,0,6.902,0.15 --6.74845,0.957844,0.932037,2,3,0,7.24214,0.15 --7.20685,0.887254,0.932037,1,3,0,7.25766,0.15 --7.20685,0.564767,0.932037,1,3,0,8.81898,0.15 --7.20685,0.320306,0.932037,1,3,0,12.13,0.15 --6.97752,0.935114,0.932037,2,3,0,7.66742,0.15 --6.87049,1,0.932037,1,1,0,6.96427,0.15 --6.74837,0.966424,0.932037,2,3,0,7.14605,0.15 --6.98253,0.907073,0.932037,2,3,0,7.2529,0.15 --7.79349,0.745081,0.932037,1,1,0,7.81771,0.15 --6.77388,1,0.932037,1,3,0,7.46942,0.15 --6.90086,0.954561,0.932037,1,3,0,7.00827,0.15 --6.79914,1,0.932037,2,3,0,6.8716,0.15 --8.11178,0.713466,0.932037,1,3,0,8.12201,0.15 --8.11178,0.190125,0.932037,1,1,0,11.1441,0.15 --7.24841,1,0.932037,1,1,0,7.88964,0.15 --7.23081,1,0.932037,1,1,0,7.40517,0.15 --6.80377,1,0.932037,2,3,0,7.08741,0.15 --6.85418,0.994603,0.932037,2,3,0,6.86482,0.15 --6.74965,0.98222,0.932037,2,3,0,6.95136,0.15 --7.03844,0.928412,0.932037,1,3,0,7.0566,0.15 --7.22621,0.808036,0.932037,1,3,0,7.93488,0.15 --6.77583,0.927823,0.932037,2,3,0,7.69178,0.15 --6.86535,0.971878,0.932037,1,1,0,6.86662,0.15 --6.77928,0.990027,0.932037,1,3,0,6.92787,0.15 --6.78451,0.998625,0.932037,1,1,0,6.79187,0.15 --6.78451,0.773207,0.932037,1,3,0,7.90069,0.15 --6.75189,0.967957,0.932037,2,3,0,6.99818,0.15 --6.88731,0.96889,0.932037,1,3,0,6.89993,0.15 --6.83332,1,0.932037,1,1,0,6.8859,0.15 --6.96445,0.969353,0.932037,1,1,0,6.9678,0.15 --6.74853,0.993691,0.932037,1,3,0,6.95955,0.15 --6.79227,0.98474,0.932037,2,3,0,6.83336,0.15 --6.78141,0.965461,0.932037,2,3,0,6.96936,0.15 --6.75837,0.995995,0.932037,1,3,0,6.80286,0.15 --6.80841,0.982527,0.932037,1,3,0,6.84862,0.15 --6.92145,0.989324,0.932037,2,3,0,6.92312,0.15 --6.94393,0.992369,0.932037,1,1,0,6.99666,0.15 --8.0719,0.66438,0.932037,1,1,0,8.0808,0.15 --8.30789,0.913191,0.932037,1,1,0,8.7652,0.15 --6.88395,1,0.932037,2,3,0,7.79691,0.15 --6.88395,0.525809,0.932037,1,3,0,8.46396,0.15 --7.66074,0.862122,0.932037,2,3,0,7.66587,0.15 --7.48718,1,0.932037,1,1,0,7.73391,0.15 --7.24771,1,0.932037,1,1,0,7.49536,0.15 --6.75294,0.907734,0.932037,2,3,0,8.2612,0.15 --6.75294,0.882023,0.932037,1,3,0,7.23222,0.15 --6.75294,0.648763,0.932037,1,3,0,8.1161,0.15 --6.75671,0.998954,0.932037,1,1,0,6.75747,0.15 --7.51733,0.821118,0.932037,1,3,0,7.63136,0.15 --7.23718,1,0.932037,2,3,0,7.55107,0.15 --7.23718,0.584164,0.932037,1,1,0,8.1976,0.15 --6.75151,1,0.932037,1,3,0,7.10952,0.15 --6.76119,0.993068,0.932037,2,3,0,6.78713,0.15 --6.79508,0.984853,0.932037,2,3,0,6.84415,0.15 --8.30022,0.789495,0.932037,2,3,0,8.51335,0.15 --7.08882,0.985416,0.932037,1,3,0,8.13433,0.15 --6.74804,0.991804,0.932037,1,3,0,7.07332,0.15 --6.76797,0.994746,0.932037,1,3,0,6.77114,0.15 --6.87611,0.984786,0.932037,2,3,0,6.88112,0.15 --7.10363,0.930507,0.932037,1,3,0,7.38443,0.15 --7.1931,0.968366,0.932037,1,1,0,7.30124,0.15 --7.02744,1,0.932037,1,1,0,7.20716,0.15 --7.47087,0.716122,0.932037,1,3,0,8.36114,0.15 --7.77445,0.953734,0.932037,1,1,0,7.84235,0.15 --7.10232,0.976364,0.932037,1,3,0,7.65215,0.15 --6.89247,0.977052,0.932037,2,3,0,7.36801,0.15 --6.88406,1,0.932037,2,3,0,6.92287,0.15 --7.00739,0.972361,0.932037,1,1,0,7.01912,0.15 --7.4581,0.959878,0.932037,2,3,0,7.46539,0.15 --7.4581,0.358894,0.932037,1,1,0,9.21803,0.15 --8.39486,0.699937,0.932037,1,1,0,8.5651,0.15 --6.98009,0.931934,0.932037,1,3,0,8.77344,0.15 --7.75622,0.895607,0.932037,2,3,0,8.30908,0.15 --7.45294,1,0.932037,1,1,0,7.85686,0.15 --7.81191,0.87317,0.932037,1,1,0,8.02199,0.15 --7.07889,1,0.932037,2,3,0,7.65163,0.15 --8.02018,0.93056,0.932037,2,3,0,8.11738,0.15 --7.32245,1,0.932037,1,1,0,7.89443,0.15 --7.11924,1,0.932037,2,3,0,7.35057,0.15 --7.13426,0.994637,0.932037,1,1,0,7.25741,0.15 --6.81324,1,0.932037,1,1,0,7.02809,0.15 --7.90962,0.554652,0.932037,2,3,0,9.26763,0.15 --10.1284,0.790216,0.932037,1,3,0,10.2416,0.15 --8.90062,1,0.932037,1,1,0,10.0537,0.15 --6.80723,1,0.932037,2,3,0,8.62687,0.15 --6.86729,0.973895,0.932037,2,3,0,7.02735,0.15 --6.79392,1,0.932037,1,1,0,6.85106,0.15 --7.40012,0.888235,0.932037,2,3,0,7.70807,0.15 --6.93792,1,0.932037,2,3,0,7.29993,0.15 --7.00949,0.984312,0.932037,1,1,0,7.03975,0.15 --7.13808,0.973678,0.932037,1,1,0,7.17115,0.15 --6.78692,0.965669,0.932037,1,3,0,7.25761,0.15 --6.87345,0.885758,0.932037,2,3,0,7.29989,0.15 --7.7385,0.869841,0.932037,2,3,0,7.74068,0.15 --7.7385,0.102215,0.932037,1,1,0,11.7215,0.15 --8.03266,0.893586,0.932037,1,1,0,8.35655,0.15 --8.22194,0.92979,0.932037,1,1,0,8.66902,0.15 --7.3561,1,0.932037,2,3,0,7.97443,0.15 --6.78127,1,0.932037,1,3,0,7.27452,0.15 --6.82275,0.984055,0.932037,1,3,0,6.89491,0.15 --7.6571,0.742126,0.932037,1,3,0,8.29259,0.15 --8.03026,0.829375,0.932037,1,3,0,9.64909,0.15 --7.37223,1,0.932037,1,1,0,7.93907,0.15 --6.79515,0.988926,0.932037,1,3,0,7.42116,0.15 --6.82487,0.992469,0.932037,1,1,0,6.83189,0.15 --7.12496,0.969767,0.932037,2,3,0,7.16248,0.15 --8.26834,0.652897,0.932037,1,1,0,8.32004,0.15 --8.67193,0.856184,0.932037,1,1,0,9.18766,0.15 --6.90442,1,0.932037,1,1,0,8.03082,0.15 --7.94108,0.68975,0.932037,1,1,0,7.94519,0.15 --7.78516,0.528351,0.932037,1,3,0,10.1916,0.15 --7.48177,1,0.932037,1,1,0,7.8074,0.15 --6.80338,0.90422,0.932037,2,3,0,8.07863,0.15 --6.89878,0.96934,0.932037,1,1,0,6.90583,0.15 --7.30937,0.866085,0.932037,1,1,0,7.32592,0.15 --6.85274,1,0.932037,1,1,0,7.15684,0.15 --6.85274,0.743543,0.932037,1,3,0,7.59752,0.15 --6.85274,0.563681,0.932037,1,3,0,9.12334,0.15 --7.14252,0.905701,0.932037,1,1,0,7.15244,0.15 --6.88606,1,0.932037,1,1,0,7.07414,0.15 --6.81352,1,0.932037,1,1,0,6.87385,0.15 --7.22426,0.603012,0.932037,2,3,0,8.88007,0.15 --6.75466,1,0.932037,1,3,0,7.17215,0.15 --6.77207,0.962029,0.932037,2,3,0,6.97984,0.15 --7.20122,0.9126,0.932037,1,3,0,7.2415,0.15 --7.97419,0.889846,0.932037,1,3,0,7.97427,0.15 --7.1089,0.976552,0.932037,1,3,0,7.82637,0.15 --7.1089,0.884111,0.932037,1,3,0,7.82698,0.15 --6.98201,0.835391,0.932037,2,3,0,9.32581,0.15 --7.4823,0.923908,0.932037,1,3,0,7.48233,0.15 --8.13382,0.907974,0.932037,1,1,0,8.15008,0.15 --7.0191,0.992287,0.932037,1,3,0,7.97523,0.15 --7.38884,0.929413,0.932037,1,1,0,7.39423,0.15 --7.05345,0.945247,0.932037,1,3,0,8.00914,0.15 --7.88022,0.88235,0.932037,2,3,0,7.92302,0.15 --7.47896,1,0.932037,1,1,0,7.94438,0.15 --8.26848,0.902685,0.932037,2,3,0,8.45552,0.15 --8.36145,0.964836,0.932037,1,1,0,8.90958,0.15 --6.80918,1,0.932037,1,3,0,7.82987,0.15 --7.23868,0.600861,0.932037,2,3,0,8.89375,0.15 --6.89006,1,0.932037,1,1,0,7.13419,0.15 --6.8044,1,0.932037,2,3,0,6.86543,0.15 --6.86009,0.995405,0.932037,2,3,0,6.86567,0.15 --6.86009,0.799308,0.932037,1,3,0,7.97123,0.15 --8.99856,0.728419,0.932037,2,3,0,9.23129,0.15 --9.09468,0.991837,0.932037,1,1,0,9.38997,0.15 --8.73756,1,0.932037,1,1,0,9.24597,0.15 --7.55986,0.937761,0.932037,1,3,0,8.57866,0.15 --7.99912,0.937675,0.932037,1,1,0,8.05117,0.15 --7.76055,1,0.932037,1,1,0,8.08641,0.15 --8.28732,0.977606,0.932037,2,3,0,8.34339,0.15 --6.82679,0.992827,0.932037,1,3,0,8.22618,0.15 --6.87274,0.996281,0.932037,2,3,0,6.88424,0.15 --6.78865,0.91873,0.932037,2,3,0,7.41091,0.15 --6.76058,1,0.932037,2,3,0,6.78115,0.15 --6.76058,0.44465,0.932037,2,3,0,10.1097,0.15 --8.19963,0.701948,0.932037,1,3,0,8.62984,0.15 --6.87827,1,0.932037,1,3,0,8.08649,0.15 --6.90011,0.99488,0.932037,1,1,0,6.92793,0.15 --7.58846,0.835161,0.932037,1,3,0,7.98997,0.15 --6.84168,1,0.932037,2,3,0,7.32922,0.15 --6.79898,0.907476,0.932037,2,3,0,7.23342,0.15 --7.18968,0.940405,0.932037,2,3,0,7.1897,0.15 --7.30081,0.811278,0.932037,2,3,0,8.27114,0.15 --7.44395,0.975262,0.932037,1,1,0,7.52376,0.15 --7.10913,1,0.932037,1,1,0,7.3984,0.15 --6.74902,0.994264,0.932037,1,3,0,7.08219,0.15 --7.95169,0.736282,0.932037,1,3,0,8.05657,0.15 -# -# Elapsed Time: 0.005 seconds (Warm-up) -# 0.012 seconds (Sampling) -# 0.017 seconds (Total) -# diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv deleted file mode 100644 index b4a727ec85..0000000000 --- a/src/test/unit/mcmc/test_csv_files/bernoulli_const_2.csv +++ /dev/null @@ -1,1057 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 35 -# stan_version_patch = 0 -# model = bernoulli_model -# start_datetime = 2024-07-20 18:56:30 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 = examples/bernoulli/bernoulli.data.json -# init = 2 (Default) -# random -# seed = 3635036313 (Default) -# output -# file = bernoulli_out.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-25-gbb9ce42 -# stancflags = -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,zeta -# Adaptation terminated -# Step size = 0.932037 -# Diagonal elements of inverse mass matrix: -# 0.591014 --7.81355,0.761218,0.932037,1,3,0,8.13669,0.15 --8.71049,0.894869,0.932037,1,1,0,8.72268,0.15 --7.3531,0.957519,0.932037,1,3,0,8.53469,0.15 --7.02007,1,0.932037,1,1,0,7.29505,0.15 --8.49033,0.716959,0.932037,1,3,0,9.20407,0.15 --7.18724,1,0.932037,1,1,0,8.06459,0.15 --10.0621,0.636916,0.932037,2,3,0,10.0852,0.15 --8.11851,1,0.932037,1,1,0,9.65805,0.15 --6.86936,0.948809,0.932037,2,3,0,8.60097,0.15 --7.13756,0.935492,0.932037,2,3,0,7.43717,0.15 --7.09122,1,0.932037,1,1,0,7.19518,0.15 --6.91669,1,0.932037,1,1,0,7.06383,0.15 --6.76371,0.840542,0.932037,2,3,0,8.08838,0.15 --6.84805,0.983351,0.932037,1,3,0,6.84861,0.15 --8.3727,0.653843,0.932037,2,3,0,9.53079,0.15 --7.25928,0.806553,0.932037,1,3,0,9.43963,0.15 --6.95987,0.853051,0.932037,2,3,0,9.71446,0.15 --6.95334,1,0.932037,1,1,0,7.00708,0.15 --6.98417,0.993206,0.932037,1,1,0,7.02663,0.15 --8.9535,0.727406,0.932037,1,3,0,9.27425,0.15 --7.08162,0.995936,0.932037,2,3,0,9.00617,0.15 --7.16691,0.98306,0.932037,1,1,0,7.22238,0.15 --6.8898,1,0.932037,1,1,0,7.10684,0.15 --7.8902,0.846547,0.932037,1,3,0,7.96857,0.15 --7.24239,1,0.932037,1,1,0,7.78446,0.15 --7.94748,0.888836,0.932037,1,1,0,7.94857,0.15 --6.83694,0.864212,0.932037,2,3,0,8.91495,0.15 --6.83694,0.425574,0.932037,1,3,0,9.01249,0.15 --6.80131,0.985852,0.932037,1,3,0,6.93894,0.15 --6.74824,0.978446,0.932037,2,3,0,6.95179,0.15 --6.74832,0.945401,0.932037,2,3,0,7.0277,0.15 --6.85442,0.972221,0.932037,1,3,0,6.87104,0.15 --6.86406,0.996818,0.932037,1,1,0,6.89618,0.15 --7.11238,0.918504,0.932037,1,1,0,7.12695,0.15 --7.11238,0.431368,0.932037,1,1,0,8.53302,0.15 --6.79843,1,0.932037,1,1,0,7.00834,0.15 --6.74804,0.996585,0.932037,2,3,0,6.81732,0.15 --9.50952,0.509265,0.932037,1,3,0,9.67564,0.15 --8.27778,1,0.932037,1,1,0,9.48419,0.15 --7.2527,1,0.932037,2,3,0,8.04703,0.15 --6.75205,0.907555,0.932037,2,3,0,8.25548,0.15 --7.3411,0.857468,0.932037,1,3,0,7.42326,0.15 --7.07094,1,0.932037,1,1,0,7.32247,0.15 --7.04767,0.556206,0.932037,2,3,0,9.56585,0.15 --6.87625,1,0.932037,2,3,0,6.9975,0.15 --7.12535,0.945777,0.932037,1,1,0,7.12652,0.15 --7.12535,0.913353,0.932037,1,1,0,7.53634,0.15 --6.78755,1,0.932037,2,3,0,7.04258,0.15 --7.7545,0.780448,0.932037,1,3,0,7.76329,0.15 --6.77502,0.859809,0.932037,2,3,0,8.49845,0.15 --7.19668,0.726665,0.932037,2,3,0,8.64609,0.15 --9.64819,0.775506,0.932037,2,3,0,10.0305,0.15 --6.86272,0.7808,0.932037,1,3,0,10.9403,0.15 --6.99329,0.696273,0.932037,2,3,0,8.30815,0.15 --6.99329,0.700745,0.932037,1,1,0,7.63428,0.15 --7.11558,0.957857,0.932037,1,1,0,7.18108,0.15 --6.80487,1,0.932037,2,3,0,7.09376,0.15 --6.97334,0.955154,0.932037,2,3,0,7.16146,0.15 --7.2664,0.98044,0.932037,2,3,0,7.27318,0.15 --7.06819,1,0.932037,2,3,0,7.25815,0.15 --6.74803,0.991749,0.932037,1,3,0,7.05576,0.15 --7.05542,0.823118,0.932037,2,3,0,7.78068,0.15 --6.89251,1,0.932037,1,1,0,7.02757,0.15 --6.76584,0.932575,0.932037,2,3,0,7.49343,0.15 --6.75064,0.997924,0.932037,2,3,0,6.78013,0.15 --6.91371,0.96173,0.932037,1,3,0,6.93351,0.15 --6.74953,0.994131,0.932037,1,3,0,6.91533,0.15 --8.33302,0.635332,0.932037,1,3,0,9.05105,0.15 --8.04729,1,0.932037,1,1,0,8.43889,0.15 --8.42015,0.956552,0.932037,1,1,0,8.53727,0.15 --7.91154,1,0.932037,1,1,0,8.4304,0.15 --7.65791,1,0.932037,1,1,0,7.97836,0.15 --7.97869,0.955317,0.932037,1,1,0,8.06587,0.15 --6.81845,1,0.932037,1,3,0,7.88771,0.15 --6.76575,0.914099,0.932037,2,3,0,7.34829,0.15 --6.74964,0.996733,0.932037,2,3,0,6.78491,0.15 --6.77106,0.99494,0.932037,1,3,0,6.77141,0.15 --6.77106,0.945747,0.932037,1,3,0,6.92649,0.15 --6.77106,0.856062,0.932037,1,3,0,7.35372,0.15 --6.88028,0.948865,0.932037,2,3,0,7.03829,0.15 --7.33958,0.635769,0.932037,2,3,0,9.861,0.15 --8.06974,0.890942,0.932037,1,1,0,8.07292,0.15 --6.97186,0.998838,0.932037,1,3,0,7.91764,0.15 --6.76939,0.981956,0.932037,1,3,0,7.03238,0.15 --7.44177,0.80944,0.932037,1,3,0,7.79154,0.15 --8.01591,0.972061,0.932037,2,3,0,8.03736,0.15 --9.92045,0.865258,0.932037,2,3,0,9.92397,0.15 --7.31963,1,0.932037,2,3,0,10.3209,0.15 --6.9789,1,0.932037,1,1,0,7.25409,0.15 --7.21981,0.951312,0.932037,1,1,0,7.23197,0.15 --7.47612,0.930523,0.932037,2,3,0,8.12075,0.15 --6.81131,0.990375,0.932037,2,3,0,7.55719,0.15 --6.80278,0.920389,0.932037,2,3,0,7.43635,0.15 --6.88803,0.979103,0.932037,1,1,0,6.89063,0.15 --7.02902,0.795987,0.932037,2,3,0,8.6993,0.15 --6.74805,0.993012,0.932037,1,3,0,7.01716,0.15 --6.93322,0.952905,0.932037,1,3,0,6.95228,0.15 --6.76781,0.904559,0.932037,2,3,0,7.33629,0.15 --6.76232,0.985564,0.932037,2,3,0,6.83656,0.15 --6.87137,0.974516,0.932037,1,3,0,6.87148,0.15 --7.21556,0.953187,0.932037,2,3,0,7.22785,0.15 --6.76367,0.998041,0.932037,1,3,0,7.1984,0.15 --6.82308,0.981349,0.932037,1,3,0,6.86896,0.15 --6.82308,0.352125,0.932037,1,3,0,10.8402,0.15 --6.99474,0.738309,0.932037,2,3,0,8.0486,0.15 --6.99474,0.963463,0.932037,1,1,0,7.1311,0.15 --6.8637,0.713515,0.932037,2,3,0,8.29356,0.15 --6.94178,0.974091,0.932037,1,1,0,6.96832,0.15 --6.80481,1,0.932037,2,3,0,6.9081,0.15 --6.92327,0.971351,0.932037,1,1,0,6.92425,0.15 --7.1233,0.957499,0.932037,1,1,0,7.13244,0.15 --6.76778,0.973133,0.932037,1,3,0,7.19571,0.15 --6.90939,0.888041,0.932037,2,3,0,7.29419,0.15 --7.3757,0.927908,0.932037,2,3,0,7.37586,0.15 --7.33194,1,0.932037,1,1,0,7.48008,0.15 --6.86262,0.893077,0.932037,2,3,0,9.38827,0.15 --6.74929,0.996117,0.932037,1,3,0,6.86347,0.15 --6.74964,0.943201,0.932037,2,3,0,7.03592,0.15 --6.9015,0.968295,0.932037,2,3,0,6.96204,0.15 --7.81106,0.864491,0.932037,1,3,0,7.86554,0.15 --8.616,0.90424,0.932037,1,1,0,8.63659,0.15 --8.16761,1,0.932037,1,1,0,8.67561,0.15 --6.96545,1,0.932037,1,3,0,8.01828,0.15 --6.75813,1,0.932037,1,3,0,6.92669,0.15 --6.75424,1,0.932037,1,1,0,6.75812,0.15 --7.76056,0.503853,0.932037,2,3,0,10.2889,0.15 --7.12518,1,0.932037,1,1,0,7.64631,0.15 --7.67249,0.905419,0.932037,1,1,0,7.67491,0.15 --7.63881,1,0.932037,1,1,0,7.83222,0.15 --7.3844,0.889767,0.932037,1,3,0,8.80917,0.15 --6.76719,1,0.932037,1,3,0,7.348,0.15 --7.47953,0.852161,0.932037,1,3,0,7.59716,0.15 --7.42386,1,0.932037,2,3,0,7.59422,0.15 --7.91668,0.975432,0.932037,2,3,0,7.94672,0.15 --6.83066,1,0.932037,2,3,0,7.62924,0.15 --6.96269,0.956934,0.932037,1,1,0,6.97473,0.15 --6.74847,0.963031,0.932037,2,3,0,7.15706,0.15 --6.80708,0.988647,0.932037,2,3,0,6.82289,0.15 --6.91792,0.9732,0.932037,1,1,0,6.91947,0.15 --6.84983,1,0.932037,2,3,0,6.91467,0.15 --6.88905,0.990653,0.932037,1,1,0,6.90679,0.15 --7.15463,0.975663,0.932037,2,3,0,7.16,0.15 --6.9586,1,0.932037,1,1,0,7.13267,0.15 --7.56708,0.803851,0.932037,1,1,0,7.59178,0.15 --6.76736,1,0.932037,1,3,0,7.31987,0.15 --6.80123,0.959699,0.932037,2,3,0,6.95431,0.15 --6.80123,0.759564,0.932037,1,3,0,7.84546,0.15 --6.80123,0.902778,0.932037,1,3,0,7.20675,0.15 --6.80123,0.96482,0.932037,1,1,0,6.88076,0.15 --6.78299,0.988689,0.932037,2,3,0,6.88032,0.15 --7.1107,0.936673,0.932037,1,3,0,7.12632,0.15 --7.31567,0.961429,0.932037,1,1,0,7.35195,0.15 --7.07455,0.968694,0.932037,2,3,0,7.7776,0.15 --6.74831,0.993779,0.932037,1,3,0,7.05357,0.15 --6.84249,0.975275,0.932037,1,3,0,6.85756,0.15 --6.88224,0.995647,0.932037,2,3,0,6.90622,0.15 --8.68021,0.668585,0.932037,2,3,0,8.68611,0.15 --7.80603,1,0.932037,1,1,0,8.5851,0.15 --7.27572,1,0.932037,1,1,0,7.73044,0.15 --8.91337,0.902662,0.932037,2,3,0,9.15324,0.15 --7.22471,0.840347,0.932037,1,3,0,9.85532,0.15 --7.57214,0.980256,0.932037,2,3,0,7.60142,0.15 --7.46188,1,0.932037,1,1,0,7.66831,0.15 --7.21293,1,0.932037,1,1,0,7.46083,0.15 --7.27196,0.911127,0.932037,1,3,0,8.06683,0.15 --6.99285,1,0.932037,1,1,0,7.22442,0.15 --7.64686,0.789204,0.932037,1,1,0,7.67915,0.15 --7.64686,0.588674,0.932037,1,1,0,8.70948,0.15 --6.76317,0.84811,0.932037,2,3,0,8.40171,0.15 --6.75852,0.995961,0.932037,2,3,0,6.79457,0.15 --6.96185,0.956175,0.932037,2,3,0,7.06538,0.15 --6.7597,0.95957,0.932037,2,3,0,7.23201,0.15 --6.95356,0.940807,0.932037,1,3,0,7.05195,0.15 --6.74802,0.995879,0.932037,1,3,0,6.94105,0.15 --6.80409,0.985416,0.932037,1,3,0,6.81492,0.15 --6.78431,0.93291,0.932037,2,3,0,7.30965,0.15 --6.85124,0.98309,0.932037,1,1,0,6.85256,0.15 --6.91874,0.970098,0.932037,1,3,0,7.11707,0.15 --6.91874,0.434093,0.932037,1,3,0,9.39656,0.15 --6.92998,0.940657,0.932037,2,3,0,7.25758,0.15 --6.7616,0.987015,0.932037,1,3,0,6.96899,0.15 --6.77385,0.996249,0.932037,1,1,0,6.77617,0.15 --7.11956,0.891801,0.932037,1,3,0,7.32561,0.15 --7.10361,0.938678,0.932037,1,3,0,7.72046,0.15 --7.10361,0.642361,0.932037,1,1,0,7.89438,0.15 --8.5001,0.593919,0.932037,1,1,0,8.53813,0.15 --7.1692,1,0.932037,2,3,0,8.39313,0.15 --6.99964,1,0.932037,2,3,0,7.15856,0.15 --6.82605,1,0.932037,1,1,0,6.95904,0.15 --6.80069,1,0.932037,1,1,0,6.8286,0.15 --6.80069,0.826864,0.932037,1,3,0,7.56839,0.15 --6.80069,0.712989,0.932037,1,3,0,8.08135,0.15 --6.79864,1,0.932037,1,1,0,6.81323,0.15 --7.21975,0.922333,0.932037,1,3,0,7.24006,0.15 --6.75061,0.978686,0.932037,1,3,0,7.23991,0.15 --8.50882,0.710206,0.932037,2,3,0,8.58833,0.15 --6.98994,1,0.932037,1,3,0,8.37388,0.15 --8.68191,0.796805,0.932037,2,3,0,9.47091,0.15 --7.31609,1,0.932037,2,3,0,8.2644,0.15 --7.14381,1,0.932037,1,1,0,7.36712,0.15 --7.14381,0.475525,0.932037,1,1,0,8.41075,0.15 --7.29505,0.813437,0.932037,2,3,0,8.20133,0.15 --7.97276,0.895575,0.932037,1,1,0,7.97663,0.15 --9.00874,0.888587,0.932037,1,1,0,9.0167,0.15 --8.5484,1,0.932037,1,1,0,9.10361,0.15 --7.88735,1,0.932037,1,1,0,8.51142,0.15 --7.36782,1,0.932037,1,1,0,7.8262,0.15 --7.34887,1,0.932037,1,1,0,7.48713,0.15 --6.81839,0.987631,0.932037,2,3,0,7.46646,0.15 --6.81839,0.712592,0.932037,1,3,0,8.16085,0.15 --6.74807,0.998893,0.932037,1,3,0,6.81316,0.15 --6.87013,0.959268,0.932037,2,3,0,6.97825,0.15 --6.76585,1,0.932037,1,1,0,6.83725,0.15 --6.7566,0.994396,0.932037,2,3,0,6.80045,0.15 --6.7566,0.628726,0.932037,1,3,0,8.7002,0.15 --6.82277,0.986161,0.932037,1,3,0,6.82387,0.15 --7.3013,0.877627,0.932037,1,3,0,7.5333,0.15 --8.78447,0.79108,0.932037,2,3,0,8.87542,0.15 --7.50584,1,0.932037,1,1,0,8.46306,0.15 --7.15669,1,0.932037,1,1,0,7.48033,0.15 --7.43591,0.967588,0.932037,2,3,0,7.54437,0.15 --6.96987,0.913229,0.932037,1,3,0,7.88228,0.15 --6.89773,1,0.932037,1,1,0,6.97541,0.15 --7.36158,0.930716,0.932037,1,3,0,7.36402,0.15 --7.16589,1,0.932037,1,1,0,7.37174,0.15 --6.95869,1,0.932037,1,1,0,7.13528,0.15 --7.16168,0.929564,0.932037,1,3,0,7.57434,0.15 --8.02154,0.725795,0.932037,1,1,0,8.09574,0.15 --8.63423,0.930003,0.932037,2,3,0,9.03662,0.15 --6.93887,1,0.932037,1,1,0,8.0172,0.15 --6.87271,1,0.932037,1,1,0,6.94734,0.15 --6.77339,1,0.932037,2,3,0,6.85408,0.15 --6.98298,0.942095,0.932037,1,3,0,7.07789,0.15 --6.75868,1,0.932037,1,3,0,6.91623,0.15 --6.7906,0.973381,0.932037,2,3,0,6.88716,0.15 --7.56742,0.820209,0.932037,1,3,0,7.57193,0.15 --6.75108,1,0.932037,1,3,0,7.35001,0.15 --6.80655,0.983396,0.932037,1,3,0,6.83092,0.15 --6.91728,0.973208,0.932037,1,1,0,6.91879,0.15 --7.7691,0.915431,0.932037,2,3,0,7.98664,0.15 --6.765,1,0.932037,1,3,0,7.46164,0.15 --7.37311,0.856184,0.932037,1,3,0,7.3856,0.15 --7.3305,1,0.932037,1,1,0,7.55404,0.15 --7.3305,0.663523,0.932037,1,1,0,8.12143,0.15 --7.12567,0.837343,0.932037,1,3,0,8.09517,0.15 --7.15885,0.957841,0.932037,2,3,0,7.71194,0.15 --6.75049,0.994782,0.932037,1,3,0,7.12461,0.15 --6.81461,0.982255,0.932037,1,3,0,6.83366,0.15 --6.75614,0.996516,0.932037,1,3,0,6.83027,0.15 --6.74853,0.904663,0.932037,2,3,0,7.2911,0.15 --7.01677,0.911602,0.932037,2,3,0,7.26139,0.15 --6.92929,0.642216,0.932037,2,3,0,8.77716,0.15 --7.65529,0.771289,0.932037,1,1,0,7.66932,0.15 --7.01834,1,0.932037,1,1,0,7.46402,0.15 --6.74897,1,0.932037,1,3,0,6.95557,0.15 --9.81129,0.348606,0.932037,1,3,0,11.6845,0.15 --10.4379,0.964322,0.932037,1,1,0,10.6078,0.15 --12.3737,0.923455,0.932037,1,1,0,12.3737,0.15 --8.6914,0.906628,0.932037,1,3,0,12.5921,0.15 --7.8205,1,0.932037,1,1,0,8.59832,0.15 --6.76573,0.925015,0.932037,1,3,0,8.00716,0.15 --7.18424,0.803585,0.932037,2,3,0,7.86457,0.15 --6.74867,0.98391,0.932037,1,3,0,7.18696,0.15 --6.74867,0.809678,0.932037,1,3,0,7.5541,0.15 --6.78928,0.864392,0.932037,2,3,0,7.45892,0.15 --7.73008,0.857073,0.932037,2,3,0,7.95215,0.15 --6.90924,0.999548,0.932037,1,3,0,7.59486,0.15 --6.83204,1,0.932037,1,1,0,6.89889,0.15 --6.92095,0.978894,0.932037,1,1,0,6.92784,0.15 --6.84946,1,0.932037,1,1,0,6.91633,0.15 --6.87329,0.97872,0.932037,1,3,0,7.05429,0.15 --7.77797,0.726161,0.932037,1,1,0,7.77978,0.15 --7.91451,0.983052,0.932037,2,3,0,8.2695,0.15 --6.99541,0.905965,0.932037,1,3,0,8.38798,0.15 --6.76541,0.9819,0.932037,1,3,0,7.04888,0.15 --6.75969,1,0.932037,1,1,0,6.76622,0.15 --6.88511,0.980043,0.932037,2,3,0,6.89657,0.15 --6.77682,0.92494,0.932037,2,3,0,7.55206,0.15 --7.22693,0.885941,0.932037,1,3,0,7.36359,0.15 --7.08301,1,0.932037,2,3,0,7.27,0.15 --6.74807,1,0.932037,1,3,0,7.01313,0.15 --6.78184,0.991048,0.932037,1,3,0,6.7889,0.15 --7.7414,0.782413,0.932037,1,3,0,7.94246,0.15 --8.34868,0.79224,0.932037,1,1,0,8.64598,0.15 --6.96656,1,0.932037,1,1,0,7.85206,0.15 --8.55062,0.559382,0.932037,1,1,0,8.55696,0.15 --8.71259,0.939683,0.932037,1,1,0,9.36157,0.15 --7.02011,1,0.932037,1,1,0,8.0992,0.15 --7.73032,0.771978,0.932037,1,1,0,7.7681,0.15 --7.58699,1,0.932037,1,1,0,7.95753,0.15 --10.1664,0.37457,0.932037,1,1,0,10.2962,0.15 --9.05941,1,0.932037,2,3,0,10.4928,0.15 --6.95163,0.994678,0.932037,1,3,0,9.25144,0.15 --6.991,0.991344,0.932037,1,1,0,7.03106,0.15 --6.93665,1,0.932037,1,1,0,7.01246,0.15 --7.53693,0.951931,0.932037,2,3,0,7.60421,0.15 --7.35042,1,0.932037,1,1,0,7.65542,0.15 --6.74833,1,0.932037,1,3,0,7.21002,0.15 --7.30096,0.866757,0.932037,1,3,0,7.34306,0.15 --7.33424,0.995938,0.932037,2,3,0,7.52117,0.15 --7.00834,1,0.932037,1,1,0,7.27119,0.15 --7.00834,0.750927,0.932037,1,3,0,7.93882,0.15 --6.85276,0.717415,0.932037,2,3,0,8.2801,0.15 --6.88149,0.915088,0.932037,2,3,0,7.26489,0.15 --7.01531,0.954346,0.932037,2,3,0,7.30842,0.15 --8.49716,0.821021,0.932037,2,3,0,8.90444,0.15 --7.75198,1,0.932037,2,3,0,8.42455,0.15 --6.78374,0.995713,0.932037,1,3,0,7.67855,0.15 --6.78319,0.955918,0.932037,2,3,0,7.05067,0.15 --6.76877,0.993356,0.932037,2,3,0,6.83116,0.15 --6.76604,1,0.932037,2,3,0,6.77242,0.15 --6.80257,0.828664,0.932037,2,3,0,7.81548,0.15 --6.7921,0.928548,0.932037,2,3,0,7.34502,0.15 --6.7921,0.869785,0.932037,1,3,0,7.3846,0.15 --6.78247,1,0.932037,1,1,0,6.7969,0.15 --6.77338,0.944315,0.932037,2,3,0,7.11056,0.15 --6.88767,0.984579,0.932037,2,3,0,6.89149,0.15 --6.87758,1,0.932037,1,1,0,6.91573,0.15 --6.98427,0.975828,0.932037,1,1,0,6.997,0.15 --8.16006,0.847199,0.932037,1,3,0,8.23533,0.15 --6.92926,1,0.932037,1,3,0,8.02086,0.15 --6.75334,1,0.932037,1,3,0,6.89875,0.15 --6.76157,0.984481,0.932037,2,3,0,6.84166,0.15 --6.77437,0.916298,0.932037,2,3,0,7.16943,0.15 --6.89883,0.966797,0.932037,2,3,0,7.01941,0.15 --7.61554,0.929243,0.932037,2,3,0,7.77465,0.15 --6.74865,1,0.932037,1,3,0,7.4327,0.15 --7.90889,0.736401,0.932037,1,3,0,8.30046,0.15 --7.36433,1,0.932037,1,1,0,7.84078,0.15 --6.7517,1,0.932037,2,3,0,7.32628,0.15 --7.47731,0.835796,0.932037,1,3,0,7.65004,0.15 --6.82682,1,0.932037,1,3,0,7.36972,0.15 --6.75257,1,0.932037,1,3,0,6.81023,0.15 --6.74814,0.924039,0.932037,2,3,0,7.16556,0.15 --6.77547,0.992637,0.932037,1,3,0,6.7818,0.15 --6.77883,0.96017,0.932037,2,3,0,7.01271,0.15 --6.83214,0.92718,0.932037,2,3,0,7.10706,0.15 --6.74855,0.999857,0.932037,1,3,0,6.82323,0.15 --6.75208,0.991977,0.932037,2,3,0,6.79074,0.15 --6.74875,1,0.932037,2,3,0,6.7511,0.15 --6.76331,0.987877,0.932037,2,3,0,6.81164,0.15 --7.11253,0.925924,0.932037,1,3,0,7.14728,0.15 --7.33832,0.934594,0.932037,2,3,0,7.89183,0.15 --7.40317,0.891695,0.932037,1,3,0,8.40906,0.15 --6.83199,1,0.932037,2,3,0,7.43757,0.15 --6.83199,0.774019,0.932037,1,3,0,8.04658,0.15 --6.99888,0.961352,0.932037,1,1,0,7.00012,0.15 --6.76802,0.991205,0.932037,2,3,0,7.06627,0.15 --7.1899,0.912501,0.932037,1,3,0,7.23327,0.15 --7.0344,0.951025,0.932037,1,3,0,7.71962,0.15 --6.74861,0.964191,0.932037,2,3,0,7.23266,0.15 --6.9356,0.954146,0.932037,1,3,0,6.96807,0.15 --6.8766,1,0.932037,1,1,0,6.94182,0.15 --6.86303,0.963467,0.932037,2,3,0,7.17361,0.15 --6.89691,0.996253,0.932037,2,3,0,6.92839,0.15 --6.74898,0.989445,0.932037,2,3,0,6.95643,0.15 --6.75192,0.906807,0.932037,2,3,0,7.25324,0.15 --6.89356,0.962004,0.932037,1,3,0,6.92873,0.15 --6.8915,1,0.932037,1,1,0,6.93856,0.15 --8.04782,0.661095,0.932037,1,1,0,8.04944,0.15 --6.96778,1,0.932037,2,3,0,8.10818,0.15 --6.94531,0.967319,0.932037,1,3,0,7.30665,0.15 --6.79303,1,0.932037,1,1,0,6.89785,0.15 --6.75073,0.998473,0.932037,1,3,0,6.79703,0.15 --6.74807,0.922346,0.932037,2,3,0,7.17097,0.15 --6.79664,0.986959,0.932037,2,3,0,6.82676,0.15 --7.42084,0.890966,0.932037,2,3,0,7.44601,0.15 --7.07938,1,0.932037,1,1,0,7.36895,0.15 --6.76996,0.975074,0.932037,1,3,0,7.1524,0.15 --6.97097,0.781354,0.932037,2,3,0,7.8694,0.15 --7.45672,0.874497,0.932037,1,3,0,7.94747,0.15 --7.73982,0.898709,0.932037,1,1,0,7.95818,0.15 --6.75761,1,0.932037,1,3,0,7.45331,0.15 --6.75128,1,0.932037,2,3,0,6.75597,0.15 --6.74857,0.969275,0.932037,2,3,0,6.90378,0.15 --6.78162,0.964009,0.932037,2,3,0,6.94604,0.15 --6.94452,0.969782,0.932037,1,3,0,6.94577,0.15 --6.83464,1,0.932037,1,1,0,6.92359,0.15 --6.85125,0.978801,0.932037,2,3,0,7.03988,0.15 --8.70862,0.498506,0.932037,2,3,0,10.892,0.15 --7.14422,0.988771,0.932037,1,3,0,8.54862,0.15 --8.22719,0.86569,0.932037,1,3,0,8.25029,0.15 --7.98302,1,0.932037,1,1,0,8.34174,0.15 --7.66766,1,0.932037,1,1,0,8.02784,0.15 --8.24143,0.924458,0.932037,1,1,0,8.28161,0.15 --7.67998,1,0.932037,1,1,0,8.20801,0.15 --7.87681,0.972029,0.932037,1,1,0,7.99803,0.15 --6.74849,0.941373,0.932037,1,3,0,7.96721,0.15 --7.11836,0.837369,0.932037,2,3,0,7.62397,0.15 --6.79142,1,0.932037,2,3,0,7.01021,0.15 --6.77524,1,0.932037,1,1,0,6.79217,0.15 --6.79636,0.997801,0.932037,2,3,0,6.8016,0.15 --6.79636,0.948581,0.932037,1,1,0,6.90729,0.15 --6.87559,0.872276,0.932037,2,3,0,7.36427,0.15 --7.91757,0.674512,0.932037,1,3,0,8.87065,0.15 --6.74935,0.935438,0.932037,1,3,0,8.03013,0.15 --6.74803,0.97594,0.932037,2,3,0,6.86976,0.15 --6.81513,0.982667,0.932037,1,3,0,6.82306,0.15 --7.49872,0.879887,0.932037,2,3,0,7.51782,0.15 --7.49872,0.948913,0.932037,1,1,0,7.85236,0.15 --8.04293,0.922216,0.932037,1,1,0,8.07282,0.15 --7.35293,1,0.932037,2,3,0,7.93996,0.15 --7.35293,0.883408,0.932037,1,1,0,8.02395,0.15 --6.80493,1,0.932037,1,3,0,7.25923,0.15 --6.82698,0.998151,0.932037,2,3,0,6.83752,0.15 --6.88114,0.986899,0.932037,1,1,0,6.89144,0.15 --6.74827,0.964042,0.932037,2,3,0,7.17919,0.15 --6.93633,0.882605,0.932037,2,3,0,7.40536,0.15 --8.02922,0.766313,0.932037,1,3,0,8.54794,0.15 --6.88064,1,0.932037,1,1,0,7.62039,0.15 --6.99856,0.960668,0.932037,1,1,0,7.02674,0.15 --6.9205,1,0.932037,1,1,0,7.0171,0.15 --7.23497,0.895629,0.932037,1,1,0,7.26191,0.15 --6.81255,0.65863,0.932037,2,3,0,8.81442,0.15 --6.8557,0.986062,0.932037,1,1,0,6.86976,0.15 --6.8557,0.724177,0.932037,1,3,0,7.66358,0.15 --6.75301,0.997497,0.932037,1,3,0,6.85969,0.15 --9.62741,0.500859,0.932037,1,3,0,9.855,0.15 --7.2064,1,0.932037,2,3,0,8.74926,0.15 --6.75431,0.815869,0.932037,2,3,0,7.99167,0.15 --6.77251,0.990864,0.932037,2,3,0,6.80395,0.15 --7.81008,0.844756,0.932037,2,3,0,8.00316,0.15 --8.11847,0.959711,0.932037,1,1,0,8.22643,0.15 --9.24757,0.890376,0.932037,2,3,0,10.2168,0.15 --6.88942,0.799493,0.932037,1,3,0,10.3695,0.15 --6.88942,0.261019,0.932037,1,3,0,10.9724,0.15 --6.80124,0.870892,0.932037,2,3,0,7.43049,0.15 --6.74978,0.998863,0.932037,1,3,0,6.80164,0.15 --7.17245,0.854684,0.932037,2,3,0,7.6,0.15 --8.81972,0.538088,0.932037,1,1,0,8.86828,0.15 --7.40622,1,0.932037,2,3,0,8.5393,0.15 --7.26318,0.961918,0.932037,2,3,0,8.05474,0.15 --7.34728,0.984906,0.932037,1,1,0,7.43596,0.15 --6.86243,0.997387,0.932037,1,3,0,7.24798,0.15 --6.89308,0.975225,0.932037,1,3,0,7.09809,0.15 --7.32886,0.939094,0.932037,2,3,0,7.34307,0.15 --7.57152,0.913466,0.932037,1,1,0,7.74604,0.15 --6.94728,1,0.932037,1,1,0,7.36923,0.15 --6.81842,1,0.932037,1,1,0,6.91356,0.15 --6.76216,1,0.932037,2,3,0,6.80728,0.15 --6.85768,0.974601,0.932037,2,3,0,6.94204,0.15 --6.77062,0.988638,0.932037,1,3,0,6.90934,0.15 --6.91451,0.978923,0.932037,2,3,0,6.91452,0.15 --6.78227,1,0.932037,1,1,0,6.87294,0.15 --7.62346,0.806356,0.932037,1,3,0,7.63204,0.15 --6.83206,1,0.932037,1,1,0,7.34914,0.15 --7.29941,0.815839,0.932037,2,3,0,7.843,0.15 --7.31671,0.996885,0.932037,1,1,0,7.4311,0.15 --6.78343,0.991818,0.932037,2,3,0,7.37529,0.15 --6.86006,0.980687,0.932037,1,1,0,6.8608,0.15 --6.77605,1,0.932037,1,1,0,6.83853,0.15 --6.86042,0.973286,0.932037,1,3,0,6.93518,0.15 --6.75338,0.997358,0.932037,1,3,0,6.86494,0.15 --6.83799,0.976298,0.932037,1,3,0,6.868,0.15 --7.00374,0.713633,0.932037,2,3,0,8.19304,0.15 --6.75259,0.98344,0.932037,2,3,0,7.10169,0.15 --6.79496,0.987555,0.932037,1,3,0,6.81495,0.15 --6.9391,0.981259,0.932037,2,3,0,6.94195,0.15 --7.22517,0.904285,0.932037,1,1,0,7.25937,0.15 --7.21052,1,0.932037,1,1,0,7.37602,0.15 --6.75985,0.787087,0.932037,2,3,0,8.11836,0.15 --6.86031,0.946513,0.932037,2,3,0,7.03793,0.15 --8.19403,0.780681,0.932037,1,3,0,8.38612,0.15 --6.7609,1,0.932037,2,3,0,7.87703,0.15 --6.95309,0.78127,0.932037,2,3,0,7.88077,0.15 --9.56705,0.565191,0.932037,1,3,0,10.2818,0.15 --6.75776,1,0.932037,1,3,0,8.93023,0.15 --6.77632,0.994978,0.932037,1,1,0,6.77679,0.15 --6.82265,0.996019,0.932037,2,3,0,6.82416,0.15 --6.89139,0.983404,0.932037,1,1,0,6.89889,0.15 --6.89139,0.777655,0.932037,1,3,0,8.12126,0.15 --7.13161,0.926877,0.932037,1,3,0,7.44089,0.15 --8.35546,0.633109,0.932037,1,1,0,8.40627,0.15 --7.06834,0.886614,0.932037,1,3,0,8.96147,0.15 --7.28399,0.958522,0.932037,1,1,0,7.31204,0.15 --7.28327,1,0.932037,1,1,0,7.40052,0.15 --7.93284,0.898826,0.932037,1,1,0,7.93762,0.15 --7.81694,1,0.932037,1,1,0,8.08024,0.15 --7.6919,1,0.932037,1,1,0,7.94232,0.15 --6.76979,0.932315,0.932037,1,3,0,7.86435,0.15 --6.97696,0.966811,0.932037,2,3,0,6.99094,0.15 --7.49857,0.902721,0.932037,2,3,0,7.93254,0.15 --7.50324,0.999237,0.932037,1,1,0,7.65578,0.15 --6.91611,1,0.932037,2,3,0,7.33316,0.15 --6.74956,1,0.932037,1,3,0,6.89861,0.15 --8.35635,0.667972,0.932037,1,3,0,8.48862,0.15 --8.35709,0.999715,0.932037,1,1,0,8.94945,0.15 --7.01492,1,0.932037,2,3,0,8.49553,0.15 --7.08433,0.985549,0.932037,1,1,0,7.13054,0.15 --7.29556,0.986569,0.932037,2,3,0,7.32674,0.15 --6.82002,1,0.932037,2,3,0,7.16863,0.15 --6.82002,0.827599,0.932037,1,1,0,7.18527,0.15 --6.96415,0.766705,0.932037,2,3,0,7.8936,0.15 --7.10108,0.953204,0.932037,1,1,0,7.15511,0.15 --7.08567,1,0.932037,1,1,0,7.2067,0.15 --8.18465,0.665208,0.932037,1,1,0,8.22692,0.15 --6.98816,1,0.932037,2,3,0,8.27915,0.15 --6.9991,0.951104,0.932037,2,3,0,7.40622,0.15 --6.87003,0.959893,0.932037,1,3,0,7.2399,0.15 --8.86597,0.67165,0.932037,1,3,0,9.3173,0.15 --9.22117,0.969943,0.932037,1,1,0,9.41531,0.15 --10.3294,0.926924,0.932037,1,1,0,10.3727,0.15 --8.32325,0.989504,0.932037,2,3,0,10.9313,0.15 --8.85098,0.946649,0.932037,1,1,0,8.95519,0.15 --9.31959,0.960963,0.932037,1,1,0,9.47897,0.15 --10.3022,0.93649,0.932037,1,1,0,10.3691,0.15 --10.3363,0.998194,0.932037,1,1,0,10.7444,0.15 --7.06812,1,0.932037,2,3,0,10.0104,0.15 --7.09449,0.998201,0.932037,2,3,0,7.16215,0.15 --7.41044,0.941678,0.932037,1,1,0,7.42835,0.15 --6.74954,0.897451,0.932037,2,3,0,8.358,0.15 --7.01483,0.952044,0.932037,2,3,0,7.06471,0.15 --7.04361,0.949288,0.932037,1,3,0,7.50082,0.15 --6.84344,1,0.932037,1,1,0,6.98754,0.15 --6.76346,1,0.932037,1,1,0,6.81845,0.15 --6.77171,0.981093,0.932037,2,3,0,6.85292,0.15 --6.84864,0.975946,0.932037,1,1,0,6.84963,0.15 --6.79009,1,0.932037,1,1,0,6.8359,0.15 --7.3603,0.823525,0.932037,1,3,0,7.7309,0.15 --7.81047,0.929962,0.932037,1,1,0,7.84015,0.15 --7.78154,1,0.932037,1,1,0,7.99363,0.15 --6.7517,1,0.932037,2,3,0,7.65292,0.15 --6.78798,0.848042,0.932037,2,3,0,7.61324,0.15 --6.76,0.921142,0.932037,2,3,0,7.25211,0.15 --6.79557,0.983288,0.932037,2,3,0,6.85013,0.15 --7.19183,0.926349,0.932037,1,3,0,7.21025,0.15 --7.38792,0.988215,0.932037,2,3,0,7.43851,0.15 --6.96601,1,0.932037,2,3,0,7.30212,0.15 --7.05786,0.980406,0.932037,1,1,0,7.08973,0.15 --7.16196,0.993052,0.932037,2,3,0,7.20877,0.15 --6.77281,0.912405,0.932037,2,3,0,8.28922,0.15 --6.75974,1,0.932037,1,1,0,6.77054,0.15 --6.74904,0.896827,0.932037,2,3,0,7.34903,0.15 --6.99017,0.938166,0.932037,1,3,0,7.02613,0.15 --9.18272,0.444151,0.932037,1,1,0,9.18621,0.15 --7.27998,1,0.932037,1,1,0,8.53072,0.15 --6.81588,0.976625,0.932037,1,3,0,7.39388,0.15 --6.85158,0.981914,0.932037,1,3,0,6.98055,0.15 --7.61781,0.765141,0.932037,1,1,0,7.61874,0.15 --6.79258,0.997137,0.932037,1,3,0,7.61795,0.15 --8.09444,0.722711,0.932037,1,3,0,8.35089,0.15 --8.09444,0.731058,0.932037,1,1,0,9.00859,0.15 --8.96537,0.715603,0.932037,1,1,0,9.37304,0.15 --8.78035,1,0.932037,1,1,0,9.62889,0.15 --7.21874,0.836764,0.932037,1,3,0,9.71962,0.15 --6.75061,0.911636,0.932037,2,3,0,8.14176,0.15 --7.65204,0.639147,0.932037,2,3,0,8.88575,0.15 --6.95151,1,0.932037,1,1,0,7.42019,0.15 --7.03245,0.89047,0.932037,2,3,0,7.4925,0.15 --6.93323,1,0.932037,1,1,0,7.03482,0.15 --6.93323,0.839701,0.932037,1,3,0,7.95662,0.15 --6.8181,1,0.932037,1,1,0,6.90794,0.15 --6.96817,0.964576,0.932037,1,1,0,6.96901,0.15 --6.75177,1,0.932037,2,3,0,6.94088,0.15 --6.75748,0.994596,0.932037,2,3,0,6.77947,0.15 --6.75598,1,0.932037,2,3,0,6.75911,0.15 --7.35596,0.838068,0.932037,1,3,0,7.60728,0.15 --6.75779,0.906448,0.932037,2,3,0,8.09794,0.15 --6.83162,0.952059,0.932037,2,3,0,6.9908,0.15 --7.67816,0.806003,0.932037,1,3,0,7.67819,0.15 --6.92603,0.932427,0.932037,1,3,0,8.01057,0.15 --7.07054,0.950192,0.932037,2,3,0,7.4224,0.15 --6.7484,0.994215,0.932037,1,3,0,7.0485,0.15 --7.08258,0.918347,0.932037,1,3,0,7.15481,0.15 --7.08258,0.737878,0.932037,1,3,0,9.18161,0.15 --7.35202,0.949338,0.932037,1,1,0,7.3743,0.15 --6.74881,0.983413,0.932037,1,3,0,7.33477,0.15 --6.95539,0.949695,0.932037,1,3,0,6.9911,0.15 --7.15608,0.958335,0.932037,1,1,0,7.16954,0.15 --6.83348,0.99773,0.932037,1,3,0,7.08351,0.15 --7.24483,0.931935,0.932037,1,3,0,7.25275,0.15 --6.98535,1,0.932037,1,1,0,7.20252,0.15 --6.79714,0.986131,0.932037,2,3,0,7.11242,0.15 --6.75975,0.994219,0.932037,2,3,0,6.84154,0.15 --7.85764,0.768175,0.932037,1,3,0,8.13554,0.15 --7.75607,1,0.932037,2,3,0,8.00291,0.15 --7.45436,1,0.932037,1,1,0,7.77479,0.15 --6.75812,0.956844,0.932037,1,3,0,7.53861,0.15 --6.78653,0.996723,0.932037,2,3,0,6.78699,0.15 --6.78653,0.689753,0.932037,1,3,0,7.7558,0.15 --7.13767,0.941965,0.932037,2,3,0,7.15428,0.15 --6.8166,0.824152,0.932037,2,3,0,8.71226,0.15 --6.79612,1,0.932037,1,1,0,6.82009,0.15 --7.16066,0.926371,0.932037,2,3,0,7.36744,0.15 --6.7485,0.867631,0.932037,2,3,0,8.25218,0.15 --6.7485,0.374064,0.932037,1,3,0,9.69677,0.15 --6.906,0.899506,0.932037,2,3,0,7.30301,0.15 --6.97495,0.960716,0.932037,1,3,0,7.26467,0.15 --6.87784,0.957976,0.932037,1,3,0,7.22871,0.15 --6.76764,1,0.932037,1,3,0,6.85023,0.15 --7.06045,0.939987,0.932037,2,3,0,7.20313,0.15 --7.56678,0.90837,0.932037,1,1,0,7.56807,0.15 --8.21909,0.9114,0.932037,1,1,0,8.24106,0.15 --7.1694,0.972439,0.932037,1,3,0,8.05615,0.15 --7.51659,0.939017,0.932037,1,1,0,7.53941,0.15 --6.80441,1,0.932037,2,3,0,7.33714,0.15 --6.84769,0.986098,0.932037,1,1,0,6.85924,0.15 --6.75447,1,0.932037,1,3,0,6.82024,0.15 --6.75447,0.941471,0.932037,1,3,0,6.92636,0.15 --7.31897,0.848317,0.932037,1,3,0,7.54592,0.15 --7.51256,0.936742,0.932037,2,3,0,8.23518,0.15 --7.00844,1,0.932037,1,1,0,7.41354,0.15 --6.81721,1,0.932037,2,3,0,6.95395,0.15 --7.45194,0.852204,0.932037,1,3,0,7.45194,0.15 --6.87259,1,0.932037,2,3,0,7.42285,0.15 --6.75616,1,0.932037,1,3,0,6.8471,0.15 --6.89502,0.961898,0.932037,1,3,0,6.94092,0.15 --6.77836,1,0.932037,2,3,0,6.87334,0.15 --6.79421,0.982898,0.932037,2,3,0,6.9004,0.15 --7.26621,0.798873,0.932037,2,3,0,7.90837,0.15 --6.86681,0.892468,0.932037,2,3,0,9.22078,0.15 --6.79361,1,0.932037,1,1,0,6.85058,0.15 --6.77748,1,0.932037,2,3,0,6.79435,0.15 --6.77887,0.999632,0.932037,1,1,0,6.78659,0.15 --6.78375,0.998717,0.932037,1,1,0,6.79108,0.15 --6.74954,0.987641,0.932037,2,3,0,6.86737,0.15 --7.83854,0.756676,0.932037,1,3,0,7.90005,0.15 --7.50039,1,0.932037,1,1,0,7.94015,0.15 --6.7491,1,0.932037,1,3,0,7.35194,0.15 --6.7636,0.996702,0.932037,1,3,0,6.76405,0.15 --6.78205,0.845782,0.932037,2,3,0,7.69714,0.15 --6.75014,0.997559,0.932037,2,3,0,6.79806,0.15 --8.34122,0.670679,0.932037,1,3,0,8.47733,0.15 --7.99963,1,0.932037,1,1,0,8.62888,0.15 --8.76385,0.745363,0.932037,1,1,0,9.14503,0.15 --7.04418,1,0.932037,1,1,0,8.14217,0.15 --7.43305,0.868749,0.932037,1,1,0,7.49441,0.15 --7.43305,0.297658,0.932037,1,1,0,9.48457,0.15 --6.83865,0.968461,0.932037,1,3,0,7.58424,0.15 --7.53033,0.883514,0.932037,1,3,0,7.57348,0.15 --6.96261,0.979104,0.932037,2,3,0,7.81614,0.15 --7.0999,0.990364,0.932037,2,3,0,7.12317,0.15 --8.07438,0.928426,0.932037,2,3,0,8.16995,0.15 --7.08332,1,0.932037,1,1,0,7.75278,0.15 --6.82918,1,0.932037,1,1,0,7.0036,0.15 --7.53288,0.784396,0.932037,1,1,0,7.53294,0.15 --7.05091,1,0.932037,2,3,0,7.39902,0.15 --7.40251,0.977978,0.932037,2,3,0,7.41207,0.15 --6.82898,1,0.932037,2,3,0,7.24836,0.15 --6.79153,1,0.932037,1,1,0,6.8253,0.15 --6.79153,0.459704,0.932037,1,3,0,9.85444,0.15 --6.76756,1,0.932037,1,1,0,6.7869,0.15 --6.97728,0.932763,0.932037,1,3,0,7.10469,0.15 --6.95157,1,0.932037,1,1,0,7.01491,0.15 --6.75905,0.960947,0.932037,2,3,0,7.21354,0.15 --6.7615,0.936647,0.932037,2,3,0,7.06828,0.15 --6.89331,0.972573,0.932037,1,3,0,6.89762,0.15 --6.77722,0.906489,0.932037,2,3,0,7.52048,0.15 --7.05175,0.910169,0.932037,1,3,0,7.23443,0.15 --6.92365,1,0.932037,1,1,0,7.04143,0.15 --6.92285,1,0.932037,2,3,0,6.9668,0.15 --7.13379,0.955304,0.932037,1,1,0,7.14184,0.15 --7.4804,0.884188,0.932037,1,3,0,8.21421,0.15 --7.40948,1,0.932037,1,1,0,7.67663,0.15 --6.7729,0.94969,0.932037,2,3,0,7.7319,0.15 --6.88124,0.967448,0.932037,1,3,0,6.95576,0.15 --8.24949,0.746027,0.932037,2,3,0,8.25756,0.15 --6.96905,1,0.932037,1,3,0,8.10239,0.15 --7.27306,0.939109,0.932037,1,1,0,7.27863,0.15 --7.00308,0.956818,0.932037,1,3,0,7.78354,0.15 --6.75472,0.998187,0.932037,1,3,0,6.9917,0.15 --6.75494,0.999941,0.932037,1,1,0,6.75678,0.15 --6.87358,0.96725,0.932037,1,3,0,6.91321,0.15 --6.88529,0.996099,0.932037,1,1,0,6.92345,0.15 --8.16803,0.810902,0.932037,2,3,0,8.16856,0.15 --8.16803,0.500501,0.932037,1,1,0,9.65653,0.15 --6.84099,0.909134,0.932037,2,3,0,8.86386,0.15 --6.7482,0.97014,0.932037,2,3,0,7.07304,0.15 --6.88126,0.965042,0.932037,1,3,0,6.91312,0.15 --6.91537,0.971395,0.932037,1,3,0,7.15288,0.15 --6.74803,1,0.932037,1,3,0,6.88372,0.15 --6.78862,0.991449,0.932037,2,3,0,6.8033,0.15 --6.75166,1,0.932037,1,3,0,6.77932,0.15 --7.64177,0.652534,0.932037,2,3,0,8.81793,0.15 --7.39307,1,0.932037,1,1,0,7.74629,0.15 --7.39307,0.385651,0.932037,1,1,0,9.0256,0.15 --6.79731,0.988358,0.932037,1,3,0,7.44468,0.15 --7.26742,0.912562,0.932037,1,3,0,7.29563,0.15 --8.03606,0.881597,0.932037,1,1,0,8.03636,0.15 --7.18684,0.969203,0.932037,1,3,0,7.89297,0.15 --7.82185,0.895632,0.932037,1,1,0,7.82342,0.15 --6.9258,0.999365,0.932037,1,3,0,7.68077,0.15 --6.84345,1,0.932037,1,1,0,6.91592,0.15 --8.02819,0.799375,0.932037,1,3,0,8.18865,0.15 --9.74173,0.805241,0.932037,1,3,0,9.76127,0.15 --8.33143,1,0.932037,1,1,0,9.60755,0.15 --7.18582,0.972127,0.932037,1,3,0,8.16309,0.15 --6.92783,1,0.932037,1,1,0,7.13538,0.15 --7.11005,0.961217,0.932037,1,1,0,7.12168,0.15 --6.79373,1,0.932037,1,3,0,7.04271,0.15 --7.11956,0.955726,0.932037,2,3,0,7.20271,0.15 --7.48398,0.958399,0.932037,2,3,0,7.57261,0.15 --7.05344,1,0.932037,2,3,0,7.38948,0.15 --6.89526,1,0.932037,1,1,0,7.02854,0.15 --6.75297,0.996542,0.932037,2,3,0,6.92061,0.15 --6.83977,0.975809,0.932037,1,3,0,6.86918,0.15 --6.8251,1,0.932037,2,3,0,6.85672,0.15 --6.76932,1,0.932037,1,1,0,6.8089,0.15 --7.2411,0.887441,0.932037,1,3,0,7.24713,0.15 --6.77198,0.978158,0.932037,2,3,0,7.39681,0.15 --6.91344,0.959133,0.932037,1,3,0,6.99309,0.15 --7.04881,0.85015,0.932037,2,3,0,7.62026,0.15 --7.60525,0.863371,0.932037,1,3,0,8.23873,0.15 --6.78473,0.999819,0.932037,1,3,0,7.58373,0.15 --6.78473,0.898858,0.932037,1,3,0,7.22409,0.15 --7.78377,0.579188,0.932037,2,3,0,9.7066,0.15 --7.70743,1,0.932037,1,1,0,7.93357,0.15 --7.96247,0.96471,0.932037,1,1,0,8.07171,0.15 --7.12674,0.974601,0.932037,1,3,0,7.81844,0.15 --6.75681,1,0.932037,1,3,0,7.07784,0.15 --6.74929,0.899259,0.932037,2,3,0,7.32696,0.15 --6.74929,0.646445,0.932037,1,3,0,8.08205,0.15 --7.15628,0.857788,0.932037,2,3,0,7.57467,0.15 --7.75903,0.923317,0.932037,2,3,0,7.84476,0.15 --6.85106,0.987384,0.932037,2,3,0,7.98227,0.15 --8.0294,0.746944,0.932037,1,3,0,8.39902,0.15 --6.8022,0.859301,0.932037,2,3,0,8.84948,0.15 --6.77032,1,0.932037,1,1,0,6.79542,0.15 --7.64151,0.740592,0.932037,2,3,0,8.46249,0.15 --8.37811,0.917274,0.932037,2,3,0,8.62816,0.15 --7.49482,1,0.932037,1,1,0,8.22793,0.15 --9.18827,0.523755,0.932037,1,1,0,9.33046,0.15 --7.76093,1,0.932037,1,1,0,8.88732,0.15 --6.97798,1,0.932037,1,1,0,7.50122,0.15 --7.35575,0.873861,0.932037,1,1,0,7.39654,0.15 --7.35575,0.110444,0.932037,1,1,0,11.0745,0.15 --7.35575,0.0800688,0.932037,1,3,0,15.4327,0.15 --7.48223,0.672997,0.932037,1,3,0,8.8362,0.15 --6.78001,0.901552,0.932037,2,3,0,8.42084,0.15 --7.27496,0.91456,0.932037,2,3,0,7.304,0.15 --7.27496,0.889573,0.932037,1,1,0,7.87313,0.15 --6.74818,0.981145,0.932037,1,3,0,7.27579,0.15 --6.74818,0.540736,0.932037,1,3,0,8.56126,0.15 --6.84577,0.975084,0.932037,1,3,0,6.8552,0.15 --6.84577,0.460221,0.932037,1,3,0,8.80117,0.15 --7.22623,0.87774,0.932037,1,1,0,7.23183,0.15 --6.86085,0.957571,0.932037,1,3,0,7.44679,0.15 --6.84216,1,0.932037,1,1,0,6.8764,0.15 --6.82726,0.902432,0.932037,2,3,0,7.67881,0.15 --7.01244,0.957121,0.932037,1,1,0,7.01282,0.15 --6.753,0.947388,0.932037,2,3,0,7.40574,0.15 --6.75612,0.999688,0.932037,2,3,0,6.75709,0.15 --7.10487,0.901325,0.932037,1,3,0,7.25063,0.15 --6.75288,0.934052,0.932037,2,3,0,7.61355,0.15 --6.75911,0.998131,0.932037,1,1,0,6.75973,0.15 --6.97448,0.935151,0.932037,1,3,0,7.07933,0.15 --8.33687,0.727783,0.932037,1,3,0,8.95629,0.15 --7.19311,1,0.932037,1,1,0,7.97929,0.15 --6.86239,0.957299,0.932037,1,3,0,7.41859,0.15 --8.81489,0.675307,0.932037,1,3,0,9.25628,0.15 --9.08174,0.976561,0.932037,1,1,0,9.30033,0.15 --8.72465,1,0.932037,2,3,0,9.23184,0.15 --9.02058,0.973248,0.932037,1,1,0,9.2222,0.15 --6.75096,0.87105,0.932037,1,3,0,9.3739,0.15 --6.77061,0.8673,0.932037,2,3,0,7.49474,0.15 --7.18049,0.687335,0.932037,2,3,0,8.77168,0.15 --6.83677,0.997719,0.932037,1,3,0,7.10412,0.15 --7.0242,0.942244,0.932037,1,3,0,7.2293,0.15 --6.75027,1,0.932037,1,3,0,6.95554,0.15 --7.19098,0.922423,0.932037,2,3,0,7.25741,0.15 --6.75095,0.998409,0.932037,2,3,0,7.18042,0.15 --6.87936,0.965588,0.932037,1,3,0,6.90968,0.15 --6.78928,1,0.932037,2,3,0,6.85581,0.15 --7.24713,0.912602,0.932037,1,3,0,7.27833,0.15 --7.64349,0.933948,0.932037,1,1,0,7.6686,0.15 --7.89818,0.963732,0.932037,1,1,0,7.99945,0.15 --9.96894,0.866816,0.932037,2,3,0,10.0037,0.15 --8.27408,1,0.932037,1,1,0,9.73188,0.15 --8.97796,0.763178,0.932037,1,1,0,9.46742,0.15 --7.07994,1,0.932037,2,3,0,9.38837,0.15 --6.75736,0.879611,0.932037,2,3,0,8.01228,0.15 --6.7519,1,0.932037,1,1,0,6.75617,0.15 --6.78524,0.992274,0.932037,1,3,0,6.78539,0.15 --7.86462,0.758008,0.932037,1,3,0,7.87664,0.15 --7.97349,0.959152,0.932037,1,1,0,8.36464,0.15 --7.11236,1,0.932037,2,3,0,7.71314,0.15 --7.71805,0.799983,0.932037,1,1,0,7.78908,0.15 --9.81575,0.716945,0.932037,2,3,0,10.0088,0.15 --7.32169,1,0.932037,1,1,0,8.93058,0.15 --6.74807,0.833534,0.932037,2,3,0,8.05557,0.15 --6.74803,1,0.932037,2,3,0,6.74806,0.15 --6.75538,0.991246,0.932037,2,3,0,6.79373,0.15 --6.93792,0.962649,0.932037,2,3,0,7.01983,0.15 --7.2862,0.88434,0.932037,1,1,0,7.31645,0.15 --6.99084,1,0.932037,2,3,0,7.19845,0.15 --7.65042,0.905856,0.932037,2,3,0,8.20379,0.15 --7.41337,1,0.932037,1,1,0,7.7679,0.15 --8.85702,0.576942,0.932037,1,1,0,8.98493,0.15 --6.78589,1,0.932037,1,3,0,8.17164,0.15 --6.90223,0.954007,0.932037,1,3,0,7.03131,0.15 --8.14191,0.811993,0.932037,1,3,0,8.27248,0.15 --8.10592,1,0.932037,1,1,0,8.36491,0.15 --8.2689,0.993522,0.932037,2,3,0,8.4528,0.15 --9.32894,0.899169,0.932037,1,1,0,9.34484,0.15 --8.02809,1,0.932037,1,1,0,9.18688,0.15 --6.99166,0.993898,0.932037,1,3,0,7.87392,0.15 --8.06441,0.911089,0.932037,2,3,0,8.31617,0.15 --8.7506,0.922675,0.932037,2,3,0,9.16274,0.15 --7.8978,1,0.932037,1,1,0,8.75888,0.15 --6.94446,1,0.932037,1,1,0,7.56554,0.15 --8.54285,0.771096,0.932037,2,3,0,8.54633,0.15 --6.78594,1,0.932037,1,3,0,7.9627,0.15 --6.78594,0.906519,0.932037,1,3,0,7.16707,0.15 --6.92112,0.942672,0.932037,2,3,0,7.08892,0.15 --6.87261,0.875781,0.932037,2,3,0,8.17854,0.15 --7.08975,0.952205,0.932037,1,1,0,7.09201,0.15 --7.02149,1,0.932037,2,3,0,7.12326,0.15 --7.04584,0.998287,0.932037,2,3,0,7.10444,0.15 --7.04584,0.672299,0.932037,1,3,0,9.55749,0.15 --7.77921,0.832639,0.932037,1,3,0,8.43718,0.15 --6.93132,0.932106,0.932037,1,3,0,8.11383,0.15 --7.37155,0.932331,0.932037,1,3,0,7.37171,0.15 --6.74802,0.977866,0.932037,1,3,0,7.37247,0.15 --6.90501,0.947815,0.932037,2,3,0,7.04469,0.15 --6.90501,0.515929,0.932037,1,1,0,8.06608,0.15 --7.26517,0.747153,0.932037,2,3,0,8.10285,0.15 --6.77759,0.959776,0.932037,1,3,0,7.38193,0.15 --6.75799,1,0.932037,1,1,0,6.77244,0.15 --6.79277,0.99575,0.932037,2,3,0,6.79381,0.15 --6.76109,1,0.932037,1,1,0,6.78457,0.15 --6.7596,0.969448,0.932037,2,3,0,6.95304,0.15 --6.79156,0.988014,0.932037,2,3,0,6.84381,0.15 --6.78312,1,0.932037,1,1,0,6.79707,0.15 --6.77762,0.949288,0.932037,2,3,0,7.08484,0.15 --7.09494,0.924565,0.932037,1,3,0,7.09566,0.15 --6.95426,1,0.932037,2,3,0,7.09613,0.15 --7.28442,0.889685,0.932037,1,1,0,7.32064,0.15 --6.79484,0.997398,0.932037,2,3,0,7.36362,0.15 --6.81648,0.99449,0.932037,1,1,0,6.8247,0.15 --6.84974,0.991789,0.932037,1,1,0,6.86103,0.15 --6.74879,0.865097,0.932037,2,3,0,7.74614,0.15 --6.88211,0.967449,0.932037,1,3,0,6.902,0.15 --6.74845,0.957844,0.932037,2,3,0,7.24214,0.15 --7.20685,0.887254,0.932037,1,3,0,7.25766,0.15 --7.20685,0.564767,0.932037,1,3,0,8.81898,0.15 --7.20685,0.320306,0.932037,1,3,0,12.13,0.15 --6.97752,0.935114,0.932037,2,3,0,7.66742,0.15 --6.87049,1,0.932037,1,1,0,6.96427,0.15 --6.74837,0.966424,0.932037,2,3,0,7.14605,0.15 --6.98253,0.907073,0.932037,2,3,0,7.2529,0.15 --7.79349,0.745081,0.932037,1,1,0,7.81771,0.15 --6.77388,1,0.932037,1,3,0,7.46942,0.15 --6.90086,0.954561,0.932037,1,3,0,7.00827,0.15 --6.79914,1,0.932037,2,3,0,6.8716,0.15 --8.11178,0.713466,0.932037,1,3,0,8.12201,0.15 --8.11178,0.190125,0.932037,1,1,0,11.1441,0.15 --7.24841,1,0.932037,1,1,0,7.88964,0.15 --7.23081,1,0.932037,1,1,0,7.40517,0.15 --6.80377,1,0.932037,2,3,0,7.08741,0.15 --6.85418,0.994603,0.932037,2,3,0,6.86482,0.15 --6.74965,0.98222,0.932037,2,3,0,6.95136,0.15 --7.03844,0.928412,0.932037,1,3,0,7.0566,0.15 --7.22621,0.808036,0.932037,1,3,0,7.93488,0.15 --6.77583,0.927823,0.932037,2,3,0,7.69178,0.15 --6.86535,0.971878,0.932037,1,1,0,6.86662,0.15 --6.77928,0.990027,0.932037,1,3,0,6.92787,0.15 --6.78451,0.998625,0.932037,1,1,0,6.79187,0.15 --6.78451,0.773207,0.932037,1,3,0,7.90069,0.15 --6.75189,0.967957,0.932037,2,3,0,6.99818,0.15 --6.88731,0.96889,0.932037,1,3,0,6.89993,0.15 --6.83332,1,0.932037,1,1,0,6.8859,0.15 --6.96445,0.969353,0.932037,1,1,0,6.9678,0.15 --6.74853,0.993691,0.932037,1,3,0,6.95955,0.15 --6.79227,0.98474,0.932037,2,3,0,6.83336,0.15 --6.78141,0.965461,0.932037,2,3,0,6.96936,0.15 --6.75837,0.995995,0.932037,1,3,0,6.80286,0.15 --6.80841,0.982527,0.932037,1,3,0,6.84862,0.15 --6.92145,0.989324,0.932037,2,3,0,6.92312,0.15 --6.94393,0.992369,0.932037,1,1,0,6.99666,0.15 --8.0719,0.66438,0.932037,1,1,0,8.0808,0.15 --8.30789,0.913191,0.932037,1,1,0,8.7652,0.15 --6.88395,1,0.932037,2,3,0,7.79691,0.15 --6.88395,0.525809,0.932037,1,3,0,8.46396,0.15 --7.66074,0.862122,0.932037,2,3,0,7.66587,0.15 --7.48718,1,0.932037,1,1,0,7.73391,0.15 --7.24771,1,0.932037,1,1,0,7.49536,0.15 --6.75294,0.907734,0.932037,2,3,0,8.2612,0.15 --6.75294,0.882023,0.932037,1,3,0,7.23222,0.15 --6.75294,0.648763,0.932037,1,3,0,8.1161,0.15 --6.75671,0.998954,0.932037,1,1,0,6.75747,0.15 --7.51733,0.821118,0.932037,1,3,0,7.63136,0.15 --7.23718,1,0.932037,2,3,0,7.55107,0.15 --7.23718,0.584164,0.932037,1,1,0,8.1976,0.15 --6.75151,1,0.932037,1,3,0,7.10952,0.15 --6.76119,0.993068,0.932037,2,3,0,6.78713,0.15 --6.79508,0.984853,0.932037,2,3,0,6.84415,0.15 --8.30022,0.789495,0.932037,2,3,0,8.51335,0.15 --7.08882,0.985416,0.932037,1,3,0,8.13433,0.15 --6.74804,0.991804,0.932037,1,3,0,7.07332,0.15 --6.76797,0.994746,0.932037,1,3,0,6.77114,0.15 --6.87611,0.984786,0.932037,2,3,0,6.88112,0.15 --7.10363,0.930507,0.932037,1,3,0,7.38443,0.15 --7.1931,0.968366,0.932037,1,1,0,7.30124,0.15 --7.02744,1,0.932037,1,1,0,7.20716,0.15 --7.47087,0.716122,0.932037,1,3,0,8.36114,0.15 --7.77445,0.953734,0.932037,1,1,0,7.84235,0.15 --7.10232,0.976364,0.932037,1,3,0,7.65215,0.15 --6.89247,0.977052,0.932037,2,3,0,7.36801,0.15 --6.88406,1,0.932037,2,3,0,6.92287,0.15 --7.00739,0.972361,0.932037,1,1,0,7.01912,0.15 --7.4581,0.959878,0.932037,2,3,0,7.46539,0.15 --7.4581,0.358894,0.932037,1,1,0,9.21803,0.15 --8.39486,0.699937,0.932037,1,1,0,8.5651,0.15 --6.98009,0.931934,0.932037,1,3,0,8.77344,0.15 --7.75622,0.895607,0.932037,2,3,0,8.30908,0.15 --7.45294,1,0.932037,1,1,0,7.85686,0.15 --7.81191,0.87317,0.932037,1,1,0,8.02199,0.15 --7.07889,1,0.932037,2,3,0,7.65163,0.15 --8.02018,0.93056,0.932037,2,3,0,8.11738,0.15 --7.32245,1,0.932037,1,1,0,7.89443,0.15 --7.11924,1,0.932037,2,3,0,7.35057,0.15 --7.13426,0.994637,0.932037,1,1,0,7.25741,0.15 --6.81324,1,0.932037,1,1,0,7.02809,0.15 --7.90962,0.554652,0.932037,2,3,0,9.26763,0.15 --10.1284,0.790216,0.932037,1,3,0,10.2416,0.15 --8.90062,1,0.932037,1,1,0,10.0537,0.15 --6.80723,1,0.932037,2,3,0,8.62687,0.15 --6.86729,0.973895,0.932037,2,3,0,7.02735,0.15 --6.79392,1,0.932037,1,1,0,6.85106,0.15 --7.40012,0.888235,0.932037,2,3,0,7.70807,0.15 --6.93792,1,0.932037,2,3,0,7.29993,0.15 --7.00949,0.984312,0.932037,1,1,0,7.03975,0.15 --7.13808,0.973678,0.932037,1,1,0,7.17115,0.15 --6.78692,0.965669,0.932037,1,3,0,7.25761,0.15 --6.87345,0.885758,0.932037,2,3,0,7.29989,0.15 --7.7385,0.869841,0.932037,2,3,0,7.74068,0.15 --7.7385,0.102215,0.932037,1,1,0,11.7215,0.15 --8.03266,0.893586,0.932037,1,1,0,8.35655,0.15 --8.22194,0.92979,0.932037,1,1,0,8.66902,0.15 --7.3561,1,0.932037,2,3,0,7.97443,0.15 --6.78127,1,0.932037,1,3,0,7.27452,0.15 --6.82275,0.984055,0.932037,1,3,0,6.89491,0.15 --7.6571,0.742126,0.932037,1,3,0,8.29259,0.15 --8.03026,0.829375,0.932037,1,3,0,9.64909,0.15 --7.37223,1,0.932037,1,1,0,7.93907,0.15 --6.79515,0.988926,0.932037,1,3,0,7.42116,0.15 --6.82487,0.992469,0.932037,1,1,0,6.83189,0.15 --7.12496,0.969767,0.932037,2,3,0,7.16248,0.15 --8.26834,0.652897,0.932037,1,1,0,8.32004,0.15 --8.67193,0.856184,0.932037,1,1,0,9.18766,0.15 --6.90442,1,0.932037,1,1,0,8.03082,0.15 --7.94108,0.68975,0.932037,1,1,0,7.94519,0.15 --7.78516,0.528351,0.932037,1,3,0,10.1916,0.15 --7.48177,1,0.932037,1,1,0,7.8074,0.15 --6.80338,0.90422,0.932037,2,3,0,8.07863,0.15 --6.89878,0.96934,0.932037,1,1,0,6.90583,0.15 --7.30937,0.866085,0.932037,1,1,0,7.32592,0.15 --6.85274,1,0.932037,1,1,0,7.15684,0.15 --6.85274,0.743543,0.932037,1,3,0,7.59752,0.15 --6.85274,0.563681,0.932037,1,3,0,9.12334,0.15 --7.14252,0.905701,0.932037,1,1,0,7.15244,0.15 --6.88606,1,0.932037,1,1,0,7.07414,0.15 --6.81352,1,0.932037,1,1,0,6.87385,0.15 --7.22426,0.603012,0.932037,2,3,0,8.88007,0.15 --6.75466,1,0.932037,1,3,0,7.17215,0.15 --6.77207,0.962029,0.932037,2,3,0,6.97984,0.15 --7.20122,0.9126,0.932037,1,3,0,7.2415,0.15 --7.97419,0.889846,0.932037,1,3,0,7.97427,0.15 --7.1089,0.976552,0.932037,1,3,0,7.82637,0.15 --7.1089,0.884111,0.932037,1,3,0,7.82698,0.15 --6.98201,0.835391,0.932037,2,3,0,9.32581,0.15 --7.4823,0.923908,0.932037,1,3,0,7.48233,0.15 --8.13382,0.907974,0.932037,1,1,0,8.15008,0.15 --7.0191,0.992287,0.932037,1,3,0,7.97523,0.15 --7.38884,0.929413,0.932037,1,1,0,7.39423,0.15 --7.05345,0.945247,0.932037,1,3,0,8.00914,0.15 --7.88022,0.88235,0.932037,2,3,0,7.92302,0.15 --7.47896,1,0.932037,1,1,0,7.94438,0.15 --8.26848,0.902685,0.932037,2,3,0,8.45552,0.15 --8.36145,0.964836,0.932037,1,1,0,8.90958,0.15 --6.80918,1,0.932037,1,3,0,7.82987,0.15 --7.23868,0.600861,0.932037,2,3,0,8.89375,0.15 --6.89006,1,0.932037,1,1,0,7.13419,0.15 --6.8044,1,0.932037,2,3,0,6.86543,0.15 --6.86009,0.995405,0.932037,2,3,0,6.86567,0.15 --6.86009,0.799308,0.932037,1,3,0,7.97123,0.15 --8.99856,0.728419,0.932037,2,3,0,9.23129,0.15 --9.09468,0.991837,0.932037,1,1,0,9.38997,0.15 --8.73756,1,0.932037,1,1,0,9.24597,0.15 --7.55986,0.937761,0.932037,1,3,0,8.57866,0.15 --7.99912,0.937675,0.932037,1,1,0,8.05117,0.15 --7.76055,1,0.932037,1,1,0,8.08641,0.15 --8.28732,0.977606,0.932037,2,3,0,8.34339,0.15 --6.82679,0.992827,0.932037,1,3,0,8.22618,0.15 --6.87274,0.996281,0.932037,2,3,0,6.88424,0.15 --6.78865,0.91873,0.932037,2,3,0,7.41091,0.15 --6.76058,1,0.932037,2,3,0,6.78115,0.15 --6.76058,0.44465,0.932037,2,3,0,10.1097,0.15 --8.19963,0.701948,0.932037,1,3,0,8.62984,0.15 --6.87827,1,0.932037,1,3,0,8.08649,0.15 --6.90011,0.99488,0.932037,1,1,0,6.92793,0.15 --7.58846,0.835161,0.932037,1,3,0,7.98997,0.15 --6.84168,1,0.932037,2,3,0,7.32922,0.15 --6.79898,0.907476,0.932037,2,3,0,7.23342,0.15 --7.18968,0.940405,0.932037,2,3,0,7.1897,0.15 --7.30081,0.811278,0.932037,2,3,0,8.27114,0.15 --7.44395,0.975262,0.932037,1,1,0,7.52376,0.15 --7.10913,1,0.932037,1,1,0,7.3984,0.15 --6.74902,0.994264,0.932037,1,3,0,7.08219,0.15 --7.95169,0.736282,0.932037,1,3,0,8.05657,0.15 -# -# Elapsed Time: 0.005 seconds (Warm-up) -# 0.012 seconds (Sampling) -# 0.017 seconds (Total) -# diff --git a/src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv b/src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv deleted file mode 100644 index 5688883ef0..0000000000 --- a/src/test/unit/mcmc/test_csv_files/bernoulli_zeta.csv +++ /dev/null @@ -1,1057 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 35 -# stan_version_patch = 0 -# model = bernoulli_model -# start_datetime = 2024-07-20 18:56:30 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 = examples/bernoulli/bernoulli.data.json -# init = 2 (Default) -# random -# seed = 3635036313 (Default) -# output -# file = bernoulli_out.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-25-gbb9ce42 -# stancflags = -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,zeta -# Adaptation terminated -# Step size = 0.932037 -# Diagonal elements of inverse mass matrix: -# 0.591014 --7.81355,0.761218,0.932037,1,3,0,8.13669,0.102158 --8.71049,0.894869,0.932037,1,1,0,8.72268,0.0676546 --7.3531,0.957519,0.932037,1,3,0,8.53469,0.131664 --7.02007,1,0.932037,1,1,0,7.29505,0.166128 --8.49033,0.716959,0.932037,1,3,0,9.20407,0.513986 --7.18724,1,0.932037,1,1,0,8.06459,0.377282 --10.0621,0.636916,0.932037,2,3,0,10.0852,0.615706 --8.11851,1,0.932037,1,1,0,9.65805,0.482811 --6.86936,0.948809,0.932037,2,3,0,8.60097,0.192035 --7.13756,0.935492,0.932037,2,3,0,7.43717,0.151774 --7.09122,1,0.932037,1,1,0,7.19518,0.157048 --6.91669,1,0.932037,1,1,0,7.06383,0.182475 --6.76371,0.840542,0.932037,2,3,0,8.08838,0.228308 --6.84805,0.983351,0.932037,1,3,0,6.84861,0.197051 --8.3727,0.653843,0.932037,2,3,0,9.53079,0.504537 --7.25928,0.806553,0.932037,1,3,0,9.43963,0.139678 --6.95987,0.853051,0.932037,2,3,0,9.71446,0.175062 --6.95334,1,0.932037,1,1,0,7.00708,0.17612 --6.98417,0.993206,0.932037,1,1,0,7.02663,0.171288 --8.9535,0.727406,0.932037,1,3,0,9.27425,0.0610911 --7.08162,0.995936,0.932037,2,3,0,9.00617,0.158197 --7.16691,0.98306,0.932037,1,1,0,7.22238,0.148646 --6.8898,1,0.932037,1,1,0,7.10684,0.18768 --7.8902,0.846547,0.932037,1,3,0,7.96857,0.0983126 --7.24239,1,0.932037,1,1,0,7.78446,0.14123 --7.94748,0.888836,0.932037,1,1,0,7.94857,0.0955821 --6.83694,0.864212,0.932037,2,3,0,8.91495,0.305006 --6.83694,0.425574,0.932037,1,3,0,9.01249,0.305006 --6.80131,0.985852,0.932037,1,3,0,6.93894,0.210747 --6.74824,0.978446,0.932037,2,3,0,6.95179,0.252645 --6.74832,0.945401,0.932037,2,3,0,7.0277,0.24694 --6.85442,0.972221,0.932037,1,3,0,6.87104,0.310384 --6.86406,0.996818,0.932037,1,1,0,6.89618,0.313175 --7.11238,0.918504,0.932037,1,1,0,7.12695,0.365274 --7.11238,0.431368,0.932037,1,1,0,8.53302,0.365274 --6.79843,1,0.932037,1,1,0,7.00834,0.291015 --6.74804,0.996585,0.932037,2,3,0,6.81732,0.249269 --9.50952,0.509265,0.932037,1,3,0,9.67564,0.584141 --8.27778,1,0.932037,1,1,0,9.48419,0.496645 --7.2527,1,0.932037,2,3,0,8.04703,0.140278 --6.75205,0.907555,0.932037,2,3,0,8.25548,0.238895 --7.3411,0.857468,0.932037,1,3,0,7.42326,0.399305 --7.07094,1,0.932037,1,1,0,7.32247,0.358137 --7.04767,0.556206,0.932037,2,3,0,9.56585,0.353943 --6.87625,1,0.932037,2,3,0,6.9975,0.190522 --7.12535,0.945777,0.932037,1,1,0,7.12652,0.153122 --7.12535,0.913353,0.932037,1,1,0,7.53634,0.153122 --6.78755,1,0.932037,2,3,0,7.04258,0.286194 --7.7545,0.780448,0.932037,1,3,0,7.76329,0.447766 --6.77502,0.859809,0.932037,2,3,0,8.49845,0.221729 --7.19668,0.726665,0.932037,2,3,0,8.64609,0.145619 --9.64819,0.775506,0.932037,2,3,0,10.0305,0.0462333 --6.86272,0.7808,0.932037,1,3,0,10.9403,0.312792 --6.99329,0.696273,0.932037,2,3,0,8.30815,0.343519 --6.99329,0.700745,0.932037,1,1,0,7.63428,0.343519 --7.11558,0.957857,0.932037,1,1,0,7.18108,0.365809 --6.80487,1,0.932037,2,3,0,7.09376,0.209509 --6.97334,0.955154,0.932037,2,3,0,7.16146,0.17294 --7.2664,0.98044,0.932037,2,3,0,7.27318,0.139035 --7.06819,1,0.932037,2,3,0,7.25815,0.159843 --6.74803,0.991749,0.932037,1,3,0,7.05576,0.250595 --7.05542,0.823118,0.932037,2,3,0,7.78068,0.161448 --6.89251,1,0.932037,1,1,0,7.02757,0.18713 --6.76584,0.932575,0.932037,2,3,0,7.49343,0.22691 --6.75064,0.997924,0.932037,2,3,0,6.78013,0.241023 --6.91371,0.96173,0.932037,1,3,0,6.93351,0.183027 --6.74953,0.994131,0.932037,1,3,0,6.91533,0.256915 --8.33302,0.635332,0.932037,1,3,0,9.05105,0.0798054 --8.04729,1,0.932037,1,1,0,8.43889,0.0910907 --8.42015,0.956552,0.932037,1,1,0,8.53727,0.0767553 --7.91154,1,0.932037,1,1,0,8.4304,0.0972813 --7.65791,1,0.932037,1,1,0,7.97836,0.110745 --7.97869,0.955317,0.932037,1,1,0,8.06587,0.0941427 --6.81845,1,0.932037,1,3,0,7.88771,0.205153 --6.76575,0.914099,0.932037,2,3,0,7.34829,0.274011 --6.74964,0.996733,0.932037,2,3,0,6.78491,0.257167 --6.77106,0.99494,0.932037,1,3,0,6.77141,0.27745 --6.77106,0.945747,0.932037,1,3,0,6.92649,0.27745 --6.77106,0.856062,0.932037,1,3,0,7.35372,0.27745 --6.88028,0.948865,0.932037,2,3,0,7.03829,0.18966 --7.33958,0.635769,0.932037,2,3,0,9.861,0.132761 --8.06974,0.890942,0.932037,1,1,0,8.07292,0.0901234 --6.97186,0.998838,0.932037,1,3,0,7.91764,0.173168 --6.76939,0.981956,0.932037,1,3,0,7.03238,0.276417 --7.44177,0.80944,0.932037,1,3,0,7.79154,0.124879 --8.01591,0.972061,0.932037,2,3,0,8.03736,0.0924685 --9.92045,0.865258,0.932037,2,3,0,9.92397,0.607959 --7.31963,1,0.932037,2,3,0,10.3209,0.134414 --6.9789,1,0.932037,1,1,0,7.25409,0.172086 --7.21981,0.951312,0.932037,1,1,0,7.23197,0.143362 --7.47612,0.930523,0.932037,2,3,0,8.12075,0.122424 --6.81131,0.990375,0.932037,2,3,0,7.55719,0.207381 --6.80278,0.920389,0.932037,2,3,0,7.43635,0.210229 --6.88803,0.979103,0.932037,1,1,0,6.89063,0.188041 --7.02902,0.795987,0.932037,2,3,0,8.6993,0.164908 --6.74805,0.993012,0.932037,1,3,0,7.01716,0.250947 --6.93322,0.952905,0.932037,1,3,0,6.95228,0.330673 --6.76781,0.904559,0.932037,2,3,0,7.33629,0.275396 --6.76232,0.985564,0.932037,2,3,0,6.83656,0.271521 --6.87137,0.974516,0.932037,1,3,0,6.87148,0.31522 --7.21556,0.953187,0.932037,2,3,0,7.22785,0.381575 --6.76367,0.998041,0.932037,1,3,0,7.1984,0.228336 --6.82308,0.981349,0.932037,1,3,0,6.86896,0.30038 --6.82308,0.352125,0.932037,1,3,0,10.8402,0.30038 --6.99474,0.738309,0.932037,2,3,0,8.0486,0.34381 --6.99474,0.963463,0.932037,1,1,0,7.1311,0.34381 --6.8637,0.713515,0.932037,2,3,0,8.29356,0.313071 --6.94178,0.974091,0.932037,1,1,0,6.96832,0.332611 --6.80481,1,0.932037,2,3,0,6.9081,0.209531 --6.92327,0.971351,0.932037,1,1,0,6.92425,0.181278 --7.1233,0.957499,0.932037,1,1,0,7.13244,0.153351 --6.76778,0.973133,0.932037,1,3,0,7.19571,0.275378 --6.90939,0.888041,0.932037,2,3,0,7.29419,0.325052 --7.3757,0.927908,0.932037,2,3,0,7.37586,0.129868 --7.33194,1,0.932037,1,1,0,7.48008,0.133389 --6.86262,0.893077,0.932037,2,3,0,9.38827,0.193563 --6.74929,0.996117,0.932037,1,3,0,6.86347,0.256335 --6.74964,0.943201,0.932037,2,3,0,7.03592,0.242941 --6.9015,0.968295,0.932037,2,3,0,6.96204,0.18535 --7.81106,0.864491,0.932037,1,3,0,7.86554,0.102287 --8.616,0.90424,0.932037,1,1,0,8.63659,0.0704513 --8.16761,1,0.932037,1,1,0,8.67561,0.0860773 --6.96545,1,0.932037,1,3,0,8.01828,0.174173 --6.75813,1,0.932037,1,3,0,6.92669,0.232517 --6.75424,1,0.932037,1,1,0,6.75812,0.236232 --7.76056,0.503853,0.932037,2,3,0,10.2889,0.104957 --7.12518,1,0.932037,1,1,0,7.64631,0.153141 --7.67249,0.905419,0.932037,1,1,0,7.67491,0.109892 --7.63881,1,0.932037,1,1,0,7.83222,0.11188 --7.3844,0.889767,0.932037,1,3,0,8.80917,0.405007 --6.76719,1,0.932037,1,3,0,7.348,0.226074 --7.47953,0.852161,0.932037,1,3,0,7.59716,0.122185 --7.42386,1,0.932037,2,3,0,7.59422,0.126195 --7.91668,0.975432,0.932037,2,3,0,7.94672,0.0970356 --6.83066,1,0.932037,2,3,0,7.62924,0.302955 --6.96269,0.956934,0.932037,1,1,0,6.97473,0.337182 --6.74847,0.963031,0.932037,2,3,0,7.15706,0.253745 --6.80708,0.988647,0.932037,2,3,0,6.82289,0.208765 --6.91792,0.9732,0.932037,1,1,0,6.91947,0.18225 --6.84983,1,0.932037,2,3,0,6.91467,0.196611 --6.88905,0.990653,0.932037,1,1,0,6.90679,0.187834 --7.15463,0.975663,0.932037,2,3,0,7.16,0.372177 --6.9586,1,0.932037,1,1,0,7.13267,0.336303 --7.56708,0.803851,0.932037,1,1,0,7.59178,0.42727 --6.76736,1,0.932037,1,3,0,7.31987,0.275105 --6.80123,0.959699,0.932037,2,3,0,6.95431,0.292173 --6.80123,0.759564,0.932037,1,3,0,7.84546,0.292173 --6.80123,0.902778,0.932037,1,3,0,7.20675,0.292173 --6.80123,0.96482,0.932037,1,1,0,6.88076,0.292173 --6.78299,0.988689,0.932037,2,3,0,6.88032,0.217954 --7.1107,0.936673,0.932037,1,3,0,7.12632,0.154778 --7.31567,0.961429,0.932037,1,1,0,7.35195,0.134747 --7.07455,0.968694,0.932037,2,3,0,7.7776,0.159058 --6.74831,0.993779,0.932037,1,3,0,7.05357,0.247022 --6.84249,0.975275,0.932037,1,3,0,6.85756,0.306763 --6.88224,0.995647,0.932037,2,3,0,6.90622,0.31816 --8.68021,0.668585,0.932037,2,3,0,8.68611,0.0685348 --7.80603,1,0.932037,1,1,0,8.5851,0.102548 --7.27572,1,0.932037,1,1,0,7.73044,0.138203 --8.91337,0.902662,0.932037,2,3,0,9.15324,0.545374 --7.22471,0.840347,0.932037,1,3,0,9.85532,0.142893 --7.57214,0.980256,0.932037,2,3,0,7.60142,0.116002 --7.46188,1,0.932037,1,1,0,7.66831,0.123431 --7.21293,1,0.932037,1,1,0,7.46083,0.144026 --7.27196,0.911127,0.932037,1,3,0,8.06683,0.389783 --6.99285,1,0.932037,1,1,0,7.22442,0.343431 --7.64686,0.789204,0.932037,1,1,0,7.67915,0.436243 --7.64686,0.588674,0.932037,1,1,0,8.70948,0.436243 --6.76317,0.84811,0.932037,2,3,0,8.40171,0.228672 --6.75852,0.995961,0.932037,2,3,0,6.79457,0.232184 --6.96185,0.956175,0.932037,2,3,0,7.06538,0.174745 --6.7597,0.95957,0.932037,2,3,0,7.23201,0.269421 --6.95356,0.940807,0.932037,1,3,0,7.05195,0.176085 --6.74802,0.995879,0.932037,1,3,0,6.94105,0.250316 --6.80409,0.985416,0.932037,1,3,0,6.81492,0.209778 --6.78431,0.93291,0.932037,2,3,0,7.30965,0.217376 --6.85124,0.98309,0.932037,1,1,0,6.85256,0.196264 --6.91874,0.970098,0.932037,1,3,0,7.11707,0.327302 --6.91874,0.434093,0.932037,1,3,0,9.39656,0.327302 --6.92998,0.940657,0.932037,2,3,0,7.25758,0.180084 --6.7616,0.987015,0.932037,1,3,0,6.96899,0.270965 --6.77385,0.996249,0.932037,1,1,0,6.77617,0.279101 --7.11956,0.891801,0.932037,1,3,0,7.32561,0.153771 --7.10361,0.938678,0.932037,1,3,0,7.72046,0.363797 --7.10361,0.642361,0.932037,1,1,0,7.89438,0.363797 --8.5001,0.593919,0.932037,1,1,0,8.53813,0.514754 --7.1692,1,0.932037,2,3,0,8.39313,0.148408 --6.99964,1,0.932037,2,3,0,7.15856,0.169008 --6.82605,1,0.932037,1,1,0,6.95904,0.202915 --6.80069,1,0.932037,1,1,0,6.8286,0.210965 --6.80069,0.826864,0.932037,1,3,0,7.56839,0.210965 --6.80069,0.712989,0.932037,1,3,0,8.08135,0.210965 --6.79864,1,0.932037,1,1,0,6.81323,0.211702 --7.21975,0.922333,0.932037,1,3,0,7.24006,0.143367 --6.75061,0.978686,0.932037,1,3,0,7.23991,0.259057 --8.50882,0.710206,0.932037,2,3,0,8.58833,0.0738116 --6.98994,1,0.932037,1,3,0,8.37388,0.170428 --8.68191,0.796805,0.932037,2,3,0,9.47091,0.528667 --7.31609,1,0.932037,2,3,0,8.2644,0.395923 --7.14381,1,0.932037,1,1,0,7.36712,0.370442 --7.14381,0.475525,0.932037,1,1,0,8.41075,0.370442 --7.29505,0.813437,0.932037,2,3,0,8.20133,0.136508 --7.97276,0.895575,0.932037,1,1,0,7.97663,0.0944136 --9.00874,0.888587,0.932037,1,1,0,9.0167,0.0597133 --8.5484,1,0.932037,1,1,0,9.10361,0.0725465 --7.88735,1,0.932037,1,1,0,8.51142,0.0984513 --7.36782,1,0.932037,1,1,0,7.8262,0.130489 --7.34887,1,0.932037,1,1,0,7.48713,0.132005 --6.81839,0.987631,0.932037,2,3,0,7.46646,0.205169 --6.81839,0.712592,0.932037,1,3,0,8.16085,0.205169 --6.74807,0.998893,0.932037,1,3,0,6.81316,0.251268 --6.87013,0.959268,0.932037,2,3,0,6.97825,0.314875 --6.76585,1,0.932037,1,1,0,6.83725,0.274086 --6.7566,0.994396,0.932037,2,3,0,6.80045,0.233869 --6.7566,0.628726,0.932037,1,3,0,8.7002,0.233869 --6.82277,0.986161,0.932037,1,3,0,6.82387,0.203864 --7.3013,0.877627,0.932037,1,3,0,7.5333,0.393891 --8.78447,0.79108,0.932037,2,3,0,8.87542,0.536201 --7.50584,1,0.932037,1,1,0,8.46306,0.420094 --7.15669,1,0.932037,1,1,0,7.48033,0.372505 --7.43591,0.967588,0.932037,2,3,0,7.54437,0.411558 --6.96987,0.913229,0.932037,1,3,0,7.88228,0.173478 --6.89773,1,0.932037,1,1,0,6.97541,0.186089 --7.36158,0.930716,0.932037,1,3,0,7.36402,0.130984 --7.16589,1,0.932037,1,1,0,7.37174,0.148752 --6.95869,1,0.932037,1,1,0,7.13528,0.175252 --7.16168,0.929564,0.932037,1,3,0,7.57434,0.373296 --8.02154,0.725795,0.932037,1,1,0,8.09574,0.473982 --8.63423,0.930003,0.932037,2,3,0,9.03662,0.52509 --6.93887,1,0.932037,1,1,0,8.0172,0.331956 --6.87271,1,0.932037,1,1,0,6.94734,0.315589 --6.77339,1,0.932037,2,3,0,6.85408,0.222571 --6.98298,0.942095,0.932037,1,3,0,7.07789,0.341427 --6.75868,1,0.932037,1,3,0,6.91623,0.268536 --6.7906,0.973381,0.932037,2,3,0,6.88716,0.2876 --7.56742,0.820209,0.932037,1,3,0,7.57193,0.427309 --6.75108,1,0.932037,1,3,0,7.35001,0.259868 --6.80655,0.983396,0.932037,1,3,0,6.83092,0.208942 --6.91728,0.973208,0.932037,1,1,0,6.91879,0.182366 --7.7691,0.915431,0.932037,2,3,0,7.98664,0.449282 --6.765,1,0.932037,1,3,0,7.46164,0.273492 --7.37311,0.856184,0.932037,1,3,0,7.3856,0.403538 --7.3305,1,0.932037,1,1,0,7.55404,0.39788 --7.3305,0.663523,0.932037,1,1,0,8.12143,0.39788 --7.12567,0.837343,0.932037,1,3,0,8.09517,0.153086 --7.15885,0.957841,0.932037,2,3,0,7.71194,0.149489 --6.75049,0.994782,0.932037,1,3,0,7.12461,0.241282 --6.81461,0.982255,0.932037,1,3,0,6.83366,0.297352 --6.75614,0.996516,0.932037,1,3,0,6.83027,0.234298 --6.74853,0.904663,0.932037,2,3,0,7.2911,0.246039 --7.01677,0.911602,0.932037,2,3,0,7.26139,0.348138 --6.92929,0.642216,0.932037,2,3,0,8.77716,0.32977 --7.65529,0.771289,0.932037,1,1,0,7.66932,0.43717 --7.01834,1,0.932037,1,1,0,7.46402,0.348441 --6.74897,1,0.932037,1,3,0,6.95557,0.255474 --9.81129,0.348606,0.932037,1,3,0,11.6845,0.0433987 --10.4379,0.964322,0.932037,1,1,0,10.6078,0.0342236 --12.3737,0.923455,0.932037,1,1,0,12.3737,0.0170254 --8.6914,0.906628,0.932037,1,3,0,12.5921,0.0682079 --7.8205,1,0.932037,1,1,0,8.59832,0.1018 --6.76573,0.925015,0.932037,1,3,0,8.00716,0.274002 --7.18424,0.803585,0.932037,2,3,0,7.86457,0.146867 --6.74867,0.98391,0.932037,1,3,0,7.18696,0.254535 --6.74867,0.809678,0.932037,1,3,0,7.5541,0.254535 --6.78928,0.864392,0.932037,2,3,0,7.45892,0.21529 --7.73008,0.857073,0.932037,2,3,0,7.95215,0.106623 --6.90924,0.999548,0.932037,1,3,0,7.59486,0.183866 --6.83204,1,0.932037,1,1,0,6.89889,0.201236 --6.92095,0.978894,0.932037,1,1,0,6.92784,0.181697 --6.84946,1,0.932037,1,1,0,6.91633,0.196703 --6.87329,0.97872,0.932037,1,3,0,7.05429,0.315746 --7.77797,0.726161,0.932037,1,1,0,7.77978,0.450197 --7.91451,0.983052,0.932037,2,3,0,8.2695,0.463836 --6.99541,0.905965,0.932037,1,3,0,8.38798,0.169623 --6.76541,0.9819,0.932037,1,3,0,7.04888,0.273777 --6.75969,1,0.932037,1,1,0,6.76622,0.269411 --6.88511,0.980043,0.932037,2,3,0,6.89657,0.188645 --6.77682,0.92494,0.932037,2,3,0,7.55206,0.220831 --7.22693,0.885941,0.932037,1,3,0,7.36359,0.383265 --7.08301,1,0.932037,2,3,0,7.27,0.360257 --6.74807,1,0.932037,1,3,0,7.01313,0.251185 --6.78184,0.991048,0.932037,1,3,0,6.7889,0.218469 --7.7414,0.782413,0.932037,1,3,0,7.94246,0.446396 --8.34868,0.79224,0.932037,1,1,0,8.64598,0.502563 --6.96656,1,0.932037,1,1,0,7.85206,0.338006 --8.55062,0.559382,0.932037,1,1,0,8.55696,0.518696 --8.71259,0.939683,0.932037,1,1,0,9.36157,0.530944 --7.02011,1,0.932037,1,1,0,8.0992,0.34878 --7.73032,0.771978,0.932037,1,1,0,7.7681,0.445231 --7.58699,1,0.932037,1,1,0,7.95753,0.429546 --10.1664,0.37457,0.932037,1,1,0,10.2962,0.621272 --9.05941,1,0.932037,2,3,0,10.4928,0.555399 --6.95163,0.994678,0.932037,1,3,0,9.25144,0.176401 --6.991,0.991344,0.932037,1,1,0,7.03106,0.170271 --6.93665,1,0.932037,1,1,0,7.01246,0.178921 --7.53693,0.951931,0.932037,2,3,0,7.60421,0.42377 --7.35042,1,0.932037,1,1,0,7.65542,0.400548 --6.74833,1,0.932037,1,3,0,7.21002,0.253091 --7.30096,0.866757,0.932037,1,3,0,7.34306,0.393844 --7.33424,0.995938,0.932037,2,3,0,7.52117,0.398384 --7.00834,1,0.932037,1,1,0,7.27119,0.346501 --7.00834,0.750927,0.932037,1,3,0,7.93882,0.346501 --6.85276,0.717415,0.932037,2,3,0,8.2801,0.309891 --6.88149,0.915088,0.932037,2,3,0,7.26489,0.189404 --7.01531,0.954346,0.932037,2,3,0,7.30842,0.166787 --8.49716,0.821021,0.932037,2,3,0,8.90444,0.0741898 --7.75198,1,0.932037,2,3,0,8.42455,0.105422 --6.78374,0.995713,0.932037,1,3,0,7.67855,0.217625 --6.78319,0.955918,0.932037,2,3,0,7.05067,0.284087 --6.76877,0.993356,0.932037,2,3,0,6.83116,0.225131 --6.76604,1,0.932037,2,3,0,6.77242,0.226786 --6.80257,0.828664,0.932037,2,3,0,7.81548,0.210302 --6.7921,0.928548,0.932037,2,3,0,7.34502,0.214164 --6.7921,0.869785,0.932037,1,3,0,7.3846,0.214164 --6.78247,1,0.932037,1,1,0,6.7969,0.218184 --6.77338,0.944315,0.932037,2,3,0,7.11056,0.278828 --6.88767,0.984579,0.932037,2,3,0,6.89149,0.188115 --6.87758,1,0.932037,1,1,0,6.91573,0.190237 --6.98427,0.975828,0.932037,1,1,0,6.997,0.171274 --8.16006,0.847199,0.932037,1,3,0,8.23533,0.0863802 --6.92926,1,0.932037,1,3,0,8.02086,0.180209 --6.75334,1,0.932037,1,3,0,6.89875,0.237258 --6.76157,0.984481,0.932037,2,3,0,6.84166,0.270942 --6.77437,0.916298,0.932037,2,3,0,7.16943,0.222065 --6.89883,0.966797,0.932037,2,3,0,7.01941,0.185873 --7.61554,0.929243,0.932037,2,3,0,7.77465,0.432768 --6.74865,1,0.932037,1,3,0,7.4327,0.2456 --7.90889,0.736401,0.932037,1,3,0,8.30046,0.0974084 --7.36433,1,0.932037,1,1,0,7.84078,0.130766 --6.7517,1,0.932037,2,3,0,7.32628,0.239385 --7.47731,0.835796,0.932037,1,3,0,7.65004,0.122341 --6.82682,1,0.932037,1,3,0,7.36972,0.202696 --6.75257,1,0.932037,1,3,0,6.81023,0.238212 --6.74814,0.924039,0.932037,2,3,0,7.16556,0.251902 --6.77547,0.992637,0.932037,1,3,0,6.7818,0.221503 --6.77883,0.96017,0.932037,2,3,0,7.01271,0.281846 --6.83214,0.92718,0.932037,2,3,0,7.10706,0.303446 --6.74855,0.999857,0.932037,1,3,0,6.82323,0.245948 --6.75208,0.991977,0.932037,2,3,0,6.79074,0.261375 --6.74875,1,0.932037,2,3,0,6.7511,0.254796 --6.76331,0.987877,0.932037,2,3,0,6.81164,0.228577 --7.11253,0.925924,0.932037,1,3,0,7.14728,0.154568 --7.33832,0.934594,0.932037,2,3,0,7.89183,0.132864 --7.40317,0.891695,0.932037,1,3,0,8.40906,0.407422 --6.83199,1,0.932037,2,3,0,7.43757,0.20125 --6.83199,0.774019,0.932037,1,3,0,8.04658,0.20125 --6.99888,0.961352,0.932037,1,1,0,7.00012,0.169119 --6.76802,0.991205,0.932037,2,3,0,7.06627,0.225576 --7.1899,0.912501,0.932037,1,3,0,7.23327,0.146297 --7.0344,0.951025,0.932037,1,3,0,7.71962,0.351486 --6.74861,0.964191,0.932037,2,3,0,7.23266,0.245744 --6.9356,0.954146,0.932037,1,3,0,6.96807,0.179103 --6.8766,1,0.932037,1,1,0,6.94182,0.190446 --6.86303,0.963467,0.932037,2,3,0,7.17361,0.312881 --6.89691,0.996253,0.932037,2,3,0,6.92839,0.321957 --6.74898,0.989445,0.932037,2,3,0,6.95643,0.244562 --6.75192,0.906807,0.932037,2,3,0,7.25324,0.239077 --6.89356,0.962004,0.932037,1,3,0,6.92873,0.321106 --6.8915,1,0.932037,1,1,0,6.93856,0.320577 --8.04782,0.661095,0.932037,1,1,0,8.04944,0.476407 --6.96778,1,0.932037,2,3,0,8.10818,0.173806 --6.94531,0.967319,0.932037,1,3,0,7.30665,0.333397 --6.79303,1,0.932037,1,1,0,6.89785,0.28869 --6.75073,0.998473,0.932037,1,3,0,6.79703,0.240873 --6.74807,0.922346,0.932037,2,3,0,7.17097,0.248807 --6.79664,0.986959,0.932037,2,3,0,6.82676,0.290259 --7.42084,0.890966,0.932037,2,3,0,7.44601,0.12642 --7.07938,1,0.932037,1,1,0,7.36895,0.158469 --6.76996,0.975074,0.932037,1,3,0,7.1524,0.27677 --6.97097,0.781354,0.932037,2,3,0,7.8694,0.173307 --7.45672,0.874497,0.932037,1,3,0,7.94747,0.41414 --7.73982,0.898709,0.932037,1,1,0,7.95818,0.446231 --6.75761,1,0.932037,1,3,0,7.45331,0.267571 --6.75128,1,0.932037,2,3,0,6.75597,0.26018 --6.74857,0.969275,0.932037,2,3,0,6.90378,0.245862 --6.78162,0.964009,0.932037,2,3,0,6.94604,0.218566 --6.94452,0.969782,0.932037,1,3,0,6.94577,0.177582 --6.83464,1,0.932037,1,1,0,6.92359,0.200526 --6.85125,0.978801,0.932037,2,3,0,7.03988,0.196263 --8.70862,0.498506,0.932037,2,3,0,10.892,0.0677086 --7.14422,0.988771,0.932037,1,3,0,8.54862,0.151051 --8.22719,0.86569,0.932037,1,3,0,8.25029,0.083741 --7.98302,1,0.932037,1,1,0,8.34174,0.0939456 --7.66766,1,0.932037,1,1,0,8.02784,0.110173 --8.24143,0.924458,0.932037,1,1,0,8.28161,0.0831957 --7.67998,1,0.932037,1,1,0,8.20801,0.109457 --7.87681,0.972029,0.932037,1,1,0,7.99803,0.0989677 --6.74849,0.941373,0.932037,1,3,0,7.96721,0.253832 --7.11836,0.837369,0.932037,2,3,0,7.62397,0.366273 --6.79142,1,0.932037,2,3,0,7.01021,0.287974 --6.77524,1,0.932037,1,1,0,6.79217,0.279893 --6.79636,0.997801,0.932037,2,3,0,6.8016,0.290137 --6.79636,0.948581,0.932037,1,1,0,6.90729,0.290137 --6.87559,0.872276,0.932037,2,3,0,7.36427,0.316373 --7.91757,0.674512,0.932037,1,3,0,8.87065,0.0969933 --6.74935,0.935438,0.932037,1,3,0,8.03013,0.256485 --6.74803,0.97594,0.932037,2,3,0,6.86976,0.250537 --6.81513,0.982667,0.932037,1,3,0,6.82306,0.297542 --7.49872,0.879887,0.932037,2,3,0,7.51782,0.120857 --7.49872,0.948913,0.932037,1,1,0,7.85236,0.120857 --8.04293,0.922216,0.932037,1,1,0,8.07282,0.0912801 --7.35293,1,0.932037,2,3,0,7.93996,0.131677 --7.35293,0.883408,0.932037,1,1,0,8.02395,0.131677 --6.80493,1,0.932037,1,3,0,7.25923,0.209492 --6.82698,0.998151,0.932037,2,3,0,6.83752,0.202651 --6.88114,0.986899,0.932037,1,1,0,6.89144,0.189478 --6.74827,0.964042,0.932037,2,3,0,7.17919,0.25277 --6.93633,0.882605,0.932037,2,3,0,7.40536,0.178978 --8.02922,0.766313,0.932037,1,3,0,8.54794,0.474694 --6.88064,1,0.932037,1,1,0,7.62039,0.317732 --6.99856,0.960668,0.932037,1,1,0,7.02674,0.344573 --6.9205,1,0.932037,1,1,0,7.0171,0.327717 --7.23497,0.895629,0.932037,1,1,0,7.26191,0.384449 --6.81255,0.65863,0.932037,2,3,0,8.81442,0.296589 --6.8557,0.986062,0.932037,1,1,0,6.86976,0.310763 --6.8557,0.724177,0.932037,1,3,0,7.66358,0.310763 --6.75301,0.997497,0.932037,1,3,0,6.85969,0.23766 --9.62741,0.500859,0.932037,1,3,0,9.855,0.591191 --7.2064,1,0.932037,2,3,0,8.74926,0.3802 --6.75431,0.815869,0.932037,2,3,0,7.99167,0.264191 --6.77251,0.990864,0.932037,2,3,0,6.80395,0.22304 --7.81008,0.844756,0.932037,2,3,0,8.00316,0.102338 --8.11847,0.959711,0.932037,1,1,0,8.22643,0.0880753 --9.24757,0.890376,0.932037,2,3,0,10.2168,0.0541819 --6.88942,0.799493,0.932037,1,3,0,10.3695,0.320039 --6.88942,0.261019,0.932037,1,3,0,10.9724,0.320039 --6.80124,0.870892,0.932037,2,3,0,7.43049,0.29218 --6.74978,0.998863,0.932037,1,3,0,6.80164,0.242642 --7.17245,0.854684,0.932037,2,3,0,7.6,0.374989 --8.81972,0.538088,0.932037,1,1,0,8.86828,0.538741 --7.40622,1,0.932037,2,3,0,8.5393,0.127518 --7.26318,0.961918,0.932037,2,3,0,8.05474,0.139325 --7.34728,0.984906,0.932037,1,1,0,7.43596,0.132134 --6.86243,0.997387,0.932037,1,3,0,7.24798,0.193608 --6.89308,0.975225,0.932037,1,3,0,7.09809,0.320982 --7.32886,0.939094,0.932037,2,3,0,7.34307,0.397658 --7.57152,0.913466,0.932037,1,1,0,7.74604,0.427779 --6.94728,1,0.932037,1,1,0,7.36923,0.333835 --6.81842,1,0.932037,1,1,0,6.91356,0.298735 --6.76216,1,0.932037,2,3,0,6.80728,0.229381 --6.85768,0.974601,0.932037,2,3,0,6.94204,0.194717 --6.77062,0.988638,0.932037,1,3,0,6.90934,0.277178 --6.91451,0.978923,0.932037,2,3,0,6.91452,0.326292 --6.78227,1,0.932037,1,1,0,6.87294,0.283622 --7.62346,0.806356,0.932037,1,3,0,7.63204,0.433652 --6.83206,1,0.932037,1,1,0,7.34914,0.303417 --7.29941,0.815839,0.932037,2,3,0,7.843,0.136132 --7.31671,0.996885,0.932037,1,1,0,7.4311,0.134659 --6.78343,0.991818,0.932037,2,3,0,7.37529,0.21776 --6.86006,0.980687,0.932037,1,1,0,6.8608,0.194157 --6.77605,1,0.932037,1,1,0,6.83853,0.221209 --6.86042,0.973286,0.932037,1,3,0,6.93518,0.312134 --6.75338,0.997358,0.932037,1,3,0,6.86494,0.237216 --6.83799,0.976298,0.932037,1,3,0,6.868,0.305342 --7.00374,0.713633,0.932037,2,3,0,8.19304,0.345598 --6.75259,0.98344,0.932037,2,3,0,7.10169,0.238182 --6.79496,0.987555,0.932037,1,3,0,6.81495,0.289538 --6.9391,0.981259,0.932037,2,3,0,6.94195,0.332008 --7.22517,0.904285,0.932037,1,1,0,7.25937,0.383004 --7.21052,1,0.932037,1,1,0,7.37602,0.38082 --6.75985,0.787087,0.932037,2,3,0,8.11836,0.269544 --6.86031,0.946513,0.932037,2,3,0,7.03793,0.194099 --8.19403,0.780681,0.932037,1,3,0,8.38612,0.0850298 --6.7609,1,0.932037,2,3,0,7.87703,0.270409 --6.95309,0.78127,0.932037,2,3,0,7.88077,0.176161 --9.56705,0.565191,0.932037,1,3,0,10.2818,0.587604 --6.75776,1,0.932037,1,3,0,8.93023,0.232834 --6.77632,0.994978,0.932037,1,1,0,6.77679,0.221079 --6.82265,0.996019,0.932037,2,3,0,6.82416,0.203899 --6.89139,0.983404,0.932037,1,1,0,6.89889,0.187357 --6.89139,0.777655,0.932037,1,3,0,8.12126,0.187357 --7.13161,0.926877,0.932037,1,3,0,7.44089,0.36846 --8.35546,0.633109,0.932037,1,1,0,8.40627,0.503122 --7.06834,0.886614,0.932037,1,3,0,8.96147,0.159824 --7.28399,0.958522,0.932037,1,1,0,7.31204,0.137472 --7.28327,1,0.932037,1,1,0,7.40052,0.137535 --7.93284,0.898826,0.932037,1,1,0,7.93762,0.0962692 --7.81694,1,0.932037,1,1,0,8.08024,0.101983 --7.6919,1,0.932037,1,1,0,7.94232,0.108772 --6.76979,0.932315,0.932037,1,3,0,7.86435,0.276668 --6.97696,0.966811,0.932037,2,3,0,6.99094,0.172382 --7.49857,0.902721,0.932037,2,3,0,7.93254,0.120867 --7.50324,0.999237,0.932037,1,1,0,7.65578,0.120547 --6.91611,1,0.932037,2,3,0,7.33316,0.326673 --6.74956,1,0.932037,1,3,0,6.89861,0.243108 --8.35635,0.667972,0.932037,1,3,0,8.48862,0.503195 --8.35709,0.999715,0.932037,1,1,0,8.94945,0.503256 --7.01492,1,0.932037,2,3,0,8.49553,0.16684 --7.08433,0.985549,0.932037,1,1,0,7.13054,0.157871 --7.29556,0.986569,0.932037,2,3,0,7.32674,0.136464 --6.82002,1,0.932037,2,3,0,7.16863,0.299304 --6.82002,0.827599,0.932037,1,1,0,7.18527,0.299304 --6.96415,0.766705,0.932037,2,3,0,7.8936,0.337494 --7.10108,0.953204,0.932037,1,1,0,7.15511,0.363367 --7.08567,1,0.932037,1,1,0,7.2067,0.36072 --8.18465,0.665208,0.932037,1,1,0,8.22692,0.488652 --6.98816,1,0.932037,2,3,0,8.27915,0.170692 --6.9991,0.951104,0.932037,2,3,0,7.40622,0.344679 --6.87003,0.959893,0.932037,1,3,0,7.2399,0.191886 --8.86597,0.67165,0.932037,1,3,0,9.3173,0.0633574 --9.22117,0.969943,0.932037,1,1,0,9.41531,0.0547614 --10.3294,0.926924,0.932037,1,1,0,10.3727,0.0356412 --8.32325,0.989504,0.932037,2,3,0,10.9313,0.0801578 --8.85098,0.946649,0.932037,1,1,0,8.95519,0.0637563 --9.31959,0.960963,0.932037,1,1,0,9.47897,0.0526385 --10.3022,0.93649,0.932037,1,1,0,10.3691,0.0360059 --10.3363,0.998194,0.932037,1,1,0,10.7444,0.0355494 --7.06812,1,0.932037,2,3,0,10.0104,0.159851 --7.09449,0.998201,0.932037,2,3,0,7.16215,0.156661 --7.41044,0.941678,0.932037,1,1,0,7.42835,0.127199 --6.74954,0.897451,0.932037,2,3,0,8.358,0.256927 --7.01483,0.952044,0.932037,2,3,0,7.06471,0.166853 --7.04361,0.949288,0.932037,1,3,0,7.50082,0.353197 --6.84344,1,0.932037,1,1,0,6.98754,0.30706 --6.76346,1,0.932037,1,1,0,6.81845,0.272378 --6.77171,0.981093,0.932037,2,3,0,6.85292,0.277844 --6.84864,0.975946,0.932037,1,1,0,6.84963,0.308656 --6.79009,1,0.932037,1,1,0,6.8359,0.287368 --7.3603,0.823525,0.932037,1,3,0,7.7309,0.131086 --7.81047,0.929962,0.932037,1,1,0,7.84015,0.102318 --7.78154,1,0.932037,1,1,0,7.99363,0.103835 --6.7517,1,0.932037,2,3,0,7.65292,0.239378 --6.78798,0.848042,0.932037,2,3,0,7.61324,0.21582 --6.76,0.921142,0.932037,2,3,0,7.25211,0.269673 --6.79557,0.983288,0.932037,2,3,0,6.85013,0.212834 --7.19183,0.926349,0.932037,1,3,0,7.21025,0.146103 --7.38792,0.988215,0.932037,2,3,0,7.43851,0.128917 --6.96601,1,0.932037,2,3,0,7.30212,0.174084 --7.05786,0.980406,0.932037,1,1,0,7.08973,0.161138 --7.16196,0.993052,0.932037,2,3,0,7.20877,0.149163 --6.77281,0.912405,0.932037,2,3,0,8.28922,0.22288 --6.75974,1,0.932037,1,1,0,6.77054,0.2312 --6.74904,0.896827,0.932037,2,3,0,7.34903,0.244397 --6.99017,0.938166,0.932037,1,3,0,7.02613,0.342891 --9.18272,0.444151,0.932037,1,1,0,9.18621,0.563582 --7.27998,1,0.932037,1,1,0,8.53072,0.390916 --6.81588,0.976625,0.932037,1,3,0,7.39388,0.205939 --6.85158,0.981914,0.932037,1,3,0,6.98055,0.309541 --7.61781,0.765141,0.932037,1,1,0,7.61874,0.433021 --6.79258,0.997137,0.932037,1,3,0,7.61795,0.21398 --8.09444,0.722711,0.932037,1,3,0,8.35089,0.48065 --8.09444,0.731058,0.932037,1,1,0,9.00859,0.48065 --8.96537,0.715603,0.932037,1,1,0,9.37304,0.548986 --8.78035,1,0.932037,1,1,0,9.62889,0.535902 --7.21874,0.836764,0.932037,1,3,0,9.71962,0.143465 --6.75061,0.911636,0.932037,2,3,0,8.14176,0.241082 --7.65204,0.639147,0.932037,2,3,0,8.88575,0.436812 --6.95151,1,0.932037,1,1,0,7.42019,0.334765 --7.03245,0.89047,0.932037,2,3,0,7.4925,0.164448 --6.93323,1,0.932037,1,1,0,7.03482,0.179514 --6.93323,0.839701,0.932037,1,3,0,7.95662,0.179514 --6.8181,1,0.932037,1,1,0,6.90794,0.205258 --6.96817,0.964576,0.932037,1,1,0,6.96901,0.173744 --6.75177,1,0.932037,2,3,0,6.94088,0.260926 --6.75748,0.994596,0.932037,2,3,0,6.77947,0.267449 --6.75598,1,0.932037,2,3,0,6.75911,0.265983 --7.35596,0.838068,0.932037,1,3,0,7.60728,0.131434 --6.75779,0.906448,0.932037,2,3,0,8.09794,0.267737 --6.83162,0.952059,0.932037,2,3,0,6.9908,0.303273 --7.67816,0.806003,0.932037,1,3,0,7.67819,0.43966 --6.92603,0.932427,0.932037,1,3,0,8.01057,0.180783 --7.07054,0.950192,0.932037,2,3,0,7.4224,0.159552 --6.7484,0.994215,0.932037,1,3,0,7.0485,0.246555 --7.08258,0.918347,0.932037,1,3,0,7.15481,0.158082 --7.08258,0.737878,0.932037,1,3,0,9.18161,0.158082 --7.35202,0.949338,0.932037,1,1,0,7.3743,0.131751 --6.74881,0.983413,0.932037,1,3,0,7.33477,0.245074 --6.95539,0.949695,0.932037,1,3,0,6.9911,0.175786 --7.15608,0.958335,0.932037,1,1,0,7.16954,0.149783 --6.83348,0.99773,0.932037,1,3,0,7.08351,0.200841 --7.24483,0.931935,0.932037,1,3,0,7.25275,0.141003 --6.98535,1,0.932037,1,1,0,7.20252,0.171111 --6.79714,0.986131,0.932037,2,3,0,7.11242,0.212252 --6.75975,0.994219,0.932037,2,3,0,6.84154,0.231186 --7.85764,0.768175,0.932037,1,3,0,8.13554,0.0999182 --7.75607,1,0.932037,2,3,0,8.00291,0.1052 --7.45436,1,0.932037,1,1,0,7.77479,0.123968 --6.75812,0.956844,0.932037,1,3,0,7.53861,0.268042 --6.78653,0.996723,0.932037,2,3,0,6.78699,0.285711 --6.78653,0.689753,0.932037,1,3,0,7.7558,0.285711 --7.13767,0.941965,0.932037,2,3,0,7.15428,0.151762 --6.8166,0.824152,0.932037,2,3,0,8.71226,0.205717 --6.79612,1,0.932037,1,1,0,6.82009,0.21263 --7.16066,0.926371,0.932037,2,3,0,7.36744,0.149299 --6.7485,0.867631,0.932037,2,3,0,8.25218,0.253873 --6.7485,0.374064,0.932037,1,3,0,9.69677,0.253873 --6.906,0.899506,0.932037,2,3,0,7.30301,0.184481 --6.97495,0.960716,0.932037,1,3,0,7.26467,0.339768 --6.87784,0.957976,0.932037,1,3,0,7.22871,0.190181 --6.76764,1,0.932037,1,3,0,6.85023,0.225799 --7.06045,0.939987,0.932037,2,3,0,7.20313,0.160811 --7.56678,0.90837,0.932037,1,1,0,7.56807,0.116345 --8.21909,0.9114,0.932037,1,1,0,8.24106,0.0840531 --7.1694,0.972439,0.932037,1,3,0,8.05615,0.148387 --7.51659,0.939017,0.932037,1,1,0,7.53941,0.119642 --6.80441,1,0.932037,2,3,0,7.33714,0.293457 --6.84769,0.986098,0.932037,1,1,0,6.85924,0.308366 --6.75447,1,0.932037,1,3,0,6.82024,0.264369 --6.75447,0.941471,0.932037,1,3,0,6.92636,0.264369 --7.31897,0.848317,0.932037,1,3,0,7.54592,0.134469 --7.51256,0.936742,0.932037,2,3,0,8.23518,0.119914 --7.00844,1,0.932037,1,1,0,7.41354,0.16775 --6.81721,1,0.932037,2,3,0,6.95395,0.298298 --7.45194,0.852204,0.932037,1,3,0,7.45194,0.413549 --6.87259,1,0.932037,2,3,0,7.42285,0.191321 --6.75616,1,0.932037,1,3,0,6.8471,0.234287 --6.89502,0.961898,0.932037,1,3,0,6.94092,0.321477 --6.77836,1,0.932037,2,3,0,6.87334,0.220083 --6.79421,0.982898,0.932037,2,3,0,6.9004,0.28921 --7.26621,0.798873,0.932037,2,3,0,7.90837,0.139052 --6.86681,0.892468,0.932037,2,3,0,9.22078,0.192607 --6.79361,1,0.932037,1,1,0,6.85058,0.213582 --6.77748,1,0.932037,2,3,0,6.79435,0.220507 --6.77887,0.999632,0.932037,1,1,0,6.78659,0.21984 --6.78375,0.998717,0.932037,1,1,0,6.79108,0.217619 --6.74954,0.987641,0.932037,2,3,0,6.86737,0.256925 --7.83854,0.756676,0.932037,1,3,0,7.90005,0.456351 --7.50039,1,0.932037,1,1,0,7.94015,0.419443 --6.7491,1,0.932037,1,3,0,7.35194,0.244238 --6.7636,0.996702,0.932037,1,3,0,6.76405,0.228378 --6.78205,0.845782,0.932037,2,3,0,7.69714,0.218372 --6.75014,0.997559,0.932037,2,3,0,6.79806,0.241923 --8.34122,0.670679,0.932037,1,3,0,8.47733,0.501947 --7.99963,1,0.932037,1,1,0,8.62888,0.471941 --8.76385,0.745363,0.932037,1,1,0,9.14503,0.534703 --7.04418,1,0.932037,1,1,0,8.14217,0.353302 --7.43305,0.868749,0.932037,1,1,0,7.49441,0.4112 --7.43305,0.297658,0.932037,1,1,0,9.48457,0.4112 --6.83865,0.968461,0.932037,1,3,0,7.58424,0.199459 --7.53033,0.883514,0.932037,1,3,0,7.57348,0.118724 --6.96261,0.979104,0.932037,2,3,0,7.81614,0.174624 --7.0999,0.990364,0.932037,2,3,0,7.12317,0.156026 --8.07438,0.928426,0.932037,2,3,0,8.16995,0.478833 --7.08332,1,0.932037,1,1,0,7.75278,0.36031 --6.82918,1,0.932037,1,1,0,7.0036,0.302462 --7.53288,0.784396,0.932037,1,1,0,7.53294,0.423295 --7.05091,1,0.932037,2,3,0,7.39902,0.162026 --7.40251,0.977978,0.932037,2,3,0,7.41207,0.127799 --6.82898,1,0.932037,2,3,0,7.24836,0.302395 --6.79153,1,0.932037,1,1,0,6.8253,0.288021 --6.79153,0.459704,0.932037,1,3,0,9.85444,0.288021 --6.76756,1,0.932037,1,1,0,6.7869,0.275233 --6.97728,0.932763,0.932037,1,3,0,7.10469,0.172333 --6.95157,1,0.932037,1,1,0,7.01491,0.17641 --6.75905,0.960947,0.932037,2,3,0,7.21354,0.26886 --6.7615,0.936647,0.932037,2,3,0,7.06828,0.229862 --6.89331,0.972573,0.932037,1,3,0,6.89762,0.18697 --6.77722,0.906489,0.932037,2,3,0,7.52048,0.280983 --7.05175,0.910169,0.932037,1,3,0,7.23443,0.161917 --6.92365,1,0.932037,1,1,0,7.04143,0.18121 --6.92285,1,0.932037,2,3,0,6.9668,0.181353 --7.13379,0.955304,0.932037,1,1,0,7.14184,0.152188 --7.4804,0.884188,0.932037,1,3,0,8.21421,0.417034 --7.40948,1,0.932037,1,1,0,7.67663,0.408227 --6.7729,0.94969,0.932037,2,3,0,7.7319,0.222833 --6.88124,0.967448,0.932037,1,3,0,6.95576,0.317894 --8.24949,0.746027,0.932037,2,3,0,8.25756,0.0828895 --6.96905,1,0.932037,1,3,0,8.10239,0.173607 --7.27306,0.939109,0.932037,1,1,0,7.27863,0.138439 --7.00308,0.956818,0.932037,1,3,0,7.78354,0.345468 --6.75472,0.998187,0.932037,1,3,0,6.9917,0.235716 --6.75494,0.999941,0.932037,1,1,0,6.75678,0.235495 --6.87358,0.96725,0.932037,1,3,0,6.91321,0.315825 --6.88529,0.996099,0.932037,1,1,0,6.92345,0.318963 --8.16803,0.810902,0.932037,2,3,0,8.16856,0.487197 --8.16803,0.500501,0.932037,1,1,0,9.65653,0.487197 --6.84099,0.909134,0.932037,2,3,0,8.86386,0.198846 --6.7482,0.97014,0.932037,2,3,0,7.07304,0.252336 --6.88126,0.965042,0.932037,1,3,0,6.91312,0.189453 --6.91537,0.971395,0.932037,1,3,0,7.15288,0.326496 --6.74803,1,0.932037,1,3,0,6.88372,0.250563 --6.78862,0.991449,0.932037,2,3,0,6.8033,0.215557 --6.75166,1,0.932037,1,3,0,6.77932,0.239445 --7.64177,0.652534,0.932037,2,3,0,8.81793,0.435682 --7.39307,1,0.932037,1,1,0,7.74629,0.406126 --7.39307,0.385651,0.932037,1,1,0,9.0256,0.406126 --6.79731,0.988358,0.932037,1,3,0,7.44468,0.212186 --7.26742,0.912562,0.932037,1,3,0,7.29563,0.138943 --8.03606,0.881597,0.932037,1,1,0,8.03636,0.0915803 --7.18684,0.969203,0.932037,1,3,0,7.89297,0.146604 --7.82185,0.895632,0.932037,1,1,0,7.82342,0.10173 --6.9258,0.999365,0.932037,1,3,0,7.68077,0.180825 --6.84345,1,0.932037,1,1,0,6.91592,0.198213 --8.02819,0.799375,0.932037,1,3,0,8.18865,0.0919253 --9.74173,0.805241,0.932037,1,3,0,9.76127,0.0445821 --8.33143,1,0.932037,1,1,0,9.60755,0.0798627 --7.18582,0.972127,0.932037,1,3,0,8.16309,0.146708 --6.92783,1,0.932037,1,1,0,7.13538,0.180463 --7.11005,0.961217,0.932037,1,1,0,7.12168,0.154851 --6.79373,1,0.932037,1,3,0,7.04271,0.213532 --7.11956,0.955726,0.932037,2,3,0,7.20271,0.366472 --7.48398,0.958399,0.932037,2,3,0,7.57261,0.417468 --7.05344,1,0.932037,2,3,0,7.38948,0.354998 --6.89526,1,0.932037,1,1,0,7.02854,0.321538 --6.75297,0.996542,0.932037,2,3,0,6.92061,0.237701 --6.83977,0.975809,0.932037,1,3,0,6.86918,0.305909 --6.8251,1,0.932037,2,3,0,6.85672,0.301077 --6.76932,1,0.932037,1,1,0,6.8089,0.276371 --7.2411,0.887441,0.932037,1,3,0,7.24713,0.385345 --6.77198,0.978158,0.932037,2,3,0,7.39681,0.223328 --6.91344,0.959133,0.932037,1,3,0,6.99309,0.326033 --7.04881,0.85015,0.932037,2,3,0,7.62026,0.162296 --7.60525,0.863371,0.932037,1,3,0,8.23873,0.431613 --6.78473,0.999819,0.932037,1,3,0,7.58373,0.217191 --6.78473,0.898858,0.932037,1,3,0,7.22409,0.217191 --7.78377,0.579188,0.932037,2,3,0,9.7066,0.103716 --7.70743,1,0.932037,1,1,0,7.93357,0.10789 --7.96247,0.96471,0.932037,1,1,0,8.07171,0.0948869 --7.12674,0.974601,0.932037,1,3,0,7.81844,0.152967 --6.75681,1,0.932037,1,3,0,7.07784,0.233681 --6.74929,0.899259,0.932037,2,3,0,7.32696,0.243745 --6.74929,0.646445,0.932037,1,3,0,8.08205,0.243745 --7.15628,0.857788,0.932037,2,3,0,7.57467,0.372439 --7.75903,0.923317,0.932037,2,3,0,7.84476,0.448237 --6.85106,0.987384,0.932037,2,3,0,7.98227,0.19631 --8.0294,0.746944,0.932037,1,3,0,8.39902,0.474711 --6.8022,0.859301,0.932037,2,3,0,8.84948,0.210434 --6.77032,1,0.932037,1,1,0,6.79542,0.22424 --7.64151,0.740592,0.932037,2,3,0,8.46249,0.435654 --8.37811,0.917274,0.932037,2,3,0,8.62816,0.504979 --7.49482,1,0.932037,1,1,0,8.22793,0.418775 --9.18827,0.523755,0.932037,1,1,0,9.33046,0.563944 --7.76093,1,0.932037,1,1,0,8.88732,0.448435 --6.97798,1,0.932037,1,1,0,7.50122,0.340396 --7.35575,0.873861,0.932037,1,1,0,7.39654,0.401255 --7.35575,0.110444,0.932037,1,1,0,11.0745,0.401255 --7.35575,0.0800688,0.932037,1,3,0,15.4327,0.401255 --7.48223,0.672997,0.932037,1,3,0,8.8362,0.121997 --6.78001,0.901552,0.932037,2,3,0,8.42084,0.28247 --7.27496,0.91456,0.932037,2,3,0,7.304,0.13827 --7.27496,0.889573,0.932037,1,1,0,7.87313,0.13827 --6.74818,0.981145,0.932037,1,3,0,7.27579,0.252199 --6.74818,0.540736,0.932037,1,3,0,8.56126,0.252199 --6.84577,0.975084,0.932037,1,3,0,6.8552,0.307778 --6.84577,0.460221,0.932037,1,3,0,8.80117,0.307778 --7.22623,0.87774,0.932037,1,1,0,7.23183,0.383162 --6.86085,0.957571,0.932037,1,3,0,7.44679,0.193973 --6.84216,1,0.932037,1,1,0,6.8764,0.198544 --6.82726,0.902432,0.932037,2,3,0,7.67881,0.202571 --7.01244,0.957121,0.932037,1,1,0,7.01282,0.167187 --6.753,0.947388,0.932037,2,3,0,7.40574,0.262602 --6.75612,0.999688,0.932037,2,3,0,6.75709,0.266127 --7.10487,0.901325,0.932037,1,3,0,7.25063,0.155448 --6.75288,0.934052,0.932037,2,3,0,7.61355,0.262456 --6.75911,0.998131,0.932037,1,1,0,6.75973,0.268918 --6.97448,0.935151,0.932037,1,3,0,7.07933,0.172763 --8.33687,0.727783,0.932037,1,3,0,8.95629,0.501587 --7.19311,1,0.932037,1,1,0,7.97929,0.378182 --6.86239,0.957299,0.932037,1,3,0,7.41859,0.193617 --8.81489,0.675307,0.932037,1,3,0,9.25628,0.0647295 --9.08174,0.976561,0.932037,1,1,0,9.30033,0.0579512 --8.72465,1,0.932037,2,3,0,9.23184,0.067248 --9.02058,0.973248,0.932037,1,1,0,9.2222,0.059423 --6.75096,0.87105,0.932037,1,3,0,9.3739,0.240494 --6.77061,0.8673,0.932037,2,3,0,7.49474,0.224077 --7.18049,0.687335,0.932037,2,3,0,8.77168,0.147248 --6.83677,0.997719,0.932037,1,3,0,7.10412,0.199956 --7.0242,0.942244,0.932037,1,3,0,7.2293,0.349561 --6.75027,1,0.932037,1,3,0,6.95554,0.258452 --7.19098,0.922423,0.932037,2,3,0,7.25741,0.146188 --6.75095,0.998409,0.932037,2,3,0,7.18042,0.240521 --6.87936,0.965588,0.932037,1,3,0,6.90968,0.31739 --6.78928,1,0.932037,2,3,0,6.85581,0.215288 --7.24713,0.912602,0.932037,1,3,0,7.27833,0.14079 --7.64349,0.933948,0.932037,1,1,0,7.6686,0.111601 --7.89818,0.963732,0.932037,1,1,0,7.99945,0.0979248 --9.96894,0.866816,0.932037,2,3,0,10.0037,0.610637 --8.27408,1,0.932037,1,1,0,9.73188,0.496333 --8.97796,0.763178,0.932037,1,1,0,9.46742,0.549854 --7.07994,1,0.932037,2,3,0,9.38837,0.158401 --6.75736,0.879611,0.932037,2,3,0,8.01228,0.267336 --6.7519,1,0.932037,1,1,0,6.75617,0.261115 --6.78524,0.992274,0.932037,1,3,0,6.78539,0.285089 --7.86462,0.758008,0.932037,1,3,0,7.87664,0.458948 --7.97349,0.959152,0.932037,1,1,0,8.36464,0.469482 --7.11236,1,0.932037,2,3,0,7.71314,0.365271 --7.71805,0.799983,0.932037,1,1,0,7.78908,0.443934 --9.81575,0.716945,0.932037,2,3,0,10.0088,0.602086 --7.32169,1,0.932037,1,1,0,8.93058,0.396686 --6.74807,0.833534,0.932037,2,3,0,8.05557,0.251241 --6.74803,1,0.932037,2,3,0,6.74806,0.250572 --6.75538,0.991246,0.932037,2,3,0,6.79373,0.235049 --6.93792,0.962649,0.932037,2,3,0,7.01983,0.331741 --7.2862,0.88434,0.932037,1,1,0,7.31645,0.391789 --6.99084,1,0.932037,2,3,0,7.19845,0.170294 --7.65042,0.905856,0.932037,2,3,0,8.20379,0.436635 --7.41337,1,0.932037,1,1,0,7.7679,0.40872 --8.85702,0.576942,0.932037,1,1,0,8.98493,0.541403 --6.78589,1,0.932037,1,3,0,8.17164,0.285406 --6.90223,0.954007,0.932037,1,3,0,7.03131,0.185207 --8.14191,0.811993,0.932037,1,3,0,8.27248,0.0871143 --8.10592,1,0.932037,1,1,0,8.36491,0.0885962 --8.2689,0.993522,0.932037,2,3,0,8.4528,0.0821583 --9.32894,0.899169,0.932037,1,1,0,9.34484,0.0524422 --8.02809,1,0.932037,1,1,0,9.18688,0.0919298 --6.99166,0.993898,0.932037,1,3,0,7.87392,0.170173 --8.06441,0.911089,0.932037,2,3,0,8.31617,0.477926 --8.7506,0.922675,0.932037,2,3,0,9.16274,0.533736 --7.8978,1,0.932037,1,1,0,8.75888,0.462211 --6.94446,1,0.932037,1,1,0,7.56554,0.333209 --8.54285,0.771096,0.932037,2,3,0,8.54633,0.518094 --6.78594,1,0.932037,1,3,0,7.9627,0.285428 --6.78594,0.906519,0.932037,1,3,0,7.16707,0.285428 --6.92112,0.942672,0.932037,2,3,0,7.08892,0.181666 --6.87261,0.875781,0.932037,2,3,0,8.17854,0.191316 --7.08975,0.952205,0.932037,1,1,0,7.09201,0.157223 --7.02149,1,0.932037,2,3,0,7.12326,0.165933 --7.04584,0.998287,0.932037,2,3,0,7.10444,0.162681 --7.04584,0.672299,0.932037,1,3,0,9.55749,0.162681 --7.77921,0.832639,0.932037,1,3,0,8.43718,0.450325 --6.93132,0.932106,0.932037,1,3,0,8.11383,0.179848 --7.37155,0.932331,0.932037,1,3,0,7.37171,0.130194 --6.74802,0.977866,0.932037,1,3,0,7.37247,0.250051 --6.90501,0.947815,0.932037,2,3,0,7.04469,0.32398 --6.90501,0.515929,0.932037,1,1,0,8.06608,0.32398 --7.26517,0.747153,0.932037,2,3,0,8.10285,0.139146 --6.77759,0.959776,0.932037,1,3,0,7.38193,0.281187 --6.75799,1,0.932037,1,1,0,6.77244,0.267921 --6.79277,0.99575,0.932037,2,3,0,6.79381,0.213903 --6.76109,1,0.932037,1,1,0,6.78457,0.230166 --6.7596,0.969448,0.932037,2,3,0,6.95304,0.231305 --6.79156,0.988014,0.932037,2,3,0,6.84381,0.214376 --6.78312,1,0.932037,1,1,0,6.79707,0.217895 --6.77762,0.949288,0.932037,2,3,0,7.08484,0.2812 --7.09494,0.924565,0.932037,1,3,0,7.09566,0.362318 --6.95426,1,0.932037,2,3,0,7.09613,0.335364 --7.28442,0.889685,0.932037,1,1,0,7.32064,0.391541 --6.79484,0.997398,0.932037,2,3,0,7.36362,0.213111 --6.81648,0.99449,0.932037,1,1,0,6.8247,0.205753 --6.84974,0.991789,0.932037,1,1,0,6.86103,0.196633 --6.74879,0.865097,0.932037,2,3,0,7.74614,0.245131 --6.88211,0.967449,0.932037,1,3,0,6.902,0.189273 --6.74845,0.957844,0.932037,2,3,0,7.24214,0.246361 --7.20685,0.887254,0.932037,1,3,0,7.25766,0.380267 --7.20685,0.564767,0.932037,1,3,0,8.81898,0.380267 --7.20685,0.320306,0.932037,1,3,0,12.13,0.380267 --6.97752,0.935114,0.932037,2,3,0,7.66742,0.172296 --6.87049,1,0.932037,1,1,0,6.96427,0.191784 --6.74837,0.966424,0.932037,2,3,0,7.14605,0.253312 --6.98253,0.907073,0.932037,2,3,0,7.2529,0.341334 --7.79349,0.745081,0.932037,1,1,0,7.81771,0.451791 --6.77388,1,0.932037,1,3,0,7.46942,0.279119 --6.90086,0.954561,0.932037,1,3,0,7.00827,0.185473 --6.79914,1,0.932037,2,3,0,6.8716,0.291311 --8.11178,0.713466,0.932037,1,3,0,8.12201,0.482208 --8.11178,0.190125,0.932037,1,1,0,11.1441,0.482208 --7.24841,1,0.932037,1,1,0,7.88964,0.386408 --7.23081,1,0.932037,1,1,0,7.40517,0.383837 --6.80377,1,0.932037,2,3,0,7.08741,0.293202 --6.85418,0.994603,0.932037,2,3,0,6.86482,0.310312 --6.74965,0.98222,0.932037,2,3,0,6.95136,0.257173 --7.03844,0.928412,0.932037,1,3,0,7.0566,0.352239 --7.22621,0.808036,0.932037,1,3,0,7.93488,0.14275 --6.77583,0.927823,0.932037,2,3,0,7.69178,0.280224 --6.86535,0.971878,0.932037,1,1,0,6.86662,0.313541 --6.77928,0.990027,0.932037,1,3,0,6.92787,0.219648 --6.78451,0.998625,0.932037,1,1,0,6.79187,0.217287 --6.78451,0.773207,0.932037,1,3,0,7.90069,0.217287 --6.75189,0.967957,0.932037,2,3,0,6.99818,0.23911 --6.88731,0.96889,0.932037,1,3,0,6.89993,0.18819 --6.83332,1,0.932037,1,1,0,6.8859,0.200884 --6.96445,0.969353,0.932037,1,1,0,6.9678,0.174331 --6.74853,0.993691,0.932037,1,3,0,6.95955,0.253983 --6.79227,0.98474,0.932037,2,3,0,6.83336,0.288352 --6.78141,0.965461,0.932037,2,3,0,6.96936,0.218663 --6.75837,0.995995,0.932037,1,3,0,6.80286,0.268259 --6.80841,0.982527,0.932037,1,3,0,6.84862,0.208324 --6.92145,0.989324,0.932037,2,3,0,6.92312,0.327942 --6.94393,0.992369,0.932037,1,1,0,6.99666,0.33309 --8.0719,0.66438,0.932037,1,1,0,8.0808,0.478608 --8.30789,0.913191,0.932037,1,1,0,8.7652,0.499176 --6.88395,1,0.932037,2,3,0,7.79691,0.318612 --6.88395,0.525809,0.932037,1,3,0,8.46396,0.318612 --7.66074,0.862122,0.932037,2,3,0,7.66587,0.110579 --7.48718,1,0.932037,1,1,0,7.73391,0.121652 --7.24771,1,0.932037,1,1,0,7.49536,0.140737 --6.75294,0.907734,0.932037,2,3,0,8.2612,0.23774 --6.75294,0.882023,0.932037,1,3,0,7.23222,0.23774 --6.75294,0.648763,0.932037,1,3,0,8.1161,0.23774 --6.75671,0.998954,0.932037,1,1,0,6.75747,0.233769 --7.51733,0.821118,0.932037,1,3,0,7.63136,0.421461 --7.23718,1,0.932037,2,3,0,7.55107,0.384773 --7.23718,0.584164,0.932037,1,1,0,8.1976,0.384773 --6.75151,1,0.932037,1,3,0,7.10952,0.260533 --6.76119,0.993068,0.932037,2,3,0,6.78713,0.270643 --6.79508,0.984853,0.932037,2,3,0,6.84415,0.213018 --8.30022,0.789495,0.932037,2,3,0,8.51335,0.0809972 --7.08882,0.985416,0.932037,1,3,0,8.13433,0.157333 --6.74804,0.991804,0.932037,1,3,0,7.07332,0.249263 --6.76797,0.994746,0.932037,1,3,0,6.77114,0.275501 --6.87611,0.984786,0.932037,2,3,0,6.88112,0.190553 --7.10363,0.930507,0.932037,1,3,0,7.38443,0.3638 --7.1931,0.968366,0.932037,1,1,0,7.30124,0.378181 --7.02744,1,0.932037,1,1,0,7.20716,0.350175 --7.47087,0.716122,0.932037,1,3,0,8.36114,0.122794 --7.77445,0.953734,0.932037,1,1,0,7.84235,0.104212 --7.10232,0.976364,0.932037,1,3,0,7.65215,0.155744 --6.89247,0.977052,0.932037,2,3,0,7.36801,0.187138 --6.88406,1,0.932037,2,3,0,6.92287,0.188864 --7.00739,0.972361,0.932037,1,1,0,7.01912,0.167899 --7.4581,0.959878,0.932037,2,3,0,7.46539,0.414309 --7.4581,0.358894,0.932037,1,1,0,9.21803,0.414309 --8.39486,0.699937,0.932037,1,1,0,8.5651,0.506344 --6.98009,0.931934,0.932037,1,3,0,8.77344,0.171904 --7.75622,0.895607,0.932037,2,3,0,8.30908,0.447944 --7.45294,1,0.932037,1,1,0,7.85686,0.413673 --7.81191,0.87317,0.932037,1,1,0,8.02199,0.453667 --7.07889,1,0.932037,2,3,0,7.65163,0.158528 --8.02018,0.93056,0.932037,2,3,0,8.11738,0.473856 --7.32245,1,0.932037,1,1,0,7.89443,0.396789 --7.11924,1,0.932037,2,3,0,7.35057,0.366419 --7.13426,0.994637,0.932037,1,1,0,7.25741,0.368892 --6.81324,1,0.932037,1,1,0,7.02809,0.296845 --7.90962,0.554652,0.932037,2,3,0,9.26763,0.0973734 --10.1284,0.790216,0.932037,1,3,0,10.2416,0.0384446 --8.90062,1,0.932037,1,1,0,10.0537,0.0624477 --6.80723,1,0.932037,2,3,0,8.62687,0.208714 --6.86729,0.973895,0.932037,2,3,0,7.02735,0.192499 --6.79392,1,0.932037,1,1,0,6.85106,0.213461 --7.40012,0.888235,0.932037,2,3,0,7.70807,0.407031 --6.93792,1,0.932037,2,3,0,7.29993,0.178704 --7.00949,0.984312,0.932037,1,1,0,7.03975,0.167602 --7.13808,0.973678,0.932037,1,1,0,7.17115,0.151717 --6.78692,0.965669,0.932037,1,3,0,7.25761,0.285893 --6.87345,0.885758,0.932037,2,3,0,7.29989,0.315791 --7.7385,0.869841,0.932037,2,3,0,7.74068,0.446092 --7.7385,0.102215,0.932037,1,1,0,11.7215,0.446092 --8.03266,0.893586,0.932037,1,1,0,8.35655,0.475011 --8.22194,0.92979,0.932037,1,1,0,8.66902,0.491883 --7.3561,1,0.932037,2,3,0,7.97443,0.131423 --6.78127,1,0.932037,1,3,0,7.27452,0.218728 --6.82275,0.984055,0.932037,1,3,0,6.89491,0.300263 --7.6571,0.742126,0.932037,1,3,0,8.29259,0.110793 --8.03026,0.829375,0.932037,1,3,0,9.64909,0.47479 --7.37223,1,0.932037,1,1,0,7.93907,0.403423 --6.79515,0.988926,0.932037,1,3,0,7.42116,0.212995 --6.82487,0.992469,0.932037,1,1,0,6.83189,0.203253 --7.12496,0.969767,0.932037,2,3,0,7.16248,0.367365 --8.26834,0.652897,0.932037,1,1,0,8.32004,0.495847 --8.67193,0.856184,0.932037,1,1,0,9.18766,0.527922 --6.90442,1,0.932037,1,1,0,8.03082,0.323833 --7.94108,0.68975,0.932037,1,1,0,7.94519,0.466396 --7.78516,0.528351,0.932037,1,3,0,10.1916,0.103643 --7.48177,1,0.932037,1,1,0,7.8074,0.122029 --6.80338,0.90422,0.932037,2,3,0,8.07863,0.293044 --6.89878,0.96934,0.932037,1,1,0,6.90583,0.322427 --7.30937,0.866085,0.932037,1,1,0,7.32592,0.395003 --6.85274,1,0.932037,1,1,0,7.15684,0.309887 --6.85274,0.743543,0.932037,1,3,0,7.59752,0.309887 --6.85274,0.563681,0.932037,1,3,0,9.12334,0.309887 --7.14252,0.905701,0.932037,1,1,0,7.15244,0.370233 --6.88606,1,0.932037,1,1,0,7.07414,0.319166 --6.81352,1,0.932037,1,1,0,6.87385,0.296952 --7.22426,0.603012,0.932037,2,3,0,8.88007,0.382871 --6.75466,1,0.932037,1,3,0,7.17215,0.235789 --6.77207,0.962029,0.932037,2,3,0,6.97984,0.223275 --7.20122,0.9126,0.932037,1,3,0,7.2415,0.145171 --7.97419,0.889846,0.932037,1,3,0,7.97427,0.0943483 --7.1089,0.976552,0.932037,1,3,0,7.82637,0.154983 --7.1089,0.884111,0.932037,1,3,0,7.82698,0.154983 --6.98201,0.835391,0.932037,2,3,0,9.32581,0.171614 --7.4823,0.923908,0.932037,1,3,0,7.48233,0.121992 --8.13382,0.907974,0.932037,1,1,0,8.15008,0.0874439 --7.0191,0.992287,0.932037,1,3,0,7.97523,0.166261 --7.38884,0.929413,0.932037,1,1,0,7.39423,0.128846 --7.05345,0.945247,0.932037,1,3,0,8.00914,0.354999 --7.88022,0.88235,0.932037,2,3,0,7.92302,0.460488 --7.47896,1,0.932037,1,1,0,7.94438,0.41686 --8.26848,0.902685,0.932037,2,3,0,8.45552,0.495858 --8.36145,0.964836,0.932037,1,1,0,8.90958,0.503614 --6.80918,1,0.932037,1,3,0,7.82987,0.295317 --7.23868,0.600861,0.932037,2,3,0,8.89375,0.384993 --6.89006,1,0.932037,1,1,0,7.13419,0.320205 --6.8044,1,0.932037,2,3,0,6.86543,0.209671 --6.86009,0.995405,0.932037,2,3,0,6.86567,0.194151 --6.86009,0.799308,0.932037,1,3,0,7.97123,0.194151 --8.99856,0.728419,0.932037,2,3,0,9.23129,0.0599642 --9.09468,0.991837,0.932037,1,1,0,9.38997,0.0576457 --8.73756,1,0.932037,1,1,0,9.24597,0.0668798 --7.55986,0.937761,0.932037,1,3,0,8.57866,0.11679 --7.99912,0.937675,0.932037,1,1,0,8.05117,0.0932182 --7.76055,1,0.932037,1,1,0,8.08641,0.104958 --8.28732,0.977606,0.932037,2,3,0,8.34339,0.0814724 --6.82679,0.992827,0.932037,1,3,0,8.22618,0.202702 --6.87274,0.996281,0.932037,2,3,0,6.88424,0.191288 --6.78865,0.91873,0.932037,2,3,0,7.41091,0.286706 --6.76058,1,0.932037,2,3,0,6.78115,0.230549 --6.76058,0.44465,0.932037,2,3,0,10.1097,0.230549 --8.19963,0.701948,0.932037,1,3,0,8.62984,0.0848102 --6.87827,1,0.932037,1,3,0,8.08649,0.190089 --6.90011,0.99488,0.932037,1,1,0,6.92793,0.185622 --7.58846,0.835161,0.932037,1,3,0,7.98997,0.429714 --6.84168,1,0.932037,2,3,0,7.32922,0.306509 --6.79898,0.907476,0.932037,2,3,0,7.23342,0.291247 --7.18968,0.940405,0.932037,2,3,0,7.1897,0.377657 --7.30081,0.811278,0.932037,2,3,0,8.27114,0.136012 --7.44395,0.975262,0.932037,1,1,0,7.52376,0.124721 --7.10913,1,0.932037,1,1,0,7.3984,0.154957 --6.74902,0.994264,0.932037,1,3,0,7.08219,0.24445 --7.95169,0.736282,0.932037,1,3,0,8.05657,0.467411 -# -# Elapsed Time: 0.005 seconds (Warm-up) -# 0.012 seconds (Sampling) -# 0.017 seconds (Total) -# diff --git a/src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv b/src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv deleted file mode 100644 index c210031c92..0000000000 --- a/src/test/unit/mcmc/test_csv_files/eight_schools_5iters_1.csv +++ /dev/null @@ -1,62 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 35 -# stan_version_patch = 0 -# model = eight_schools_model -# start_datetime = 2024-08-02 00:41:06 UTC -# method = sample (Default) -# sample -# num_samples = 5 -# 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 = true -# 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/github/stan-dev/cmdstan/examples/eight_schools/eight_schools.data.json -# init = 2 (Default) -# random -# seed = 1272150304 -# output -# file = /Users/mitzi/github/stan-dev/cmdstan/examples/eight_schools/test_csv_files/eight_schools-202408012041-1-5c2994.csv -# diagnostic_file = (Default) -# refresh = 100 (Default) -# sig_figs = -1 (Default) -# profile_file = /Users/mitzi/github/stan-dev/cmdstan/examples/eight_schools/test_csv_files/eight_schools-profile-202408012041-1-71b713.csv -# save_cmdstan_config = true -# num_threads = 1 (Default) -# stanc_version = stanc3 v2.35.0-25-gbb9ce42 -# stancflags = -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,mu,theta.1,theta.2,theta.3,theta.4,theta.5,theta.6,theta.7,theta.8,tau -# Adaptation terminated -# Step size = 0.255122 -# Diagonal elements of inverse mass matrix: -# 29.0476, 61.52, 39.9696, 71.637, 55.2727, 46.9849, 47.056, 46.955, 63.8751, 0.452837 --20.7877,0.992501,0.255122,4,31,0,26.7532,15.418,22.6964,2.33549,-0.47199,10.617,0.327037,10.1927,16.3596,19.9623,9.72387 --20.3617,0.786426,0.255122,3,15,0,23.3769,15.4589,17.628,4.63432,10.408,11.706,2.19791,13.2514,13.176,24.6951,11.005 --20.0581,0.970637,0.255122,3,15,0,23.1533,10.6479,9.46195,13.6135,12.0037,13.4518,-0.981723,14.7449,10.6646,23.8779,6.28949 --27.7784,0.685455,0.255122,4,31,0,32.1245,18.1249,29.0012,16.4194,21.7475,18.8411,-5.54255,-0.590031,2.02352,1.58803,26.5075 --20.4323,0.976331,0.255122,4,15,0,31.0216,6.67189,0.393845,2.87533,-5.4399,-0.80737,7.71426,5.1214,17.8469,7.69329,9.05484 -# -# Elapsed Time: 0.03 seconds (Warm-up) -# 0 seconds (Sampling) -# 0.03 seconds (Total) -# diff --git a/src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv b/src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv deleted file mode 100644 index 5ac7176c6f..0000000000 --- a/src/test/unit/mcmc/test_csv_files/eight_schools_5iters_2.csv +++ /dev/null @@ -1,62 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 35 -# stan_version_patch = 0 -# model = eight_schools_model -# start_datetime = 2024-08-02 00:41:07 UTC -# method = sample (Default) -# sample -# num_samples = 5 -# 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 = true -# 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/github/stan-dev/cmdstan/examples/eight_schools/eight_schools.data.json -# init = 2 (Default) -# random -# seed = 1272150304 -# output -# file = /Users/mitzi/github/stan-dev/cmdstan/examples/eight_schools/test_csv_files/eight_schools-202408012041-2-5c2994.csv -# diagnostic_file = (Default) -# refresh = 100 (Default) -# sig_figs = -1 (Default) -# profile_file = /Users/mitzi/github/stan-dev/cmdstan/examples/eight_schools/test_csv_files/eight_schools-profile-202408012041-2-71b713.csv -# save_cmdstan_config = true -# num_threads = 1 (Default) -# stanc_version = stanc3 v2.35.0-25-gbb9ce42 -# stancflags = -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,mu,theta.1,theta.2,theta.3,theta.4,theta.5,theta.6,theta.7,theta.8,tau -# Adaptation terminated -# Step size = 0.212532 -# Diagonal elements of inverse mass matrix: -# 36.7915, 71.7469, 39.8211, 74.4468, 50.0889, 46.2225, 50.7702, 47.6696, 63.508, 0.719632 --25.6347,0.977811,0.212532,4,15,0,30.7373,3.48962,18.9434,-8.37292,-16.7421,0.568964,9.96071,17.3906,8.33767,4.11305,13.9073 --26.2724,0.957923,0.212532,5,31,0,33.4452,1.10426,19.5777,7.16892,-4.27551,1.20374,1.75746,15.5193,-6.81069,-11.3926,16.3893 --25.8267,0.989673,0.212532,4,15,0,28.8245,1.07736,17.5014,13.9165,0.358151,2.27947,-3.36194,14.716,-5.54053,-11.8808,8.61073 --29.6451,0.640928,0.212532,5,31,0,35.3758,8.49943,13.8662,0.409198,7.39161,8.57074,6.92426,24.1421,4.40711,-10.1655,31.0153 --21.8872,0.886503,0.212532,4,15,0,32.6965,7.28245,18.5208,12.251,6.33112,7.20102,3.02724,23.5692,10.1139,4.93785,5.93738 -# -# Elapsed Time: 0.03 seconds (Warm-up) -# 0 seconds (Sampling) -# 0.03 seconds (Total) -# diff --git a/src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv b/src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv deleted file mode 100644 index 1e93414470..0000000000 --- a/src/test/unit/mcmc/test_csv_files/eight_schools_empty.csv +++ /dev/null @@ -1,57 +0,0 @@ -# stan_version_major = 2 -# stan_version_minor = 35 -# stan_version_patch = 0 -# model = eight_schools_model -# start_datetime = 2024-07-20 18:52:24 UTC -# method = sample (Default) -# sample -# num_samples = 0 -# 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 = examples/eight_schools/eight_schools.data.json -# init = 2 (Default) -# random -# seed = 3634790287 (Default) -# output -# file = eight_schools_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-25-gbb9ce42 -# stancflags = -lp__,accept_stat__,stepsize__,treedepth__,n_leapfrog__,divergent__,energy__,mu,theta.1,theta.2,theta.3,theta.4,theta.5,theta.6,theta.7,theta.8,tau -# Adaptation terminated -# Step size = 0.21285 -# Diagonal elements of inverse mass matrix: -# 22.9615, 70.1007, 38.6355, 46.2857, 44.7487, 36.401, 46.9537, 45.2008, 61.2207, 0.755335 -# -# Elapsed Time: 0.046 seconds (Warm-up) -# 0.023 seconds (Sampling) -# 0.069 seconds (Total) -# From aaa732516618ae24ec52668adfb931b5946a9135 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Sat, 19 Oct 2024 22:15:04 -0400 Subject: [PATCH 26/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/mcmc/chainset_test.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 24126d392c..0c59ec1a8e 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -69,11 +69,11 @@ class McmcChains : public testing::Test { std::stringstream out; std::ifstream bernoulli_500_stream, bernoulli_default_stream, - bernoulli_thin_stream, bernoulli_warmup_stream, - eight_schools_1_stream, eight_schools_2_stream; + bernoulli_thin_stream, bernoulli_warmup_stream, eight_schools_1_stream, + eight_schools_2_stream; stan::io::stan_csv bernoulli_500, bernoulli_default, bernoulli_thin, - bernoulli_warmup, eight_schools_1, eight_schools_2; + bernoulli_warmup, eight_schools_1, eight_schools_2; }; TEST_F(McmcChains, constructor) { From 5a90da7f9625ffc065212811ab1af52c3691d23d Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Sun, 20 Oct 2024 11:28:20 -0400 Subject: [PATCH 27/40] minor edit --- src/test/unit/analyze/mcmc/check_chains_test.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/test/unit/analyze/mcmc/check_chains_test.cpp b/src/test/unit/analyze/mcmc/check_chains_test.cpp index 4f3f9c579b..7d4c9107b1 100644 --- a/src/test/unit/analyze/mcmc/check_chains_test.cpp +++ b/src/test/unit/analyze/mcmc/check_chains_test.cpp @@ -41,7 +41,7 @@ TEST(CheckChains, good_and_bad) { EXPECT_TRUE(stan::analyze::is_finite_and_varies(chains)); } - // above test shows that column 7 is - make it non-finite + // above test shows that column 7 is OK - make it non-finite chain_1.col(0) = eight_schools_1.samples.col(7); chain_1(0, 0) = std::numeric_limits::infinity(); EXPECT_FALSE(stan::analyze::is_finite_and_varies(chain_1)); From c38b15f9f1c506c6d3fa7afc97fa4db77d29dc7a Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Mon, 21 Oct 2024 16:23:49 -0400 Subject: [PATCH 28/40] changes per code review --- .../mcmc/compute_effective_sample_size.hpp | 28 +++++++++++++ .../compute_potential_scale_reduction.hpp | 28 +++++++++++++ src/stan/analyze/mcmc/ess.hpp | 7 +++- src/stan/mcmc/chainset.hpp | 16 ------- .../mcmc/split_rank_normalized_ess_test.cpp | 1 + .../mcmc/split_rank_normalized_rhat_test.cpp | 9 ++-- src/test/unit/mcmc/chainset_test.cpp | 42 +++++++++---------- 7 files changed, 88 insertions(+), 43 deletions(-) diff --git a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp index 39eb636c71..bdfbbfd142 100644 --- a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp +++ b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp @@ -12,6 +12,8 @@ namespace stan { namespace analyze { /** + * \deprecated use split_rank_normalized_ess instead + * * Computes the effective sample size (ESS) for the specified * parameter across all kept samples. The value returned is the * minimum of ESS and the number_total_draws * @@ -29,6 +31,11 @@ namespace analyze { * @param sizes stores sizes of chains * @return effective sample size for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_effective_sample_size(std::vector draws, std::vector sizes) { int num_chains = sizes.size(); @@ -138,6 +145,8 @@ inline double compute_effective_sample_size(std::vector draws, } /** + * \deprecated use split_rank_normalized_ess instead + * * Computes the effective sample size (ESS) for the specified * parameter across all kept samples. The value returned is the * minimum of ESS and the number_total_draws * @@ -156,6 +165,11 @@ inline double compute_effective_sample_size(std::vector draws, * @param size size of chains * @return effective sample size for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_effective_sample_size(std::vector draws, size_t size) { int num_chains = draws.size(); @@ -164,6 +178,8 @@ inline double compute_effective_sample_size(std::vector draws, } /** + * \deprecated use split_rank_normalized_ess instead + * * Computes the split effective sample size (ESS) for the specified * parameter across all kept samples. The value returned is the * minimum of ESS and the number_total_draws * @@ -182,6 +198,11 @@ inline double compute_effective_sample_size(std::vector draws, * @param sizes stores sizes of chains * @return effective sample size for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_split_effective_sample_size( std::vector draws, std::vector sizes) { int num_chains = sizes.size(); @@ -199,6 +220,8 @@ inline double compute_split_effective_sample_size( } /** + * \deprecated use split_rank_normalized_ess instead + * * Computes the split effective sample size (ESS) for the specified * parameter across all kept samples. The value returned is the * minimum of ESS and the number_total_draws * @@ -218,6 +241,11 @@ inline double compute_split_effective_sample_size( * @param size size of chains * @return effective sample size for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_split_effective_sample_size( std::vector draws, size_t size) { int num_chains = draws.size(); diff --git a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp index e40253ebb4..ff2363e643 100644 --- a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp +++ b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp @@ -18,6 +18,8 @@ namespace stan { namespace analyze { /** + * DEPRECATED - re-implemented as function `rhat`. + * * Computes the potential scale reduction (Rhat) for the specified * parameter across all kept samples. * @@ -32,6 +34,11 @@ namespace analyze { * @param sizes stores sizes of chains * @return potential scale reduction for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_potential_scale_reduction( std::vector draws, std::vector sizes) { int num_chains = sizes.size(); @@ -102,6 +109,8 @@ inline double compute_potential_scale_reduction( } /** + * \deprecated use split_rank_normalized_rhat instead + * * Computes the potential scale reduction (Rhat) for the specified * parameter across all kept samples. * @@ -117,6 +126,11 @@ inline double compute_potential_scale_reduction( * @param size stores sizes of chains * @return potential scale reduction for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_potential_scale_reduction( std::vector draws, size_t size) { int num_chains = draws.size(); @@ -125,6 +139,8 @@ inline double compute_potential_scale_reduction( } /** + * \deprecated use split_rank_normalized_rhat instead + * * Computes the split potential scale reduction (Rhat) for the * specified parameter across all kept samples. When the number of * total draws N is odd, the (N+1)/2th draw is ignored. @@ -140,6 +156,11 @@ inline double compute_potential_scale_reduction( * @param sizes stores sizes of chains * @return potential scale reduction for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_split_potential_scale_reduction( std::vector draws, std::vector sizes) { int num_chains = sizes.size(); @@ -157,6 +178,8 @@ inline double compute_split_potential_scale_reduction( } /** + * \deprecated use split_rank_normalized_rhat instead + * * Computes the split potential scale reduction (Rhat) for the * specified parameter across all kept samples. When the number of * total draws N is odd, the (N+1)/2th draw is ignored. @@ -173,6 +196,11 @@ inline double compute_split_potential_scale_reduction( * @param size stores sizes of chains * @return potential scale reduction for the specified parameter */ +#if defined(__GNUC__) || defined(__clang__) +__attribute__((deprecated)) +#elif defined(_MSC_VER) +__declspec(deprecated) +#endif inline double compute_split_potential_scale_reduction( std::vector draws, size_t size) { int num_chains = draws.size(); diff --git a/src/stan/analyze/mcmc/ess.hpp b/src/stan/analyze/mcmc/ess.hpp index 49070894ba..dedc0f7b50 100644 --- a/src/stan/analyze/mcmc/ess.hpp +++ b/src/stan/analyze/mcmc/ess.hpp @@ -15,10 +15,13 @@ namespace analyze { * Computes the effective sample size (ESS) for the specified * parameter across all chains. The number of draws per chain must be > 3, * and the values across all draws must be finite and not constant. - * The value returned is the minimum of ESS and (sample_sz * log10(sample_sz). - * Sample autocovariance is computed using Stan math library implmentation. * See https://arxiv.org/abs/1903.08008, section 3.2 for discussion. * + * Sample autocovariance is computed using the implementation in this namespace + * which normalizes lag-k autocorrelation estimators by N instead of (N - k), + * yielding biased but more stable estimators as discussed in Geyer (1992); see + * https://projecteuclid.org/euclid.ss/1177011137. + * * @param chains matrix of draws across all chains * @return effective sample size for the specified parameter */ diff --git a/src/stan/mcmc/chainset.hpp b/src/stan/mcmc/chainset.hpp index b1f735d344..9eb9369621 100644 --- a/src/stan/mcmc/chainset.hpp +++ b/src/stan/mcmc/chainset.hpp @@ -411,11 +411,6 @@ class chainset { */ double mcse_mean(const int index) const { return analyze::mcse_mean(samples(index)); - // if (num_samples() < 4 - // || !stan::analyze::is_finite_and_varies(samples(index))) - // return std::numeric_limits::quiet_NaN(); - // double ess = analyze::ess(samples(index)); - // return sd(index) / std::sqrt(ess); } /** @@ -440,17 +435,6 @@ class chainset { */ double mcse_sd(const int index) const { return analyze::mcse_sd(samples(index)); - // if (num_samples() < 4 - // || !stan::analyze::is_finite_and_varies(samples(index))) - // return std::numeric_limits::quiet_NaN(); - // Eigen::MatrixXd s = samples(index); - // Eigen::MatrixXd s2 = s.array().square(); - // double ess_s = analyze::ess(s); - // double ess_s2 = analyze::ess(s2); - // double ess_sd = std::min(ess_s, ess_s2); - // return sd(index) - // * std::sqrt(stan::math::e() * std::pow(1 - 1 / ess_sd, ess_sd - 1) - // - 1); } /** diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 5632bc5908..34f34426b5 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -35,6 +35,7 @@ class RankNormalizedEss : public testing::Test { }; TEST_F(RankNormalizedEss, test_bulk_tail_ess) { + // computed via R pkg posterior double ess_lp_bulk_expect = 1512.7684; double ess_lp_tail_expect = 1591.9707; diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp index f043b9c96e..c9fd1ddb8d 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_rhat_test.cpp @@ -37,15 +37,16 @@ class RankNormalizedRhat : public testing::Test { }; TEST_F(RankNormalizedRhat, test_bulk_tail_rhat) { - double rhat_lp_expect = 1.0007301; - double rhat_theta_expect = 1.0067897; + // computed via R pkg posterior + double rhat_lp_expect = 1.00073; + double rhat_theta_expect = 1.006789; auto rhat_lp = stan::analyze::split_rank_normalized_rhat(chains_lp); auto rhat_theta = stan::analyze::split_rank_normalized_rhat(chains_theta); - EXPECT_NEAR(rhat_lp_expect, std::max(rhat_lp.first, rhat_lp.second), 0.00001); + EXPECT_NEAR(rhat_lp_expect, std::max(rhat_lp.first, rhat_lp.second), 1e-5); EXPECT_NEAR(rhat_theta_expect, std::max(rhat_theta.first, rhat_theta.second), - 0.00001); + 1e-5); } TEST_F(RankNormalizedRhat, const_fail) { diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 0c59ec1a8e..6d5db4bd19 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -160,50 +160,50 @@ TEST_F(McmcChains, summary_stats) { Eigen::MatrixXd theta = bern_chains.samples("theta"); // default summary statistics - via R pkg posterior - double theta_mean_expect = 0.2512974105; - EXPECT_NEAR(theta_mean_expect, bern_chains.mean("theta"), 0.00001); + double theta_mean_expect = 0.251297; + EXPECT_NEAR(theta_mean_expect, bern_chains.mean("theta"), 1e-5); double theta_median_expect = 0.237476; - EXPECT_NEAR(theta_median_expect, bern_chains.median("theta"), 0.00001); + EXPECT_NEAR(theta_median_expect, bern_chains.median("theta"), 1e-5); - double theta_sd_expect = 0.1215466867; - EXPECT_NEAR(theta_sd_expect, bern_chains.sd("theta"), 0.00001); + double theta_sd_expect = 0.121546; + EXPECT_NEAR(theta_sd_expect, bern_chains.sd("theta"), 1e-5); - double theta_mad_expect = 0.1230906411; + double theta_mad_expect = 0.12309; EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), - 0.00001); + 1e-5); - double theta_mcse_mean_expect = 0.0032339916; - EXPECT_NEAR(theta_mcse_mean_expect, bern_chains.mcse_mean("theta"), 0.0001); + double theta_mcse_mean_expect = 0.003234; + EXPECT_NEAR(theta_mcse_mean_expect, bern_chains.mcse_mean("theta"), 1e-4); - double theta_mcse_sd_expect = 0.0021642137; - EXPECT_NEAR(theta_mcse_sd_expect, bern_chains.mcse_sd("theta"), 0.0001); + double theta_mcse_sd_expect = 0.002164; + EXPECT_NEAR(theta_mcse_sd_expect, bern_chains.mcse_sd("theta"), 1e-4); Eigen::VectorXd probs(6); probs << 0.0, 0.01, 0.05, 0.95, 0.99, 1.0; Eigen::VectorXd quantiles_expect(6); - quantiles_expect << 0.004072430, 0.046281211, 0.07716935, 0.47388505, - 0.574524110, 0.698401000; + quantiles_expect << 0.004072, 0.046281, 0.077169, 0.473885, + 0.574524, 0.698401; Eigen::VectorXd theta_quantiles = bern_chains.quantiles("theta", probs); for (size_t i = 0; i < probs.size(); ++i) { - EXPECT_NEAR(quantiles_expect(i), theta_quantiles(i), 0.00001); + EXPECT_NEAR(quantiles_expect(i), theta_quantiles(i), 1e-5); } - double theta_rhat_expect = 1.0067897; + double theta_rhat_expect = 1.00679; auto rhat = bern_chains.split_rank_normalized_rhat("theta"); - EXPECT_NEAR(theta_rhat_expect, std::max(rhat.first, rhat.second), 0.00001); + EXPECT_NEAR(theta_rhat_expect, std::max(rhat.first, rhat.second), 1e-5); double theta_ess_bulk_expect = 1407.5124; double theta_ess_tail_expect = 1291.7131; auto ess = bern_chains.split_rank_normalized_ess("theta"); - EXPECT_NEAR(theta_ess_bulk_expect, ess.first, 0.0001); - EXPECT_NEAR(theta_ess_tail_expect, ess.second, 0.0001); + EXPECT_NEAR(theta_ess_bulk_expect, ess.first, 1e-4); + EXPECT_NEAR(theta_ess_tail_expect, ess.second, 1e-4); // autocorrelation - first 10 lags Eigen::VectorXd theta_ac_expect(10); - theta_ac_expect << 1.000000000000, 0.422042451075, 0.206832857945, - 0.083833599168, 0.037326065784, 0.025076266911, 0.020038613922, - 0.013467409681, 0.004762861453, 0.029494701819; + theta_ac_expect << 1.00000, 0.42204, 0.20683, + 0.08383, 0.037326, 0.02507, 0.02003, + 0.01347, 0.00476, 0.029495; auto theta_ac = bern_chains.autocorrelation(0, "theta"); for (size_t i = 0; i < 10; ++i) { EXPECT_NEAR(theta_ac(i), theta_ac_expect(i), 0.0005); From 199155d81c7930df2a065ada1ccf0aa2f2c2ce08 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Mon, 21 Oct 2024 16:24:19 -0400 Subject: [PATCH 29/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- .../mcmc/compute_effective_sample_size.hpp | 19 ++++++++++-------- .../compute_potential_scale_reduction.hpp | 20 +++++++++++-------- src/stan/analyze/mcmc/ess.hpp | 2 +- src/test/unit/mcmc/chainset_test.cpp | 14 ++++++------- 4 files changed, 30 insertions(+), 25 deletions(-) diff --git a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp index bdfbbfd142..cb17a83223 100644 --- a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp +++ b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp @@ -36,8 +36,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_effective_sample_size(std::vector draws, - std::vector sizes) { +inline double +compute_effective_sample_size(std::vector draws, + std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; for (int chain = 1; chain < num_chains; ++chain) { @@ -170,8 +171,8 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_effective_sample_size(std::vector draws, - size_t size) { +inline double +compute_effective_sample_size(std::vector draws, size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_effective_sample_size(draws, sizes); @@ -203,8 +204,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_split_effective_sample_size( - std::vector draws, std::vector sizes) { +inline double +compute_split_effective_sample_size(std::vector draws, + std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; for (int chain = 1; chain < num_chains; ++chain) { @@ -246,8 +248,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_split_effective_sample_size( - std::vector draws, size_t size) { +inline double +compute_split_effective_sample_size(std::vector draws, + size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_split_effective_sample_size(draws, sizes); diff --git a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp index ff2363e643..0404401071 100644 --- a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp +++ b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp @@ -39,8 +39,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_potential_scale_reduction( - std::vector draws, std::vector sizes) { +inline double +compute_potential_scale_reduction(std::vector draws, + std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; if (num_draws == 0) { @@ -131,8 +132,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_potential_scale_reduction( - std::vector draws, size_t size) { +inline double +compute_potential_scale_reduction(std::vector draws, + size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_potential_scale_reduction(draws, sizes); @@ -161,8 +163,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_split_potential_scale_reduction( - std::vector draws, std::vector sizes) { +inline double +compute_split_potential_scale_reduction(std::vector draws, + std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; for (int chain = 1; chain < num_chains; ++chain) { @@ -201,8 +204,9 @@ __attribute__((deprecated)) #elif defined(_MSC_VER) __declspec(deprecated) #endif -inline double compute_split_potential_scale_reduction( - std::vector draws, size_t size) { +inline double +compute_split_potential_scale_reduction(std::vector draws, + size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_split_potential_scale_reduction(draws, sizes); diff --git a/src/stan/analyze/mcmc/ess.hpp b/src/stan/analyze/mcmc/ess.hpp index dedc0f7b50..33342ce68a 100644 --- a/src/stan/analyze/mcmc/ess.hpp +++ b/src/stan/analyze/mcmc/ess.hpp @@ -21,7 +21,7 @@ namespace analyze { * which normalizes lag-k autocorrelation estimators by N instead of (N - k), * yielding biased but more stable estimators as discussed in Geyer (1992); see * https://projecteuclid.org/euclid.ss/1177011137. - * + * * @param chains matrix of draws across all chains * @return effective sample size for the specified parameter */ diff --git a/src/test/unit/mcmc/chainset_test.cpp b/src/test/unit/mcmc/chainset_test.cpp index 6d5db4bd19..5647652485 100644 --- a/src/test/unit/mcmc/chainset_test.cpp +++ b/src/test/unit/mcmc/chainset_test.cpp @@ -170,8 +170,7 @@ TEST_F(McmcChains, summary_stats) { EXPECT_NEAR(theta_sd_expect, bern_chains.sd("theta"), 1e-5); double theta_mad_expect = 0.12309; - EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), - 1e-5); + EXPECT_NEAR(theta_mad_expect, bern_chains.max_abs_deviation("theta"), 1e-5); double theta_mcse_mean_expect = 0.003234; EXPECT_NEAR(theta_mcse_mean_expect, bern_chains.mcse_mean("theta"), 1e-4); @@ -182,8 +181,8 @@ TEST_F(McmcChains, summary_stats) { Eigen::VectorXd probs(6); probs << 0.0, 0.01, 0.05, 0.95, 0.99, 1.0; Eigen::VectorXd quantiles_expect(6); - quantiles_expect << 0.004072, 0.046281, 0.077169, 0.473885, - 0.574524, 0.698401; + quantiles_expect << 0.004072, 0.046281, 0.077169, 0.473885, 0.574524, + 0.698401; Eigen::VectorXd theta_quantiles = bern_chains.quantiles("theta", probs); for (size_t i = 0; i < probs.size(); ++i) { EXPECT_NEAR(quantiles_expect(i), theta_quantiles(i), 1e-5); @@ -196,14 +195,13 @@ TEST_F(McmcChains, summary_stats) { double theta_ess_bulk_expect = 1407.5124; double theta_ess_tail_expect = 1291.7131; auto ess = bern_chains.split_rank_normalized_ess("theta"); - EXPECT_NEAR(theta_ess_bulk_expect, ess.first, 1e-4); + EXPECT_NEAR(theta_ess_bulk_expect, ess.first, 1e-4); EXPECT_NEAR(theta_ess_tail_expect, ess.second, 1e-4); // autocorrelation - first 10 lags Eigen::VectorXd theta_ac_expect(10); - theta_ac_expect << 1.00000, 0.42204, 0.20683, - 0.08383, 0.037326, 0.02507, 0.02003, - 0.01347, 0.00476, 0.029495; + theta_ac_expect << 1.00000, 0.42204, 0.20683, 0.08383, 0.037326, 0.02507, + 0.02003, 0.01347, 0.00476, 0.029495; auto theta_ac = bern_chains.autocorrelation(0, "theta"); for (size_t i = 0; i < 10; ++i) { EXPECT_NEAR(theta_ac(i), theta_ac_expect(i), 0.0005); From b4febe80de2bdd6b14d70cb8f4dbf5ab0084168f Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Mon, 21 Oct 2024 16:37:45 -0400 Subject: [PATCH 30/40] changes per code review --- src/test/unit/analyze/mcmc/ess_basic_test.cpp | 9 +++++---- src/test/unit/analyze/mcmc/mcse_test.cpp | 17 +++++++++-------- src/test/unit/analyze/mcmc/rhat_basic_test.cpp | 9 +++++---- 3 files changed, 19 insertions(+), 16 deletions(-) diff --git a/src/test/unit/analyze/mcmc/ess_basic_test.cpp b/src/test/unit/analyze/mcmc/ess_basic_test.cpp index a010909140..101e9c793b 100644 --- a/src/test/unit/analyze/mcmc/ess_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/ess_basic_test.cpp @@ -42,6 +42,7 @@ class EssBasic : public testing::Test { }; TEST_F(EssBasic, test_basic_ess) { + // computed via R pkg posterior double ess_lp_expect = 1335.4137; double ess_theta_expect = 1377.503; @@ -53,9 +54,9 @@ TEST_F(EssBasic, test_basic_ess) { auto old_ess_basic_theta = stan::analyze::compute_effective_sample_size(draws_theta, sizes); - EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 0.0001); - EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 0.0001); + EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 1e-4); + EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 1e-4); - EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 0.00001); - EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 0.00001); + EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 1e-9); + EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 1e-9); } diff --git a/src/test/unit/analyze/mcmc/mcse_test.cpp b/src/test/unit/analyze/mcmc/mcse_test.cpp index 45f4ce6ccc..92efc49b47 100644 --- a/src/test/unit/analyze/mcmc/mcse_test.cpp +++ b/src/test/unit/analyze/mcmc/mcse_test.cpp @@ -35,18 +35,19 @@ class MonteCarloStandardError : public testing::Test { }; TEST_F(MonteCarloStandardError, test_mcse) { - double mcse_mean_lp_expect = 0.020164778; - double mcse_mean_theta_expect = 0.0032339916; + // computed via R pkg posterior + double mcse_mean_lp_expect = 0.02016; + double mcse_mean_theta_expect = 0.00323; - double mcse_sd_lp_expect = 0.0355305; - double mcse_sd_theta_expect = 0.0021642137; - EXPECT_NEAR(mcse_mean_lp_expect, stan::analyze::mcse_mean(chains_lp), 0.0001); + double mcse_sd_lp_expect = 0.03553; + double mcse_sd_theta_expect = 0.00216; + EXPECT_NEAR(mcse_mean_lp_expect, stan::analyze::mcse_mean(chains_lp), 1e-4); EXPECT_NEAR(mcse_mean_theta_expect, stan::analyze::mcse_mean(chains_theta), - 0.0001); + 1e-4); - EXPECT_NEAR(mcse_sd_lp_expect, stan::analyze::mcse_sd(chains_lp), 0.0001); + EXPECT_NEAR(mcse_sd_lp_expect, stan::analyze::mcse_sd(chains_lp), 1e-4); EXPECT_NEAR(mcse_sd_theta_expect, stan::analyze::mcse_sd(chains_theta), - 0.0001); + 1e-4); } TEST_F(MonteCarloStandardError, const_fail) { diff --git a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp index 4e15262000..5a09b585dd 100644 --- a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp @@ -40,6 +40,7 @@ class RhatBasic : public testing::Test { }; TEST_F(RhatBasic, test_basic_rhat) { + // computed via R pkg posterior double rhat_lp_basic_expect = 1.0001296; double rhat_theta_basic_expect = 1.0029197; @@ -51,9 +52,9 @@ TEST_F(RhatBasic, test_basic_rhat) { auto old_rhat_basic_theta = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); - EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 0.00001); - EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 0.00001); + EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 1e-5); + EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 1e-5); - EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 0.00001); - EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 0.00001); + EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 1e-9); + EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 1e-9); } From b4bca5364654ec091b60e0625acdfc436379d3e6 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Mon, 21 Oct 2024 16:38:15 -0400 Subject: [PATCH 31/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/analyze/mcmc/mcse_test.cpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/test/unit/analyze/mcmc/mcse_test.cpp b/src/test/unit/analyze/mcmc/mcse_test.cpp index 92efc49b47..5b962ec3eb 100644 --- a/src/test/unit/analyze/mcmc/mcse_test.cpp +++ b/src/test/unit/analyze/mcmc/mcse_test.cpp @@ -46,8 +46,7 @@ TEST_F(MonteCarloStandardError, test_mcse) { 1e-4); EXPECT_NEAR(mcse_sd_lp_expect, stan::analyze::mcse_sd(chains_lp), 1e-4); - EXPECT_NEAR(mcse_sd_theta_expect, stan::analyze::mcse_sd(chains_theta), - 1e-4); + EXPECT_NEAR(mcse_sd_theta_expect, stan::analyze::mcse_sd(chains_theta), 1e-4); } TEST_F(MonteCarloStandardError, const_fail) { From bf0d5816095b1045c636a9f475acb28164803e7e Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Mon, 21 Oct 2024 20:07:03 -0400 Subject: [PATCH 32/40] increase test precision, fix split chain logic --- src/stan/analyze/mcmc/split_chains.hpp | 14 +++--- src/test/unit/analyze/mcmc/ess_basic_test.cpp | 4 +- .../unit/analyze/mcmc/rhat_basic_test.cpp | 4 +- .../unit/analyze/mcmc/split_chains_test.cpp | 46 +++++++++++++++++++ 4 files changed, 58 insertions(+), 10 deletions(-) diff --git a/src/stan/analyze/mcmc/split_chains.hpp b/src/stan/analyze/mcmc/split_chains.hpp index a7fb1b8d61..9a7fb9aac1 100644 --- a/src/stan/analyze/mcmc/split_chains.hpp +++ b/src/stan/analyze/mcmc/split_chains.hpp @@ -20,8 +20,9 @@ namespace analyze { inline Eigen::MatrixXd split_chains(const std::vector& chains, const int index) { size_t num_chains = chains.size(); - size_t num_samples = chains[0].rows(); - size_t half = std::floor(num_samples / 2.0); + size_t num_draws = chains[0].rows(); + size_t half = std::floor(num_draws / 2.0); + size_t tail_start = std::floor((num_draws + 1) / 2.0); Eigen::MatrixXd split_draws_matrix(half, num_chains * 2); int split_i = 0; @@ -29,7 +30,7 @@ inline Eigen::MatrixXd split_chains(const std::vector& chains, Eigen::Map head_block(chains[i].col(index).data(), half); Eigen::Map tail_block( - chains[i].col(index).data() + half, half); + chains[i].col(index).data() + tail_start, half); split_draws_matrix.col(split_i) = head_block; split_draws_matrix.col(split_i + 1) = tail_block; @@ -47,14 +48,15 @@ inline Eigen::MatrixXd split_chains(const std::vector& chains, */ inline Eigen::MatrixXd split_chains(const Eigen::MatrixXd& samples) { size_t num_chains = samples.cols(); - size_t num_samples = samples.rows(); - size_t half = std::floor(num_samples / 2.0); + size_t num_draws = samples.rows(); + size_t half = std::floor(num_draws / 2.0); + size_t tail_start = std::floor((num_draws + 1) / 2.0); Eigen::MatrixXd split_draws_matrix(half, num_chains * 2); int split_i = 0; for (std::size_t i = 0; i < num_chains; ++i) { Eigen::Map head_block(samples.col(i).data(), half); - Eigen::Map tail_block(samples.col(i).data() + half, + Eigen::Map tail_block(samples.col(i).data() + tail_start, half); split_draws_matrix.col(split_i) = head_block; diff --git a/src/test/unit/analyze/mcmc/ess_basic_test.cpp b/src/test/unit/analyze/mcmc/ess_basic_test.cpp index 101e9c793b..6cf1226e20 100644 --- a/src/test/unit/analyze/mcmc/ess_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/ess_basic_test.cpp @@ -57,6 +57,6 @@ TEST_F(EssBasic, test_basic_ess) { EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 1e-4); EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 1e-4); - EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 1e-9); - EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 1e-9); + EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 1e-12); + EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 1e-12); } diff --git a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp index 5a09b585dd..48d4d5bdf7 100644 --- a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp @@ -55,6 +55,6 @@ TEST_F(RhatBasic, test_basic_rhat) { EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 1e-5); EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 1e-5); - EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 1e-9); - EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 1e-9); + EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 1e-12); + EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 1e-12); } diff --git a/src/test/unit/analyze/mcmc/split_chains_test.cpp b/src/test/unit/analyze/mcmc/split_chains_test.cpp index 55fb46725f..0725ef6d5c 100644 --- a/src/test/unit/analyze/mcmc/split_chains_test.cpp +++ b/src/test/unit/analyze/mcmc/split_chains_test.cpp @@ -109,3 +109,49 @@ TEST_F(SplitChains, split_chains_convenience) { } } } + +TEST_F(SplitChains, split_draws_matrix_odd_rows) { + // When the number of total draws N is odd, the (N+1)/2th draw is ignored. + Eigen::MatrixXd foo(7, 2); + int val = 0; + for (size_t col = 0; col < 2; ++col) { + for (size_t row = 0; row < 7; ++row) { + val += 1; + foo(row, col) = val; + } + } + auto bar = stan::analyze::split_chains(foo); + EXPECT_EQ(4, bar.cols()); + EXPECT_EQ(3, bar.rows()); + EXPECT_EQ(bar(0,0), 1); + EXPECT_EQ(bar(1,0), 2); + EXPECT_EQ(bar(2,0), 3); + EXPECT_EQ(bar(0,1), 5); + EXPECT_EQ(bar(1,1), 6); + EXPECT_EQ(bar(2,1), 7); + EXPECT_EQ(bar(0,2), 8); + EXPECT_EQ(bar(1,2), 9); + EXPECT_EQ(bar(2,2), 10); + EXPECT_EQ(bar(0,3), 12); + EXPECT_EQ(bar(1,3), 13); + EXPECT_EQ(bar(2,3), 14); + + Eigen::MatrixXd baz(4, 2); + for (size_t col = 0; col < 2; ++col) { + for (size_t row = 0; row < 4; ++row) { + val += 1; + baz(row, col) = val; + } + } + auto boz = stan::analyze::split_chains(baz); + EXPECT_EQ(4, boz.cols()); + EXPECT_EQ(2, boz.rows()); + EXPECT_EQ(boz(0,0), 15); + EXPECT_EQ(boz(1,0), 16); + EXPECT_EQ(boz(0,1), 17); + EXPECT_EQ(boz(1,1), 18); + EXPECT_EQ(boz(0,2), 19); + EXPECT_EQ(boz(1,2), 20); + EXPECT_EQ(boz(0,3), 21); + EXPECT_EQ(boz(1,3), 22); +} From c41190719b38b799040e15343f1c6c77bbb31b9b Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Mon, 21 Oct 2024 20:07:32 -0400 Subject: [PATCH 33/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/stan/analyze/mcmc/split_chains.hpp | 4 +- .../unit/analyze/mcmc/split_chains_test.cpp | 40 +++++++++---------- 2 files changed, 22 insertions(+), 22 deletions(-) diff --git a/src/stan/analyze/mcmc/split_chains.hpp b/src/stan/analyze/mcmc/split_chains.hpp index 9a7fb9aac1..fa89f6dc29 100644 --- a/src/stan/analyze/mcmc/split_chains.hpp +++ b/src/stan/analyze/mcmc/split_chains.hpp @@ -56,8 +56,8 @@ inline Eigen::MatrixXd split_chains(const Eigen::MatrixXd& samples) { int split_i = 0; for (std::size_t i = 0; i < num_chains; ++i) { Eigen::Map head_block(samples.col(i).data(), half); - Eigen::Map tail_block(samples.col(i).data() + tail_start, - half); + Eigen::Map tail_block( + samples.col(i).data() + tail_start, half); split_draws_matrix.col(split_i) = head_block; split_draws_matrix.col(split_i + 1) = tail_block; diff --git a/src/test/unit/analyze/mcmc/split_chains_test.cpp b/src/test/unit/analyze/mcmc/split_chains_test.cpp index 0725ef6d5c..a027937da7 100644 --- a/src/test/unit/analyze/mcmc/split_chains_test.cpp +++ b/src/test/unit/analyze/mcmc/split_chains_test.cpp @@ -123,18 +123,18 @@ TEST_F(SplitChains, split_draws_matrix_odd_rows) { auto bar = stan::analyze::split_chains(foo); EXPECT_EQ(4, bar.cols()); EXPECT_EQ(3, bar.rows()); - EXPECT_EQ(bar(0,0), 1); - EXPECT_EQ(bar(1,0), 2); - EXPECT_EQ(bar(2,0), 3); - EXPECT_EQ(bar(0,1), 5); - EXPECT_EQ(bar(1,1), 6); - EXPECT_EQ(bar(2,1), 7); - EXPECT_EQ(bar(0,2), 8); - EXPECT_EQ(bar(1,2), 9); - EXPECT_EQ(bar(2,2), 10); - EXPECT_EQ(bar(0,3), 12); - EXPECT_EQ(bar(1,3), 13); - EXPECT_EQ(bar(2,3), 14); + EXPECT_EQ(bar(0, 0), 1); + EXPECT_EQ(bar(1, 0), 2); + EXPECT_EQ(bar(2, 0), 3); + EXPECT_EQ(bar(0, 1), 5); + EXPECT_EQ(bar(1, 1), 6); + EXPECT_EQ(bar(2, 1), 7); + EXPECT_EQ(bar(0, 2), 8); + EXPECT_EQ(bar(1, 2), 9); + EXPECT_EQ(bar(2, 2), 10); + EXPECT_EQ(bar(0, 3), 12); + EXPECT_EQ(bar(1, 3), 13); + EXPECT_EQ(bar(2, 3), 14); Eigen::MatrixXd baz(4, 2); for (size_t col = 0; col < 2; ++col) { @@ -146,12 +146,12 @@ TEST_F(SplitChains, split_draws_matrix_odd_rows) { auto boz = stan::analyze::split_chains(baz); EXPECT_EQ(4, boz.cols()); EXPECT_EQ(2, boz.rows()); - EXPECT_EQ(boz(0,0), 15); - EXPECT_EQ(boz(1,0), 16); - EXPECT_EQ(boz(0,1), 17); - EXPECT_EQ(boz(1,1), 18); - EXPECT_EQ(boz(0,2), 19); - EXPECT_EQ(boz(1,2), 20); - EXPECT_EQ(boz(0,3), 21); - EXPECT_EQ(boz(1,3), 22); + EXPECT_EQ(boz(0, 0), 15); + EXPECT_EQ(boz(1, 0), 16); + EXPECT_EQ(boz(0, 1), 17); + EXPECT_EQ(boz(1, 1), 18); + EXPECT_EQ(boz(0, 2), 19); + EXPECT_EQ(boz(1, 2), 20); + EXPECT_EQ(boz(0, 3), 21); + EXPECT_EQ(boz(1, 3), 22); } From 17009f8326db0cac5c37d78ed32d5c9bd0e2ddb9 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Mon, 21 Oct 2024 21:03:49 -0400 Subject: [PATCH 34/40] more unit tests --- src/stan/analyze/mcmc/rank_normalization.hpp | 5 +- .../analyze/mcmc/rank_normalization_test.cpp | 85 +++++++++++++++++++ 2 files changed, 88 insertions(+), 2 deletions(-) create mode 100644 src/test/unit/analyze/mcmc/rank_normalization_test.cpp diff --git a/src/stan/analyze/mcmc/rank_normalization.hpp b/src/stan/analyze/mcmc/rank_normalization.hpp index d53a9acf56..f645b153bd 100644 --- a/src/stan/analyze/mcmc/rank_normalization.hpp +++ b/src/stan/analyze/mcmc/rank_normalization.hpp @@ -12,8 +12,9 @@ namespace stan { namespace analyze { /** - * Computes normalized average ranks for pooled draws. Normal scores computed - * using inverse normal transformation and a fractional offset. Based on paper + * Computes normalized average ranks for pooled draws. The values across + * all draws be finite and not constant. Normal scores computed using + * inverse normal transformation and a fractional offset. Based on paper * https://arxiv.org/abs/1903.08008 * * @param chains matrix of draws, one column per chain diff --git a/src/test/unit/analyze/mcmc/rank_normalization_test.cpp b/src/test/unit/analyze/mcmc/rank_normalization_test.cpp new file mode 100644 index 0000000000..0a7fdc06fb --- /dev/null +++ b/src/test/unit/analyze/mcmc/rank_normalization_test.cpp @@ -0,0 +1,85 @@ +#include +#include +#include +#include +#include +#include +#include +#include +#include + +class RankNormalization : public testing::Test { + public: + void SetUp() { + chains_theta.resize(1000, 4); + for (size_t i = 0; i < 4; ++i) { + std::stringstream fname; + fname << "src/test/unit/analyze/mcmc/test_csv_files/bern" << (i + 1) + << ".csv"; + std::ifstream bern_stream(fname.str(), std::ifstream::in); + stan::io::stan_csv bern_csv + = stan::io::stan_csv_reader::parse(bern_stream, &out); + bern_stream.close(); + chains_theta.col(i) = bern_csv.samples.col(7); + } + } + + void TearDown() {} + + std::stringstream out; + Eigen::MatrixXd chains_theta; +}; + +TEST_F(RankNormalization, test_min_max) { + Eigen::Index maxRow, maxCol; + Eigen::Index minRow, minCol; + double max_val = chains_theta.maxCoeff(&maxRow, &maxCol); + double min_val = chains_theta.minCoeff(&minRow, &minCol); + chains_theta(maxRow, maxCol) = 0.9999; + chains_theta(minRow, minCol) = 0.001; + + auto rank_norm_theta = stan::analyze::rank_transform(chains_theta); + + Eigen::Index maxRowRankNorm, maxColRankNorm; + Eigen::Index minRowRankNorm, minColRankNorm; + max_val = rank_norm_theta.maxCoeff(&maxRowRankNorm, &maxColRankNorm); + min_val = rank_norm_theta.minCoeff(&minRowRankNorm, &minColRankNorm); + EXPECT_EQ(maxRow, maxRowRankNorm); + EXPECT_EQ(minRow, minRowRankNorm); + EXPECT_EQ(maxCol, maxColRankNorm); + EXPECT_EQ(minCol, minColRankNorm); +} + +TEST_F(RankNormalization, test_symmetry) { + Eigen::MatrixXd foo(8, 2); + int val = 0; + for (size_t col = 0; col < 2; ++col) { + for (size_t row = 0; row < 8; ++row) { + val++; + foo(row, col) = val; + } + } + auto bar = stan::analyze::rank_transform(foo); + size_t rev_col = 2; + for (size_t col = 0; col < 2; ++col) { + --rev_col; + size_t rev_row = 8; + for (size_t row = 0; row < 8; ++row) { + --rev_row; + EXPECT_NEAR(bar(row, col), -bar(rev_row, rev_col), 1e-10); + } + } + + Eigen::MatrixXd baz(2, 8); + for (size_t col = 0; col < 8; ++col) { + int val = 0; + for (size_t row = 0; row < 2; ++row) { + val++; + baz(row, col) = val; + } + } + auto boz = stan::analyze::rank_transform(baz); + for (size_t col = 0; col < 8; ++col) { + EXPECT_NEAR(boz(0, col), -boz(1, col), 1e-10); + } +} From 1195c35a41c6061abc8817a90724815a22404650 Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Mon, 21 Oct 2024 21:04:27 -0400 Subject: [PATCH 35/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/analyze/mcmc/rank_normalization_test.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/test/unit/analyze/mcmc/rank_normalization_test.cpp b/src/test/unit/analyze/mcmc/rank_normalization_test.cpp index 0a7fdc06fb..f4776d3443 100644 --- a/src/test/unit/analyze/mcmc/rank_normalization_test.cpp +++ b/src/test/unit/analyze/mcmc/rank_normalization_test.cpp @@ -39,7 +39,7 @@ TEST_F(RankNormalization, test_min_max) { chains_theta(minRow, minCol) = 0.001; auto rank_norm_theta = stan::analyze::rank_transform(chains_theta); - + Eigen::Index maxRowRankNorm, maxColRankNorm; Eigen::Index minRowRankNorm, minColRankNorm; max_val = rank_norm_theta.maxCoeff(&maxRowRankNorm, &maxColRankNorm); From edbc96e47ef9025e1843b5796d17124e9632694d Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Tue, 22 Oct 2024 08:53:35 -0400 Subject: [PATCH 36/40] unit tests against cmdstan 2.35.0 --- src/test/unit/analyze/mcmc/ess_basic_test.cpp | 19 ++++----------- .../unit/analyze/mcmc/rhat_basic_test.cpp | 24 +++++++------------ .../cmdstan-2-35-0-stansummary.csv | 18 ++++++++++++++ 3 files changed, 31 insertions(+), 30 deletions(-) create mode 100644 src/test/unit/analyze/mcmc/test_csv_files/cmdstan-2-35-0-stansummary.csv diff --git a/src/test/unit/analyze/mcmc/ess_basic_test.cpp b/src/test/unit/analyze/mcmc/ess_basic_test.cpp index 6cf1226e20..2a1e910f59 100644 --- a/src/test/unit/analyze/mcmc/ess_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/ess_basic_test.cpp @@ -1,4 +1,3 @@ -#include #include #include #include @@ -42,21 +41,13 @@ class EssBasic : public testing::Test { }; TEST_F(EssBasic, test_basic_ess) { - // computed via R pkg posterior - double ess_lp_expect = 1335.4137; - double ess_theta_expect = 1377.503; + // computed via cmdstan 2.35.0 stansummary + double ess_lp_expect = 1335.41366787; + double ess_theta_expect = 1377.5030282; auto ess_basic_lp = stan::analyze::ess(chains_lp); - auto old_ess_basic_lp - = stan::analyze::compute_effective_sample_size(draws_lp, sizes); - auto ess_basic_theta = stan::analyze::ess(chains_theta); - auto old_ess_basic_theta - = stan::analyze::compute_effective_sample_size(draws_theta, sizes); - - EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 1e-4); - EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 1e-4); - EXPECT_NEAR(old_ess_basic_lp, ess_basic_lp, 1e-12); - EXPECT_NEAR(old_ess_basic_theta, ess_basic_theta, 1e-12); + EXPECT_NEAR(ess_lp_expect, ess_basic_lp, 1e-8); + EXPECT_NEAR(ess_theta_expect, ess_basic_theta, 1e-8); } diff --git a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp index 48d4d5bdf7..e22aff0c0a 100644 --- a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp @@ -1,5 +1,5 @@ -#include #include +#include #include #include #include @@ -40,21 +40,13 @@ class RhatBasic : public testing::Test { }; TEST_F(RhatBasic, test_basic_rhat) { - // computed via R pkg posterior - double rhat_lp_basic_expect = 1.0001296; - double rhat_theta_basic_expect = 1.0029197; + // computed via cmdstan 2.35.0 stansummary + double rhat_lp_basic_expect = 1.00035489482; + double rhat_theta_basic_expect = 1.00721797217; - auto rhat_basic_lp = stan::analyze::rhat(chains_lp); - auto old_rhat_basic_lp - = stan::analyze::compute_potential_scale_reduction(draws_lp, sizes); + auto rhat_basic_lp = stan::analyze::rhat(stan::analyze::split_chains(chains_lp)); + auto rhat_basic_theta = stan::analyze::rhat(stan::analyze::split_chains(chains_theta)); - auto rhat_basic_theta = stan::analyze::rhat(chains_theta); - auto old_rhat_basic_theta - = stan::analyze::compute_potential_scale_reduction(draws_theta, sizes); - - EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 1e-5); - EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 1e-5); - - EXPECT_NEAR(old_rhat_basic_lp, rhat_basic_lp, 1e-12); - EXPECT_NEAR(old_rhat_basic_theta, rhat_basic_theta, 1e-12); + EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 1e-10); + EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 1e-10); } diff --git a/src/test/unit/analyze/mcmc/test_csv_files/cmdstan-2-35-0-stansummary.csv b/src/test/unit/analyze/mcmc/test_csv_files/cmdstan-2-35-0-stansummary.csv new file mode 100644 index 0000000000..7537b4cb0b --- /dev/null +++ b/src/test/unit/analyze/mcmc/test_csv_files/cmdstan-2-35-0-stansummary.csv @@ -0,0 +1,18 @@ +name,Mean,MCSE,StdDev,5%,50%,95%,N_Eff,N_Eff/s,R_hat +"lp__",-7.2867579275,0.0202120721354,0.738616062616,-8.7825,-6.99001,-6.7503,1335.41366787,35142.4649438,1.00035489482 +"accept_stat__",0.92587778475,0.00177759974411,0.116280973122,0.672417,0.974476,1,4279.0696651,112607.09645,1.00155471132 +"stepsize__",0.90426575,0.0139260619795,0.0197240339958,0.883328,0.911571,0.933117,2.00601805416,52.7899487937,6.91946682912e+12 +"treedepth__",1.3515,0.00798399449516,0.479066932987,1,1,2,3600.40978064,94747.6258062,1.00017741661 +"n_leapfrog__",2.515,0.0230857538371,1.31423240019,1,3,3,3240.82976278,85284.9937574,1.00632559786 +"divergent__",0,nan,0,0,0,0,nan,nan,nan +"energy__",7.76890199,0.0271304159659,1.00790019677,6.80125,7.46009,9.72873,1380.13686038,36319.3910627,1.00204956973 +"theta",0.251297410482,0.00327489095264,0.121546686658,0.0769898,0.237539,0.473863,1377.5030282,36250.0796895,1.00721797217 +# Inference for Stan model: bernoulli_model +# 4 chains: each with iter=(1000,1000,1000,1000); warmup=(0,0,0,0); thin=(1,1,1,1); 4000 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, N_Eff is a crude measure of effective sample size, +# and R_hat is the potential scale reduction factor on split chains (at +# convergence, R_hat=1). From c3ae868ee3abeb7f3182ead6bba8fb7c7afc5e2f Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Tue, 22 Oct 2024 08:54:16 -0400 Subject: [PATCH 37/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- src/test/unit/analyze/mcmc/rhat_basic_test.cpp | 6 ++++-- 1 file changed, 4 insertions(+), 2 deletions(-) diff --git a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp index e22aff0c0a..a825ecb820 100644 --- a/src/test/unit/analyze/mcmc/rhat_basic_test.cpp +++ b/src/test/unit/analyze/mcmc/rhat_basic_test.cpp @@ -44,8 +44,10 @@ TEST_F(RhatBasic, test_basic_rhat) { double rhat_lp_basic_expect = 1.00035489482; double rhat_theta_basic_expect = 1.00721797217; - auto rhat_basic_lp = stan::analyze::rhat(stan::analyze::split_chains(chains_lp)); - auto rhat_basic_theta = stan::analyze::rhat(stan::analyze::split_chains(chains_theta)); + auto rhat_basic_lp + = stan::analyze::rhat(stan::analyze::split_chains(chains_lp)); + auto rhat_basic_theta + = stan::analyze::rhat(stan::analyze::split_chains(chains_theta)); EXPECT_NEAR(rhat_lp_basic_expect, rhat_basic_lp, 1e-10); EXPECT_NEAR(rhat_theta_basic_expect, rhat_basic_theta, 1e-10); From ad0bd3522703ec3d0ace37e42d20891e07e860bb Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Tue, 22 Oct 2024 12:42:53 -0400 Subject: [PATCH 38/40] checkpointing --- .../unit/analyze/mcmc/split_rank_normalized_ess_test.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp index 34f34426b5..44c823f5f2 100644 --- a/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp +++ b/src/test/unit/analyze/mcmc/split_rank_normalized_ess_test.cpp @@ -45,11 +45,11 @@ TEST_F(RankNormalizedEss, test_bulk_tail_ess) { auto ess_lp = stan::analyze::split_rank_normalized_ess(chains_lp); auto ess_theta = stan::analyze::split_rank_normalized_ess(chains_theta); - EXPECT_NEAR(ess_lp_bulk_expect, ess_lp.first, 0.001); - EXPECT_NEAR(ess_lp_tail_expect, ess_lp.second, 0.001); + EXPECT_NEAR(ess_lp_bulk_expect, ess_lp.first, 1e-4); + EXPECT_NEAR(ess_lp_tail_expect, ess_lp.second, 1e-4); - EXPECT_NEAR(ess_theta_bulk_expect, ess_theta.first, 0.001); - EXPECT_NEAR(ess_theta_tail_expect, ess_theta.second, 0.001); + EXPECT_NEAR(ess_theta_bulk_expect, ess_theta.first, 1e-4); + EXPECT_NEAR(ess_theta_tail_expect, ess_theta.second, 1e-4); } TEST_F(RankNormalizedEss, const_fail) { From 2ee4dc1ca79ca66dd8c162e97feea754c028e5e4 Mon Sep 17 00:00:00 2001 From: Mitzi Morris Date: Tue, 22 Oct 2024 14:36:43 -0400 Subject: [PATCH 39/40] changes per code review --- .../mcmc/compute_effective_sample_size.hpp | 20 ----------------- .../compute_potential_scale_reduction.hpp | 22 +------------------ src/stan/analyze/mcmc/mcse.hpp | 4 ++-- 3 files changed, 3 insertions(+), 43 deletions(-) diff --git a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp index cb17a83223..d9cb11588d 100644 --- a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp +++ b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp @@ -31,11 +31,6 @@ namespace analyze { * @param sizes stores sizes of chains * @return effective sample size for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_effective_sample_size(std::vector draws, std::vector sizes) { @@ -166,11 +161,6 @@ compute_effective_sample_size(std::vector draws, * @param size size of chains * @return effective sample size for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_effective_sample_size(std::vector draws, size_t size) { int num_chains = draws.size(); @@ -199,11 +189,6 @@ compute_effective_sample_size(std::vector draws, size_t size) { * @param sizes stores sizes of chains * @return effective sample size for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_split_effective_sample_size(std::vector draws, std::vector sizes) { @@ -243,11 +228,6 @@ compute_split_effective_sample_size(std::vector draws, * @param size size of chains * @return effective sample size for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_split_effective_sample_size(std::vector draws, size_t size) { diff --git a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp index 0404401071..8420b720aa 100644 --- a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp +++ b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp @@ -18,7 +18,7 @@ namespace stan { namespace analyze { /** - * DEPRECATED - re-implemented as function `rhat`. + * \deprecated use `rhat` instead * * Computes the potential scale reduction (Rhat) for the specified * parameter across all kept samples. @@ -34,11 +34,6 @@ namespace analyze { * @param sizes stores sizes of chains * @return potential scale reduction for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_potential_scale_reduction(std::vector draws, std::vector sizes) { @@ -127,11 +122,6 @@ compute_potential_scale_reduction(std::vector draws, * @param size stores sizes of chains * @return potential scale reduction for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_potential_scale_reduction(std::vector draws, size_t size) { @@ -158,11 +148,6 @@ compute_potential_scale_reduction(std::vector draws, * @param sizes stores sizes of chains * @return potential scale reduction for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_split_potential_scale_reduction(std::vector draws, std::vector sizes) { @@ -199,11 +184,6 @@ compute_split_potential_scale_reduction(std::vector draws, * @param size stores sizes of chains * @return potential scale reduction for the specified parameter */ -#if defined(__GNUC__) || defined(__clang__) -__attribute__((deprecated)) -#elif defined(_MSC_VER) -__declspec(deprecated) -#endif inline double compute_split_potential_scale_reduction(std::vector draws, size_t size) { diff --git a/src/stan/analyze/mcmc/mcse.hpp b/src/stan/analyze/mcmc/mcse.hpp index 93292a0cf3..040b94d9ea 100644 --- a/src/stan/analyze/mcmc/mcse.hpp +++ b/src/stan/analyze/mcmc/mcse.hpp @@ -25,9 +25,9 @@ inline double mcse_mean(const Eigen::MatrixXd& chains) { if (chains.rows() < 4 || !is_finite_and_varies(chains)) return std::numeric_limits::quiet_NaN(); - double sd + double sample_var = (chains.array() - chains.mean()).square().sum() / (chains.size() - 1); - return std::sqrt(sd / ess(chains)); + return std::sqrt(sample_var / ess(chains)); } /** From 68a3cfbbcaa40ba1a6d589ea300ad80a6baefdbd Mon Sep 17 00:00:00 2001 From: Stan Jenkins Date: Tue, 22 Oct 2024 14:37:16 -0400 Subject: [PATCH 40/40] [Jenkins] auto-formatting by clang-format version 10.0.0-4ubuntu1 --- .../mcmc/compute_effective_sample_size.hpp | 19 ++++++++---------- .../compute_potential_scale_reduction.hpp | 20 ++++++++----------- 2 files changed, 16 insertions(+), 23 deletions(-) diff --git a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp index d9cb11588d..e06c89f7a1 100644 --- a/src/stan/analyze/mcmc/compute_effective_sample_size.hpp +++ b/src/stan/analyze/mcmc/compute_effective_sample_size.hpp @@ -31,9 +31,8 @@ namespace analyze { * @param sizes stores sizes of chains * @return effective sample size for the specified parameter */ -inline double -compute_effective_sample_size(std::vector draws, - std::vector sizes) { +inline double compute_effective_sample_size(std::vector draws, + std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; for (int chain = 1; chain < num_chains; ++chain) { @@ -161,8 +160,8 @@ compute_effective_sample_size(std::vector draws, * @param size size of chains * @return effective sample size for the specified parameter */ -inline double -compute_effective_sample_size(std::vector draws, size_t size) { +inline double compute_effective_sample_size(std::vector draws, + size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_effective_sample_size(draws, sizes); @@ -189,9 +188,8 @@ compute_effective_sample_size(std::vector draws, size_t size) { * @param sizes stores sizes of chains * @return effective sample size for the specified parameter */ -inline double -compute_split_effective_sample_size(std::vector draws, - std::vector sizes) { +inline double compute_split_effective_sample_size( + std::vector draws, std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; for (int chain = 1; chain < num_chains; ++chain) { @@ -228,9 +226,8 @@ compute_split_effective_sample_size(std::vector draws, * @param size size of chains * @return effective sample size for the specified parameter */ -inline double -compute_split_effective_sample_size(std::vector draws, - size_t size) { +inline double compute_split_effective_sample_size( + std::vector draws, size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_split_effective_sample_size(draws, sizes); diff --git a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp index 8420b720aa..baa686e63d 100644 --- a/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp +++ b/src/stan/analyze/mcmc/compute_potential_scale_reduction.hpp @@ -34,9 +34,8 @@ namespace analyze { * @param sizes stores sizes of chains * @return potential scale reduction for the specified parameter */ -inline double -compute_potential_scale_reduction(std::vector draws, - std::vector sizes) { +inline double compute_potential_scale_reduction( + std::vector draws, std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; if (num_draws == 0) { @@ -122,9 +121,8 @@ compute_potential_scale_reduction(std::vector draws, * @param size stores sizes of chains * @return potential scale reduction for the specified parameter */ -inline double -compute_potential_scale_reduction(std::vector draws, - size_t size) { +inline double compute_potential_scale_reduction( + std::vector draws, size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_potential_scale_reduction(draws, sizes); @@ -148,9 +146,8 @@ compute_potential_scale_reduction(std::vector draws, * @param sizes stores sizes of chains * @return potential scale reduction for the specified parameter */ -inline double -compute_split_potential_scale_reduction(std::vector draws, - std::vector sizes) { +inline double compute_split_potential_scale_reduction( + std::vector draws, std::vector sizes) { int num_chains = sizes.size(); size_t num_draws = sizes[0]; for (int chain = 1; chain < num_chains; ++chain) { @@ -184,9 +181,8 @@ compute_split_potential_scale_reduction(std::vector draws, * @param size stores sizes of chains * @return potential scale reduction for the specified parameter */ -inline double -compute_split_potential_scale_reduction(std::vector draws, - size_t size) { +inline double compute_split_potential_scale_reduction( + std::vector draws, size_t size) { int num_chains = draws.size(); std::vector sizes(num_chains, size); return compute_split_potential_scale_reduction(draws, sizes);