diff --git a/.github/workflows/code-style.yml b/.github/workflows/code-style.yml index f9f43afdb..39274a654 100644 --- a/.github/workflows/code-style.yml +++ b/.github/workflows/code-style.yml @@ -20,7 +20,7 @@ jobs: - name: Install dependencies run: | python -m pip install --upgrade pip - pip install cpplint + pip install --force-reinstall -v "cpplint==1.6.1" - name: "Check Code Format" run: | ./scripts/cpplint.sh diff --git a/Bembel/src/AnsatzSpace/Glue.hpp b/Bembel/src/AnsatzSpace/Glue.hpp index a1c0d7a15..bd0fac427 100644 --- a/Bembel/src/AnsatzSpace/Glue.hpp +++ b/Bembel/src/AnsatzSpace/Glue.hpp @@ -165,13 +165,15 @@ class Glue { // Here, we fill the two vectors above int number_of_slaves = 0; + int number_of_boundary_dofs = 0; for (auto dofset : dof_id) { // This sorting is required, since by construction only dofs[0]dofs[2]. Moreover, we count how many dofs we "glue - // away". + // away" or skipped on the boundary. std::sort(dofset.dofs.begin(), dofset.dofs.end()); dof_is_master[dofset.dofs[0]] = true; + if (dofset.dofs.size() == 1) ++number_of_boundary_dofs; for (int i = 1; i < dofset.dofs.size(); ++i) { dof_is_slave[dofset.dofs[i]] = true; ++number_of_slaves; @@ -185,17 +187,24 @@ class Glue { return a.dofs[0] < b.dofs[0]; }); - const int post_dofs = pre_dofs - number_of_slaves; - + const int post_dofs = pre_dofs - number_of_slaves - number_of_boundary_dofs; + const int glued_dofs = pre_dofs - number_of_slaves; + assert(post_dofs != 0 && "All degrees of freedom are on the boundary!"); // This block is the heart of the algorithms. Skip keeps track of how many // slaves have been skipped already, and master_index keeps track on which - // master is about to be glued next. + // master is about to be glued next. post_index keeps track on how many + // dofs are on the boundary of the patches and therefore skipped. int skip = 0; int master_index = 0; - for (int i = 0; i < post_dofs; ++i) { - const int post_index = i; + int post_index = 0; + for (int i = 0; i < glued_dofs; ++i) { while (dof_is_slave[i + skip] && ((i + skip) < pre_dofs)) ++skip; const int pre_index = i + skip; + // skip dofs on patch boundary without a slave patch + if (dof_is_master[pre_index] && dof_id[master_index].dofs.size() == 1) { + ++master_index; + continue; + } trips.push_back(Eigen::Triplet(pre_index, post_index, 1)); // The dof cannot be declared slave and master at the same time assert(!(dof_is_master[pre_index] && dof_is_slave[pre_index])); @@ -212,12 +221,13 @@ class Glue { } ++master_index; } + ++post_index; } Eigen::SparseMatrix glue_matrix(pre_dofs, post_dofs); glue_matrix.setFromTriplets(trips.begin(), trips.end()); - assert(trips.size() == pre_dofs); + assert(trips.size() == (pre_dofs - number_of_boundary_dofs)); return glue_matrix; } }; @@ -557,7 +567,7 @@ struct glue_identificationmaker_ { const bool needReversion = reverseParametrized(edge); const int coef = glueCoefficientDivergenceConforming(edge); - // Check if the edge is hanging. For screens one would need an "else". + // Check if the edge is hanging. if (edge[1] > -1 && edge[0] > -1) { for (int i = 0; i < size_of_edge_dofs; ++i) { GlueRoutines::dofIdentification d; @@ -569,6 +579,13 @@ struct glue_identificationmaker_ { d.coef = coef; out.push_back(d); } + } else { + for (int i = 0; i < size_of_edge_dofs; ++i) { + // Add only the master dof which is skipped in subsequent routines + GlueRoutines::dofIdentification d; + d.dofs.push_back(dofs_e1[i]); + out.push_back(d); + } } } out.shrink_to_fit(); diff --git a/Bembel/src/util/Constants.hpp b/Bembel/src/util/Constants.hpp index 8ff6a6671..cca136afe 100644 --- a/Bembel/src/util/Constants.hpp +++ b/Bembel/src/util/Constants.hpp @@ -36,6 +36,11 @@ constexpr size_t Bembel_alloc_size = 100; // solution of the linear system constexpr double projector_tolerance = 1e-4; //////////////////////////////////////////////////////////////////////////////// +/// physical constants +//////////////////////////////////////////////////////////////////////////////// +constexpr double eps0 = 8.854187812813 * 1e-12; +constexpr double mu0 = 4 * M_PI * 1e-7; +//////////////////////////////////////////////////////////////////////////////// /// methods //////////////////////////////////////////////////////////////////////////////// diff --git a/CMakeLists.txt b/CMakeLists.txt index 92eb35e35..a88f374bf 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -73,6 +73,7 @@ set (BEMBEL_PATH "${PROJECT_SOURCE_DIR}") set(CMAKE_CXX_STANDARD 11) include_directories(${BEMBEL_PATH}) +include_directories(${BEMBEL_PATH}/unsupported) if(NOT CMAKE_BUILD_TYPE) set(CMAKE_BUILD_TYPE Release CACHE STRING @@ -108,4 +109,5 @@ set(CMAKE_CXX_FLAGS_COVERAGE "-g -fPIC -fprofile-arcs -ftest-coverage" CACHE STR add_subdirectory(tests) add_subdirectory(examples) +add_subdirectory(unsupported/examples) enable_testing() diff --git a/Doxyfile b/Doxyfile index 90dc99e29..f49c35216 100644 --- a/Doxyfile +++ b/Doxyfile @@ -833,7 +833,8 @@ WARN_LOGFILE = INPUT = Bembel \ README.md \ doc \ - examples + examples \ + unsupported # This tag can be used to specify the character encoding of the source files # that doxygen parses. Internally doxygen uses the UTF-8 encoding. Doxygen uses diff --git a/doc/layout.xml b/doc/layout.xml index 757ef7cd1..73206b7b6 100644 --- a/doc/layout.xml +++ b/doc/layout.xml @@ -16,7 +16,7 @@ - + diff --git a/tests/test_TangentialTrace.cpp b/tests/test_TangentialTrace.cpp index 744f9e9a6..2977d98e0 100644 --- a/tests/test_TangentialTrace.cpp +++ b/tests/test_TangentialTrace.cpp @@ -22,10 +22,27 @@ struct Bembel::LinearOperatorTraits { typedef Eigen::VectorXd::Scalar Scalar; enum { OperatorOrder = 0, Form = DifferentialForm::DivConforming }; }; - +/* + * This test uses a five patch geometry. After discretizing with level zero + * refinement four degrees of freedom remain which are all located on the edge + * of patch 0. + * The linear form integrates the function (x,y,z) with the tangential trace. + * For a simplified test the function is 0 outside of patch 0. Thereby only + * contributions of basis functions with support on patch 0 need to be taken + * into account. + * + * ---- + * |4 | + * ---------- + * |2 |0 |1 | + * ---------- + * |3 | + * ---- + * + */ int main() { - Test::TestGeometryWriter::writeScreen(); - Bembel::Geometry geometry("test_Screen.dat"); + Test::TestGeometryWriter::writeEdgeCase1(); + Bembel::Geometry geometry("test_EdgeCase1.dat"); const int refinement_level = 0; const int polynomial_degree = 1; @@ -33,7 +50,13 @@ int main() { polynomial_degree); std::function fun = [](Eigen::Vector3d in) { - return Eigen::Vector3d(in(0), in(1), in(2)); + Eigen::Vector3d retval; + if (in(0) < 0 || in(0) > 1 || in(1) < 0 || in(1) > 1) { + retval << 0, 0, 0; + } else { + retval << in(0), in(1), in(2); + } + return retval; }; Bembel::DiscreteLinearForm, TestOperatorDivC> diff --git a/unsupported/Bembel/AugmentedEFIE b/unsupported/Bembel/AugmentedEFIE new file mode 100644 index 000000000..69e6c6593 --- /dev/null +++ b/unsupported/Bembel/AugmentedEFIE @@ -0,0 +1,38 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#ifndef BEMBEL_AugmentedEFIE_MODULE_ +#define BEMBEL_AugmentedEFIE_MODULE_ + +/** + * \ingroup Modules + * \defgroup AugmentedEFIE AugmentedEFIE + * \brief The AugmentedEFIE module contains routines for the spline-based + * Augmented Electric Field Integral Equation. + **/ + +#include +#include +#include +#include + +#include "src/AugmentedEFIE/IncidenceMatrix.hpp" +#include "src/AugmentedEFIE/InductanceMatrix.hpp" +#include "src/AugmentedEFIE/EFIE.hpp" +#include "src/AugmentedEFIE/VectorPotential.hpp" +#include "src/AugmentedEFIE/GradScalarPotential.hpp" +#include "src/AugmentedEFIE/MixedEFIE.hpp" +#include "src/AugmentedEFIE/VoltageSource.hpp" +#include "src/AugmentedEFIE/AugmentedEFIEAssembler.hpp" +#include "src/AugmentedEFIE/AugmentedEFIE.hpp" +#include "src/AugmentedEFIE/AugmentedEFIEExcitation.hpp" + +#endif \ No newline at end of file diff --git a/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIE.hpp b/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIE.hpp new file mode 100644 index 000000000..0f83dce58 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIE.hpp @@ -0,0 +1,167 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIE_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIE_HPP_ + +namespace Bembel { +/** + * \ingroup AugmentedEFIE + * \brief This class handles the assembly and storage of the system matrix. + */ +template +class AugmentedEFIE { + public: + ////////////////////////////////////////////////////////////////////////////// + // constructors + ////////////////////////////////////////////////////////////////////////////// + AugmentedEFIE() {} + AugmentedEFIE(const AnsatzSpace &ansatz_space_vector, + const Geometry &geometry) { + init_AugmentedEFIE(ansatz_space_vector, geometry); + } + ////////////////////////////////////////////////////////////////////////////// + // init_AugmentedEFIE + ////////////////////////////////////////////////////////////////////////////// + void init_AugmentedEFIE(const AnsatzSpace &ansatz_space_vector, + const Geometry &geometry) { + ansatz_space_vector_ = ansatz_space_vector; + + // Build ansatz spaces + ansatz_space_mass_ = AnsatzSpace( + geometry, ansatz_space_vector.get_refinement_level(), + ansatz_space_vector.get_polynomial_degree() - 1); + + ansatz_space_scalar_ = AnsatzSpace( + geometry, ansatz_space_vector.get_refinement_level(), + ansatz_space_vector.get_polynomial_degree() - 1); + + dofs_scalar_ = ansatz_space_scalar_.get_number_of_dofs(); + dofs_vector_ = ansatz_space_vector_.get_number_of_dofs(); + return; + } + ////////////////////////////////////////////////////////////////////////////// + // compute + ////////////////////////////////////////////////////////////////////////////// + /** + * \brief Assembles the system matrix without voltage source excitation. + */ + inline void compute() { + system_matrix_ = Eigen::MatrixXcd(dofs_scalar_ + dofs_vector_, + dofs_scalar_ + dofs_vector_); + + AugmentedEFIEAssembler::compute( + &system_matrix_, ansatz_space_mass_, ansatz_space_scalar_, + ansatz_space_vector_, wavenumber_); + return; + } + /** + * \brief Assembles the system matrix with voltage source excitation. + */ + inline void compute(VoltageSource source) { + const int elements_per_edge = + (1 << ansatz_space_vector_.get_refinement_level()); + // This number contains all degrees of freedom on the edge for the + // excitation and three extra ones dedicated to the potential of the voltage + // source. + const int dofs_excitation = + 3 + + (source.positive_.size() + source.negative_.size()) * elements_per_edge; + system_matrix_ = + Eigen::MatrixXcd::Zero(dofs_scalar_ + dofs_vector_ + dofs_excitation, + dofs_scalar_ + dofs_vector_ + dofs_excitation); + excitation_ = Eigen::VectorXcd::Zero(dofs_scalar_); + + AugmentedEFIEAssembler::compute_matrix_and_excitation( + &system_matrix_, &excitation_, ansatz_space_mass_, ansatz_space_scalar_, + ansatz_space_vector_, wavenumber_, source); + return; + } + void stabilize() { + std::function(Eigen::Vector3d)> one = + [](Eigen::Vector3d in) { return std::complex(1., 0.); }; + DiscreteLinearForm>, + HelmholtzSingleLayerOperator> + const_lf(ansatz_space_scalar_); + const_lf.get_linear_form().set_function(one); + const_lf.compute(); + + system_matrix_.bottomRows(dofs_scalar_) *= omega_ * + std::complex(0., 1.) * + Constants::mu0 * Constants::eps0; + system_matrix_.leftCols(dofs_vector_) *= + 1. / (omega_ * std::complex(0., 1.) * Constants::mu0); + + std::complex eigenvalues_average = + system_matrix_.trace() / ((double)system_matrix_.cols()); + + Eigen::VectorXcd a = Eigen::VectorXcd::Zero(system_matrix_.cols()); + a.bottomRows(dofs_scalar_) = const_lf.get_discrete_linear_form(); + + system_matrix_ = system_matrix_ - eigenvalues_average * a * a.transpose(); + } + ////////////////////////////////////////////////////////////////////////////// + // setters + ////////////////////////////////////////////////////////////////////////////// + /** + * \brief Set wave number + */ + void set_wavenumber(std::complex wavenumber) { + wavenumber_ = wavenumber; + } + void set_omega(double omega) { omega_ = omega; } + ////////////////////////////////////////////////////////////////////////////// + // getters + ////////////////////////////////////////////////////////////////////////////// + const MatrixFormat &get_system_matrix() const { return system_matrix_; } + /** + * \brief Return wave number + */ + const std::complex get_wavenumber() { return wavenumber_; } + /** + * \brief Return number of degrees of freedom for the current. + */ + const int get_dofs_vector() { return dofs_vector_; } + /** + * \brief Return number of degrees of freedom for the potential + */ + const int get_dofs_scalar() { return dofs_scalar_; } + /** + * \brief Debug output for the excitation. + */ + const Eigen::VectorXcd get_excitation() { return excitation_; } + /** + * \brief Debug output for the excitation. + */ + const AnsatzSpace get_ansatz_space_scalar() { + return ansatz_space_scalar_; + } + const AnsatzSpace get_ansatz_space_mass() { + return ansatz_space_mass_; + } + ////////////////////////////////////////////////////////////////////////////// + // private member variables + ////////////////////////////////////////////////////////////////////////////// + private: + MatrixFormat system_matrix_; + Eigen::VectorXcd excitation_; + + AnsatzSpace ansatz_space_mass_; + AnsatzSpace ansatz_space_scalar_; + AnsatzSpace ansatz_space_vector_; + + int dofs_scalar_; + int dofs_vector_; + double omega_; + std::complex wavenumber_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIE_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIEAssembler.hpp b/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIEAssembler.hpp new file mode 100644 index 000000000..bb73c2fb6 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIEAssembler.hpp @@ -0,0 +1,262 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIEASSEMBLER_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIEASSEMBLER_HPP_ + +namespace Bembel { +template +struct AugmentedEFIEAssembler {}; +/** + * \ingroup AugmentedEFIE + * \brief This struct handles the routines for assembling the system matrix. + */ +template <> +struct AugmentedEFIEAssembler { + public: + AugmentedEFIEAssembler() {} + /** + * This routine assembles the system matrix for solving the scattering + * problem. + */ + static std::unique_ptr compute( + Eigen::MatrixXcd *system_matrix, + const AnsatzSpace &ansatz_space_mass, + const AnsatzSpace &ansatz_space_scalar, + const AnsatzSpace &ansatz_space_vector, + const std::complex wavenumber) { + const int dofs_scalar = ansatz_space_scalar.get_number_of_dofs(); + const int dofs_vector = ansatz_space_vector.get_number_of_dofs(); + + assembleZ(system_matrix, ansatz_space_vector, wavenumber); + + IncidenceMatrix + incidence_matrix(ansatz_space_vector, ansatz_space_scalar); + incidence_matrix.compute(); + + assembleS(system_matrix, incidence_matrix, dofs_vector, dofs_scalar); + + DiscreteLocalOperator mass_matrix(ansatz_space_mass); + mass_matrix.compute(); + + assembleM(system_matrix, mass_matrix, wavenumber, dofs_vector, dofs_scalar); + + DiscreteOperator + capacitive_operator(ansatz_space_scalar); + capacitive_operator.get_linear_operator().set_wavenumber(wavenumber); + capacitive_operator.compute(); + + std::unique_ptr P_times_mass_inverse( + new Eigen::MatrixXcd); + *P_times_mass_inverse = + capacitive_operator.get_discrete_operator() / Constants::eps0 * + Eigen::MatrixXcd(mass_matrix.get_discrete_operator()).inverse(); + + assembleP(system_matrix, ansatz_space_scalar, P_times_mass_inverse, + incidence_matrix, wavenumber, dofs_vector, dofs_scalar); + + return P_times_mass_inverse; + } + /** + * This routine assembles the incident matrices necessary for the voltage + * source excitation. It is necessary to run the code of the compute routine + * above because the inverse of the mass matrix is utilized. + * + * The variable excitation is used for debug output only. + */ + static void compute_matrix_and_excitation( + Eigen::MatrixXcd *system_matrix, Eigen::VectorXcd *excitation, + const AnsatzSpace &ansatz_space_mass, + const AnsatzSpace &ansatz_space_scalar, + const AnsatzSpace &ansatz_space_vector, + const std::complex wavenumber, const VoltageSource &source) { + assert(ansatz_space_scalar.get_polynomial_degree() == 0 && + "This works only for lowest order!"); + const int refinement_level = ansatz_space_scalar.get_refinement_level(); + const int dofs_scalar = ansatz_space_scalar.get_number_of_dofs(); + const int dofs_vector = ansatz_space_vector.get_number_of_dofs(); + + std::unique_ptr P_times_mass_inverse = + compute(system_matrix, ansatz_space_mass, ansatz_space_scalar, + ansatz_space_vector, wavenumber); + + assembleV(system_matrix, excitation, ansatz_space_scalar, + P_times_mass_inverse, source, dofs_vector, + ansatz_space_scalar.get_number_of_dofs()); + assembleA(system_matrix, source, refinement_level, dofs_vector, + dofs_scalar); + return; + } + + private: + /** + * \brief Assemble the top left block of the system matrix j*omega*mu*L. + * + * Currently there are no finitely resistive materials realized. + */ + static void assembleZ( + Eigen::MatrixXcd *system_matrix, + const AnsatzSpace &ansatz_space_vector, + const std::complex wavenumber) { + DiscreteOperator disc_op( + ansatz_space_vector); + disc_op.get_linear_operator().set_wavenumber(wavenumber); + disc_op.compute(); + + const int dofs_vector = ansatz_space_vector.get_number_of_dofs(); + std::complex omega = + wavenumber / std::sqrt(Constants::mu0 * Constants::eps0); + system_matrix->block(0, 0, dofs_vector, dofs_vector) = + Constants::mu0 * omega * std::complex(0., 1.) * + disc_op.get_discrete_operator(); + return; + } + /** + * \brief Assemble the top right block of the system matrix with the incident + * matrix. + */ + static void assembleS( + Eigen::MatrixXcd *system_matrix, + IncidenceMatrix + incidence_matrix, + const int dofs_vector, const int dofs_scalar) { + system_matrix->block(0, dofs_vector, dofs_vector, dofs_scalar) = + incidence_matrix.get_incidence_matrix(); + return; + } + /** + * \brief Assemble the top right block of the system matrix with the incident + * matrix. + */ + static void assembleM(Eigen::MatrixXcd *system_matrix, + DiscreteLocalOperator mass_matrix, + const std::complex wavenumber, + const int dofs_vector, const int dofs_scalar) { + std::complex omega = + wavenumber / std::sqrt(Constants::mu0 * Constants::eps0); + system_matrix->block(dofs_vector, dofs_vector, dofs_scalar, dofs_scalar) = + -omega * std::complex(0., 1.) * + mass_matrix.get_discrete_operator(); + return; + } + /** + * \brief Assemble the bottom left block of the system matrix with + * P * M^-1 * S^T. + */ + static void assembleP( + Eigen::MatrixXcd *system_matrix, + const AnsatzSpace &ansatz_space_scalar, + const std::unique_ptr &P_times_mass_inverse, + const IncidenceMatrix + &incident_matrix, + const std::complex wavenumber, const int dofs_vector, + const int dofs_scalar) { + system_matrix->block(dofs_vector, 0, dofs_scalar, dofs_vector) = + *P_times_mass_inverse * + incident_matrix.get_incidence_matrix().transpose(); + return; + } + /** + * \brief Assemble the excitation block right of and below the M block. + */ + static void assembleV( + Eigen::MatrixXcd *system_matrix, Eigen::VectorXcd *excitation, + const AnsatzSpace &ansatz_space_scalar, + const std::unique_ptr &P_times_mass_inverse, + VoltageSource source, const int dofs_vector, const int dofs_scalar) { + Eigen::MatrixXcd V = get_voltage_incidence_matrix( + excitation, source, ansatz_space_scalar.get_number_of_dofs(), + ansatz_space_scalar.get_polynomial_degree(), + ansatz_space_scalar.get_refinement_level()); + + system_matrix->block(dofs_vector, dofs_vector + dofs_scalar, dofs_scalar, + V.rows()) = *P_times_mass_inverse * V.transpose(); + system_matrix->block(dofs_vector + dofs_scalar, dofs_vector, V.rows(), + dofs_scalar) = V; + return; + } + /** + * \brief Assemble the excitation block on the very right of and very bottom. + * Task of this block is to bundle all the degrees of freedom of one pole to + * the same potential. + * + * This matrix has two columns each containing ones for the degrees of + * freedom corresponding either to the positive or negative pole of the + * voltage source. The first line mimes the difference of the potential. + */ + static void assembleA(Eigen::MatrixXcd *system_matrix, + const VoltageSource &source, const int refinement_level, + const int dofs_vector, const int dofs_scalar) { + const int dofs_excitation_positive = + source.positive_.size() * (1 << refinement_level); + const int dofs_excitation_negative = + source.negative_.size() * (1 << refinement_level); + const int dofs_excitation = + dofs_excitation_positive + dofs_excitation_negative + 1; + Eigen::MatrixXcd A = Eigen::MatrixXcd::Ones(dofs_excitation, 2); + A.block(1, 1, dofs_excitation_negative, 1) = + Eigen::VectorXcd::Zero(dofs_excitation_negative); + A.block(1 + dofs_excitation_negative, 0, dofs_excitation_positive, 1) = + Eigen::VectorXcd::Zero(dofs_excitation_positive); + A(0, 0) = 1; + A(0, 1) = -1; + + const int dofs_basis = dofs_vector + dofs_scalar; + system_matrix->block(dofs_basis, dofs_basis + dofs_excitation, + dofs_excitation, 2) = A; + system_matrix->block(dofs_basis + dofs_excitation, dofs_basis, 2, + dofs_excitation) = A.transpose(); + return; + } + static Eigen::MatrixXcd get_voltage_incidence_matrix( + Eigen::VectorXcd *excitation, VoltageSource source, const int dofs_scalar, + const int polynomial_degree, const int refinement_level) { + const int elements_per_edge = (1 << refinement_level); + const int num_elements_per_patch = elements_per_edge * elements_per_edge; + const int dofs_excitation_V = + (source.positive_.size() + source.negative_.size()) * + elements_per_edge + + 1; + const int number_of_basisfunctions = polynomial_degree + elements_per_edge; + + Eigen::MatrixXcd ret = + Eigen::MatrixXcd::Zero(dofs_excitation_V, dofs_scalar); + + const int number_of_patches_negative = source.negative_.size(); + int row_count = 1; + for (auto i = 0; i < number_of_patches_negative; ++i) { + std::vector edge_dofs = GlueRoutines::getEdgeDofIndices( + source.negative_[i][1], number_of_basisfunctions, + number_of_basisfunctions, + source.negative_[i][0] * num_elements_per_patch); + for (auto dof : edge_dofs) { + ret(row_count, dof) = -1; + excitation[0](dof) = -1; + ++row_count; + } + } + + const int number_of_patches_positive = source.positive_.size(); + for (auto i = 0; i < number_of_patches_positive; ++i) { + std::vector edge_dofs = GlueRoutines::getEdgeDofIndices( + source.positive_[i][1], number_of_basisfunctions, + number_of_basisfunctions, + source.positive_[i][0] * num_elements_per_patch); + for (auto dof : edge_dofs) { + ret(row_count, dof) = -1; + excitation[0](dof) = 1; + ++row_count; + } + } + return ret; + } +}; +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIEASSEMBLER_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIEExcitation.hpp b/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIEExcitation.hpp new file mode 100644 index 000000000..b3b712114 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/AugmentedEFIEExcitation.hpp @@ -0,0 +1,74 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2022 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIEEXCITATION_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIEEXCITATION_HPP_ + +namespace Bembel { +/** + * \ingroup AugmentedEFIE + * \brief This class, given a LinearForm with defined traits, takes care of the + * assembly of the right hand side. + */ +template +class AugmentedEFIEExcitation { + public: + ////////////////////////////////////////////////////////////////////////////// + // constructors + ////////////////////////////////////////////////////////////////////////////// + AugmentedEFIEExcitation() {} + explicit AugmentedEFIEExcitation(const AnsatzSpace &ansatz_space, + const int dofs_scalar) { + init_AugmentedEFIEExcitation(ansatz_space, dofs_scalar); + } + ////////////////////////////////////////////////////////////////////////////// + // init_AugmentedEFIEExcitation + ////////////////////////////////////////////////////////////////////////////// + void init_AugmentedEFIEExcitation(const AnsatzSpace &ansatz_space, + const int dofs_scalar) { + ansatz_space_ = ansatz_space; + disc_lf_ = DiscreteLinearForm(ansatz_space_); + dofs_scalar_ = dofs_scalar; + dofs_vector_ = ansatz_space.get_number_of_dofs(); + return; + } + ////////////////////////////////////////////////////////////////////////////// + // compute + ////////////////////////////////////////////////////////////////////////////// + /** + * \todo Add inline commentary + **/ + void compute() { + excitation_ = Eigen::VectorXcd::Zero(dofs_scalar_ + dofs_vector_); + disc_lf_.compute(); + + excitation_.head(dofs_vector_) = -disc_lf_.get_discrete_linear_form(); + return; + } + ////////////////////////////////////////////////////////////////////////////// + // getter + ////////////////////////////////////////////////////////////////////////////// + Derived &get_linear_form() { return disc_lf_.get_linear_form(); } + const Eigen::VectorXcd &get_excitation() const { return excitation_; } + ////////////////////////////////////////////////////////////////////////////// + // private member variables + ////////////////////////////////////////////////////////////////////////////// + private: + Eigen::VectorXcd excitation_; + + DiscreteLinearForm disc_lf_; + AnsatzSpace ansatz_space_; + + int dofs_scalar_; + int dofs_vector_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_AUGMENTEDEFIEEXCITATION_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/EFIE.hpp b/unsupported/Bembel/src/AugmentedEFIE/EFIE.hpp new file mode 100644 index 000000000..78d692d40 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/EFIE.hpp @@ -0,0 +1,115 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_EFIE_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_EFIE_HPP_ + +namespace Bembel { +// forward declaration of class EFIE in order to define +// traits +template +class EFIE; + +template +struct PotentialTraits> { + typedef Eigen::VectorXcd::Scalar Scalar; + static constexpr int OutputSpaceDimension = 3; +}; + +/** + * \ingroup AugmentedEFIE + */ +template +class EFIE : public PotentialBase, LinOp> { + // implementation of the kernel evaluation, which may be based on the + // information available from the superSpace + public: + EFIE() {} + Eigen::Matrix::Scalar, + std::complex>::Scalar, + 3, 1> + evaluateIntegrand_impl(const FunctionEvaluator &fun_ev, + const ElementTreeNode &element, + const Eigen::Vector3d &point, + const SurfacePoint &p) const { + // get evaluation points on unit square + auto s = p.segment<2>(0); + + // get quadrature weights + auto ws = p(2); + + // get points on geometry and tangential derivatives + auto x_f = p.segment<3>(3); + + // compute surface measures from tangential derivatives + auto h = element.get_h(); + + // evaluate kernel + auto kernel = evaluateKernel(point, x_f); + auto kernel_gradient = evaluateKernelGrad(point, x_f); + + // assemble Galerkin solution + auto scalar_part = fun_ev.evaluate(element, p); + auto divergence_part = fun_ev.evaluateDiv(element, p); + + // integrand without basis functions, note that the surface measure + // disappears for the divergence + std::complex omega = + wavenumber_ / std::sqrt(Constants::mu0 * Constants::eps0); + auto integrand = -(std::complex(0., 1.) * omega * Constants::mu0 * + kernel * scalar_part - + kernel_gradient * divergence_part / Constants::eps0 / + std::complex(0., 1.) / omega) * + ws; + + return integrand; + } + + /** + * \brief Fundamental solution of Helmholtz problem + */ + std::complex evaluateKernel(const Eigen::Vector3d &x, + const Eigen::Vector3d &y) const { + auto r = (x - y).norm(); + return std::exp(-std::complex(0., 1.) * wavenumber_ * r) / 4. / + BEMBEL_PI / r; + } + /** + * \brief Gradient of fundamental solution of Helmholtz problem + */ + Eigen::VectorXcd evaluateKernelGrad(const Eigen::Vector3d &x, + const Eigen::Vector3d &y) const { + auto c = x - y; + auto r = c.norm(); + auto r3 = r * r * r; + auto i = std::complex(0., 1.); + return (std::exp(-i * wavenumber_ * r) * (-1. - i * wavenumber_ * r) / 4. / + BEMBEL_PI / r3) * + c; + } + ////////////////////////////////////////////////////////////////////////////// + // setters + ////////////////////////////////////////////////////////////////////////////// + void set_wavenumber(std::complex wavenumber) { + wavenumber_ = wavenumber; + } + ////////////////////////////////////////////////////////////////////////////// + // getters + ////////////////////////////////////////////////////////////////////////////// + std::complex get_wavenumber() { return wavenumber_; } + + private: + std::complex wavenumber_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_EFIE_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/GradScalarPotential.hpp b/unsupported/Bembel/src/AugmentedEFIE/GradScalarPotential.hpp new file mode 100644 index 000000000..68db775b8 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/GradScalarPotential.hpp @@ -0,0 +1,100 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_GRADSCALARPOTENTIAL_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_GRADSCALARPOTENTIAL_HPP_ + +namespace Bembel { +// forward declaration of class GradScalarPotential in order to define +// traits +template +class GradScalarPotential; + +template +struct PotentialTraits> { + typedef Eigen::VectorXcd::Scalar Scalar; + static constexpr int OutputSpaceDimension = 3; +}; + +/** + * \ingroup AugmentedEFIE + */ +template +class GradScalarPotential + : public PotentialBase, LinOp> { + // implementation of the kernel evaluation, which may be based on the + // information available from the superSpace + public: + GradScalarPotential() {} + Eigen::Matrix::Scalar, + std::complex>::Scalar, + 3, 1> + evaluateIntegrand_impl(const FunctionEvaluator &fun_ev, + const ElementTreeNode &element, + const Eigen::Vector3d &point, + const SurfacePoint &p) const { + // get evaluation points on unit square + auto s = p.segment<2>(0); + + // get quadrature weights + auto ws = p(2); + + // get points on geometry and tangential derivatives + auto x_f = p.segment<3>(3); + auto x_f_dx = p.segment<3>(6); + auto x_f_dy = p.segment<3>(9); + + // compute surface measures from tangential derivatives + auto x_kappa = x_f_dx.cross(x_f_dy).norm(); + + // evaluate gradient of kernel + auto kernel_gradient = evaluateKernelGrad(point, x_f); + + // assemble Galerkin solution + auto cauchy_data = fun_ev.evaluate(element, p); + + // integrand without basis functions, note that the surface measure + // disappears for the divergence + auto integrand = kernel_gradient * cauchy_data * ws * x_kappa; + + return integrand; + } + /** + * \brief Gradient of fundamental solution of Helmholtz problem + */ + Eigen::VectorXcd evaluateKernelGrad(const Eigen::Vector3d &x, + const Eigen::Vector3d &y) const { + auto c = x - y; + auto r = c.norm(); + auto r3 = r * r * r; + auto i = std::complex(0., 1.); + return (std::exp(-i * wavenumber_ * r) * (-1. - i * wavenumber_ * r) / 4. / + BEMBEL_PI / r3) * + c; + } + ////////////////////////////////////////////////////////////////////////////// + // setters + ////////////////////////////////////////////////////////////////////////////// + void set_wavenumber(std::complex wavenumber) { + wavenumber_ = wavenumber; + } + ////////////////////////////////////////////////////////////////////////////// + // getters + ////////////////////////////////////////////////////////////////////////////// + std::complex get_wavenumber() { return wavenumber_; } + + private: + std::complex wavenumber_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_GRADSCALARPOTENTIAL_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/IncidenceMatrix.hpp b/unsupported/Bembel/src/AugmentedEFIE/IncidenceMatrix.hpp new file mode 100644 index 000000000..d173bbc26 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/IncidenceMatrix.hpp @@ -0,0 +1,150 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_INCIDENCEMATRIX_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_INCIDENCEMATRIX_HPP_ + +namespace Bembel { +/** + * \ingroup AugmentedEFIE + */ +template +class IncidenceMatrix { + typedef Eigen::SparseMatrix::Scalar> + MatrixType; + typedef Eigen::Matrix::Scalar, + Eigen::Dynamic, 1> + VectorType; + + public: + ////////////////////////////////////////////////////////////////////////////// + // constructors + ////////////////////////////////////////////////////////////////////////////// + IncidenceMatrix() {} + IncidenceMatrix(const AnsatzSpace &ansatz_space_vec, + const AnsatzSpace &ansatz_space) { + static_assert( + std::is_same< + typename LinearOperatorTraits::Scalar, + typename LinearOperatorTraits::Scalar>::value && + "Scalar Types need to be equal"); + init_IncidenceMatrix(ansatz_space_vec, ansatz_space); + } + ////////////////////////////////////////////////////////////////////////////// + // init_IncidenceMatrix + ////////////////////////////////////////////////////////////////////////////// + void init_IncidenceMatrix(const AnsatzSpace &ansatz_space_vec, + const AnsatzSpace &ansatz_space) { + ansatz_space_vec_ = ansatz_space_vec; + ansatz_space_ = ansatz_space; + return; + } + ////////////////////////////////////////////////////////////////////////////// + // compute + ////////////////////////////////////////////////////////////////////////////// + void compute() { + const SuperSpace &super_space_vec = + ansatz_space_vec_.get_superspace(); + const SuperSpace &super_space = ansatz_space_.get_superspace(); + const auto &element_tree = super_space.get_mesh().get_element_tree(); + + // Quadrature + GaussSquare<20> GS; + Cubature Q = GS[19]; + const auto &number_of_elements = element_tree.get_number_of_elements(); + const auto polynomial_degree_plus_one_squared_vec = + super_space_vec.get_polynomial_degree_plus_one_squared(); + const auto polynomial_degree_plus_one_squared = + super_space.get_polynomial_degree_plus_one_squared(); + + // Triplets + typedef Eigen::Triplet::Scalar> T; + std::vector tripletList; + tripletList.reserve(2 * polynomial_degree_plus_one_squared_vec * + polynomial_degree_plus_one_squared * + number_of_elements); + + // Iterate over elements + for (auto element = element_tree.cpbegin(); element != element_tree.cpend(); + ++element) { + Eigen::Matrix::Scalar, + Eigen::Dynamic, Eigen::Dynamic> + intval(2 * polynomial_degree_plus_one_squared_vec, + polynomial_degree_plus_one_squared); + intval.setZero(); + // Iterate over quadrature points + for (auto i = 0; i < Q.w_.size(); ++i) { + SurfacePoint qp; + super_space.map2surface(*element, Q.xi_.col(i), Q.w_(i), &qp); + evaluateIntegrand(super_space_vec, super_space, qp, &intval); + } + // Transform local element matrices to triplets + for (auto jj = 0; jj < polynomial_degree_plus_one_squared; ++jj) + for (auto i = 0; i < 2; ++i) + for (auto ii = 0; ii < polynomial_degree_plus_one_squared_vec; ++ii) + tripletList.push_back( + T(polynomial_degree_plus_one_squared_vec * + (i * number_of_elements + element->id_) + + ii, + polynomial_degree_plus_one_squared * element->id_ + jj, + intval(i * polynomial_degree_plus_one_squared_vec + ii, jj))); + } + incidence_matrix_.resize( + 2 * polynomial_degree_plus_one_squared_vec * number_of_elements, + polynomial_degree_plus_one_squared * number_of_elements); + incidence_matrix_.setFromTriplets(tripletList.begin(), tripletList.end()); + auto projector_vec = ansatz_space_vec_.get_transformation_matrix(); + auto projector = ansatz_space_.get_transformation_matrix(); + incidence_matrix_ = + projector_vec.transpose() * (incidence_matrix_ * projector); + return; + } + ////////////////////////////////////////////////////////////////////////////// + // getter + ////////////////////////////////////////////////////////////////////////////// + const MatrixType &get_incidence_matrix() const { return incidence_matrix_; } + ////////////////////////////////////////////////////////////////////////////// + // private member variables + ////////////////////////////////////////////////////////////////////////////// + private: + template + void evaluateIntegrand( + const T_vec &super_space_vec, const T &super_space, const SurfacePoint &p, + Eigen::Matrix::Scalar, + Eigen::Dynamic, Eigen::Dynamic> *intval) { + const auto polynomial_degree_plus_one_squared_vec = + super_space_vec.get_polynomial_degree_plus_one_squared(); + + // const auto polynomial_degree_plus_one_squared = + // super_space.get_polynomial_degree_plus_one_squared(); + VectorType intval_scal = + super_space.basis(p.segment<2>(0)).array().real(); + VectorType intval_dx = super_space_vec.basisDx(p.segment<2>(0)); + VectorType intval_dy = super_space_vec.basisDy(p.segment<2>(0)); + VectorType intval_div(2 * polynomial_degree_plus_one_squared_vec); + intval_div << intval_dx, intval_dy; + + // get basic information + const unsigned int elements_per_direction = + (1 << super_space.get_refinement_level()); + const double h = 1. / ((double)(elements_per_direction)); + + // compute surface measures from tangential derivatives + double x_kappa = p.segment<3>(6).cross(p.segment<3>(9)).norm(); + double w = p(2) / h; + intval[0] += w * intval_div * intval_scal.transpose(); + } + MatrixType incidence_matrix_; + AnsatzSpace ansatz_space_vec_; + AnsatzSpace ansatz_space_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_INCIDENCEMATRIX_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/InductanceMatrix.hpp b/unsupported/Bembel/src/AugmentedEFIE/InductanceMatrix.hpp new file mode 100644 index 000000000..75a8869c7 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/InductanceMatrix.hpp @@ -0,0 +1,100 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2023 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_INDUCTANCEMATRIX_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_INDUCTANCEMATRIX_HPP_ + +namespace Bembel { +// forward declaration of class InductanceMatrix in order to define +// traits +class InductanceMatrix; + +template <> +struct LinearOperatorTraits { + typedef Eigen::VectorXcd EigenType; + typedef Eigen::VectorXcd::Scalar Scalar; + enum { + OperatorOrder = -1, + Form = DifferentialForm::DivConforming, + NumberOfFMMComponents = 2 + }; +}; + +/** + * \ingroup AugmentedEFIE + */ +class InductanceMatrix : public LinearOperatorBase { + // implementation of the kernel evaluation, which may be based on the + // information available from the superSpace + public: + InductanceMatrix() {} + template + void evaluateIntegrand_impl( + const T &super_space, const SurfacePoint &p1, const SurfacePoint &p2, + Eigen::Matrix::Scalar, + Eigen::Dynamic, Eigen::Dynamic> *intval) const { + auto polynomial_degree = super_space.get_polynomial_degree(); + auto polynomial_degree_plus_one_squared = + (polynomial_degree + 1) * (polynomial_degree + 1); + + // get evaluation points on unit square + auto s = p1.segment<2>(0); + auto t = p2.segment<2>(0); + + // get quadrature weights + auto ws = p1(2); + auto wt = p2(2); + + // get points on geometry and tangential derivatives + auto x_f = p1.segment<3>(3); + auto x_f_dx = p1.segment<3>(6); + auto x_f_dy = p1.segment<3>(9); + auto y_f = p2.segment<3>(3); + auto y_f_dx = p2.segment<3>(6); + auto y_f_dy = p2.segment<3>(9); + + // integrand without basis functions + auto kernel_evaluation = evaluateKernel(x_f, y_f) * ws * wt; + auto integrand_vector = kernel_evaluation; + + // vector part: mulitply shape functions with integrand and add to buffer + super_space.addScaledVectorBasisInteraction(intval, integrand_vector, s, t, + x_f_dx, x_f_dy, y_f_dx, y_f_dy); + + return; + } + + /** + * \brief Fundamental solution of Helmholtz/Maxwell problem + */ + std::complex evaluateKernel(const Eigen::Vector3d &x, + const Eigen::Vector3d &y) const { + auto r = (x - y).norm(); + return std::exp(-std::complex(0., 1.) * wavenumber_ * r) / 4. / + BEMBEL_PI / r; + } + ////////////////////////////////////////////////////////////////////////////// + // setters + ////////////////////////////////////////////////////////////////////////////// + void set_wavenumber(std::complex wavenumber) { + wavenumber_ = wavenumber; + } + ////////////////////////////////////////////////////////////////////////////// + // getters + ////////////////////////////////////////////////////////////////////////////// + std::complex get_wavenumber() { return wavenumber_; } + + private: + std::complex wavenumber_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_INDUCTANCEMATRIX_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/MixedEFIE.hpp b/unsupported/Bembel/src/AugmentedEFIE/MixedEFIE.hpp new file mode 100644 index 000000000..a19d60cf3 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/MixedEFIE.hpp @@ -0,0 +1,91 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_MIXEDEFIE_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_MIXEDEFIE_HPP_ + +namespace Bembel { +// forward declaration of class MixedEFIE in order to define +// traits + +/** + * \ingroup AugmentedEFIE + */ +template +class MixedEFIE { + // implementation of the kernel evaluation, which may be based on the + // information available from the superSpace + public: + MixedEFIE() {} + MixedEFIE(AnsatzSpace ansatz_space_vector, + AnsatzSpace ansatz_space_scalar) { + init_MixedEFIE(ansatz_space_vector, ansatz_space_scalar); + } + + void init_MixedEFIE(AnsatzSpace ansatz_space_vector, + AnsatzSpace ansatz_space_scalar) { + ansatz_space_vector_ = ansatz_space_vector; + ansatz_space_scalar_ = ansatz_space_scalar; + } + + Eigen::Matrix, -1, 3> evaluate( + const Eigen::Matrix &points) { + // Define the two parts of the EFIE each as Potential -> new classes + DiscretePotential, LinOpVector> A( + ansatz_space_vector_); + DiscretePotential, LinOpScalar> grad_phi( + ansatz_space_scalar_); + + // Set wave number + A.get_potential().set_wavenumber(wavenumber_); + grad_phi.get_potential().set_wavenumber(wavenumber_); + + // Set cauchy data + A.set_cauchy_data(current_); + grad_phi.set_cauchy_data(charges_); + + // Compute each contribution to the potential + Eigen::Matrix, -1, 3> potential(points.rows(), 3); + potential.setZero(); + potential = -std::complex(0., 1.) * omega_ * Constants::mu0 * + A.evaluate(points); + potential -= grad_phi.evaluate(points) / Constants::eps0; + + return potential; + } + ////////////////////////////////////////////////////////////////////////////// + // setters + ////////////////////////////////////////////////////////////////////////////// + void set_omega(double omega) { omega_ = omega; } + void set_wavenumber(std::complex wavenumber) { + wavenumber_ = wavenumber; + } + void set_current(Eigen::VectorXcd current) { current_ = current; } + void set_charges(Eigen::VectorXcd charges) { charges_ = charges; } + ////////////////////////////////////////////////////////////////////////////// + // getters + ////////////////////////////////////////////////////////////////////////////// + double get_omega() { return omega_; } + std::complex get_wavenumber() { return wavenumber_; } + Eigen::VectorXcd get_current() { return current_; } + Eigen::VectorXcd get_charges() { return charges_; } + + private: + AnsatzSpace ansatz_space_vector_; + AnsatzSpace ansatz_space_scalar_; + Eigen::VectorXcd current_; + Eigen::VectorXcd charges_; + double omega_; + std::complex wavenumber_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_MIXEDEFIE_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/VectorPotential.hpp b/unsupported/Bembel/src/AugmentedEFIE/VectorPotential.hpp new file mode 100644 index 000000000..fa9dce642 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/VectorPotential.hpp @@ -0,0 +1,91 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_VECTORPOTENTIAL_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_VECTORPOTENTIAL_HPP_ + +namespace Bembel { +// forward declaration of class VectorPotential in order to define +// traits +template +class VectorPotential; + +template +struct PotentialTraits> { + typedef Eigen::VectorXcd::Scalar Scalar; + static constexpr int OutputSpaceDimension = 3; +}; + +/** + * \ingroup AugmentedEFIE + */ +template +class VectorPotential : public PotentialBase, LinOp> { + // implementation of the kernel evaluation, which may be based on the + // information available from the superSpace + public: + VectorPotential() {} + Eigen::Matrix::Scalar, + std::complex>::Scalar, + 3, 1> + evaluateIntegrand_impl(const FunctionEvaluator &fun_ev, + const ElementTreeNode &element, + const Eigen::Vector3d &point, + const SurfacePoint &p) const { + // get evaluation points on unit square + auto s = p.segment<2>(0); + + // get quadrature weights + auto ws = p(2); + + // get points on geometry and tangential derivatives + auto x_f = p.segment<3>(3); + + // evaluate kernel + auto kernel = evaluateKernel(point, x_f); + + // assemble Galerkin solution + auto scalar_part = fun_ev.evaluate(element, p); + + // integrand without basis functions, note that the surface measure + // disappears for the divergence + auto integrand = kernel * scalar_part * ws; + + return integrand; + } + + /** + * \brief Fundamental solution of Helmholtz problem + */ + std::complex evaluateKernel(const Eigen::Vector3d &x, + const Eigen::Vector3d &y) const { + auto r = (x - y).norm(); + return std::exp(-std::complex(0., 1.) * wavenumber_ * r) / 4. / + BEMBEL_PI / r; + } + ////////////////////////////////////////////////////////////////////////////// + // setters + ////////////////////////////////////////////////////////////////////////////// + void set_wavenumber(std::complex wavenumber) { + wavenumber_ = wavenumber; + } + ////////////////////////////////////////////////////////////////////////////// + // getters + ////////////////////////////////////////////////////////////////////////////// + std::complex get_wavenumber() { return wavenumber_; } + + private: + std::complex wavenumber_; +}; + +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_VECTORPOTENTIAL_HPP_ diff --git a/unsupported/Bembel/src/AugmentedEFIE/VoltageSource.hpp b/unsupported/Bembel/src/AugmentedEFIE/VoltageSource.hpp new file mode 100644 index 000000000..49d0ec238 --- /dev/null +++ b/unsupported/Bembel/src/AugmentedEFIE/VoltageSource.hpp @@ -0,0 +1,33 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. +#ifndef BEMBEL_SRC_AUGMENTEDEFIE_VOLTAGESOURCE_HPP_ +#define BEMBEL_SRC_AUGMENTEDEFIE_VOLTAGESOURCE_HPP_ + +namespace Bembel { +/** + * \brief Struct to handle the geometry information of the excitation by a + * voltage source. + * + * The vector contains all patches of the positive and negative pole + * respectively. The first entry of the array is the patch number whereas the + * second entry corresponds to the edge case which is connected to the voltage + * source. + +/** + * \ingroup AugmentedEFIE + * + */ +struct VoltageSource { + std::vector> positive_; + std::vector> negative_; +}; +} // namespace Bembel +#endif // BEMBEL_SRC_AUGMENTEDEFIE_VOLTAGESOURCE_HPP_ diff --git a/unsupported/CMakeLists.txt b/unsupported/CMakeLists.txt new file mode 100644 index 000000000..4803b8d44 --- /dev/null +++ b/unsupported/CMakeLists.txt @@ -0,0 +1,2 @@ +add_subdirectory(Bembel) +add_subdirectory(examples) diff --git a/unsupported/CPPLINT.cfg b/unsupported/CPPLINT.cfg new file mode 100644 index 000000000..56ef7f6d9 --- /dev/null +++ b/unsupported/CPPLINT.cfg @@ -0,0 +1,22 @@ +# This file is part of Bembel, the higher order C++ boundary element library. +# +# Copyright (C) 2024 see +# +# It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +# M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +# Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +# source code is subject to the GNU General Public License version 3 and +# provided WITHOUT ANY WARRANTY, see for further +# information. + +# Stop searching for additional config files. +# set noparent + +# Omit unsupported folder in header guard +root=../unsupported + +# For better readability using declarations are utilized +filter=-build/namespaces + +# For better readability using declarations are utilized +# filter=-build/header_guard diff --git a/unsupported/README.md b/unsupported/README.md new file mode 100644 index 000000000..a119d1343 --- /dev/null +++ b/unsupported/README.md @@ -0,0 +1,11 @@ +This directory contains contributions from various users. +They are provided "as is", without any support. Nevertheless, +most of them are subject to be included in Bembel in the future. + +In order to use an unsupported module you have to do either: + + - add the path_to_bembel/unsupported directory to your include path and do: + #include + + - or directly do: + #include \ No newline at end of file diff --git a/unsupported/examples/AugmentedEFIE.cpp b/unsupported/examples/AugmentedEFIE.cpp new file mode 100644 index 000000000..9f8b86ae6 --- /dev/null +++ b/unsupported/examples/AugmentedEFIE.cpp @@ -0,0 +1,120 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#include +#include +#include +#include + +#include "examples/Data.hpp" +#include "examples/Error.hpp" +#include "examples/Grids.hpp" + +/** + * \ingroup Examples + * \defgroup AugmentedEFIEDipole Augmented Electric Field Integral Equation + * + * \brief This example uses the A-EFIE method to solve a scattering problem. + * + * This example sets up an academic example to apply the A-EFIE method to a + * problem where the analytical solution is known. A dipole is placed inside + * the unit sphere. + * The scattered field in the exterior is computed with the A-EFIE formulation. + * This is a mixed problem which is discretized with higher-order B-splines + * whereas the geometry is represented with NURBS functions. + */ + +int main() { + using namespace Bembel; + using namespace Eigen; + + const int refinement_level_max = 4; + const int polynomial_degree_max = 3; + + // set up excitation + double wavenumber_re = + 2 * BEMBEL_PI * 30e6 * std::sqrt(Constants::mu0 * Constants::eps0); + std::complex wavenumber = std::complex(wavenumber_re, 0.0); + + Vector3cd k(0, 0, wavenumber); + Vector3cd E0(1, 0, 0); + // Define analytical solution using lambda function, in this case a dipole + // centered on 0, see Data.hpp + const std::function fun = [wavenumber](Vector3d pt) { + return Data::Dipole(pt, wavenumber, Vector3d(0.2, 0.2, 0.2), + Vector3d(0., 0.1, 0.1)); + }; + + Geometry geometry("sphere.dat"); + + // Define evaluation points for scattered field, sphere of radius 2 + MatrixXd gridpoints = Util::makeSphereGrid(2., 5); + + std::cout << "\n" << std::string(60, '=') << "\n"; + for (int polynomial_degree = 1; polynomial_degree < polynomial_degree_max + 1; + ++polynomial_degree) { + VectorXd error(refinement_level_max + 1); + + IO::Logger<10> logger( + "Dipole_P" + std::to_string(polynomial_degree) + ".txt", ","); + logger.file("refinement_level", "dofs", "error"); + for (int refinement_level = 0; refinement_level <= refinement_level_max; + ++refinement_level) { + std::cout << "Degree " << polynomial_degree << " Level " + << refinement_level << "\t\t"; + + // set up vector valued ansatz space + AnsatzSpace ansatz_space_vector( + geometry, refinement_level, polynomial_degree); + + // set up matrix + AugmentedEFIE augmented_efie( + ansatz_space_vector, geometry); + augmented_efie.set_wavenumber(wavenumber); + augmented_efie.compute(); + + // assemble the right hand side + AugmentedEFIEExcitation>, + InductanceMatrix> + excitation(ansatz_space_vector, augmented_efie.get_dofs_scalar()); + excitation.get_linear_form().set_function(fun); + excitation.compute(); + + // solve system + PartialPivLU lu; + lu.compute(augmented_efie.get_system_matrix()); + VectorXcd u = lu.solve(excitation.get_excitation()); + VectorXcd j = u.head(augmented_efie.get_dofs_vector()); + + // evaluate potential + DiscretePotential, InductanceMatrix> disc_pot( + ansatz_space_vector); + disc_pot.get_potential().set_wavenumber(wavenumber); + disc_pot.set_cauchy_data(j); + auto pot = disc_pot.evaluate(gridpoints); + + // compute reference, print time, and compute error + MatrixXcd pot_ref(gridpoints.rows(), 3); + for (int i = 0; i < gridpoints.rows(); ++i) + pot_ref.row(i) = fun(gridpoints.row(i)); + error(refinement_level) = (pot - pot_ref).rowwise().norm().maxCoeff(); + const int dofs_total = + augmented_efie.get_dofs_scalar() + augmented_efie.get_dofs_vector(); + logger.file(refinement_level, dofs_total, error(refinement_level)); + + std::cout << error(refinement_level) << std::endl; + } + assert(checkRateOfConvergence(error.tail(2), 2 * polynomial_degree, 0.9)); + std::cout << std::endl; + } + std::cout << std::string(60, '=') << std::endl; + return 0; +} diff --git a/unsupported/examples/AugmentedEFIEBalun.cpp b/unsupported/examples/AugmentedEFIEBalun.cpp new file mode 100644 index 000000000..af0720140 --- /dev/null +++ b/unsupported/examples/AugmentedEFIEBalun.cpp @@ -0,0 +1,120 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#include +#include +#include +#include + +#include "examples/Data.hpp" +#include "examples/Error.hpp" +#include "examples/Grids.hpp" + +/** + * \ingroup Examples + * \defgroup AugmentedEFIEBalun A-EFIE Application to Balun Spiral Antenna + * + * \brief This example simulates an application example with the A-EFIE method. + * + * The geometric model contains a complex geometry with significant curvature. + * The simulation with the higher-order spline-based A-EFIE minimizes unwanted + * reflections due to the numerical computation. This facilitates the design of + * the component of interest. + */ + +template +class logspace { + private: + t curvalue, base; + + public: + logspace(t first, t base) : curvalue(first), base(base) {} + + t operator()() { + t retval = curvalue; + curvalue *= base; + return retval; + } +}; + +int main() { + using namespace Bembel; + using namespace Eigen; + + const int refinement_level = 1; + const int polynomial_degree = 1; + + const double f_min = 250e6; + const double base = 1.0064; + const int N = 1000; + std::vector frequencies; + std::generate_n(std::back_inserter(frequencies), N, + logspace(f_min, base)); + + std::cout << "Number of Frequency Samples: " << frequencies.size() + << std::endl; + + IO::Logger<10> logger("Balun_M" + std::to_string(refinement_level) + ".txt", + ","); + logger.file("frequency", "Zmag", "Zphase"); + + Geometry geometry("balun_spiral.dat"); + + VoltageSource source; + + source.positive_ = {{4, 1}, {5, 1}, {6, 1}, {7, 1}, {8, 1}, {9, 1}}; + source.negative_ = {{0, 1}, {1, 1}, {2, 2}, {3, 2}}; + + AnsatzSpace ansatz_space_vector(geometry, refinement_level, + polynomial_degree); + + AugmentedEFIE augmented_efie( + ansatz_space_vector, geometry); + + std::cout << "\n" << std::string(60, '=') << "\n"; + for (auto f = frequencies.begin(); f != frequencies.end(); ++f) { + std::cout << std::string(60, '=') + "\nStarting Sample: " + << std::to_string(f - frequencies.begin()) << " @ " << *f << "Hz" + << std::endl; + double omega = 2 * BEMBEL_PI * *f; + std::complex wavenumber = std::complex( + omega * std::sqrt(Constants::mu0 * Constants::eps0), 0.0); + + augmented_efie.set_wavenumber(wavenumber); + augmented_efie.compute(source); + + const int dofs_vector = augmented_efie.get_dofs_vector(); + const int dofs_scalar = augmented_efie.get_dofs_scalar(); + const int dofs_total = augmented_efie.get_system_matrix().cols(); + + // Define Excitation by Voltage Source + Eigen::VectorXcd rhs = Eigen::VectorXcd::Zero(dofs_total); + rhs(dofs_vector + dofs_scalar) = 1; + + // Solve System + PartialPivLU lu; + lu.compute(augmented_efie.get_system_matrix()); + VectorXcd u = lu.solve(rhs); + VectorXcd j = u.head(dofs_vector); + + int correction = (1 << refinement_level) * (1 << refinement_level); + // Compute Impedance + std::complex Z = (u(dofs_total - 2) - u(dofs_total - 1)) / + u(dofs_vector + dofs_scalar) * + (double)(correction); + + std::cout << "Impedance: " << std::abs(Z) << std::endl; + + logger.file(*f, std::abs(Z), std::arg(Z) * 180 / BEMBEL_PI); + } + std::cout << "\n" << std::string(60, '=') << "\n"; + return 0; +} diff --git a/unsupported/examples/AugmentedEFIEStabilized.cpp b/unsupported/examples/AugmentedEFIEStabilized.cpp new file mode 100644 index 000000000..b7bbde432 --- /dev/null +++ b/unsupported/examples/AugmentedEFIEStabilized.cpp @@ -0,0 +1,201 @@ +// This file is part of Bembel, the higher order C++ boundary element library. +// +// Copyright (C) 2024 see +// +// It was written as part of a cooperation of J. Doelz, H. Harbrecht, S. Kurz, +// M. Multerer, S. Schoeps, and F. Wolf at Technische Universitaet Darmstadt, +// Universitaet Basel, and Universita della Svizzera italiana, Lugano. This +// source code is subject to the GNU General Public License version 3 and +// provided WITHOUT ANY WARRANTY, see for further +// information. + +#include +#include +#include +#include + +#include "examples/Data.hpp" +#include "examples/Error.hpp" +#include "examples/Grids.hpp" + +/** + * \ingroup Examples + * \defgroup AugmentedEFIEStabilized A-EFIE Low Frequency Stabilization + * + * \brief This example uses the A-EFIE method to solve a scattering problem. + * + * This example sets up an academic example to apply the A-EFIE method to a + * problem where the analytical solution is known. A dipole is placed inside + * the unit sphere. + * Low frequency stability is demonstrated by applying the deflation method. + */ + +template +class logspace { + private: + t curvalue, base; + + public: + logspace(t first, t base) : curvalue(first), base(base) {} + + t operator()() { + t retval = curvalue; + curvalue *= base; + return retval; + } +}; + +int main() { + using namespace Bembel; + using namespace Eigen; + + const int refinement_level = 3; + const int polynomial_degree_max = 3; + + const double f_min = 1e-9; + const double base = 3; + const int N = 40; + std::vector frequencies; + std::generate_n(std::back_inserter(frequencies), N + 1, + logspace(f_min, base)); + + std::cout << "f_min: " << f_min << std::endl; + std::cout << "f_max: " << frequencies[frequencies.size() - 1] << std::endl; + std::cout << "size: " << frequencies.size() << std::endl; + + Geometry geometry("sphere.dat"); + + // Define evaluation points for scattered field, sphere of radius 2 + MatrixXd gridpoints = Util::makeSphereGrid(2., 5); + + std::cout << "\n" << std::string(60, '=') << "\n"; + for (int polynomial_degree = 1; polynomial_degree < polynomial_degree_max + 1; + ++polynomial_degree) { + std::string filename = "Dipole_P" + std::to_string(polynomial_degree) + + "M" + std::to_string(refinement_level); + + IO::Logger<10> logger(filename + ".txt", ","); + logger.file("f", "original_condition", "original_pw_error", + "stabilized_condition", "stabilized_pw_error"); + std::cout << "Degree " << polynomial_degree << " Level " << refinement_level + << std::endl; + for (auto f = frequencies.begin(); f != frequencies.end(); ++f) { + std::cout << std::setprecision(1) << std::scientific << *f << "Hz\t"; + + // set up excitation + double omega = 2 * BEMBEL_PI * *f; + double wavenumber_re = + omega * std::sqrt(Constants::mu0 * Constants::eps0); + std::complex wavenumber = + std::complex(wavenumber_re, 0.0); + + Vector3cd k(0, 0, wavenumber); + Vector3cd E0(1, 0, 0); + // Define analytical solution using lambda function, in this case a dipole + // centered on 0, see Data.hpp + const std::function fun = [wavenumber](Vector3d pt) { + return Data::Dipole(pt, wavenumber, Vector3d(0.2, 0.2, 0.2), + Vector3d(0., 0.1, 0.1)); + }; + + // set up vector valued ansatz space + AnsatzSpace ansatz_space_vector( + geometry, refinement_level, polynomial_degree); + + // set up matrix + AugmentedEFIE augmented_efie( + ansatz_space_vector, geometry); + augmented_efie.set_wavenumber(wavenumber); + augmented_efie.set_omega(omega); + augmented_efie.compute(); + + // assemble the right hand side + AugmentedEFIEExcitation>, + InductanceMatrix> + excitation(ansatz_space_vector, augmented_efie.get_dofs_scalar()); + excitation.get_linear_form().set_function(fun); + excitation.compute(); + + // prepare post processing + DiscreteLocalOperator mass_matrix( + augmented_efie.get_ansatz_space_mass()); + mass_matrix.compute(); + MatrixXcd M = MatrixXcd(mass_matrix.get_discrete_operator()); + DiscreteOperator cap_matrix( + augmented_efie.get_ansatz_space_scalar()); + cap_matrix.get_linear_operator().set_wavenumber(wavenumber); + cap_matrix.compute(); + MatrixXcd P = cap_matrix.get_discrete_operator() / Constants::eps0; + PartialPivLU lu_P; + lu_P.compute(P); + + // solve the system, compute error and condition number + double condition_original, condition_stabilized; + double error_original, error_stabilized; + for (auto simulation = 0; simulation < 2; ++simulation) { + bool stabilized = false; + if (simulation == 1) { + stabilized = true; + } + + // apply stabilization + if (stabilized) { + augmented_efie.stabilize(); + } + + // solve system + PartialPivLU lu; + lu.compute(augmented_efie.get_system_matrix()); + VectorXcd u = lu.solve(excitation.get_excitation()); + VectorXcd j = u.head(augmented_efie.get_dofs_vector()); + VectorXcd phi = u.tail(augmented_efie.get_dofs_scalar()); + + // correct stabilization in right hand side + if (stabilized) { + j *= 1. / (omega * std::complex(0., 1.) * Constants::mu0); + } + + // post processing + VectorXcd q_post = lu_P.solve(-M * phi); + + MixedEFIE efie( + ansatz_space_vector, augmented_efie.get_ansatz_space_scalar()); + + efie.set_omega(omega); + efie.set_wavenumber(wavenumber); + efie.set_current(j); + efie.set_charges(q_post); + + auto pot = efie.evaluate(gridpoints); + + // compute reference solution + MatrixXcd pot_ref(gridpoints.rows(), 3); + for (int i = 0; i < gridpoints.rows(); ++i) + pot_ref.row(i) = fun(gridpoints.row(i)); + double error = (pot - pot_ref).rowwise().norm().maxCoeff(); + + // compute condition number + JacobiSVD svd(augmented_efie.get_system_matrix()); + double cond = + std::abs(svd.singularValues()(0) / + svd.singularValues()(svd.singularValues().size() - 1)); + + if (stabilized) { + std::cout << "\t\t(stabilized) Error:\t"; + error_stabilized = error; + condition_stabilized = cond; + } else { + std::cout << "(original) Error:\t"; + error_original = error; + condition_original = cond; + } + + std::cout << error << "\tCondition number:\t" << cond << std::endl; + } + logger.file(*f, condition_original, error_original, condition_stabilized, + error_stabilized); + } + } + std::cout << std::string(60, '=') << std::endl; + return 0; +} diff --git a/unsupported/examples/CMakeLists.txt b/unsupported/examples/CMakeLists.txt new file mode 100644 index 000000000..546a27c18 --- /dev/null +++ b/unsupported/examples/CMakeLists.txt @@ -0,0 +1,15 @@ + +############################################################################### +# examples not being run from CI +############################################################################### + +set(OTHER_NOCIFILES + AugmentedEFIE + AugmentedEFIEStabilized + AugmentedEFIEBalun + ) + +foreach(file IN LISTS OTHER_NOCIFILES) + add_executable(${file} ${file}.cpp) + target_link_libraries(${file} Eigen3::Eigen) +endforeach() diff --git a/unsupported/geo/balun_spiral.dat b/unsupported/geo/balun_spiral.dat new file mode 100644 index 000000000..1ceb3be4b --- /dev/null +++ b/unsupported/geo/balun_spiral.dat @@ -0,0 +1,2444 @@ +# nurbs mesh v.2.1 +# +# +# +2 3 271 0 0 +PATCH 1 +1 14 +2 15 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000820000000000 0.000620000000000 0.000785689651510 0.000594058029191 0.000747646829162 0.000565293944001 0.000705871532955 0.000533707744429 0.000660363762889 0.000499299430477 0.000611123518965 0.000462069002144 0.000558150801181 0.000422016459430 0.000501445609539 0.000379141802335 0.000441007944038 0.000333445030858 0.000376837804679 0.000284926145001 0.000308935191461 0.000233585144763 0.000237300104384 0.000179422030144 0.000161932543448 0.000122436801143 0.000082832508653 0.000062629457762 0.000000000000000 0.000000000000000 +0.000000000000000 0.000000000000000 0.000082832508653 0.000062629457762 0.000161932543448 0.000122436801143 0.000237300104384 0.000179422030144 0.000308935191461 0.000233585144763 0.000376837804679 0.000284926145001 0.000441007944038 0.000333445030858 0.000501445609539 0.000379141802335 0.000558150801181 0.000422016459430 0.000611123518965 0.000462069002144 0.000660363762889 0.000499299430477 0.000705871532955 0.000533707744429 0.000747646829162 0.000565293944001 0.000785689651510 0.000594058029191 0.000820000000000 0.000620000000000 +-0.006000000000000 -0.006000000000000 -0.005748948669588 -0.005748948669588 -0.005536520620779 -0.005536520620779 -0.005362715853571 -0.005362715853571 -0.005227534367965 -0.005227534367965 -0.005130976163960 -0.005130976163960 -0.005073041241557 -0.005073041241557 -0.005053729600757 -0.005053729600757 -0.005073041241557 -0.005073041241557 -0.005130976163960 -0.005130976163960 -0.005227534367965 -0.005227534367965 -0.005362715853571 -0.005362715853571 -0.005536520620779 -0.005536520620779 -0.005748948669588 -0.005748948669588 -0.006000000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.958158111598078 0.958158111598078 0.922753436796452 0.922753436796452 0.893785975595122 0.893785975595122 0.871255727994087 0.871255727994087 0.855162693993348 0.855162693993348 0.845506873592904 0.845506873592904 0.842288266792756 0.842288266792756 0.845506873592904 0.845506873592904 0.855162693993348 0.855162693993348 0.871255727994087 0.871255727994087 0.893785975595122 0.893785975595122 0.922753436796452 0.922753436796452 0.958158111598078 0.958158111598078 1.000000000000000 1.000000000000000 +PATCH 2 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 -0.000579827560573 -0.000438406204336 -0.000820000000000 -0.000620000000000 +0.000820000000000 0.000620000000000 0.000579827560573 0.000438406204336 0.000000000000000 0.000000000000000 +-0.006000000000000 -0.006000000000000 -0.004242640687119 -0.004242640687119 -0.006000000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.707106781186547 0.707106781186547 1.000000000000000 1.000000000000000 +PATCH 3 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000000000000000 -0.000579827560573 -0.000820000000000 -0.000000000000000 -0.000438406204336 -0.000620000000000 +-0.000820000000000 -0.000579827560573 0.000000000000000 -0.000620000000000 -0.000438406204336 0.000000000000000 +-0.006000000000000 -0.004242640687119 -0.006000000000000 -0.006000000000000 -0.004242640687119 -0.006000000000000 +1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 +PATCH 4 +14 1 +15 2 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000820000000000 0.000785689651510 0.000747646829162 0.000705871532955 0.000660363762889 0.000611123518965 0.000558150801181 0.000501445609539 0.000441007944038 0.000376837804679 0.000308935191461 0.000237300104384 0.000161932543448 0.000082832508653 -0.000000000000000 0.000620000000000 0.000594058029191 0.000565293944001 0.000533707744429 0.000499299430477 0.000462069002144 0.000422016459430 0.000379141802335 0.000333445030858 0.000284926145001 0.000233585144763 0.000179422030144 0.000122436801143 0.000062629457762 -0.000000000000000 +-0.000000000000000 -0.000082832508653 -0.000161932543448 -0.000237300104384 -0.000308935191461 -0.000376837804679 -0.000441007944038 -0.000501445609539 -0.000558150801181 -0.000611123518965 -0.000660363762889 -0.000705871532955 -0.000747646829162 -0.000785689651510 -0.000820000000000 -0.000000000000000 -0.000062629457762 -0.000122436801143 -0.000179422030144 -0.000233585144763 -0.000284926145001 -0.000333445030858 -0.000379141802335 -0.000422016459430 -0.000462069002144 -0.000499299430477 -0.000533707744429 -0.000565293944001 -0.000594058029191 -0.000620000000000 +-0.006000000000000 -0.005748948669588 -0.005536520620779 -0.005362715853571 -0.005227534367965 -0.005130976163960 -0.005073041241557 -0.005053729600757 -0.005073041241557 -0.005130976163960 -0.005227534367965 -0.005362715853571 -0.005536520620779 -0.005748948669588 -0.006000000000000 -0.006000000000000 -0.005748948669588 -0.005536520620779 -0.005362715853571 -0.005227534367965 -0.005130976163960 -0.005073041241557 -0.005053729600757 -0.005073041241557 -0.005130976163960 -0.005227534367965 -0.005362715853571 -0.005536520620779 -0.005748948669588 -0.006000000000000 +1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 +PATCH 5 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000600000000000 0.000600000000000 0.000519615242271 0.000519615242271 0.000300000000000 0.000300000000000 +0.000000000000000 0.000000000000000 0.000300000000000 0.000300000000000 0.000519615242271 0.000519615242271 +-0.005800000000000 -0.006000000000000 -0.005022947341950 -0.005196152422707 -0.005800000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 6 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000300000000000 0.000519615242271 0.000519615242271 0.000600000000000 0.000600000000000 +-0.000519615242271 -0.000519615242271 -0.000300000000000 -0.000300000000000 -0.000000000000000 -0.000000000000000 +-0.005800000000000 -0.006000000000000 -0.005022947341950 -0.005196152422707 -0.005800000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.866025403784438 0.866025403784438 1.000000000000000 1.000000000000000 +PATCH 7 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000300000000000 -0.000000000000000 -0.000000000000000 0.000300000000000 0.000300000000000 +-0.000519615242271 -0.000519615242271 -0.000600000000000 -0.000600000000000 -0.000519615242271 -0.000519615242271 +-0.005800000000000 -0.006000000000000 -0.005022947341950 -0.005196152422707 -0.005800000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 8 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000600000000000 -0.000600000000000 -0.000519615242271 -0.000519615242271 -0.000300000000000 -0.000300000000000 +0.000000000000000 0.000000000000000 -0.000300000000000 -0.000300000000000 -0.000519615242271 -0.000519615242271 +-0.005800000000000 -0.006000000000000 -0.005022947341950 -0.005196152422707 -0.005800000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 9 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000300000000000 -0.000519615242271 -0.000519615242271 -0.000600000000000 -0.000600000000000 +0.000519615242271 0.000519615242271 0.000300000000000 0.000300000000000 0.000000000000000 0.000000000000000 +-0.005800000000000 -0.006000000000000 -0.005022947341950 -0.005196152422707 -0.005800000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 10 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000300000000000 0.000000000000000 0.000000000000000 -0.000300000000000 -0.000300000000000 +0.000519615242271 0.000519615242271 0.000600000000000 0.000600000000000 0.000519615242271 0.000519615242271 +-0.005800000000000 -0.006000000000000 -0.005022947341950 -0.005196152422707 -0.005800000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 11 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000600000000000 0.000600000000000 0.000519615242271 0.000519615242271 0.000300000000000 0.000300000000000 +0.000000000000000 0.000000000000000 0.000300000000000 0.000300000000000 0.000519615242271 0.000519615242271 +-0.003500000000000 -0.005800000000000 -0.003031088913246 -0.005022947341950 -0.003500000000000 -0.005800000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 12 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000300000000000 0.000519615242271 0.000519615242271 0.000600000000000 0.000600000000000 +-0.000519615242271 -0.000519615242271 -0.000300000000000 -0.000300000000000 -0.000000000000000 -0.000000000000000 +-0.003500000000000 -0.005800000000000 -0.003031088913246 -0.005022947341950 -0.003500000000000 -0.005800000000000 +1.000000000000000 1.000000000000000 0.866025403784438 0.866025403784438 1.000000000000000 1.000000000000000 +PATCH 13 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000300000000000 -0.000000000000000 -0.000000000000000 0.000300000000000 0.000300000000000 +-0.000519615242271 -0.000519615242271 -0.000600000000000 -0.000600000000000 -0.000519615242271 -0.000519615242271 +-0.003500000000000 -0.005800000000000 -0.003031088913246 -0.005022947341950 -0.003500000000000 -0.005800000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 14 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000600000000000 -0.000600000000000 -0.000519615242271 -0.000519615242271 -0.000300000000000 -0.000300000000000 +0.000000000000000 0.000000000000000 -0.000300000000000 -0.000300000000000 -0.000519615242271 -0.000519615242271 +-0.003500000000000 -0.005800000000000 -0.003031088913246 -0.005022947341950 -0.003500000000000 -0.005800000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 15 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000300000000000 -0.000519615242271 -0.000519615242271 -0.000600000000000 -0.000600000000000 +0.000519615242271 0.000519615242271 0.000300000000000 0.000300000000000 0.000000000000000 0.000000000000000 +-0.003500000000000 -0.005800000000000 -0.003031088913246 -0.005022947341950 -0.003500000000000 -0.005800000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 16 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000300000000000 0.000000000000000 0.000000000000000 -0.000300000000000 -0.000300000000000 +0.000519615242271 0.000519615242271 0.000600000000000 0.000600000000000 0.000519615242271 0.000519615242271 +-0.003500000000000 -0.005800000000000 -0.003031088913246 -0.005022947341950 -0.003500000000000 -0.005800000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 17 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000600000000000 0.000600000000000 0.000519615242271 0.000519615242271 0.000300000000000 0.000300000000000 +0.000000000000000 0.000000000000000 0.000300000000000 0.000300000000000 0.000519615242271 0.000519615242271 +-0.001000000000000 -0.003500000000000 -0.000866025403784 -0.003031088913246 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 18 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000300000000000 0.000519615242271 0.000519615242271 0.000600000000000 0.000600000000000 +-0.000519615242271 -0.000519615242271 -0.000300000000000 -0.000300000000000 -0.000000000000000 -0.000000000000000 +-0.001000000000000 -0.003500000000000 -0.000866025403784 -0.003031088913246 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.866025403784438 0.866025403784438 1.000000000000000 1.000000000000000 +PATCH 19 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000300000000000 -0.000000000000000 -0.000000000000000 0.000300000000000 0.000300000000000 +-0.000519615242271 -0.000519615242271 -0.000600000000000 -0.000600000000000 -0.000519615242271 -0.000519615242271 +-0.001000000000000 -0.003500000000000 -0.000866025403784 -0.003031088913246 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 20 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000600000000000 -0.000600000000000 -0.000519615242271 -0.000519615242271 -0.000300000000000 -0.000300000000000 +0.000000000000000 0.000000000000000 -0.000300000000000 -0.000300000000000 -0.000519615242271 -0.000519615242271 +-0.001000000000000 -0.003500000000000 -0.000866025403784 -0.003031088913246 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 21 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000300000000000 -0.000519615242271 -0.000519615242271 -0.000600000000000 -0.000600000000000 +0.000519615242271 0.000519615242271 0.000300000000000 0.000300000000000 0.000000000000000 0.000000000000000 +-0.001000000000000 -0.003500000000000 -0.000866025403784 -0.003031088913246 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 22 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000300000000000 0.000000000000000 0.000000000000000 -0.000300000000000 -0.000300000000000 +0.000519615242271 0.000519615242271 0.000600000000000 0.000600000000000 0.000519615242271 0.000519615242271 +-0.001000000000000 -0.003500000000000 -0.000866025403784 -0.003031088913246 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.866025403784439 0.866025403784439 1.000000000000000 1.000000000000000 +PATCH 23 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000000000000000 -0.000300000000000 0.000291666666667 0.000000000000000 -0.000291666666667 +0.000519615242271 0.000600000000000 0.000519615242271 0.000505181485541 0.000583333333333 0.000505181485541 +-0.001000000000000 -0.000866025403784 -0.001000000000000 0.000416666666667 0.000360843918244 0.000416666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 24 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000519615242271 -0.000600000000000 -0.000291666666667 -0.000505181485541 -0.000583333333333 +0.000519615242271 0.000300000000000 0.000000000000000 0.000505181485541 0.000291666666667 0.000000000000000 +-0.001000000000000 -0.000866025403784 -0.001000000000000 0.000416666666667 0.000360843918244 0.000416666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 25 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000600000000000 -0.000519615242271 -0.000300000000000 -0.000583333333333 -0.000505181485541 -0.000291666666667 +0.000000000000000 -0.000300000000000 -0.000519615242271 0.000000000000000 -0.000291666666667 -0.000505181485541 +-0.001000000000000 -0.000866025403784 -0.001000000000000 0.000416666666667 0.000360843918244 0.000416666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 26 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000300000000000 -0.000000000000000 0.000300000000000 -0.000291666666667 -0.000000000000000 0.000291666666667 +-0.000519615242271 -0.000600000000000 -0.000519615242271 -0.000505181485541 -0.000583333333333 -0.000505181485541 +-0.001000000000000 -0.000866025403784 -0.001000000000000 0.000416666666667 0.000360843918244 0.000416666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 27 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000519615242271 0.000600000000000 0.000291666666667 0.000505181485541 0.000583333333333 +-0.000519615242271 -0.000300000000000 -0.000000000000000 -0.000505181485541 -0.000291666666667 -0.000000000000000 +-0.001000000000000 -0.000866025403784 -0.001000000000000 0.000416666666667 0.000360843918244 0.000416666666667 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.866025403784438 1.000000000000000 +PATCH 28 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000600000000000 0.000519615242271 0.000300000000000 0.000583333333333 0.000505181485541 0.000291666666667 +0.000000000000000 0.000300000000000 0.000519615242271 0.000000000000000 0.000291666666667 0.000505181485541 +-0.001000000000000 -0.000866025403784 -0.001000000000000 0.000416666666667 0.000360843918244 0.000416666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 29 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000291666666667 0.000000000000000 -0.000291666666667 0.000263333333333 0.000000000000000 -0.000263333333333 +0.000505181485541 0.000583333333333 0.000505181485541 0.000456106712660 0.000526666666667 0.000456106712660 +0.000416666666667 0.000360843918244 0.000416666666667 0.001833333333333 0.001587713240271 0.001833333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 30 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000291666666667 -0.000505181485541 -0.000583333333333 -0.000263333333333 -0.000456106712660 -0.000526666666667 +0.000505181485541 0.000291666666667 0.000000000000000 0.000456106712660 0.000263333333333 0.000000000000000 +0.000416666666667 0.000360843918244 0.000416666666667 0.001833333333333 0.001587713240271 0.001833333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 31 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000583333333333 -0.000505181485541 -0.000291666666667 -0.000526666666667 -0.000456106712660 -0.000263333333333 +0.000000000000000 -0.000291666666667 -0.000505181485541 0.000000000000000 -0.000263333333333 -0.000456106712660 +0.000416666666667 0.000360843918244 0.000416666666667 0.001833333333333 0.001587713240271 0.001833333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 32 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000291666666667 -0.000000000000000 0.000291666666667 -0.000263333333333 -0.000000000000000 0.000263333333333 +-0.000505181485541 -0.000583333333333 -0.000505181485541 -0.000456106712660 -0.000526666666667 -0.000456106712660 +0.000416666666667 0.000360843918244 0.000416666666667 0.001833333333333 0.001587713240271 0.001833333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 33 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000291666666667 0.000505181485541 0.000583333333333 0.000263333333333 0.000456106712660 0.000526666666667 +-0.000505181485541 -0.000291666666667 -0.000000000000000 -0.000456106712660 -0.000263333333333 -0.000000000000000 +0.000416666666667 0.000360843918244 0.000416666666667 0.001833333333333 0.001587713240271 0.001833333333333 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.866025403784438 1.000000000000000 +PATCH 34 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000583333333333 0.000505181485541 0.000291666666667 0.000526666666667 0.000456106712660 0.000263333333333 +0.000000000000000 0.000291666666667 0.000505181485541 0.000000000000000 0.000263333333333 0.000456106712660 +0.000416666666667 0.000360843918244 0.000416666666667 0.001833333333333 0.001587713240271 0.001833333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 35 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000263333333333 0.000000000000000 -0.000263333333333 0.000235000000000 0.000000000000000 -0.000235000000000 +0.000456106712660 0.000526666666667 0.000456106712660 0.000407031939779 0.000470000000000 0.000407031939779 +0.001833333333333 0.001587713240271 0.001833333333333 0.003250000000000 0.002814582562299 0.003250000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 36 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000263333333333 -0.000456106712660 -0.000526666666667 -0.000235000000000 -0.000407031939779 -0.000470000000000 +0.000456106712660 0.000263333333333 0.000000000000000 0.000407031939779 0.000235000000000 0.000000000000000 +0.001833333333333 0.001587713240271 0.001833333333333 0.003250000000000 0.002814582562299 0.003250000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 37 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000526666666667 -0.000456106712660 -0.000263333333333 -0.000470000000000 -0.000407031939779 -0.000235000000000 +0.000000000000000 -0.000263333333333 -0.000456106712660 0.000000000000000 -0.000235000000000 -0.000407031939779 +0.001833333333333 0.001587713240271 0.001833333333333 0.003250000000000 0.002814582562299 0.003250000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 38 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000263333333333 -0.000000000000000 0.000263333333333 -0.000235000000000 -0.000000000000000 0.000235000000000 +-0.000456106712660 -0.000526666666667 -0.000456106712660 -0.000407031939779 -0.000470000000000 -0.000407031939779 +0.001833333333333 0.001587713240271 0.001833333333333 0.003250000000000 0.002814582562299 0.003250000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 39 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000263333333333 0.000456106712660 0.000526666666667 0.000235000000000 0.000407031939779 0.000470000000000 +-0.000456106712660 -0.000263333333333 -0.000000000000000 -0.000407031939779 -0.000235000000000 -0.000000000000000 +0.001833333333333 0.001587713240271 0.001833333333333 0.003250000000000 0.002814582562299 0.003250000000000 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.866025403784438 1.000000000000000 +PATCH 40 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000526666666667 0.000456106712660 0.000263333333333 0.000470000000000 0.000407031939779 0.000235000000000 +0.000000000000000 0.000263333333333 0.000456106712660 0.000000000000000 0.000235000000000 0.000407031939779 +0.001833333333333 0.001587713240271 0.001833333333333 0.003250000000000 0.002814582562299 0.003250000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 41 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000235000000000 0.000000000000000 -0.000235000000000 0.000206666666667 0.000000000000000 -0.000206666666667 +0.000407031939779 0.000470000000000 0.000407031939779 0.000357957166898 0.000413333333333 0.000357957166898 +0.003250000000000 0.002814582562299 0.003250000000000 0.004666666666667 0.004041451884327 0.004666666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 42 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000235000000000 -0.000407031939779 -0.000470000000000 -0.000206666666667 -0.000357957166898 -0.000413333333333 +0.000407031939779 0.000235000000000 0.000000000000000 0.000357957166898 0.000206666666667 0.000000000000000 +0.003250000000000 0.002814582562299 0.003250000000000 0.004666666666667 0.004041451884327 0.004666666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 43 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000470000000000 -0.000407031939779 -0.000235000000000 -0.000413333333333 -0.000357957166898 -0.000206666666667 +0.000000000000000 -0.000235000000000 -0.000407031939779 0.000000000000000 -0.000206666666667 -0.000357957166898 +0.003250000000000 0.002814582562299 0.003250000000000 0.004666666666667 0.004041451884327 0.004666666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 44 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000235000000000 -0.000000000000000 0.000235000000000 -0.000206666666667 -0.000000000000000 0.000206666666667 +-0.000407031939779 -0.000470000000000 -0.000407031939779 -0.000357957166898 -0.000413333333333 -0.000357957166898 +0.003250000000000 0.002814582562299 0.003250000000000 0.004666666666667 0.004041451884327 0.004666666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 45 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000235000000000 0.000407031939779 0.000470000000000 0.000206666666667 0.000357957166898 0.000413333333333 +-0.000407031939779 -0.000235000000000 -0.000000000000000 -0.000357957166898 -0.000206666666667 -0.000000000000000 +0.003250000000000 0.002814582562299 0.003250000000000 0.004666666666667 0.004041451884327 0.004666666666667 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.866025403784438 1.000000000000000 +PATCH 46 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000470000000000 0.000407031939779 0.000235000000000 0.000413333333333 0.000357957166898 0.000206666666667 +0.000000000000000 0.000235000000000 0.000407031939779 0.000000000000000 0.000206666666667 0.000357957166898 +0.003250000000000 0.002814582562299 0.003250000000000 0.004666666666667 0.004041451884327 0.004666666666667 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 47 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000206666666667 0.000000000000000 -0.000206666666667 0.000178333333333 0.000000000000000 -0.000178333333333 +0.000357957166898 0.000413333333333 0.000357957166898 0.000308882394016 0.000356666666667 0.000308882394016 +0.004666666666667 0.004041451884327 0.004666666666667 0.006083333333333 0.005268321206355 0.006083333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 48 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000206666666667 -0.000357957166898 -0.000413333333333 -0.000178333333333 -0.000308882394016 -0.000356666666667 +0.000357957166898 0.000206666666667 0.000000000000000 0.000308882394016 0.000178333333333 0.000000000000000 +0.004666666666667 0.004041451884327 0.004666666666667 0.006083333333333 0.005268321206355 0.006083333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 49 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000413333333333 -0.000357957166898 -0.000206666666667 -0.000356666666667 -0.000308882394016 -0.000178333333333 +0.000000000000000 -0.000206666666667 -0.000357957166898 0.000000000000000 -0.000178333333333 -0.000308882394016 +0.004666666666667 0.004041451884327 0.004666666666667 0.006083333333333 0.005268321206355 0.006083333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 50 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000206666666667 -0.000000000000000 0.000206666666667 -0.000178333333333 -0.000000000000000 0.000178333333333 +-0.000357957166898 -0.000413333333333 -0.000357957166898 -0.000308882394016 -0.000356666666667 -0.000308882394016 +0.004666666666667 0.004041451884327 0.004666666666667 0.006083333333333 0.005268321206355 0.006083333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 51 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000206666666667 0.000357957166898 0.000413333333333 0.000178333333333 0.000308882394016 0.000356666666667 +-0.000357957166898 -0.000206666666667 -0.000000000000000 -0.000308882394016 -0.000178333333333 -0.000000000000000 +0.004666666666667 0.004041451884327 0.004666666666667 0.006083333333333 0.005268321206355 0.006083333333333 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.866025403784438 1.000000000000000 +PATCH 52 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000413333333333 0.000357957166898 0.000206666666667 0.000356666666667 0.000308882394016 0.000178333333333 +0.000000000000000 0.000206666666667 0.000357957166898 0.000000000000000 0.000178333333333 0.000308882394016 +0.004666666666667 0.004041451884327 0.004666666666667 0.006083333333333 0.005268321206355 0.006083333333333 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 53 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000178333333333 0.000000000000000 -0.000178333333333 0.000150000000000 0.000000000000000 -0.000150000000000 +0.000308882394016 0.000356666666667 0.000308882394016 0.000259807621135 0.000300000000000 0.000259807621135 +0.006083333333333 0.005268321206355 0.006083333333333 0.007500000000000 0.006495190528383 0.007500000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 54 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000178333333333 -0.000308882394016 -0.000356666666667 -0.000150000000000 -0.000259807621135 -0.000300000000000 +0.000308882394016 0.000178333333333 0.000000000000000 0.000259807621135 0.000150000000000 0.000000000000000 +0.006083333333333 0.005268321206355 0.006083333333333 0.007500000000000 0.006495190528383 0.007500000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 55 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000356666666667 -0.000308882394016 -0.000178333333333 -0.000300000000000 -0.000259807621135 -0.000150000000000 +0.000000000000000 -0.000178333333333 -0.000308882394016 0.000000000000000 -0.000150000000000 -0.000259807621135 +0.006083333333333 0.005268321206355 0.006083333333333 0.007500000000000 0.006495190528383 0.007500000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 56 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +-0.000178333333333 -0.000000000000000 0.000178333333333 -0.000150000000000 -0.000000000000000 0.000150000000000 +-0.000308882394016 -0.000356666666667 -0.000308882394016 -0.000259807621135 -0.000300000000000 -0.000259807621135 +0.006083333333333 0.005268321206355 0.006083333333333 0.007500000000000 0.006495190528383 0.007500000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 57 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000178333333333 0.000308882394016 0.000356666666667 0.000150000000000 0.000259807621135 0.000300000000000 +-0.000308882394016 -0.000178333333333 -0.000000000000000 -0.000259807621135 -0.000150000000000 -0.000000000000000 +0.006083333333333 0.005268321206355 0.006083333333333 0.007500000000000 0.006495190528383 0.007500000000000 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.866025403784438 1.000000000000000 +PATCH 58 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000356666666667 0.000308882394016 0.000178333333333 0.000300000000000 0.000259807621135 0.000150000000000 +0.000000000000000 0.000178333333333 0.000308882394016 0.000000000000000 0.000150000000000 0.000259807621135 +0.006083333333333 0.005268321206355 0.006083333333333 0.007500000000000 0.006495190528383 0.007500000000000 +1.000000000000000 0.866025403784439 1.000000000000000 1.000000000000000 0.866025403784439 1.000000000000000 +PATCH 59 +1 14 +2 15 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.000820000000000 0.001724684600877 0.000785689651510 0.001641175966453 0.000747646829162 0.001549474096731 0.000705871532955 0.001449578991708 0.000660363762889 0.001341490651386 0.000611123518965 0.001225209075764 0.000558150801181 0.001100734264842 0.000501445609539 0.000968066218621 0.000441007944038 0.000827204937100 0.000376837804679 0.000678150420279 0.000308935191461 0.000520902668159 0.000237300104384 0.000355461680739 0.000161932543448 0.000181827458019 0.000082832508653 0.000000000000000 0.000000000000000 +0.000000000000000 0.000000000000000 0.000181827458019 0.000082832508653 0.000355461680739 0.000161932543448 0.000520902668159 0.000237300104384 0.000678150420279 0.000308935191461 0.000827204937100 0.000376837804679 0.000968066218621 0.000441007944038 0.001100734264842 0.000501445609539 0.001225209075764 0.000558150801181 0.001341490651386 0.000611123518965 0.001449578991708 0.000660363762889 0.001549474096731 0.000705871532955 0.001641175966453 0.000747646829162 0.001724684600877 0.000785689651510 0.001800000000000 0.000820000000000 +-0.006000000000000 -0.006000000000000 -0.005748948669588 -0.005748948669588 -0.005536520620779 -0.005536520620779 -0.005362715853571 -0.005362715853571 -0.005227534367965 -0.005227534367965 -0.005130976163960 -0.005130976163960 -0.005073041241557 -0.005073041241557 -0.005053729600757 -0.005053729600757 -0.005073041241557 -0.005073041241557 -0.005130976163960 -0.005130976163960 -0.005227534367965 -0.005227534367965 -0.005362715853571 -0.005362715853571 -0.005536520620779 -0.005536520620779 -0.005748948669588 -0.005748948669588 -0.006000000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.958158111598078 0.958158111598078 0.922753436796452 0.922753436796452 0.893785975595122 0.893785975595122 0.871255727994087 0.871255727994087 0.855162693993348 0.855162693993348 0.845506873592904 0.845506873592904 0.842288266792756 0.842288266792756 0.845506873592904 0.845506873592904 0.855162693993348 0.855162693993348 0.871255727994087 0.871255727994087 0.893785975595122 0.893785975595122 0.922753436796452 0.922753436796452 0.958158111598078 0.958158111598078 1.000000000000000 1.000000000000000 +PATCH 60 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 -0.001272792206136 -0.000579827560573 -0.001800000000000 -0.000820000000000 +0.001800000000000 0.000820000000000 0.001272792206136 0.000579827560573 0.000000000000000 0.000000000000000 +-0.006000000000000 -0.006000000000000 -0.004242640687119 -0.004242640687119 -0.006000000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.707106781186547 0.707106781186547 1.000000000000000 1.000000000000000 +PATCH 61 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 -0.001272792206136 -0.001800000000000 -0.000000000000000 -0.000579827560573 -0.000820000000000 +-0.001800000000000 -0.001272792206136 0.000000000000000 -0.000820000000000 -0.000579827560573 0.000000000000000 +-0.006000000000000 -0.004242640687119 -0.006000000000000 -0.006000000000000 -0.004242640687119 -0.006000000000000 +1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 +PATCH 62 +14 1 +15 2 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.000820000000000 0.000785689651510 0.000747646829162 0.000705871532955 0.000660363762889 0.000611123518965 0.000558150801181 0.000501445609539 0.000441007944038 0.000376837804679 0.000308935191461 0.000237300104384 0.000161932543448 0.000082832508653 -0.000000000000000 +0.000000000000000 -0.000181827458019 -0.000355461680739 -0.000520902668159 -0.000678150420279 -0.000827204937100 -0.000968066218621 -0.001100734264842 -0.001225209075764 -0.001341490651386 -0.001449578991708 -0.001549474096731 -0.001641175966453 -0.001724684600877 -0.001800000000000 -0.000000000000000 -0.000082832508653 -0.000161932543448 -0.000237300104384 -0.000308935191461 -0.000376837804679 -0.000441007944038 -0.000501445609539 -0.000558150801181 -0.000611123518965 -0.000660363762889 -0.000705871532955 -0.000747646829162 -0.000785689651510 -0.000820000000000 +-0.006000000000000 -0.005748948669588 -0.005536520620779 -0.005362715853571 -0.005227534367965 -0.005130976163960 -0.005073041241557 -0.005053729600757 -0.005073041241557 -0.005130976163960 -0.005227534367965 -0.005362715853571 -0.005536520620779 -0.005748948669588 -0.006000000000000 -0.006000000000000 -0.005748948669588 -0.005536520620779 -0.005362715853571 -0.005227534367965 -0.005130976163960 -0.005073041241557 -0.005053729600757 -0.005073041241557 -0.005130976163960 -0.005227534367965 -0.005362715853571 -0.005536520620779 -0.005748948669588 -0.006000000000000 +1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 +PATCH 63 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 -0.001272792206136 -0.001800000000000 0.000000000000000 -0.001272792206136 -0.001800000000000 +-0.001800000000000 -0.001272792206136 0.000000000000000 -0.001800000000000 -0.001272792206136 0.000000000000000 +-0.003500000000000 -0.002474873734153 -0.003500000000000 -0.006000000000000 -0.004242640687119 -0.006000000000000 +1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 +PATCH 64 +14 1 +15 2 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 +0.000000000000000 -0.000181827458019 -0.000355461680739 -0.000520902668159 -0.000678150420279 -0.000827204937100 -0.000968066218621 -0.001100734264842 -0.001225209075764 -0.001341490651386 -0.001449578991708 -0.001549474096731 -0.001641175966453 -0.001724684600877 -0.001800000000000 0.000000000000000 -0.000181827458019 -0.000355461680739 -0.000520902668159 -0.000678150420279 -0.000827204937100 -0.000968066218621 -0.001100734264842 -0.001225209075764 -0.001341490651386 -0.001449578991708 -0.001549474096731 -0.001641175966453 -0.001724684600877 -0.001800000000000 +-0.003500000000000 -0.003353553390593 -0.003229637028788 -0.003128250914583 -0.003049395047979 -0.002993069428977 -0.002959274057575 -0.002948008933775 -0.002959274057575 -0.002993069428977 -0.003049395047979 -0.003128250914583 -0.003229637028788 -0.003353553390593 -0.003500000000000 -0.006000000000000 -0.005748948669588 -0.005536520620779 -0.005362715853571 -0.005227534367965 -0.005130976163960 -0.005073041241557 -0.005053729600757 -0.005073041241557 -0.005130976163960 -0.005227534367965 -0.005362715853571 -0.005536520620779 -0.005748948669588 -0.006000000000000 +1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 +PATCH 65 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 -0.001272792206136 -0.001272792206136 -0.001800000000000 -0.001800000000000 +0.001800000000000 0.001800000000000 0.001272792206136 0.001272792206136 0.000000000000000 0.000000000000000 +-0.003500000000000 -0.006000000000000 -0.002474873734153 -0.004242640687119 -0.003500000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.707106781186547 0.707106781186547 1.000000000000000 1.000000000000000 +PATCH 66 +1 14 +2 15 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001800000000000 0.001724684600877 0.001724684600877 0.001641175966453 0.001641175966453 0.001549474096731 0.001549474096731 0.001449578991708 0.001449578991708 0.001341490651386 0.001341490651386 0.001225209075764 0.001225209075764 0.001100734264842 0.001100734264842 0.000968066218621 0.000968066218621 0.000827204937100 0.000827204937100 0.000678150420279 0.000678150420279 0.000520902668159 0.000520902668159 0.000355461680739 0.000355461680739 0.000181827458019 0.000181827458019 0.000000000000000 0.000000000000000 +0.000000000000000 0.000000000000000 0.000181827458019 0.000181827458019 0.000355461680739 0.000355461680739 0.000520902668159 0.000520902668159 0.000678150420279 0.000678150420279 0.000827204937100 0.000827204937100 0.000968066218621 0.000968066218621 0.001100734264842 0.001100734264842 0.001225209075764 0.001225209075764 0.001341490651386 0.001341490651386 0.001449578991708 0.001449578991708 0.001549474096731 0.001549474096731 0.001641175966453 0.001641175966453 0.001724684600877 0.001724684600877 0.001800000000000 0.001800000000000 +-0.003500000000000 -0.006000000000000 -0.003353553390593 -0.005748948669588 -0.003229637028788 -0.005536520620779 -0.003128250914583 -0.005362715853571 -0.003049395047979 -0.005227534367965 -0.002993069428977 -0.005130976163960 -0.002959274057575 -0.005073041241557 -0.002948008933775 -0.005053729600757 -0.002959274057575 -0.005073041241557 -0.002993069428977 -0.005130976163960 -0.003049395047979 -0.005227534367965 -0.003128250914583 -0.005362715853571 -0.003229637028788 -0.005536520620779 -0.003353553390593 -0.005748948669588 -0.003500000000000 -0.006000000000000 +1.000000000000000 1.000000000000000 0.958158111598078 0.958158111598078 0.922753436796452 0.922753436796452 0.893785975595122 0.893785975595122 0.871255727994087 0.871255727994087 0.855162693993348 0.855162693993348 0.845506873592904 0.845506873592904 0.842288266792756 0.842288266792756 0.845506873592904 0.845506873592904 0.855162693993348 0.855162693993348 0.871255727994087 0.871255727994087 0.893785975595122 0.893785975595122 0.922753436796452 0.922753436796452 0.958158111598078 0.958158111598078 1.000000000000000 1.000000000000000 +PATCH 67 +1 14 +2 15 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001800000000000 0.001724684600877 0.001724684600877 0.001641175966453 0.001641175966453 0.001549474096731 0.001549474096731 0.001449578991708 0.001449578991708 0.001341490651386 0.001341490651386 0.001225209075764 0.001225209075764 0.001100734264842 0.001100734264842 0.000968066218621 0.000968066218621 0.000827204937100 0.000827204937100 0.000678150420279 0.000678150420279 0.000520902668159 0.000520902668159 0.000355461680739 0.000355461680739 0.000181827458019 0.000181827458019 0.000000000000000 0.000000000000000 +0.000000000000000 0.000000000000000 0.000181827458019 0.000181827458019 0.000355461680739 0.000355461680739 0.000520902668159 0.000520902668159 0.000678150420279 0.000678150420279 0.000827204937100 0.000827204937100 0.000968066218621 0.000968066218621 0.001100734264842 0.001100734264842 0.001225209075764 0.001225209075764 0.001341490651386 0.001341490651386 0.001449578991708 0.001449578991708 0.001549474096731 0.001549474096731 0.001641175966453 0.001641175966453 0.001724684600877 0.001724684600877 0.001800000000000 0.001800000000000 +-0.001000000000000 -0.003500000000000 -0.000958158111598 -0.003353553390593 -0.000922753436796 -0.003229637028788 -0.000893785975595 -0.003128250914583 -0.000871255727994 -0.003049395047979 -0.000855162693993 -0.002993069428977 -0.000845506873593 -0.002959274057575 -0.000842288266793 -0.002948008933775 -0.000845506873593 -0.002959274057575 -0.000855162693993 -0.002993069428977 -0.000871255727994 -0.003049395047979 -0.000893785975595 -0.003128250914583 -0.000922753436796 -0.003229637028788 -0.000958158111598 -0.003353553390593 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.958158111598078 0.958158111598078 0.922753436796452 0.922753436796452 0.893785975595122 0.893785975595122 0.871255727994087 0.871255727994087 0.855162693993348 0.855162693993348 0.845506873592904 0.845506873592904 0.842288266792756 0.842288266792756 0.845506873592904 0.845506873592904 0.855162693993348 0.855162693993348 0.871255727994087 0.871255727994087 0.893785975595122 0.893785975595122 0.922753436796452 0.922753436796452 0.958158111598078 0.958158111598078 1.000000000000000 1.000000000000000 +PATCH 68 +1 2 +2 3 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 -0.001272792206136 -0.001272792206136 -0.001800000000000 -0.001800000000000 +0.001800000000000 0.001800000000000 0.001272792206136 0.001272792206136 0.000000000000000 0.000000000000000 +-0.001000000000000 -0.003500000000000 -0.000707106781187 -0.002474873734153 -0.001000000000000 -0.003500000000000 +1.000000000000000 1.000000000000000 0.707106781186547 0.707106781186547 1.000000000000000 1.000000000000000 +PATCH 69 +14 1 +15 2 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 +-0.000000000000000 -0.000181827458019 -0.000355461680739 -0.000520902668159 -0.000678150420279 -0.000827204937100 -0.000968066218621 -0.001100734264842 -0.001225209075764 -0.001341490651386 -0.001449578991708 -0.001549474096731 -0.001641175966453 -0.001724684600877 -0.001800000000000 0.000000000000000 -0.000181827458019 -0.000355461680739 -0.000520902668159 -0.000678150420279 -0.000827204937100 -0.000968066218621 -0.001100734264842 -0.001225209075764 -0.001341490651386 -0.001449578991708 -0.001549474096731 -0.001641175966453 -0.001724684600877 -0.001800000000000 +-0.001000000000000 -0.000958158111598 -0.000922753436796 -0.000893785975595 -0.000871255727994 -0.000855162693993 -0.000845506873593 -0.000842288266793 -0.000845506873593 -0.000855162693993 -0.000871255727994 -0.000893785975595 -0.000922753436796 -0.000958158111598 -0.001000000000000 -0.003500000000000 -0.003353553390593 -0.003229637028788 -0.003128250914583 -0.003049395047979 -0.002993069428977 -0.002959274057575 -0.002948008933775 -0.002959274057575 -0.002993069428977 -0.003049395047979 -0.003128250914583 -0.003229637028788 -0.003353553390593 -0.003500000000000 +1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 +PATCH 70 +2 1 +3 2 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 -0.001272792206136 -0.001800000000000 0.000000000000000 -0.001272792206136 -0.001800000000000 +-0.001800000000000 -0.001272792206136 -0.000000000000000 -0.001800000000000 -0.001272792206136 0.000000000000000 +-0.001000000000000 -0.000707106781187 -0.001000000000000 -0.003500000000000 -0.002474873734153 -0.003500000000000 +1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 +PATCH 71 +14 13 +15 14 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000520902668159 0.000355461680739 0.000181827458019 -0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000827204937100 0.000678150420279 0.000519584967697 0.000352541239502 0.000179302640192 -0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001100734264842 0.000968066218621 0.000823279719784 0.000670721809443 0.000511930057563 0.000347115266087 0.000176435443548 -0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001341490651386 0.001225209075764 0.001095585839607 0.000957125207185 0.000812221638314 0.000661185630949 0.000504275147429 0.000341689292672 0.000173568246905 -0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001449578991708 0.001338132691552 0.001213776264057 0.001082567917781 0.000944908311656 0.000801163556843 0.000651649452454 0.000496620237295 0.000336263319258 0.000170701050262 -0.000000000000000 0.001800000000000 0.001724684600877 0.001641175966453 0.001549474096731 0.001441757557260 0.001324518939119 0.001200300521240 0.001069549995956 0.000932691416127 0.000790105475373 0.000642113273960 0.000488965327161 0.000330837345843 0.000167833853619 -0.000000000000000 0.001800000000000 0.001724684600877 0.001641065449562 0.001538505446488 0.001428294488277 0.001310905186686 0.001186824778424 0.001056532074131 0.000920474520598 0.000779047393902 0.000632577095466 0.000481310417027 0.000325411372428 0.000164966656976 -0.000000000000000 0.001800000000000 0.001723867182827 0.001628616546126 0.001525444488548 0.001414831419293 0.001297291434253 0.001173349035607 0.001043514152306 0.000908257625070 0.000767989312432 0.000623040916972 0.000473655506893 0.000319985399014 0.000162099460333 -0.000000000000000 0.001800000000000 0.001712196698492 0.001616167642690 0.001512383530608 0.001401368350310 0.001283677681821 0.001159873292790 0.001030496230480 0.000896040729541 0.000756931230961 0.000613504738478 0.000466000596759 0.000314559425599 0.000159232263690 -0.000000000000000 +0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001549474096731 0.001641175966453 0.001724684600877 0.001800000000000 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001549474096731 0.001641175966453 0.001724684600877 0.001800000000000 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001549474096731 0.001641175966453 0.001724684600877 0.001800000000000 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001549474096731 0.001641175966453 0.001724684600877 0.001800000000000 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001549474096731 0.001641175966453 0.001724684600877 0.001800000000000 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001549474096731 0.001641175966453 0.001724684600877 0.001794103238158 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001341490651386 0.001449578991708 0.001545554472474 0.001627692212141 0.001700735993360 0.001764923885790 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001100734264842 0.001225209075764 0.001335125067602 0.001433699980379 0.001522784220582 0.001602640349605 0.001673539826446 0.001735744533421 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000827204937100 0.000968066218621 0.001095585839607 0.001211361855138 0.001317192011052 0.001413315942276 0.001500013968690 0.001577588487069 0.001646343659531 0.001706565181053 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000678150420279 0.000825134314431 0.000959032887889 0.001082567917781 0.001195899843355 0.001299258954503 0.001392931904174 0.001477243716797 0.001552536624533 0.001619147492616 0.001677385828684 0.000000000000000 0.000181827458019 0.000355461680739 0.000520902668159 0.000674491351620 0.000816739650470 0.000948385389719 0.001069549995956 0.001180437831571 0.001281325897953 0.001372547866071 0.001454473464905 0.001527484761997 0.001591951325701 0.001648206476316 0.000000000000000 0.000181827458019 0.000355437743928 0.000517215224020 0.000668192980892 0.000808344986509 0.000937737891550 0.001056532074131 0.001164975819788 0.001263392841404 0.001352163827968 0.001431703213013 0.001502432899461 0.001564755158787 0.001619027123948 0.000000000000000 0.000181741280497 0.000352741440649 0.000512824387249 0.000661894610164 0.000799950322549 0.000927090393380 0.001043514152306 0.001149513808004 0.001245459784854 0.001331779789866 0.001408932961120 0.001477381036925 0.001537558991872 0.001589847771579 0.000000000000000 0.000180510902201 0.000350045137371 0.000508433550478 0.000655596239436 0.000791555658588 0.000916442895210 0.001030496230480 0.001134051796220 0.001227526728305 0.001311395751763 0.001386162709228 0.001452329174389 0.001510362824957 0.001560668419211 +-0.001000000000000 -0.000958158111598 -0.000922753436796 -0.000893785975595 -0.000871255727994 -0.000855162693993 -0.000845506873593 -0.000842288266793 -0.000845506873593 -0.000855162693993 -0.000871255727994 -0.000893785975595 -0.000922753436796 -0.000958158111598 -0.001000000000000 -0.000923076923077 -0.000877842818769 -0.000838799004608 -0.000805816608392 -0.000778756360086 -0.000757467113320 -0.000741784069704 -0.000731526628127 -0.000726495755781 -0.000726470742124 -0.000731205146496 -0.000740421677263 -0.000753805633055 -0.000770996375473 -0.000791576054511 -0.000846153846154 -0.000797527525940 -0.000754844572419 -0.000717847241189 -0.000686256992178 -0.000659771532646 -0.000638061265816 -0.000620764989461 -0.000607484637970 -0.000597778790255 -0.000591154564998 -0.000587057378930 -0.000584857829314 -0.000583834639348 -0.000583152109023 -0.000769230769231 -0.000717212233111 -0.000670890140230 -0.000629877873987 -0.000593757624270 -0.000562075951972 -0.000534338461927 -0.000510003350795 -0.000488473520158 -0.000469086838385 -0.000451103983500 -0.000433693080598 -0.000415910025573 -0.000396672903223 -0.000374728163534 -0.000692307692308 -0.000636896940282 -0.000586935708041 -0.000541908506784 -0.000501258256361 -0.000464380371299 -0.000430615658038 -0.000399241712130 -0.000369462402347 -0.000340394886516 -0.000311053402003 -0.000280328782265 -0.000246962221832 -0.000209511167098 -0.000166304218046 -0.000615384615385 -0.000556581647453 -0.000502981275852 -0.000453939139581 -0.000408758888453 -0.000366684790625 -0.000326892854150 -0.000288480073464 -0.000250451284535 -0.000211702934647 -0.000171002820505 -0.000126964483933 -0.000078014418091 -0.000022349430973 0.000042119727443 -0.000538461538462 -0.000476266354624 -0.000419026843664 -0.000365969772378 -0.000316259520545 -0.000268989209952 -0.000223170050261 -0.000177718434798 -0.000131440166724 -0.000083010982778 -0.000030952239007 0.000026399814400 0.000090933385650 0.000164812305152 0.000250543672931 -0.000461538461538 -0.000395951061795 -0.000335072411475 -0.000278000405175 -0.000223760152637 -0.000171293629278 -0.000119447246372 -0.000066956796132 -0.000012429048912 0.000045680969092 0.000109098342491 0.000179764112732 0.000259881189391 0.000351974041277 0.000458967618420 -0.000384615384615 -0.000315635768965 -0.000251117979286 -0.000190031037973 -0.000131260784729 -0.000073598048604 -0.000015724442484 0.000043804842533 0.000106582068900 0.000174372920961 0.000249148923989 0.000333128411065 0.000428828993132 0.000539135777402 0.000667391563909 -0.000307692307692 -0.000235320476136 -0.000167163547097 -0.000102061670770 -0.000038761416821 0.000024097532069 0.000087998361405 0.000154566481199 0.000225593186711 0.000303064872830 0.000389199505487 0.000486492709398 0.000597776796874 0.000726297513527 0.000875815509397 -0.000230769230769 -0.000155005183307 -0.000083209114908 -0.000014092303567 0.000053737951088 0.000121793112743 0.000191721165294 0.000265328119865 0.000344604304523 0.000431756824700 0.000529250086985 0.000639857007730 0.000766724600615 0.000913459249651 0.001084239454886 -0.000153846153846 -0.000074689890478 0.000000745317280 0.000073877063636 0.000146237318996 0.000219488693416 0.000295443969182 0.000376089758531 0.000463615422334 0.000560448776569 0.000669300668483 0.000793221306063 0.000935672404356 0.001100620985776 0.001292663400374 -0.000076923076923 0.000005625402351 0.000084699749469 0.000161846430839 0.000238736686904 0.000317184274090 0.000399166773071 0.000486851397197 0.000582626540146 0.000689140728438 0.000809351249981 0.000946585604395 0.001104620208097 0.001287782721901 0.001501087345863 0.000000000000000 0.000085940695180 0.000168654181658 0.000249815798042 0.000331236054812 0.000414879854764 0.000502889576960 0.000597613035862 0.000701637657957 0.000817832680307 0.000949401831478 0.001099949902728 0.001273568011838 0.001474944458026 0.001709511291351 +1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792757 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792757 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 1.000000000000000 0.958158111598078 0.922753436796452 0.893785975595122 0.871255727994087 0.855162693993348 0.845506873592904 0.842288266792756 0.845506873592904 0.855162693993348 0.871255727994087 0.893785975595122 0.922753436796452 0.958158111598078 1.000000000000000 +PATCH 72 +2 13 +3 14 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 -0.001272792206136 -0.001800000000000 0.000000000000000 -0.001272792206136 -0.001800000000000 0.000000000000000 -0.001272792206136 -0.001800000000000 0.000000000000000 -0.001272792206136 -0.001800000000000 0.000000000000000 -0.001272792206136 -0.001800000000000 -0.000000000000000 -0.001268622565850 -0.001794103238158 -0.000000000000000 -0.001247989647920 -0.001764923885790 -0.000000000000000 -0.001227356729990 -0.001735744533421 -0.000000000000000 -0.001206723812059 -0.001706565181053 -0.000000000000000 -0.001186090894129 -0.001677385828684 -0.000000000000000 -0.001165457976199 -0.001648206476316 -0.000000000000000 -0.001144825058268 -0.001619027123948 -0.000000000000000 -0.001124192140338 -0.001589847771579 -0.000000000000000 -0.001103559222408 -0.001560668419211 +0.001800000000000 0.001272792206136 0.000000000000000 0.001800000000000 0.001272792206136 0.000000000000000 0.001800000000000 0.001272792206136 0.000000000000000 0.001800000000000 0.001272792206136 0.000000000000000 0.001800000000000 0.001272792206136 0.000000000000000 0.001794103238158 0.001268622565850 -0.000000000000000 0.001764923885790 0.001247989647920 -0.000000000000000 0.001735744533421 0.001227356729990 -0.000000000000000 0.001706565181053 0.001206723812059 -0.000000000000000 0.001677385828684 0.001186090894129 -0.000000000000000 0.001648206476316 0.001165457976199 -0.000000000000000 0.001619027123948 0.001144825058268 -0.000000000000000 0.001589847771579 0.001124192140338 -0.000000000000000 0.001560668419211 0.001103559222408 -0.000000000000000 +-0.001000000000000 -0.000707106781187 -0.001000000000000 -0.000791576054511 -0.000559728795970 -0.000791576054511 -0.000583152109023 -0.000412350810753 -0.000583152109023 -0.000374728163534 -0.000264972825537 -0.000374728163534 -0.000166304218046 -0.000117594840320 -0.000166304218046 0.000042119727443 0.000029783144897 0.000042119727443 0.000250543672931 0.000177161130113 0.000250543672931 0.000458967618420 0.000324539115330 0.000458967618420 0.000667391563909 0.000471917100546 0.000667391563909 0.000875815509397 0.000619295085763 0.000875815509397 0.001084239454886 0.000766673070980 0.001084239454886 0.001292663400374 0.000914051056196 0.001292663400374 0.001501087345863 0.001061429041413 0.001501087345863 0.001709511291351 0.001208807026630 0.001709511291351 +1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186548 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186548 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186548 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186548 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186548 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 1.000000000000000 0.707106781186548 1.000000000000000 1.000000000000000 0.707106781186547 1.000000000000000 +PATCH 73 +2 14 +3 15 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 -0.001103559222408 -0.001560668419211 -0.000084503616606 -0.001117356191447 -0.001543573306297 -0.000166354117847 -0.001130276126953 -0.001526478193384 -0.000245524625540 -0.001142345378356 -0.001509383080470 -0.000321993305878 -0.001153585329020 -0.001492287967557 -0.000395742685060 -0.001164012116847 -0.001475192854643 -0.000466758645681 -0.001173636335474 -0.001458097741730 -0.000535029054774 -0.001182462682272 -0.001441002628816 -0.000600541960380 -0.001190489509681 -0.001423907515903 -0.000663283272908 -0.001197708223721 -0.001406812402989 -0.000723233817081 -0.001204102456021 -0.001389717290076 -0.000780365595008 -0.001209646910942 -0.001372622177162 -0.000834637032508 -0.001214305752959 -0.001355527064249 -0.000885986875597 -0.001218030344637 -0.001338431951335 -0.000934326238680 -0.001220756060571 -0.001321336838422 +0.001560668419211 0.001103559222408 -0.000000000000000 0.001528921327554 0.001062289045673 -0.000000000000000 0.001494775935370 0.001020768137742 -0.000000000000000 0.001458334638708 0.000979009764268 -0.000000000000000 0.001419700916658 0.000937023862218 -0.000000000000000 0.001378978290034 0.000894817630010 -0.000000000000000 0.001336269281333 0.000852396130754 -0.000000000000000 0.001291674400298 0.000809762897776 -0.000000000000000 0.001245291180478 0.000766920535245 -0.000000000000000 0.001197213293441 0.000723871311275 -0.000000000000000 0.001147529768749 0.000680617746750 -0.000000000000000 0.001096324349336 0.000637163210554 -0.000000000000000 0.001043675013417 0.000593512541586 -0.000000000000000 0.000989653695363 0.000549672731039 -0.000000000000000 0.000934326238680 0.000505653716638 -0.000000000000000 +0.001709511291351 0.001208807026630 0.001709511291351 0.001779639749375 0.001322099992288 0.001831619240734 0.001854295060573 0.001437656384533 0.001953727190116 0.001934109222007 0.001555792201896 0.002075835139498 0.002019773445727 0.001676853050402 0.002197943088880 0.002112047256426 0.001801218692398 0.002320051038263 0.002211769505659 0.001929308553661 0.002442158987645 0.002319871820470 0.002061588447713 0.002564266937027 0.002437395177371 0.002198578862810 0.002686374886409 0.002565510535721 0.002340865278631 0.002808482835792 0.002705544811282 0.002489111153058 0.002930590785174 0.002859013974016 0.002644074471071 0.003052698734556 0.003027665798442 0.002806629119930 0.003174806683938 0.003213535919200 0.002977792916956 0.003296914633321 0.003419022582703 0.003158764985353 0.003419022582703 +1.000000000000000 0.707106781186547 1.000000000000000 0.989125647501612 0.717153372889121 1.000000000000000 0.979924272310669 0.728036453245416 1.000000000000000 0.972395874427170 0.739756022255434 1.000000000000000 0.966540453851115 0.752312079919173 1.000000000000000 0.962358010582504 0.765704626236635 1.000000000000000 0.959848544621338 0.779933661207819 1.000000000000000 0.959012055967616 0.794999184832725 1.000000000000000 0.959848544621338 0.810901197111353 1.000000000000000 0.962358010582504 0.827639698043704 1.000000000000000 0.966540453851115 0.845214687629776 1.000000000000000 0.972395874427170 0.863626165869571 1.000000000000000 0.979924272310669 0.882874132763087 1.000000000000000 0.989125647501612 0.902958588310326 1.000000000000000 1.000000000000000 0.923879532511287 1.000000000000000 +PATCH 74 +2 14 +3 15 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000934326238680 -0.001220756060571 -0.001321336838422 -0.000947858213412 -0.001213145865456 -0.001304241725508 -0.000960184257278 -0.001205023200185 -0.001287146612595 -0.000971281996768 -0.001196380333714 -0.001270051499681 -0.000981125140436 -0.001187207149417 -0.001252956386768 -0.000989682689719 -0.001177490751128 -0.001235861273854 -0.000996917977983 -0.001167214983814 -0.001218766160941 -0.001002787490188 -0.001156359844709 -0.001201671048027 -0.001007239399223 -0.001144900752536 -0.001184575935113 -0.001010211731895 -0.001132807630703 -0.001167480822200 -0.001011630044360 -0.001120043743713 -0.001150385709286 -0.001011404438523 -0.001106564201587 -0.001133290596373 -0.001009425679011 -0.001092314010934 -0.001116195483459 -0.001005560061253 -0.001077225496288 -0.001099100370546 -0.000999642511596 -0.001061214830005 -0.001082005257632 +0.000934326238680 0.000505653716638 -0.000000000000000 0.000896319425862 0.000483185182771 -0.000000000000000 0.000858366740678 0.000460912171527 -0.000000000000000 0.000820485741075 0.000438840138599 -0.000000000000000 0.000782694258964 0.000416974619760 -0.000000000000000 0.000745010480269 0.000395321281245 -0.000000000000000 0.000707453046074 0.000373885978854 -0.000000000000000 0.000670041179316 0.000352674827692 -0.000000000000000 0.000632794842752 0.000331694285043 -0.000000000000000 0.000595734935524 0.000310951249684 -0.000000000000000 0.000558883537928 0.000290453182015 -0.000000000000000 0.000522264217086 0.000270208250973 -0.000000000000000 0.000485902410568 0.000250225515872 -0.000000000000000 0.000449825911261 0.000230515154565 -0.000000000000000 0.000414065485828 0.000211088754135 -0.000000000000000 +0.003419022582703 0.003158764985353 0.003419022582703 0.003499084943941 0.003271401159022 0.003541130532085 0.003583542806884 0.003386235083543 0.003663238481467 0.003672754277478 0.003503445811889 0.003785346430850 0.003767116736956 0.003623232034678 0.003907454380232 0.003867073282130 0.003745815300314 0.004029562329614 0.003973120571143 0.003871443937870 0.004151670278996 0.004085818462889 0.004000397876793 0.004273778228379 0.004205801970071 0.004132994623433 0.004395886177761 0.004333796231423 0.004269596747159 0.004517994127143 0.004470635474236 0.004410621361614 0.004640102076525 0.004617287324927 0.004556552280009 0.004762210025908 0.004774884399054 0.004707955810123 0.004884317975290 0.004944765971310 0.004865501589300 0.005006425924672 0.005128533874054 0.005029990533722 0.005128533874054 +1.000000000000000 0.923879532511287 1.000000000000000 0.997255040057604 0.926571748818085 1.000000000000000 0.994932381644808 0.929475115889683 1.000000000000000 0.993032024761611 0.932589633726080 1.000000000000000 0.991553969408013 0.935915302327277 1.000000000000000 0.990498215584015 0.939452121693274 1.000000000000000 0.989864763289616 0.943200091824071 1.000000000000000 0.989653612524817 0.947159212719667 1.000000000000000 0.989864763289616 0.951329484380063 1.000000000000000 0.990498215584015 0.955710906805258 1.000000000000000 0.991553969408013 0.960303479995253 1.000000000000000 0.993032024761611 0.965107203950048 1.000000000000000 0.994932381644808 0.970122078669643 1.000000000000000 0.997255040057604 0.975348104154036 1.000000000000000 1.000000000000000 0.980785280403230 1.000000000000000 +PATCH 75 +2 14 +3 15 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000999642511596 -0.001061214830005 -0.001082005257632 -0.000993853565343 -0.001050301070225 -0.001068203434079 -0.000987610628984 -0.001039167545967 -0.001054401610525 -0.000980892907513 -0.001027804388621 -0.001040599786971 -0.000973677300432 -0.001016200549867 -0.001026797963417 -0.000965938070142 -0.001004343634281 -0.001012996139863 -0.000957646449170 -0.000992219701173 -0.000999194316309 -0.000948770172150 -0.000979813028578 -0.000985392492755 -0.000939272914590 -0.000967105830384 -0.000971590669202 -0.000929113615205 -0.000954077914922 -0.000957788845648 -0.000918245651605 -0.000940706269882 -0.000943987022094 -0.000906615829535 -0.000926964553538 -0.000930185198540 -0.000894163132682 -0.000912822465742 -0.000916383374986 -0.000880817161643 -0.000898244962825 -0.000902581551432 -0.000866496164490 -0.000883191267498 -0.000888779727878 +0.000414065485828 0.000211088754135 -0.000000000000000 0.000397748948340 0.000202401420802 -0.000000000000000 0.000381547033771 0.000193818618333 -0.000000000000000 0.000365463586781 0.000185341573537 -0.000000000000000 0.000349502688302 0.000176971578160 -0.000000000000000 0.000333668683427 0.000168709997413 -0.000000000000000 0.000317966213410 0.000160558279737 -0.000000000000000 0.000302400252551 0.000152517968039 -0.000000000000000 0.000286976150906 0.000144590712698 -0.000000000000000 0.000271699684009 0.000136778286687 -0.000000000000000 0.000256577111084 0.000129082603281 -0.000000000000000 0.000241615243617 0.000121505736912 -0.000000000000000 0.000226821526667 0.000114049947918 -0.000000000000000 0.000212204136013 0.000106717712138 -0.000000000000000 0.000197772095129 0.000099511756603 -0.000000000000000 +0.005128533874054 0.005029990533722 0.005128533874054 0.005202581457200 0.005120422116474 0.005227118328010 0.005279420689589 0.005212249523848 0.005325702781967 0.005359229851829 0.005305561896147 0.005424287235923 0.005442204959814 0.005400457241319 0.005522871689879 0.005528562256809 0.005497043680996 0.005621456143835 0.005618541161988 0.005595440924765 0.005720040597791 0.005712407779827 0.005695782024863 0.005818625051747 0.005810459103762 0.005798215478010 0.005917209505703 0.005913028086139 0.005902907760378 0.006015793959659 0.006020489798372 0.006010046407673 0.006114378413616 0.006133268975942 0.006119843787638 0.006212962867572 0.006251849340223 0.006232541760958 0.006311547321528 0.006376785225128 0.006348417494589 0.006410131775484 0.006508716229440 0.006467790787925 0.006508716229440 +1.000000000000000 0.980785280403230 1.000000000000000 0.999494499159660 0.981455882089490 1.000000000000000 0.999066767679372 0.982165368455775 1.000000000000000 0.998716805559137 0.982913739502087 1.000000000000000 0.998444612798953 0.983700995228425 1.000000000000000 0.998250189398823 0.984527135634789 1.000000000000000 0.998133535358744 0.985392160721179 1.000000000000000 0.998094650678718 0.986296070487596 1.000000000000000 0.998133535358744 0.987238864934038 1.000000000000000 0.998250189398823 0.988220544060507 1.000000000000000 0.998444612798953 0.989241107867002 1.000000000000000 0.998716805559137 0.990300556353523 1.000000000000000 0.999066767679372 0.991398889520070 1.000000000000000 0.999494499159660 0.992536107366643 1.000000000000000 1.000000000000000 0.993712209893243 1.000000000000000 +PATCH 76 +2 14 +3 15 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000866496164490 -0.000883191267498 -0.000888779727878 -0.000859318215316 -0.000874394174660 -0.000878861801281 -0.000851921534874 -0.000865487874525 -0.000868943874683 -0.000844296202950 -0.000856467486064 -0.000859025948085 -0.000836431516111 -0.000847327733686 -0.000849108021488 -0.000828315904482 -0.000838062905456 -0.000839190094890 -0.000819936837191 -0.000828666805643 -0.000829272168292 -0.000811280714582 -0.000819132700626 -0.000819354241694 -0.000802332744912 -0.000809453257037 -0.000809436315097 -0.000793076802766 -0.000799620470726 -0.000799518388499 -0.000783495265849 -0.000789625584909 -0.000789600461901 -0.000773568826058 -0.000779458995417 -0.000779682535303 -0.000763276269830 -0.000769110140561 -0.000769764608706 -0.000752594221554 -0.000758567372490 -0.000759846682108 -0.000741496842341 -0.000747817806198 -0.000749928755510 +0.000197772095129 0.000099511756603 -0.000000000000000 0.000191342029155 0.000096175314453 -0.000000000000000 0.000184955435512 0.000092875195115 -0.000000000000000 0.000178613332062 0.000089611687668 -0.000000000000000 0.000172316789610 0.000086385094958 -0.000000000000000 0.000166066936176 0.000083195734750 -0.000000000000000 0.000159864961739 0.000080043941016 -0.000000000000000 0.000153712123499 0.000076930065347 -0.000000000000000 0.000147609751741 0.000073854478543 -0.000000000000000 0.000141559256383 0.000070817572378 -0.000000000000000 0.000135562134317 0.000067819761582 -0.000000000000000 0.000129619977660 0.000064861486069 -0.000000000000000 0.000123734483063 0.000061943213449 -0.000000000000000 0.000117907462251 0.000059065441879 -0.000000000000000 0.000112140854014 0.000056228703299 -0.000000000000000 +0.006508716229440 0.006467790787925 0.006508716229440 0.006567099716553 0.006533818877223 0.006579558562281 0.006627019418721 0.006600615074049 0.006650400895122 0.006688550496117 0.006668216958488 0.006721243227963 0.006751773855330 0.006736664983837 0.006792085560804 0.006816776755551 0.006806002779689 0.006862927893644 0.006883653497023 0.006876277496167 0.006933770226485 0.006952506205559 0.006947540196177 0.007004612559326 0.007023445729674 0.007019846303976 0.007075454892167 0.007096592670325 0.007093256120043 0.007146297225008 0.007172078567522 0.007167835414383 0.007217139557849 0.007250047273399 0.007243656113064 0.007287981890690 0.007330656548093 0.007320797096152 0.007358824223531 0.007414079923287 0.007399345129491 0.007429666556372 0.007500508889212 0.007479395958196 0.007500508889212 +1.000000000000000 0.993712209893243 1.000000000000000 0.999901428082276 0.993910989908086 1.000000000000000 0.999818021074972 0.994117352378139 1.000000000000000 0.999749778978086 0.994331297303401 1.000000000000000 0.999696701791619 0.994552824683873 1.000000000000000 0.999658789515572 0.994781934519555 1.000000000000000 0.999636042149943 0.995018626810445 1.000000000000000 0.999628459694734 0.995262901556546 1.000000000000000 0.999636042149943 0.995514758757856 1.000000000000000 0.999658789515572 0.995774198414376 1.000000000000000 0.999696701791619 0.996041220526104 1.000000000000000 0.999749778978086 0.996315825093043 1.000000000000000 0.999818021074972 0.996598012115191 1.000000000000000 0.999901428082276 0.996887781592549 1.000000000000000 1.000000000000000 0.997185133525116 1.000000000000000 +PATCH 77 +13 14 +14 15 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001800000000000 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001724684600877 0.001723867182827 0.001712196698492 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641175966453 0.001641065449562 0.001628616546126 0.001616167642690 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001549474096731 0.001538505446488 0.001525444488548 0.001512383530608 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001449578991708 0.001441757557260 0.001428294488277 0.001414831419293 0.001401368350310 0.001341490651386 0.001341490651386 0.001341490651386 0.001341490651386 0.001341490651386 0.001341490651386 0.001341490651386 0.001341490651386 0.001341490651386 0.001338132691552 0.001324518939119 0.001310905186686 0.001297291434253 0.001283677681821 0.001225209075764 0.001225209075764 0.001225209075764 0.001225209075764 0.001225209075764 0.001225209075764 0.001225209075764 0.001225209075764 0.001225209075764 0.001213776264057 0.001200300521240 0.001186824778424 0.001173349035607 0.001159873292790 0.001100734264842 0.001100734264842 0.001100734264842 0.001100734264842 0.001100734264842 0.001100734264842 0.001100734264842 0.001100734264842 0.001095585839607 0.001082567917781 0.001069549995956 0.001056532074131 0.001043514152306 0.001030496230480 0.000968066218621 0.000968066218621 0.000968066218621 0.000968066218621 0.000968066218621 0.000968066218621 0.000968066218621 0.000968066218621 0.000957125207185 0.000944908311656 0.000932691416127 0.000920474520598 0.000908257625070 0.000896040729541 0.000827204937100 0.000827204937100 0.000827204937100 0.000827204937100 0.000827204937100 0.000827204937100 0.000827204937100 0.000823279719784 0.000812221638314 0.000801163556843 0.000790105475373 0.000779047393902 0.000767989312432 0.000756931230961 0.000678150420279 0.000678150420279 0.000678150420279 0.000678150420279 0.000678150420279 0.000678150420279 0.000678150420279 0.000670721809443 0.000661185630949 0.000651649452454 0.000642113273960 0.000632577095466 0.000623040916972 0.000613504738478 0.000520902668159 0.000520902668159 0.000520902668159 0.000520902668159 0.000520902668159 0.000520902668159 0.000519584967697 0.000511930057563 0.000504275147429 0.000496620237295 0.000488965327161 0.000481310417027 0.000473655506893 0.000466000596759 0.000355461680739 0.000355461680739 0.000355461680739 0.000355461680739 0.000355461680739 0.000355461680739 0.000352541239502 0.000347115266087 0.000341689292672 0.000336263319258 0.000330837345843 0.000325411372428 0.000319985399014 0.000314559425599 0.000181827458019 0.000181827458019 0.000181827458019 0.000181827458019 0.000181827458019 0.000181827458019 0.000179302640192 0.000176435443548 0.000173568246905 0.000170701050262 0.000167833853619 0.000164966656976 0.000162099460333 0.000159232263690 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 +-0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 0.000000000000000 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181827458019 -0.000181741280497 -0.000180510902201 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355461680739 -0.000355437743928 -0.000352741440649 -0.000350045137371 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000520902668159 -0.000517215224020 -0.000512824387249 -0.000508433550478 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000678150420279 -0.000674491351620 -0.000668192980892 -0.000661894610164 -0.000655596239436 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000827204937100 -0.000825134314431 -0.000816739650470 -0.000808344986509 -0.000799950322549 -0.000791555658588 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000968066218621 -0.000959032887889 -0.000948385389719 -0.000937737891550 -0.000927090393380 -0.000916442895210 -0.001100734264842 -0.001100734264842 -0.001100734264842 -0.001100734264842 -0.001100734264842 -0.001100734264842 -0.001100734264842 -0.001100734264842 -0.001095585839607 -0.001082567917781 -0.001069549995956 -0.001056532074131 -0.001043514152306 -0.001030496230480 -0.001225209075764 -0.001225209075764 -0.001225209075764 -0.001225209075764 -0.001225209075764 -0.001225209075764 -0.001225209075764 -0.001225209075764 -0.001211361855138 -0.001195899843355 -0.001180437831571 -0.001164975819788 -0.001149513808004 -0.001134051796220 -0.001341490651386 -0.001341490651386 -0.001341490651386 -0.001341490651386 -0.001341490651386 -0.001341490651386 -0.001341490651386 -0.001335125067602 -0.001317192011052 -0.001299258954503 -0.001281325897953 -0.001263392841404 -0.001245459784854 -0.001227526728305 -0.001449578991708 -0.001449578991708 -0.001449578991708 -0.001449578991708 -0.001449578991708 -0.001449578991708 -0.001449578991708 -0.001433699980379 -0.001413315942276 -0.001392931904174 -0.001372547866071 -0.001352163827968 -0.001331779789866 -0.001311395751763 -0.001549474096731 -0.001549474096731 -0.001549474096731 -0.001549474096731 -0.001549474096731 -0.001549474096731 -0.001545554472474 -0.001522784220582 -0.001500013968690 -0.001477243716797 -0.001454473464905 -0.001431703213013 -0.001408932961120 -0.001386162709228 -0.001641175966453 -0.001641175966453 -0.001641175966453 -0.001641175966453 -0.001641175966453 -0.001641175966453 -0.001627692212141 -0.001602640349605 -0.001577588487069 -0.001552536624533 -0.001527484761997 -0.001502432899461 -0.001477381036925 -0.001452329174389 -0.001724684600877 -0.001724684600877 -0.001724684600877 -0.001724684600877 -0.001724684600877 -0.001724684600877 -0.001700735993360 -0.001673539826446 -0.001646343659531 -0.001619147492616 -0.001591951325701 -0.001564755158787 -0.001537558991872 -0.001510362824957 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001794103238158 -0.001764923885790 -0.001735744533421 -0.001706565181053 -0.001677385828684 -0.001648206476316 -0.001619027123948 -0.001589847771579 -0.001560668419211 +-0.001000000000000 -0.000923076923077 -0.000846153846154 -0.000769230769231 -0.000692307692308 -0.000615384615385 -0.000538461538462 -0.000461538461538 -0.000384615384615 -0.000307692307692 -0.000230769230769 -0.000153846153846 -0.000076923076923 0.000000000000000 -0.000958158111598 -0.000877842818769 -0.000797527525940 -0.000717212233111 -0.000636896940282 -0.000556581647453 -0.000476266354624 -0.000395951061795 -0.000315635768965 -0.000235320476136 -0.000155005183307 -0.000074689890478 0.000005625402351 0.000085940695180 -0.000922753436796 -0.000838799004608 -0.000754844572419 -0.000670890140230 -0.000586935708041 -0.000502981275852 -0.000419026843664 -0.000335072411475 -0.000251117979286 -0.000167163547097 -0.000083209114908 0.000000745317280 0.000084699749469 0.000168654181658 -0.000893785975595 -0.000805816608392 -0.000717847241189 -0.000629877873987 -0.000541908506784 -0.000453939139581 -0.000365969772378 -0.000278000405175 -0.000190031037973 -0.000102061670770 -0.000014092303567 0.000073877063636 0.000161846430839 0.000249815798042 -0.000871255727994 -0.000778756360086 -0.000686256992178 -0.000593757624270 -0.000501258256361 -0.000408758888453 -0.000316259520545 -0.000223760152637 -0.000131260784729 -0.000038761416821 0.000053737951088 0.000146237318996 0.000238736686904 0.000331236054812 -0.000855162693993 -0.000757467113320 -0.000659771532646 -0.000562075951972 -0.000464380371299 -0.000366684790625 -0.000268989209952 -0.000171293629278 -0.000073598048604 0.000024097532069 0.000121793112743 0.000219488693416 0.000317184274090 0.000414879854764 -0.000845506873593 -0.000741784069704 -0.000638061265816 -0.000534338461927 -0.000430615658038 -0.000326892854150 -0.000223170050261 -0.000119447246372 -0.000015724442484 0.000087998361405 0.000191721165294 0.000295443969182 0.000399166773071 0.000502889576960 -0.000842288266793 -0.000731526628127 -0.000620764989461 -0.000510003350795 -0.000399241712130 -0.000288480073464 -0.000177718434798 -0.000066956796132 0.000043804842533 0.000154566481199 0.000265328119865 0.000376089758531 0.000486851397197 0.000597613035862 -0.000845506873593 -0.000726495755781 -0.000607484637970 -0.000488473520158 -0.000369462402347 -0.000250451284535 -0.000131440166724 -0.000012429048912 0.000106582068900 0.000225593186711 0.000344604304523 0.000463615422334 0.000582626540146 0.000701637657957 -0.000855162693993 -0.000726470742124 -0.000597778790255 -0.000469086838385 -0.000340394886516 -0.000211702934647 -0.000083010982778 0.000045680969092 0.000174372920961 0.000303064872830 0.000431756824700 0.000560448776569 0.000689140728438 0.000817832680307 -0.000871255727994 -0.000731205146496 -0.000591154564998 -0.000451103983500 -0.000311053402003 -0.000171002820505 -0.000030952239007 0.000109098342491 0.000249148923989 0.000389199505487 0.000529250086985 0.000669300668483 0.000809351249981 0.000949401831478 -0.000893785975595 -0.000740421677263 -0.000587057378930 -0.000433693080598 -0.000280328782265 -0.000126964483933 0.000026399814400 0.000179764112732 0.000333128411065 0.000486492709398 0.000639857007730 0.000793221306063 0.000946585604395 0.001099949902728 -0.000922753436796 -0.000753805633055 -0.000584857829314 -0.000415910025573 -0.000246962221832 -0.000078014418091 0.000090933385650 0.000259881189391 0.000428828993132 0.000597776796874 0.000766724600615 0.000935672404356 0.001104620208097 0.001273568011838 -0.000958158111598 -0.000770996375473 -0.000583834639348 -0.000396672903223 -0.000209511167098 -0.000022349430973 0.000164812305152 0.000351974041277 0.000539135777402 0.000726297513527 0.000913459249651 0.001100620985776 0.001287782721901 0.001474944458026 -0.001000000000000 -0.000791576054511 -0.000583152109023 -0.000374728163534 -0.000166304218046 0.000042119727443 0.000250543672931 0.000458967618420 0.000667391563909 0.000875815509397 0.001084239454886 0.001292663400374 0.001501087345863 0.001709511291351 +1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.842288266792756 0.842288266792757 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792756 0.842288266792757 0.842288266792756 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.845506873592904 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.855162693993348 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.871255727994087 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.893785975595122 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.922753436796452 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 0.958158111598078 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +PATCH 78 +13 2 +14 3 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.001272792206136 -0.001272792206136 -0.001272792206136 -0.001272792206136 -0.001272792206136 -0.001268622565850 -0.001247989647920 -0.001227356729990 -0.001206723812059 -0.001186090894129 -0.001165457976199 -0.001144825058268 -0.001124192140338 -0.001103559222408 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001794103238158 -0.001764923885790 -0.001735744533421 -0.001706565181053 -0.001677385828684 -0.001648206476316 -0.001619027123948 -0.001589847771579 -0.001560668419211 +-0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001800000000000 -0.001794103238158 -0.001764923885790 -0.001735744533421 -0.001706565181053 -0.001677385828684 -0.001648206476316 -0.001619027123948 -0.001589847771579 -0.001560668419211 -0.001272792206136 -0.001272792206136 -0.001272792206136 -0.001272792206136 -0.001272792206136 -0.001268622565850 -0.001247989647920 -0.001227356729990 -0.001206723812059 -0.001186090894129 -0.001165457976199 -0.001144825058268 -0.001124192140338 -0.001103559222408 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 -0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 +-0.001000000000000 -0.000791576054511 -0.000583152109023 -0.000374728163534 -0.000166304218046 0.000042119727443 0.000250543672931 0.000458967618420 0.000667391563909 0.000875815509397 0.001084239454886 0.001292663400374 0.001501087345863 0.001709511291351 -0.000707106781187 -0.000559728795970 -0.000412350810753 -0.000264972825537 -0.000117594840320 0.000029783144897 0.000177161130113 0.000324539115330 0.000471917100546 0.000619295085763 0.000766673070980 0.000914051056196 0.001061429041413 0.001208807026630 -0.001000000000000 -0.000791576054511 -0.000583152109023 -0.000374728163534 -0.000166304218046 0.000042119727443 0.000250543672931 0.000458967618420 0.000667391563909 0.000875815509397 0.001084239454886 0.001292663400374 0.001501087345863 0.001709511291351 +1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 0.707106781186547 0.707106781186548 0.707106781186547 0.707106781186548 0.707106781186547 0.707106781186548 0.707106781186547 0.707106781186547 0.707106781186548 0.707106781186547 0.707106781186548 0.707106781186547 0.707106781186548 0.707106781186547 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +PATCH 79 +14 2 +15 3 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 -0.000084503616606 -0.000166354117847 -0.000245524625540 -0.000321993305878 -0.000395742685060 -0.000466758645681 -0.000535029054774 -0.000600541960380 -0.000663283272908 -0.000723233817081 -0.000780365595008 -0.000834637032508 -0.000885986875597 -0.000934326238680 -0.001103559222408 -0.001117356191447 -0.001130276126953 -0.001142345378356 -0.001153585329020 -0.001164012116847 -0.001173636335474 -0.001182462682272 -0.001190489509681 -0.001197708223721 -0.001204102456021 -0.001209646910942 -0.001214305752959 -0.001218030344637 -0.001220756060571 -0.001560668419211 -0.001543573306297 -0.001526478193384 -0.001509383080470 -0.001492287967557 -0.001475192854643 -0.001458097741730 -0.001441002628816 -0.001423907515903 -0.001406812402989 -0.001389717290076 -0.001372622177162 -0.001355527064249 -0.001338431951335 -0.001321336838422 +-0.001560668419211 -0.001528921327554 -0.001494775935370 -0.001458334638708 -0.001419700916658 -0.001378978290034 -0.001336269281333 -0.001291674400298 -0.001245291180478 -0.001197213293441 -0.001147529768749 -0.001096324349336 -0.001043675013417 -0.000989653695363 -0.000934326238680 -0.001103559222408 -0.001062289045673 -0.001020768137742 -0.000979009764268 -0.000937023862218 -0.000894817630010 -0.000852396130754 -0.000809762897776 -0.000766920535245 -0.000723871311275 -0.000680617746750 -0.000637163210554 -0.000593512541586 -0.000549672731039 -0.000505653716638 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 +0.001709511291351 0.001779639749375 0.001854295060573 0.001934109222007 0.002019773445727 0.002112047256426 0.002211769505659 0.002319871820470 0.002437395177371 0.002565510535721 0.002705544811282 0.002859013974016 0.003027665798442 0.003213535919200 0.003419022582703 0.001208807026630 0.001322099992288 0.001437656384533 0.001555792201896 0.001676853050402 0.001801218692398 0.001929308553661 0.002061588447713 0.002198578862810 0.002340865278631 0.002489111153058 0.002644074471071 0.002806629119930 0.002977792916956 0.003158764985353 0.001709511291351 0.001831619240734 0.001953727190116 0.002075835139498 0.002197943088880 0.002320051038263 0.002442158987645 0.002564266937027 0.002686374886409 0.002808482835792 0.002930590785174 0.003052698734556 0.003174806683938 0.003296914633321 0.003419022582703 +1.000000000000000 0.989125647501612 0.979924272310669 0.972395874427170 0.966540453851115 0.962358010582504 0.959848544621338 0.959012055967616 0.959848544621338 0.962358010582504 0.966540453851115 0.972395874427170 0.979924272310669 0.989125647501612 1.000000000000000 0.707106781186547 0.717153372889121 0.728036453245416 0.739756022255434 0.752312079919173 0.765704626236635 0.779933661207819 0.794999184832725 0.810901197111353 0.827639698043704 0.845214687629776 0.863626165869571 0.882874132763087 0.902958588310326 0.923879532511287 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +PATCH 80 +14 2 +15 3 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000934326238680 -0.000947858213412 -0.000960184257278 -0.000971281996768 -0.000981125140436 -0.000989682689719 -0.000996917977983 -0.001002787490188 -0.001007239399223 -0.001010211731895 -0.001011630044360 -0.001011404438523 -0.001009425679011 -0.001005560061253 -0.000999642511596 -0.001220756060571 -0.001213145865456 -0.001205023200185 -0.001196380333714 -0.001187207149417 -0.001177490751128 -0.001167214983814 -0.001156359844709 -0.001144900752536 -0.001132807630703 -0.001120043743713 -0.001106564201587 -0.001092314010934 -0.001077225496288 -0.001061214830005 -0.001321336838422 -0.001304241725508 -0.001287146612595 -0.001270051499681 -0.001252956386768 -0.001235861273854 -0.001218766160941 -0.001201671048027 -0.001184575935113 -0.001167480822200 -0.001150385709286 -0.001133290596373 -0.001116195483459 -0.001099100370546 -0.001082005257632 +-0.000934326238680 -0.000896319425862 -0.000858366740678 -0.000820485741075 -0.000782694258964 -0.000745010480269 -0.000707453046074 -0.000670041179316 -0.000632794842752 -0.000595734935524 -0.000558883537928 -0.000522264217086 -0.000485902410568 -0.000449825911261 -0.000414065485828 -0.000505653716638 -0.000483185182771 -0.000460912171527 -0.000438840138599 -0.000416974619760 -0.000395321281245 -0.000373885978854 -0.000352674827692 -0.000331694285043 -0.000310951249684 -0.000290453182015 -0.000270208250973 -0.000250225515872 -0.000230515154565 -0.000211088754135 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 +0.003419022582703 0.003499084943941 0.003583542806884 0.003672754277478 0.003767116736956 0.003867073282130 0.003973120571143 0.004085818462889 0.004205801970071 0.004333796231423 0.004470635474236 0.004617287324927 0.004774884399054 0.004944765971310 0.005128533874054 0.003158764985353 0.003271401159022 0.003386235083543 0.003503445811889 0.003623232034678 0.003745815300314 0.003871443937870 0.004000397876793 0.004132994623433 0.004269596747159 0.004410621361614 0.004556552280009 0.004707955810123 0.004865501589300 0.005029990533722 0.003419022582703 0.003541130532085 0.003663238481467 0.003785346430850 0.003907454380232 0.004029562329614 0.004151670278996 0.004273778228379 0.004395886177761 0.004517994127143 0.004640102076525 0.004762210025908 0.004884317975290 0.005006425924672 0.005128533874054 +1.000000000000000 0.997255040057604 0.994932381644808 0.993032024761611 0.991553969408013 0.990498215584015 0.989864763289616 0.989653612524817 0.989864763289616 0.990498215584015 0.991553969408013 0.993032024761611 0.994932381644808 0.997255040057604 1.000000000000000 0.923879532511287 0.926571748818085 0.929475115889683 0.932589633726080 0.935915302327277 0.939452121693274 0.943200091824071 0.947159212719667 0.951329484380063 0.955710906805258 0.960303479995253 0.965107203950048 0.970122078669643 0.975348104154036 0.980785280403230 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +PATCH 81 +14 2 +15 3 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000999642511596 -0.000993853565343 -0.000987610628984 -0.000980892907513 -0.000973677300432 -0.000965938070142 -0.000957646449170 -0.000948770172150 -0.000939272914590 -0.000929113615205 -0.000918245651605 -0.000906615829535 -0.000894163132682 -0.000880817161643 -0.000866496164490 -0.001061214830005 -0.001050301070225 -0.001039167545967 -0.001027804388621 -0.001016200549867 -0.001004343634281 -0.000992219701173 -0.000979813028578 -0.000967105830384 -0.000954077914922 -0.000940706269882 -0.000926964553538 -0.000912822465742 -0.000898244962825 -0.000883191267498 -0.001082005257632 -0.001068203434079 -0.001054401610525 -0.001040599786971 -0.001026797963417 -0.001012996139863 -0.000999194316309 -0.000985392492755 -0.000971590669202 -0.000957788845648 -0.000943987022094 -0.000930185198540 -0.000916383374986 -0.000902581551432 -0.000888779727878 +-0.000414065485828 -0.000397748948340 -0.000381547033771 -0.000365463586781 -0.000349502688302 -0.000333668683427 -0.000317966213410 -0.000302400252551 -0.000286976150906 -0.000271699684009 -0.000256577111084 -0.000241615243617 -0.000226821526667 -0.000212204136013 -0.000197772095129 -0.000211088754135 -0.000202401420802 -0.000193818618333 -0.000185341573537 -0.000176971578160 -0.000168709997413 -0.000160558279737 -0.000152517968039 -0.000144590712698 -0.000136778286687 -0.000129082603281 -0.000121505736912 -0.000114049947918 -0.000106717712138 -0.000099511756603 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 +0.005128533874054 0.005202581457200 0.005279420689589 0.005359229851829 0.005442204959814 0.005528562256809 0.005618541161988 0.005712407779827 0.005810459103762 0.005913028086139 0.006020489798372 0.006133268975942 0.006251849340223 0.006376785225128 0.006508716229440 0.005029990533722 0.005120422116474 0.005212249523848 0.005305561896147 0.005400457241319 0.005497043680996 0.005595440924765 0.005695782024863 0.005798215478010 0.005902907760378 0.006010046407673 0.006119843787638 0.006232541760958 0.006348417494589 0.006467790787925 0.005128533874054 0.005227118328010 0.005325702781967 0.005424287235923 0.005522871689879 0.005621456143835 0.005720040597791 0.005818625051747 0.005917209505703 0.006015793959659 0.006114378413616 0.006212962867572 0.006311547321528 0.006410131775484 0.006508716229440 +1.000000000000000 0.999494499159660 0.999066767679372 0.998716805559137 0.998444612798953 0.998250189398823 0.998133535358744 0.998094650678718 0.998133535358744 0.998250189398823 0.998444612798953 0.998716805559137 0.999066767679372 0.999494499159660 1.000000000000000 0.980785280403230 0.981455882089490 0.982165368455775 0.982913739502087 0.983700995228425 0.984527135634789 0.985392160721179 0.986296070487596 0.987238864934038 0.988220544060507 0.989241107867002 0.990300556353523 0.991398889520070 0.992536107366643 0.993712209893243 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +PATCH 82 +14 2 +15 3 +0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000866496164490 -0.000859318215316 -0.000851921534874 -0.000844296202950 -0.000836431516111 -0.000828315904482 -0.000819936837191 -0.000811280714582 -0.000802332744912 -0.000793076802766 -0.000783495265849 -0.000773568826058 -0.000763276269830 -0.000752594221554 -0.000741496842341 -0.000883191267498 -0.000874394174660 -0.000865487874525 -0.000856467486064 -0.000847327733686 -0.000838062905456 -0.000828666805643 -0.000819132700626 -0.000809453257037 -0.000799620470726 -0.000789625584909 -0.000779458995417 -0.000769110140561 -0.000758567372490 -0.000747817806198 -0.000888779727878 -0.000878861801281 -0.000868943874683 -0.000859025948085 -0.000849108021488 -0.000839190094890 -0.000829272168292 -0.000819354241694 -0.000809436315097 -0.000799518388499 -0.000789600461901 -0.000779682535303 -0.000769764608706 -0.000759846682108 -0.000749928755510 +-0.000197772095129 -0.000191342029155 -0.000184955435512 -0.000178613332062 -0.000172316789610 -0.000166066936176 -0.000159864961739 -0.000153712123499 -0.000147609751741 -0.000141559256383 -0.000135562134317 -0.000129619977660 -0.000123734483063 -0.000117907462251 -0.000112140854014 -0.000099511756603 -0.000096175314453 -0.000092875195115 -0.000089611687668 -0.000086385094958 -0.000083195734750 -0.000080043941016 -0.000076930065347 -0.000073854478543 -0.000070817572378 -0.000067819761582 -0.000064861486069 -0.000061943213449 -0.000059065441879 -0.000056228703299 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 0.000000000000000 +0.006508716229440 0.006567099716553 0.006627019418721 0.006688550496117 0.006751773855330 0.006816776755551 0.006883653497023 0.006952506205559 0.007023445729674 0.007096592670325 0.007172078567522 0.007250047273399 0.007330656548093 0.007414079923287 0.007500508889212 0.006467790787925 0.006533818877223 0.006600615074049 0.006668216958488 0.006736664983837 0.006806002779689 0.006876277496167 0.006947540196177 0.007019846303976 0.007093256120043 0.007167835414383 0.007243656113064 0.007320797096152 0.007399345129491 0.007479395958196 0.006508716229440 0.006579558562281 0.006650400895122 0.006721243227963 0.006792085560804 0.006862927893644 0.006933770226485 0.007004612559326 0.007075454892167 0.007146297225008 0.007217139557849 0.007287981890690 0.007358824223531 0.007429666556372 0.007500508889212 +1.000000000000000 0.999901428082276 0.999818021074972 0.999749778978086 0.999696701791619 0.999658789515572 0.999636042149943 0.999628459694734 0.999636042149943 0.999658789515572 0.999696701791619 0.999749778978086 0.999818021074972 0.999901428082276 1.000000000000000 0.993712209893243 0.993910989908086 0.994117352378139 0.994331297303401 0.994552824683873 0.994781934519555 0.995018626810445 0.995262901556546 0.995514758757856 0.995774198414376 0.996041220526104 0.996315825093043 0.996598012115191 0.996887781592549 0.997185133525116 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +PATCH 83 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000150000000000 0.000259807621135 0.000300000000000 0.000338150477505 0.000699798293704 0.000888024735350 0.000526300955011 0.001139788966272 0.001476049470699 +-0.000259807621135 -0.000150000000000 -0.000000000000000 -0.000505554288073 -0.000277972489174 0.000169179888623 -0.000751300955011 -0.000405944978348 0.000338359777247 +0.007500000000000 0.006495190528383 0.007500000000000 0.007500000000000 0.006554800005498 0.007500000000000 0.007500000000000 0.006614409482613 0.007500000000000 +1.000000000000000 0.866025403784438 1.000000000000000 1.000000000000000 0.873973334066397 1.000000000000000 1.000000000000000 0.881921264348355 1.000000000000000 +PATCH 84 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000300000000000 0.000351278634152 0.000402557268303 0.000888024735350 0.000921655753156 0.000844499006545 0.001476049470699 0.001492032872160 0.001286440744786 +-0.000000000000000 0.000313778634152 0.000627557268303 0.000169179888623 0.000613186627175 0.001069499006545 0.000338359777247 0.000912594620199 0.001511440744786 +0.007500000000000 0.007500000000000 0.007500000000000 0.007500000000000 0.007338526258996 0.007500000000000 0.007500000000000 0.007177052517992 0.007500000000000 +1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 0.978470167866104 1.000000000000000 1.000000000000000 0.956940335732209 1.000000000000000 +PATCH 85 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000402557268303 0.000381730774974 0.000342723331867 0.000844499006545 0.000778226577576 0.000689954727504 0.001286440744786 0.001174722380178 0.001037186123141 +0.000627557268303 0.000737983417195 0.000849658010072 0.001069499006545 0.001221114950546 0.001369326517761 0.001511440744786 0.001704246483898 0.001888995025450 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 86 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000342723331867 0.000289463945198 0.000217477718672 0.000689954727504 0.000584086905715 0.000456654863900 0.001037186123141 0.000878709866231 0.000695832009128 +0.000849658010072 0.000960467376954 0.001068235709466 0.001369326517761 0.001511668167172 0.001645660417286 0.001888995025450 0.002062868957390 0.002223085125105 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 87 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000217477718672 0.000131228596327 0.000026788446852 0.000456654863900 0.000312656519611 0.000148719898112 0.000695832009128 0.000494084442895 0.000270651349372 +0.001068235709466 0.001170756691997 0.001265826002520 0.001645660417286 0.001768844401830 0.001878816802772 0.002223085125105 0.002366932111663 0.002491807603024 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 88 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000026788446852 -0.000090827665148 -0.000225000000000 0.000148719898112 -0.000029566952442 -0.000225000000000 0.000270651349372 0.000031693760264 -0.000225000000000 +0.001265826002520 0.001351274261685 0.001425000000000 0.001878816802772 0.001973264715855 0.002050000000000 0.002491807603024 0.002595255170025 0.002675000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 89 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.000370176515087 -0.000529218970894 -0.000225000000000 -0.000431437227793 -0.000651150422154 -0.000225000000000 -0.000492697940499 -0.000773081873414 +0.001425000000000 0.001485002209331 0.001529412046629 0.002050000000000 0.002106992663501 0.002142402846881 0.002675000000000 0.002728983117671 0.002755393647133 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 90 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000529218970894 -0.000696082733848 -0.000873170063568 -0.000651150422154 -0.000877510657132 -0.001112347208797 -0.000773081873414 -0.001058938580416 -0.001351524354025 +0.001529412046629 0.001556523264839 0.001564820958191 0.002142402846881 0.002154610974672 0.002142245666011 0.002755393647133 0.002752698684505 0.002719670373830 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 91 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000873170063568 -0.001054016754756 -0.001240651832239 -0.001112347208797 -0.001348639715272 -0.001587883227876 -0.001351524354025 -0.001643262675788 -0.001935114623513 +0.001564820958191 0.001553008226438 0.001520030384991 0.002142245666011 0.002104209016656 0.002039698892680 0.002719670373830 0.002655409806874 0.002559367400369 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 92 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001240651832239 -0.001426290084893 -0.001612697058079 -0.001587883227876 -0.001822785887495 -0.002054638796320 -0.001935114623513 -0.002219281690097 -0.002496580534562 +0.001520030384991 0.001465096374889 0.001387697058079 0.002039698892680 0.001948227908241 0.001829638796320 0.002559367400369 0.002431359441592 0.002271580534562 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 93 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001612697058079 -0.001792886218061 -0.001968487843297 -0.002054638796320 -0.002276017751413 -0.002488156350986 -0.002496580534562 -0.002759149284764 -0.003007824858675 +0.001387697058079 0.001287620118951 0.001164961332363 0.001829638796320 0.001684115921553 0.001512192728000 0.002271580534562 0.002080611724155 0.001859424123637 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 94 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001968487843297 -0.002132449299630 -0.002286406206916 -0.002488156350986 -0.002683650089848 -0.002863830914735 -0.003007824858675 -0.003234850880066 -0.003441255622555 +0.001164961332363 0.001020132000788 0.000853862408465 0.001512192728000 0.001314754961304 0.001093039553693 0.001859424123637 0.001609377921820 0.001332216698921 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 95 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002286406206916 -0.002423384116411 -0.002545170178954 -0.002863830914735 -0.003021471826243 -0.003158160979206 -0.003441255622555 -0.003619559536076 -0.003771151779458 +0.000853862408465 0.000667201187877 0.000461510543019 0.001093039553693 0.000848629111161 0.000583441994279 0.001332216698921 0.001030057034445 0.000705373445540 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 96 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002545170178954 -0.002645014406358 -0.002725000000000 -0.003158160979206 -0.003267004860529 -0.003350000000000 -0.003771151779458 -0.003888995314699 -0.003975000000000 +0.000461510543019 0.000238457324208 0.000000000000000 0.000583441994279 0.000299718036914 0.000000000000000 0.000705373445540 0.000360978749620 0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 97 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002725000000000 -0.002778742354005 -0.002808756223062 -0.003350000000000 -0.003400732808175 -0.003421747023314 -0.003975000000000 -0.004022723262345 -0.004034737823566 +0.000000000000000 -0.000251628377440 -0.000513941067061 0.000000000000000 -0.000312889090146 -0.000635872518321 0.000000000000000 -0.000374149802852 -0.000757803969581 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 98 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002808756223062 -0.002809150689253 -0.002782991455641 -0.003421747023314 -0.003407238399085 -0.003360416163460 -0.004034737823566 -0.004005326108918 -0.003937840871280 +-0.000513941067061 -0.000784222198395 -0.001059554753361 -0.000635872518321 -0.000965650121679 -0.001298731898589 -0.000757803969581 -0.001147078044963 -0.001537909043817 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 99 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002782991455641 -0.002724990149114 -0.002638860218216 -0.003360416163460 -0.003276190939332 -0.003158528725905 -0.003937840871280 -0.003827391729550 -0.003678197233594 +-0.001059554753361 -0.001336851683342 -0.001612889832735 -0.001298731898589 -0.001631474643859 -0.001960121228372 -0.001537909043817 -0.001926097604375 -0.002307352624010 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 100 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002638860218216 -0.002519999175755 -0.002372836847854 -0.003158528725905 -0.003003130709107 -0.002814778586096 -0.003678197233594 -0.003486262242459 -0.003256720324337 +-0.001612889832735 -0.001884346301867 -0.002147836847854 -0.001960121228372 -0.002280842104470 -0.002589778586096 -0.002307352624010 -0.002677337907072 -0.003031720324337 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 101 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002372836847854 -0.002193509462928 -0.001987199332859 -0.002814778586096 -0.002590005265530 -0.002334430728496 -0.003256720324337 -0.002986501068133 -0.002681662124134 +-0.002147836847854 -0.002399955891925 -0.002637317676522 -0.002589778586096 -0.002883087425276 -0.003156986184211 -0.003031720324337 -0.003366218958628 -0.003676654691900 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 102 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001987199332859 -0.001750800056377 -0.001490247098257 -0.002334430728496 -0.002045423016893 -0.001729424243485 -0.002681662124134 -0.002340045977409 -0.001968601388713 +-0.002637317676522 -0.002856598095303 -0.003054576704365 -0.003156986184211 -0.003407798885521 -0.003632001412185 -0.003676654691900 -0.003958999675739 -0.004209426120005 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 103 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001490247098257 -0.001203173779427 -0.000896232639187 -0.001729424243485 -0.001384601702711 -0.001018164090447 -0.001968601388713 -0.001566029625995 -0.001140095541707 +-0.003054576704365 -0.003228178413822 -0.003374514355387 -0.003632001412185 -0.003826266123654 -0.003987505155639 -0.004209426120005 -0.004424353833487 -0.004600495955891 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 104 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000896232639187 -0.000567742313564 -0.000225000000000 -0.001018164090447 -0.000629003026270 -0.000225000000000 -0.001140095541707 -0.000690263738975 -0.000225000000000 +-0.003374514355387 -0.003490921424030 -0.003575000000000 -0.003987505155639 -0.004112911878200 -0.004200000000000 -0.004600495955891 -0.004734902332370 -0.004825000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 105 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 0.000133080239793 0.000498663163229 -0.000225000000000 0.000194340952499 0.000620594614489 -0.000225000000000 0.000255601665205 0.000742526065749 +-0.003575000000000 -0.003624649371676 -0.003638100399496 -0.004200000000000 -0.004246639825847 -0.004251091199748 -0.004825000000000 -0.004868630280017 -0.004864082000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 106 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000498663163229 0.000872361662943 0.001245939443153 0.000620594614489 0.001053789586227 0.001485116588381 0.000742526065749 0.001235217509511 0.001724293733610 +-0.003638100399496 -0.003613944986664 -0.003551161953090 -0.004251091199748 -0.004212032696496 -0.004128586660910 -0.004864082000000 -0.004810120406329 -0.004706011368729 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 107 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001245939443153 0.001619686611929 0.001985127833231 0.001485116588381 0.001914309572445 0.002332359228868 0.001724293733610 0.002208932532962 0.002679590624506 +-0.003551161953090 -0.003449138944787 -0.003307690051441 -0.004128586660910 -0.004000339735005 -0.003827358559130 -0.004706011368729 -0.004551540525223 -0.004347027066819 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 108 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001985127833231 0.002342402518842 0.002682976637630 0.002332359228868 0.002738898321444 0.003124918375871 0.002679590624506 0.003135394124047 0.003566860114113 +-0.003307690051441 -0.003127068849619 -0.002907976637630 -0.003827358559130 -0.003610200382971 -0.003349918375871 -0.004347027066819 -0.004093331916322 -0.003791860114113 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 109 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002682976637630 0.003007025565788 0.003306147509747 0.003124918375871 0.003490157099140 0.003825816017436 0.003566860114113 0.003973288632492 0.004345484525126 +-0.002907976637630 -0.002651565679903 -0.002359437333355 -0.003349918375871 -0.003048061482505 -0.002706668728992 -0.003791860114113 -0.003444557285107 -0.003053900124630 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 110 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003306147509747 0.003580746890977 0.003822747201815 0.003825816017436 0.004131947681194 0.004400171909635 0.004345484525126 0.004683148471412 0.004977596617454 +-0.002359437333355 -0.002033634984963 -0.001676631788050 -0.002706668728992 -0.002328257945480 -0.001915808933278 -0.003053900124630 -0.002622880905996 -0.002154986078506 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 111 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003822747201815 0.004032972711233 0.004203858531821 0.004400171909635 0.004631060421065 0.004816849332073 0.004977596617454 0.005229148130898 0.005429840132325 +-0.001676631788050 -0.001291313243974 -0.000880954735354 -0.001915808933278 -0.001472741167258 -0.001002886186614 -0.002154986078506 -0.001654169090542 -0.001124817637874 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 112 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004203858531821 0.004336828441701 0.004425000000000 0.004816849332073 0.004958818895871 0.005050000000000 0.005429840132325 0.005580809350041 0.005675000000000 +-0.000880954735354 -0.000449194175917 -0.000000000000000 -0.001002886186614 -0.000510454888623 -0.000000000000000 -0.001124817637874 -0.000571715601329 -0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 113 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004425000000000 0.004470556389348 0.004467444575929 0.005050000000000 0.005092546843518 0.005080435376181 0.005675000000000 0.005714537297688 0.005693426176433 +-0.000000000000000 0.000462365229148 0.000933385259396 -0.000000000000000 0.000523625941854 0.001055316710656 -0.000000000000000 0.000584886654560 0.001177248161916 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 114 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004467444575929 0.004418739284075 0.004319332450540 0.005080435376181 0.005016826993907 0.004896757158359 0.005693426176433 0.005614914703740 0.005474181866179 +0.000933385259396 0.001408334254492 0.001882324132946 0.001055316710656 0.001589762177776 0.002121501278174 0.001177248161916 0.001771190101060 0.002360678423402 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 115 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004319332450540 0.004173287740461 0.003976519884666 0.004896757158359 0.004724488530678 0.004496188392355 0.005474181866179 0.005275689320896 0.005015856900044 +0.001882324132946 0.002350354667518 0.002807365833727 0.002121501278174 0.002644977628035 0.003154597229364 0.002360678423402 0.002939600588551 0.003501828625002 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 116 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003976519884666 0.003734138523483 0.003443116427405 0.004496188392355 0.004217270056834 0.003885058165647 0.005015856900044 0.004700401590186 0.004326999903888 +0.002807365833727 0.003248291862819 0.003668116427405 0.003154597229364 0.003644787665421 0.004110058165647 0.003501828625002 0.004041283468024 0.004551999903888 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 117 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003443116427405 0.003109621896877 0.002731675333851 0.003885058165647 0.003506117699480 0.003078906729488 0.004326999903888 0.003902613502082 0.003426138125126 +0.003668116427405 0.004061928366655 0.004424977342973 0.004110058165647 0.004545059900006 0.004944645850662 0.004551999903888 0.005028191433358 0.005464314358351 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 118 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002731675333851 0.002316469913550 0.001863016477842 0.003078906729488 0.002611092874066 0.002102193623070 0.003426138125126 0.002905715834583 0.002341370768298 +0.004424977342973 0.004752728813652 0.005040917699265 0.004944645850662 0.005303929603870 0.005618342407084 0.005464314358351 0.005855130394088 0.006195767114904 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 119 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001863016477842 0.001379452708521 0.000865676831521 0.002102193623070 0.001560880631805 0.000987608282782 0.002341370768298 0.001742308555090 0.001109539734042 +0.005040917699265 0.005285600135646 0.005483202708254 0.005618342407084 0.005883687845479 0.006096193508506 0.006195767114904 0.006481775555311 0.006709184308758 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 120 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000865676831521 0.000330646038270 -0.000225000000000 0.000987608282781 0.000391906750976 -0.000225000000000 0.001109539734042 0.000453167463682 -0.000225000000000 +0.005483202708254 0.005630568586375 0.005725000000000 0.006096193508506 0.006252559040545 0.006350000000000 0.006709184308758 0.006874549494715 0.006975000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 121 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.000791650218504 -0.001368107355563 -0.000225000000000 -0.000852910931210 -0.001490038806823 -0.000225000000000 -0.000914171643916 -0.001611970258083 +0.005725000000000 0.005764296534022 0.005746788752363 0.006350000000000 0.006386286988192 0.006359779552615 0.006975000000000 0.007008277442362 0.006972770352867 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 122 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001368107355563 -0.001944306846042 -0.002518708822738 -0.001490038806823 -0.002125734769326 -0.002757885967966 -0.001611970258083 -0.002307162692610 -0.002997063113195 +0.005746788752363 0.005671366708488 0.005537502947990 0.006359779552615 0.006269454418321 0.006114927655809 0.006972770352867 0.006867542128153 0.006692352363629 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 123 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002518708822738 -0.003081022723108 -0.003629603834223 -0.002757885967966 -0.003375645683624 -0.003976835229860 -0.002997063113195 -0.003670268644140 -0.004324066625498 +0.005537502947990 0.005345269663136 0.005095349717892 0.006114927655809 0.005896470453354 0.005615018225581 0.006692352363629 0.006447671243572 0.006134686733270 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 124 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003629603834223 -0.004154181206796 -0.004653256217181 -0.003976835229860 -0.004550677009399 -0.005095197955422 -0.004324066625498 -0.004947172812001 -0.005537139693664 +0.005095349717892 0.004789041324349 0.004428256217181 0.005615018225581 0.005272172857701 0.004870197955422 0.006134686733270 0.005755304391052 0.005312139693664 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 125 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004653256217181 -0.005116831167521 -0.005543807176198 -0.005095197955422 -0.005599962700872 -0.006063475683887 -0.005537139693664 -0.006083094234224 -0.006583144191576 +0.004428256217181 0.004015511240855 0.003553913334347 0.004870197955422 0.004412007043457 0.003901144729985 0.005312139693664 0.004808502846059 0.004248376125622 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 126 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.005543807176198 -0.005924710736328 -0.006259088196714 -0.006063475683887 -0.006475911526546 -0.006836512904534 -0.006583144191576 -0.007027112316763 -0.007413937612353 +0.003553913334347 0.003047137969139 0.002499401167634 0.003901144729985 0.003341760929656 0.002738578312863 0.004248376125622 0.003636383890172 0.002977755458091 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 127 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006259088196714 -0.006538227560059 -0.006762546884688 -0.006836512904534 -0.007136315269892 -0.007375537684940 -0.007413937612353 -0.007734402979725 -0.007988528485192 +0.002499401167634 0.001915425300071 0.001300398927689 0.002738578312863 0.002096853223355 0.001422330378949 0.002977755458091 0.002278281146639 0.001544261830209 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 128 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006762546884688 -0.006924308731049 -0.007025000000000 -0.007375537684940 -0.007546299185219 -0.007650000000000 -0.007988528485192 -0.008168289639389 -0.008275000000000 +0.001300398927689 0.000659931027625 0.000000000000000 0.001422330378949 0.000721191740331 0.000000000000000 0.001544261830209 0.000782452453037 0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 129 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.007025000000000 -0.007058036678695 -0.007026132928796 -0.007650000000000 -0.007680027132866 -0.007639123729048 -0.008275000000000 -0.008302017587036 -0.008252114529300 +0.000000000000000 -0.000673102080857 -0.001352829451731 0.000000000000000 -0.000734362793563 -0.001474760902991 0.000000000000000 -0.000795623506269 -0.001596692354251 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 130 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.007026132928796 -0.006923994132901 -0.006755673445439 -0.007639123729048 -0.007522081842734 -0.007333098153259 -0.008252114529300 -0.008120169552567 -0.007910522861078 +-0.001352829451731 -0.002032446310589 -0.002705093512531 -0.001474760902991 -0.002213874233873 -0.002944270657759 -0.001596692354251 -0.002395302157158 -0.003183447802987 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 131 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006755673445439 -0.006517251585812 -0.006214179551117 -0.007333098153259 -0.007068452376030 -0.006733848058806 -0.007910522861078 -0.007619653166248 -0.007253516566495 +-0.002705093512531 -0.003363857651694 -0.004001841834719 -0.002944270657759 -0.003658480612211 -0.004349073230357 -0.003183447802987 -0.003953103572727 -0.004696304625994 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 132 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006214179551117 -0.005843944125215 -0.005413396006956 -0.006733848058806 -0.006327075658567 -0.005855337745198 -0.007253516566495 -0.006810207191918 -0.006297279483439 +-0.004001841834719 -0.004612237423771 -0.005188396006956 -0.004349073230357 -0.005008733226373 -0.005630337745198 -0.004696304625994 -0.005405229028976 -0.006072279483439 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 133 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.005413396006956 -0.004921400584832 -0.004376151334843 -0.005855337745198 -0.005317896387434 -0.004723382730481 -0.006297279483439 -0.005714392190036 -0.005070614126118 +-0.005188396006956 -0.005723900841384 -0.006212637009423 -0.005630337745198 -0.006207032374736 -0.006732305517112 -0.006072279483439 -0.006690163908088 -0.007251974024801 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 134 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004376151334843 -0.003777806024728 -0.003135785857427 -0.004723382730481 -0.004072428985245 -0.003374963002655 -0.005070614126118 -0.004367051945761 -0.003614140147883 +-0.006212637009423 -0.006648859532001 -0.007027258694164 -0.006732305517112 -0.007200060322219 -0.007604683401984 -0.007251974024801 -0.007751261112437 -0.008182108109803 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 135 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003135785857427 -0.002451397891621 -0.001735121023856 -0.003374963002655 -0.002632825814905 -0.001857052475116 -0.003614140147883 -0.002814253738189 -0.001978983926376 +-0.007027258694164 -0.007343021857470 -0.007591891061121 -0.007604683401984 -0.007941109567303 -0.008204881861373 -0.008182108109803 -0.008539197277135 -0.008817872661625 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 136 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001735121023856 -0.000989216016981 -0.000225000000000 -0.001857052475116 -0.001050476729687 -0.000225000000000 -0.001978983926376 -0.001111737442393 -0.000225000000000 +-0.007591891061121 -0.007770215748720 -0.007875000000000 -0.008204881861373 -0.008392206202890 -0.008500000000000 -0.008817872661625 -0.009014196657061 -0.009125000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 137 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 0.000554553943210 0.001337551547898 -0.000225000000000 0.000615814655916 0.001459482999158 -0.000225000000000 0.000677075368622 0.001581414450418 +-0.007875000000000 -0.007903943696367 -0.007855477105230 -0.008500000000000 -0.008525934150537 -0.008468467905482 -0.009125000000000 -0.009147924604707 -0.009081458705734 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 138 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001337551547898 0.002120585775137 0.002891478202323 0.001459482999158 0.002302013698421 0.003130655347551 0.001581414450418 0.002483441621705 0.003369832492780 +-0.007855477105230 -0.007728788430312 -0.007523843942889 -0.008468467905482 -0.008326876140145 -0.008101268650708 -0.009081458705734 -0.008924963849977 -0.008678693358528 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 139 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002891478202323 0.003646692580281 0.004374079835215 0.003130655347551 0.003941315540797 0.004721311230853 0.003369832492780 0.004235938501313 0.005068542626490 +-0.007523843942889 -0.007241400381485 -0.006883009384342 -0.008101268650708 -0.007792601171703 -0.007402677892031 -0.008678693358528 -0.008343801961921 -0.007922346399720 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 140 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004374079835215 0.005070293640746 0.005723535796732 0.004721311230853 0.005466789443348 0.006165477534973 0.005068542626490 0.005863285245950 0.006607419273215 +-0.006883009384342 -0.006451013799079 -0.005948535796732 -0.007402677892031 -0.006934145332430 -0.006390477534973 -0.007922346399720 -0.007417276865782 -0.006832419273215 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 141 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.005723535796732 0.006330970515248 0.006881466842648 0.006165477534973 0.006814102048600 0.007401135350337 0.006607419273215 0.007297233581952 0.007920803858026 +-0.005948535796732 -0.005379456801806 -0.004748389335339 -0.006390477534973 -0.005775952604409 -0.005095620730977 -0.006832419273215 -0.006172448407011 -0.005442852126614 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 142 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006881466842648 0.007373008327675 0.007795429191614 0.007401135350337 0.007924209117892 0.008372853899433 0.007920803858026 0.008475409908110 0.008950278607253 +-0.004748389335339 -0.004060640953315 -0.003322170547219 -0.005095620730977 -0.004355263913831 -0.003561347692448 -0.005442852126614 -0.004649886874348 -0.003800524837676 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 143 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.007795429191614 0.008147816154881 0.008421235237555 0.008372853899433 0.008745903864714 0.009034226037807 0.008950278607253 0.009343991574546 0.009647216838059 +-0.003322170547219 -0.002539537356168 -0.001719843120023 -0.003561347692448 -0.002720965279452 -0.001841774571284 -0.003800524837676 -0.002902393202736 -0.001963706022544 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 144 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008421235237555 0.008616122766392 0.008725000000000 0.009034226037807 0.009238113220562 0.009350000000000 0.009647216838059 0.009860103674732 0.009975000000000 +-0.001719843120023 -0.000870667879334 -0.000000000000000 -0.001841774571284 -0.000931928592040 -0.000000000000000 -0.001963706022544 -0.000993189304746 -0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 145 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008725000000000 0.008749850714038 0.008684821281663 0.009350000000000 0.009371841168208 0.009297812081915 0.009975000000000 0.009993831622378 0.009910802882167 +-0.000000000000000 0.000883838932565 0.001772273644065 -0.000000000000000 0.000945099645271 0.001894205095325 -0.000000000000000 0.001006360357977 0.002016136546585 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 146 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008684821281663 0.008533582727723 0.008292014440338 0.009297812081915 0.009131670437556 0.008869439148158 0.009910802882167 0.009729758147388 0.009446863855978 +0.001772273644065 0.002656558366687 0.003527862892116 0.001894205095325 0.002837986289971 0.003767040037344 0.002016136546585 0.003019414213255 0.004006217182572 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 147 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008292014440338 0.007965549177159 0.007551839217567 0.008869439148158 0.008516749967376 0.008071507725256 0.009446863855978 0.009067950757594 0.008591176232945 +0.003527862892116 0.004377360635870 0.005196317835711 0.003767040037344 0.004671983596386 0.005543549231349 0.004006217182572 0.004966606556903 0.005890780626986 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 148 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.007551839217567 0.007058083472942 0.006483675586507 0.008071507725256 0.007541215006294 0.006925617324749 0.008591176232945 0.008024346539646 0.007367559062991 +0.005196317835711 0.005976182984723 0.006708675586507 0.005543549231349 0.006372678787325 0.007150617324749 0.005890780626986 0.006769174589927 0.007592559062991 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 149 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006483675586507 0.005837513018781 0.005120627335835 0.006925617324749 0.006234008821383 0.005467858731473 0.007367559062991 0.006630504623986 0.005815090127110 +0.006708675586507 0.007385873316114 0.008000296675874 0.007150617324749 0.007869004849466 0.008519965183563 0.007592559062991 0.008352136382818 0.009039633691252 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 150 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.005120627335835 0.004343475881902 0.003508555237012 0.005467858731473 0.004638098842418 0.003747732382240 0.005815090127110 0.004932721802934 0.003986909527468 +0.008000296675874 0.008544990250350 0.009013599689063 0.008519965183563 0.009096191040568 0.009591024396883 0.009039633691252 0.009647391830786 0.010168449104702 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 151 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003508555237012 0.002627676820716 0.001704565216191 0.003747732382240 0.002809104744000 0.001826496667451 0.003986909527468 0.002990532667284 0.001948428118711 +0.009013599689063 0.009400443579294 0.009700579413988 0.009591024396883 0.009998531289127 0.010313570214240 0.010168449104702 0.010596618998960 0.010926561014492 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 152 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001704565216191 0.000752119741687 -0.000225000000000 0.001826496667451 0.000813380454393 -0.000225000000000 0.001948428118711 0.000874641167099 -0.000225000000000 +0.009700579413988 0.009909862911065 0.010025000000000 0.010313570214240 0.010531853365236 0.010650000000000 0.010926561014492 0.011153843819406 0.011275000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 153 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.001213123921921 -0.002206995740233 -0.000225000000000 -0.001274384634627 -0.002328927191493 -0.000225000000000 -0.001335645347333 -0.002450858642753 +0.010025000000000 0.010043590858712 0.009964165458097 0.010650000000000 0.010665581312882 0.010577156258349 0.011275000000000 0.011287571767052 0.011190147058601 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 154 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002206995740233 -0.003192530958236 -0.004164247581908 -0.002328927191493 -0.003373958881520 -0.004403424727136 -0.002450858642753 -0.003555386804804 -0.004642601872365 +0.009964165458097 0.009786210152136 0.009510184937788 0.010577156258349 0.010384297861969 0.010087609645608 0.011190147058601 0.010982385571802 0.010665034353427 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 155 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004164247581908 -0.005108028691459 -0.006018555836208 -0.004403424727136 -0.005402651651976 -0.006365787231845 -0.004642601872365 -0.005697274612492 -0.006713018627482 +0.009510184937788 0.009137531099834 0.008670669050792 0.010087609645608 0.009688731890052 0.009190337558482 0.010665034353427 0.010239932680270 0.009710006066171 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 156 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006018555836208 -0.006882072328700 -0.007693815376283 -0.006365787231845 -0.007278568131302 -0.008135757114524 -0.006713018627482 -0.007675063933905 -0.008577698852766 +0.008670669050792 0.008112986273809 0.007468815376283 0.009190337558482 0.008596117807160 0.007910757114525 0.009710006066171 0.009079249340512 0.008352698852766 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 157 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.007693815376283 -0.008440776116980 -0.009119126509099 -0.008135757114524 -0.008923907650332 -0.009638795016788 -0.008577698852766 -0.009407039183684 -0.010158463524477 +0.007468815376283 0.006743402362758 0.005942865336332 0.007910757114525 0.007139898165361 0.006290096731969 0.008352698852766 0.007536393967963 0.006637328127606 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 158 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.009119126509099 -0.009716972173026 -0.010231770186513 -0.009638795016788 -0.010268172963244 -0.010809194894332 -0.010158463524477 -0.010819373753461 -0.011386619602152 +0.005942865336332 0.005074143937491 0.004144939926804 0.006290096731969 0.005368766898007 0.004384117072033 0.006637328127606 0.005663389858524 0.004623294217261 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 159 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.010231770186513 -0.010653071003708 -0.010979923590422 -0.010809194894332 -0.011251158713540 -0.011592914390674 -0.011386619602152 -0.011849246423373 -0.012205905190926 +0.004144939926804 0.003163649412265 0.002139287312358 0.004384117072033 0.003345077335549 0.002261218763618 0.004623294217261 0.003526505258834 0.002383150214878 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 160 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.010979923590422 -0.011203603055739 -0.011325000000000 -0.011592914390674 -0.011825593509909 -0.011950000000000 -0.012205905190926 -0.012447583964080 -0.012575000000000 +0.002139287312358 0.001081404731042 0.000000000000000 0.002261218763618 0.001142665443748 0.000000000000000 0.002383150214878 0.001203926156454 0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 161 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.011325000000000 -0.011337331003386 -0.011243509634530 -0.011950000000000 -0.011959321457556 -0.011856500434782 -0.012575000000000 -0.012581311911726 -0.012469491235034 +0.000000000000000 -0.001094575784274 -0.002191717836400 0.000000000000000 -0.001155836496980 -0.002313649287660 0.000000000000000 -0.001217097209686 -0.002435580738920 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 162 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.011243509634530 -0.011038837576550 -0.010728355435238 -0.011856500434782 -0.011636925286382 -0.011305780143057 -0.012469491235034 -0.012235012996215 -0.011883204850877 +-0.002191717836400 -0.003280670422784 -0.004350632271701 -0.002313649287660 -0.003462098346068 -0.004589809416929 -0.002435580738920 -0.003643526269352 -0.004828986562157 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 163 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.010728355435238 -0.010309513022510 -0.009789498884018 -0.011305780143057 -0.010860713812728 -0.010309167391707 -0.011883204850877 -0.011411914602945 -0.010828835899396 +-0.004350632271701 -0.005390863620046 -0.006390793836704 -0.004589809416929 -0.005685486580562 -0.006738025232341 -0.004828986562157 -0.005980109541079 -0.007085256627978 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 164 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.009789498884018 -0.009167889074675 -0.008453955166058 -0.010309167391707 -0.009651020608026 -0.008895896904300 -0.010828835899396 -0.010134152141378 -0.009337838642542 +-0.006390793836704 -0.007340128545675 -0.008228955166058 -0.006738025232341 -0.007736624348277 -0.008670896904300 -0.007085256627978 -0.008133120150879 -0.009112838642542 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 165 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.008453955166058 -0.007649291706735 -0.006765103336828 -0.008895896904300 -0.008045787509338 -0.007112334732465 -0.009337838642542 -0.008442283311940 -0.007459566128102 +-0.008228955166058 -0.009047845790844 -0.009787956342324 -0.008670896904300 -0.009530977324196 -0.010307624850013 -0.009112838642542 -0.010014108857548 -0.010827293357702 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 166 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006765103336828 -0.005804811993080 -0.004781324616597 -0.007112334732465 -0.006099434953597 -0.005020501761825 -0.007459566128102 -0.006394057914113 -0.005259678907053 +-0.009787956342324 -0.010441120968699 -0.010999940683963 -0.010307624850013 -0.010992321758917 -0.011577365391782 -0.010827293357702 -0.011543522549135 -0.012154790099602 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 167 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004781324616597 -0.003699622003815 -0.002574009408525 -0.005020501761825 -0.003881049927099 -0.002695940859786 -0.005259678907053 -0.004062477850383 -0.002817872311046 +-0.010999940683963 -0.011457865301119 -0.011809267766855 -0.011577365391782 -0.012055953010951 -0.012422258567107 -0.012154790099602 -0.012654040720784 -0.013035249367359 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 168 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002574009408525 -0.001410689720398 -0.000225000000000 -0.002695940859786 -0.001471950433104 -0.000225000000000 -0.002817872311046 -0.001533211145810 -0.000225000000000 +-0.011809267766855 -0.012049510073411 -0.012175000000000 -0.012422258567107 -0.012671500527581 -0.012800000000000 -0.013035249367359 -0.013293490981751 -0.013425000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 169 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 0.000976027646627 0.002176439932567 -0.000225000000000 0.001037288359333 0.002298371383827 -0.000225000000000 0.001098549072039 0.002420302835087 +-0.012175000000000 -0.012183238021057 -0.012072853810964 -0.012800000000000 -0.012805228475227 -0.012685844611216 -0.013425000000000 -0.013427218929398 -0.013298835411468 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 170 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002176439932567 0.003368809887331 0.004537016961493 0.002298371383827 0.003550237810615 0.004776194106721 0.002420302835087 0.003731665733899 0.005015371251949 +-0.012072853810964 -0.011843631873961 -0.011496525932687 -0.012685844611216 -0.012441719583793 -0.012073950640507 -0.013298835411468 -0.013039807293626 -0.012651375348326 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 171 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004537016961493 0.005673698548633 0.006763031837200 0.004776194106721 0.005968321509149 0.007110263232837 0.005015371251949 0.006262944469665 0.007457494628474 +-0.011496525932687 -0.011033661818183 -0.010458328717243 -0.012073950640507 -0.011584862608401 -0.010977997224932 -0.012651375348326 -0.012136063398619 -0.011497665732621 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 172 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006763031837200 0.007798184762649 0.008764094955834 0.007110263232837 0.008194680565252 0.009206036694076 0.007457494628474 0.008591176367854 0.009647978432317 +-0.010458328717243 -0.009774958748538 -0.008989094955834 -0.010977997224932 -0.010258090281890 -0.009431036694076 -0.011497665732621 -0.010741221815242 -0.009872978432317 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 173 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008764094955834 0.009654915464708 0.010456786175549 0.009206036694076 0.010138046998060 0.010976454683238 0.009647978432317 0.010621178531411 0.011496123190927 +-0.008989094955834 -0.008107347923710 -0.007137341337324 -0.009431036694076 -0.008503843726312 -0.007484572732961 -0.009872978432317 -0.008900339528915 -0.007831804128598 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 174 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.010456786175549 0.011165269764372 0.011768111181412 0.010976454683238 0.011716470554590 0.012345535889232 0.011496123190927 0.012267671344808 0.012922960597051 +-0.007137341337324 -0.006087646921667 -0.004967709306389 -0.007484572732961 -0.006382269882183 -0.005206886451617 -0.007831804128598 -0.006676892842700 -0.005446063596846 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 175 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.011768111181412 0.012262659598530 0.012638611943289 0.012345535889232 0.012860747308362 0.013251602743541 0.012922960597051 0.013458835018195 0.013864593543793 +-0.004967709306389 -0.003787761468363 -0.002558731504693 -0.005206886451617 -0.003969189391647 -0.002680662955953 -0.005446063596846 -0.004150617314931 -0.002802594407213 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 176 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.012638611943289 0.012895417091082 0.013025000000000 0.013251602743541 0.013517407545252 0.013650000000000 0.013864593543793 0.014139397999422 0.014275000000000 +-0.002558731504693 -0.001292141582751 -0.000000000000000 -0.002680662955953 -0.001353402295457 -0.000000000000000 -0.002802594407213 -0.001414663008163 -0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 177 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000741496842341 -0.000747817806198 -0.000749928755510 -0.000858898898676 -0.001020232996739 -0.001173674183515 -0.000976300955011 -0.001292648187281 -0.001597419611519 +0.000112140854014 0.000056228703299 -0.000000000000000 0.000431720904512 0.000338531018316 0.000183869363292 0.000751300955011 0.000620833333333 0.000367738726583 +0.007500508889212 0.007479395958196 0.007500508889212 0.007500254444606 0.007361919827682 0.007500254444606 0.007500000000000 0.007244443697168 0.007500000000000 +1.000000000000000 0.997185133525116 1.000000000000000 1.000000000000000 0.981555479907092 1.000000000000000 1.000000000000000 0.965925826289068 1.000000000000000 +PATCH 178 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000749928755510 -0.000747817806198 -0.000741496842341 -0.001173674183515 -0.001282575558556 -0.001342519937474 -0.001597419611519 -0.001817333310915 -0.001943543032606 +-0.000000000000000 -0.000056228703299 -0.000112140854014 0.000183869363292 -0.000028114351649 -0.000286311535879 0.000367738726583 0.000000000000000 -0.000460482217745 +0.007500508889212 0.007479395958196 0.007500508889212 0.007500254444606 0.007361919827682 0.007500254444606 0.007500000000000 0.007244443697168 0.007500000000000 +1.000000000000000 0.997185133525116 1.000000000000000 1.000000000000000 0.981555479907092 1.000000000000000 1.000000000000000 0.965925826289068 1.000000000000000 +PATCH 179 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000741496842341 -0.000797027055322 -0.000852557268303 -0.001342519937474 -0.001355163390991 -0.001294499006545 -0.001943543032606 -0.001913299726660 -0.001736440744786 +-0.000112140854014 -0.000369849061158 -0.000627557268303 -0.000286311535879 -0.000674507863912 -0.001069499006545 -0.000460482217745 -0.000979166666667 -0.001511440744786 +0.007500508889212 0.007500254444606 0.007500000000000 0.007500254444606 0.007372349070887 0.007500000000000 0.007500000000000 0.007244443697168 0.007500000000000 +1.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 0.982962913144534 1.000000000000000 1.000000000000000 0.965925826289068 1.000000000000000 +PATCH 180 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000852557268303 -0.000829563901976 -0.000792723331867 -0.001294499006545 -0.001226059704579 -0.001139954727504 -0.001736440744786 -0.001622555507181 -0.001487186123141 +-0.000627557268303 -0.000737983417195 -0.000849658010072 -0.001069499006545 -0.001221114950546 -0.001369326517761 -0.001511440744786 -0.001704246483898 -0.001888995025450 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 181 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000792723331867 -0.000737297072201 -0.000667477718672 -0.001139954727504 -0.001031920032717 -0.000906654863900 -0.001487186123141 -0.001326542993233 -0.001145832009128 +-0.000849658010072 -0.000960467376954 -0.001068235709466 -0.001369326517761 -0.001511668167172 -0.001645660417286 -0.001888995025450 -0.002062868957390 -0.002223085125105 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 182 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000667477718672 -0.000579061723330 -0.000476788446852 -0.000906654863900 -0.000760489646614 -0.000598719898112 -0.001145832009128 -0.000941917569898 -0.000720651349372 +-0.001068235709466 -0.001170756691997 -0.001265826002520 -0.001645660417286 -0.001768844401830 -0.001878816802772 -0.002223085125105 -0.002366932111663 -0.002491807603024 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 183 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000476788446852 -0.000357005461855 -0.000225000000000 -0.000598719898112 -0.000418266174561 -0.000225000000000 -0.000720651349372 -0.000479526887267 -0.000225000000000 +-0.001265826002520 -0.001351274261685 -0.001425000000000 -0.001878816802772 -0.001973264715855 -0.002050000000000 -0.002491807603024 -0.002595255170025 -0.002675000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 184 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.000077656611916 0.000079218970894 -0.000225000000000 -0.000016395899210 0.000201150422154 -0.000225000000000 0.000044864813496 0.000323081873414 +-0.001425000000000 -0.001485002209331 -0.001529412046629 -0.002050000000000 -0.002106992663501 -0.002142402846881 -0.002675000000000 -0.002728983117671 -0.002755393647133 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 185 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000079218970894 0.000248249606845 0.000423170063568 0.000201150422154 0.000429677530130 0.000662347208797 0.000323081873414 0.000611105453414 0.000901524354025 +-0.001529412046629 -0.001556523264839 -0.001564820958191 -0.002142402846881 -0.002154610974672 -0.002142245666011 -0.002755393647133 -0.002752698684505 -0.002719670373830 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 186 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000423170063568 0.000606183627753 0.000790651832239 0.000662347208797 0.000900806588270 0.001137883227876 0.000901524354025 0.001195429548786 0.001485114623513 +-0.001564820958191 -0.001553008226438 -0.001520030384991 -0.002142245666011 -0.002104209016656 -0.002039698892680 -0.002719670373830 -0.002655409806874 -0.002559367400369 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 187 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000790651832239 0.000978456957890 0.001162697058079 0.001137883227876 0.001374952760492 0.001604638796320 0.001485114623513 0.001771448563095 0.002046580534562 +-0.001520030384991 -0.001465096374889 -0.001387697058079 -0.002039698892680 -0.001948227908241 -0.001829638796320 -0.002559367400369 -0.002431359441592 -0.002271580534562 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 188 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001162697058079 0.001345053091058 0.001518487843297 0.001604638796320 0.001828184624410 0.002038156350986 0.002046580534562 0.002311316157762 0.002557824858675 +-0.001387697058079 -0.001287620118951 -0.001164961332363 -0.001829638796320 -0.001684115921553 -0.001512192728000 -0.002271580534562 -0.002080611724155 -0.001859424123637 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 189 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001518487843297 0.001684616172628 0.001836406206916 0.002038156350986 0.002235816962845 0.002413830914735 0.002557824858675 0.002787017753063 0.002991255622555 +-0.001164961332363 -0.001020132000788 -0.000853862408465 -0.001512192728000 -0.001314754961304 -0.001093039553693 -0.001859424123637 -0.001609377921820 -0.001332216698921 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 190 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001836406206916 0.001975550989408 0.002095170178954 0.002413830914735 0.002573638699241 0.002708160979206 0.002991255622555 0.003171726409074 0.003321151779458 +-0.000853862408465 -0.000667201187877 -0.000461510543019 -0.001093039553693 -0.000848629111161 -0.000583441994279 -0.001332216698921 -0.001030057034445 -0.000705373445540 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 191 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002095170178954 0.002197181279356 0.002275000000000 0.002708160979206 0.002819171733526 0.002900000000000 0.003321151779458 0.003441162187696 0.003525000000000 +-0.000461510543019 -0.000238457324208 -0.000000000000000 -0.000583441994279 -0.000299718036914 -0.000000000000000 -0.000705373445540 -0.000360978749620 -0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 192 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002275000000000 0.002330909227003 0.002358756223062 0.002900000000000 0.002952899681173 0.002971747023314 0.003525000000000 0.003574890135343 0.003584737823566 +-0.000000000000000 0.000251628377440 0.000513941067061 -0.000000000000000 0.000312889090146 0.000635872518321 -0.000000000000000 0.000374149802852 0.000757803969581 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 193 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002358756223062 0.002361317562250 0.002332991455641 0.002971747023314 0.002959405272083 0.002910416163460 0.003584737823566 0.003557492981916 0.003487840871280 +0.000513941067061 0.000784222198395 0.001059554753361 0.000635872518321 0.000965650121679 0.001298731898589 0.000757803969581 0.001147078044963 0.001537909043817 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 194 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002332991455641 0.002277157022112 0.002188860218216 0.002910416163460 0.002828357812329 0.002708528725905 0.003487840871280 0.003379558602547 0.003228197233594 +0.001059554753361 0.001336851683342 0.001612889832735 0.001298731898589 0.001631474643859 0.001960121228372 0.001537909043817 0.001926097604375 0.002307352624010 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 195 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002188860218216 0.002072166048753 0.001922836847854 0.002708528725905 0.002555297582104 0.002364778586096 0.003228197233594 0.003038429115456 0.002806720324337 +0.001612889832735 0.001884346301867 0.002147836847854 0.001960121228372 0.002280842104470 0.002589778586096 0.002307352624010 0.002677337907072 0.003031720324337 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 196 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001922836847854 0.001745676335926 0.001537199332859 0.002364778586096 0.002142172138528 0.001884430728496 0.002806720324337 0.002538667941130 0.002231662124134 +0.002147836847854 0.002399955891925 0.002637317676522 0.002589778586096 0.002883087425276 0.003156986184211 0.003031720324337 0.003366218958628 0.003676654691900 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 197 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001537199332859 0.001302966929374 0.001040247098257 0.001884430728496 0.001597589889890 0.001279424243485 0.002231662124134 0.001892212850407 0.001518601388713 +0.002637317676522 0.002856598095303 0.003054576704365 0.003156986184211 0.003407798885521 0.003632001412185 0.003676654691900 0.003958999675739 0.004209426120005 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 198 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001040247098257 0.000755340652424 0.000446232639187 0.001279424243485 0.000936768575708 0.000568164090447 0.001518601388713 0.001118196498992 0.000690095541707 +0.003054576704365 0.003228178413822 0.003374514355387 0.003632001412185 0.003826266123654 0.003987505155639 0.004209426120005 0.004424353833487 0.004600495955891 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 199 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000446232639187 0.000119909186561 -0.000225000000000 0.000568164090447 0.000181169899267 -0.000225000000000 0.000690095541707 0.000242430611973 -0.000225000000000 +0.003374514355387 0.003490921424030 0.003575000000000 0.003987505155639 0.004112911878200 0.004200000000000 0.004600495955891 0.004734902332370 0.004825000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 200 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.000580913366795 -0.000948663163229 -0.000225000000000 -0.000642174079501 -0.001070594614489 -0.000225000000000 -0.000703434792207 -0.001192526065749 +0.003575000000000 0.003624649371676 0.003638100399496 0.004200000000000 0.004246639825847 0.004251091199748 0.004825000000000 0.004868630280017 0.004864082000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 201 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000948663163229 -0.001320194789945 -0.001695939443153 -0.001070594614489 -0.001501622713229 -0.001935116588381 -0.001192526065749 -0.001683050636513 -0.002174293733610 +0.003638100399496 0.003613944986664 0.003551161953090 0.004251091199748 0.004212032696496 0.004128586660910 0.004864082000000 0.004810120406329 0.004706011368729 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 202 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001695939443153 -0.002067519738932 -0.002435127833231 -0.001935116588381 -0.002362142699448 -0.002782359228868 -0.002174293733610 -0.002656765659964 -0.003129590624506 +0.003551161953090 0.003449138944787 0.003307690051441 0.004128586660910 0.004000339735005 0.003827358559130 0.004706011368729 0.004551540525223 0.004347027066819 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 203 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002435127833231 -0.002790235645844 -0.003132976637630 -0.002782359228868 -0.003186731448447 -0.003574918375871 -0.003129590624506 -0.003583227251049 -0.004016860114113 +0.003307690051441 0.003127068849619 0.002907976637630 0.003827358559130 0.003610200382971 0.003349918375871 0.004347027066819 0.004093331916322 0.003791860114113 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 204 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003132976637630 -0.003454858692791 -0.003756147509747 -0.003574918375871 -0.003937990226143 -0.004275816017436 -0.004016860114113 -0.004421121759494 -0.004795484525126 +0.002907976637630 0.002651565679903 0.002359437333355 0.003349918375871 0.003048061482505 0.002706668728992 0.003791860114113 0.003444557285107 0.003053900124630 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 205 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003756147509747 -0.004028580017979 -0.004272747201815 -0.004275816017436 -0.004579780808197 -0.004850171909635 -0.004795484525126 -0.005130981598415 -0.005427596617454 +0.002359437333355 0.002033634984963 0.001676631788050 0.002706668728992 0.002328257945480 0.001915808933278 0.003053900124630 0.002622880905996 0.002154986078506 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 206 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004272747201815 -0.004480805838235 -0.004653858531821 -0.004850171909635 -0.005078893548068 -0.005266849332073 -0.005427596617454 -0.005676981257900 -0.005879840132325 +0.001676631788050 0.001291313243974 0.000880954735354 0.001915808933278 0.001472741167258 0.001002886186614 0.002154986078506 0.001654169090542 0.001124817637874 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 207 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004653858531821 -0.004784661568704 -0.004875000000000 -0.005266849332073 -0.005406652022874 -0.005500000000000 -0.005879840132325 -0.006028642477044 -0.006125000000000 +0.000880954735354 0.000449194175917 0.000000000000000 0.001002886186614 0.000510454888623 0.000000000000000 0.001124817637874 0.000571715601329 0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 208 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004875000000000 -0.004918389516350 -0.004917444575929 -0.005500000000000 -0.005540379970520 -0.005530435376181 -0.006125000000000 -0.006162370424690 -0.006143426176433 +0.000000000000000 -0.000462365229148 -0.000933385259396 0.000000000000000 -0.000523625941854 -0.001055316710656 0.000000000000000 -0.000584886654560 -0.001177248161916 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 209 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004917444575929 -0.004866572411077 -0.004769332450540 -0.005530435376181 -0.005464660120910 -0.005346757158359 -0.006143426176433 -0.006062747830742 -0.005924181866179 +-0.000933385259396 -0.001408334254492 -0.001882324132946 -0.001055316710656 -0.001589762177776 -0.002121501278174 -0.001177248161916 -0.001771190101060 -0.002360678423402 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 210 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004769332450540 -0.004621120867463 -0.004426519884666 -0.005346757158359 -0.005172321657681 -0.004946188392355 -0.005924181866179 -0.005723522447899 -0.005465856900044 +-0.001882324132946 -0.002350354667518 -0.002807365833727 -0.002121501278174 -0.002644977628035 -0.003154597229364 -0.002360678423402 -0.002939600588551 -0.003501828625002 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 211 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004426519884666 -0.004181971650485 -0.003893116427405 -0.004946188392355 -0.004665103183837 -0.004335058165647 -0.005465856900044 -0.005148234717189 -0.004776999903888 +-0.002807365833727 -0.003248291862819 -0.003668116427405 -0.003154597229364 -0.003644787665421 -0.004110058165647 -0.003501828625002 -0.004041283468024 -0.004551999903888 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 212 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003893116427405 -0.003557455023880 -0.003181675333851 -0.004335058165647 -0.003953950826482 -0.003528906729488 -0.004776999903888 -0.004350446629084 -0.003876138125126 +-0.003668116427405 -0.004061928366655 -0.004424977342973 -0.004110058165647 -0.004545059900006 -0.004944645850662 -0.004551999903888 -0.005028191433358 -0.005464314358351 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 213 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003181675333851 -0.002764303040553 -0.002313016477842 -0.003528906729488 -0.003058926001069 -0.002552193623070 -0.003876138125126 -0.003353548961585 -0.002791370768298 +-0.004424977342973 -0.004752728813652 -0.005040917699265 -0.004944645850662 -0.005303929603870 -0.005618342407084 -0.005464314358351 -0.005855130394088 -0.006195767114904 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 214 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002313016477842 -0.001827285835524 -0.001315676831521 -0.002552193623070 -0.002008713758808 -0.001437608282782 -0.002791370768298 -0.002190141682092 -0.001559539734042 +-0.005040917699265 -0.005285600135646 -0.005483202708254 -0.005618342407084 -0.005883687845479 -0.006096193508506 -0.006195767114904 -0.006481775555311 -0.006709184308758 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 215 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001315676831521 -0.000778479165272 -0.000225000000000 -0.001437608282782 -0.000839739877978 -0.000225000000000 -0.001559539734042 -0.000901000590684 -0.000225000000000 +-0.005483202708254 -0.005630568586375 -0.005725000000000 -0.006096193508506 -0.006252559040545 -0.006350000000000 -0.006709184308758 -0.006874549494715 -0.006975000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 216 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 0.000343817091501 0.000918107355563 -0.000225000000000 0.000405077804207 0.001040038806823 -0.000225000000000 0.000466338516913 0.001161970258083 +-0.005725000000000 -0.005764296534022 -0.005746788752363 -0.006350000000000 -0.006386286988192 -0.006359779552615 -0.006975000000000 -0.007008277442362 -0.006972770352867 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 217 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000918107355563 0.001496473719040 0.002068708822738 0.001040038806823 0.001677901642324 0.002307885967966 0.001161970258083 0.001859329565608 0.002547063113195 +-0.005746788752363 -0.005671366708488 -0.005537502947990 -0.006359779552615 -0.006269454418321 -0.006114927655809 -0.006972770352867 -0.006867542128153 -0.006692352363629 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 218 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002068708822738 0.002633189596105 0.003179603834223 0.002307885967966 0.002927812556621 0.003526835229860 0.002547063113195 0.003222435517138 0.003874066625498 +-0.005537502947990 -0.005345269663136 -0.005095349717892 -0.006114927655809 -0.005896470453354 -0.005615018225581 -0.006692352363629 -0.006447671243572 -0.006134686733270 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 219 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003179603834223 0.003706348079794 0.004203256217181 0.003526835229860 0.004102843882396 0.004645197955422 0.003874066625498 0.004499339684998 0.005087139693664 +-0.005095349717892 -0.004789041324349 -0.004428256217181 -0.005615018225581 -0.005272172857701 -0.004870197955422 -0.006134686733270 -0.005755304391052 -0.005312139693664 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 220 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004203256217181 0.004668998040518 0.005093807176198 0.004645197955422 0.005152129573870 0.005613475683887 0.005087139693664 0.005635261107222 0.006133144191576 +-0.004428256217181 -0.004015511240855 -0.003553913334347 -0.004870197955422 -0.004412007043457 -0.003901144729985 -0.005312139693664 -0.004808502846059 -0.004248376125622 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 221 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.005093807176198 0.005476877609326 0.005809088196714 0.005613475683887 0.006028078399543 0.006386512904534 0.006133144191576 0.006579279189761 0.006963937612353 +-0.003553913334347 -0.003047137969139 -0.002499401167634 -0.003901144729985 -0.003341760929656 -0.002738578312863 -0.004248376125622 -0.003636383890172 -0.002977755458091 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 222 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.005809088196714 0.006090394433057 0.006312546884688 0.006386512904534 0.006688482142889 0.006925537684940 0.006963937612353 0.007286569852722 0.007538528485192 +-0.002499401167634 -0.001915425300071 -0.001300398927689 -0.002738578312863 -0.002096853223355 -0.001422330378949 -0.002977755458091 -0.002278281146639 -0.001544261830209 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 223 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006312546884688 0.006476475604046 0.006575000000000 0.006925537684940 0.007098466058217 0.007200000000000 0.007538528485192 0.007720456512387 0.007825000000000 +-0.001300398927689 -0.000659931027625 -0.000000000000000 -0.001422330378949 -0.000721191740331 -0.000000000000000 -0.001544261830209 -0.000782452453037 -0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 224 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006575000000000 0.006610203551693 0.006576132928796 0.007200000000000 0.007232194005863 0.007189123729048 0.007825000000000 0.007854184460033 0.007802114529300 +-0.000000000000000 0.000673102080857 0.001352829451731 -0.000000000000000 0.000734362793563 0.001474760902991 -0.000000000000000 0.000795623506269 0.001596692354251 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 225 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006576132928796 0.006476161005899 0.006305673445439 0.007189123729048 0.007074248715731 0.006883098153259 0.007802114529300 0.007672336425564 0.007460522861078 +0.001352829451731 0.002032446310589 0.002705093512531 0.001474760902991 0.002213874233873 0.002944270657759 0.001596692354251 0.002395302157158 0.003183447802987 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 226 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006305673445439 0.006069418458810 0.005764179551117 0.006883098153259 0.006620619249027 0.006283848058806 0.007460522861078 0.007171820039245 0.006803516566495 +0.002705093512531 0.003363857651694 0.004001841834719 0.002944270657759 0.003658480612211 0.004349073230357 0.003183447802987 0.003953103572727 0.004696304625994 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 227 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.005764179551117 0.005396110998213 0.004963396006956 0.006283848058806 0.005879242531564 0.005405337745198 0.006803516566495 0.006362374064916 0.005847279483439 +0.004001841834719 0.004612237423771 0.005188396006956 0.004349073230357 0.005008733226373 0.005630337745198 0.004696304625994 0.005405229028976 0.006072279483439 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 228 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004963396006956 0.004473567457829 0.003926151334843 0.005405337745198 0.004870063260432 0.004273382730481 0.005847279483439 0.005266559063034 0.004620614126118 +0.005188396006956 0.005723900841384 0.006212637009423 0.005630337745198 0.006207032374736 0.006732305517112 0.006072279483439 0.006690163908088 0.007251974024801 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 229 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003926151334843 0.003329972897726 0.002685785857427 0.004273382730481 0.003624595858242 0.002924963002655 0.004620614126118 0.003919218818759 0.003164140147883 +0.006212637009423 0.006648859532001 0.007027258694164 0.006732305517112 0.007200060322219 0.007604683401984 0.007251974024801 0.007751261112437 0.008182108109803 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 230 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002685785857427 0.002003564764619 0.001285121023856 0.002924963002655 0.002184992687903 0.001407052475116 0.003164140147883 0.002366420611187 0.001528983926376 +0.007027258694164 0.007343021857470 0.007591891061121 0.007604683401984 0.007941109567303 0.008204881861373 0.008182108109803 0.008539197277135 0.008817872661625 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 231 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001285121023856 0.000541382889978 -0.000225000000000 0.001407052475116 0.000602643602684 -0.000225000000000 0.001528983926376 0.000663904315390 -0.000225000000000 +0.007591891061121 0.007770215748720 0.007875000000000 0.008204881861373 0.008392206202890 0.008500000000000 0.008817872661625 0.009014196657061 0.009125000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 232 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.001002387070212 -0.001787551547898 -0.000225000000000 -0.001063647782918 -0.001909482999158 -0.000225000000000 -0.001124908495624 -0.002031414450418 +0.007875000000000 0.007903943696367 0.007855477105230 0.008500000000000 0.008525934150537 0.008468467905482 0.009125000000000 0.009147924604707 0.009081458705734 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 233 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.001787551547898 -0.002568418902139 -0.003341478202323 -0.001909482999158 -0.002749846825423 -0.003580655347551 -0.002031414450418 -0.002931274748707 -0.003819832492780 +0.007855477105230 0.007728788430312 0.007523843942889 0.008468467905482 0.008326876140145 0.008101268650708 0.009081458705734 0.008924963849977 0.008678693358528 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 234 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003341478202323 -0.004094525707283 -0.004824079835215 -0.003580655347551 -0.004389148667800 -0.005171311230853 -0.003819832492780 -0.004683771628316 -0.005518542626490 +0.007523843942889 0.007241400381485 0.006883009384342 0.008101268650708 0.007792601171703 0.007402677892031 0.008678693358528 0.008343801961921 0.007922346399720 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 235 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004824079835215 -0.005518126767748 -0.006173535796732 -0.005171311230853 -0.005914622570350 -0.006615477534973 -0.005518542626490 -0.006311118372953 -0.007057419273215 +0.006883009384342 0.006451013799079 0.005948535796732 0.007402677892031 0.006934145332430 0.006390477534973 0.007922346399720 0.007417276865782 0.006832419273215 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 236 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006173535796732 -0.006778803642251 -0.007331466842648 -0.006615477534973 -0.007261935175602 -0.007851135350337 -0.007057419273215 -0.007745066708954 -0.008370803858026 +0.005948535796732 0.005379456801806 0.004748389335339 0.006390477534973 0.005775952604409 0.005095620730977 0.006832419273215 0.006172448407011 0.005442852126614 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 237 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.007331466842648 -0.007820841454677 -0.008245429191614 -0.007851135350337 -0.008372042244895 -0.008822853899433 -0.008370803858026 -0.008923243035112 -0.009400278607253 +0.004748389335339 0.004060640953315 0.003322170547219 0.005095620730977 0.004355263913831 0.003561347692448 0.005442852126614 0.004649886874348 0.003800524837676 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 238 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.008245429191614 -0.008595649281883 -0.008871235237555 -0.008822853899433 -0.009193736991716 -0.009484226037807 -0.009400278607253 -0.009791824701549 -0.010097216838059 +0.003322170547219 0.002539537356168 0.001719843120023 0.003561347692448 0.002720965279452 0.001841774571284 0.003800524837676 0.002902393202736 0.001963706022544 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 239 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.008871235237555 -0.009063955893394 -0.009175000000000 -0.009484226037807 -0.009685946347564 -0.009800000000000 -0.010097216838059 -0.010307936801734 -0.010425000000000 +0.001719843120023 0.000870667879334 0.000000000000000 0.001841774571284 0.000931928592040 0.000000000000000 0.001963706022544 0.000993189304746 0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 240 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.009175000000000 -0.009197683841041 -0.009134821281663 -0.009800000000000 -0.009819674295211 -0.009747812081915 -0.010425000000000 -0.010441664749381 -0.010360802882167 +0.000000000000000 -0.000883838932565 -0.001772273644065 0.000000000000000 -0.000945099645271 -0.001894205095325 0.000000000000000 -0.001006360357977 -0.002016136546585 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 241 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.009134821281663 -0.008981415854726 -0.008742014440338 -0.009747812081915 -0.009579503564558 -0.009319439148158 -0.010360802882167 -0.010177591274391 -0.009896863855978 +-0.001772273644065 -0.002656558366687 -0.003527862892116 -0.001894205095325 -0.002837986289971 -0.003767040037344 -0.002016136546585 -0.003019414213255 -0.004006217182572 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 242 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.008742014440338 -0.008413382304161 -0.008001839217567 -0.009319439148158 -0.008964583094379 -0.008521507725256 -0.009896863855978 -0.009515783884596 -0.009041176232945 +-0.003527862892116 -0.004377360635870 -0.005196317835711 -0.003767040037344 -0.004671983596386 -0.005543549231349 -0.004006217182572 -0.004966606556903 -0.005890780626986 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 243 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.008001839217567 -0.007505916599945 -0.006933675586507 -0.008521507725256 -0.007989048133297 -0.007375617324749 -0.009041176232945 -0.008472179666648 -0.007817559062991 +-0.005196317835711 -0.005976182984723 -0.006708675586507 -0.005543549231349 -0.006372678787325 -0.007150617324749 -0.005890780626986 -0.006769174589927 -0.007592559062991 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 244 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.006933675586507 -0.006285346145784 -0.005570627335835 -0.007375617324749 -0.006681841948386 -0.005917858731473 -0.007817559062991 -0.007078337750988 -0.006265090127110 +-0.006708675586507 -0.007385873316114 -0.008000296675874 -0.007150617324749 -0.007869004849466 -0.008519965183563 -0.007592559062991 -0.008352136382818 -0.009039633691252 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 245 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.005570627335835 -0.004791309008904 -0.003958555237012 -0.005917858731473 -0.005085931969421 -0.004197732382240 -0.006265090127110 -0.005380554929937 -0.004436909527468 +-0.008000296675874 -0.008544990250350 -0.009013599689063 -0.008519965183563 -0.009096191040568 -0.009591024396883 -0.009039633691252 -0.009647391830786 -0.010168449104702 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 246 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.003958555237012 -0.003075509947718 -0.002154565216191 -0.004197732382240 -0.003256937871002 -0.002276496667451 -0.004436909527468 -0.003438365794286 -0.002398428118711 +-0.009013599689063 -0.009400443579294 -0.009700579413988 -0.009591024396883 -0.009998531289127 -0.010313570214240 -0.010168449104702 -0.010596618998960 -0.010926561014492 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 247 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002154565216191 -0.001199952868689 -0.000225000000000 -0.002276496667451 -0.001261213581395 -0.000225000000000 -0.002398428118711 -0.001322474294101 -0.000225000000000 +-0.009700579413988 -0.009909862911065 -0.010025000000000 -0.010313570214240 -0.010531853365236 -0.010650000000000 -0.010926561014492 -0.011153843819406 -0.011275000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 248 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 0.000765290794918 0.001756995740233 -0.000225000000000 0.000826551507624 0.001878927191493 -0.000225000000000 0.000887812220330 0.002000858642753 +-0.010025000000000 -0.010043590858712 -0.009964165458097 -0.010650000000000 -0.010665581312882 -0.010577156258349 -0.011275000000000 -0.011287571767052 -0.011190147058601 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 249 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.001756995740233 0.002744697831234 0.003714247581908 0.001878927191493 0.002926125754518 0.003953424727136 0.002000858642753 0.003107553677802 0.004192601872365 +-0.009964165458097 -0.009786210152136 -0.009510184937788 -0.010577156258349 -0.010384297861969 -0.010087609645608 -0.011190147058601 -0.010982385571802 -0.010665034353427 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 250 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.003714247581908 0.004660195564457 0.005568555836208 0.003953424727136 0.004954818524973 0.005915787231845 0.004192601872365 0.005249441485489 0.006263018627482 +-0.009510184937788 -0.009137531099834 -0.008670669050792 -0.010087609645608 -0.009688731890052 -0.009190337558482 -0.010665034353427 -0.010239932680270 -0.009710006066171 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 251 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.005568555836208 0.006434239201698 0.007243815376283 0.005915787231845 0.006830735004300 0.007685757114524 0.006263018627482 0.007227230806902 0.008127698852766 +-0.008670669050792 -0.008112986273809 -0.007468815376283 -0.009190337558482 -0.008596117807160 -0.007910757114525 -0.009710006066171 -0.009079249340512 -0.008352698852766 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 252 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.007243815376283 0.007992942989978 0.008669126509099 0.007685757114524 0.008476074523330 0.009188795016788 0.008127698852766 0.008959206056681 0.009708463524477 +-0.007468815376283 -0.006743402362758 -0.005942865336332 -0.007910757114525 -0.007139898165361 -0.006290096731969 -0.008352698852766 -0.007536393967963 -0.006637328127606 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 253 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008669126509099 0.009269139046023 0.009781770186513 0.009188795016788 0.009820339836241 0.010359194894332 0.009708463524477 0.010371540626459 0.010936619602152 +-0.005942865336332 -0.005074143937491 -0.004144939926804 -0.006290096731969 -0.005368766898007 -0.004384117072033 -0.006637328127606 -0.005663389858524 -0.004623294217261 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 254 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.009781770186513 0.010205237876705 0.010529923590422 0.010359194894332 0.010803325586538 0.011142914390674 0.010936619602152 0.011401413296371 0.011755905190926 +-0.004144939926804 -0.003163649412265 -0.002139287312358 -0.004384117072033 -0.003345077335549 -0.002261218763618 -0.004623294217261 -0.003526505258834 -0.002383150214878 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 255 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.010529923590422 0.010755769928737 0.010875000000000 0.011142914390674 0.011377760382907 0.011500000000000 0.011755905190926 0.011999750837077 0.012125000000000 +-0.002139287312358 -0.001081404731042 -0.000000000000000 -0.002261218763618 -0.001142665443748 -0.000000000000000 -0.002383150214878 -0.001203926156454 -0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 256 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.010875000000000 0.010889497876383 0.010793509634530 0.011500000000000 0.011511488330554 0.011406500434782 0.012125000000000 0.012133478784724 0.012019491235034 +-0.000000000000000 0.001094575784274 0.002191717836400 -0.000000000000000 0.001155836496980 0.002313649287660 -0.000000000000000 0.001217097209686 0.002435580738920 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 257 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.010793509634530 0.010591004449547 0.010278355435238 0.011406500434782 0.011189092159380 0.010855780143057 0.012019491235034 0.011787179869213 0.011433204850877 +0.002191717836400 0.003280670422784 0.004350632271701 0.002313649287660 0.003462098346068 0.004589809416929 0.002435580738920 0.003643526269352 0.004828986562157 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 258 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.010278355435238 0.009861679895508 0.009339498884018 0.010855780143057 0.010412880685725 0.009859167391707 0.011433204850877 0.010964081475943 0.010378835899396 +0.004350632271701 0.005390863620046 0.006390793836704 0.004589809416929 0.005685486580562 0.006738025232341 0.004828986562157 0.005980109541079 0.007085256627978 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 259 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.009339498884018 0.008720055947672 0.008003955166058 0.009859167391707 0.009203187481024 0.008445896904300 0.010378835899396 0.009686319014376 0.008887838642542 +0.006390793836704 0.007340128545675 0.008228955166058 0.006738025232341 0.007736624348277 0.008670896904300 0.007085256627978 0.008133120150879 0.009112838642542 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 260 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.008003955166058 0.007201458579733 0.006315103336828 0.008445896904300 0.007597954382335 0.006662334732465 0.008887838642542 0.007994450184937 0.007009566128102 +0.008228955166058 0.009047845790844 0.009787956342324 0.008670896904300 0.009530977324196 0.010307624850013 0.009112838642542 0.010014108857548 0.010827293357702 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 261 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.006315103336828 0.005356978866078 0.004331324616597 0.006662334732465 0.005651601826594 0.004570501761825 0.007009566128102 0.005946224787110 0.004809678907053 +0.009787956342324 0.010441120968699 0.010999940683963 0.010307624850013 0.010992321758917 0.011577365391782 0.010827293357702 0.011543522549135 0.012154790099602 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 262 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.004331324616597 0.003251788876813 0.002124009408525 0.004570501761825 0.003433216800097 0.002245940859786 0.004809678907053 0.003614644723381 0.002367872311046 +0.010999940683963 0.011457865301119 0.011809267766855 0.011577365391782 0.012055953010951 0.012422258567107 0.012154790099602 0.012654040720784 0.013035249367359 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 263 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.002124009408525 0.000962856593395 -0.000225000000000 0.002245940859786 0.001024117306101 -0.000225000000000 0.002367872311046 0.001085378018807 -0.000225000000000 +0.011809267766855 0.012049510073411 0.012175000000000 0.012422258567107 0.012671500527581 0.012800000000000 0.013035249367359 0.013293490981751 0.013425000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 264 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.000225000000000 -0.001423860773630 -0.002626439932567 -0.000225000000000 -0.001485121486336 -0.002748371383827 -0.000225000000000 -0.001546382199041 -0.002870302835087 +0.012175000000000 0.012183238021057 0.012072853810964 0.012800000000000 0.012805228475227 0.012685844611216 0.013425000000000 0.013427218929398 0.013298835411468 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 265 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.002626439932567 -0.003816643014333 -0.004987016961493 -0.002748371383827 -0.003998070937617 -0.005226194106721 -0.002870302835087 -0.004179498860902 -0.005465371251949 +0.012072853810964 0.011843631873961 0.011496525932687 0.012685844611216 0.012441719583793 0.012073950640507 0.013298835411468 0.013039807293626 0.012651375348326 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 266 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.004987016961493 -0.006121531675635 -0.007213031837200 -0.005226194106721 -0.006416154636151 -0.007560263232837 -0.005465371251949 -0.006710777596668 -0.007907494628474 +0.011496525932687 0.011033661818183 0.010458328717243 0.012073950640507 0.011584862608401 0.010977997224932 0.012651375348326 0.012136063398619 0.011497665732621 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 267 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.007213031837200 -0.008246017889652 -0.009214094955834 -0.007560263232837 -0.008642513692254 -0.009656036694076 -0.007907494628474 -0.009039009494856 -0.010097978432317 +0.010458328717243 0.009774958748538 0.008989094955834 0.010977997224932 0.010258090281890 0.009431036694076 0.011497665732621 0.010741221815242 0.009872978432317 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 268 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.009214094955834 -0.010102748591710 -0.010906786175549 -0.009656036694076 -0.010585880125062 -0.011426454683238 -0.010097978432317 -0.011069011658414 -0.011946123190927 +0.008989094955834 0.008107347923710 0.007137341337324 0.009431036694076 0.008503843726312 0.007484572732961 0.009872978432317 0.008900339528915 0.007831804128598 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 269 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.010906786175549 -0.011613102891375 -0.012218111181412 -0.011426454683238 -0.012164303681593 -0.012795535889232 -0.011946123190927 -0.012715504471810 -0.013372960597051 +0.007137341337324 0.006087646921667 0.004967709306389 0.007484572732961 0.006382269882183 0.005206886451617 0.007831804128598 0.006676892842700 0.005446063596846 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 270 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.012218111181412 -0.012710492725532 -0.013088611943289 -0.012795535889232 -0.013308580435365 -0.013701602743541 -0.013372960597051 -0.013906668145197 -0.014314593543793 +0.004967709306389 0.003787761468363 0.002558731504693 0.005206886451617 0.003969189391647 0.002680662955953 0.005446063596846 0.004150617314931 0.002802594407213 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 +PATCH 271 +2 2 +3 3 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +0.000000000000000 0.000000000000000 0.000000000000000 1.000000000000000 1.000000000000000 1.000000000000000 +-0.013088611943289 -0.013343250218085 -0.013475000000000 -0.013701602743541 -0.013965240672255 -0.014100000000000 -0.014314593543793 -0.014587231126425 -0.014725000000000 +0.002558731504693 0.001292141582751 0.000000000000000 0.002680662955953 0.001353402295457 0.000000000000000 0.002802594407213 0.001414663008163 0.000000000000000 +0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 0.007500000000000 0.007463885450041 0.007500000000000 +1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 1.000000000000000 0.995184726672197 1.000000000000000 \ No newline at end of file