From ee9a9af451d85392ce3c05d4868faa250ce28741 Mon Sep 17 00:00:00 2001 From: Ankang Gao <ankanggao@ustc.edu.cn> Date: Fri, 27 Sep 2024 14:10:26 +0000 Subject: [PATCH] Fix interpolation on 2D manifold in a 3D space --- CHANGELOG.md | 1 + library/FieldUtils/Interpolator.cpp | 12 +- library/FieldUtils/Interpolator.h | 7 +- .../ProcessModules/ProcessInterpField.cpp | 13 +- .../ProcessModules/ProcessInterpPoints.cpp | 9 +- .../ProcessModules/ProcessInterpPoints.h | 2 +- library/MultiRegions/ExpList.cpp | 23 +- library/SpatialDomains/Geometry.cpp | 13 +- library/SpatialDomains/Geometry2D.cpp | 59 +- library/SpatialDomains/QuadGeom.cpp | 3 +- library/SpatialDomains/TriGeom.cpp | 3 +- utilities/FieldConvert/CMakeLists.txt | 1 + .../FieldConvert/Tests/interpManifold.tst | 37 + .../FieldConvert/Tests/naca0012_3D_bnd.tst | 28 +- .../FieldConvert/Tests/naca0012_3D_interp.csv | 2003 +++++++++++++++++ 15 files changed, 2173 insertions(+), 41 deletions(-) create mode 100644 utilities/FieldConvert/Tests/interpManifold.tst create mode 100644 utilities/FieldConvert/Tests/naca0012_3D_interp.csv diff --git a/CHANGELOG.md b/CHANGELOG.md index 83716c0fe2..fd9659e44e 100644 --- a/CHANGELOG.md +++ b/CHANGELOG.md @@ -11,6 +11,7 @@ v5.7.0 - Fix fieldconvert filter incorrect boundary values (!1789) - Fix numerical precision issues with filters OutputStartTime (!1789) - Fix AdaptiveSFD for MPI (!1821) +- Fix interpolation on manifold (!1840) - Fix IterativeStaticCond when using absolute tolerance (!1850) - Fix deadlock by scotch with multi-threading support (!1853) diff --git a/library/FieldUtils/Interpolator.cpp b/library/FieldUtils/Interpolator.cpp index 34cc8c9e69..13ca2c882a 100644 --- a/library/FieldUtils/Interpolator.cpp +++ b/library/FieldUtils/Interpolator.cpp @@ -60,7 +60,7 @@ namespace Nektar::FieldUtils */ template <typename T> void Interpolator<T>::Interpolate(const T expInField, T &expOutField, - NekDouble def_value) + NekDouble def_value, NekDouble tolerance) { ASSERTL0(expInField.size() == expOutField.size(), "number of fields does not match"); @@ -111,7 +111,7 @@ void Interpolator<T>::Interpolate(const T expInField, T &expOutField, tmpPts->AddField(expOutField[f]->GetPhys(), "DefaultVar"); } // interpolate m_ptsInField to this intermediate field - Interpolate(expInField, tmpPts, def_value); + Interpolate(expInField, tmpPts, def_value, tolerance); // write the intermediate fields data into our expOutField for (int i = 0; i < nFields; i++) { @@ -137,7 +137,7 @@ void Interpolator<T>::Interpolate(const T expInField, T &expOutField, template <typename T> void Interpolator<T>::Interpolate(const T expInField, LibUtilities::PtsFieldSharedPtr &ptsOutField, - NekDouble def_value) + NekDouble def_value, NekDouble tolerance) { ASSERTL0(expInField.size() == ptsOutField->GetNFields(), "number of fields does not match"); @@ -169,9 +169,9 @@ void Interpolator<T>::Interpolate(const T expInField, } // Obtain Element and LocalCoordinate to interpolate. - elmtid = expInField[0]->GetExpIndex( - coords, Lcoords, NekConstants::kGeomFactorsTol, true, elmtid, - NekConstants::kGeomFactorsTol * 1e3); + elmtid = expInField[0]->GetExpIndex(coords, Lcoords, + NekConstants::kGeomFactorsTol, true, + elmtid, tolerance); // we use kGeomFactorsTol as tolerance, while StdPhysEvaluate has // kNekZeroTol hardcoded, so we need to limit Lcoords to not produce diff --git a/library/FieldUtils/Interpolator.h b/library/FieldUtils/Interpolator.h index e755d6599b..fdb833748c 100644 --- a/library/FieldUtils/Interpolator.h +++ b/library/FieldUtils/Interpolator.h @@ -74,13 +74,14 @@ public: } /// Interpolate from an expansion to an expansion - FIELD_UTILS_EXPORT void Interpolate(const T expInField, T &expOutField, - NekDouble def_value = 0.0); + FIELD_UTILS_EXPORT void Interpolate( + const T expInField, T &expOutField, NekDouble def_value = 0., + NekDouble tolerance = NekConstants::kFindDistanceMin); /// Interpolate from an expansion to a pts field FIELD_UTILS_EXPORT void Interpolate( const T expInField, LibUtilities::PtsFieldSharedPtr &ptsOutField, - NekDouble def_value = 0.0); + NekDouble def_value = 0., NekDouble tolerance = 1.E-5); /// Interpolate from a pts field to an expansion FIELD_UTILS_EXPORT void Interpolate( diff --git a/library/FieldUtils/ProcessModules/ProcessInterpField.cpp b/library/FieldUtils/ProcessModules/ProcessInterpField.cpp index 4b912583dd..b5e94a61a3 100644 --- a/library/FieldUtils/ProcessModules/ProcessInterpField.cpp +++ b/library/FieldUtils/ProcessModules/ProcessInterpField.cpp @@ -73,6 +73,8 @@ ProcessInterpField::ProcessInterpField(FieldSharedPtr f) : ProcessModule(f) ConfigOption(false, "0", "Default value if point is outside domain"); m_config["realmodetoimag"] = ConfigOption(false, "NotSet", "Take fields as sin mode"); + m_config["distTolerance"] = + ConfigOption(false, "1e-5", "The maximum acceptable distance."); } ProcessInterpField::~ProcessInterpField() @@ -238,14 +240,7 @@ void ProcessInterpField::v_Process(po::variables_map &vm) NekDouble clamp_low = m_config["clamptolowervalue"].as<NekDouble>(); NekDouble clamp_up = m_config["clamptouppervalue"].as<NekDouble>(); NekDouble def_value = m_config["defaultvalue"].as<NekDouble>(); - - for (int i = 0; i < nfields; i++) - { - for (int j = 0; j < nq1; ++j) - { - m_f->m_exp[i]->UpdatePhys()[j] = def_value; - } - } + NekDouble tolerance = m_config["distTolerance"].as<NekDouble>(); Interpolator<std::vector<MultiRegions::ExpListSharedPtr>> interp; if (m_f->m_verbose && m_f->m_comm->TreatAsRankZero()) @@ -253,7 +248,7 @@ void ProcessInterpField::v_Process(po::variables_map &vm) interp.SetProgressCallback(&ProcessInterpField::PrintProgressbar, this); } - interp.Interpolate(fromField->m_exp, m_f->m_exp); + interp.Interpolate(fromField->m_exp, m_f->m_exp, def_value, tolerance); if (m_f->m_verbose && m_f->m_comm->TreatAsRankZero()) { diff --git a/library/FieldUtils/ProcessModules/ProcessInterpPoints.cpp b/library/FieldUtils/ProcessModules/ProcessInterpPoints.cpp index 03335dcfce..c49d952063 100644 --- a/library/FieldUtils/ProcessModules/ProcessInterpPoints.cpp +++ b/library/FieldUtils/ProcessModules/ProcessInterpPoints.cpp @@ -97,6 +97,8 @@ ProcessInterpPoints::ProcessInterpPoints(FieldSharedPtr f) : ProcessModule(f) "Parameters p0 and q to determine pressure coefficients"); m_config["realmodetoimag"] = ConfigOption(false, "NotSet", "Take fields as sin mode"); + m_config["distTolerance"] = + ConfigOption(false, "1e-5", "The maximum acceptable distance."); } ProcessInterpPoints::~ProcessInterpPoints() @@ -259,9 +261,10 @@ void ProcessInterpPoints::v_Process(po::variables_map &vm) NekDouble clamp_low = m_config["clamptolowervalue"].as<NekDouble>(); NekDouble clamp_up = m_config["clamptouppervalue"].as<NekDouble>(); NekDouble def_value = m_config["defaultvalue"].as<NekDouble>(); + NekDouble tolerance = m_config["distTolerance"].as<NekDouble>(); InterpolateFieldToPts(fromField->m_exp, m_f->m_fieldPts, clamp_low, - clamp_up, def_value); + clamp_up, def_value, tolerance); if (!boost::iequals(m_config["cp"].as<string>(), "NotSet")) { @@ -495,7 +498,7 @@ void ProcessInterpPoints::CreateFieldPts([[maybe_unused]] po::variables_map &vm) void ProcessInterpPoints::InterpolateFieldToPts( vector<MultiRegions::ExpListSharedPtr> &field0, LibUtilities::PtsFieldSharedPtr &pts, NekDouble clamp_low, - NekDouble clamp_up, [[maybe_unused]] NekDouble def_value) + NekDouble clamp_up, NekDouble def_value, NekDouble tolerance) { ASSERTL0(pts->GetNFields() == field0.size(), "ptField has too few fields"); @@ -507,7 +510,7 @@ void ProcessInterpPoints::InterpolateFieldToPts( interp.SetProgressCallback(&ProcessInterpPoints::PrintProgressbar, this); } - interp.Interpolate(field0, pts); + interp.Interpolate(field0, pts, def_value, tolerance); if (m_f->m_comm->GetRank() == 0) { diff --git a/library/FieldUtils/ProcessModules/ProcessInterpPoints.h b/library/FieldUtils/ProcessModules/ProcessInterpPoints.h index 744ade6e87..cfa1061e5f 100644 --- a/library/FieldUtils/ProcessModules/ProcessInterpPoints.h +++ b/library/FieldUtils/ProcessModules/ProcessInterpPoints.h @@ -85,7 +85,7 @@ private: void InterpolateFieldToPts( std::vector<MultiRegions::ExpListSharedPtr> &field0, LibUtilities::PtsFieldSharedPtr &pts, NekDouble clamp_low, - NekDouble clamp_up, NekDouble def_value); + NekDouble clamp_up, NekDouble def_value, NekDouble tolerance); void calcCp0(); }; diff --git a/library/MultiRegions/ExpList.cpp b/library/MultiRegions/ExpList.cpp index 49938f9d15..9607cc42ac 100644 --- a/library/MultiRegions/ExpList.cpp +++ b/library/MultiRegions/ExpList.cpp @@ -3270,18 +3270,21 @@ int ExpList::GetExpIndex(const Array<OneD, const NekDouble> &gloCoords, // that. Otherwise return -1 to indicate no matching elemenet found. if (returnNearestElmt && nearpt_min <= maxDistance) { - - std::string msg = "Failed to find point within element to " - "tolerance of " + + Vmath::Vcopy(locCoords.size(), savLocCoords, 1, locCoords, 1); + std::string msg = "Failed to find point within a tolerance of " + boost::lexical_cast<std::string>(tol) + - " using local point (" + - boost::lexical_cast<std::string>(locCoords[0]) + "," + - boost::lexical_cast<std::string>(locCoords[1]) + "," + - boost::lexical_cast<std::string>(locCoords[1]) + - ") in element: " + std::to_string(min_id); + ", using local point ("; + for (size_t j = 0; j < locCoords.size(); ++j) + { + msg += boost::lexical_cast<std::string>(savLocCoords[j]); + if (j < locCoords.size()) + { + msg += ", "; + } + } + msg += ") in element: " + std::to_string(min_id) + + " with a distance of " + std::to_string(nearpt_min); WARNINGL1(false, msg.c_str()); - - Vmath::Vcopy(locCoords.size(), savLocCoords, 1, locCoords, 1); return min_id; } else diff --git a/library/SpatialDomains/Geometry.cpp b/library/SpatialDomains/Geometry.cpp index 840a529cd2..d723469ce1 100644 --- a/library/SpatialDomains/Geometry.cpp +++ b/library/SpatialDomains/Geometry.cpp @@ -277,7 +277,18 @@ bool Geometry::v_ContainsPoint(const Array<OneD, const NekDouble> &gloCoord, { Array<OneD, NekDouble> eta(GetShapeDim(), 0.); m_xmap->LocCoordToLocCollapsed(locCoord, eta); - return !ClampLocCoords(eta, tol); + if (ClampLocCoords(eta, tol)) + { + if (GetMetricInfo()->GetGtype() == eRegular) + { + dist = std::numeric_limits<double>::max(); + } + return false; + } + return 3 != m_coordim || + (LibUtilities::eTriangle != m_shapeType && + LibUtilities::eQuadrilateral != m_shapeType) || + dist <= tol; } } diff --git a/library/SpatialDomains/Geometry2D.cpp b/library/SpatialDomains/Geometry2D.cpp index 5cc012b3ba..ad5dcfdbe5 100644 --- a/library/SpatialDomains/Geometry2D.cpp +++ b/library/SpatialDomains/Geometry2D.cpp @@ -70,7 +70,7 @@ int Geometry2D::v_AllLeftCheck(const Array<OneD, const NekDouble> &gloCoord) x[0] = Array<OneD, NekDouble>(3); x[1] = Array<OneD, NekDouble>(3); m_verts[m_verts.size() - 1]->GetCoords(x[0]); - int i0 = 1, i1 = 0; + int i0 = 1, i1 = 0, direction = 1; for (size_t i = 0; i < m_verts.size(); ++i) { i0 ^= 1; @@ -84,6 +84,34 @@ int Geometry2D::v_AllLeftCheck(const Array<OneD, const NekDouble> &gloCoord) m_edgeNormal[i][0] = x[i0][d1] - x[i1][d1]; m_edgeNormal[i][1] = x[i1][d0] - x[i0][d0]; } + if (m_coordim == 3) + { + for (size_t i = 0; i < m_verts.size(); ++i) + { + if (m_edgeNormal[i].size() == 2) + { + m_verts[i]->GetCoords(x[0]); + m_verts[(i + 2) % m_verts.size()]->GetCoords(x[1]); + if (m_edgeNormal[i][0] * (x[1][d0] - x[0][d0]) < + m_edgeNormal[i][1] * (x[0][d1] - x[1][d1])) + { + direction = -1; + } + break; + } + } + } + if (direction == -1) + { + for (size_t i = 0; i < m_verts.size(); ++i) + { + if (m_edgeNormal[i].size() == 2) + { + m_edgeNormal[i][0] = -m_edgeNormal[i][0]; + m_edgeNormal[i][1] = -m_edgeNormal[i][1]; + } + } + } } Array<OneD, NekDouble> vertex(3); @@ -95,13 +123,17 @@ int Geometry2D::v_AllLeftCheck(const Array<OneD, const NekDouble> &gloCoord) nc = 0; // not sure continue; } - NekDouble value = m_edgeNormal[i][0] * (gloCoord[d0] - vertex[d0]) + - m_edgeNormal[i][1] * (gloCoord[d1] - vertex[d1]); - if (value < 0) + if (m_edgeNormal[i][0] * (gloCoord[d0] - vertex[d0]) < + m_edgeNormal[i][1] * (vertex[d1] - gloCoord[d1])) { return -1; // outside } } + // 3D manifold needs to check the distance + if (m_coordim == 3) + { + nc = 0; + } // nc: 1 (side element), 0 (maybe inside), -1 (outside) return nc; } @@ -310,6 +342,25 @@ NekDouble Geometry2D::v_GetLocCoords(const Array<OneD, const NekDouble> &coords, // Perform newton iteration to find local coordinates NewtonIterationForLocCoord(tmpcoords, ptsx, ptsy, Lcoords, dist); } + if (m_coordim == 3) + { + Array<OneD, NekDouble> eta(2, 0.), xi(2, 0.); + m_xmap->LocCoordToLocCollapsed(Lcoords, eta); + ClampLocCoords(eta, 0.); + m_xmap->LocCollapsedToLocCoord(eta, xi); + int npts = m_xmap->GetTotPoints(); + Array<OneD, NekDouble> ptsz(npts); + m_xmap->BwdTrans(m_coeffs[m_manifold[2]], ptsz); + NekDouble z = m_xmap->PhysEvaluate(xi, ptsz) - coords[m_manifold[2]]; + if (GetMetricInfo()->GetGtype() == eDeformed) + { + dist = sqrt(z * z + dist * dist); + } + else + { + dist = fabs(z); + } + } return dist; } diff --git a/library/SpatialDomains/QuadGeom.cpp b/library/SpatialDomains/QuadGeom.cpp index b5cf09b114..fb6812e551 100644 --- a/library/SpatialDomains/QuadGeom.cpp +++ b/library/SpatialDomains/QuadGeom.cpp @@ -307,7 +307,7 @@ void QuadGeom::v_GenGeomFactors() // x_i^A - x_i^B = x_i^D - x_i^C // // This corresponds to quadrilaterals which are paralellograms. - m_manifold = Array<OneD, int>(2); + m_manifold = Array<OneD, int>(m_coordim); m_manifold[0] = 0; m_manifold[1] = 1; if (m_coordim == 3) @@ -329,6 +329,7 @@ void QuadGeom::v_GenGeomFactors() } m_manifold[0] = (tmpi + 1) % 3; m_manifold[1] = (tmpi + 2) % 3; + m_manifold[2] = (tmpi + 3) % 3; } if (Gtype == eRegular) diff --git a/library/SpatialDomains/TriGeom.cpp b/library/SpatialDomains/TriGeom.cpp index 6c599ba896..73abaff15b 100644 --- a/library/SpatialDomains/TriGeom.cpp +++ b/library/SpatialDomains/TriGeom.cpp @@ -244,7 +244,7 @@ void TriGeom::v_GenGeomFactors() m_straightEdge = 0; } - m_manifold = Array<OneD, int>(2); + m_manifold = Array<OneD, int>(m_coordim); m_manifold[0] = 0; m_manifold[1] = 1; if (m_coordim == 3) @@ -266,6 +266,7 @@ void TriGeom::v_GenGeomFactors() } m_manifold[0] = (tmpi + 1) % 3; m_manifold[1] = (tmpi + 2) % 3; + m_manifold[2] = (tmpi + 3) % 3; } if (Gtype == eRegular) { diff --git a/utilities/FieldConvert/CMakeLists.txt b/utilities/FieldConvert/CMakeLists.txt index 6c76bc20dc..cae6eca53e 100644 --- a/utilities/FieldConvert/CMakeLists.txt +++ b/utilities/FieldConvert/CMakeLists.txt @@ -55,6 +55,7 @@ ADD_NEKTAR_TEST(taylor_vortex_2D_div) ADD_NEKTAR_TEST(wss_3D_periodic) ADD_NEKTAR_TEST(scale_compressed_2D) ADD_NEKTAR_TEST(naca0012_3D_bnd) +ADD_NEKTAR_TEST(interpManifold) ADD_NEKTAR_TEST(Helmholtz) ADD_NEKTAR_TEST(Hex_channel_C0helmsmoothing) ADD_NEKTAR_TEST(surfDist) diff --git a/utilities/FieldConvert/Tests/interpManifold.tst b/utilities/FieldConvert/Tests/interpManifold.tst new file mode 100644 index 0000000000..632b074141 --- /dev/null +++ b/utilities/FieldConvert/Tests/interpManifold.tst @@ -0,0 +1,37 @@ +<?xml version="1.0" encoding="utf-8"?> +<test> + <description> interpolation on a manifold </description> + <executable>FieldConvert</executable> + <parameters> -e -f -v -m interppoints:fromxml=naca0012_3D_bnd.xml:fromfld=naca0012_3D_bnd.fld:topts=naca0012_3D_interp.csv:distTolerance=1E-2 naca0012_3D_interp.dat </parameters> + <files> + <file description="Session File">naca0012_3D_bnd.xml</file> + <file description="Field File">naca0012_3D_bnd.fld</file> + <file description="Field File">naca0012_3D_interp.csv</file> + </files> + <metrics> + <metric type="L2" id="1"> + <value variable="x" tolerance="1e-4">0.557936</value> + <value variable="y" tolerance="1e-4">0.155526</value> + <value variable="z" tolerance="1e-4">0.195195</value> + <value variable="Shear_x" tolerance="1e-4">0.0911352</value> + <value variable="Shear_y" tolerance="1e-4">0.067545</value> + <value variable="Shear_z" tolerance="1e-4">0.013328</value> + <value variable="Shear_mag" tolerance="1e-4">0.114146</value> + <value variable="Norm_x" tolerance="1e-4">0.296038</value> + <value variable="Norm_y" tolerance="1e-4">0.955176</value> + <value variable="Norm_z" tolerance="1e-4">2.92847e-17</value> + </metric> + <metric type="Linf" id="2"> + <value variable="x" tolerance="1e-4">0.966252</value> + <value variable="y" tolerance="1e-4">0.260036</value> + <value variable="z" tolerance="1e-4">0.195195</value> + <value variable="Shear_x" tolerance="1e-4">0.719677</value> + <value variable="Shear_y" tolerance="1e-4">1.14682</value> + <value variable="Shear_z" tolerance="1e-4">0.0390763</value> + <value variable="Shear_mag" tolerance="1e-4">1.18736</value> + <value variable="Norm_x" tolerance="1e-4">0.993076</value> + <value variable="Norm_y" tolerance="1e-4">0.999989</value> + <value variable="Norm_z" tolerance="1e-4">3.90539e-16</value> + </metric> + </metrics> +</test> diff --git a/utilities/FieldConvert/Tests/naca0012_3D_bnd.tst b/utilities/FieldConvert/Tests/naca0012_3D_bnd.tst index 6c3cf1efc1..99f1e00909 100644 --- a/utilities/FieldConvert/Tests/naca0012_3D_bnd.tst +++ b/utilities/FieldConvert/Tests/naca0012_3D_bnd.tst @@ -2,11 +2,35 @@ <test> <description> Process fld directory without P0000000.fld </description> <executable>FieldConvert</executable> - <parameters> naca0012_3D_bnd.xml naca0012_3D_bnd.fld naca0012_3D_bnd.plt </parameters> + <parameters> -e -f naca0012_3D_bnd.xml naca0012_3D_bnd.fld naca0012_3D_bnd.plt </parameters> <files> <file description="Session File">naca0012_3D_bnd.xml</file> <file description="Field File">naca0012_3D_bnd.fld</file> </files> - <metrics> + <metrics> + <metric type="L2" id="1"> + <value variable="x" tolerance="1e-4">1.77227</value> + <value variable="y" tolerance="1e-4">0.493971</value> + <value variable="z" tolerance="1e-4">9.2236</value> + <value variable="Shear_x" tolerance="1e-4">0.312949</value> + <value variable="Shear_y" tolerance="1e-4">0.32099</value> + <value variable="Shear_z" tolerance="1e-4">0.0578149</value> + <value variable="Shear_mag" tolerance="1e-4">0.452696</value> + <value variable="Norm_x" tolerance="1e-4">0.987202</value> + <value variable="Norm_y" tolerance="1e-4">3.03874</value> + <value variable="Norm_z" tolerance="1e-4">4.96156e-16</value> + </metric> + <metric type="Linf" id="2"> + <value variable="x" tolerance="1e-4">0.966252</value> + <value variable="y" tolerance="1e-4">0.021514</value> + <value variable="z" tolerance="1e-4">5</value> + <value variable="Shear_x" tolerance="1e-4">0.725261</value> + <value variable="Shear_y" tolerance="1e-4">1.11074</value> + <value variable="Shear_z" tolerance="1e-4">0.808733</value> + <value variable="Shear_mag" tolerance="1e-4">1.57498</value> + <value variable="Norm_x" tolerance="1e-4">0.999636</value> + <value variable="Norm_y" tolerance="1e-4">0.992511</value> + <value variable="Norm_z" tolerance="1e-4">3.57464e-14</value> + </metric> </metrics> </test> diff --git a/utilities/FieldConvert/Tests/naca0012_3D_interp.csv b/utilities/FieldConvert/Tests/naca0012_3D_interp.csv new file mode 100644 index 0000000000..fecab4e78f --- /dev/null +++ b/utilities/FieldConvert/Tests/naca0012_3D_interp.csv @@ -0,0 +1,2003 @@ +#x,y,z +0.000000,0.000000,0.195195 +0.002545,0.005633,0.195195 +0.004024,0.007291,0.195195 +0.005286,0.008136,0.195195 +0.006624,0.009267,0.195195 +0.007976,0.010448,0.195195 +0.009277,0.011442,0.195195 +0.010519,0.012211,0.195195 +0.011718,0.012823,0.195195 +0.012893,0.013343,0.195195 +0.014060,0.013834,0.195195 +0.015224,0.014318,0.195195 +0.016386,0.014788,0.195195 +0.017542,0.015238,0.195195 +0.018691,0.015664,0.195195 +0.019832,0.016059,0.195195 +0.020965,0.016422,0.195195 +0.022090,0.016757,0.195195 +0.023208,0.017066,0.195195 +0.024320,0.017354,0.195195 +0.025428,0.017623,0.195195 +0.026531,0.017878,0.195195 +0.027631,0.018120,0.195195 +0.028729,0.018351,0.195195 +0.029823,0.018571,0.195195 +0.030914,0.018780,0.195195 +0.032003,0.018979,0.195195 +0.033088,0.019167,0.195195 +0.034171,0.019345,0.195195 +0.035251,0.019513,0.195195 +0.036329,0.019671,0.195195 +0.037404,0.019820,0.195195 +0.038477,0.019961,0.195195 +0.039548,0.020094,0.195195 +0.040617,0.020218,0.195195 +0.041684,0.020335,0.195195 +0.042748,0.020446,0.195195 +0.043811,0.020549,0.195195 +0.044873,0.020647,0.195195 +0.045933,0.020738,0.195195 +0.046991,0.020824,0.195195 +0.048048,0.020904,0.195195 +0.049103,0.020979,0.195195 +0.050157,0.021048,0.195195 +0.051209,0.021112,0.195195 +0.052260,0.021171,0.195195 +0.053310,0.021225,0.195195 +0.054358,0.021274,0.195195 +0.055406,0.021319,0.195195 +0.056452,0.021359,0.195195 +0.057497,0.021395,0.195195 +0.058540,0.021427,0.195195 +0.059583,0.021454,0.195195 +0.060625,0.021478,0.195195 +0.061665,0.021497,0.195195 +0.062705,0.021513,0.195195 +0.063743,0.021525,0.195195 +0.064781,0.021534,0.195195 +0.065817,0.021539,0.195195 +0.066853,0.021541,0.195195 +0.067888,0.021539,0.195195 +0.068922,0.021534,0.195195 +0.069955,0.021526,0.195195 +0.070987,0.021515,0.195195 +0.072019,0.021500,0.195195 +0.073049,0.021483,0.195195 +0.074079,0.021463,0.195195 +0.075108,0.021439,0.195195 +0.076136,0.021413,0.195195 +0.077164,0.021385,0.195195 +0.078191,0.021353,0.195195 +0.079217,0.021319,0.195195 +0.080242,0.021282,0.195195 +0.081267,0.021243,0.195195 +0.082291,0.021201,0.195195 +0.083315,0.021157,0.195195 +0.084337,0.021110,0.195195 +0.085359,0.021061,0.195195 +0.086381,0.021009,0.195195 +0.087402,0.020955,0.195195 +0.088422,0.020899,0.195195 +0.089442,0.020841,0.195195 +0.090461,0.020780,0.195195 +0.091479,0.020718,0.195195 +0.092497,0.020653,0.195195 +0.093514,0.020586,0.195195 +0.094531,0.020517,0.195195 +0.095547,0.020446,0.195195 +0.096563,0.020373,0.195195 +0.097578,0.020298,0.195195 +0.098593,0.020221,0.195195 +0.099607,0.020142,0.195195 +0.100621,0.020061,0.195195 +0.101634,0.019979,0.195195 +0.102647,0.019894,0.195195 +0.103659,0.019808,0.195195 +0.104670,0.019720,0.195195 +0.105682,0.019630,0.195195 +0.106692,0.019538,0.195195 +0.107703,0.019445,0.195195 +0.108712,0.019350,0.195195 +0.109722,0.019254,0.195195 +0.110731,0.019155,0.195195 +0.111739,0.019055,0.195195 +0.112747,0.018954,0.195195 +0.113755,0.018851,0.195195 +0.114762,0.018746,0.195195 +0.115769,0.018640,0.195195 +0.116775,0.018532,0.195195 +0.117781,0.018422,0.195195 +0.118787,0.018312,0.195195 +0.119792,0.018199,0.195195 +0.120797,0.018085,0.195195 +0.121801,0.017970,0.195195 +0.122805,0.017853,0.195195 +0.123809,0.017735,0.195195 +0.124812,0.017616,0.195195 +0.125815,0.017495,0.195195 +0.126818,0.017373,0.195195 +0.127820,0.017249,0.195195 +0.128821,0.017124,0.195195 +0.129823,0.016998,0.195195 +0.130824,0.016870,0.195195 +0.131825,0.016741,0.195195 +0.132825,0.016611,0.195195 +0.133825,0.016479,0.195195 +0.134825,0.016346,0.195195 +0.135824,0.016212,0.195195 +0.136823,0.016077,0.195195 +0.137822,0.015940,0.195195 +0.138820,0.015803,0.195195 +0.139818,0.015664,0.195195 +0.140816,0.015523,0.195195 +0.141813,0.015382,0.195195 +0.142810,0.015240,0.195195 +0.143807,0.015096,0.195195 +0.144804,0.014951,0.195195 +0.145800,0.014805,0.195195 +0.146796,0.014658,0.195195 +0.147791,0.014510,0.195195 +0.148786,0.014360,0.195195 +0.149781,0.014210,0.195195 +0.150776,0.014058,0.195195 +0.151770,0.013906,0.195195 +0.152765,0.013752,0.195195 +0.153758,0.013597,0.195195 +0.154752,0.013441,0.195195 +0.155745,0.013284,0.195195 +0.156738,0.013126,0.195195 +0.157731,0.012967,0.195195 +0.158723,0.012807,0.195195 +0.159715,0.012646,0.195195 +0.160707,0.012484,0.195195 +0.161699,0.012321,0.195195 +0.162690,0.012157,0.195195 +0.163681,0.011992,0.195195 +0.164672,0.011826,0.195195 +0.165663,0.011659,0.195195 +0.166653,0.011492,0.195195 +0.167643,0.011323,0.195195 +0.168633,0.011153,0.195195 +0.169622,0.010982,0.195195 +0.170611,0.010810,0.195195 +0.171600,0.010638,0.195195 +0.172589,0.010464,0.195195 +0.173578,0.010290,0.195195 +0.174566,0.010115,0.195195 +0.175554,0.009938,0.195195 +0.176542,0.009761,0.195195 +0.177529,0.009583,0.195195 +0.178517,0.009404,0.195195 +0.179504,0.009225,0.195195 +0.180491,0.009044,0.195195 +0.181477,0.008862,0.195195 +0.182464,0.008680,0.195195 +0.183450,0.008497,0.195195 +0.184436,0.008313,0.195195 +0.185422,0.008128,0.195195 +0.186407,0.007942,0.195195 +0.187393,0.007756,0.195195 +0.188378,0.007568,0.195195 +0.189362,0.007380,0.195195 +0.190347,0.007191,0.195195 +0.191332,0.007001,0.195195 +0.192316,0.006811,0.195195 +0.193300,0.006619,0.195195 +0.194284,0.006427,0.195195 +0.195267,0.006234,0.195195 +0.196250,0.006041,0.195195 +0.197234,0.005846,0.195195 +0.198217,0.005651,0.195195 +0.199199,0.005455,0.195195 +0.200182,0.005258,0.195195 +0.201164,0.005060,0.195195 +0.202146,0.004862,0.195195 +0.203128,0.004663,0.195195 +0.204110,0.004463,0.195195 +0.205092,0.004263,0.195195 +0.206073,0.004061,0.195195 +0.207054,0.003859,0.195195 +0.208035,0.003657,0.195195 +0.209016,0.003453,0.195195 +0.209996,0.003249,0.195195 +0.210977,0.003044,0.195195 +0.211957,0.002839,0.195195 +0.212937,0.002632,0.195195 +0.213917,0.002425,0.195195 +0.214896,0.002218,0.195195 +0.215876,0.002009,0.195195 +0.216855,0.001800,0.195195 +0.217834,0.001591,0.195195 +0.218813,0.001380,0.195195 +0.219792,0.001169,0.195195 +0.220770,0.000957,0.195195 +0.221749,0.000745,0.195195 +0.222727,0.000532,0.195195 +0.223705,0.000318,0.195195 +0.224683,0.000104,0.195195 +0.225660,-0.000111,0.195195 +0.226638,-0.000327,0.195195 +0.227615,-0.000543,0.195195 +0.228592,-0.000760,0.195195 +0.229569,-0.000978,0.195195 +0.230546,-0.001196,0.195195 +0.231523,-0.001415,0.195195 +0.232499,-0.001635,0.195195 +0.233475,-0.001855,0.195195 +0.234452,-0.002076,0.195195 +0.235428,-0.002297,0.195195 +0.236403,-0.002519,0.195195 +0.237379,-0.002741,0.195195 +0.238354,-0.002965,0.195195 +0.239330,-0.003188,0.195195 +0.240305,-0.003413,0.195195 +0.241280,-0.003638,0.195195 +0.242255,-0.003863,0.195195 +0.243229,-0.004090,0.195195 +0.244204,-0.004316,0.195195 +0.245178,-0.004544,0.195195 +0.246152,-0.004772,0.195195 +0.247126,-0.005000,0.195195 +0.248100,-0.005229,0.195195 +0.249074,-0.005459,0.195195 +0.250048,-0.005689,0.195195 +0.251021,-0.005920,0.195195 +0.251994,-0.006151,0.195195 +0.252968,-0.006383,0.195195 +0.253940,-0.006616,0.195195 +0.254913,-0.006849,0.195195 +0.255886,-0.007083,0.195195 +0.256859,-0.007317,0.195195 +0.257831,-0.007551,0.195195 +0.258803,-0.007787,0.195195 +0.259775,-0.008023,0.195195 +0.260747,-0.008259,0.195195 +0.261719,-0.008496,0.195195 +0.262691,-0.008733,0.195195 +0.263662,-0.008971,0.195195 +0.264634,-0.009210,0.195195 +0.265605,-0.009449,0.195195 +0.266576,-0.009688,0.195195 +0.267547,-0.009928,0.195195 +0.268518,-0.010169,0.195195 +0.269488,-0.010410,0.195195 +0.270459,-0.010652,0.195195 +0.271429,-0.010894,0.195195 +0.272400,-0.011136,0.195195 +0.273370,-0.011379,0.195195 +0.274340,-0.011623,0.195195 +0.275309,-0.011867,0.195195 +0.276279,-0.012112,0.195195 +0.277249,-0.012357,0.195195 +0.278218,-0.012603,0.195195 +0.279188,-0.012849,0.195195 +0.280157,-0.013095,0.195195 +0.281126,-0.013343,0.195195 +0.282095,-0.013590,0.195195 +0.283064,-0.013838,0.195195 +0.284032,-0.014087,0.195195 +0.285001,-0.014336,0.195195 +0.285969,-0.014585,0.195195 +0.286937,-0.014835,0.195195 +0.287906,-0.015086,0.195195 +0.288874,-0.015337,0.195195 +0.289842,-0.015588,0.195195 +0.290809,-0.015840,0.195195 +0.291777,-0.016093,0.195195 +0.292745,-0.016345,0.195195 +0.293712,-0.016599,0.195195 +0.294679,-0.016852,0.195195 +0.295646,-0.017107,0.195195 +0.296613,-0.017361,0.195195 +0.297580,-0.017616,0.195195 +0.298547,-0.017872,0.195195 +0.299514,-0.018128,0.195195 +0.300480,-0.018385,0.195195 +0.301447,-0.018641,0.195195 +0.302413,-0.018899,0.195195 +0.303379,-0.019157,0.195195 +0.304345,-0.019415,0.195195 +0.305311,-0.019674,0.195195 +0.306277,-0.019933,0.195195 +0.307243,-0.020192,0.195195 +0.308209,-0.020452,0.195195 +0.309174,-0.020713,0.195195 +0.310139,-0.020973,0.195195 +0.311105,-0.021235,0.195195 +0.312070,-0.021496,0.195195 +0.313035,-0.021758,0.195195 +0.314000,-0.022021,0.195195 +0.314965,-0.022284,0.195195 +0.315929,-0.022547,0.195195 +0.316894,-0.022811,0.195195 +0.317858,-0.023075,0.195195 +0.318823,-0.023340,0.195195 +0.319787,-0.023605,0.195195 +0.320751,-0.023870,0.195195 +0.321715,-0.024136,0.195195 +0.322679,-0.024402,0.195195 +0.323643,-0.024669,0.195195 +0.324607,-0.024936,0.195195 +0.325570,-0.025204,0.195195 +0.326534,-0.025472,0.195195 +0.327497,-0.025740,0.195195 +0.328461,-0.026008,0.195195 +0.329424,-0.026277,0.195195 +0.330387,-0.026547,0.195195 +0.331350,-0.026817,0.195195 +0.332313,-0.027087,0.195195 +0.333275,-0.027358,0.195195 +0.334238,-0.027629,0.195195 +0.335201,-0.027900,0.195195 +0.336163,-0.028172,0.195195 +0.337125,-0.028444,0.195195 +0.338088,-0.028716,0.195195 +0.339050,-0.028989,0.195195 +0.340012,-0.029263,0.195195 +0.340974,-0.029536,0.195195 +0.341936,-0.029810,0.195195 +0.342897,-0.030085,0.195195 +0.343859,-0.030360,0.195195 +0.344821,-0.030635,0.195195 +0.345782,-0.030910,0.195195 +0.346743,-0.031186,0.195195 +0.347705,-0.031462,0.195195 +0.348666,-0.031739,0.195195 +0.349627,-0.032016,0.195195 +0.350588,-0.032293,0.195195 +0.351549,-0.032571,0.195195 +0.352510,-0.032849,0.195195 +0.353470,-0.033127,0.195195 +0.354431,-0.033406,0.195195 +0.355391,-0.033685,0.195195 +0.356352,-0.033965,0.195195 +0.357312,-0.034245,0.195195 +0.358272,-0.034525,0.195195 +0.359232,-0.034805,0.195195 +0.360192,-0.035086,0.195195 +0.361152,-0.035367,0.195195 +0.362112,-0.035649,0.195195 +0.363072,-0.035931,0.195195 +0.364031,-0.036213,0.195195 +0.364991,-0.036496,0.195195 +0.365950,-0.036779,0.195195 +0.366910,-0.037062,0.195195 +0.367869,-0.037346,0.195195 +0.368828,-0.037630,0.195195 +0.369787,-0.037914,0.195195 +0.370746,-0.038198,0.195195 +0.371705,-0.038483,0.195195 +0.372664,-0.038769,0.195195 +0.373623,-0.039054,0.195195 +0.374582,-0.039340,0.195195 +0.375540,-0.039626,0.195195 +0.376499,-0.039913,0.195195 +0.377457,-0.040200,0.195195 +0.378415,-0.040487,0.195195 +0.379374,-0.040775,0.195195 +0.380332,-0.041063,0.195195 +0.381290,-0.041351,0.195195 +0.382248,-0.041639,0.195195 +0.383206,-0.041928,0.195195 +0.384163,-0.042217,0.195195 +0.385121,-0.042507,0.195195 +0.386079,-0.042797,0.195195 +0.387036,-0.043087,0.195195 +0.387994,-0.043377,0.195195 +0.388951,-0.043668,0.195195 +0.389908,-0.043959,0.195195 +0.390866,-0.044250,0.195195 +0.391823,-0.044542,0.195195 +0.392780,-0.044834,0.195195 +0.393737,-0.045126,0.195195 +0.394694,-0.045419,0.195195 +0.395650,-0.045711,0.195195 +0.396607,-0.046005,0.195195 +0.397564,-0.046298,0.195195 +0.398520,-0.046592,0.195195 +0.399477,-0.046886,0.195195 +0.400433,-0.047180,0.195195 +0.401390,-0.047475,0.195195 +0.402346,-0.047770,0.195195 +0.403302,-0.048065,0.195195 +0.404258,-0.048361,0.195195 +0.405214,-0.048656,0.195195 +0.406170,-0.048952,0.195195 +0.407126,-0.049249,0.195195 +0.408082,-0.049546,0.195195 +0.409037,-0.049843,0.195195 +0.409993,-0.050140,0.195195 +0.410949,-0.050437,0.195195 +0.411904,-0.050735,0.195195 +0.412859,-0.051033,0.195195 +0.413815,-0.051332,0.195195 +0.414770,-0.051630,0.195195 +0.415725,-0.051929,0.195195 +0.416680,-0.052229,0.195195 +0.417635,-0.052528,0.195195 +0.418590,-0.052828,0.195195 +0.419545,-0.053128,0.195195 +0.420500,-0.053428,0.195195 +0.421455,-0.053729,0.195195 +0.422409,-0.054030,0.195195 +0.423364,-0.054331,0.195195 +0.424318,-0.054633,0.195195 +0.425273,-0.054934,0.195195 +0.426227,-0.055236,0.195195 +0.427181,-0.055539,0.195195 +0.428136,-0.055841,0.195195 +0.429090,-0.056144,0.195195 +0.430044,-0.056447,0.195195 +0.430998,-0.056750,0.195195 +0.431952,-0.057054,0.195195 +0.432906,-0.057358,0.195195 +0.433859,-0.057662,0.195195 +0.434813,-0.057966,0.195195 +0.435767,-0.058271,0.195195 +0.436720,-0.058576,0.195195 +0.437674,-0.058881,0.195195 +0.438627,-0.059186,0.195195 +0.439581,-0.059492,0.195195 +0.440534,-0.059798,0.195195 +0.441487,-0.060104,0.195195 +0.442440,-0.060411,0.195195 +0.443393,-0.060717,0.195195 +0.444347,-0.061024,0.195195 +0.445299,-0.061331,0.195195 +0.446252,-0.061639,0.195195 +0.447205,-0.061947,0.195195 +0.448158,-0.062255,0.195195 +0.449111,-0.062563,0.195195 +0.450063,-0.062871,0.195195 +0.451016,-0.063180,0.195195 +0.451968,-0.063489,0.195195 +0.452921,-0.063798,0.195195 +0.453873,-0.064108,0.195195 +0.454825,-0.064417,0.195195 +0.455778,-0.064727,0.195195 +0.456730,-0.065037,0.195195 +0.457682,-0.065348,0.195195 +0.458634,-0.065658,0.195195 +0.459586,-0.065969,0.195195 +0.460538,-0.066280,0.195195 +0.461490,-0.066592,0.195195 +0.462441,-0.066903,0.195195 +0.463393,-0.067215,0.195195 +0.464345,-0.067527,0.195195 +0.465296,-0.067840,0.195195 +0.466248,-0.068152,0.195195 +0.467199,-0.068465,0.195195 +0.468151,-0.068778,0.195195 +0.469102,-0.069091,0.195195 +0.470053,-0.069405,0.195195 +0.471005,-0.069718,0.195195 +0.471956,-0.070032,0.195195 +0.472907,-0.070346,0.195195 +0.473858,-0.070661,0.195195 +0.474809,-0.070975,0.195195 +0.475760,-0.071290,0.195195 +0.476711,-0.071605,0.195195 +0.477661,-0.071921,0.195195 +0.478612,-0.072236,0.195195 +0.479563,-0.072552,0.195195 +0.480513,-0.072868,0.195195 +0.481464,-0.073184,0.195195 +0.482415,-0.073501,0.195195 +0.483365,-0.073817,0.195195 +0.484315,-0.074134,0.195195 +0.485266,-0.074451,0.195195 +0.486216,-0.074769,0.195195 +0.487166,-0.075086,0.195195 +0.488116,-0.075404,0.195195 +0.489066,-0.075722,0.195195 +0.490016,-0.076040,0.195195 +0.490966,-0.076358,0.195195 +0.491916,-0.076677,0.195195 +0.492866,-0.076996,0.195195 +0.493816,-0.077315,0.195195 +0.494766,-0.077634,0.195195 +0.495715,-0.077953,0.195195 +0.496665,-0.078273,0.195195 +0.497614,-0.078593,0.195195 +0.498564,-0.078913,0.195195 +0.499513,-0.079233,0.195195 +0.500463,-0.079554,0.195195 +0.501412,-0.079875,0.195195 +0.502361,-0.080196,0.195195 +0.503311,-0.080517,0.195195 +0.504260,-0.080838,0.195195 +0.505209,-0.081160,0.195195 +0.506158,-0.081481,0.195195 +0.507107,-0.081803,0.195195 +0.508056,-0.082126,0.195195 +0.509005,-0.082448,0.195195 +0.509954,-0.082770,0.195195 +0.510902,-0.083093,0.195195 +0.511851,-0.083416,0.195195 +0.512800,-0.083739,0.195195 +0.513749,-0.084063,0.195195 +0.514697,-0.084386,0.195195 +0.515646,-0.084710,0.195195 +0.516594,-0.085034,0.195195 +0.517542,-0.085358,0.195195 +0.518491,-0.085683,0.195195 +0.519439,-0.086007,0.195195 +0.520387,-0.086332,0.195195 +0.521336,-0.086657,0.195195 +0.522284,-0.086982,0.195195 +0.523232,-0.087308,0.195195 +0.524180,-0.087633,0.195195 +0.525128,-0.087959,0.195195 +0.526076,-0.088285,0.195195 +0.527024,-0.088611,0.195195 +0.527972,-0.088937,0.195195 +0.528919,-0.089264,0.195195 +0.529867,-0.089590,0.195195 +0.530815,-0.089917,0.195195 +0.531762,-0.090244,0.195195 +0.532710,-0.090572,0.195195 +0.533657,-0.090899,0.195195 +0.534605,-0.091227,0.195195 +0.535552,-0.091555,0.195195 +0.536500,-0.091883,0.195195 +0.537447,-0.092211,0.195195 +0.538394,-0.092539,0.195195 +0.539342,-0.092868,0.195195 +0.540289,-0.093197,0.195195 +0.541236,-0.093526,0.195195 +0.542183,-0.093855,0.195195 +0.543130,-0.094184,0.195195 +0.544077,-0.094514,0.195195 +0.545024,-0.094843,0.195195 +0.545971,-0.095173,0.195195 +0.546918,-0.095503,0.195195 +0.547864,-0.095834,0.195195 +0.548811,-0.096164,0.195195 +0.549758,-0.096495,0.195195 +0.550705,-0.096825,0.195195 +0.551651,-0.097156,0.195195 +0.552598,-0.097487,0.195195 +0.553544,-0.097819,0.195195 +0.554491,-0.098150,0.195195 +0.555437,-0.098482,0.195195 +0.556383,-0.098814,0.195195 +0.557330,-0.099146,0.195195 +0.558276,-0.099478,0.195195 +0.559222,-0.099810,0.195195 +0.560168,-0.100143,0.195195 +0.561114,-0.100476,0.195195 +0.562061,-0.100809,0.195195 +0.563007,-0.101142,0.195195 +0.563953,-0.101475,0.195195 +0.564899,-0.101808,0.195195 +0.565844,-0.102142,0.195195 +0.566790,-0.102476,0.195195 +0.567736,-0.102810,0.195195 +0.568682,-0.103144,0.195195 +0.569628,-0.103478,0.195195 +0.570573,-0.103812,0.195195 +0.571519,-0.104147,0.195195 +0.572464,-0.104482,0.195195 +0.573410,-0.104817,0.195195 +0.574355,-0.105152,0.195195 +0.575301,-0.105487,0.195195 +0.576246,-0.105823,0.195195 +0.577192,-0.106158,0.195195 +0.578137,-0.106494,0.195195 +0.579082,-0.106830,0.195195 +0.580027,-0.107166,0.195195 +0.580972,-0.107503,0.195195 +0.581918,-0.107839,0.195195 +0.582863,-0.108176,0.195195 +0.583808,-0.108512,0.195195 +0.584753,-0.108849,0.195195 +0.585698,-0.109186,0.195195 +0.586643,-0.109524,0.195195 +0.587587,-0.109861,0.195195 +0.588532,-0.110199,0.195195 +0.589477,-0.110537,0.195195 +0.590422,-0.110875,0.195195 +0.591366,-0.111213,0.195195 +0.592311,-0.111551,0.195195 +0.593256,-0.111889,0.195195 +0.594200,-0.112228,0.195195 +0.595145,-0.112567,0.195195 +0.596089,-0.112905,0.195195 +0.597034,-0.113245,0.195195 +0.597978,-0.113584,0.195195 +0.598922,-0.113923,0.195195 +0.599867,-0.114263,0.195195 +0.600811,-0.114602,0.195195 +0.601755,-0.114942,0.195195 +0.602699,-0.115282,0.195195 +0.603643,-0.115622,0.195195 +0.604587,-0.115963,0.195195 +0.605532,-0.116303,0.195195 +0.606476,-0.116644,0.195195 +0.607419,-0.116985,0.195195 +0.608363,-0.117326,0.195195 +0.609307,-0.117667,0.195195 +0.610251,-0.118008,0.195195 +0.611195,-0.118349,0.195195 +0.612139,-0.118691,0.195195 +0.613082,-0.119033,0.195195 +0.614026,-0.119374,0.195195 +0.614970,-0.119716,0.195195 +0.615913,-0.120059,0.195195 +0.616857,-0.120401,0.195195 +0.617800,-0.120743,0.195195 +0.618744,-0.121086,0.195195 +0.619687,-0.121429,0.195195 +0.620631,-0.121772,0.195195 +0.621574,-0.122115,0.195195 +0.622517,-0.122458,0.195195 +0.623461,-0.122801,0.195195 +0.624404,-0.123145,0.195195 +0.625347,-0.123489,0.195195 +0.626290,-0.123832,0.195195 +0.627233,-0.124176,0.195195 +0.628176,-0.124520,0.195195 +0.629119,-0.124865,0.195195 +0.630062,-0.125209,0.195195 +0.631005,-0.125554,0.195195 +0.631948,-0.125898,0.195195 +0.632891,-0.126243,0.195195 +0.633834,-0.126588,0.195195 +0.634777,-0.126933,0.195195 +0.635719,-0.127279,0.195195 +0.636662,-0.127624,0.195195 +0.637605,-0.127970,0.195195 +0.638547,-0.128316,0.195195 +0.639490,-0.128661,0.195195 +0.640433,-0.129007,0.195195 +0.641375,-0.129354,0.195195 +0.642318,-0.129700,0.195195 +0.643260,-0.130046,0.195195 +0.644202,-0.130393,0.195195 +0.645145,-0.130740,0.195195 +0.646087,-0.131087,0.195195 +0.647029,-0.131434,0.195195 +0.647972,-0.131781,0.195195 +0.648914,-0.132128,0.195195 +0.649856,-0.132476,0.195195 +0.650798,-0.132823,0.195195 +0.651740,-0.133171,0.195195 +0.652682,-0.133519,0.195195 +0.653624,-0.133867,0.195195 +0.654566,-0.134215,0.195195 +0.655508,-0.134563,0.195195 +0.656450,-0.134912,0.195195 +0.657392,-0.135260,0.195195 +0.658334,-0.135609,0.195195 +0.659276,-0.135958,0.195195 +0.660217,-0.136307,0.195195 +0.661159,-0.136656,0.195195 +0.662101,-0.137006,0.195195 +0.663043,-0.137355,0.195195 +0.663984,-0.137705,0.195195 +0.664926,-0.138054,0.195195 +0.665867,-0.138404,0.195195 +0.666809,-0.138754,0.195195 +0.667750,-0.139104,0.195195 +0.668692,-0.139455,0.195195 +0.669633,-0.139805,0.195195 +0.670574,-0.140155,0.195195 +0.671516,-0.140506,0.195195 +0.672457,-0.140857,0.195195 +0.673398,-0.141208,0.195195 +0.674339,-0.141559,0.195195 +0.675281,-0.141910,0.195195 +0.676222,-0.142262,0.195195 +0.677163,-0.142613,0.195195 +0.678104,-0.142965,0.195195 +0.679045,-0.143316,0.195195 +0.679986,-0.143668,0.195195 +0.680927,-0.144020,0.195195 +0.681868,-0.144373,0.195195 +0.682809,-0.144725,0.195195 +0.683749,-0.145077,0.195195 +0.684690,-0.145430,0.195195 +0.685631,-0.145783,0.195195 +0.686572,-0.146136,0.195195 +0.687512,-0.146489,0.195195 +0.688453,-0.146842,0.195195 +0.689394,-0.147195,0.195195 +0.690334,-0.147548,0.195195 +0.691275,-0.147902,0.195195 +0.692215,-0.148256,0.195195 +0.693156,-0.148609,0.195195 +0.694096,-0.148963,0.195195 +0.695037,-0.149317,0.195195 +0.695977,-0.149672,0.195195 +0.696917,-0.150026,0.195195 +0.697858,-0.150380,0.195195 +0.698798,-0.150735,0.195195 +0.699738,-0.151090,0.195195 +0.700678,-0.151444,0.195195 +0.701618,-0.151799,0.195195 +0.702559,-0.152155,0.195195 +0.703499,-0.152510,0.195195 +0.704439,-0.152865,0.195195 +0.705379,-0.153221,0.195195 +0.706319,-0.153576,0.195195 +0.707259,-0.153932,0.195195 +0.708199,-0.154288,0.195195 +0.709138,-0.154644,0.195195 +0.710078,-0.155000,0.195195 +0.711018,-0.155357,0.195195 +0.711958,-0.155713,0.195195 +0.712898,-0.156070,0.195195 +0.713837,-0.156426,0.195195 +0.714777,-0.156783,0.195195 +0.715717,-0.157140,0.195195 +0.716656,-0.157497,0.195195 +0.717596,-0.157855,0.195195 +0.718535,-0.158212,0.195195 +0.719475,-0.158569,0.195195 +0.720414,-0.158927,0.195195 +0.721354,-0.159285,0.195195 +0.722293,-0.159643,0.195195 +0.723232,-0.160001,0.195195 +0.724172,-0.160359,0.195195 +0.725111,-0.160717,0.195195 +0.726050,-0.161076,0.195195 +0.726989,-0.161434,0.195195 +0.727929,-0.161793,0.195195 +0.728868,-0.162152,0.195195 +0.729807,-0.162511,0.195195 +0.730746,-0.162870,0.195195 +0.731685,-0.163229,0.195195 +0.732624,-0.163588,0.195195 +0.733563,-0.163948,0.195195 +0.734502,-0.164307,0.195195 +0.735441,-0.164667,0.195195 +0.736379,-0.165027,0.195195 +0.737318,-0.165387,0.195195 +0.738257,-0.165747,0.195195 +0.739196,-0.166107,0.195195 +0.740135,-0.166467,0.195195 +0.741073,-0.166828,0.195195 +0.742012,-0.167188,0.195195 +0.742951,-0.167549,0.195195 +0.743889,-0.167910,0.195195 +0.744828,-0.168271,0.195195 +0.745766,-0.168632,0.195195 +0.746705,-0.168993,0.195195 +0.747643,-0.169355,0.195195 +0.748582,-0.169716,0.195195 +0.749520,-0.170078,0.195195 +0.750458,-0.170440,0.195195 +0.751397,-0.170801,0.195195 +0.752335,-0.171163,0.195195 +0.753273,-0.171526,0.195195 +0.754211,-0.171888,0.195195 +0.755149,-0.172250,0.195195 +0.756088,-0.172613,0.195195 +0.757026,-0.172976,0.195195 +0.757964,-0.173338,0.195195 +0.758902,-0.173701,0.195195 +0.759840,-0.174064,0.195195 +0.760778,-0.174427,0.195195 +0.761716,-0.174791,0.195195 +0.762654,-0.175154,0.195195 +0.763591,-0.175518,0.195195 +0.764529,-0.175881,0.195195 +0.765467,-0.176245,0.195195 +0.766405,-0.176609,0.195195 +0.767343,-0.176973,0.195195 +0.768280,-0.177337,0.195195 +0.769218,-0.177702,0.195195 +0.770155,-0.178066,0.195195 +0.771093,-0.178431,0.195195 +0.772031,-0.178796,0.195195 +0.772968,-0.179160,0.195195 +0.773906,-0.179525,0.195195 +0.774843,-0.179890,0.195195 +0.775780,-0.180256,0.195195 +0.776718,-0.180621,0.195195 +0.777655,-0.180986,0.195195 +0.778593,-0.181352,0.195195 +0.779530,-0.181718,0.195195 +0.780467,-0.182084,0.195195 +0.781404,-0.182450,0.195195 +0.782341,-0.182816,0.195195 +0.783279,-0.183182,0.195195 +0.784216,-0.183548,0.195195 +0.785153,-0.183915,0.195195 +0.786090,-0.184282,0.195195 +0.787027,-0.184648,0.195195 +0.787964,-0.185015,0.195195 +0.788901,-0.185382,0.195195 +0.789838,-0.185750,0.195195 +0.790774,-0.186117,0.195195 +0.791711,-0.186484,0.195195 +0.792648,-0.186852,0.195195 +0.793585,-0.187219,0.195195 +0.794522,-0.187587,0.195195 +0.795458,-0.187955,0.195195 +0.796395,-0.188323,0.195195 +0.797331,-0.188691,0.195195 +0.798268,-0.189060,0.195195 +0.799205,-0.189428,0.195195 +0.800141,-0.189797,0.195195 +0.801078,-0.190166,0.195195 +0.802014,-0.190534,0.195195 +0.802950,-0.190903,0.195195 +0.803887,-0.191272,0.195195 +0.804823,-0.191642,0.195195 +0.805759,-0.192011,0.195195 +0.806696,-0.192381,0.195195 +0.807632,-0.192750,0.195195 +0.808568,-0.193120,0.195195 +0.809504,-0.193490,0.195195 +0.810440,-0.193860,0.195195 +0.811377,-0.194230,0.195195 +0.812313,-0.194600,0.195195 +0.813249,-0.194971,0.195195 +0.814185,-0.195341,0.195195 +0.815121,-0.195712,0.195195 +0.816057,-0.196083,0.195195 +0.816992,-0.196453,0.195195 +0.817928,-0.196825,0.195195 +0.818864,-0.197196,0.195195 +0.819800,-0.197567,0.195195 +0.820736,-0.197938,0.195195 +0.821671,-0.198310,0.195195 +0.822607,-0.198682,0.195195 +0.823543,-0.199054,0.195195 +0.824478,-0.199426,0.195195 +0.825414,-0.199798,0.195195 +0.826349,-0.200170,0.195195 +0.827285,-0.200542,0.195195 +0.828220,-0.200915,0.195195 +0.829156,-0.201287,0.195195 +0.830091,-0.201660,0.195195 +0.831027,-0.202033,0.195195 +0.831962,-0.202406,0.195195 +0.832897,-0.202779,0.195195 +0.833832,-0.203153,0.195195 +0.834768,-0.203526,0.195195 +0.835703,-0.203900,0.195195 +0.836638,-0.204273,0.195195 +0.837573,-0.204647,0.195195 +0.838508,-0.205021,0.195195 +0.839443,-0.205395,0.195195 +0.840378,-0.205769,0.195195 +0.841313,-0.206144,0.195195 +0.842248,-0.206518,0.195195 +0.843183,-0.206893,0.195195 +0.844118,-0.207268,0.195195 +0.845053,-0.207643,0.195195 +0.845987,-0.208018,0.195195 +0.846922,-0.208393,0.195195 +0.847857,-0.208768,0.195195 +0.848792,-0.209144,0.195195 +0.849726,-0.209519,0.195195 +0.850661,-0.209895,0.195195 +0.851595,-0.210271,0.195195 +0.852530,-0.210647,0.195195 +0.853464,-0.211023,0.195195 +0.854399,-0.211399,0.195195 +0.855333,-0.211776,0.195195 +0.856268,-0.212152,0.195195 +0.857202,-0.212529,0.195195 +0.858136,-0.212906,0.195195 +0.859071,-0.213283,0.195195 +0.860005,-0.213660,0.195195 +0.860939,-0.214037,0.195195 +0.861873,-0.214414,0.195195 +0.862807,-0.214792,0.195195 +0.863741,-0.215169,0.195195 +0.864675,-0.215547,0.195195 +0.865609,-0.215925,0.195195 +0.866543,-0.216303,0.195195 +0.867477,-0.216681,0.195195 +0.868411,-0.217060,0.195195 +0.869345,-0.217438,0.195195 +0.870279,-0.217817,0.195195 +0.871213,-0.218195,0.195195 +0.872146,-0.218574,0.195195 +0.873080,-0.218953,0.195195 +0.874014,-0.219332,0.195195 +0.874948,-0.219712,0.195195 +0.875881,-0.220091,0.195195 +0.876815,-0.220471,0.195195 +0.877748,-0.220850,0.195195 +0.878682,-0.221230,0.195195 +0.879615,-0.221610,0.195195 +0.880549,-0.221991,0.195195 +0.881482,-0.222371,0.195195 +0.882415,-0.222751,0.195195 +0.883349,-0.223132,0.195195 +0.884282,-0.223513,0.195195 +0.885215,-0.223893,0.195195 +0.886148,-0.224274,0.195195 +0.887081,-0.224656,0.195195 +0.888015,-0.225037,0.195195 +0.888948,-0.225418,0.195195 +0.889881,-0.225800,0.195195 +0.890814,-0.226182,0.195195 +0.891747,-0.226563,0.195195 +0.892680,-0.226945,0.195195 +0.893612,-0.227328,0.195195 +0.894545,-0.227710,0.195195 +0.895478,-0.228092,0.195195 +0.896411,-0.228475,0.195195 +0.897344,-0.228858,0.195195 +0.898276,-0.229240,0.195195 +0.899209,-0.229623,0.195195 +0.900141,-0.230007,0.195195 +0.901074,-0.230390,0.195195 +0.902007,-0.230773,0.195195 +0.902939,-0.231157,0.195195 +0.903872,-0.231541,0.195195 +0.904804,-0.231925,0.195195 +0.905736,-0.232309,0.195195 +0.906669,-0.232693,0.195195 +0.907601,-0.233077,0.195195 +0.908533,-0.233462,0.195195 +0.909465,-0.233846,0.195195 +0.910398,-0.234231,0.195195 +0.911330,-0.234616,0.195195 +0.912262,-0.235001,0.195195 +0.913194,-0.235386,0.195195 +0.914126,-0.235772,0.195195 +0.915058,-0.236157,0.195195 +0.915990,-0.236543,0.195195 +0.916922,-0.236929,0.195195 +0.917853,-0.237315,0.195195 +0.918785,-0.237701,0.195195 +0.919717,-0.238087,0.195195 +0.920649,-0.238474,0.195195 +0.921580,-0.238860,0.195195 +0.922512,-0.239247,0.195195 +0.923444,-0.239634,0.195195 +0.924375,-0.240021,0.195195 +0.925307,-0.240408,0.195195 +0.926238,-0.240796,0.195195 +0.927170,-0.241183,0.195195 +0.928101,-0.241571,0.195195 +0.929032,-0.241959,0.195195 +0.929964,-0.242347,0.195195 +0.930895,-0.242735,0.195195 +0.931826,-0.243123,0.195195 +0.932758,-0.243512,0.195195 +0.933689,-0.243900,0.195195 +0.934620,-0.244289,0.195195 +0.935551,-0.244678,0.195195 +0.936482,-0.245067,0.195195 +0.937413,-0.245456,0.195195 +0.938344,-0.245846,0.195195 +0.939275,-0.246235,0.195195 +0.940206,-0.246625,0.195195 +0.941136,-0.247015,0.195195 +0.942067,-0.247405,0.195195 +0.942998,-0.247795,0.195195 +0.943929,-0.248185,0.195195 +0.944859,-0.248576,0.195195 +0.945790,-0.248966,0.195195 +0.946720,-0.249357,0.195195 +0.947651,-0.249748,0.195195 +0.948581,-0.250139,0.195195 +0.949512,-0.250531,0.195195 +0.950442,-0.250922,0.195195 +0.951372,-0.251314,0.195195 +0.952303,-0.251705,0.195195 +0.953233,-0.252097,0.195195 +0.954163,-0.252490,0.195195 +0.955093,-0.252882,0.195195 +0.956024,-0.253274,0.195195 +0.956954,-0.253667,0.195195 +0.957884,-0.254060,0.195195 +0.958814,-0.254453,0.195195 +0.959744,-0.254846,0.195195 +0.960673,-0.255239,0.195195 +0.961603,-0.255632,0.195195 +0.962533,-0.256026,0.195195 +0.963463,-0.256420,0.195195 +0.964393,-0.256814,0.195195 +0.965322,-0.257208,0.195195 +0.966252,-0.257602,0.195195 +0.965600,-0.260036,0.195195 +0.964597,-0.259913,0.195195 +0.963595,-0.259789,0.195195 +0.962593,-0.259665,0.195195 +0.961591,-0.259542,0.195195 +0.960589,-0.259418,0.195195 +0.959587,-0.259293,0.195195 +0.958585,-0.259169,0.195195 +0.957583,-0.259044,0.195195 +0.956581,-0.258920,0.195195 +0.955580,-0.258795,0.195195 +0.954578,-0.258670,0.195195 +0.953576,-0.258545,0.195195 +0.952574,-0.258419,0.195195 +0.951573,-0.258294,0.195195 +0.950571,-0.258168,0.195195 +0.949570,-0.258042,0.195195 +0.948568,-0.257916,0.195195 +0.947567,-0.257790,0.195195 +0.946565,-0.257664,0.195195 +0.945564,-0.257537,0.195195 +0.944562,-0.257411,0.195195 +0.943561,-0.257284,0.195195 +0.942560,-0.257157,0.195195 +0.941559,-0.257030,0.195195 +0.940558,-0.256902,0.195195 +0.939556,-0.256775,0.195195 +0.938555,-0.256647,0.195195 +0.937554,-0.256519,0.195195 +0.936553,-0.256392,0.195195 +0.935552,-0.256263,0.195195 +0.934551,-0.256135,0.195195 +0.933551,-0.256007,0.195195 +0.932550,-0.255878,0.195195 +0.931549,-0.255749,0.195195 +0.930548,-0.255621,0.195195 +0.929547,-0.255492,0.195195 +0.928547,-0.255362,0.195195 +0.927546,-0.255233,0.195195 +0.926546,-0.255104,0.195195 +0.925545,-0.254974,0.195195 +0.924545,-0.254844,0.195195 +0.923544,-0.254714,0.195195 +0.922544,-0.254584,0.195195 +0.921543,-0.254454,0.195195 +0.920543,-0.254323,0.195195 +0.919543,-0.254193,0.195195 +0.918542,-0.254062,0.195195 +0.917542,-0.253931,0.195195 +0.916542,-0.253800,0.195195 +0.915542,-0.253669,0.195195 +0.914542,-0.253538,0.195195 +0.913542,-0.253406,0.195195 +0.912542,-0.253274,0.195195 +0.911542,-0.253143,0.195195 +0.910542,-0.253011,0.195195 +0.909542,-0.252879,0.195195 +0.908542,-0.252746,0.195195 +0.907542,-0.252614,0.195195 +0.906543,-0.252481,0.195195 +0.905543,-0.252349,0.195195 +0.904543,-0.252216,0.195195 +0.903544,-0.252083,0.195195 +0.902544,-0.251950,0.195195 +0.901545,-0.251816,0.195195 +0.900545,-0.251683,0.195195 +0.899546,-0.251549,0.195195 +0.898546,-0.251416,0.195195 +0.897547,-0.251282,0.195195 +0.896547,-0.251148,0.195195 +0.895548,-0.251014,0.195195 +0.894549,-0.250879,0.195195 +0.893549,-0.250745,0.195195 +0.892550,-0.250610,0.195195 +0.891551,-0.250475,0.195195 +0.890552,-0.250340,0.195195 +0.889553,-0.250205,0.195195 +0.888554,-0.250070,0.195195 +0.887555,-0.249935,0.195195 +0.886556,-0.249799,0.195195 +0.885557,-0.249664,0.195195 +0.884558,-0.249528,0.195195 +0.883559,-0.249392,0.195195 +0.882560,-0.249256,0.195195 +0.881562,-0.249120,0.195195 +0.880563,-0.248983,0.195195 +0.879564,-0.248847,0.195195 +0.878565,-0.248710,0.195195 +0.877567,-0.248573,0.195195 +0.876568,-0.248436,0.195195 +0.875570,-0.248299,0.195195 +0.874571,-0.248162,0.195195 +0.873573,-0.248025,0.195195 +0.872574,-0.247887,0.195195 +0.871576,-0.247750,0.195195 +0.870578,-0.247612,0.195195 +0.869579,-0.247474,0.195195 +0.868581,-0.247336,0.195195 +0.867583,-0.247198,0.195195 +0.866584,-0.247059,0.195195 +0.865586,-0.246921,0.195195 +0.864588,-0.246782,0.195195 +0.863590,-0.246644,0.195195 +0.862592,-0.246505,0.195195 +0.861594,-0.246366,0.195195 +0.860596,-0.246226,0.195195 +0.859598,-0.246087,0.195195 +0.858600,-0.245948,0.195195 +0.857602,-0.245808,0.195195 +0.856604,-0.245668,0.195195 +0.855607,-0.245529,0.195195 +0.854609,-0.245389,0.195195 +0.853611,-0.245248,0.195195 +0.852613,-0.245108,0.195195 +0.851616,-0.244968,0.195195 +0.850618,-0.244827,0.195195 +0.849621,-0.244686,0.195195 +0.848623,-0.244546,0.195195 +0.847626,-0.244405,0.195195 +0.846628,-0.244264,0.195195 +0.845631,-0.244122,0.195195 +0.844633,-0.243981,0.195195 +0.843636,-0.243839,0.195195 +0.842639,-0.243698,0.195195 +0.841641,-0.243556,0.195195 +0.840644,-0.243414,0.195195 +0.839647,-0.243272,0.195195 +0.838650,-0.243130,0.195195 +0.837653,-0.242988,0.195195 +0.836655,-0.242845,0.195195 +0.835658,-0.242702,0.195195 +0.834661,-0.242560,0.195195 +0.833664,-0.242417,0.195195 +0.832667,-0.242274,0.195195 +0.831670,-0.242131,0.195195 +0.830674,-0.241987,0.195195 +0.829677,-0.241844,0.195195 +0.828680,-0.241701,0.195195 +0.827683,-0.241557,0.195195 +0.826686,-0.241413,0.195195 +0.825690,-0.241269,0.195195 +0.824693,-0.241125,0.195195 +0.823696,-0.240981,0.195195 +0.822700,-0.240837,0.195195 +0.821703,-0.240692,0.195195 +0.820707,-0.240547,0.195195 +0.819710,-0.240403,0.195195 +0.818714,-0.240258,0.195195 +0.817717,-0.240113,0.195195 +0.816721,-0.239968,0.195195 +0.815725,-0.239822,0.195195 +0.814728,-0.239677,0.195195 +0.813732,-0.239531,0.195195 +0.812736,-0.239386,0.195195 +0.811739,-0.239240,0.195195 +0.810743,-0.239094,0.195195 +0.809747,-0.238948,0.195195 +0.808751,-0.238802,0.195195 +0.807755,-0.238656,0.195195 +0.806759,-0.238509,0.195195 +0.805763,-0.238363,0.195195 +0.804767,-0.238216,0.195195 +0.803771,-0.238069,0.195195 +0.802775,-0.237922,0.195195 +0.801779,-0.237775,0.195195 +0.800783,-0.237628,0.195195 +0.799788,-0.237480,0.195195 +0.798792,-0.237333,0.195195 +0.797796,-0.237185,0.195195 +0.796801,-0.237037,0.195195 +0.795805,-0.236889,0.195195 +0.794809,-0.236741,0.195195 +0.793814,-0.236593,0.195195 +0.792818,-0.236445,0.195195 +0.791823,-0.236297,0.195195 +0.790827,-0.236148,0.195195 +0.789832,-0.235999,0.195195 +0.788836,-0.235851,0.195195 +0.787841,-0.235702,0.195195 +0.786846,-0.235553,0.195195 +0.785850,-0.235403,0.195195 +0.784855,-0.235254,0.195195 +0.783860,-0.235105,0.195195 +0.782865,-0.234955,0.195195 +0.781869,-0.234805,0.195195 +0.780874,-0.234656,0.195195 +0.779879,-0.234506,0.195195 +0.778884,-0.234356,0.195195 +0.777889,-0.234205,0.195195 +0.776894,-0.234055,0.195195 +0.775899,-0.233905,0.195195 +0.774904,-0.233754,0.195195 +0.773909,-0.233603,0.195195 +0.772915,-0.233452,0.195195 +0.771920,-0.233301,0.195195 +0.770925,-0.233150,0.195195 +0.769930,-0.232999,0.195195 +0.768935,-0.232848,0.195195 +0.767941,-0.232696,0.195195 +0.766946,-0.232544,0.195195 +0.765952,-0.232393,0.195195 +0.764957,-0.232241,0.195195 +0.763962,-0.232089,0.195195 +0.762968,-0.231937,0.195195 +0.761973,-0.231784,0.195195 +0.760979,-0.231632,0.195195 +0.759985,-0.231479,0.195195 +0.758990,-0.231327,0.195195 +0.757996,-0.231174,0.195195 +0.757002,-0.231021,0.195195 +0.756007,-0.230868,0.195195 +0.755013,-0.230715,0.195195 +0.754019,-0.230561,0.195195 +0.753025,-0.230408,0.195195 +0.752031,-0.230254,0.195195 +0.751037,-0.230101,0.195195 +0.750042,-0.229947,0.195195 +0.749048,-0.229793,0.195195 +0.748054,-0.229639,0.195195 +0.747060,-0.229485,0.195195 +0.746067,-0.229330,0.195195 +0.745073,-0.229176,0.195195 +0.744079,-0.229021,0.195195 +0.743085,-0.228866,0.195195 +0.742091,-0.228712,0.195195 +0.741097,-0.228557,0.195195 +0.740104,-0.228402,0.195195 +0.739110,-0.228246,0.195195 +0.738116,-0.228091,0.195195 +0.737123,-0.227935,0.195195 +0.736129,-0.227780,0.195195 +0.735136,-0.227624,0.195195 +0.734142,-0.227468,0.195195 +0.733149,-0.227312,0.195195 +0.732155,-0.227156,0.195195 +0.731162,-0.227000,0.195195 +0.730168,-0.226843,0.195195 +0.729175,-0.226687,0.195195 +0.728182,-0.226530,0.195195 +0.727189,-0.226374,0.195195 +0.726195,-0.226217,0.195195 +0.725202,-0.226060,0.195195 +0.724209,-0.225902,0.195195 +0.723216,-0.225745,0.195195 +0.722223,-0.225588,0.195195 +0.721230,-0.225430,0.195195 +0.720237,-0.225273,0.195195 +0.719244,-0.225115,0.195195 +0.718251,-0.224957,0.195195 +0.717258,-0.224799,0.195195 +0.716265,-0.224641,0.195195 +0.715272,-0.224482,0.195195 +0.714279,-0.224324,0.195195 +0.713286,-0.224165,0.195195 +0.712294,-0.224006,0.195195 +0.711301,-0.223848,0.195195 +0.710308,-0.223689,0.195195 +0.709316,-0.223530,0.195195 +0.708323,-0.223370,0.195195 +0.707330,-0.223211,0.195195 +0.706338,-0.223051,0.195195 +0.705345,-0.222892,0.195195 +0.704353,-0.222732,0.195195 +0.703361,-0.222572,0.195195 +0.702368,-0.222412,0.195195 +0.701376,-0.222252,0.195195 +0.700383,-0.222092,0.195195 +0.699391,-0.221931,0.195195 +0.698399,-0.221771,0.195195 +0.697407,-0.221610,0.195195 +0.696414,-0.221449,0.195195 +0.695422,-0.221288,0.195195 +0.694430,-0.221127,0.195195 +0.693438,-0.220966,0.195195 +0.692446,-0.220805,0.195195 +0.691454,-0.220643,0.195195 +0.690462,-0.220482,0.195195 +0.689470,-0.220320,0.195195 +0.688478,-0.220158,0.195195 +0.687486,-0.219996,0.195195 +0.686494,-0.219834,0.195195 +0.685503,-0.219672,0.195195 +0.684511,-0.219510,0.195195 +0.683519,-0.219347,0.195195 +0.682527,-0.219184,0.195195 +0.681536,-0.219022,0.195195 +0.680544,-0.218859,0.195195 +0.679553,-0.218696,0.195195 +0.678561,-0.218532,0.195195 +0.677570,-0.218369,0.195195 +0.676578,-0.218206,0.195195 +0.675587,-0.218042,0.195195 +0.674595,-0.217878,0.195195 +0.673604,-0.217715,0.195195 +0.672612,-0.217551,0.195195 +0.671621,-0.217387,0.195195 +0.670630,-0.217222,0.195195 +0.669639,-0.217058,0.195195 +0.668647,-0.216893,0.195195 +0.667656,-0.216729,0.195195 +0.666665,-0.216564,0.195195 +0.665674,-0.216399,0.195195 +0.664683,-0.216234,0.195195 +0.663692,-0.216069,0.195195 +0.662701,-0.215904,0.195195 +0.661710,-0.215738,0.195195 +0.660719,-0.215572,0.195195 +0.659728,-0.215407,0.195195 +0.658738,-0.215241,0.195195 +0.657747,-0.215075,0.195195 +0.656756,-0.214909,0.195195 +0.655765,-0.214742,0.195195 +0.654775,-0.214576,0.195195 +0.653784,-0.214409,0.195195 +0.652793,-0.214243,0.195195 +0.651803,-0.214076,0.195195 +0.650812,-0.213909,0.195195 +0.649822,-0.213742,0.195195 +0.648831,-0.213575,0.195195 +0.647841,-0.213407,0.195195 +0.646850,-0.213240,0.195195 +0.645860,-0.213072,0.195195 +0.644870,-0.212904,0.195195 +0.643879,-0.212736,0.195195 +0.642889,-0.212568,0.195195 +0.641899,-0.212400,0.195195 +0.640909,-0.212232,0.195195 +0.639919,-0.212063,0.195195 +0.638929,-0.211895,0.195195 +0.637939,-0.211726,0.195195 +0.636949,-0.211557,0.195195 +0.635959,-0.211388,0.195195 +0.634969,-0.211219,0.195195 +0.633979,-0.211050,0.195195 +0.632989,-0.210880,0.195195 +0.631999,-0.210710,0.195195 +0.631009,-0.210541,0.195195 +0.630019,-0.210371,0.195195 +0.629030,-0.210201,0.195195 +0.628040,-0.210031,0.195195 +0.627050,-0.209860,0.195195 +0.626061,-0.209690,0.195195 +0.625071,-0.209519,0.195195 +0.624082,-0.209348,0.195195 +0.623092,-0.209178,0.195195 +0.622103,-0.209007,0.195195 +0.621113,-0.208835,0.195195 +0.620124,-0.208664,0.195195 +0.619135,-0.208493,0.195195 +0.618145,-0.208321,0.195195 +0.617156,-0.208149,0.195195 +0.616167,-0.207977,0.195195 +0.615178,-0.207805,0.195195 +0.614189,-0.207633,0.195195 +0.613199,-0.207461,0.195195 +0.612210,-0.207288,0.195195 +0.611221,-0.207116,0.195195 +0.610232,-0.206943,0.195195 +0.609243,-0.206770,0.195195 +0.608255,-0.206597,0.195195 +0.607266,-0.206424,0.195195 +0.606277,-0.206250,0.195195 +0.605288,-0.206077,0.195195 +0.604299,-0.205903,0.195195 +0.603311,-0.205729,0.195195 +0.602322,-0.205555,0.195195 +0.601333,-0.205381,0.195195 +0.600345,-0.205207,0.195195 +0.599356,-0.205033,0.195195 +0.598368,-0.204858,0.195195 +0.597379,-0.204683,0.195195 +0.596391,-0.204508,0.195195 +0.595402,-0.204333,0.195195 +0.594414,-0.204158,0.195195 +0.593426,-0.203983,0.195195 +0.592438,-0.203807,0.195195 +0.591449,-0.203632,0.195195 +0.590461,-0.203456,0.195195 +0.589473,-0.203280,0.195195 +0.588485,-0.203104,0.195195 +0.587497,-0.202928,0.195195 +0.586509,-0.202751,0.195195 +0.585521,-0.202575,0.195195 +0.584533,-0.202398,0.195195 +0.583545,-0.202221,0.195195 +0.582557,-0.202044,0.195195 +0.581569,-0.201867,0.195195 +0.580582,-0.201690,0.195195 +0.579594,-0.201512,0.195195 +0.578606,-0.201335,0.195195 +0.577619,-0.201157,0.195195 +0.576631,-0.200979,0.195195 +0.575644,-0.200801,0.195195 +0.574656,-0.200623,0.195195 +0.573669,-0.200444,0.195195 +0.572681,-0.200266,0.195195 +0.571694,-0.200087,0.195195 +0.570706,-0.199908,0.195195 +0.569719,-0.199729,0.195195 +0.568732,-0.199550,0.195195 +0.567745,-0.199370,0.195195 +0.566757,-0.199191,0.195195 +0.565770,-0.199011,0.195195 +0.564783,-0.198831,0.195195 +0.563796,-0.198651,0.195195 +0.562809,-0.198471,0.195195 +0.561822,-0.198291,0.195195 +0.560835,-0.198110,0.195195 +0.559848,-0.197929,0.195195 +0.558862,-0.197748,0.195195 +0.557875,-0.197567,0.195195 +0.556888,-0.197386,0.195195 +0.555901,-0.197205,0.195195 +0.554915,-0.197023,0.195195 +0.553928,-0.196842,0.195195 +0.552942,-0.196660,0.195195 +0.551955,-0.196478,0.195195 +0.550969,-0.196296,0.195195 +0.549982,-0.196113,0.195195 +0.548996,-0.195931,0.195195 +0.548010,-0.195748,0.195195 +0.547023,-0.195565,0.195195 +0.546037,-0.195382,0.195195 +0.545051,-0.195199,0.195195 +0.544065,-0.195016,0.195195 +0.543079,-0.194832,0.195195 +0.542093,-0.194649,0.195195 +0.541107,-0.194465,0.195195 +0.540121,-0.194281,0.195195 +0.539135,-0.194096,0.195195 +0.538149,-0.193912,0.195195 +0.537163,-0.193727,0.195195 +0.536177,-0.193543,0.195195 +0.535192,-0.193358,0.195195 +0.534206,-0.193173,0.195195 +0.533220,-0.192987,0.195195 +0.532235,-0.192802,0.195195 +0.531249,-0.192616,0.195195 +0.530264,-0.192431,0.195195 +0.529278,-0.192245,0.195195 +0.528293,-0.192059,0.195195 +0.527307,-0.191872,0.195195 +0.526322,-0.191686,0.195195 +0.525337,-0.191499,0.195195 +0.524352,-0.191312,0.195195 +0.523366,-0.191125,0.195195 +0.522381,-0.190938,0.195195 +0.521396,-0.190751,0.195195 +0.520411,-0.190563,0.195195 +0.519426,-0.190375,0.195195 +0.518441,-0.190187,0.195195 +0.517457,-0.189999,0.195195 +0.516472,-0.189811,0.195195 +0.515487,-0.189622,0.195195 +0.514502,-0.189434,0.195195 +0.513518,-0.189245,0.195195 +0.512533,-0.189056,0.195195 +0.511548,-0.188867,0.195195 +0.510564,-0.188677,0.195195 +0.509579,-0.188487,0.195195 +0.508595,-0.188298,0.195195 +0.507611,-0.188108,0.195195 +0.506626,-0.187918,0.195195 +0.505642,-0.187727,0.195195 +0.504658,-0.187537,0.195195 +0.503674,-0.187346,0.195195 +0.502689,-0.187155,0.195195 +0.501705,-0.186964,0.195195 +0.500721,-0.186773,0.195195 +0.499737,-0.186581,0.195195 +0.498754,-0.186389,0.195195 +0.497770,-0.186197,0.195195 +0.496786,-0.186005,0.195195 +0.495802,-0.185813,0.195195 +0.494818,-0.185621,0.195195 +0.493835,-0.185428,0.195195 +0.492851,-0.185235,0.195195 +0.491868,-0.185042,0.195195 +0.490884,-0.184849,0.195195 +0.489901,-0.184655,0.195195 +0.488917,-0.184462,0.195195 +0.487934,-0.184268,0.195195 +0.486951,-0.184074,0.195195 +0.485967,-0.183879,0.195195 +0.484984,-0.183685,0.195195 +0.484001,-0.183490,0.195195 +0.483018,-0.183296,0.195195 +0.482035,-0.183100,0.195195 +0.481052,-0.182905,0.195195 +0.480069,-0.182710,0.195195 +0.479086,-0.182514,0.195195 +0.478104,-0.182318,0.195195 +0.477121,-0.182122,0.195195 +0.476138,-0.181926,0.195195 +0.475156,-0.181729,0.195195 +0.474173,-0.181533,0.195195 +0.473190,-0.181336,0.195195 +0.472208,-0.181139,0.195195 +0.471226,-0.180941,0.195195 +0.470243,-0.180744,0.195195 +0.469261,-0.180546,0.195195 +0.468279,-0.180348,0.195195 +0.467297,-0.180150,0.195195 +0.466314,-0.179951,0.195195 +0.465332,-0.179753,0.195195 +0.464350,-0.179554,0.195195 +0.463368,-0.179355,0.195195 +0.462387,-0.179156,0.195195 +0.461405,-0.178956,0.195195 +0.460423,-0.178757,0.195195 +0.459441,-0.178557,0.195195 +0.458460,-0.178357,0.195195 +0.457478,-0.178156,0.195195 +0.456496,-0.177956,0.195195 +0.455515,-0.177755,0.195195 +0.454534,-0.177554,0.195195 +0.453552,-0.177353,0.195195 +0.452571,-0.177151,0.195195 +0.451590,-0.176950,0.195195 +0.450608,-0.176748,0.195195 +0.449627,-0.176546,0.195195 +0.448646,-0.176343,0.195195 +0.447665,-0.176141,0.195195 +0.446684,-0.175938,0.195195 +0.445703,-0.175735,0.195195 +0.444723,-0.175532,0.195195 +0.443742,-0.175328,0.195195 +0.442761,-0.175124,0.195195 +0.441781,-0.174921,0.195195 +0.440800,-0.174716,0.195195 +0.439819,-0.174512,0.195195 +0.438839,-0.174307,0.195195 +0.437859,-0.174103,0.195195 +0.436878,-0.173897,0.195195 +0.435898,-0.173692,0.195195 +0.434918,-0.173487,0.195195 +0.433938,-0.173281,0.195195 +0.432958,-0.173075,0.195195 +0.431978,-0.172868,0.195195 +0.430998,-0.172662,0.195195 +0.430018,-0.172455,0.195195 +0.429038,-0.172248,0.195195 +0.428058,-0.172041,0.195195 +0.427079,-0.171833,0.195195 +0.426099,-0.171626,0.195195 +0.425119,-0.171418,0.195195 +0.424140,-0.171210,0.195195 +0.423160,-0.171001,0.195195 +0.422181,-0.170792,0.195195 +0.421202,-0.170584,0.195195 +0.420223,-0.170374,0.195195 +0.419243,-0.170165,0.195195 +0.418264,-0.169955,0.195195 +0.417285,-0.169745,0.195195 +0.416306,-0.169535,0.195195 +0.415327,-0.169325,0.195195 +0.414349,-0.169114,0.195195 +0.413370,-0.168903,0.195195 +0.412391,-0.168692,0.195195 +0.411413,-0.168480,0.195195 +0.410434,-0.168269,0.195195 +0.409456,-0.168057,0.195195 +0.408477,-0.167845,0.195195 +0.407499,-0.167632,0.195195 +0.406521,-0.167419,0.195195 +0.405542,-0.167206,0.195195 +0.404564,-0.166993,0.195195 +0.403586,-0.166780,0.195195 +0.402608,-0.166566,0.195195 +0.401630,-0.166352,0.195195 +0.400652,-0.166137,0.195195 +0.399675,-0.165923,0.195195 +0.398697,-0.165708,0.195195 +0.397719,-0.165493,0.195195 +0.396742,-0.165278,0.195195 +0.395764,-0.165062,0.195195 +0.394787,-0.164846,0.195195 +0.393809,-0.164630,0.195195 +0.392832,-0.164413,0.195195 +0.391855,-0.164197,0.195195 +0.390878,-0.163980,0.195195 +0.389901,-0.163762,0.195195 +0.388924,-0.163545,0.195195 +0.387947,-0.163327,0.195195 +0.386970,-0.163109,0.195195 +0.385993,-0.162890,0.195195 +0.385017,-0.162672,0.195195 +0.384040,-0.162453,0.195195 +0.383063,-0.162234,0.195195 +0.382087,-0.162014,0.195195 +0.381111,-0.161794,0.195195 +0.380134,-0.161574,0.195195 +0.379158,-0.161354,0.195195 +0.378182,-0.161133,0.195195 +0.377206,-0.160912,0.195195 +0.376230,-0.160691,0.195195 +0.375254,-0.160469,0.195195 +0.374278,-0.160248,0.195195 +0.373302,-0.160026,0.195195 +0.372327,-0.159803,0.195195 +0.371351,-0.159580,0.195195 +0.370375,-0.159357,0.195195 +0.369400,-0.159134,0.195195 +0.368425,-0.158911,0.195195 +0.367449,-0.158687,0.195195 +0.366474,-0.158463,0.195195 +0.365499,-0.158238,0.195195 +0.364524,-0.158013,0.195195 +0.363549,-0.157788,0.195195 +0.362574,-0.157563,0.195195 +0.361599,-0.157337,0.195195 +0.360625,-0.157111,0.195195 +0.359650,-0.156885,0.195195 +0.358675,-0.156658,0.195195 +0.357701,-0.156431,0.195195 +0.356727,-0.156204,0.195195 +0.355752,-0.155976,0.195195 +0.354778,-0.155749,0.195195 +0.353804,-0.155520,0.195195 +0.352830,-0.155292,0.195195 +0.351856,-0.155063,0.195195 +0.350882,-0.154834,0.195195 +0.349908,-0.154605,0.195195 +0.348935,-0.154375,0.195195 +0.347961,-0.154145,0.195195 +0.346987,-0.153914,0.195195 +0.346014,-0.153684,0.195195 +0.345041,-0.153453,0.195195 +0.344067,-0.153221,0.195195 +0.343094,-0.152989,0.195195 +0.342121,-0.152757,0.195195 +0.341148,-0.152525,0.195195 +0.340175,-0.152292,0.195195 +0.339202,-0.152059,0.195195 +0.338229,-0.151826,0.195195 +0.337257,-0.151592,0.195195 +0.336284,-0.151358,0.195195 +0.335312,-0.151124,0.195195 +0.334339,-0.150889,0.195195 +0.333367,-0.150654,0.195195 +0.332395,-0.150419,0.195195 +0.331423,-0.150183,0.195195 +0.330451,-0.149947,0.195195 +0.329479,-0.149711,0.195195 +0.328507,-0.149474,0.195195 +0.327535,-0.149237,0.195195 +0.326564,-0.148999,0.195195 +0.325592,-0.148761,0.195195 +0.324621,-0.148523,0.195195 +0.323649,-0.148285,0.195195 +0.322678,-0.148046,0.195195 +0.321707,-0.147807,0.195195 +0.320736,-0.147567,0.195195 +0.319765,-0.147327,0.195195 +0.318794,-0.147087,0.195195 +0.317823,-0.146846,0.195195 +0.316852,-0.146605,0.195195 +0.315882,-0.146364,0.195195 +0.314911,-0.146122,0.195195 +0.313941,-0.145880,0.195195 +0.312970,-0.145637,0.195195 +0.312000,-0.145395,0.195195 +0.311030,-0.145151,0.195195 +0.310060,-0.144908,0.195195 +0.309090,-0.144664,0.195195 +0.308120,-0.144419,0.195195 +0.307151,-0.144175,0.195195 +0.306181,-0.143930,0.195195 +0.305212,-0.143684,0.195195 +0.304242,-0.143438,0.195195 +0.303273,-0.143192,0.195195 +0.302304,-0.142945,0.195195 +0.301335,-0.142698,0.195195 +0.300366,-0.142451,0.195195 +0.299397,-0.142203,0.195195 +0.298428,-0.141955,0.195195 +0.297459,-0.141706,0.195195 +0.296491,-0.141457,0.195195 +0.295522,-0.141208,0.195195 +0.294554,-0.140958,0.195195 +0.293586,-0.140708,0.195195 +0.292618,-0.140457,0.195195 +0.291650,-0.140206,0.195195 +0.290682,-0.139955,0.195195 +0.289714,-0.139703,0.195195 +0.288746,-0.139451,0.195195 +0.287779,-0.139198,0.195195 +0.286811,-0.138945,0.195195 +0.285844,-0.138692,0.195195 +0.284877,-0.138438,0.195195 +0.283909,-0.138184,0.195195 +0.282942,-0.137929,0.195195 +0.281975,-0.137674,0.195195 +0.281009,-0.137419,0.195195 +0.280042,-0.137163,0.195195 +0.279075,-0.136906,0.195195 +0.278109,-0.136649,0.195195 +0.277143,-0.136392,0.195195 +0.276176,-0.136135,0.195195 +0.275210,-0.135876,0.195195 +0.274244,-0.135618,0.195195 +0.273278,-0.135359,0.195195 +0.272312,-0.135100,0.195195 +0.271347,-0.134840,0.195195 +0.270381,-0.134579,0.195195 +0.269416,-0.134319,0.195195 +0.268451,-0.134058,0.195195 +0.267485,-0.133796,0.195195 +0.266520,-0.133534,0.195195 +0.265555,-0.133271,0.195195 +0.264591,-0.133008,0.195195 +0.263626,-0.132745,0.195195 +0.262661,-0.132481,0.195195 +0.261697,-0.132217,0.195195 +0.260733,-0.131952,0.195195 +0.259768,-0.131687,0.195195 +0.258804,-0.131421,0.195195 +0.257840,-0.131155,0.195195 +0.256877,-0.130888,0.195195 +0.255913,-0.130621,0.195195 +0.254949,-0.130353,0.195195 +0.253986,-0.130085,0.195195 +0.253023,-0.129817,0.195195 +0.252059,-0.129547,0.195195 +0.251096,-0.129278,0.195195 +0.250133,-0.129008,0.195195 +0.249171,-0.128737,0.195195 +0.248208,-0.128466,0.195195 +0.247245,-0.128195,0.195195 +0.246283,-0.127923,0.195195 +0.245321,-0.127650,0.195195 +0.244359,-0.127377,0.195195 +0.243397,-0.127104,0.195195 +0.242435,-0.126830,0.195195 +0.241473,-0.126555,0.195195 +0.240511,-0.126280,0.195195 +0.239550,-0.126005,0.195195 +0.238589,-0.125729,0.195195 +0.237627,-0.125452,0.195195 +0.236666,-0.125175,0.195195 +0.235706,-0.124898,0.195195 +0.234745,-0.124620,0.195195 +0.233784,-0.124341,0.195195 +0.232824,-0.124062,0.195195 +0.231863,-0.123782,0.195195 +0.230903,-0.123502,0.195195 +0.229943,-0.123221,0.195195 +0.228983,-0.122940,0.195195 +0.228023,-0.122658,0.195195 +0.227064,-0.122376,0.195195 +0.226104,-0.122093,0.195195 +0.225145,-0.121809,0.195195 +0.224186,-0.121525,0.195195 +0.223227,-0.121241,0.195195 +0.222268,-0.120956,0.195195 +0.221309,-0.120670,0.195195 +0.220351,-0.120384,0.195195 +0.219392,-0.120097,0.195195 +0.218434,-0.119809,0.195195 +0.217476,-0.119521,0.195195 +0.216518,-0.119233,0.195195 +0.215560,-0.118944,0.195195 +0.214602,-0.118654,0.195195 +0.213645,-0.118364,0.195195 +0.212688,-0.118073,0.195195 +0.211730,-0.117781,0.195195 +0.210773,-0.117489,0.195195 +0.209817,-0.117197,0.195195 +0.208860,-0.116904,0.195195 +0.207903,-0.116610,0.195195 +0.206947,-0.116315,0.195195 +0.205991,-0.116020,0.195195 +0.205035,-0.115725,0.195195 +0.204079,-0.115428,0.195195 +0.203123,-0.115131,0.195195 +0.202167,-0.114834,0.195195 +0.201212,-0.114536,0.195195 +0.200257,-0.114237,0.195195 +0.199302,-0.113938,0.195195 +0.198347,-0.113638,0.195195 +0.197392,-0.113337,0.195195 +0.196438,-0.113036,0.195195 +0.195483,-0.112734,0.195195 +0.194529,-0.112431,0.195195 +0.193575,-0.112128,0.195195 +0.192621,-0.111824,0.195195 +0.191668,-0.111519,0.195195 +0.190714,-0.111214,0.195195 +0.189761,-0.110908,0.195195 +0.188808,-0.110602,0.195195 +0.187855,-0.110295,0.195195 +0.186902,-0.109987,0.195195 +0.185949,-0.109678,0.195195 +0.184997,-0.109369,0.195195 +0.184045,-0.109059,0.195195 +0.183093,-0.108748,0.195195 +0.182141,-0.108437,0.195195 +0.181189,-0.108125,0.195195 +0.180238,-0.107812,0.195195 +0.179286,-0.107498,0.195195 +0.178335,-0.107184,0.195195 +0.177384,-0.106869,0.195195 +0.176434,-0.106554,0.195195 +0.175483,-0.106237,0.195195 +0.174533,-0.105920,0.195195 +0.173583,-0.105602,0.195195 +0.172633,-0.105284,0.195195 +0.171683,-0.104964,0.195195 +0.170734,-0.104644,0.195195 +0.169784,-0.104324,0.195195 +0.168835,-0.104002,0.195195 +0.167886,-0.103680,0.195195 +0.166938,-0.103357,0.195195 +0.165989,-0.103033,0.195195 +0.165041,-0.102708,0.195195 +0.164093,-0.102382,0.195195 +0.163145,-0.102056,0.195195 +0.162197,-0.101729,0.195195 +0.161250,-0.101401,0.195195 +0.160303,-0.101073,0.195195 +0.159356,-0.100743,0.195195 +0.158409,-0.100413,0.195195 +0.157462,-0.100082,0.195195 +0.156516,-0.099750,0.195195 +0.155570,-0.099417,0.195195 +0.154624,-0.099084,0.195195 +0.153678,-0.098749,0.195195 +0.152733,-0.098414,0.195195 +0.151788,-0.098078,0.195195 +0.150843,-0.097741,0.195195 +0.149898,-0.097403,0.195195 +0.148953,-0.097064,0.195195 +0.148009,-0.096724,0.195195 +0.147065,-0.096384,0.195195 +0.146121,-0.096043,0.195195 +0.145178,-0.095700,0.195195 +0.144234,-0.095357,0.195195 +0.143291,-0.095013,0.195195 +0.142349,-0.094668,0.195195 +0.141406,-0.094322,0.195195 +0.140464,-0.093975,0.195195 +0.139522,-0.093627,0.195195 +0.138580,-0.093278,0.195195 +0.137638,-0.092929,0.195195 +0.136697,-0.092578,0.195195 +0.135756,-0.092226,0.195195 +0.134815,-0.091874,0.195195 +0.133875,-0.091520,0.195195 +0.132934,-0.091165,0.195195 +0.131994,-0.090810,0.195195 +0.131055,-0.090453,0.195195 +0.130115,-0.090096,0.195195 +0.129176,-0.089737,0.195195 +0.128237,-0.089377,0.195195 +0.127298,-0.089016,0.195195 +0.126360,-0.088655,0.195195 +0.125422,-0.088292,0.195195 +0.124484,-0.087928,0.195195 +0.123547,-0.087563,0.195195 +0.122610,-0.087197,0.195195 +0.121673,-0.086830,0.195195 +0.120736,-0.086461,0.195195 +0.119800,-0.086092,0.195195 +0.118864,-0.085721,0.195195 +0.117928,-0.085350,0.195195 +0.116993,-0.084977,0.195195 +0.116058,-0.084603,0.195195 +0.115123,-0.084228,0.195195 +0.114188,-0.083852,0.195195 +0.113254,-0.083474,0.195195 +0.112321,-0.083096,0.195195 +0.111387,-0.082716,0.195195 +0.110454,-0.082335,0.195195 +0.109521,-0.081952,0.195195 +0.108589,-0.081569,0.195195 +0.107656,-0.081184,0.195195 +0.106725,-0.080798,0.195195 +0.105793,-0.080410,0.195195 +0.104862,-0.080022,0.195195 +0.103931,-0.079632,0.195195 +0.103001,-0.079240,0.195195 +0.102071,-0.078848,0.195195 +0.101141,-0.078454,0.195195 +0.100212,-0.078059,0.195195 +0.099283,-0.077662,0.195195 +0.098354,-0.077264,0.195195 +0.097426,-0.076864,0.195195 +0.096498,-0.076463,0.195195 +0.095570,-0.076061,0.195195 +0.094643,-0.075657,0.195195 +0.093717,-0.075252,0.195195 +0.092790,-0.074845,0.195195 +0.091865,-0.074437,0.195195 +0.090939,-0.074027,0.195195 +0.090014,-0.073616,0.195195 +0.089089,-0.073203,0.195195 +0.088165,-0.072788,0.195195 +0.087241,-0.072372,0.195195 +0.086318,-0.071954,0.195195 +0.085395,-0.071535,0.195195 +0.084473,-0.071114,0.195195 +0.083551,-0.070691,0.195195 +0.082629,-0.070267,0.195195 +0.081708,-0.069841,0.195195 +0.080787,-0.069413,0.195195 +0.079867,-0.068983,0.195195 +0.078947,-0.068552,0.195195 +0.078028,-0.068119,0.195195 +0.077110,-0.067684,0.195195 +0.076191,-0.067247,0.195195 +0.075274,-0.066808,0.195195 +0.074356,-0.066368,0.195195 +0.073440,-0.065925,0.195195 +0.072524,-0.065480,0.195195 +0.071608,-0.065034,0.195195 +0.070693,-0.064585,0.195195 +0.069778,-0.064134,0.195195 +0.068865,-0.063682,0.195195 +0.067951,-0.063227,0.195195 +0.067038,-0.062770,0.195195 +0.066126,-0.062310,0.195195 +0.065215,-0.061849,0.195195 +0.064304,-0.061385,0.195195 +0.063393,-0.060919,0.195195 +0.062483,-0.060450,0.195195 +0.061574,-0.059979,0.195195 +0.060666,-0.059506,0.195195 +0.059758,-0.059030,0.195195 +0.058851,-0.058552,0.195195 +0.057944,-0.058071,0.195195 +0.057039,-0.057588,0.195195 +0.056134,-0.057102,0.195195 +0.055229,-0.056613,0.195195 +0.054326,-0.056121,0.195195 +0.053423,-0.055627,0.195195 +0.052521,-0.055129,0.195195 +0.051620,-0.054629,0.195195 +0.050719,-0.054126,0.195195 +0.049820,-0.053620,0.195195 +0.048921,-0.053110,0.195195 +0.048023,-0.052597,0.195195 +0.047126,-0.052081,0.195195 +0.046230,-0.051562,0.195195 +0.045335,-0.051039,0.195195 +0.044440,-0.050513,0.195195 +0.043547,-0.049983,0.195195 +0.042655,-0.049450,0.195195 +0.041764,-0.048913,0.195195 +0.040873,-0.048371,0.195195 +0.039984,-0.047826,0.195195 +0.039096,-0.047277,0.195195 +0.038209,-0.046723,0.195195 +0.037323,-0.046165,0.195195 +0.036439,-0.045603,0.195195 +0.035555,-0.045036,0.195195 +0.034673,-0.044464,0.195195 +0.033792,-0.043888,0.195195 +0.032913,-0.043306,0.195195 +0.032035,-0.042719,0.195195 +0.031158,-0.042127,0.195195 +0.030283,-0.041530,0.195195 +0.029410,-0.040926,0.195195 +0.028538,-0.040317,0.195195 +0.027667,-0.039702,0.195195 +0.026798,-0.039081,0.195195 +0.025931,-0.038453,0.195195 +0.025066,-0.037818,0.195195 +0.024203,-0.037176,0.195195 +0.023342,-0.036525,0.195195 +0.022483,-0.035867,0.195195 +0.021626,-0.035200,0.195195 +0.020772,-0.034524,0.195195 +0.019921,-0.033838,0.195195 +0.019072,-0.033143,0.195195 +0.018226,-0.032437,0.195195 +0.017382,-0.031721,0.195195 +0.016542,-0.030995,0.195195 +0.015704,-0.030257,0.195195 +0.014869,-0.029508,0.195195 +0.014038,-0.028748,0.195195 +0.013209,-0.027976,0.195195 +0.012385,-0.027189,0.195195 +0.011566,-0.026383,0.195195 +0.010752,-0.025556,0.195195 +0.009945,-0.024704,0.195195 +0.009146,-0.023823,0.195195 +0.008355,-0.022911,0.195195 +0.007572,-0.021967,0.195195 +0.006797,-0.020999,0.195195 +0.006026,-0.020012,0.195195 +0.005259,-0.019011,0.195195 +0.004494,-0.018002,0.195195 +0.003737,-0.016964,0.195195 +0.003004,-0.015835,0.195195 +0.002314,-0.014547,0.195195 +0.001683,-0.013036,0.195195 +0.001103,-0.011338,0.195195 +0.000510,-0.009689,0.195195 +-0.000160,-0.008326,0.195195 +-0.000613,-0.006151,0.195195 +0.000000,0.000000,0.195195 -- GitLab